content
stringlengths
5
1.03M
input_ids
sequencelengths
4
823k
ratio_char_token
float64
0.4
12.5
token_count
int64
4
823k
""" expval1(basis::SingleBlockBasis, op::AbstractMatrix, i::Int, wf::AbstractVector{Float64}) Calculate the expectation value of the one-body operator `op` at site `i` in the state `wf`. """ function expval1(basis::SingleBlockBasis{N}, op::AbstractMatrix, i::Int, wf::AbstractVector{Float64}) where {N} w = Array{Int}(undef, 2N) result = 0.0 for col in 1:basis.block.size v = basis.block.vectors[col] li = v[2i-1] mi = v[2i] coli = li*(li+1) + mi + 1 rowi = 0 for lip in 0:basis.l_max for mip in (-lip):lip rowi += 1 op[rowi, coli] == 0.0 && continue w .= v w[2i-1] = lip w[2i] = mip haskey(basis.block.lookup, w) || continue result += wf[basis.block.lookup[w]] * wf[col] * op[rowi, coli] end end end result end """ expval2(basis::SingleBlockBasis, op_i::AbstractMatrix, i::Int, op_j::AbstractMatrix, j::Int, wf::AbstractVector{Float64}) Calculate the expectation value of the two-body operator composed of `op_i` at site `i` and `op_j` at site `j` in the state `wf`. """ function expval2(basis::SingleBlockBasis{N}, op_i::AbstractMatrix, i::Int, op_j::AbstractMatrix, j::Int, wf::AbstractVector{Float64}) where {N} w = Array{Int}(undef, 2N) result = 0.0 for col in 1:basis.block.size v = basis.block.vectors[col] li = v[2i-1] mi = v[2i] coli = li*(li+1) + mi + 1 lj = v[2j-1] mj = v[2j] colj = lj*(lj+1) + mj + 1 rowi = 0 for lip in 0:basis.l_max for mip in (-lip):lip rowi += 1 op_i[rowi, coli] == 0.0 && continue rowj = 0 for ljp in 0:basis.l_max for mjp in (-ljp):ljp rowj += 1 op_j[rowj, colj] == 0.0 && continue w .= v w[2i-1] = lip w[2i] = mip w[2j-1] = ljp w[2j] = mjp haskey(basis.block.lookup, w) || continue result += wf[basis.block.lookup[w]] * wf[col] * op_i[rowi, coli] * op_j[rowj, colj] end end end end end result end
[ 37811, 198, 220, 220, 220, 1033, 2100, 16, 7, 12093, 271, 3712, 28008, 12235, 15522, 271, 11, 1034, 3712, 23839, 46912, 11, 1312, 3712, 5317, 11, 266, 69, 3712, 23839, 38469, 90, 43879, 2414, 30072, 198, 198, 9771, 3129, 378, 262, 17507, 1988, 286, 262, 530, 12, 2618, 10088, 4600, 404, 63, 379, 2524, 4600, 72, 63, 287, 198, 1169, 1181, 4600, 86, 69, 44646, 198, 37811, 198, 8818, 1033, 2100, 16, 7, 12093, 271, 3712, 28008, 12235, 15522, 271, 90, 45, 5512, 1034, 3712, 23839, 46912, 11, 1312, 3712, 5317, 11, 266, 69, 3712, 23839, 38469, 90, 43879, 2414, 30072, 810, 1391, 45, 92, 198, 220, 220, 220, 266, 796, 15690, 90, 5317, 92, 7, 917, 891, 11, 362, 45, 8, 628, 220, 220, 220, 1255, 796, 657, 13, 15, 628, 220, 220, 220, 329, 951, 287, 352, 25, 12093, 271, 13, 9967, 13, 7857, 198, 220, 220, 220, 220, 220, 220, 220, 410, 796, 4308, 13, 9967, 13, 303, 5217, 58, 4033, 60, 628, 220, 220, 220, 220, 220, 220, 220, 7649, 796, 410, 58, 17, 72, 12, 16, 60, 198, 220, 220, 220, 220, 220, 220, 220, 21504, 796, 410, 58, 17, 72, 60, 198, 220, 220, 220, 220, 220, 220, 220, 40395, 796, 7649, 9, 7, 4528, 10, 16, 8, 1343, 21504, 1343, 352, 628, 220, 220, 220, 220, 220, 220, 220, 5752, 72, 796, 657, 198, 220, 220, 220, 220, 220, 220, 220, 329, 10645, 287, 657, 25, 12093, 271, 13, 75, 62, 9806, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 285, 541, 287, 13841, 40712, 2599, 40712, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 5752, 72, 15853, 352, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1034, 58, 808, 72, 11, 40395, 60, 6624, 657, 13, 15, 11405, 2555, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 266, 764, 28, 410, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 266, 58, 17, 72, 12, 16, 60, 796, 10645, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 266, 58, 17, 72, 60, 796, 285, 541, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 468, 2539, 7, 12093, 271, 13, 9967, 13, 5460, 929, 11, 266, 8, 8614, 2555, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1255, 15853, 266, 69, 58, 12093, 271, 13, 9967, 13, 5460, 929, 58, 86, 11907, 1635, 266, 69, 58, 4033, 60, 1635, 1034, 58, 808, 72, 11, 40395, 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, 886, 628, 220, 220, 220, 1255, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 1033, 2100, 17, 7, 12093, 271, 3712, 28008, 12235, 15522, 271, 11, 1034, 62, 72, 3712, 23839, 46912, 11, 1312, 3712, 5317, 11, 1034, 62, 73, 3712, 23839, 46912, 11, 474, 3712, 5317, 11, 266, 69, 3712, 23839, 38469, 90, 43879, 2414, 30072, 198, 198, 9771, 3129, 378, 262, 17507, 1988, 286, 262, 734, 12, 2618, 10088, 13160, 286, 4600, 404, 62, 72, 63, 379, 198, 15654, 4600, 72, 63, 290, 4600, 404, 62, 73, 63, 379, 2524, 4600, 73, 63, 287, 262, 1181, 4600, 86, 69, 44646, 198, 37811, 198, 8818, 1033, 2100, 17, 7, 12093, 271, 3712, 28008, 12235, 15522, 271, 90, 45, 5512, 1034, 62, 72, 3712, 23839, 46912, 11, 1312, 3712, 5317, 11, 1034, 62, 73, 3712, 23839, 46912, 11, 474, 3712, 5317, 11, 266, 69, 3712, 23839, 38469, 90, 43879, 2414, 30072, 810, 1391, 45, 92, 198, 220, 220, 220, 266, 796, 15690, 90, 5317, 92, 7, 917, 891, 11, 362, 45, 8, 628, 220, 220, 220, 1255, 796, 657, 13, 15, 628, 220, 220, 220, 329, 951, 287, 352, 25, 12093, 271, 13, 9967, 13, 7857, 198, 220, 220, 220, 220, 220, 220, 220, 410, 796, 4308, 13, 9967, 13, 303, 5217, 58, 4033, 60, 628, 220, 220, 220, 220, 220, 220, 220, 7649, 796, 410, 58, 17, 72, 12, 16, 60, 198, 220, 220, 220, 220, 220, 220, 220, 21504, 796, 410, 58, 17, 72, 60, 198, 220, 220, 220, 220, 220, 220, 220, 40395, 796, 7649, 9, 7, 4528, 10, 16, 8, 1343, 21504, 1343, 352, 198, 220, 220, 220, 220, 220, 220, 220, 300, 73, 796, 410, 58, 17, 73, 12, 16, 60, 198, 220, 220, 220, 220, 220, 220, 220, 285, 73, 796, 410, 58, 17, 73, 60, 198, 220, 220, 220, 220, 220, 220, 220, 951, 73, 796, 300, 73, 9, 7, 75, 73, 10, 16, 8, 1343, 285, 73, 1343, 352, 628, 220, 220, 220, 220, 220, 220, 220, 5752, 72, 796, 657, 198, 220, 220, 220, 220, 220, 220, 220, 329, 10645, 287, 657, 25, 12093, 271, 13, 75, 62, 9806, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 285, 541, 287, 13841, 40712, 2599, 40712, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 5752, 72, 15853, 352, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1034, 62, 72, 58, 808, 72, 11, 40395, 60, 6624, 657, 13, 15, 11405, 2555, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 5752, 73, 796, 657, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 300, 34523, 287, 657, 25, 12093, 271, 13, 75, 62, 9806, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 285, 34523, 287, 13841, 75, 34523, 2599, 75, 34523, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 5752, 73, 15853, 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, 1034, 62, 73, 58, 808, 73, 11, 951, 73, 60, 6624, 657, 13, 15, 11405, 2555, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 266, 764, 28, 410, 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, 58, 17, 72, 12, 16, 60, 796, 10645, 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, 58, 17, 72, 60, 796, 285, 541, 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, 58, 17, 73, 12, 16, 60, 796, 300, 34523, 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, 58, 17, 73, 60, 796, 285, 34523, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 468, 2539, 7, 12093, 271, 13, 9967, 13, 5460, 929, 11, 266, 8, 8614, 2555, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1255, 15853, 266, 69, 58, 12093, 271, 13, 9967, 13, 5460, 929, 58, 86, 11907, 1635, 266, 69, 58, 4033, 60, 1635, 1034, 62, 72, 58, 808, 72, 11, 40395, 60, 1635, 1034, 62, 73, 58, 808, 73, 11, 951, 73, 60, 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, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1255, 198, 437, 198 ]
1.736091
1,402
struct HSDEMatrixQ{T,M<:AbstractMatrix{T},V<:AbstractVector{T}} <: AbstractMatrix{T} A::M b::V c::V am::Int64 an::Int64 end """ HSDEMatrixQ(A::M, b::V, c::V) where {T,M<:AbstractMatrix{T},V<:AbstractVector{T}} """ function HSDEMatrixQ(A::M, b::V, c::V) where {T,M<:AbstractMatrix{T},V<:AbstractVector{T}} am, an = size(A) @assert size(b,1) == am @assert size(c,1) == an HSDEMatrixQ{T,M,V}(A, b, c, am, an) end Base.size(Q::HSDEMatrixQ) = (Q.am+Q.an+1, Q.am+Q.an+1) # Fallback, to have both defined Base.show(io::IO, mt::MIME"text/plain", Q::T) where {T<:HSDEMatrixQ} = Base.show(io, Q) function Base.show(io::IO, Q::T) where {T<:HSDEMatrixQ} m,n = size(Q) println(io, "$(m)x$(m) $T:") println(io, "[0 A' c;\n -A 0 b;\n -c' -b' 0]") println(io,"where A:") Base.show(io, Q.A) println(io,"\nb:") Base.show(io, Q.b) println(io,"\nc:") Base.show(io, Q.c) end # Q of size #(n,n) (n,m) (n,1) #(m,m) (m,m) (m,1) #(1,n) (1,m) (1,1) function mul!(Y::AbstractArray{T,1}, Q::HSDEMatrixQ{T,M,V}, B::AbstractArray{T,1}) where {T,M<:AbstractArray{T,2},V<:AbstractArray{T,1}} @assert size(Q) == (size(Y,1), size(B,1)) y1 = view(Y, 1:Q.an) y2 = view(Y, (Q.an+1):(Q.an+Q.am)) b1 = view(B, 1:Q.an) b2 = view(B, (Q.an+1):(Q.an+Q.am)) b3 = B[Q.am+Q.an+1] A = Q.A b = Q.b c = Q.c mul!(y1, transpose(A), b2) mul!( y2, A, b1) #TODO maybe switch back for readability? y1 .+= b3.*c # y1 .= y1 .+ c.*b3 y2 .-= b3.*b # y2 .= b.*b3 .- y2 y2 .= .-y2 Y[Q.am+Q.an+1] = - dot(c, b1) - dot(b,b2) return Y end function mul!(Y::AbstractArray{T,1}, Q::Transpose{T, QMat}, B::AbstractArray{T,1}) where {T, M<:AbstractArray{T,2},V<:AbstractArray{T,1}, QMat<:HSDEMatrixQ{T,M,V}} mul!(Y,Q.parent,B) Y .= .-Y return Y end struct HSDEMatrix{T,QType<:AbstractMatrix{T}} <: AbstractMatrix{T} Q::QType cgdata::CGdata{T} end """ HSDEMatrix(Q::HSDEMatrixQ) """ HSDEMatrix(Q::QType) where {T, QType<:AbstractMatrix{T}} = HSDEMatrix{T,QType}(Q, CGdata(2*size(Q)[1])) """ HSDEMatrix(A::M, b::V, c::V) where {T,M<:AbstractMatrix{T},V<:AbstractVector{T}} """ function HSDEMatrix(A::M, b::V, c::V) where {T,M<:AbstractMatrix{T},V<:AbstractVector{T}} Q = HSDEMatrixQ(A, b, c) HSDEMatrix(Q, CGdata(2*size(M.Q)[1])) end function Base.size(M::HSDEMatrix) m, n = size(M.Q) return (2m,2m) end # Try fallback Base.show(io::IO, mt::MIME"text/plain", M::T) where {T<:HSDEMatrix} = Base.show(io, M) function Base.show(io::IO, M::T) where {T<:HSDEMatrix} m,n = size(M) println(io, "$(m)x$(m) $T:") println(io, "[I Q';\n Q -I]") println(io,"where Q:") Base.show(io, M.Q) end """ solve argmin_y{||x-y||₂}, s.t. Q*u==v, where [u;v] == x """ function prox!(y::AbstractVector, A::HSDEMatrix, x::AbstractVector) tol = size(A,2)*eps() max_iters = 1000 cgdata = A.cgdata if cgdata.firstrun.x #Pointer, has this been initialized cgdata.xinit .= x #Works as guess since Q square cgdata.firstrun.x = false end #Since y is the initial guess, use previous solution y .= cgdata.xinit #solve [I Q';Q -I][u^(k+1);μ] = [u^k;v^k] conjugategradient!(y, A, x, cgdata.r, cgdata.p, cgdata.z, tol = tol, max_iters = max_iters) #Save initial guess for next prox! cgdata.xinit .= y m, n = size(A.Q) #Let v=Q*u u = view(y,1:m) v = view(y,(m+1):2m) mul!(v, A.Q, u) return 0.0 end function mul!(Y::AbstractArray{T,1}, M::HSDEMatrix{T,QType}, B::AbstractArray{T,1}) where {T,QType<:AbstractMatrix{T}} m2 = size(M)[1] mQ = size(M.Q)[1] @assert (m2,m2) == (size(Y,1), size(B,1)) y1 = view(Y, 1:mQ) y2 = view(Y, (mQ+1):(2mQ)) b1 = view(B, 1:mQ) b2 = view(B, (mQ+1):(2mQ)) mul!(y1, transpose(M.Q), b2) mul!( y2, M.Q, b1) @inbounds y1 .= y1 .+ b1 @inbounds y2 .= y2 .- b2 return Y end mul!(Y::AbstractArray{T,1}, Q::Transpose{T, QMat}, B::AbstractArray{T,1}) where {T, QType<:AbstractMatrix{T}, QMat<:HSDEMatrix{T,QType}} = mul!(Y, Q.parent, B)
[ 198, 7249, 367, 10305, 3620, 265, 8609, 48, 90, 51, 11, 44, 27, 25, 23839, 46912, 90, 51, 5512, 53, 27, 25, 23839, 38469, 90, 51, 11709, 1279, 25, 27741, 46912, 90, 51, 92, 198, 220, 220, 220, 317, 3712, 44, 198, 220, 220, 220, 275, 3712, 53, 198, 220, 220, 220, 269, 3712, 53, 198, 220, 220, 220, 716, 3712, 5317, 2414, 198, 220, 220, 220, 281, 3712, 5317, 2414, 198, 437, 198, 198, 37811, 198, 7998, 39429, 265, 8609, 48, 7, 32, 3712, 44, 11, 275, 3712, 53, 11, 269, 3712, 53, 8, 810, 1391, 51, 11, 44, 27, 25, 23839, 46912, 90, 51, 5512, 53, 27, 25, 23839, 38469, 90, 51, 11709, 198, 37811, 198, 8818, 367, 10305, 3620, 265, 8609, 48, 7, 32, 3712, 44, 11, 275, 3712, 53, 11, 269, 3712, 53, 8, 810, 1391, 51, 11, 44, 27, 25, 23839, 46912, 90, 51, 5512, 53, 27, 25, 23839, 38469, 90, 51, 11709, 198, 220, 220, 220, 716, 11, 281, 796, 2546, 7, 32, 8, 198, 220, 220, 220, 2488, 30493, 2546, 7, 65, 11, 16, 8, 6624, 716, 198, 220, 220, 220, 2488, 30493, 2546, 7, 66, 11, 16, 8, 6624, 281, 198, 220, 220, 220, 367, 10305, 3620, 265, 8609, 48, 90, 51, 11, 44, 11, 53, 92, 7, 32, 11, 275, 11, 269, 11, 716, 11, 281, 8, 198, 437, 198, 198, 14881, 13, 7857, 7, 48, 3712, 7998, 39429, 265, 8609, 48, 8, 796, 357, 48, 13, 321, 10, 48, 13, 272, 10, 16, 11, 1195, 13, 321, 10, 48, 13, 272, 10, 16, 8, 198, 198, 2, 7218, 1891, 11, 284, 423, 1111, 5447, 198, 14881, 13, 12860, 7, 952, 3712, 9399, 11, 45079, 3712, 44, 12789, 1, 5239, 14, 25638, 1600, 1195, 3712, 51, 8, 810, 1391, 51, 27, 25, 7998, 39429, 265, 8609, 48, 92, 796, 7308, 13, 12860, 7, 952, 11, 1195, 8, 198, 198, 8818, 7308, 13, 12860, 7, 952, 3712, 9399, 11, 1195, 3712, 51, 8, 810, 1391, 51, 27, 25, 7998, 39429, 265, 8609, 48, 92, 198, 220, 220, 220, 285, 11, 77, 796, 2546, 7, 48, 8, 198, 220, 220, 220, 44872, 7, 952, 11, 17971, 7, 76, 8, 87, 3, 7, 76, 8, 720, 51, 25, 4943, 198, 220, 220, 220, 44872, 7, 952, 11, 12878, 15, 220, 220, 317, 6, 220, 269, 26, 59, 77, 532, 32, 220, 657, 220, 220, 275, 26, 59, 77, 532, 66, 6, 532, 65, 6, 657, 60, 4943, 198, 220, 220, 220, 44872, 7, 952, 553, 3003, 317, 25, 4943, 198, 220, 220, 220, 7308, 13, 12860, 7, 952, 11, 1195, 13, 32, 8, 198, 220, 220, 220, 44872, 7, 952, 553, 59, 46803, 25, 4943, 198, 220, 220, 220, 7308, 13, 12860, 7, 952, 11, 1195, 13, 65, 8, 198, 220, 220, 220, 44872, 7, 952, 553, 59, 10782, 25, 4943, 198, 220, 220, 220, 7308, 13, 12860, 7, 952, 11, 1195, 13, 66, 8, 198, 437, 198, 198, 2, 1195, 286, 2546, 198, 2, 7, 77, 11, 77, 8, 357, 77, 11, 76, 8, 357, 77, 11, 16, 8, 198, 2, 7, 76, 11, 76, 8, 357, 76, 11, 76, 8, 357, 76, 11, 16, 8, 198, 2, 7, 16, 11, 77, 8, 357, 16, 11, 76, 8, 357, 16, 11, 16, 8, 198, 8818, 35971, 0, 7, 56, 3712, 23839, 19182, 90, 51, 11, 16, 5512, 1195, 3712, 7998, 39429, 265, 8609, 48, 90, 51, 11, 44, 11, 53, 5512, 347, 3712, 23839, 19182, 90, 51, 11, 16, 30072, 810, 1391, 51, 11, 44, 27, 25, 23839, 19182, 90, 51, 11, 17, 5512, 53, 27, 25, 23839, 19182, 90, 51, 11, 16, 11709, 198, 220, 220, 220, 2488, 30493, 2546, 7, 48, 8, 6624, 357, 7857, 7, 56, 11, 16, 828, 2546, 7, 33, 11, 16, 4008, 198, 220, 220, 220, 331, 16, 796, 1570, 7, 56, 11, 352, 25, 48, 13, 272, 8, 198, 220, 220, 220, 331, 17, 796, 1570, 7, 56, 11, 357, 48, 13, 272, 10, 16, 2599, 7, 48, 13, 272, 10, 48, 13, 321, 4008, 198, 220, 220, 220, 275, 16, 796, 1570, 7, 33, 11, 352, 25, 48, 13, 272, 8, 198, 220, 220, 220, 275, 17, 796, 1570, 7, 33, 11, 357, 48, 13, 272, 10, 16, 2599, 7, 48, 13, 272, 10, 48, 13, 321, 4008, 198, 220, 220, 220, 275, 18, 796, 347, 58, 48, 13, 321, 10, 48, 13, 272, 10, 16, 60, 198, 220, 220, 220, 317, 796, 1195, 13, 32, 198, 220, 220, 220, 275, 796, 1195, 13, 65, 198, 220, 220, 220, 269, 796, 1195, 13, 66, 198, 220, 220, 220, 35971, 0, 7, 88, 16, 11, 1007, 3455, 7, 32, 828, 275, 17, 8, 198, 220, 220, 220, 35971, 0, 7, 331, 17, 11, 317, 11, 275, 16, 8, 198, 220, 220, 220, 1303, 51, 3727, 46, 3863, 5078, 736, 329, 1100, 1799, 30, 198, 220, 220, 220, 331, 16, 764, 47932, 275, 18, 15885, 66, 1303, 331, 16, 764, 28, 220, 331, 16, 764, 10, 269, 15885, 65, 18, 198, 220, 220, 220, 331, 17, 764, 12, 28, 275, 18, 15885, 65, 1303, 331, 17, 764, 28, 275, 15885, 65, 18, 764, 12, 331, 17, 198, 220, 220, 220, 331, 17, 764, 28, 764, 12, 88, 17, 198, 220, 220, 220, 575, 58, 48, 13, 321, 10, 48, 13, 272, 10, 16, 60, 796, 532, 16605, 7, 66, 11, 275, 16, 8, 532, 16605, 7, 65, 11, 65, 17, 8, 198, 220, 220, 220, 1441, 575, 198, 437, 198, 198, 8818, 35971, 0, 7, 56, 3712, 23839, 19182, 90, 51, 11, 16, 5512, 1195, 3712, 8291, 3455, 90, 51, 11, 1195, 19044, 5512, 347, 3712, 23839, 19182, 90, 51, 11, 16, 30072, 810, 1391, 51, 11, 337, 27, 25, 23839, 19182, 90, 51, 11, 17, 5512, 53, 27, 25, 23839, 19182, 90, 51, 11, 16, 5512, 1195, 19044, 27, 25, 7998, 39429, 265, 8609, 48, 90, 51, 11, 44, 11, 53, 11709, 198, 220, 220, 220, 35971, 0, 7, 56, 11, 48, 13, 8000, 11, 33, 8, 198, 220, 220, 220, 575, 764, 28, 764, 12, 56, 198, 220, 220, 220, 1441, 575, 198, 437, 628, 198, 7249, 367, 10305, 3620, 265, 8609, 90, 51, 11, 48, 6030, 27, 25, 23839, 46912, 90, 51, 11709, 1279, 25, 27741, 46912, 90, 51, 92, 198, 220, 220, 220, 1195, 3712, 48, 6030, 198, 220, 220, 220, 269, 70, 7890, 3712, 39816, 7890, 90, 51, 92, 198, 437, 198, 198, 37811, 198, 7998, 39429, 265, 8609, 7, 48, 3712, 7998, 39429, 265, 8609, 48, 8, 198, 37811, 198, 7998, 39429, 265, 8609, 7, 48, 3712, 48, 6030, 8, 810, 1391, 51, 11, 1195, 6030, 27, 25, 23839, 46912, 90, 51, 11709, 796, 367, 10305, 3620, 265, 8609, 90, 51, 11, 48, 6030, 92, 7, 48, 11, 29925, 7890, 7, 17, 9, 7857, 7, 48, 38381, 16, 60, 4008, 198, 198, 37811, 198, 7998, 39429, 265, 8609, 7, 32, 3712, 44, 11, 275, 3712, 53, 11, 269, 3712, 53, 8, 810, 1391, 51, 11, 44, 27, 25, 23839, 46912, 90, 51, 5512, 53, 27, 25, 23839, 38469, 90, 51, 11709, 198, 37811, 198, 8818, 367, 10305, 3620, 265, 8609, 7, 32, 3712, 44, 11, 275, 3712, 53, 11, 269, 3712, 53, 8, 810, 1391, 51, 11, 44, 27, 25, 23839, 46912, 90, 51, 5512, 53, 27, 25, 23839, 38469, 90, 51, 11709, 198, 220, 220, 220, 1195, 796, 367, 10305, 3620, 265, 8609, 48, 7, 32, 11, 275, 11, 269, 8, 198, 220, 220, 220, 367, 10305, 3620, 265, 8609, 7, 48, 11, 29925, 7890, 7, 17, 9, 7857, 7, 44, 13, 48, 38381, 16, 60, 4008, 198, 437, 198, 198, 8818, 7308, 13, 7857, 7, 44, 3712, 7998, 39429, 265, 8609, 8, 198, 220, 220, 220, 285, 11, 299, 796, 2546, 7, 44, 13, 48, 8, 198, 220, 220, 220, 1441, 357, 17, 76, 11, 17, 76, 8, 198, 437, 198, 198, 2, 9993, 2121, 1891, 198, 14881, 13, 12860, 7, 952, 3712, 9399, 11, 45079, 3712, 44, 12789, 1, 5239, 14, 25638, 1600, 337, 3712, 51, 8, 810, 1391, 51, 27, 25, 7998, 39429, 265, 8609, 92, 796, 7308, 13, 12860, 7, 952, 11, 337, 8, 198, 198, 8818, 7308, 13, 12860, 7, 952, 3712, 9399, 11, 337, 3712, 51, 8, 810, 1391, 51, 27, 25, 7998, 39429, 265, 8609, 92, 198, 220, 220, 220, 285, 11, 77, 796, 2546, 7, 44, 8, 198, 220, 220, 220, 44872, 7, 952, 11, 17971, 7, 76, 8, 87, 3, 7, 76, 8, 720, 51, 25, 4943, 198, 220, 220, 220, 44872, 7, 952, 11, 12878, 40, 220, 1195, 17020, 59, 77, 1195, 532, 40, 60, 4943, 198, 220, 220, 220, 44872, 7, 952, 553, 3003, 1195, 25, 4943, 198, 220, 220, 220, 7308, 13, 12860, 7, 952, 11, 337, 13, 48, 8, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 8494, 1822, 1084, 62, 88, 90, 15886, 87, 12, 88, 15886, 158, 224, 224, 5512, 264, 13, 83, 13, 1195, 9, 84, 855, 85, 11, 810, 685, 84, 26, 85, 60, 6624, 2124, 198, 37811, 198, 8818, 14793, 0, 7, 88, 3712, 23839, 38469, 11, 317, 3712, 7998, 39429, 265, 8609, 11, 2124, 3712, 23839, 38469, 8, 198, 220, 220, 220, 284, 75, 796, 2546, 7, 32, 11, 17, 27493, 25386, 3419, 198, 220, 220, 220, 3509, 62, 270, 364, 796, 8576, 198, 220, 220, 220, 269, 70, 7890, 796, 317, 13, 66, 70, 7890, 198, 220, 220, 220, 611, 269, 70, 7890, 13, 11085, 5143, 13, 87, 1303, 18833, 3849, 11, 468, 428, 587, 23224, 198, 220, 220, 220, 220, 220, 220, 220, 269, 70, 7890, 13, 87, 15003, 764, 28, 2124, 1303, 23044, 355, 4724, 1201, 1195, 6616, 198, 220, 220, 220, 220, 220, 220, 220, 269, 70, 7890, 13, 11085, 5143, 13, 87, 796, 3991, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1303, 6385, 331, 318, 262, 4238, 4724, 11, 779, 2180, 4610, 198, 220, 220, 220, 331, 764, 28, 269, 70, 7890, 13, 87, 15003, 198, 220, 220, 220, 1303, 82, 6442, 685, 40, 1195, 17020, 48, 532, 40, 7131, 84, 61, 7, 74, 10, 16, 1776, 34703, 60, 796, 685, 84, 61, 74, 26, 85, 61, 74, 60, 198, 220, 220, 220, 11644, 1018, 378, 49607, 0, 7, 88, 11, 317, 11, 2124, 11, 269, 70, 7890, 13, 81, 11, 269, 70, 7890, 13, 79, 11, 269, 70, 7890, 13, 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, 284, 75, 796, 284, 75, 11, 3509, 62, 270, 364, 796, 3509, 62, 270, 364, 8, 198, 220, 220, 220, 1303, 16928, 4238, 4724, 329, 1306, 14793, 0, 198, 220, 220, 220, 269, 70, 7890, 13, 87, 15003, 764, 28, 331, 198, 220, 220, 220, 285, 11, 299, 796, 2546, 7, 32, 13, 48, 8, 198, 220, 220, 220, 1303, 5756, 410, 28, 48, 9, 84, 198, 220, 220, 220, 334, 796, 1570, 7, 88, 11, 16, 25, 76, 8, 198, 220, 220, 220, 410, 796, 1570, 7, 88, 11, 7, 76, 10, 16, 2599, 17, 76, 8, 198, 220, 220, 220, 35971, 0, 7, 85, 11, 317, 13, 48, 11, 334, 8, 198, 220, 220, 220, 1441, 657, 13, 15, 198, 437, 628, 628, 198, 8818, 35971, 0, 7, 56, 3712, 23839, 19182, 90, 51, 11, 16, 5512, 337, 3712, 7998, 39429, 265, 8609, 90, 51, 11, 48, 6030, 5512, 347, 3712, 23839, 19182, 90, 51, 11, 16, 30072, 810, 1391, 51, 11, 48, 6030, 27, 25, 23839, 46912, 90, 51, 11709, 198, 220, 220, 220, 285, 17, 796, 2546, 7, 44, 38381, 16, 60, 198, 220, 220, 220, 285, 48, 796, 2546, 7, 44, 13, 48, 38381, 16, 60, 198, 220, 220, 220, 2488, 30493, 357, 76, 17, 11, 76, 17, 8, 6624, 357, 7857, 7, 56, 11, 16, 828, 2546, 7, 33, 11, 16, 4008, 198, 220, 220, 220, 331, 16, 796, 1570, 7, 56, 11, 352, 25, 76, 48, 8, 198, 220, 220, 220, 331, 17, 796, 1570, 7, 56, 11, 357, 76, 48, 10, 16, 2599, 7, 17, 76, 48, 4008, 198, 220, 220, 220, 275, 16, 796, 1570, 7, 33, 11, 352, 25, 76, 48, 8, 198, 220, 220, 220, 275, 17, 796, 1570, 7, 33, 11, 357, 76, 48, 10, 16, 2599, 7, 17, 76, 48, 4008, 198, 220, 220, 220, 35971, 0, 7, 88, 16, 11, 1007, 3455, 7, 44, 13, 48, 828, 275, 17, 8, 198, 220, 220, 220, 35971, 0, 7, 331, 17, 11, 337, 13, 48, 11, 275, 16, 8, 198, 220, 220, 220, 2488, 259, 65, 3733, 331, 16, 764, 28, 331, 16, 764, 10, 275, 16, 198, 220, 220, 220, 2488, 259, 65, 3733, 331, 17, 764, 28, 331, 17, 764, 12, 275, 17, 198, 220, 220, 220, 1441, 575, 198, 437, 198, 198, 76, 377, 0, 7, 56, 3712, 23839, 19182, 90, 51, 11, 16, 5512, 1195, 3712, 8291, 3455, 90, 51, 11, 1195, 19044, 5512, 347, 3712, 23839, 19182, 90, 51, 11, 16, 30072, 810, 1391, 51, 11, 1195, 6030, 27, 25, 23839, 46912, 90, 51, 5512, 1195, 19044, 27, 25, 7998, 39429, 265, 8609, 90, 51, 11, 48, 6030, 11709, 796, 198, 220, 220, 220, 35971, 0, 7, 56, 11, 1195, 13, 8000, 11, 347, 8, 198 ]
1.856694
2,226
function Error(experimental_data_array,simulation_time_array,simulation_state_array,output_index,species_symbol,data_dictionary) # initialize - total_error_value = Inf # Interpole the simulation data to the experimental time scale - interpolated_simulated_trajectory = np.interp(experimental_data_array[:,1],simulation_time_array,simulation_state_array[:,output_index]); # Compute the error - # Error is the sum of a shape function, a scale function and a background_copy_number function - # Compute the shape term - scaled_data_array = alpha_scaling(experimental_data_array[:,2]); scaled_simulation_array = alpha_scaling(interpolated_simulated_trajectory); shape_term = sum((scaled_data_array - scaled_simulation_array).^2); # Compute the initial value term - background_copy_number_dictionary = data_dictionary["background_copy_number_dictionary"]; background_copy_number = background_copy_number_dictionary[species_symbol] cell_volume = data_dictionary["cell_volume"]; av_number = data_dictionary["av_number"]; initial_concentration = background_copy_number*(1/av_number)*(1/cell_volume)*1e9; # nM initial_value_term = ((interpolated_simulated_trajectory[1] - initial_concentration)^2); # Compute the scale term - simulated_fold_change = (interpolated_simulated_trajectory)./(interpolated_simulated_trajectory[1]); scale_term = sum((simulated_fold_change - experimental_data_array[:,2]).^2); # @show (interpolated_simulated_trajectory[1],initial_concentration,interpolated_simulated_trajectory[end],species_symbol) # @show (shape_term,scale_term,initial_value_term) # compute the total error - total_error_value = shape_term+scale_term+initial_value_term; # return - return total_error_value end function Error_E2F(experimental_data_array,simulation_time_array,simulation_state_array,output_index,species_symbol,data_dictionary) # initialize - total_error_value = Inf # Interpole the simulation data to the experimental time scale - interpolated_simulated_trajectory = np.interp(experimental_data_array[:,1],simulation_time_array,simulation_state_array[:,output_index]); # Compute G1G0 - simulated_G1G0 = 1./interpolated_simulated_trajectory; # Compute the shape term - scaled_data_array = alpha_scaling(experimental_data_array[:,2]); scaled_simulation_array = alpha_scaling(simulated_G1G0); shape_term = sum((scaled_data_array - scaled_simulation_array).^2); # Compute the initial value term - background_copy_number_dictionary = data_dictionary["background_copy_number_dictionary"]; background_copy_number = background_copy_number_dictionary[species_symbol] cell_volume = data_dictionary["cell_volume"]; av_number = data_dictionary["av_number"]; initial_concentration = background_copy_number*(1/av_number)*(1/cell_volume)*1e9; # nM initial_value_term = ((interpolated_simulated_trajectory[1] - initial_concentration)^2); # Compute the fold change term - scaling_factor = simulated_G1G0[1]; simulated_fold_change = (simulated_G1G0)./(scaling_factor); scale_term = sum((simulated_fold_change - experimental_data_array[:,2]).^2); # compute the total error - total_error_value = shape_term+scale_term+initial_value_term; # return - return total_error_value; end function alpha_scaling(data_array) # get the dimension - number_of_points = length(data_array) # what is the min index? min_index = indmin(data_array) min_value = data_array[min_index] # What is the max index? max_index = indmax(data_array) max_value = data_array[max_index] # compute the scaling - scaled_array = Float64[] for index = 1:number_of_points value = data_array[index] scaled_value = (value - min_value)/(max_value - min_value) push!(scaled_array,scaled_value) end return scaled_array end
[ 8818, 13047, 7, 23100, 9134, 62, 7890, 62, 18747, 11, 14323, 1741, 62, 2435, 62, 18747, 11, 14323, 1741, 62, 5219, 62, 18747, 11, 22915, 62, 9630, 11, 35448, 62, 1837, 23650, 11, 7890, 62, 67, 14188, 8, 628, 220, 1303, 41216, 532, 198, 220, 2472, 62, 18224, 62, 8367, 796, 4806, 628, 220, 1303, 4225, 36869, 262, 18640, 1366, 284, 262, 11992, 640, 5046, 532, 198, 220, 39555, 515, 62, 14323, 4817, 62, 9535, 752, 652, 796, 45941, 13, 3849, 79, 7, 23100, 9134, 62, 7890, 62, 18747, 58, 45299, 16, 4357, 14323, 1741, 62, 2435, 62, 18747, 11, 14323, 1741, 62, 5219, 62, 18747, 58, 45299, 22915, 62, 9630, 36563, 628, 220, 1303, 3082, 1133, 262, 4049, 532, 198, 220, 1303, 13047, 318, 262, 2160, 286, 257, 5485, 2163, 11, 257, 5046, 2163, 290, 257, 4469, 62, 30073, 62, 17618, 2163, 532, 628, 220, 1303, 3082, 1133, 262, 5485, 3381, 532, 198, 220, 27464, 62, 7890, 62, 18747, 796, 17130, 62, 1416, 4272, 7, 23100, 9134, 62, 7890, 62, 18747, 58, 45299, 17, 36563, 198, 220, 27464, 62, 14323, 1741, 62, 18747, 796, 17130, 62, 1416, 4272, 7, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 1776, 198, 220, 5485, 62, 4354, 796, 2160, 19510, 1416, 3021, 62, 7890, 62, 18747, 532, 27464, 62, 14323, 1741, 62, 18747, 737, 61, 17, 1776, 628, 628, 220, 1303, 3082, 1133, 262, 4238, 1988, 3381, 532, 198, 220, 4469, 62, 30073, 62, 17618, 62, 67, 14188, 796, 1366, 62, 67, 14188, 14692, 25249, 62, 30073, 62, 17618, 62, 67, 14188, 8973, 26, 198, 220, 4469, 62, 30073, 62, 17618, 796, 4469, 62, 30073, 62, 17618, 62, 67, 14188, 58, 35448, 62, 1837, 23650, 60, 198, 220, 2685, 62, 29048, 796, 1366, 62, 67, 14188, 14692, 3846, 62, 29048, 8973, 26, 198, 220, 1196, 62, 17618, 796, 1366, 62, 67, 14188, 14692, 615, 62, 17618, 8973, 26, 198, 220, 4238, 62, 1102, 1087, 1358, 796, 4469, 62, 30073, 62, 17618, 9, 7, 16, 14, 615, 62, 17618, 27493, 7, 16, 14, 3846, 62, 29048, 27493, 16, 68, 24, 26, 1303, 299, 44, 198, 220, 4238, 62, 8367, 62, 4354, 796, 14808, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 58, 16, 60, 532, 4238, 62, 1102, 1087, 1358, 8, 61, 17, 1776, 628, 220, 1303, 3082, 1133, 262, 5046, 3381, 532, 198, 220, 28590, 62, 11379, 62, 3803, 796, 357, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 737, 29006, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 58, 16, 36563, 198, 220, 5046, 62, 4354, 796, 2160, 19510, 14323, 4817, 62, 11379, 62, 3803, 532, 11992, 62, 7890, 62, 18747, 58, 45299, 17, 35944, 61, 17, 1776, 628, 220, 1303, 2488, 12860, 357, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 58, 16, 4357, 36733, 62, 1102, 1087, 1358, 11, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 58, 437, 4357, 35448, 62, 1837, 23650, 8, 198, 220, 1303, 2488, 12860, 357, 43358, 62, 4354, 11, 9888, 62, 4354, 11, 36733, 62, 8367, 62, 4354, 8, 628, 220, 1303, 24061, 262, 2472, 4049, 532, 198, 220, 2472, 62, 18224, 62, 8367, 796, 5485, 62, 4354, 10, 9888, 62, 4354, 10, 36733, 62, 8367, 62, 4354, 26, 628, 220, 1303, 1441, 532, 198, 220, 1441, 2472, 62, 18224, 62, 8367, 198, 437, 198, 198, 8818, 13047, 62, 36, 17, 37, 7, 23100, 9134, 62, 7890, 62, 18747, 11, 14323, 1741, 62, 2435, 62, 18747, 11, 14323, 1741, 62, 5219, 62, 18747, 11, 22915, 62, 9630, 11, 35448, 62, 1837, 23650, 11, 7890, 62, 67, 14188, 8, 628, 220, 1303, 41216, 532, 198, 220, 2472, 62, 18224, 62, 8367, 796, 4806, 628, 220, 1303, 4225, 36869, 262, 18640, 1366, 284, 262, 11992, 640, 5046, 532, 198, 220, 39555, 515, 62, 14323, 4817, 62, 9535, 752, 652, 796, 45941, 13, 3849, 79, 7, 23100, 9134, 62, 7890, 62, 18747, 58, 45299, 16, 4357, 14323, 1741, 62, 2435, 62, 18747, 11, 14323, 1741, 62, 5219, 62, 18747, 58, 45299, 22915, 62, 9630, 36563, 628, 220, 1303, 3082, 1133, 402, 16, 38, 15, 532, 198, 220, 28590, 62, 38, 16, 38, 15, 796, 352, 19571, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 26, 628, 220, 1303, 3082, 1133, 262, 5485, 3381, 532, 198, 220, 27464, 62, 7890, 62, 18747, 796, 17130, 62, 1416, 4272, 7, 23100, 9134, 62, 7890, 62, 18747, 58, 45299, 17, 36563, 198, 220, 27464, 62, 14323, 1741, 62, 18747, 796, 17130, 62, 1416, 4272, 7, 14323, 4817, 62, 38, 16, 38, 15, 1776, 198, 220, 5485, 62, 4354, 796, 2160, 19510, 1416, 3021, 62, 7890, 62, 18747, 532, 27464, 62, 14323, 1741, 62, 18747, 737, 61, 17, 1776, 628, 220, 1303, 3082, 1133, 262, 4238, 1988, 3381, 532, 198, 220, 4469, 62, 30073, 62, 17618, 62, 67, 14188, 796, 1366, 62, 67, 14188, 14692, 25249, 62, 30073, 62, 17618, 62, 67, 14188, 8973, 26, 198, 220, 4469, 62, 30073, 62, 17618, 796, 4469, 62, 30073, 62, 17618, 62, 67, 14188, 58, 35448, 62, 1837, 23650, 60, 198, 220, 2685, 62, 29048, 796, 1366, 62, 67, 14188, 14692, 3846, 62, 29048, 8973, 26, 198, 220, 1196, 62, 17618, 796, 1366, 62, 67, 14188, 14692, 615, 62, 17618, 8973, 26, 198, 220, 4238, 62, 1102, 1087, 1358, 796, 4469, 62, 30073, 62, 17618, 9, 7, 16, 14, 615, 62, 17618, 27493, 7, 16, 14, 3846, 62, 29048, 27493, 16, 68, 24, 26, 1303, 299, 44, 198, 220, 4238, 62, 8367, 62, 4354, 796, 14808, 3849, 16104, 515, 62, 14323, 4817, 62, 9535, 752, 652, 58, 16, 60, 532, 4238, 62, 1102, 1087, 1358, 8, 61, 17, 1776, 628, 220, 1303, 3082, 1133, 262, 5591, 1487, 3381, 532, 198, 220, 20796, 62, 31412, 796, 28590, 62, 38, 16, 38, 15, 58, 16, 11208, 198, 220, 28590, 62, 11379, 62, 3803, 796, 357, 14323, 4817, 62, 38, 16, 38, 15, 737, 29006, 1416, 4272, 62, 31412, 1776, 198, 220, 5046, 62, 4354, 796, 2160, 19510, 14323, 4817, 62, 11379, 62, 3803, 532, 11992, 62, 7890, 62, 18747, 58, 45299, 17, 35944, 61, 17, 1776, 628, 220, 1303, 24061, 262, 2472, 4049, 532, 198, 220, 2472, 62, 18224, 62, 8367, 796, 5485, 62, 4354, 10, 9888, 62, 4354, 10, 36733, 62, 8367, 62, 4354, 26, 628, 220, 1303, 1441, 532, 198, 220, 1441, 2472, 62, 18224, 62, 8367, 26, 198, 437, 198, 198, 8818, 17130, 62, 1416, 4272, 7, 7890, 62, 18747, 8, 628, 220, 1303, 651, 262, 15793, 532, 198, 220, 1271, 62, 1659, 62, 13033, 796, 4129, 7, 7890, 62, 18747, 8, 628, 220, 1303, 644, 318, 262, 949, 6376, 30, 198, 220, 949, 62, 9630, 796, 773, 1084, 7, 7890, 62, 18747, 8, 198, 220, 949, 62, 8367, 796, 1366, 62, 18747, 58, 1084, 62, 9630, 60, 628, 220, 1303, 1867, 318, 262, 3509, 6376, 30, 198, 220, 3509, 62, 9630, 796, 773, 9806, 7, 7890, 62, 18747, 8, 198, 220, 3509, 62, 8367, 796, 1366, 62, 18747, 58, 9806, 62, 9630, 60, 628, 220, 1303, 24061, 262, 20796, 532, 198, 220, 27464, 62, 18747, 796, 48436, 2414, 21737, 198, 220, 329, 6376, 796, 352, 25, 17618, 62, 1659, 62, 13033, 628, 220, 220, 220, 1988, 796, 1366, 62, 18747, 58, 9630, 60, 198, 220, 220, 220, 27464, 62, 8367, 796, 357, 8367, 532, 949, 62, 8367, 20679, 7, 9806, 62, 8367, 532, 949, 62, 8367, 8, 198, 220, 220, 220, 4574, 0, 7, 1416, 3021, 62, 18747, 11, 1416, 3021, 62, 8367, 8, 198, 220, 886, 628, 220, 1441, 27464, 62, 18747, 198, 437, 198 ]
3.024467
1,267
""" vbmf_sparse_parameters Compound type for vbmf_sparse computation. Contains the following fields:\n L::Int - number of rows of the original matrix M::Int - number of columns of the original matrix H::Int - internal product dimension MH::Int - dimension of vec(A') H1::Int - number of columns of B that should belong to a contaminated class labels::Array{Int64, 1} - which columns of Y are labeled as non-contaminated AHat::Array{Float64, 2} - mean value of A, size (M, H) ATVecHat::Array{Float64, 1} - mean value of vec(A^T), size (MH,1) SigmaATVec::Array{Float64, 2} - covariance of vec(A^T), size (MH, MH) diagSigmaATVec::Array{Float64,1} - diagonal of covariance of vec(A^T), size (MH) invSigmaATVec::Array{Float64, 2} - inverse of covariance of vec(A^T), size (MH, MH) SigmaA::Array{Float64,2} - covariance of A matrix, size (H, H) BHat::Array{Float64, 2} - mean value of B, size (L, H) SigmaB::Array{Float64, 2} - covariance of B matrix, size (H, H) CA::Array{Float64, 1} - diagonal of the prior covariance of vec(A^T), size (MH) alpha0::Float64 - shape of CA gamma prior beta0::Float64 - scale of CA gamma prior alpha::Float64 - shape of CA gamma posterior beta::Array{Float64,1} - scale of CA gamma posterior, size (MH, 1) CB::Array{Float64, 1} - diagonal of prior covariance of B, size (H) gamma0::Float64 - shape of CB gamma prior delta0::Float64 - scale of CB gamma prior gamma::Float64 - shape of CB posterior delta::Array{Float64,1} - scale of CB posterior, size (H) sigmaHat::Float64 - variance of data - homoscedastic case eta0::Float64 - shape of sigma gamma prior zeta0::Float64 - scale of sigma gamma prior eta::Float64 - shape of homoscedastic sigma posterior zeta::Float64 - scale of homoscedastic sigma posterior sigmaVecHat::Array{Float64,1} - variance of data (rows) - heteroscedastic case, size (L) etaVec::Array{Float64,1} - shape of heteroscedastic sigma posterior, size (L) zetaVec::Array{Float64,1} - scale of heteroscedastic sigma posterior, size (L) YHat::Array{Float64, 2} - estimate of Y, size (L, M) trYTY::Float64 - trace(Y^T*Y), saved so that it does not have to be recomputed """ type vbmf_sparse_parameters L::Int M::Int H::Int MH::Int H1::Int labels::Array{Int64,1} AHat::Array{Float64, 2} ATVecHat::Array{Float64, 1} SigmaATVec::Array{Float64, 2} diagSigmaATVec::Array{Float64,1} invSigmaATVec::Array{Float64, 2} SigmaA::Array{Float64,2} BHat::Array{Float64, 2} SigmaB::Array{Float64, 2} CA::Array{Float64, 1} alpha0::Float64 beta0::Float64 alpha::Float64 beta::Array{Float64,1} CB::Array{Float64, 1} gamma0::Float64 delta0::Float64 gamma::Float64 delta::Array{Float64,1} sigmaHat::Float64 eta0::Float64 zeta0::Float64 eta::Float64 zeta::Float64 sigmaVecHat::Array{Float64,1} etaVec::Array{Float64,1} zetaVec::Array{Float64,1} YHat::Array{Float64, 2} trYTY::Float64 vbmf_sparse_parameters() = new() end """ vbmf_sparse_init(Y::Array{Float64,2}, H::Int; ca::Float64 = 1.0, alpha0::Float64 = 1e-10, beta0::Float64 = 1e-10, cb::Float64 = 1.0, gamma0::Float64 = 1e-10, delta0::Float64 = 1e-10, sigma::Float64 = 1.0, eta0::Float64 = 1e-10, zeta0::Float64 = 1e-10, H1::Int = 0, labels::Array{Int64,1} = Array{Int64,1}()) Returns an initialized structure of type vbmf_sparse_parameters. """ function vbmf_sparse_init(Y::Array{Float64,2}, H::Int; ca::Float64 = 1.0, alpha0::Float64 = 1e-10, beta0::Float64 = 1e-10, cb::Float64 = 1.0, gamma0::Float64 = 1e-10, delta0::Float64 = 1e-10, sigma::Float64 = 1.0, eta0::Float64 = 1e-10, zeta0::Float64 = 1e-10, H1::Int = 0, labels::Array{Int64,1} = Array{Int64,1}()) params = vbmf_sparse_parameters() L, M = size(Y) params.L, params.M = L, M params.H = H params.MH = M*H params.H1 = H1 params.labels = labels params.AHat = randn(M, H) # now set zeroes to where the columns of Y labeled as non-infected are # in A, these are rows params.AHat[labels, end-H1+1:end] = 0.0 params.ATVecHat = reshape(params.AHat', M*H) params.SigmaATVec = eye(M*H, M*H) params.diagSigmaATVec = ones(M*H) params.invSigmaATVec = eye(M*H, M*H) params.SigmaA = zeros(H, H) params.BHat = randn(L, H) params.SigmaB = zeros(H, H) params.CA = ca*ones(M*H) params.alpha0 = alpha0 params.beta0 = beta0 params.alpha = params.alpha0 + 0.5 params.beta = beta0*ones(M*H) params.CB = cb*ones(H) params.gamma0 = gamma0 params.delta0 = delta0 params.gamma = gamma0 + L/2 params.delta = delta0*ones(H) params.sigmaHat = sigma params.eta0 = eta0 params.zeta0 = zeta0 params.eta = eta0 + L*M/2 params.zeta = zeta0 params.sigmaVecHat = sigma*ones(L) params.etaVec = (eta0 + M/2)*ones(L) params.zetaVec = zeta0*ones(L) params.YHat = params.BHat*params.AHat' params.trYTY = traceXTY(Y, Y) return params end """ copy(params_in::vbmf_sparse_parameters) Copy function for vbmfa_sparse_parameters. """ function copy(params_in::vbmf_sparse_parameters) params = vbmf_sparse_parameters() for field in fieldnames(params_in) setfield!(params, field, copy(getfield(params_in, field))) end return params end """ updateA!(Y::Array{Float64,2}, params::vbmf_sparse_parameters; full_cov::Bool, diag_var::Bool = false) Updates mean and covariance of vec(A^T) and also of the A matrix. If full_cov is true, then inverse of full covariance matrix is computed, otherwise just the diagonal is estimated. """ function updateA!(Y::Array{Float64,2}, params::vbmf_sparse_parameters; full_cov::Bool = false, diag_var::Bool = false) # either just the diagonal or the full covariance if full_cov # compute the inverse of covariance if diag_var params.invSigmaATVec = kron(eye(params.M), (params.BHat'*diagm(params.sigmaVecHat)*params.BHat + params.L*mean(params.sigmaVecHat)*params.SigmaB)) + diagm(params.CA) else params.invSigmaATVec = params.sigmaHat*kron(eye(params.M), (params.BHat'*params.BHat + params.L*params.SigmaB)) + diagm(params.CA) end params.SigmaATVec = inv(params.invSigmaATVec) params.diagSigmaATVec = diag(params.SigmaATVec) # now the mean if diag_var params.ATVecHat = params.SigmaATVec*reshape(params.BHat'*diagm(params.sigmaVecHat)*Y, params.H*params.M) else params.ATVecHat = params.sigmaHat*params.SigmaATVec*reshape(params.BHat'*Y, params.H*params.M) end # now compute the covariance of AHat params.SigmaA = zeros(params.H, params.H) for m in 1:params.M params.SigmaA += view(params.SigmaATVec, (m-1)*params.H+1:m*params.H, (m-1)*params.H+1:m*params.H) end else # this updates just the diagonal of the covariance of A # compute the inverse of covariance # only use for large problems, for small problems the full covariance is more precise if diag_var for h in 1:params.H # instead of the full matrix multiplication as above, we compute just # the diagonal params.diagSigmaATVec[h] = norm2(params.BHat[:,h].*params.sigmaVecHat) + params.L*mean(params.sigmaVecHat)*params.SigmaB[h,h] end else # this is computed in case the variance of data is homoscedastic for h in 1:params.H # instead of the full matrix multiplication as above, we compute just # the diagonal params.diagSigmaATVec[h] = params.sigmaHat*norm2(params.BHat[:,h]) + params.L*params.SigmaB[h,h] end end # we filled just the first H elements, so we just copy it to fill the rest params.diagSigmaATVec[params.H+1:end] = repeat(params.diagSigmaATVec[1:params.H], inner = params.M-1) # also add the CA vector params.diagSigmaATVec += params.CA # finally, invert it params.diagSigmaATVec = 1./params.diagSigmaATVec # now the mean if diag_var params.ATVecHat = params.diagSigmaATVec.*reshape(params.BHat'*diagm(params.sigmaVecHat)*Y, params.H*params.M) else params.ATVecHat = params.sigmaHat*params.diagSigmaATVec.*reshape(params.BHat'*Y, params.H*params.M) end # now compute the covariance of AHat params.SigmaA = zeros(params.H, params.H) for m in 1:params.M params.SigmaA += diagm(view(params.diagSigmaATVec, (m-1)*params.H+1:m*params.H)) end end # now set zeroes to where the columns of Y labeled as non-infected are # in A, these are rows params.AHat = reshape(params.ATVecHat, params.H, params.M)' params.AHat[params.labels, end-params.H1+1:end] = 0.0 params.ATVecHat = reshape(params.AHat', params.M*params.H) end """ updateB!(Y::Array{Float64,2}, params::vbmf_sparse_parameters, diag_var::Bool = false) Updates mean and covariance of the B matrix. """ function updateB!(Y::Array{Float64,2}, params::vbmf_sparse_parameters; diag_var::Bool = false) # first, compute the inverse of the covariance if diag_var params.SigmaB = diagm(params.CB) + mean(params.sigmaVecHat)*(params.AHat'*params.AHat + params.SigmaA) #invert it params.SigmaB = inv(params.SigmaB) # now compute the mean params.BHat = diagm(params.sigmaVecHat)*Y*params.AHat*params.SigmaB else params.SigmaB = diagm(params.CB) + params.sigmaHat*(params.AHat'*params.AHat + params.SigmaA) #invert it params.SigmaB = inv(params.SigmaB) params.BHat = params.sigmaHat*Y*params.AHat*params.SigmaB end end """ updateYHat!(params::vbmf_sparse_parameters) Updates estimate of Y. """ function updateYHat!(params::vbmf_sparse_parameters) params.YHat = params.BHat*params.AHat' end """ updateCA!(params::vbmf_sparse_parameters) Updates the estimate of CA. """ function updateCA!(params::vbmf_sparse_parameters) params.beta = params.beta0*ones(params.M*params.H) + 1/2*(params.ATVecHat.*params.ATVecHat + params.diagSigmaATVec) params.CA = params.alpha*ones(params.M*params.H)./params.beta end """ updateCB!(params::vbmf_sparse_parameters) Updates the estimate of CB. """ function updateCB!(params::vbmf_sparse_parameters) for h in 1:params.H params.delta[h] = params.delta0 + 1/2*(params.BHat[:,h]'*params.BHat[:,h])[1] + 1/2*params.SigmaB[h,h] params.CB[h] = params.gamma/params.delta[h] end end """ updateSigma!(Y::Array{Float64,2}, params::vbmf_sparse_parameters, diag_var::Bool = false) Updates estimate of the measurement variance. """ function updateSigma!(Y::Array{Float64,2}, params::vbmf_sparse_parameters; diag_var::Bool = false) if diag_var for l in 1:params.L params.zetaVec[l] = params.zeta0 + 1/2*norm2(Y[l,:]) - sum(Y[l,:].*(params.AHat*params.BHat[l,:])) + 1/2*traceXTY(params.AHat'*params.AHat + params.SigmaA, params.BHat[l,:]*params.BHat[l,:]' + params.SigmaB) params.sigmaVecHat[l] = params.etaVec[l]/params.zetaVec[l] end else params.zeta = params.zeta0 + 1/2*params.trYTY - traceXTY(params.BHat, Y*params.AHat) + 1/2*traceXTY(params.AHat'*params.AHat + params.SigmaA, params.BHat'*params.BHat + params.L*params.SigmaB) params.sigmaHat = params.eta/params.zeta end end """ vbmf_sparse!(Y::Array{Float64, 2}, params::vbmf_sparse_parameters, niter::Int, eps::Float64 = 1e-6, est_var = false, full_cov::Bool = false, logdir = "", desc = "") Computes variational bayes matrix factorization of Y = AB' + E. Independence of A and B is assumed. Estimate of variance sigma can be either a scalar or a vector - for row variance estimation. ARD property is imposed upon columns of B and also upon vec(A) through gamma prior CB and CA and estimation of covariance. The prior model is following: p(Y|A,B) = N(Y|BA^T, 1/sigma*I) or p(Y|A,B) = N(Y|BA^T, inv(diag(sigma))) p(vec(A^T)) = N(vec(A^T)|0, invCA), CA = diag(c_a) p(B_h) = MN(B|0, I, invCB), CB = diag(c1, ..., cH) p(CA) = G(C_A| alpha0, beta0) p(CB) = G(C_B| gamma0, delta0) The params argument with initialized data is modified and contains the resulting estimates after the algorithm stops. """ function vbmf_sparse!(Y::Array{Float64, 2}, params::vbmf_sparse_parameters, niter::Int; eps::Float64 = 1e-6, diag_var::Bool = false, full_cov::Bool = false, logdir = "", desc = "", verb = false, est_cb::Bool = true) priors = Dict() # create the log dictionary loging = false if logdir !="" loging = true logVar = create_log(params) end # choice of convergence control variable convergence_var = :BHat #convergence_var = :dY if convergence_var == :dY old = Y - params.YHat else old = copy(getfield(params, convergence_var)) end d = eps + 1.0 # delta i = 1 # run the loop for a given number of iterations while ((i <= niter) && (d > eps)) updateA!(Y, params, full_cov = full_cov, diag_var = diag_var) updateB!(Y, params, diag_var = diag_var) updateCA!(params) if est_cb updateCB!(params) end updateSigma!(Y, params, diag_var = diag_var) if loging update_log!(logVar, params) end # check convergence if convergence_var == :dY updateYHat!(params) d = delta(Y - params.YHat, old) old = Y - params.YHat else d = delta(getfield(params, convergence_var), old) old = copy(getfield(params, convergence_var)) end i += 1 end # finally, compute the estimate of Y updateYHat!(params) # convergence info if verb print("Factorization finished after ", i-1, " iterations, eps = ", d, "\n") end # save inputs and outputs if loging println("Saving outputs and inputs under ", logdir, "/") save_log(logVar, Y, priors, logdir, desc = desc) end return d end """ vbmf_sparse(Y::Array{Float64, 2}, params_in::vbmf_sparse_parameters, niter::Int, eps::Float64 = 1e-6, est_var = false, full_cov::Bool = false, logdir = "", desc = "") Calls vbmf_sparse!() but copies the params_in argument so that it is not modified and can be reused. """ function vbmf_sparse(Y::Array{Float64, 2}, params_in::vbmf_sparse_parameters, niter::Int; eps::Float64 = 1e-6, diag_var::Bool = false, full_cov::Bool = false, logdir = "", desc = "", verb = false, est_cb::Bool = true) # make a copy of input params params = copy(params_in) # run the algorithm d = vbmf_sparse!(Y, params, niter, eps = eps, diag_var = diag_var, full_cov = full_cov, logdir = logdir, desc = desc, verb = verb, est_cb = est_cb) return params, d end """ lowerBound(Y::Array{Float64,2}, params::vbmf_sparse_parameters) Compute the lower bound for logarithm of data distribution. """ function lowerBound(Y::Array{Float64,2}, params::vbmf_sparse_parameters) L = 0.0 # E[lnp(Y|params)] L += - params.L*params.M/2*ln2pi + params.L*params.M/2*gammaELn(params.eta, params.zeta) L += - params.sigmaHat/2*(params.trYTY - 2*traceXTY(params.BHat, Y*params.AHat) + traceXTY(params.AHat'*params.AHat + params.SigmaA, params.BHat'*params.BHat + params.L*params.SigmaB)) # E[lnp(vec(A'))] L += - params.MH/2*ln2pi + 1/2*sum(map(gammaELn, params.alpha*ones(size(params.beta)), params.beta)) L += - (1/2*params.CA'*(params.ATVecHat.^2 + params.diagSigmaATVec))[1] # E[lnp(B)] L += - params.L*params.H/2*ln2pi L += params.L/2*sum(map(gammaELn, params.gamma*ones(size(params.delta)), params.delta)) L += - 1/2*traceXTY(diagm(params.CB), (params.BHat'*params.BHat + params.L*params.SigmaB)) # E[lnp(sigma)] L += params.eta0*log(params.zeta0) - lgamma(params.eta0) L += (params.eta0 - 1)*gammaELn(params.eta, params.zeta) - params.zeta0*params.sigmaHat # E[lnp(CA)] L += params.MH*(params.alpha0*log(params.beta0) - lgamma(params.alpha0)) L += (params.alpha0 - 1)*sum(map(gammaELn, params.alpha*ones(size(params.beta)), params.beta)) L += - params.beta0*sum(params.CA) # E[lnp(CB)] L += params.H*(params.gamma0*log(params.delta0) - lgamma(params.gamma0)) L += (params.gamma0 - 1)*sum(map(gammaELn, params.gamma*ones(size(params.delta)), params.delta)) L += - params.gamma0*sum(params.CB) # H(vec(A')) L += normalEntropy(params.diagSigmaATVec) # H(B) L += normalEntropy(kron(params.SigmaB,eye(params.L))) # H(sigma) L += gammaEntropy(params.eta, params.zeta) # H(CA) L += sum(map(gammaEntropy, params.alpha*ones(size(params.beta)), params.beta)) # H(CB) L += sum(map(gammaEntropy, params.gamma*ones(size(params.delta)), params.delta)) return L end """ lowerBoundTrimmed(Y::Array{Float64,2}, params_in::vbmf_sparse_parameters, trim = 1e-1) AHat with abs(AHat[i,j]) < trim and the corresponding elements of CA are not involved in the computation. """ function lowerBoundTrimmed(Y::Array{Float64,2}, params_in::vbmf_sparse_parameters, trim = 1e-1) params = copy(params_in) trim_inds = (abs(params.ATVecHat) .> trim) params.ATVecHat = params.ATVecHat[trim_inds] params.MH = size(params.ATVecHat)[1] params.beta = params.beta[trim_inds] params.CA = params.CA[trim_inds] params.diagSigmaATVec = params.diagSigmaATVec[trim_inds] return lowerBound(Y, params) end
[ 37811, 198, 220, 220, 410, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 198, 198, 7293, 633, 2099, 329, 410, 20475, 69, 62, 82, 29572, 29964, 13, 49850, 262, 1708, 7032, 7479, 77, 220, 198, 220, 220, 220, 220, 198, 220, 220, 220, 406, 3712, 5317, 532, 1271, 286, 15274, 286, 262, 2656, 17593, 220, 198, 220, 220, 220, 337, 3712, 5317, 532, 1271, 286, 15180, 286, 262, 2656, 17593, 198, 220, 220, 220, 367, 3712, 5317, 532, 5387, 1720, 15793, 198, 220, 220, 220, 20752, 3712, 5317, 532, 15793, 286, 43030, 7, 32, 11537, 198, 220, 220, 220, 367, 16, 3712, 5317, 532, 1271, 286, 15180, 286, 347, 326, 815, 5594, 284, 257, 23543, 1398, 198, 220, 220, 220, 14722, 3712, 19182, 90, 5317, 2414, 11, 352, 92, 532, 543, 15180, 286, 575, 389, 15494, 355, 1729, 12, 3642, 321, 3898, 628, 220, 220, 220, 28159, 265, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 532, 1612, 1988, 286, 317, 11, 2546, 357, 44, 11, 367, 8, 198, 220, 220, 220, 5161, 53, 721, 40483, 3712, 19182, 90, 43879, 2414, 11, 352, 92, 532, 1612, 1988, 286, 43030, 7, 32, 61, 51, 828, 2546, 357, 36208, 11, 16, 8, 198, 220, 220, 220, 31669, 1404, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 532, 44829, 590, 286, 43030, 7, 32, 61, 51, 828, 2546, 357, 36208, 11, 20752, 8, 198, 220, 220, 220, 2566, 363, 50, 13495, 1404, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 532, 40039, 286, 44829, 590, 286, 43030, 7, 32, 61, 51, 828, 2546, 357, 36208, 8, 198, 220, 220, 220, 800, 50, 13495, 1404, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 532, 34062, 286, 44829, 590, 286, 43030, 7, 32, 61, 51, 828, 2546, 357, 36208, 11, 20752, 8, 198, 220, 220, 220, 31669, 32, 3712, 19182, 90, 43879, 2414, 11, 17, 92, 532, 44829, 590, 286, 317, 17593, 11, 2546, 357, 39, 11, 367, 8, 628, 220, 220, 220, 347, 40483, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 532, 1612, 1988, 286, 347, 11, 2546, 357, 43, 11, 367, 8, 198, 220, 220, 220, 31669, 33, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 532, 44829, 590, 286, 347, 17593, 11, 2546, 357, 39, 11, 367, 8, 628, 220, 220, 220, 7257, 3712, 19182, 90, 43879, 2414, 11, 352, 92, 532, 40039, 286, 262, 3161, 44829, 590, 286, 43030, 7, 32, 61, 51, 828, 2546, 357, 36208, 8, 198, 220, 220, 220, 17130, 15, 3712, 43879, 2414, 532, 5485, 286, 7257, 34236, 3161, 198, 220, 220, 220, 12159, 15, 3712, 43879, 2414, 532, 5046, 286, 7257, 34236, 3161, 198, 220, 220, 220, 17130, 3712, 43879, 2414, 532, 5485, 286, 7257, 34236, 34319, 198, 220, 220, 220, 12159, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 532, 5046, 286, 7257, 34236, 34319, 11, 2546, 357, 36208, 11, 352, 8, 628, 220, 220, 220, 10078, 3712, 19182, 90, 43879, 2414, 11, 352, 92, 532, 40039, 286, 3161, 44829, 590, 286, 347, 11, 2546, 357, 39, 8, 198, 220, 220, 220, 34236, 15, 3712, 43879, 2414, 532, 5485, 286, 10078, 34236, 3161, 198, 220, 220, 220, 25979, 15, 3712, 43879, 2414, 532, 5046, 286, 10078, 34236, 3161, 198, 220, 220, 220, 34236, 3712, 43879, 2414, 532, 5485, 286, 10078, 34319, 198, 220, 220, 220, 25979, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 532, 5046, 286, 10078, 34319, 11, 2546, 357, 39, 8, 628, 220, 220, 220, 264, 13495, 40483, 3712, 43879, 2414, 532, 24198, 286, 1366, 532, 3488, 418, 771, 3477, 1339, 198, 220, 220, 220, 2123, 64, 15, 3712, 43879, 2414, 532, 5485, 286, 264, 13495, 34236, 3161, 198, 220, 220, 220, 1976, 17167, 15, 3712, 43879, 2414, 532, 5046, 286, 264, 13495, 34236, 3161, 198, 220, 220, 220, 2123, 64, 3712, 43879, 2414, 532, 5485, 286, 3488, 418, 771, 3477, 264, 13495, 34319, 198, 220, 220, 220, 1976, 17167, 3712, 43879, 2414, 532, 5046, 286, 3488, 418, 771, 3477, 264, 13495, 34319, 220, 198, 220, 220, 220, 264, 13495, 53, 721, 40483, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 532, 24198, 286, 1366, 357, 8516, 8, 532, 14445, 418, 771, 3477, 1339, 11, 2546, 357, 43, 8, 198, 220, 220, 220, 2123, 64, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 532, 5485, 286, 14445, 418, 771, 3477, 264, 13495, 34319, 11, 2546, 357, 43, 8, 198, 220, 220, 220, 1976, 17167, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 532, 5046, 286, 14445, 418, 771, 3477, 264, 13495, 34319, 11, 2546, 357, 43, 8, 628, 220, 220, 220, 575, 40483, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 532, 8636, 286, 575, 11, 2546, 357, 43, 11, 337, 8, 198, 220, 220, 220, 491, 56, 9936, 3712, 43879, 2414, 532, 12854, 7, 56, 61, 51, 9, 56, 828, 7448, 523, 326, 340, 857, 407, 423, 284, 307, 664, 296, 17128, 198, 37811, 198, 4906, 410, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 198, 220, 220, 220, 406, 3712, 5317, 198, 220, 220, 220, 337, 3712, 5317, 198, 220, 220, 220, 367, 3712, 5317, 198, 220, 220, 220, 20752, 3712, 5317, 198, 220, 220, 220, 367, 16, 3712, 5317, 198, 220, 220, 220, 14722, 3712, 19182, 90, 5317, 2414, 11, 16, 92, 628, 220, 220, 220, 28159, 265, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 198, 220, 220, 220, 5161, 53, 721, 40483, 3712, 19182, 90, 43879, 2414, 11, 352, 92, 198, 220, 220, 220, 31669, 1404, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 198, 220, 220, 220, 2566, 363, 50, 13495, 1404, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 198, 220, 220, 220, 800, 50, 13495, 1404, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 198, 220, 220, 220, 31669, 32, 3712, 19182, 90, 43879, 2414, 11, 17, 92, 198, 220, 220, 220, 220, 198, 220, 220, 220, 347, 40483, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 198, 220, 220, 220, 31669, 33, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 628, 220, 220, 220, 7257, 3712, 19182, 90, 43879, 2414, 11, 352, 92, 198, 220, 220, 220, 17130, 15, 3712, 43879, 2414, 198, 220, 220, 220, 12159, 15, 3712, 43879, 2414, 198, 220, 220, 220, 17130, 3712, 43879, 2414, 198, 220, 220, 220, 12159, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 628, 220, 220, 220, 10078, 3712, 19182, 90, 43879, 2414, 11, 352, 92, 198, 220, 220, 220, 34236, 15, 3712, 43879, 2414, 198, 220, 220, 220, 25979, 15, 3712, 43879, 2414, 198, 220, 220, 220, 34236, 3712, 43879, 2414, 198, 220, 220, 220, 25979, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 628, 220, 220, 220, 264, 13495, 40483, 3712, 43879, 2414, 198, 220, 220, 220, 2123, 64, 15, 3712, 43879, 2414, 198, 220, 220, 220, 1976, 17167, 15, 3712, 43879, 2414, 198, 220, 220, 220, 2123, 64, 3712, 43879, 2414, 198, 220, 220, 220, 1976, 17167, 3712, 43879, 2414, 198, 220, 220, 220, 264, 13495, 53, 721, 40483, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 198, 220, 220, 220, 2123, 64, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 198, 220, 220, 220, 1976, 17167, 53, 721, 3712, 19182, 90, 43879, 2414, 11, 16, 92, 628, 220, 220, 220, 575, 40483, 3712, 19182, 90, 43879, 2414, 11, 362, 92, 198, 220, 220, 220, 491, 56, 9936, 3712, 43879, 2414, 198, 220, 220, 220, 220, 198, 220, 220, 220, 410, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 3419, 796, 649, 3419, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 410, 20475, 69, 62, 82, 29572, 62, 15003, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 367, 3712, 5317, 26, 1275, 3712, 43879, 2414, 796, 352, 13, 15, 11, 220, 198, 220, 220, 220, 17130, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 12159, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 269, 65, 3712, 43879, 2414, 796, 352, 13, 15, 11, 220, 198, 220, 220, 220, 34236, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 25979, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 198, 220, 220, 220, 264, 13495, 3712, 43879, 2414, 796, 352, 13, 15, 11, 2123, 64, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 1976, 17167, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 198, 220, 220, 220, 367, 16, 3712, 5317, 796, 657, 11, 14722, 3712, 19182, 90, 5317, 2414, 11, 16, 92, 796, 15690, 90, 5317, 2414, 11, 16, 92, 28955, 198, 198, 35561, 281, 23224, 4645, 286, 2099, 410, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 13, 198, 37811, 198, 8818, 410, 20475, 69, 62, 82, 29572, 62, 15003, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 367, 3712, 5317, 26, 1275, 3712, 43879, 2414, 796, 352, 13, 15, 11, 220, 198, 220, 220, 220, 17130, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 12159, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 269, 65, 3712, 43879, 2414, 796, 352, 13, 15, 11, 220, 198, 220, 220, 220, 34236, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 25979, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 198, 220, 220, 220, 264, 13495, 3712, 43879, 2414, 796, 352, 13, 15, 11, 2123, 64, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 1976, 17167, 15, 3712, 43879, 2414, 796, 352, 68, 12, 940, 11, 198, 220, 220, 220, 367, 16, 3712, 5317, 796, 657, 11, 14722, 3712, 19182, 90, 5317, 2414, 11, 16, 92, 796, 15690, 90, 5317, 2414, 11, 16, 92, 28955, 198, 220, 220, 220, 42287, 796, 410, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 3419, 198, 220, 220, 220, 406, 11, 337, 796, 2546, 7, 56, 8, 628, 220, 220, 220, 42287, 13, 43, 11, 42287, 13, 44, 796, 406, 11, 337, 220, 198, 220, 220, 220, 42287, 13, 39, 796, 367, 198, 220, 220, 220, 42287, 13, 36208, 796, 337, 9, 39, 198, 220, 220, 220, 42287, 13, 39, 16, 796, 367, 16, 198, 220, 220, 220, 42287, 13, 23912, 1424, 796, 14722, 628, 220, 220, 220, 42287, 13, 18429, 265, 796, 43720, 77, 7, 44, 11, 367, 8, 198, 220, 220, 220, 1303, 783, 900, 1976, 263, 3028, 284, 810, 262, 15180, 286, 575, 15494, 355, 1729, 12, 27816, 276, 389, 198, 220, 220, 220, 1303, 287, 317, 11, 777, 389, 15274, 198, 220, 220, 220, 42287, 13, 18429, 265, 58, 23912, 1424, 11, 886, 12, 39, 16, 10, 16, 25, 437, 60, 796, 657, 13, 15, 198, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 27179, 1758, 7, 37266, 13, 18429, 265, 3256, 337, 9, 39, 8, 198, 220, 220, 220, 42287, 13, 50, 13495, 1404, 53, 721, 796, 4151, 7, 44, 9, 39, 11, 337, 9, 39, 8, 198, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 796, 3392, 7, 44, 9, 39, 8, 198, 220, 220, 220, 42287, 13, 16340, 50, 13495, 1404, 53, 721, 796, 4151, 7, 44, 9, 39, 11, 337, 9, 39, 8, 198, 220, 220, 220, 42287, 13, 50, 13495, 32, 796, 1976, 27498, 7, 39, 11, 367, 8, 628, 220, 220, 220, 42287, 13, 33, 40483, 796, 43720, 77, 7, 43, 11, 367, 8, 198, 220, 220, 220, 42287, 13, 50, 13495, 33, 796, 1976, 27498, 7, 39, 11, 367, 8, 628, 220, 220, 220, 42287, 13, 8141, 796, 1275, 9, 1952, 7, 44, 9, 39, 8, 198, 220, 220, 220, 42287, 13, 26591, 15, 796, 17130, 15, 198, 220, 220, 220, 42287, 13, 31361, 15, 796, 12159, 15, 198, 220, 220, 220, 42287, 13, 26591, 796, 42287, 13, 26591, 15, 1343, 657, 13, 20, 198, 220, 220, 220, 42287, 13, 31361, 796, 12159, 15, 9, 1952, 7, 44, 9, 39, 8, 628, 220, 220, 220, 42287, 13, 23199, 796, 269, 65, 9, 1952, 7, 39, 8, 220, 220, 198, 220, 220, 220, 42287, 13, 28483, 2611, 15, 796, 34236, 15, 198, 220, 220, 220, 42287, 13, 67, 12514, 15, 796, 25979, 15, 198, 220, 220, 220, 42287, 13, 28483, 2611, 796, 34236, 15, 1343, 406, 14, 17, 198, 220, 220, 220, 42287, 13, 67, 12514, 796, 25979, 15, 9, 1952, 7, 39, 8, 628, 220, 220, 220, 42287, 13, 82, 13495, 40483, 796, 264, 13495, 198, 220, 220, 220, 42287, 13, 17167, 15, 796, 2123, 64, 15, 198, 220, 220, 220, 42287, 13, 89, 17167, 15, 796, 1976, 17167, 15, 198, 220, 220, 220, 42287, 13, 17167, 796, 2123, 64, 15, 1343, 406, 9, 44, 14, 17, 198, 220, 220, 220, 42287, 13, 89, 17167, 796, 1976, 17167, 15, 198, 220, 220, 220, 42287, 13, 82, 13495, 53, 721, 40483, 796, 264, 13495, 9, 1952, 7, 43, 8, 198, 220, 220, 220, 42287, 13, 17167, 53, 721, 796, 357, 17167, 15, 1343, 337, 14, 17, 27493, 1952, 7, 43, 8, 198, 220, 220, 220, 42287, 13, 89, 17167, 53, 721, 796, 1976, 17167, 15, 9, 1952, 7, 43, 8, 628, 220, 220, 220, 42287, 13, 56, 40483, 796, 42287, 13, 33, 40483, 9, 37266, 13, 18429, 265, 6, 198, 220, 220, 220, 42287, 13, 2213, 56, 9936, 796, 12854, 55, 9936, 7, 56, 11, 575, 8, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1441, 42287, 198, 437, 198, 198, 37811, 198, 220, 220, 4866, 7, 37266, 62, 259, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 198, 29881, 2163, 329, 410, 20475, 13331, 62, 82, 29572, 62, 17143, 7307, 13, 220, 198, 37811, 198, 8818, 4866, 7, 37266, 62, 259, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 220, 220, 220, 42287, 796, 410, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 3419, 198, 220, 220, 220, 220, 198, 220, 220, 220, 329, 2214, 287, 2214, 14933, 7, 37266, 62, 259, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 3245, 0, 7, 37266, 11, 2214, 11, 4866, 7, 1136, 3245, 7, 37266, 62, 259, 11, 2214, 22305, 198, 220, 220, 220, 886, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1441, 42287, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 4296, 32, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 26, 1336, 62, 66, 709, 3712, 33, 970, 11, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 8, 198, 198, 4933, 19581, 1612, 290, 44829, 590, 286, 43030, 7, 32, 61, 51, 8, 290, 635, 286, 262, 317, 17593, 13, 1002, 1336, 62, 66, 709, 318, 2081, 11, 220, 198, 8524, 34062, 286, 1336, 44829, 590, 17593, 318, 29231, 11, 4306, 655, 262, 40039, 318, 6108, 13, 198, 37811, 198, 8818, 4296, 32, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 26, 1336, 62, 66, 709, 3712, 33, 970, 796, 3991, 11, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 8, 198, 220, 220, 220, 1303, 2035, 655, 262, 40039, 393, 262, 1336, 44829, 590, 198, 220, 220, 220, 611, 1336, 62, 66, 709, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 24061, 262, 34062, 286, 44829, 590, 198, 220, 220, 220, 220, 220, 220, 220, 611, 2566, 363, 62, 7785, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 16340, 50, 13495, 1404, 53, 721, 796, 479, 1313, 7, 25379, 7, 37266, 13, 44, 828, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 357, 37266, 13, 33, 40483, 6, 9, 10989, 363, 76, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 37266, 13, 33, 40483, 1343, 42287, 13, 43, 9, 32604, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 37266, 13, 50, 13495, 33, 4008, 1343, 2566, 363, 76, 7, 37266, 13, 8141, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 16340, 50, 13495, 1404, 53, 721, 796, 42287, 13, 82, 13495, 40483, 9, 74, 1313, 7, 25379, 7, 37266, 13, 44, 828, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 357, 37266, 13, 33, 40483, 6, 9, 37266, 13, 33, 40483, 1343, 42287, 13, 43, 9, 37266, 13, 50, 13495, 33, 4008, 1343, 2566, 363, 76, 7, 37266, 13, 8141, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 1404, 53, 721, 796, 800, 7, 37266, 13, 16340, 50, 13495, 1404, 53, 721, 8, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 796, 2566, 363, 7, 37266, 13, 50, 13495, 1404, 53, 721, 8, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 783, 262, 1612, 198, 220, 220, 220, 220, 220, 220, 220, 611, 2566, 363, 62, 7785, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 42287, 13, 50, 13495, 1404, 53, 721, 9, 3447, 1758, 7, 37266, 13, 33, 40483, 6, 9, 10989, 363, 76, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 56, 11, 42287, 13, 39, 9, 37266, 13, 44, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 42287, 13, 82, 13495, 40483, 9, 37266, 13, 50, 13495, 1404, 53, 721, 9, 3447, 1758, 7, 37266, 13, 33, 40483, 6, 9, 56, 11, 42287, 13, 39, 9, 37266, 13, 44, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 783, 24061, 262, 44829, 590, 286, 28159, 265, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 32, 796, 1976, 27498, 7, 37266, 13, 39, 11, 42287, 13, 39, 8, 198, 220, 220, 220, 220, 220, 220, 220, 329, 285, 287, 352, 25, 37266, 13, 44, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 32, 15853, 1570, 7, 37266, 13, 50, 13495, 1404, 53, 721, 11, 357, 76, 12, 16, 27493, 37266, 13, 39, 10, 16, 25, 76, 9, 37266, 13, 39, 11, 357, 76, 12, 16, 27493, 37266, 13, 39, 10, 16, 25, 76, 9, 37266, 13, 39, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 2073, 1303, 428, 5992, 655, 262, 40039, 286, 262, 44829, 590, 286, 317, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 24061, 262, 34062, 286, 44829, 590, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 691, 779, 329, 1588, 2761, 11, 329, 1402, 2761, 262, 1336, 44829, 590, 318, 517, 7141, 198, 220, 220, 220, 220, 220, 220, 220, 611, 2566, 363, 62, 7785, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 289, 287, 352, 25, 37266, 13, 39, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 2427, 286, 262, 1336, 17593, 48473, 355, 2029, 11, 356, 24061, 655, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 262, 40039, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 58, 71, 60, 796, 2593, 17, 7, 37266, 13, 33, 40483, 58, 45299, 71, 4083, 9, 37266, 13, 82, 13495, 53, 721, 40483, 8, 1343, 42287, 13, 43, 9, 32604, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 37266, 13, 50, 13495, 33, 58, 71, 11, 71, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 428, 318, 29231, 287, 1339, 262, 24198, 286, 1366, 318, 3488, 418, 771, 3477, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 289, 287, 352, 25, 37266, 13, 39, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 2427, 286, 262, 1336, 17593, 48473, 355, 2029, 11, 356, 24061, 655, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 262, 40039, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 58, 71, 60, 796, 42287, 13, 82, 13495, 40483, 9, 27237, 17, 7, 37266, 13, 33, 40483, 58, 45299, 71, 12962, 1343, 42287, 13, 43, 9, 37266, 13, 50, 13495, 33, 58, 71, 11, 71, 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, 1303, 356, 5901, 655, 262, 717, 367, 4847, 11, 523, 356, 655, 4866, 340, 284, 6070, 262, 1334, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 58, 37266, 13, 39, 10, 16, 25, 437, 60, 796, 9585, 7, 37266, 13, 10989, 363, 50, 13495, 1404, 53, 721, 58, 16, 25, 37266, 13, 39, 4357, 8434, 796, 42287, 13, 44, 12, 16, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 635, 751, 262, 7257, 15879, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 15853, 42287, 13, 8141, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 3443, 11, 287, 1851, 340, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 796, 352, 19571, 37266, 13, 10989, 363, 50, 13495, 1404, 53, 721, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 783, 262, 1612, 198, 220, 220, 220, 220, 220, 220, 220, 611, 2566, 363, 62, 7785, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 15885, 3447, 1758, 7, 37266, 13, 33, 40483, 6, 9, 10989, 363, 76, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 56, 11, 42287, 13, 39, 9, 37266, 13, 44, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 42287, 13, 82, 13495, 40483, 9, 37266, 13, 10989, 363, 50, 13495, 1404, 53, 721, 15885, 3447, 1758, 7, 37266, 13, 33, 40483, 6, 9, 56, 11, 42287, 13, 39, 9, 37266, 13, 44, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 783, 24061, 262, 44829, 590, 286, 28159, 265, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 32, 796, 1976, 27498, 7, 37266, 13, 39, 11, 42287, 13, 39, 8, 198, 220, 220, 220, 220, 220, 220, 220, 329, 285, 287, 352, 25, 37266, 13, 44, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 32, 15853, 2566, 363, 76, 7, 1177, 7, 37266, 13, 10989, 363, 50, 13495, 1404, 53, 721, 11, 357, 76, 12, 16, 27493, 37266, 13, 39, 10, 16, 25, 76, 9, 37266, 13, 39, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1303, 783, 900, 1976, 263, 3028, 284, 810, 262, 15180, 286, 575, 15494, 355, 1729, 12, 27816, 276, 389, 198, 220, 220, 220, 1303, 287, 317, 11, 777, 389, 15274, 198, 220, 220, 220, 42287, 13, 18429, 265, 796, 27179, 1758, 7, 37266, 13, 1404, 53, 721, 40483, 11, 42287, 13, 39, 11, 42287, 13, 44, 33047, 198, 220, 220, 220, 42287, 13, 18429, 265, 58, 37266, 13, 23912, 1424, 11, 886, 12, 37266, 13, 39, 16, 10, 16, 25, 437, 60, 796, 657, 13, 15, 198, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 27179, 1758, 7, 37266, 13, 18429, 265, 3256, 42287, 13, 44, 9, 37266, 13, 39, 8, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 4296, 33, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 8, 198, 198, 4933, 19581, 1612, 290, 44829, 590, 286, 262, 347, 17593, 13, 198, 37811, 198, 8818, 4296, 33, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 26, 220, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 8, 198, 220, 220, 220, 1303, 717, 11, 24061, 262, 34062, 286, 262, 44829, 590, 198, 220, 220, 220, 611, 2566, 363, 62, 7785, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 33, 796, 2566, 363, 76, 7, 37266, 13, 23199, 8, 1343, 1612, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 7, 37266, 13, 18429, 265, 6, 9, 37266, 13, 18429, 265, 1343, 42287, 13, 50, 13495, 32, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 259, 1851, 340, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 33, 796, 800, 7, 37266, 13, 50, 13495, 33, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 783, 24061, 262, 1612, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 33, 40483, 796, 2566, 363, 76, 7, 37266, 13, 82, 13495, 53, 721, 40483, 27493, 56, 9, 37266, 13, 18429, 265, 9, 37266, 13, 50, 13495, 33, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 33, 796, 2566, 363, 76, 7, 37266, 13, 23199, 8, 1343, 42287, 13, 82, 13495, 40483, 9, 7, 37266, 13, 18429, 265, 6, 9, 37266, 13, 18429, 265, 1343, 42287, 13, 50, 13495, 32, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 259, 1851, 340, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 50, 13495, 33, 796, 800, 7, 37266, 13, 50, 13495, 33, 8, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 33, 40483, 796, 42287, 13, 82, 13495, 40483, 9, 56, 9, 37266, 13, 18429, 265, 9, 37266, 13, 50, 13495, 33, 198, 220, 220, 220, 886, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 4296, 56, 40483, 0, 7, 37266, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 198, 4933, 19581, 8636, 286, 575, 13, 198, 37811, 198, 8818, 4296, 56, 40483, 0, 7, 37266, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 220, 220, 220, 42287, 13, 56, 40483, 796, 42287, 13, 33, 40483, 9, 37266, 13, 18429, 265, 6, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 4296, 8141, 0, 7, 37266, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 198, 4933, 19581, 262, 8636, 286, 7257, 13, 198, 37811, 198, 8818, 4296, 8141, 0, 7, 37266, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 220, 220, 220, 42287, 13, 31361, 796, 42287, 13, 31361, 15, 9, 1952, 7, 37266, 13, 44, 9, 37266, 13, 39, 8, 1343, 220, 198, 220, 220, 220, 352, 14, 17, 9, 7, 37266, 13, 1404, 53, 721, 40483, 15885, 37266, 13, 1404, 53, 721, 40483, 1343, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 8, 198, 220, 220, 220, 42287, 13, 8141, 796, 42287, 13, 26591, 9, 1952, 7, 37266, 13, 44, 9, 37266, 13, 39, 737, 14, 37266, 13, 31361, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 4296, 23199, 0, 7, 37266, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 198, 4933, 19581, 262, 8636, 286, 10078, 13, 198, 37811, 198, 8818, 4296, 23199, 0, 7, 37266, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 220, 220, 220, 329, 289, 287, 352, 25, 37266, 13, 39, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 67, 12514, 58, 71, 60, 796, 42287, 13, 67, 12514, 15, 1343, 352, 14, 17, 9, 7, 37266, 13, 33, 40483, 58, 45299, 71, 49946, 9, 37266, 13, 33, 40483, 58, 45299, 71, 12962, 58, 16, 60, 1343, 352, 14, 17, 9, 37266, 13, 50, 13495, 33, 58, 71, 11, 71, 60, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 23199, 58, 71, 60, 796, 42287, 13, 28483, 2611, 14, 37266, 13, 67, 12514, 58, 71, 60, 198, 220, 220, 220, 886, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 4296, 50, 13495, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 8, 198, 198, 4933, 19581, 8636, 286, 262, 15558, 24198, 13, 198, 37811, 198, 8818, 4296, 50, 13495, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 26, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 8, 198, 220, 220, 220, 611, 2566, 363, 62, 7785, 198, 220, 220, 220, 220, 220, 220, 220, 329, 300, 287, 352, 25, 37266, 13, 43, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 89, 17167, 53, 721, 58, 75, 60, 796, 42287, 13, 89, 17167, 15, 1343, 352, 14, 17, 9, 27237, 17, 7, 56, 58, 75, 11, 25, 12962, 532, 2160, 7, 56, 58, 75, 11, 25, 4083, 9, 7, 37266, 13, 18429, 265, 9, 37266, 13, 33, 40483, 58, 75, 11, 47715, 4008, 1343, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 352, 14, 17, 9, 40546, 55, 9936, 7, 37266, 13, 18429, 265, 6, 9, 37266, 13, 18429, 265, 1343, 42287, 13, 50, 13495, 32, 11, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 33, 40483, 58, 75, 11, 47715, 9, 37266, 13, 33, 40483, 58, 75, 11, 47715, 6, 1343, 42287, 13, 50, 13495, 33, 8, 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, 42287, 13, 82, 13495, 53, 721, 40483, 58, 75, 60, 796, 42287, 13, 17167, 53, 721, 58, 75, 60, 14, 37266, 13, 89, 17167, 53, 721, 58, 75, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 89, 17167, 796, 42287, 13, 89, 17167, 15, 1343, 352, 14, 17, 9, 37266, 13, 2213, 56, 9936, 532, 12854, 55, 9936, 7, 37266, 13, 33, 40483, 11, 575, 9, 37266, 13, 18429, 265, 8, 1343, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 352, 14, 17, 9, 40546, 55, 9936, 7, 37266, 13, 18429, 265, 6, 9, 37266, 13, 18429, 265, 1343, 42287, 13, 50, 13495, 32, 11, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 33, 40483, 6, 9, 37266, 13, 33, 40483, 1343, 42287, 13, 43, 9, 37266, 13, 50, 13495, 33, 8, 628, 220, 220, 220, 220, 220, 220, 220, 42287, 13, 82, 13495, 40483, 796, 42287, 13, 17167, 14, 37266, 13, 89, 17167, 198, 220, 220, 220, 886, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 410, 20475, 69, 62, 82, 29572, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 362, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 299, 2676, 3712, 5317, 11, 304, 862, 3712, 43879, 2414, 796, 352, 68, 12, 21, 11, 220, 198, 220, 220, 220, 1556, 62, 7785, 796, 3991, 11, 1336, 62, 66, 709, 3712, 33, 970, 796, 3991, 11, 2604, 15908, 796, 366, 1600, 1715, 796, 366, 4943, 198, 198, 7293, 1769, 5553, 864, 15489, 274, 17593, 5766, 1634, 286, 575, 796, 9564, 6, 1343, 412, 13, 20153, 286, 317, 290, 347, 318, 9672, 13, 220, 198, 22362, 1920, 286, 24198, 264, 13495, 460, 307, 2035, 257, 16578, 283, 393, 257, 15879, 532, 329, 5752, 24198, 31850, 13, 220, 198, 9795, 3119, 318, 10893, 2402, 15180, 286, 347, 290, 635, 198, 27287, 43030, 7, 32, 8, 832, 34236, 3161, 10078, 290, 7257, 290, 31850, 286, 44829, 590, 13, 220, 198, 464, 3161, 2746, 318, 1708, 25, 198, 220, 220, 220, 220, 198, 220, 220, 220, 279, 7, 56, 91, 32, 11, 33, 8, 796, 399, 7, 56, 91, 4339, 61, 51, 11, 352, 14, 82, 13495, 9, 40, 8, 393, 279, 7, 56, 91, 32, 11, 33, 8, 796, 399, 7, 56, 91, 4339, 61, 51, 11, 800, 7, 10989, 363, 7, 82, 13495, 22305, 220, 198, 220, 220, 220, 279, 7, 35138, 7, 32, 61, 51, 4008, 796, 399, 7, 35138, 7, 32, 61, 51, 14726, 15, 11, 800, 8141, 828, 7257, 796, 2566, 363, 7, 66, 62, 64, 8, 198, 220, 220, 220, 279, 7, 33, 62, 71, 8, 796, 29060, 7, 33, 91, 15, 11, 314, 11, 800, 23199, 828, 10078, 796, 2566, 363, 7, 66, 16, 11, 2644, 11, 269, 39, 8, 198, 220, 220, 220, 279, 7, 8141, 8, 796, 402, 7, 34, 62, 32, 91, 17130, 15, 11, 12159, 15, 8, 198, 220, 220, 220, 279, 7, 23199, 8, 796, 402, 7, 34, 62, 33, 91, 34236, 15, 11, 25979, 15, 8, 198, 198, 464, 42287, 4578, 351, 23224, 1366, 318, 9518, 290, 4909, 262, 7186, 7746, 706, 262, 220, 198, 282, 42289, 9911, 13, 198, 37811, 198, 8818, 410, 20475, 69, 62, 82, 29572, 0, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 362, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 299, 2676, 3712, 5317, 26, 304, 862, 3712, 43879, 2414, 796, 352, 68, 12, 21, 11, 198, 220, 220, 220, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 11, 1336, 62, 66, 709, 3712, 33, 970, 796, 3991, 11, 2604, 15908, 796, 366, 1600, 1715, 796, 366, 1600, 15942, 796, 3991, 11, 1556, 62, 21101, 3712, 33, 970, 796, 2081, 8, 198, 220, 220, 220, 1293, 669, 796, 360, 713, 3419, 628, 220, 220, 220, 1303, 2251, 262, 2604, 22155, 198, 220, 220, 220, 2604, 278, 796, 3991, 198, 220, 220, 220, 611, 2604, 15908, 5145, 33151, 198, 220, 220, 220, 220, 220, 220, 220, 2604, 278, 796, 2081, 198, 220, 220, 220, 220, 220, 220, 220, 2604, 19852, 796, 2251, 62, 6404, 7, 37266, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1303, 3572, 286, 40826, 1630, 7885, 198, 220, 220, 220, 40826, 62, 7785, 796, 1058, 33, 40483, 198, 220, 220, 220, 1303, 1102, 332, 12745, 62, 7785, 796, 1058, 67, 56, 628, 220, 220, 220, 611, 40826, 62, 7785, 6624, 1058, 67, 56, 198, 220, 220, 220, 220, 220, 220, 220, 1468, 796, 575, 532, 42287, 13, 56, 40483, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1468, 796, 4866, 7, 1136, 3245, 7, 37266, 11, 40826, 62, 7785, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 288, 796, 304, 862, 1343, 352, 13, 15, 1303, 25979, 198, 220, 220, 220, 1312, 796, 352, 628, 220, 220, 220, 1303, 1057, 262, 9052, 329, 257, 1813, 1271, 286, 34820, 198, 220, 220, 220, 981, 14808, 72, 19841, 299, 2676, 8, 11405, 357, 67, 1875, 304, 862, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 4296, 32, 0, 7, 56, 11, 42287, 11, 1336, 62, 66, 709, 796, 1336, 62, 66, 709, 11, 2566, 363, 62, 7785, 796, 2566, 363, 62, 7785, 8, 198, 220, 220, 220, 220, 220, 220, 220, 4296, 33, 0, 7, 56, 11, 42287, 11, 2566, 363, 62, 7785, 796, 2566, 363, 62, 7785, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 4296, 8141, 0, 7, 37266, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 1556, 62, 21101, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4296, 23199, 0, 7, 37266, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 4296, 50, 13495, 0, 7, 56, 11, 42287, 11, 2566, 363, 62, 7785, 796, 2566, 363, 62, 7785, 8, 628, 220, 220, 220, 220, 220, 220, 220, 611, 2604, 278, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4296, 62, 6404, 0, 7, 6404, 19852, 11, 42287, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 2198, 40826, 198, 220, 220, 220, 220, 220, 220, 220, 611, 40826, 62, 7785, 6624, 1058, 67, 56, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4296, 56, 40483, 0, 7, 37266, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 288, 796, 25979, 7, 56, 532, 42287, 13, 56, 40483, 11, 1468, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1468, 796, 575, 532, 42287, 13, 56, 40483, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 288, 796, 25979, 7, 1136, 3245, 7, 37266, 11, 40826, 62, 7785, 828, 1468, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1468, 796, 4866, 7, 1136, 3245, 7, 37266, 11, 40826, 62, 7785, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 1312, 15853, 352, 198, 220, 220, 220, 886, 220, 220, 220, 220, 628, 220, 220, 220, 1303, 3443, 11, 24061, 262, 8636, 286, 575, 198, 220, 220, 220, 4296, 56, 40483, 0, 7, 37266, 8, 628, 220, 220, 220, 1303, 40826, 7508, 198, 220, 220, 220, 611, 15942, 198, 220, 220, 220, 220, 220, 220, 220, 3601, 7203, 41384, 1634, 5201, 706, 33172, 1312, 12, 16, 11, 366, 34820, 11, 304, 862, 796, 33172, 288, 11, 37082, 77, 4943, 198, 220, 220, 220, 886, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 3613, 17311, 290, 23862, 198, 220, 220, 220, 611, 2604, 278, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 50, 2703, 23862, 290, 17311, 739, 33172, 2604, 15908, 11, 12813, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 3613, 62, 6404, 7, 6404, 19852, 11, 575, 11, 1293, 669, 11, 2604, 15908, 11, 1715, 796, 1715, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1441, 288, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 410, 20475, 69, 62, 82, 29572, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 362, 5512, 42287, 62, 259, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 299, 2676, 3712, 5317, 11, 304, 862, 3712, 43879, 2414, 796, 352, 68, 12, 21, 11, 220, 198, 220, 220, 220, 1556, 62, 7785, 796, 3991, 11, 1336, 62, 66, 709, 3712, 33, 970, 796, 3991, 11, 2604, 15908, 796, 366, 1600, 1715, 796, 366, 4943, 198, 198, 34, 5691, 410, 20475, 69, 62, 82, 29572, 0, 3419, 475, 9088, 262, 42287, 62, 259, 4578, 523, 326, 340, 318, 407, 9518, 290, 460, 307, 46823, 13, 198, 37811, 198, 8818, 410, 20475, 69, 62, 82, 29572, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 362, 5512, 42287, 62, 259, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 299, 2676, 3712, 5317, 26, 304, 862, 3712, 43879, 2414, 796, 352, 68, 12, 21, 11, 198, 220, 220, 220, 2566, 363, 62, 7785, 3712, 33, 970, 796, 3991, 11, 1336, 62, 66, 709, 3712, 33, 970, 796, 3991, 11, 2604, 15908, 796, 366, 1600, 1715, 796, 366, 1600, 15942, 796, 3991, 11, 1556, 62, 21101, 3712, 33, 970, 796, 2081, 8, 198, 220, 220, 220, 1303, 787, 257, 4866, 286, 5128, 42287, 198, 220, 220, 220, 42287, 796, 4866, 7, 37266, 62, 259, 8, 628, 220, 220, 220, 1303, 1057, 262, 11862, 198, 220, 220, 220, 288, 796, 410, 20475, 69, 62, 82, 29572, 0, 7, 56, 11, 42287, 11, 299, 2676, 11, 304, 862, 796, 304, 862, 11, 2566, 363, 62, 7785, 796, 2566, 363, 62, 7785, 11, 1336, 62, 66, 709, 796, 1336, 62, 66, 709, 11, 220, 198, 220, 220, 220, 220, 220, 220, 220, 2604, 15908, 796, 2604, 15908, 11, 1715, 796, 1715, 11, 15942, 796, 15942, 11, 1556, 62, 21101, 796, 1556, 62, 21101, 8, 628, 220, 220, 220, 1441, 42287, 11, 288, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 2793, 49646, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 198, 7293, 1133, 262, 2793, 5421, 329, 2604, 283, 342, 76, 286, 1366, 6082, 13, 220, 198, 37811, 198, 8818, 2793, 49646, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 8, 198, 220, 220, 220, 406, 796, 657, 13, 15, 198, 220, 220, 220, 1303, 412, 58, 18755, 79, 7, 56, 91, 37266, 15437, 198, 220, 220, 220, 406, 15853, 532, 42287, 13, 43, 9, 37266, 13, 44, 14, 17, 9, 18755, 17, 14415, 1343, 42287, 13, 43, 9, 37266, 13, 44, 14, 17, 9, 28483, 2611, 3698, 77, 7, 37266, 13, 17167, 11, 42287, 13, 89, 17167, 8, 220, 198, 220, 220, 220, 406, 15853, 532, 42287, 13, 82, 13495, 40483, 14, 17, 9, 7, 37266, 13, 2213, 56, 9936, 532, 362, 9, 40546, 55, 9936, 7, 37266, 13, 33, 40483, 11, 575, 9, 37266, 13, 18429, 265, 8, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 1343, 12854, 55, 9936, 7, 37266, 13, 18429, 265, 6, 9, 37266, 13, 18429, 265, 1343, 42287, 13, 50, 13495, 32, 11, 42287, 13, 33, 40483, 6, 9, 37266, 13, 33, 40483, 1343, 42287, 13, 43, 9, 37266, 13, 50, 13495, 33, 4008, 198, 220, 220, 220, 1303, 412, 58, 18755, 79, 7, 35138, 7, 32, 6, 4008, 60, 198, 220, 220, 220, 406, 15853, 532, 42287, 13, 36208, 14, 17, 9, 18755, 17, 14415, 1343, 352, 14, 17, 9, 16345, 7, 8899, 7, 28483, 2611, 3698, 77, 11, 42287, 13, 26591, 9, 1952, 7, 7857, 7, 37266, 13, 31361, 36911, 42287, 13, 31361, 4008, 198, 220, 220, 220, 406, 15853, 532, 357, 16, 14, 17, 9, 37266, 13, 8141, 6, 9, 7, 37266, 13, 1404, 53, 721, 40483, 13, 61, 17, 1343, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 4008, 58, 16, 60, 198, 220, 220, 220, 1303, 412, 58, 18755, 79, 7, 33, 15437, 198, 220, 220, 220, 406, 15853, 532, 42287, 13, 43, 9, 37266, 13, 39, 14, 17, 9, 18755, 17, 14415, 198, 220, 220, 220, 406, 15853, 42287, 13, 43, 14, 17, 9, 16345, 7, 8899, 7, 28483, 2611, 3698, 77, 11, 42287, 13, 28483, 2611, 9, 1952, 7, 7857, 7, 37266, 13, 67, 12514, 36911, 42287, 13, 67, 12514, 4008, 198, 220, 220, 220, 406, 15853, 532, 352, 14, 17, 9, 40546, 55, 9936, 7, 10989, 363, 76, 7, 37266, 13, 23199, 828, 357, 37266, 13, 33, 40483, 6, 9, 37266, 13, 33, 40483, 1343, 42287, 13, 43, 9, 37266, 13, 50, 13495, 33, 4008, 220, 220, 198, 220, 220, 220, 1303, 412, 58, 18755, 79, 7, 82, 13495, 15437, 198, 220, 220, 220, 406, 15853, 42287, 13, 17167, 15, 9, 6404, 7, 37266, 13, 89, 17167, 15, 8, 532, 300, 28483, 2611, 7, 37266, 13, 17167, 15, 8, 220, 198, 220, 220, 220, 406, 15853, 357, 37266, 13, 17167, 15, 532, 352, 27493, 28483, 2611, 3698, 77, 7, 37266, 13, 17167, 11, 42287, 13, 89, 17167, 8, 532, 42287, 13, 89, 17167, 15, 9, 37266, 13, 82, 13495, 40483, 198, 220, 220, 220, 1303, 412, 58, 18755, 79, 7, 8141, 15437, 198, 220, 220, 220, 406, 15853, 42287, 13, 36208, 9, 7, 37266, 13, 26591, 15, 9, 6404, 7, 37266, 13, 31361, 15, 8, 532, 300, 28483, 2611, 7, 37266, 13, 26591, 15, 4008, 198, 220, 220, 220, 406, 15853, 357, 37266, 13, 26591, 15, 532, 352, 27493, 16345, 7, 8899, 7, 28483, 2611, 3698, 77, 11, 42287, 13, 26591, 9, 1952, 7, 7857, 7, 37266, 13, 31361, 36911, 42287, 13, 31361, 4008, 198, 220, 220, 220, 406, 15853, 532, 42287, 13, 31361, 15, 9, 16345, 7, 37266, 13, 8141, 8, 198, 220, 220, 220, 1303, 412, 58, 18755, 79, 7, 23199, 15437, 198, 220, 220, 220, 406, 15853, 42287, 13, 39, 9, 7, 37266, 13, 28483, 2611, 15, 9, 6404, 7, 37266, 13, 67, 12514, 15, 8, 532, 300, 28483, 2611, 7, 37266, 13, 28483, 2611, 15, 4008, 198, 220, 220, 220, 406, 15853, 357, 37266, 13, 28483, 2611, 15, 532, 352, 27493, 16345, 7, 8899, 7, 28483, 2611, 3698, 77, 11, 42287, 13, 28483, 2611, 9, 1952, 7, 7857, 7, 37266, 13, 67, 12514, 36911, 42287, 13, 67, 12514, 4008, 198, 220, 220, 220, 406, 15853, 532, 42287, 13, 28483, 2611, 15, 9, 16345, 7, 37266, 13, 23199, 8, 628, 220, 220, 220, 1303, 367, 7, 35138, 7, 32, 6, 4008, 198, 220, 220, 220, 406, 15853, 3487, 14539, 28338, 7, 37266, 13, 10989, 363, 50, 13495, 1404, 53, 721, 8, 198, 220, 220, 220, 1303, 367, 7, 33, 8, 198, 220, 220, 220, 406, 15853, 3487, 14539, 28338, 7, 74, 1313, 7, 37266, 13, 50, 13495, 33, 11, 25379, 7, 37266, 13, 43, 22305, 198, 220, 220, 220, 1303, 367, 7, 82, 13495, 8, 198, 220, 220, 220, 406, 15853, 34236, 14539, 28338, 7, 37266, 13, 17167, 11, 42287, 13, 89, 17167, 8, 198, 220, 220, 220, 1303, 367, 7, 8141, 8, 198, 220, 220, 220, 406, 15853, 2160, 7, 8899, 7, 28483, 2611, 14539, 28338, 11, 42287, 13, 26591, 9, 1952, 7, 7857, 7, 37266, 13, 31361, 36911, 42287, 13, 31361, 4008, 198, 220, 220, 220, 1303, 367, 7, 23199, 8, 198, 220, 220, 220, 406, 15853, 2160, 7, 8899, 7, 28483, 2611, 14539, 28338, 11, 42287, 13, 28483, 2611, 9, 1952, 7, 7857, 7, 37266, 13, 67, 12514, 36911, 42287, 13, 67, 12514, 4008, 198, 220, 220, 220, 1441, 406, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 2793, 49646, 2898, 320, 1150, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 62, 259, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 15797, 796, 352, 68, 12, 16, 8, 198, 198, 18429, 265, 351, 2352, 7, 18429, 265, 58, 72, 11, 73, 12962, 1279, 15797, 290, 262, 11188, 4847, 286, 7257, 389, 407, 2950, 287, 262, 29964, 13, 198, 37811, 198, 8818, 2793, 49646, 2898, 320, 1150, 7, 56, 3712, 19182, 90, 43879, 2414, 11, 17, 5512, 42287, 62, 259, 3712, 85, 20475, 69, 62, 82, 29572, 62, 17143, 7307, 11, 15797, 796, 352, 68, 12, 16, 8, 198, 220, 220, 220, 42287, 796, 4866, 7, 37266, 62, 259, 8, 628, 220, 220, 220, 15797, 62, 521, 82, 796, 357, 8937, 7, 37266, 13, 1404, 53, 721, 40483, 8, 764, 29, 15797, 8, 198, 220, 220, 220, 42287, 13, 1404, 53, 721, 40483, 796, 42287, 13, 1404, 53, 721, 40483, 58, 2213, 320, 62, 521, 82, 60, 198, 220, 220, 220, 42287, 13, 36208, 796, 2546, 7, 37266, 13, 1404, 53, 721, 40483, 38381, 16, 60, 198, 220, 220, 220, 42287, 13, 31361, 796, 42287, 13, 31361, 58, 2213, 320, 62, 521, 82, 60, 198, 220, 220, 220, 42287, 13, 8141, 796, 42287, 13, 8141, 58, 2213, 320, 62, 521, 82, 60, 198, 220, 220, 220, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 796, 42287, 13, 10989, 363, 50, 13495, 1404, 53, 721, 58, 2213, 320, 62, 521, 82, 60, 628, 220, 220, 220, 1441, 2793, 49646, 7, 56, 11, 42287, 8, 198, 437 ]
2.231332
8,062
using HamiltonianABC using Base.Test using Parameters using Distributions using Cubature using StatsBase import HamiltonianABC: logdensity, simulate! # use consistent random seed for unit tests srand(UInt32[0x8c736cc0, 0x63556b2b, 0x808f767c, 0xc912a668]) include("utilities.jl") include("test-mcmc.jl") # toy model: exponential through normal include("test-toyexponential.jl") # toy model: G-and-K through normal mixture include("EM_GaussianMixtureModel.jl") include("g_and_k_quantile.jl")
[ 3500, 11582, 666, 24694, 198, 3500, 7308, 13, 14402, 198, 3500, 40117, 198, 3500, 46567, 507, 198, 3500, 7070, 1300, 198, 3500, 20595, 14881, 198, 198, 11748, 11582, 666, 24694, 25, 2604, 43337, 11, 29308, 0, 198, 198, 2, 779, 6414, 4738, 9403, 329, 4326, 5254, 198, 82, 25192, 7, 52, 5317, 2624, 58, 15, 87, 23, 66, 49150, 535, 15, 11, 657, 87, 48250, 3980, 65, 17, 65, 11, 657, 87, 28362, 69, 32059, 66, 11, 657, 25306, 24, 1065, 64, 35809, 12962, 198, 198, 17256, 7203, 315, 2410, 13, 20362, 4943, 198, 17256, 7203, 9288, 12, 76, 11215, 66, 13, 20362, 4943, 198, 198, 2, 13373, 2746, 25, 39682, 832, 3487, 198, 17256, 7203, 9288, 12, 83, 726, 11201, 35470, 13, 20362, 4943, 198, 198, 2, 13373, 2746, 25, 402, 12, 392, 12, 42, 832, 3487, 11710, 198, 17256, 7203, 3620, 62, 35389, 31562, 44, 9602, 17633, 13, 20362, 4943, 198, 17256, 7203, 70, 62, 392, 62, 74, 62, 40972, 576, 13, 20362, 4943, 198 ]
2.97006
167
@testset "167.two-sum-ii-input-array-is-sorted.jl" begin @test two_sum_167([2, 7, 11, 15], 9) == [1, 2] @test two_sum_167([2, 3, 4], 6) == [1, 3] @test two_sum_167([-1, 0], -1) == [1, 2] end
[ 31, 9288, 2617, 366, 21940, 13, 11545, 12, 16345, 12, 4178, 12, 15414, 12, 18747, 12, 271, 12, 82, 9741, 13, 20362, 1, 2221, 198, 220, 220, 220, 2488, 9288, 734, 62, 16345, 62, 21940, 26933, 17, 11, 767, 11, 1367, 11, 1315, 4357, 860, 8, 6624, 685, 16, 11, 362, 60, 198, 220, 220, 220, 2488, 9288, 734, 62, 16345, 62, 21940, 26933, 17, 11, 513, 11, 604, 4357, 718, 8, 6624, 685, 16, 11, 513, 60, 198, 220, 220, 220, 2488, 9288, 734, 62, 16345, 62, 21940, 26933, 12, 16, 11, 657, 4357, 532, 16, 8, 6624, 685, 16, 11, 362, 60, 198, 437, 198 ]
1.897196
107
using Base.Test using BCBI_base @testset "Test Adding and Precompiling Packages" begin println("--------------------------------") println("Testin Base Pkgs") println("--------------------------------") @test length(BCBI_base.add(BCBI_base.base_pkgs)) == 0 println("--------------------------------") println("Testing Plotting Pkgs") println("--------------------------------") @test length(BCBI_base.add(BCBI_base.plotting_pkgs)) == 0 println("--------------------------------") println("Testing Datasets Pkgs") println("--------------------------------") @test length(BCBI_base.add(BCBI_base.datasets_pkg)) == 0 println("--------------------------------") println("Testing Python/R Pkgs") println("--------------------------------") @test length(BCBI_base.add(BCBI_base.external_pkgs)) == 0 println("--------------------------------") println("Testing Clone Pkgs") println("--------------------------------") @test length(BCBI_base.clone(BCBI_base.clone_pkgs)) == 0 println("--------------------------------") println("Testing Checkout Pkgs") println("--------------------------------") @test length(BCBI_base.checkout(BCBI_base.checkout_pkgs)) == 0 println("--------------------------------") println("Precompiling Installed Pkgs") println("--------------------------------") @test length(using_all()) == 0 BCBI_base.clean_up() @test check_installed() == 0 end
[ 3500, 7308, 13, 14402, 198, 3500, 11843, 3483, 62, 8692, 198, 198, 31, 9288, 2617, 366, 14402, 18247, 290, 3771, 5589, 4386, 6400, 1095, 1, 2221, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 14402, 259, 7308, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 2749, 3483, 62, 8692, 13, 2860, 7, 2749, 3483, 62, 8692, 13, 8692, 62, 35339, 82, 4008, 6624, 657, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 44154, 28114, 889, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 2749, 3483, 62, 8692, 13, 2860, 7, 2749, 3483, 62, 8692, 13, 29487, 889, 62, 35339, 82, 4008, 6624, 657, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 44154, 16092, 292, 1039, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 2749, 3483, 62, 8692, 13, 2860, 7, 2749, 3483, 62, 8692, 13, 19608, 292, 1039, 62, 35339, 4008, 6624, 657, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 44154, 11361, 14, 49, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 2749, 3483, 62, 8692, 13, 2860, 7, 2749, 3483, 62, 8692, 13, 22615, 62, 35339, 82, 4008, 6624, 657, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 44154, 30698, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 2749, 3483, 62, 8692, 13, 21018, 7, 2749, 3483, 62, 8692, 13, 21018, 62, 35339, 82, 4008, 6624, 657, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 44154, 6822, 448, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 2749, 3483, 62, 8692, 13, 9122, 448, 7, 2749, 3483, 62, 8692, 13, 9122, 448, 62, 35339, 82, 4008, 6624, 657, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 44872, 7203, 6719, 5589, 4386, 2262, 4262, 350, 10025, 82, 4943, 198, 220, 220, 220, 44872, 7203, 3880, 4943, 198, 220, 220, 220, 2488, 9288, 4129, 7, 3500, 62, 439, 28955, 6624, 657, 198, 220, 220, 220, 11843, 3483, 62, 8692, 13, 27773, 62, 929, 3419, 198, 220, 220, 220, 2488, 9288, 2198, 62, 37050, 3419, 6624, 657, 198, 437, 628 ]
3.377273
440
#= Copyright (c) 2015, Intel Corporation Redistribution and use in source and binary forms, with or without modification, are permitted provided that the following conditions are met: * Redistributions of source code must retain the above copyright notice, this list of conditions and the following disclaimer. * Redistributions in binary form must reproduce the above copyright notice, this list of conditions and the following disclaimer in the documentation and/or other materials provided with the distribution. * Neither the name of Intel Corporation nor the names of its contributors may be used to endorse or promote products derived from this software without specific prior written permission. THIS SOFTWARE IS PROVIDED BY THE COPYRIGHT HOLDERS AND CONTRIBUTORS "AS IS" AND ANY EXPRESS OR IMPLIED WARRANTIES, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE ARE DISCLAIMED. IN NO EVENT SHALL THE COPYRIGHT OWNER OR CONTRIBUTORS BE LIABLE FOR ANY DIRECT, INDIRECT, INCIDENTAL, SPECIAL, EXEMPLARY, OR CONSEQUENTIAL DAMAGES (INCLUDING, BUT NOT LIMITED TO, PROCUREMENT OF SUBSTITUTE GOODS OR SERVICES; LOSS OF USE, DATA, OR PROFITS; OR BUSINESS INTERRUPTION) HOWEVER CAUSED AND ON ANY THEORY OF LIABILITY, WHETHER IN CONTRACT, STRICT LIABILITY, OR TORT (INCLUDING NEGLIGENCE OR OTHERWISE) ARISING IN ANY WAY OUT OF THE USE OF THIS SOFTWARE, EVEN IF ADVISED OF THE POSSIBILITY OF SUCH DAMAGE. =# export set_debug_level, remove_line_nodes debug_level = parse(Int, get(ENV, "LATTE_DEBUG_LEVEL", "0")) function debugp(level::Int, args...) global debug_level if debug_level >= level println(args...) end end function set_debug_level(level::Int) global debug_level debug_level = level end macro recurse_unless(pred) quote if !$pred return ASTWALK_RECURSE end end end function isexpr(node) isa(node, Expr) end function line_node_remover(node, cbdata, index, top_level, read) if isa(node, LineNumberNode) || isa(node, Expr) && node.head == :line return ASTWALK_REMOVE end return ASTWALK_RECURSE end function remove_line_nodes(ast) AstWalk(ast, line_node_remover, nothing) end function Base.contains(symbol::Symbol, value::AbstractString) return contains(string(symbol), string(value)) end """ Replaces symbols in keys(cdata) with cbdata[symbol] """ function symbol_replacer(node, cbdata, index, top_level, read) if isa(node, Symbol) if haskey(cbdata, node) return cbdata[node] end elseif isa(node, Expr) && node.head == :return return AstWalk(node.args[1], symbol_replacer, cbdata) elseif isa(node, Expr) && node.head in [:loophead, :loopend, :parallel_loophead, :parallel_loopend] for i in 1:length(node.args) if isa(node.args[i], Array) node.args[i] = map!((x) ->AstWalk(x, symbol_replacer, cbdata), node.args[i]) elseif isa(node.args[i], Set) # skip else node.args[i] = AstWalk(node.args[i], symbol_replacer, cbdata) end end return node end ASTWALK_RECURSE end function replace_symbols(block::Vector{Any}, mapping::Dict{Symbol, Any}) [AstWalk(s, symbol_replacer, mapping) for s in block] end """ Inline a function with a set of arguments `args`. """ function inline(func, args) ast = Base.uncompressed_ast(func.code) env = Dict{Symbol, Any}() for (closure_var, value) in zip(ast.args[2][2], func.env) if isa(value, Box) # FIXME: Hack for Boxed vars that should be unboxed properly value = value.contents end env[closure_var[1]] = value end for (param, arg) in zip(ast.args[1], args) env[param.args[1]] = arg end # Replace arguments and escaped variables with their values AstWalk(ast.args[3], symbol_replacer, env) end intel_runtime = "/home/truongle/pse-hpc/intel-julia/intel-runtime/lib/libintel-runtime.so" double_buffer = true # @eval ccall((:pert_init,$intel_runtime), Cint, (Cint,), convert(Cint, double_buffer)) # @eval function pert_shutdown() # ccall((:pert_shutdown, $intel_runtime), Cint, ()) # end # atexit(pert_shutdown) using Base.LinAlg import Base.LinAlg: BlasInt @eval function new_sgemm(order, transA, transB, M::BlasInt, N::BlasInt, K::BlasInt, alpha::Float32, Ap::Ptr{Float32}, lda::BlasInt, Bp::Ptr{Float32}, ldb::BlasInt, beta::Float32, Cp::Ptr{Float32}, ldc::BlasInt) ccall((:new_sgemm_LD, $intel_runtime), Ptr{Void}, (UInt8, UInt8, UInt8, BlasInt, BlasInt, BlasInt, Float32, Ptr{Float32}, BlasInt, Ptr{Float32}, BlasInt, Float32, Ptr{Float32}, BlasInt), order, transA, transB, M, N, K, alpha, Ap, lda, Bp, ldb, beta, Cp, ldc) end @eval function insert_task(obj, flag) ccall((:insert_task, $intel_runtime), BlasInt, (Ptr{Void},Cint), obj, flag) end elty = Float32 const blas = Base.libblas_name function gemm!(transA::Char, transB::Char, M::Int, N::Int, K::Int, alpha::Float32, A::Ptr{Float32}, lda::Int, B::Ptr{Float32}, ldb::Int, beta::Float32, C::Ptr{Float32}, ldc::Int) # lda = (transA == 'N') ? M : K # ldb = (transB == 'N') ? K : N # ldc = M CblasNoTrans = 111 CblasTrans = 112 _transA = transA == 'N' ? CblasNoTrans : CblasTrans _transB = transB == 'N' ? CblasNoTrans : CblasTrans CblasColMajor = 102 ccall((:cblas_sgemm, blas), Void, (Clonglong, Clonglong, Clonglong, Clonglong, Clonglong, Clonglong, Float32, Ptr{Float32}, Clonglong, Ptr{Float32}, Clonglong, Float32, Ptr{Float32}, Clonglong), CblasColMajor, _transA, _transB, M, N, K, alpha, A, lda, B, ldb, beta, C, ldc) end function tree_cleaner(node, cbdata, index, top_level, read) if isa(node, Expr) # Don't collapse :block nodes for nodes that need one as args[2] if node.head == :for || node.head == :function #|| node.head == :if new_args = [] for arg in node.args[2].args result = clean_tree(arg) if !(isa(result, Symbol) && result == :nothing) if isa(result, Array) append!(new_args, result) else push!(new_args, result) end end end node.args[2].args = new_args return node # Collapse all other block nodes # TODO: There are probably other blocks we shouldn't collapse elseif node.head == :block map!(clean_tree, node.args) return node end end return ASTWALK_RECURSE end function clean_tree(ast) ast = AstWalk(ast, tree_cleaner, nothing) remove_line_nodes(ast) end function log_info(args...) _time = string(Libc.strftime("%d-%b %H:%M:%S",time())," - ") if LATTE_MPI rank = @eval ccall((:get_rank, $libComm), Cint, ()) Base.info(_time, "RANK $rank: ", args...) else Base.info(_time, args...) end end function _omp_get_thread_num() return ccall((:omp_get_thread_num, "libiomp"), Cint, ()) end for head in [:(:for), :(:call), :(:function), :(:ref)] fn_name = symbol(:is_,@eval $head) @eval function $fn_name(expr::Expr) return expr.head == $head end @eval function $fn_name(expr::Any) return false end end function is_call_target(call_node::Expr, name::Symbol) target = call_node.args[1] if isa(target, GlobalRef) return target.name == name else return target == name end end is_colon(expr::Expr) = expr.head == :(:) is_colon(expr::Any) = false is_num(value::Any) = isa(value, Number) # BEGIN - :for helpers # These are utility methods for working with :for ast nodes. function get_loopvar(for_node::Expr) @assert is_for(for_node) "Expected a :for expression" for_node.args[1].args[1] end function get_loop_length(for_node::Expr) @assert is_for(for_node) "Expected a :for expression" return :(length($(for_node.args[1].args[2]))) end function get_loop_start(for_node::Expr) @assert is_for(for_node) "Expected a :for expression" for_node.args[1].args[2].args[1] end # END - :for helpers @noinline function _REMOVE_THIS_LINE() return 0 end function exp{T}(arg::T) ccall((:exp, "libm"), T, (T, ), arg) end function log{T}(arg::T) ccall((:log, "libm"), T, (T, ), arg) end function tanh{T}(arg::T) ccall((:tanh, "libm"), T, (T, ), arg) end macro NotImplemented() return :(throw("Not Implemented")) end function remove_temp_nodes(ast) function walker(node, cbdata, index, top_level, read) if isa(node, Expr) && node.head == :(=) && isa(node.args[2], Expr) && node.args[2].head == :call && isa(node.args[2].args[1], GlobalRef) && node.args[2].args[1].mod == Latte && node.args[2].args[1].name == :_REMOVE_THIS_LINE return ASTWALK_REMOVE elseif isa(node, Expr) && node.head in [:parallel_loophead, :parallel_loopend, :loophead, :loopend] return node end ASTWALK_RECURSE end AstWalk(ast, walker, nothing) end @noinline function pointer(args...) Base.pointer(args...) end function transform_to_raw_array(ast) function walker(node, cbdata, index, top_level, read) if isa(node, Expr) && node.head == :call if isa(node.args[1], GlobalRef) if node.args[1].name == :arrayref node.args[1] = :raw_arrayref return node elseif node.args[1].name == :arrayset node.args[1] = :raw_arrayset return node elseif node.args[1].name == :pointer node.args[1] = :raw_pointer return node end end elseif isa(node, Expr) && node.head in [:parallel_loophead, :parallel_loopend, :loophead, :loopend] return node end ASTWALK_RECURSE end AstWalk(ast, walker, nothing) end """ Defines @expr only if LATTE_MPI is enabled """ macro latte_mpi(args...) if length(args) == 2 LATTE_MPI ? esc(args[1]) : args[2] elseif length(args) == 1 LATTE_MPI ? esc(args[1]) : nothing else @assert false end end
[ 2, 28, 198, 15269, 357, 66, 8, 1853, 11, 8180, 10501, 198, 198, 7738, 396, 3890, 290, 779, 287, 2723, 290, 13934, 5107, 11, 351, 393, 1231, 198, 4666, 2649, 11, 389, 10431, 2810, 326, 262, 1708, 3403, 389, 1138, 25, 628, 220, 220, 220, 1635, 2297, 396, 2455, 507, 286, 2723, 2438, 1276, 12377, 262, 2029, 6634, 4003, 11, 198, 220, 220, 220, 220, 220, 428, 1351, 286, 3403, 290, 262, 1708, 37592, 13, 198, 220, 220, 220, 1635, 2297, 396, 2455, 507, 287, 13934, 1296, 1276, 22919, 262, 2029, 6634, 198, 220, 220, 220, 220, 220, 4003, 11, 428, 1351, 286, 3403, 290, 262, 1708, 37592, 287, 262, 198, 220, 220, 220, 220, 220, 10314, 290, 14, 273, 584, 5696, 2810, 351, 262, 6082, 13, 198, 220, 220, 220, 1635, 16126, 262, 1438, 286, 8180, 10501, 4249, 262, 3891, 286, 663, 20420, 198, 220, 220, 220, 220, 220, 743, 307, 973, 284, 11438, 393, 7719, 3186, 10944, 422, 428, 3788, 198, 220, 220, 220, 220, 220, 1231, 2176, 3161, 3194, 7170, 13, 198, 198, 43559, 47466, 3180, 36592, 2389, 1961, 11050, 3336, 27975, 38162, 9947, 367, 15173, 4877, 5357, 27342, 9865, 3843, 20673, 366, 1921, 3180, 1, 198, 6981, 15529, 7788, 32761, 6375, 8959, 49094, 34764, 11015, 11, 47783, 2751, 11, 21728, 5626, 40880, 5390, 11, 3336, 198, 3955, 49094, 34764, 11015, 3963, 34482, 3398, 1565, 5603, 25382, 5357, 376, 46144, 7473, 317, 16652, 2149, 37232, 33079, 48933, 15986, 198, 26288, 48778, 1961, 13, 3268, 8005, 49261, 50163, 3336, 27975, 38162, 9947, 47210, 21479, 6375, 27342, 9865, 3843, 20673, 9348, 43031, 19146, 198, 13775, 15529, 42242, 11, 3268, 17931, 23988, 11, 19387, 25256, 1847, 11, 38846, 11, 7788, 3620, 6489, 13153, 11, 6375, 7102, 5188, 10917, 3525, 12576, 198, 35, 2390, 25552, 357, 1268, 39149, 2751, 11, 21728, 5626, 40880, 5390, 11, 41755, 11335, 10979, 3963, 28932, 2257, 2043, 37780, 21090, 50, 6375, 198, 35009, 53, 34444, 26, 406, 18420, 3963, 23210, 11, 42865, 11, 6375, 4810, 19238, 29722, 26, 6375, 43949, 44180, 23255, 49, 8577, 24131, 8, 29630, 36, 5959, 198, 8141, 2937, 1961, 5357, 6177, 15529, 3336, 15513, 3963, 43031, 25382, 11, 7655, 2767, 16879, 3268, 27342, 10659, 11, 19269, 18379, 43031, 25382, 11, 198, 1581, 309, 9863, 357, 1268, 39149, 2751, 399, 7156, 43, 3528, 18310, 6375, 25401, 54, 24352, 8, 5923, 1797, 2751, 3268, 15529, 34882, 16289, 3963, 3336, 23210, 198, 19238, 12680, 47466, 11, 45886, 16876, 5984, 29817, 1961, 3963, 3336, 28069, 11584, 25382, 3963, 13558, 3398, 29506, 11879, 13, 198, 46249, 198, 198, 39344, 900, 62, 24442, 62, 5715, 11, 4781, 62, 1370, 62, 77, 4147, 198, 198, 24442, 62, 5715, 796, 21136, 7, 5317, 11, 651, 7, 1677, 53, 11, 366, 43, 1404, 9328, 62, 30531, 62, 2538, 18697, 1600, 366, 15, 48774, 198, 198, 8818, 14257, 79, 7, 5715, 3712, 5317, 11, 26498, 23029, 198, 220, 220, 220, 3298, 14257, 62, 5715, 198, 220, 220, 220, 611, 14257, 62, 5715, 18189, 1241, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 22046, 23029, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 900, 62, 24442, 62, 5715, 7, 5715, 3712, 5317, 8, 198, 220, 220, 220, 3298, 14257, 62, 5715, 198, 220, 220, 220, 14257, 62, 5715, 796, 1241, 198, 437, 198, 198, 20285, 305, 664, 12321, 62, 25252, 7, 28764, 8, 198, 220, 220, 220, 9577, 198, 220, 220, 220, 220, 220, 220, 220, 611, 5145, 3, 28764, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 29273, 54, 28082, 62, 38827, 4261, 5188, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 318, 31937, 7, 17440, 8, 198, 220, 220, 220, 318, 64, 7, 17440, 11, 1475, 1050, 8, 198, 437, 198, 198, 8818, 1627, 62, 17440, 62, 2787, 2502, 7, 17440, 11, 269, 65, 7890, 11, 6376, 11, 1353, 62, 5715, 11, 1100, 8, 198, 220, 220, 220, 611, 318, 64, 7, 17440, 11, 6910, 15057, 19667, 8, 8614, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 6624, 1058, 1370, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 29273, 54, 28082, 62, 2200, 11770, 6089, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 29273, 54, 28082, 62, 38827, 4261, 5188, 198, 437, 198, 198, 8818, 4781, 62, 1370, 62, 77, 4147, 7, 459, 8, 198, 220, 220, 220, 8304, 35963, 7, 459, 11, 1627, 62, 17440, 62, 2787, 2502, 11, 2147, 8, 198, 437, 198, 198, 8818, 7308, 13, 3642, 1299, 7, 1837, 23650, 3712, 13940, 23650, 11, 1988, 3712, 23839, 10100, 8, 198, 220, 220, 220, 1441, 4909, 7, 8841, 7, 1837, 23650, 828, 4731, 7, 8367, 4008, 198, 437, 198, 198, 37811, 198, 3041, 23625, 14354, 287, 8251, 7, 66, 7890, 8, 351, 269, 65, 7890, 58, 1837, 23650, 60, 198, 37811, 198, 8818, 6194, 62, 35666, 11736, 7, 17440, 11, 269, 65, 7890, 11, 6376, 11, 1353, 62, 5715, 11, 1100, 8, 198, 220, 220, 220, 611, 318, 64, 7, 17440, 11, 38357, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 468, 2539, 7, 21101, 7890, 11, 10139, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 269, 65, 7890, 58, 17440, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 2073, 361, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 6624, 1058, 7783, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 8304, 35963, 7, 17440, 13, 22046, 58, 16, 4357, 6194, 62, 35666, 11736, 11, 269, 65, 7890, 8, 198, 220, 220, 220, 2073, 361, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 287, 685, 25, 26268, 2256, 11, 1058, 26268, 437, 11, 1058, 1845, 29363, 62, 26268, 2256, 11, 1058, 1845, 29363, 62, 26268, 437, 60, 198, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 287, 352, 25, 13664, 7, 17440, 13, 22046, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 318, 64, 7, 17440, 13, 22046, 58, 72, 4357, 15690, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 72, 60, 796, 3975, 0, 19510, 87, 8, 4613, 33751, 35963, 7, 87, 11, 6194, 62, 35666, 11736, 11, 269, 65, 7890, 828, 10139, 13, 22046, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 318, 64, 7, 17440, 13, 22046, 58, 72, 4357, 5345, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 14267, 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, 10139, 13, 22046, 58, 72, 60, 796, 8304, 35963, 7, 17440, 13, 22046, 58, 72, 4357, 6194, 62, 35666, 11736, 11, 269, 65, 7890, 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, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 886, 198, 220, 220, 220, 29273, 54, 28082, 62, 38827, 4261, 5188, 198, 437, 198, 198, 8818, 6330, 62, 1837, 2022, 10220, 7, 9967, 3712, 38469, 90, 7149, 5512, 16855, 3712, 35, 713, 90, 13940, 23650, 11, 4377, 30072, 198, 220, 220, 220, 685, 33751, 35963, 7, 82, 11, 6194, 62, 35666, 11736, 11, 16855, 8, 329, 264, 287, 2512, 60, 198, 437, 198, 198, 37811, 198, 818, 1370, 257, 2163, 351, 257, 900, 286, 7159, 4600, 22046, 44646, 198, 37811, 198, 8818, 26098, 7, 20786, 11, 26498, 8, 198, 220, 220, 220, 6468, 796, 7308, 13, 403, 5589, 2790, 62, 459, 7, 20786, 13, 8189, 8, 198, 220, 220, 220, 17365, 796, 360, 713, 90, 13940, 23650, 11, 4377, 92, 3419, 198, 220, 220, 220, 329, 357, 17966, 62, 7785, 11, 1988, 8, 287, 19974, 7, 459, 13, 22046, 58, 17, 7131, 17, 4357, 25439, 13, 24330, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 318, 64, 7, 8367, 11, 8315, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 44855, 11682, 25, 18281, 329, 8315, 276, 410, 945, 326, 815, 307, 555, 3524, 276, 6105, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1988, 796, 1988, 13, 3642, 658, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 17365, 58, 17966, 62, 7785, 58, 16, 11907, 796, 1988, 198, 220, 220, 220, 886, 198, 220, 220, 220, 329, 357, 17143, 11, 1822, 8, 287, 19974, 7, 459, 13, 22046, 58, 16, 4357, 26498, 8, 198, 220, 220, 220, 220, 220, 220, 220, 17365, 58, 17143, 13, 22046, 58, 16, 11907, 796, 1822, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1303, 40177, 7159, 290, 13537, 9633, 351, 511, 3815, 198, 220, 220, 220, 8304, 35963, 7, 459, 13, 22046, 58, 18, 4357, 6194, 62, 35666, 11736, 11, 17365, 8, 198, 437, 198, 198, 48779, 62, 43282, 796, 12813, 11195, 14, 83, 622, 506, 293, 14, 7752, 12, 71, 14751, 14, 48779, 12, 73, 43640, 14, 48779, 12, 43282, 14, 8019, 14, 8019, 48779, 12, 43282, 13, 568, 1, 198, 198, 23352, 62, 22252, 796, 2081, 198, 2, 2488, 18206, 269, 13345, 19510, 25, 11766, 62, 15003, 11, 3, 48779, 62, 43282, 828, 327, 600, 11, 357, 34, 600, 11, 828, 10385, 7, 34, 600, 11, 4274, 62, 22252, 4008, 198, 2, 2488, 18206, 2163, 22146, 62, 49625, 2902, 3419, 198, 2, 220, 220, 269, 13345, 19510, 25, 11766, 62, 49625, 2902, 11, 720, 48779, 62, 43282, 828, 327, 600, 11, 32865, 198, 2, 886, 198, 2, 379, 37023, 7, 11766, 62, 49625, 2902, 8, 198, 198, 3500, 7308, 13, 14993, 2348, 70, 198, 11748, 7308, 13, 14993, 2348, 70, 25, 1086, 292, 5317, 198, 198, 31, 18206, 2163, 649, 62, 82, 24090, 76, 7, 2875, 11, 1007, 32, 11, 1007, 33, 11, 198, 220, 220, 220, 337, 3712, 3629, 292, 5317, 11, 399, 3712, 3629, 292, 5317, 11, 509, 3712, 3629, 292, 5317, 11, 17130, 3712, 43879, 2624, 11, 198, 220, 220, 220, 5949, 3712, 46745, 90, 43879, 2624, 5512, 300, 6814, 3712, 3629, 292, 5317, 11, 347, 79, 3712, 46745, 90, 43879, 2624, 5512, 300, 9945, 3712, 3629, 292, 5317, 11, 198, 220, 220, 220, 12159, 3712, 43879, 2624, 11, 327, 79, 3712, 46745, 90, 43879, 2624, 5512, 300, 17896, 3712, 3629, 292, 5317, 8, 198, 220, 269, 13345, 19510, 25, 3605, 62, 82, 24090, 76, 62, 11163, 11, 720, 48779, 62, 43282, 828, 350, 2213, 90, 53, 1868, 5512, 198, 220, 220, 220, 357, 52, 5317, 23, 11, 471, 5317, 23, 11, 471, 5317, 23, 11, 1086, 292, 5317, 11, 1086, 292, 5317, 11, 1086, 292, 5317, 11, 48436, 2624, 11, 350, 2213, 90, 43879, 2624, 5512, 1086, 292, 5317, 11, 198, 220, 220, 220, 220, 350, 2213, 90, 43879, 2624, 5512, 1086, 292, 5317, 11, 48436, 2624, 11, 350, 2213, 90, 43879, 2624, 5512, 1086, 292, 5317, 828, 198, 220, 220, 220, 1502, 11, 1007, 32, 11, 1007, 33, 11, 337, 11, 399, 11, 509, 11, 17130, 11, 5949, 11, 300, 6814, 11, 347, 79, 11, 300, 9945, 11, 12159, 11, 327, 79, 11, 300, 17896, 8, 198, 437, 198, 198, 31, 18206, 2163, 7550, 62, 35943, 7, 26801, 11, 6056, 8, 198, 220, 269, 13345, 19510, 25, 28463, 62, 35943, 11, 720, 48779, 62, 43282, 828, 1086, 292, 5317, 11, 357, 46745, 90, 53, 1868, 5512, 34, 600, 828, 26181, 11, 6056, 8, 198, 437, 198, 198, 417, 774, 796, 48436, 2624, 198, 9979, 698, 292, 796, 7308, 13, 8019, 2436, 292, 62, 3672, 198, 8818, 16840, 76, 0, 7, 7645, 32, 3712, 12441, 11, 1007, 33, 3712, 12441, 11, 337, 3712, 5317, 11, 399, 3712, 5317, 11, 509, 3712, 5317, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 17130, 3712, 43879, 2624, 11, 317, 3712, 46745, 90, 43879, 2624, 5512, 300, 6814, 3712, 5317, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 347, 3712, 46745, 90, 43879, 2624, 5512, 300, 9945, 3712, 5317, 11, 12159, 3712, 43879, 2624, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 327, 3712, 46745, 90, 43879, 2624, 5512, 300, 17896, 3712, 5317, 8, 198, 220, 220, 220, 1303, 300, 6814, 796, 357, 7645, 32, 6624, 705, 45, 11537, 5633, 337, 1058, 509, 198, 220, 220, 220, 1303, 300, 9945, 796, 357, 7645, 33, 6624, 705, 45, 11537, 5633, 509, 1058, 399, 198, 220, 220, 220, 1303, 300, 17896, 796, 337, 198, 220, 220, 220, 327, 2436, 292, 2949, 8291, 796, 13374, 198, 220, 220, 220, 327, 2436, 292, 8291, 796, 13539, 198, 220, 220, 220, 4808, 7645, 32, 796, 1007, 32, 6624, 705, 45, 6, 5633, 327, 2436, 292, 2949, 8291, 1058, 327, 2436, 292, 8291, 198, 220, 220, 220, 4808, 7645, 33, 796, 1007, 33, 6624, 705, 45, 6, 5633, 327, 2436, 292, 2949, 8291, 1058, 327, 2436, 292, 8291, 198, 220, 220, 220, 327, 2436, 292, 5216, 24206, 796, 15143, 198, 220, 220, 220, 269, 13345, 19510, 25, 66, 2436, 292, 62, 82, 24090, 76, 11, 698, 292, 828, 18331, 11, 198, 220, 220, 220, 220, 220, 220, 220, 357, 2601, 506, 6511, 11, 1012, 506, 6511, 11, 1012, 506, 6511, 11, 1012, 506, 6511, 11, 1012, 506, 6511, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1012, 506, 6511, 11, 48436, 2624, 11, 350, 2213, 90, 43879, 2624, 5512, 1012, 506, 6511, 11, 198, 220, 220, 220, 220, 220, 220, 220, 350, 2213, 90, 43879, 2624, 5512, 1012, 506, 6511, 11, 48436, 2624, 11, 350, 2213, 90, 43879, 2624, 5512, 198, 220, 220, 220, 220, 220, 220, 220, 1012, 506, 6511, 828, 198, 220, 220, 220, 220, 220, 220, 220, 327, 2436, 292, 5216, 24206, 11, 4808, 7645, 32, 11, 4808, 7645, 33, 11, 337, 11, 399, 11, 509, 11, 17130, 11, 317, 11, 300, 6814, 11, 347, 11, 300, 9945, 11, 12159, 11, 327, 11, 300, 17896, 8, 198, 437, 198, 198, 8818, 5509, 62, 27773, 263, 7, 17440, 11, 269, 65, 7890, 11, 6376, 11, 1353, 62, 5715, 11, 1100, 8, 198, 220, 220, 220, 611, 318, 64, 7, 17440, 11, 1475, 1050, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 2094, 470, 9807, 1058, 9967, 13760, 329, 13760, 326, 761, 530, 355, 26498, 58, 17, 60, 198, 220, 220, 220, 220, 220, 220, 220, 611, 10139, 13, 2256, 6624, 1058, 1640, 8614, 10139, 13, 2256, 6624, 1058, 8818, 1303, 15886, 10139, 13, 2256, 6624, 1058, 361, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 649, 62, 22046, 796, 17635, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 329, 1822, 287, 10139, 13, 22046, 58, 17, 4083, 22046, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1255, 796, 3424, 62, 21048, 7, 853, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 5145, 7, 9160, 7, 20274, 11, 38357, 8, 11405, 1255, 6624, 1058, 22366, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 318, 64, 7, 20274, 11, 15690, 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, 24443, 0, 7, 3605, 62, 22046, 11, 1255, 8, 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, 4574, 0, 7, 3605, 62, 22046, 11, 1255, 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, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 17, 4083, 22046, 796, 649, 62, 22046, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 7778, 7512, 477, 584, 2512, 13760, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 16926, 46, 25, 1318, 389, 2192, 584, 7021, 356, 6584, 470, 9807, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 10139, 13, 2256, 6624, 1058, 9967, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3975, 0, 7, 27773, 62, 21048, 11, 10139, 13, 22046, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 29273, 54, 28082, 62, 38827, 4261, 5188, 198, 437, 198, 198, 8818, 3424, 62, 21048, 7, 459, 8, 198, 220, 220, 220, 6468, 796, 8304, 35963, 7, 459, 11, 5509, 62, 27773, 263, 11, 2147, 8, 198, 220, 220, 220, 4781, 62, 1370, 62, 77, 4147, 7, 459, 8, 198, 437, 198, 198, 8818, 2604, 62, 10951, 7, 22046, 23029, 198, 220, 220, 220, 4808, 2435, 796, 4731, 7, 25835, 66, 13, 2536, 31387, 7203, 4, 67, 12, 4, 65, 4064, 39, 25, 4, 44, 25, 4, 50, 1600, 2435, 3419, 27267, 532, 366, 8, 198, 220, 220, 220, 611, 42355, 9328, 62, 7378, 40, 198, 220, 220, 220, 220, 220, 220, 220, 4279, 796, 2488, 18206, 269, 13345, 19510, 25, 1136, 62, 43027, 11, 720, 8019, 6935, 828, 327, 600, 11, 32865, 198, 220, 220, 220, 220, 220, 220, 220, 7308, 13, 10951, 28264, 2435, 11, 366, 49, 15154, 720, 43027, 25, 33172, 220, 26498, 23029, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 7308, 13, 10951, 28264, 2435, 11, 26498, 23029, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 4808, 3361, 62, 1136, 62, 16663, 62, 22510, 3419, 198, 220, 220, 220, 1441, 269, 13345, 19510, 25, 3361, 62, 1136, 62, 16663, 62, 22510, 11, 366, 8019, 72, 3361, 12340, 327, 600, 11, 32865, 198, 437, 198, 198, 1640, 1182, 287, 685, 37498, 25, 1640, 828, 36147, 25, 13345, 828, 36147, 25, 8818, 828, 36147, 25, 5420, 15437, 198, 220, 220, 220, 24714, 62, 3672, 796, 6194, 7, 25, 271, 62, 11, 31, 18206, 720, 2256, 8, 198, 220, 220, 220, 2488, 18206, 2163, 720, 22184, 62, 3672, 7, 31937, 3712, 3109, 1050, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 44052, 13, 2256, 6624, 720, 2256, 198, 220, 220, 220, 886, 628, 220, 220, 220, 2488, 18206, 2163, 720, 22184, 62, 3672, 7, 31937, 3712, 7149, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 3991, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 318, 62, 13345, 62, 16793, 7, 13345, 62, 17440, 3712, 3109, 1050, 11, 1438, 3712, 13940, 23650, 8, 198, 220, 220, 220, 2496, 796, 869, 62, 17440, 13, 22046, 58, 16, 60, 198, 220, 220, 220, 611, 318, 64, 7, 16793, 11, 8060, 8134, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2496, 13, 3672, 6624, 1438, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2496, 6624, 1438, 198, 220, 220, 220, 886, 198, 437, 198, 198, 271, 62, 4033, 261, 7, 31937, 3712, 3109, 1050, 8, 796, 44052, 13, 2256, 6624, 36147, 25, 8, 198, 271, 62, 4033, 261, 7, 31937, 3712, 7149, 8, 220, 796, 3991, 198, 198, 271, 62, 22510, 7, 8367, 3712, 7149, 8, 796, 318, 64, 7, 8367, 11, 7913, 8, 198, 198, 2, 347, 43312, 532, 1058, 1640, 49385, 198, 2, 2312, 389, 10361, 5050, 329, 1762, 351, 1058, 1640, 6468, 13760, 13, 198, 198, 8818, 651, 62, 26268, 7785, 7, 1640, 62, 17440, 3712, 3109, 1050, 8, 198, 220, 220, 220, 2488, 30493, 318, 62, 1640, 7, 1640, 62, 17440, 8, 366, 3109, 7254, 257, 1058, 1640, 5408, 1, 198, 220, 220, 220, 329, 62, 17440, 13, 22046, 58, 16, 4083, 22046, 58, 16, 60, 198, 437, 198, 198, 8818, 651, 62, 26268, 62, 13664, 7, 1640, 62, 17440, 3712, 3109, 1050, 8, 198, 220, 220, 220, 2488, 30493, 318, 62, 1640, 7, 1640, 62, 17440, 8, 366, 3109, 7254, 257, 1058, 1640, 5408, 1, 198, 220, 220, 220, 1441, 36147, 13664, 16763, 7, 1640, 62, 17440, 13, 22046, 58, 16, 4083, 22046, 58, 17, 60, 22305, 198, 437, 198, 198, 8818, 651, 62, 26268, 62, 9688, 7, 1640, 62, 17440, 3712, 3109, 1050, 8, 198, 220, 220, 220, 2488, 30493, 318, 62, 1640, 7, 1640, 62, 17440, 8, 366, 3109, 7254, 257, 1058, 1640, 5408, 1, 198, 220, 220, 220, 329, 62, 17440, 13, 22046, 58, 16, 4083, 22046, 58, 17, 4083, 22046, 58, 16, 60, 198, 437, 198, 198, 2, 23578, 532, 1058, 1640, 49385, 198, 198, 31, 3919, 45145, 2163, 4808, 2200, 11770, 6089, 62, 43559, 62, 24027, 3419, 198, 220, 220, 220, 1441, 657, 198, 437, 198, 198, 8818, 1033, 90, 51, 92, 7, 853, 3712, 51, 8, 198, 220, 220, 220, 269, 13345, 19510, 25, 11201, 11, 366, 8019, 76, 12340, 309, 11, 357, 51, 11, 10612, 1822, 8, 198, 437, 198, 198, 8818, 2604, 90, 51, 92, 7, 853, 3712, 51, 8, 198, 220, 220, 220, 269, 13345, 19510, 25, 6404, 11, 366, 8019, 76, 12340, 309, 11, 357, 51, 11, 10612, 1822, 8, 198, 437, 198, 198, 8818, 25706, 71, 90, 51, 92, 7, 853, 3712, 51, 8, 198, 220, 220, 220, 269, 13345, 19510, 25, 38006, 71, 11, 366, 8019, 76, 12340, 309, 11, 357, 51, 11, 10612, 1822, 8, 198, 437, 198, 198, 20285, 305, 1892, 3546, 1154, 12061, 3419, 198, 220, 220, 220, 1441, 36147, 16939, 7203, 3673, 1846, 1154, 12061, 48774, 198, 437, 198, 198, 8818, 4781, 62, 29510, 62, 77, 4147, 7, 459, 8, 198, 220, 220, 220, 2163, 2513, 263, 7, 17440, 11, 269, 65, 7890, 11, 6376, 11, 1353, 62, 5715, 11, 1100, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 6624, 36147, 28, 8, 11405, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 318, 64, 7, 17440, 13, 22046, 58, 17, 4357, 1475, 1050, 8, 11405, 10139, 13, 22046, 58, 17, 4083, 2256, 6624, 1058, 13345, 11405, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 318, 64, 7, 17440, 13, 22046, 58, 17, 4083, 22046, 58, 16, 4357, 8060, 8134, 8, 11405, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 17, 4083, 22046, 58, 16, 4083, 4666, 6624, 5476, 660, 11405, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 17, 4083, 22046, 58, 16, 4083, 3672, 6624, 1058, 62, 2200, 11770, 6089, 62, 43559, 62, 24027, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 29273, 54, 28082, 62, 2200, 11770, 6089, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 287, 685, 25, 1845, 29363, 62, 26268, 2256, 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, 220, 220, 220, 220, 220, 220, 1058, 1845, 29363, 62, 26268, 437, 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, 220, 220, 220, 220, 220, 220, 1058, 26268, 2256, 11, 1058, 26268, 437, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 29273, 54, 28082, 62, 38827, 4261, 5188, 198, 220, 220, 220, 886, 198, 220, 220, 220, 8304, 35963, 7, 459, 11, 2513, 263, 11, 2147, 8, 198, 437, 198, 198, 31, 3919, 45145, 2163, 17562, 7, 22046, 23029, 198, 220, 220, 220, 7308, 13, 29536, 7, 22046, 23029, 198, 437, 198, 198, 8818, 6121, 62, 1462, 62, 1831, 62, 18747, 7, 459, 8, 198, 220, 220, 220, 2163, 2513, 263, 7, 17440, 11, 269, 65, 7890, 11, 6376, 11, 1353, 62, 5715, 11, 1100, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 6624, 1058, 13345, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 318, 64, 7, 17440, 13, 22046, 58, 16, 4357, 8060, 8134, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 10139, 13, 22046, 58, 16, 4083, 3672, 6624, 1058, 18747, 5420, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 16, 60, 796, 1058, 1831, 62, 18747, 5420, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 10139, 13, 22046, 58, 16, 4083, 3672, 6624, 1058, 3258, 592, 316, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 16, 60, 796, 1058, 1831, 62, 3258, 592, 316, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 10139, 13, 22046, 58, 16, 4083, 3672, 6624, 1058, 29536, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10139, 13, 22046, 58, 16, 60, 796, 1058, 1831, 62, 29536, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 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, 361, 318, 64, 7, 17440, 11, 1475, 1050, 8, 11405, 10139, 13, 2256, 287, 685, 25, 1845, 29363, 62, 26268, 2256, 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, 220, 220, 220, 220, 220, 220, 1058, 1845, 29363, 62, 26268, 437, 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, 220, 220, 220, 220, 220, 220, 1058, 26268, 2256, 11, 1058, 26268, 437, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 10139, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 29273, 54, 28082, 62, 38827, 4261, 5188, 198, 220, 220, 220, 886, 198, 220, 220, 220, 8304, 35963, 7, 459, 11, 2513, 263, 11, 2147, 8, 198, 437, 198, 198, 37811, 198, 7469, 1127, 2488, 31937, 691, 611, 42355, 9328, 62, 7378, 40, 318, 9343, 198, 37811, 198, 20285, 305, 3042, 660, 62, 3149, 72, 7, 22046, 23029, 198, 220, 220, 220, 611, 4129, 7, 22046, 8, 6624, 362, 198, 220, 220, 220, 220, 220, 220, 220, 42355, 9328, 62, 7378, 40, 5633, 3671, 7, 22046, 58, 16, 12962, 1058, 26498, 58, 17, 60, 198, 220, 220, 220, 2073, 361, 4129, 7, 22046, 8, 6624, 352, 198, 220, 220, 220, 220, 220, 220, 220, 42355, 9328, 62, 7378, 40, 5633, 3671, 7, 22046, 58, 16, 12962, 1058, 2147, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 3991, 198, 220, 220, 220, 886, 198, 437, 628 ]
2.213339
4,828
# https://docs.julialang.org/en/v1/base/parallel/ using Test function learn_Tasks() ## Core.Task # Task from a function a() = sum([i for i in 1:1000]) b = Task(a) ## Base.@task b = @task a() @test false == istaskstarted(b) schedule(b) yield() @test true == istaskstarted(b) @test true == istaskdone(b) x = fetch(b) @show x end learn_Tasks() nothing
[ 2, 3740, 1378, 31628, 13, 73, 377, 498, 648, 13, 2398, 14, 268, 14, 85, 16, 14, 8692, 14, 1845, 29363, 14, 198, 198, 3500, 6208, 198, 198, 8818, 2193, 62, 51, 6791, 3419, 198, 220, 220, 220, 22492, 7231, 13, 25714, 198, 220, 220, 220, 1303, 15941, 422, 257, 2163, 198, 220, 220, 220, 257, 3419, 796, 2160, 26933, 72, 329, 1312, 287, 352, 25, 12825, 12962, 198, 220, 220, 220, 275, 796, 15941, 7, 64, 8, 628, 220, 220, 220, 22492, 7308, 13, 31, 35943, 198, 220, 220, 220, 275, 796, 2488, 35943, 257, 3419, 628, 220, 220, 220, 2488, 9288, 3991, 6624, 318, 35943, 46981, 7, 65, 8, 198, 220, 220, 220, 7269, 7, 65, 8, 198, 220, 220, 220, 7800, 3419, 198, 220, 220, 220, 2488, 9288, 2081, 6624, 318, 35943, 46981, 7, 65, 8, 198, 220, 220, 220, 2488, 9288, 2081, 6624, 318, 35943, 28060, 7, 65, 8, 198, 220, 220, 220, 220, 198, 220, 220, 220, 2124, 796, 21207, 7, 65, 8, 198, 220, 220, 220, 2488, 12860, 2124, 198, 437, 198, 198, 35720, 62, 51, 6791, 3419, 198, 198, 22366, 198 ]
2.191489
188
include("$(pwd())/startup.jl") #fp = "./ExampleFiles/STOFDATA/" # All files in this path will be processed fp = "/media/wiebke/Extreme SSD/PSM_vs_PTR3/Data/apiTOFdata/CLOUD10/run1734_02/" filefilterRegexp = r"\.h5$" #rf = "./ExampleFiles/STOFDATA/2017-05-24_12h50m39_NH4.h5" # The mass scale from this file defines the mass scale of all rf = "$(fp)APi4_Data_2015.10.20-13h34m44s.h5" #masslist = MasslistFunctions.loadMasslist("./ExampleFiles/MASSLISTS/exampleMasslistSTOF.csv") masslist = MasslistFunctions.loadMasslist("$(fp)MassList_NO3-_AP_03-01-20.csv") cr = [37 137] # alternatively: use an auto generated masslist # masslistMasses, masslistElements, masslistElementsMasses, masslistCompositions = createMassList(C=0:20, O=0:20, N=0:1, allowRadicals=false) # (masslistMasses, masslistElements, masslistElementsMasses, masslistCompositions) = masslist s = (masslistMasses.>0) .& ( masslistMasses.<600) masslistMasses = masslistMasses[s] masslistCompositions = masslistCompositions[s,:] ####################### END OF SETTINGS ############################################################### ####################### Processing sequence ########################################################### correctMassScaleAndExtractSumSpec( fp, masslistMasses, masslistElements, masslistElementsMasses, masslistCompositions, rf, cr, filefilterRegexp=filefilterRegexp, onlyUseAverages = true, plotControlMass = true, recalibInterval = 300, resolution = 1500, firstNFiles=0, lastNFiles = 0 ) baselineAndPeakshape( fp, peakshapeRegions=4, peakshapeRegionStretch=1, peakshapeQuantileValue = 0.2, peakfindingNoiseThresholdValue = 2, peakfindingSignalLimit=0.01 ) mtrx = deconvolute( fp, calcTransposed = false )
[ 17256, 7203, 3, 7, 79, 16993, 3419, 20679, 9688, 929, 13, 20362, 4943, 198, 198, 2, 46428, 796, 366, 19571, 16281, 25876, 14, 2257, 19238, 26947, 30487, 1303, 1439, 3696, 287, 428, 3108, 481, 307, 13686, 198, 198, 46428, 796, 12813, 11431, 14, 86, 494, 65, 365, 14, 36716, 21252, 14, 3705, 44, 62, 14259, 62, 47, 5446, 18, 14, 6601, 14, 15042, 10468, 37, 7890, 14, 5097, 2606, 35, 940, 14, 5143, 1558, 2682, 62, 2999, 30487, 628, 198, 7753, 24455, 3041, 25636, 79, 796, 374, 1, 17405, 71, 20, 3, 1, 198, 2, 41871, 796, 366, 19571, 16281, 25876, 14, 2257, 19238, 26947, 14, 5539, 12, 2713, 12, 1731, 62, 1065, 71, 1120, 76, 2670, 62, 33863, 19, 13, 71, 20, 1, 220, 1303, 383, 2347, 5046, 422, 428, 2393, 15738, 262, 2347, 5046, 286, 477, 198, 198, 41871, 796, 17971, 7, 46428, 8, 2969, 72, 19, 62, 6601, 62, 4626, 13, 940, 13, 1238, 12, 1485, 71, 2682, 76, 2598, 82, 13, 71, 20, 1, 198, 198, 2, 22208, 4868, 796, 5674, 4868, 24629, 2733, 13, 2220, 20273, 4868, 7, 1911, 14, 16281, 25876, 14, 31180, 8634, 1797, 4694, 14, 20688, 20273, 4868, 2257, 19238, 13, 40664, 4943, 198, 198, 22208, 4868, 796, 5674, 4868, 24629, 2733, 13, 2220, 20273, 4868, 7203, 3, 7, 46428, 8, 20273, 8053, 62, 15285, 18, 12, 62, 2969, 62, 3070, 12, 486, 12, 1238, 13, 40664, 4943, 198, 198, 6098, 796, 685, 2718, 21643, 60, 198, 198, 2, 46596, 25, 779, 281, 8295, 7560, 2347, 4868, 198, 2, 2347, 4868, 44, 13978, 11, 2347, 4868, 36, 3639, 11, 2347, 4868, 36, 3639, 44, 13978, 11, 2347, 4868, 5377, 1930, 1756, 796, 2251, 20273, 8053, 7, 34, 28, 15, 25, 1238, 11, 440, 28, 15, 25, 1238, 11, 399, 28, 15, 25, 16, 11, 1249, 15546, 20155, 28, 9562, 8, 1303, 198, 7, 22208, 4868, 44, 13978, 11, 2347, 4868, 36, 3639, 11, 2347, 4868, 36, 3639, 44, 13978, 11, 2347, 4868, 5377, 1930, 1756, 8, 796, 2347, 4868, 198, 82, 796, 357, 22208, 4868, 44, 13978, 13, 29, 15, 8, 764, 5, 357, 2347, 4868, 44, 13978, 29847, 8054, 8, 198, 22208, 4868, 44, 13978, 796, 2347, 4868, 44, 13978, 58, 82, 60, 198, 22208, 4868, 5377, 1930, 1756, 796, 2347, 4868, 5377, 1930, 1756, 58, 82, 11, 47715, 198, 198, 14468, 4242, 21017, 23578, 3963, 25823, 51, 20754, 1303, 29113, 14468, 7804, 4242, 2235, 198, 198, 14468, 4242, 21017, 28403, 8379, 1303, 29113, 14468, 7804, 2235, 628, 198, 30283, 20273, 29990, 1870, 11627, 974, 13065, 22882, 7, 198, 220, 220, 220, 277, 79, 11, 198, 220, 220, 220, 2347, 4868, 44, 13978, 11, 198, 220, 220, 220, 2347, 4868, 36, 3639, 11, 198, 220, 220, 220, 2347, 4868, 36, 3639, 44, 13978, 11, 198, 220, 220, 220, 2347, 4868, 5377, 1930, 1756, 11, 198, 220, 220, 220, 374, 69, 11, 198, 220, 220, 220, 1067, 11, 198, 220, 220, 220, 2393, 24455, 3041, 25636, 79, 28, 7753, 24455, 3041, 25636, 79, 11, 198, 220, 220, 220, 691, 11041, 32, 23118, 796, 2081, 11, 198, 220, 220, 220, 7110, 15988, 20273, 796, 2081, 11, 198, 220, 220, 220, 42653, 571, 9492, 2100, 796, 5867, 11, 198, 220, 220, 220, 6323, 796, 20007, 11, 198, 220, 220, 220, 717, 21870, 2915, 28, 15, 11, 198, 220, 220, 220, 938, 21870, 2915, 796, 657, 198, 220, 220, 220, 1267, 198, 198, 12093, 4470, 1870, 6435, 461, 43358, 7, 198, 220, 220, 220, 277, 79, 11, 198, 220, 220, 220, 9103, 43358, 8081, 507, 28, 19, 11, 198, 220, 220, 220, 9103, 43358, 47371, 39181, 28, 16, 11, 198, 220, 220, 220, 9103, 43358, 24915, 576, 11395, 796, 657, 13, 17, 11, 198, 220, 220, 220, 9103, 41070, 2949, 786, 817, 10126, 11395, 796, 362, 11, 198, 220, 220, 220, 9103, 41070, 11712, 282, 39184, 28, 15, 13, 486, 198, 220, 220, 220, 1267, 198, 198, 76, 2213, 87, 796, 37431, 85, 3552, 7, 198, 220, 220, 220, 277, 79, 11, 198, 220, 220, 220, 42302, 8291, 29813, 796, 3991, 198, 220, 220, 220, 1267, 198 ]
2.66129
682
export fit # Default solvers # TODO: in the future, have cases where if the things are too big, take another # default. Also should check if p > n in which case should do dual stuff (or # other appropriate alternative) # Linear, Ridge _solver(::GLR{L2Loss,<:L2R}, np::NTuple{2,Int}) = Analytical() # Logistic, Multinomial _solver(::GLR{LogisticLoss,<:L2R}, np::NTuple{2,Int}) = LBFGS() _solver(::GLR{MultinomialLoss,<:L2R}, np::NTuple{2,Int}) = LBFGS() # Lasso, ElasticNet, Logistic, Multinomial function _solver(glr::GLR{<:SmoothLoss,<:ENR}, np::NTuple{2,Int}) (is_l1(glr.penalty) || is_elnet(glr.penalty)) && return FISTA() @error "Not yet implemented." end # Robust, Quantile _solver(::GLR{<:RobustLoss,<:L2R}, np::NTuple{2,Int}) = LBFGS() # Fallback NOTE: should revisit bc with non-smooth, wouldn't work probably # PGD/PSGD depending on how much data there is _solver(::GLR, np::NTuple{2,Int}) = @error "Not yet implemented." """ $SIGNATURES Fit a generalised linear regression model using an appropriate solver based on the loss and penalty of the model. A method can, in some cases, be specified. """ function fit(glr::GLR, X::AbstractMatrix{<:Real}, y::AVR; solver::Solver=_solver(glr, size(X))) check_nrows(X, y) n, p = size(X) p += Int(glr.fit_intercept) # allocate cache for temporary computations of size n/p # which are frequent but otherwise un-important so that # we can reduce the overall number of allocations # these are const Refs defined when the module is loaded c = glr.loss isa MultinomialLoss ? maximum(y) : 0 allocate(n, p, c) # effective call to fit routine θ = _fit(glr, solver, X, y) # de-allocate cache deallocate() return θ end
[ 39344, 4197, 198, 198, 2, 15161, 1540, 690, 198, 198, 2, 16926, 46, 25, 287, 262, 2003, 11, 423, 2663, 810, 611, 262, 1243, 389, 1165, 1263, 11, 1011, 1194, 198, 2, 4277, 13, 4418, 815, 2198, 611, 279, 1875, 299, 287, 543, 1339, 815, 466, 10668, 3404, 357, 273, 198, 2, 584, 5035, 5559, 8, 198, 198, 2, 44800, 11, 20614, 198, 62, 82, 14375, 7, 3712, 8763, 49, 90, 43, 17, 43, 793, 11, 27, 25, 43, 17, 49, 5512, 45941, 3712, 11251, 29291, 90, 17, 11, 5317, 30072, 796, 16213, 22869, 3419, 198, 198, 2, 5972, 2569, 11, 7854, 259, 49070, 198, 62, 82, 14375, 7, 3712, 8763, 49, 90, 11187, 2569, 43, 793, 11, 27, 25, 43, 17, 49, 5512, 220, 197, 220, 45941, 3712, 11251, 29291, 90, 17, 11, 5317, 30072, 796, 22199, 37, 14313, 3419, 198, 62, 82, 14375, 7, 3712, 8763, 49, 90, 15205, 259, 49070, 43, 793, 11, 27, 25, 43, 17, 49, 5512, 45941, 3712, 11251, 29291, 90, 17, 11, 5317, 30072, 796, 22199, 37, 14313, 3419, 198, 198, 2, 406, 28372, 11, 48567, 7934, 11, 5972, 2569, 11, 7854, 259, 49070, 198, 8818, 4808, 82, 14375, 7, 4743, 81, 3712, 8763, 49, 90, 27, 25, 7556, 5226, 43, 793, 11, 27, 25, 1677, 49, 5512, 45941, 3712, 11251, 29291, 90, 17, 11, 5317, 30072, 198, 197, 7, 271, 62, 75, 16, 7, 4743, 81, 13, 3617, 6017, 8, 8614, 318, 62, 417, 3262, 7, 4743, 81, 13, 3617, 6017, 4008, 11405, 1441, 376, 1797, 5603, 3419, 198, 197, 31, 18224, 366, 3673, 1865, 9177, 526, 198, 437, 198, 198, 2, 3851, 436, 11, 16972, 576, 198, 62, 82, 14375, 7, 3712, 8763, 49, 90, 27, 25, 14350, 436, 43, 793, 11, 27, 25, 43, 17, 49, 5512, 45941, 3712, 11251, 29291, 90, 17, 11, 5317, 30072, 796, 22199, 37, 14313, 3419, 198, 198, 2, 7218, 1891, 24550, 25, 815, 32302, 47125, 351, 1729, 12, 5796, 5226, 11, 3636, 470, 670, 2192, 198, 2, 23842, 35, 14, 3705, 45113, 6906, 319, 703, 881, 1366, 612, 318, 198, 62, 82, 14375, 7, 3712, 8763, 49, 11, 45941, 3712, 11251, 29291, 90, 17, 11, 5317, 30072, 796, 2488, 18224, 366, 3673, 1865, 9177, 526, 628, 198, 37811, 198, 3, 46224, 47471, 198, 198, 31805, 257, 2276, 1417, 14174, 20683, 2746, 1262, 281, 5035, 1540, 332, 1912, 319, 198, 1169, 2994, 290, 7389, 286, 262, 2746, 13, 317, 2446, 460, 11, 287, 617, 2663, 11, 307, 7368, 13, 198, 37811, 198, 8818, 4197, 7, 4743, 81, 3712, 8763, 49, 11, 1395, 3712, 23839, 46912, 90, 27, 25, 15633, 5512, 331, 3712, 10116, 49, 26, 198, 197, 197, 197, 1540, 332, 3712, 50, 14375, 28, 62, 82, 14375, 7, 4743, 81, 11, 2546, 7, 55, 22305, 198, 220, 220, 220, 2198, 62, 77, 8516, 7, 55, 11, 331, 8, 198, 197, 77, 11, 279, 796, 2546, 7, 55, 8, 198, 197, 79, 15853, 2558, 7, 4743, 81, 13, 11147, 62, 3849, 984, 8, 198, 197, 2, 31935, 12940, 329, 8584, 2653, 602, 286, 2546, 299, 14, 79, 198, 197, 2, 543, 389, 10792, 475, 4306, 555, 12, 18049, 523, 326, 198, 197, 2, 356, 460, 4646, 262, 4045, 1271, 286, 49157, 198, 197, 2, 777, 389, 1500, 6524, 82, 5447, 618, 262, 8265, 318, 9639, 198, 197, 66, 796, 1278, 81, 13, 22462, 318, 64, 7854, 259, 49070, 43, 793, 5633, 5415, 7, 88, 8, 1058, 657, 198, 197, 439, 13369, 7, 77, 11, 279, 11, 269, 8, 198, 197, 2, 4050, 869, 284, 4197, 8027, 198, 220, 220, 220, 7377, 116, 796, 4808, 11147, 7, 4743, 81, 11, 1540, 332, 11, 1395, 11, 331, 8, 198, 197, 2, 390, 12, 439, 13369, 12940, 198, 197, 2934, 439, 13369, 3419, 198, 197, 7783, 7377, 116, 198, 437, 198 ]
2.680885
633
# quadratic function export Quadratic ### ABSTRACT TYPE abstract type Quadratic <: ProximableFunction end is_convex(f::Quadratic) = true is_smooth(f::Quadratic) = true is_quadratic(f::Quadratic) = true fun_name(f::Quadratic) = "Quadratic function" ### CONSTRUCTORS """ **Quadratic function** Quadratic(Q, q; iterative=false) For a matrix `Q` (dense or sparse, symmetric and positive semidefinite) and a vector `q`, returns the function ```math f(x) = \\tfrac{1}{2}\\langle Qx, x\\rangle + \\langle q, x \\rangle. ``` By default, a direct method (based on Cholesky factorization) is used to evaluate `prox!`. If `iterative=true`, then `prox!` is evaluated approximately using an iterative method instead. """ function Quadratic(Q::M, q::V; iterative=false) where {M, V} if iterative == false QuadraticDirect(Q, q) else QuadraticIterative(Q, q) end end ### INCLUDE CONCRETE TYPES include("quadraticDirect.jl") include("quadraticIterative.jl")
[ 2, 15094, 81, 1512, 2163, 198, 198, 39344, 20648, 81, 1512, 198, 198, 21017, 9564, 18601, 10659, 41876, 198, 198, 397, 8709, 2099, 20648, 81, 1512, 1279, 25, 1041, 87, 320, 540, 22203, 886, 198, 198, 271, 62, 1102, 303, 87, 7, 69, 3712, 4507, 41909, 1512, 8, 796, 2081, 198, 271, 62, 5796, 5226, 7, 69, 3712, 4507, 41909, 1512, 8, 796, 2081, 198, 271, 62, 421, 41909, 1512, 7, 69, 3712, 4507, 41909, 1512, 8, 796, 2081, 198, 198, 12543, 62, 3672, 7, 69, 3712, 4507, 41909, 1512, 8, 796, 366, 4507, 41909, 1512, 2163, 1, 198, 198, 21017, 7102, 46126, 20673, 198, 198, 37811, 198, 1174, 4507, 41909, 1512, 2163, 1174, 628, 220, 220, 220, 20648, 81, 1512, 7, 48, 11, 10662, 26, 11629, 876, 28, 9562, 8, 198, 198, 1890, 257, 17593, 4600, 48, 63, 357, 67, 1072, 393, 29877, 11, 23606, 19482, 290, 3967, 5026, 485, 69, 9504, 8, 290, 257, 15879, 4600, 80, 47671, 5860, 262, 2163, 198, 15506, 63, 11018, 198, 69, 7, 87, 8, 796, 26867, 83, 31944, 90, 16, 18477, 17, 92, 6852, 75, 9248, 1195, 87, 11, 2124, 6852, 81, 9248, 1343, 26867, 75, 9248, 10662, 11, 2124, 26867, 81, 9248, 13, 198, 15506, 63, 198, 3886, 4277, 11, 257, 1277, 2446, 357, 3106, 319, 609, 4316, 2584, 5766, 1634, 8, 318, 973, 284, 13446, 4600, 1676, 87, 0, 44646, 198, 1532, 4600, 2676, 876, 28, 7942, 47671, 788, 4600, 1676, 87, 0, 63, 318, 16726, 6702, 1262, 281, 11629, 876, 2446, 2427, 13, 198, 37811, 198, 8818, 20648, 81, 1512, 7, 48, 3712, 44, 11, 10662, 3712, 53, 26, 11629, 876, 28, 9562, 8, 810, 1391, 44, 11, 569, 92, 198, 220, 220, 220, 611, 11629, 876, 6624, 3991, 198, 220, 220, 220, 220, 220, 220, 220, 20648, 81, 1512, 13470, 7, 48, 11, 10662, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 20648, 81, 1512, 29993, 876, 7, 48, 11, 10662, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 21017, 3268, 5097, 52, 7206, 39962, 2200, 9328, 24412, 47, 1546, 198, 198, 17256, 7203, 421, 41909, 1512, 13470, 13, 20362, 4943, 198, 17256, 7203, 421, 41909, 1512, 29993, 876, 13, 20362, 4943, 198 ]
2.63807
373
# # """ # Take one step of iLQR algorithm (non-allocating) # """ # function step!(solver::iLQRSolver, J) # Z = solver.Z # state_diff_jacobian!(solver.G, solver.model, Z) # discrete_jacobian!(solver.∇F, solver.model, Z) # cost_expansion!(solver.Q, solver.G, solver.obj, solver.model, solver.Z) # ΔV = backwardpass!(solver) # forwardpass!(solver, ΔV, J) # end # # # """ # $(SIGNATURES) # Calculates the optimal feedback gains K,d as well as the 2nd Order approximation of the # Cost-to-Go, using a backward Riccati-style recursion. (non-allocating) # """ # function backwardpass!(solver::StaticiLQRSolver{T,QUAD}) where {T,QUAD<:QuadratureRule} # n,m,N = size(solver) # # # Objective # obj = solver.obj # model = solver.model # # # Extract variables # Z = solver.Z; K = solver.K; d = solver.d; # G = solver.G # S = solver.S # Q = solver.Q # # # Terminal cost-to-go # S.xx[N] = Q.xx[N] # S.x[N] = Q.x[N] # # # Initialize expecte change in cost-to-go # ΔV = @SVector zeros(2) # # # k = N-1 # while k > 0 # ix = Z[k]._x # iu = Z[k]._u # # # fdx = G[k+1]'solver.∇F[k][ix,ix]*G[k] # # fdu = G[k+1]'solver.∇F[k][ix,iu] # fdx,fdu = dynamics_expansion(solver.∇F[k], G[k], G[k+1], model, Z[k]) # # fdx, fdu = dynamics_expansion(QUAD, model, Z[k]) # # Qx = Q.x[k] + fdx'S.x[k+1] # Qu = Q.u[k] + fdu'S.x[k+1] # Qxx = Q.xx[k] + fdx'S.xx[k+1]*fdx # Quu = Q.uu[k] + fdu'S.xx[k+1]*fdu # Qux = Q.ux[k] + fdu'S.xx[k+1]*fdx # # if solver.opts.bp_reg_type == :state # Quu_reg = Quu + solver.ρ[1]*fdu'fdu # Qux_reg = Qux + solver.ρ[1]*fdu'fdx # elseif solver.opts.bp_reg_type == :control # Quu_reg = Quu + solver.ρ[1]*I # Qux_reg = Qux # end # # # Regularization # if solver.opts.bp_reg # vals = eigvals(Hermitian(Quu_reg)) # if minimum(vals) <= 0 # @warn "Backward pass regularized" # regularization_update!(solver, :increase) # k = N-1 # ΔV = @SVector zeros(2) # continue # end # end # # # Compute gains # K[k] = -(Quu_reg\Qux_reg) # d[k] = -(Quu_reg\Qu) # # # Calculate cost-to-go (using unregularized Quu and Qux) # S.x[k] = Qx + K[k]'*Quu*d[k] + K[k]'* Qu + Qux'd[k] # S.xx[k] = Qxx + K[k]'*Quu*K[k] + K[k]'*Qux + Qux'K[k] # S.xx[k] = 0.5*(S.xx[k] + S.xx[k]') # # # calculated change is cost-to-go over entire trajectory # ΔV += @SVector [d[k]'*Qu, 0.5*d[k]'*Quu*d[k]] # # k -= 1 # end # # regularization_update!(solver, :decrease) # # return ΔV # # end # # # """ # $(SIGNATURES) # Simulate forward the system with the optimal feedback gains from the iLQR backward pass. # (non-allocating) # """ # function rollout!(solver::StaticiLQRSolver{T,Q}, α) where {T,Q} # Z = solver.Z; Z̄ = solver.Z̄ # K = solver.K; d = solver.d; # # Z̄[1].z = [solver.x0; control(Z[1])] # # temp = 0.0 # # # for k = 1:solver.N-1 # δx = state_diff(solver.model, state(Z̄[k]), state(Z[k])) # ū = control(Z[k]) + K[k]*δx + α*d[k] # set_control!(Z̄[k], ū) # # # Z̄[k].z = [state(Z̄[k]); control(Z[k]) + δu] # Z̄[k+1].z = [discrete_dynamics(Q, solver.model, Z̄[k]); # control(Z[k+1])] # # temp = norm(Z̄[k+1].z) # if temp > solver.opts.max_state_value # return false # end # end # return true # end
[ 198, 2, 198, 2, 37227, 198, 2, 7214, 530, 2239, 286, 1312, 43, 48, 49, 11862, 357, 13159, 12, 439, 27123, 8, 198, 2, 37227, 198, 2, 2163, 2239, 0, 7, 82, 14375, 3712, 72, 43, 48, 6998, 14375, 11, 449, 8, 198, 2, 220, 220, 220, 220, 1168, 796, 1540, 332, 13, 57, 198, 2, 220, 220, 220, 220, 1181, 62, 26069, 62, 30482, 672, 666, 0, 7, 82, 14375, 13, 38, 11, 1540, 332, 13, 19849, 11, 1168, 8, 198, 2, 220, 220, 220, 220, 28810, 62, 30482, 672, 666, 0, 7, 82, 14375, 13, 24861, 229, 37, 11, 1540, 332, 13, 19849, 11, 1168, 8, 198, 2, 220, 220, 220, 220, 1575, 62, 11201, 5487, 0, 7, 82, 14375, 13, 48, 11, 1540, 332, 13, 38, 11, 1540, 332, 13, 26801, 11, 1540, 332, 13, 19849, 11, 1540, 332, 13, 57, 8, 198, 2, 220, 220, 220, 220, 37455, 53, 796, 19528, 6603, 0, 7, 82, 14375, 8, 198, 2, 220, 220, 220, 220, 2651, 6603, 0, 7, 82, 14375, 11, 37455, 53, 11, 449, 8, 198, 2, 886, 198, 2, 198, 2, 198, 2, 37227, 198, 2, 29568, 46224, 47471, 8, 198, 2, 27131, 689, 262, 16586, 7538, 8810, 509, 11, 67, 355, 880, 355, 262, 362, 358, 8284, 40874, 286, 262, 198, 2, 6446, 12, 1462, 12, 5247, 11, 1262, 257, 19528, 15868, 66, 7246, 12, 7635, 664, 24197, 13, 357, 13159, 12, 439, 27123, 8, 198, 2, 37227, 198, 2, 2163, 19528, 6603, 0, 7, 82, 14375, 3712, 45442, 72, 43, 48, 6998, 14375, 90, 51, 11, 10917, 2885, 30072, 810, 1391, 51, 11, 10917, 2885, 27, 25, 4507, 41909, 1300, 31929, 92, 198, 2, 220, 220, 220, 220, 299, 11, 76, 11, 45, 796, 2546, 7, 82, 14375, 8, 198, 2, 198, 2, 220, 220, 220, 220, 1303, 37092, 198, 2, 220, 220, 220, 220, 26181, 796, 1540, 332, 13, 26801, 198, 2, 220, 220, 220, 220, 2746, 796, 1540, 332, 13, 19849, 198, 2, 198, 2, 220, 220, 220, 220, 1303, 29677, 9633, 198, 2, 220, 220, 220, 220, 1168, 796, 1540, 332, 13, 57, 26, 509, 796, 1540, 332, 13, 42, 26, 288, 796, 1540, 332, 13, 67, 26, 198, 2, 220, 220, 220, 220, 402, 796, 1540, 332, 13, 38, 198, 2, 220, 220, 220, 220, 311, 796, 1540, 332, 13, 50, 198, 2, 220, 220, 220, 220, 1195, 796, 1540, 332, 13, 48, 198, 2, 198, 2, 220, 220, 220, 220, 1303, 24523, 1575, 12, 1462, 12, 2188, 198, 2, 220, 220, 220, 220, 311, 13, 5324, 58, 45, 60, 796, 1195, 13, 5324, 58, 45, 60, 198, 2, 220, 220, 220, 220, 311, 13, 87, 58, 45, 60, 796, 1195, 13, 87, 58, 45, 60, 198, 2, 198, 2, 220, 220, 220, 220, 1303, 20768, 1096, 1607, 68, 1487, 287, 1575, 12, 1462, 12, 2188, 198, 2, 220, 220, 220, 220, 37455, 53, 796, 2488, 50, 38469, 1976, 27498, 7, 17, 8, 198, 2, 198, 2, 198, 2, 220, 220, 220, 220, 479, 796, 399, 12, 16, 198, 2, 220, 220, 220, 220, 981, 479, 1875, 657, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 844, 796, 1168, 58, 74, 4083, 62, 87, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1312, 84, 796, 1168, 58, 74, 4083, 62, 84, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 277, 34350, 796, 402, 58, 74, 10, 16, 49946, 82, 14375, 13, 24861, 229, 37, 58, 74, 7131, 844, 11, 844, 60, 9, 38, 58, 74, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 277, 646, 796, 402, 58, 74, 10, 16, 49946, 82, 14375, 13, 24861, 229, 37, 58, 74, 7131, 844, 11, 16115, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 277, 34350, 11, 69, 646, 796, 17262, 62, 11201, 5487, 7, 82, 14375, 13, 24861, 229, 37, 58, 74, 4357, 402, 58, 74, 4357, 402, 58, 74, 10, 16, 4357, 2746, 11, 1168, 58, 74, 12962, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 277, 34350, 11, 277, 646, 796, 17262, 62, 11201, 5487, 7, 10917, 2885, 11, 2746, 11, 1168, 58, 74, 12962, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1195, 87, 796, 220, 1195, 13, 87, 58, 74, 60, 1343, 277, 34350, 6, 50, 13, 87, 58, 74, 10, 16, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 796, 220, 1195, 13, 84, 58, 74, 60, 1343, 277, 646, 6, 50, 13, 87, 58, 74, 10, 16, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1195, 5324, 796, 1195, 13, 5324, 58, 74, 60, 1343, 277, 34350, 6, 50, 13, 5324, 58, 74, 10, 16, 60, 9, 16344, 87, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 84, 796, 1195, 13, 12303, 58, 74, 60, 1343, 277, 646, 6, 50, 13, 5324, 58, 74, 10, 16, 60, 9, 69, 646, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 87, 796, 1195, 13, 2821, 58, 74, 60, 1343, 277, 646, 6, 50, 13, 5324, 58, 74, 10, 16, 60, 9, 16344, 87, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 611, 1540, 332, 13, 404, 912, 13, 46583, 62, 2301, 62, 4906, 6624, 1058, 5219, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 84, 62, 2301, 796, 2264, 84, 1343, 1540, 332, 13, 33643, 58, 16, 60, 9, 69, 646, 6, 69, 646, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 87, 62, 2301, 796, 2264, 87, 1343, 1540, 332, 13, 33643, 58, 16, 60, 9, 69, 646, 6, 16344, 87, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 1540, 332, 13, 404, 912, 13, 46583, 62, 2301, 62, 4906, 6624, 1058, 13716, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 84, 62, 2301, 796, 2264, 84, 1343, 1540, 332, 13, 33643, 58, 16, 60, 9, 40, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2264, 87, 62, 2301, 796, 2264, 87, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 23603, 1634, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 611, 1540, 332, 13, 404, 912, 13, 46583, 62, 2301, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 410, 874, 796, 304, 328, 12786, 7, 9360, 2781, 666, 7, 4507, 84, 62, 2301, 4008, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 5288, 7, 12786, 8, 19841, 657, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 40539, 366, 7282, 904, 1208, 3218, 1143, 1, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3218, 1634, 62, 19119, 0, 7, 82, 14375, 11, 1058, 24988, 589, 8, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 479, 796, 399, 12, 16, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 37455, 53, 796, 2488, 50, 38469, 1976, 27498, 7, 17, 8, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2555, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 3082, 1133, 8810, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 509, 58, 74, 60, 796, 532, 7, 4507, 84, 62, 2301, 59, 48, 2821, 62, 2301, 8, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 288, 58, 74, 60, 796, 532, 7, 4507, 84, 62, 2301, 59, 4507, 8, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 27131, 378, 1575, 12, 1462, 12, 2188, 357, 3500, 555, 16338, 1143, 2264, 84, 290, 2264, 87, 8, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 311, 13, 87, 58, 74, 60, 220, 796, 220, 1195, 87, 1343, 509, 58, 74, 49946, 9, 4507, 84, 9, 67, 58, 74, 60, 1343, 509, 58, 74, 49946, 9, 2264, 1343, 2264, 87, 1549, 58, 74, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 311, 13, 5324, 58, 74, 60, 796, 1195, 5324, 1343, 509, 58, 74, 49946, 9, 4507, 84, 9, 42, 58, 74, 60, 1343, 509, 58, 74, 49946, 9, 48, 2821, 1343, 2264, 87, 6, 42, 58, 74, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 311, 13, 5324, 58, 74, 60, 796, 657, 13, 20, 9, 7, 50, 13, 5324, 58, 74, 60, 1343, 311, 13, 5324, 58, 74, 60, 11537, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 10488, 1487, 318, 1575, 12, 1462, 12, 2188, 625, 2104, 22942, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 37455, 53, 15853, 2488, 50, 38469, 685, 67, 58, 74, 49946, 9, 4507, 11, 657, 13, 20, 9, 67, 58, 74, 49946, 9, 4507, 84, 9, 67, 58, 74, 11907, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 479, 48185, 352, 198, 2, 220, 220, 220, 220, 886, 198, 2, 198, 2, 220, 220, 220, 220, 3218, 1634, 62, 19119, 0, 7, 82, 14375, 11, 1058, 12501, 260, 589, 8, 198, 2, 198, 2, 220, 220, 220, 220, 1441, 37455, 53, 198, 2, 198, 2, 886, 198, 2, 198, 198, 2, 198, 2, 37227, 198, 2, 29568, 46224, 47471, 8, 198, 2, 3184, 5039, 2651, 262, 1080, 351, 262, 16586, 7538, 8810, 422, 262, 1312, 43, 48, 49, 19528, 1208, 13, 198, 2, 357, 13159, 12, 439, 27123, 8, 198, 2, 37227, 198, 2, 2163, 38180, 0, 7, 82, 14375, 3712, 45442, 72, 43, 48, 6998, 14375, 90, 51, 11, 48, 5512, 26367, 8, 810, 1391, 51, 11, 48, 92, 198, 2, 220, 220, 220, 220, 1168, 796, 1540, 332, 13, 57, 26, 1168, 136, 226, 796, 1540, 332, 13, 57, 136, 226, 198, 2, 220, 220, 220, 220, 509, 796, 1540, 332, 13, 42, 26, 288, 796, 1540, 332, 13, 67, 26, 198, 2, 198, 2, 220, 220, 220, 220, 1168, 136, 226, 58, 16, 4083, 89, 796, 685, 82, 14375, 13, 87, 15, 26, 1630, 7, 57, 58, 16, 12962, 60, 198, 2, 198, 2, 220, 220, 220, 220, 20218, 796, 657, 13, 15, 198, 2, 198, 2, 198, 2, 220, 220, 220, 220, 329, 479, 796, 352, 25, 82, 14375, 13, 45, 12, 16, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 7377, 112, 87, 796, 1181, 62, 26069, 7, 82, 14375, 13, 19849, 11, 1181, 7, 57, 136, 226, 58, 74, 46570, 1181, 7, 57, 58, 74, 60, 4008, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 334, 136, 226, 796, 1630, 7, 57, 58, 74, 12962, 1343, 509, 58, 74, 60, 9, 138, 112, 87, 1343, 26367, 9, 67, 58, 74, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 900, 62, 13716, 0, 7, 57, 136, 226, 58, 74, 4357, 334, 136, 226, 8, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 1168, 136, 226, 58, 74, 4083, 89, 796, 685, 5219, 7, 57, 136, 226, 58, 74, 36563, 1630, 7, 57, 58, 74, 12962, 1343, 7377, 112, 84, 60, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1168, 136, 226, 58, 74, 10, 16, 4083, 89, 796, 685, 15410, 8374, 62, 67, 4989, 873, 7, 48, 11, 1540, 332, 13, 19849, 11, 1168, 136, 226, 58, 74, 36563, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1630, 7, 57, 58, 74, 10, 16, 12962, 60, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 20218, 796, 2593, 7, 57, 136, 226, 58, 74, 10, 16, 4083, 89, 8, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 611, 20218, 1875, 1540, 332, 13, 404, 912, 13, 9806, 62, 5219, 62, 8367, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 3991, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 2, 220, 220, 220, 220, 886, 198, 2, 220, 220, 220, 220, 1441, 2081, 198, 2, 886, 198 ]
1.712547
2,136
using Games using Test include("test_pure_nash.jl") include("test_repeated_game.jl") include("test_normal_form_game.jl") include("test_random.jl") include("test_support_enumeration.jl") include("generators/runtests.jl")
[ 3500, 5776, 198, 3500, 6208, 198, 198, 17256, 7203, 9288, 62, 37424, 62, 77, 1077, 13, 20362, 4943, 198, 17256, 7203, 9288, 62, 45956, 515, 62, 6057, 13, 20362, 4943, 198, 17256, 7203, 9288, 62, 11265, 62, 687, 62, 6057, 13, 20362, 4943, 198, 17256, 7203, 9288, 62, 25120, 13, 20362, 4943, 198, 17256, 7203, 9288, 62, 11284, 62, 268, 6975, 341, 13, 20362, 4943, 198, 198, 17256, 7203, 8612, 2024, 14, 81, 2797, 3558, 13, 20362, 4943, 198 ]
2.810127
79
@testset "461.hamming-distance.jl" begin @test hamming_distance(1, 4) == 2 @test hamming_distance(235, 63626) == 8 end
[ 31, 9288, 2617, 366, 40652, 13, 2763, 2229, 12, 30246, 13, 20362, 1, 2221, 198, 220, 220, 220, 2488, 9288, 8891, 2229, 62, 30246, 7, 16, 11, 604, 8, 6624, 362, 198, 220, 220, 220, 2488, 9288, 8891, 2229, 62, 30246, 7, 22370, 11, 718, 2623, 2075, 8, 6624, 807, 198, 437 ]
2.423077
52
abstract type Drift{R,W} <: CellRule{R,W} end
[ 397, 8709, 2099, 39819, 90, 49, 11, 54, 92, 1279, 25, 12440, 31929, 90, 49, 11, 54, 92, 886, 198 ]
2.3
20
using TrajectoryOptimization using BenchmarkTools using TrajOptPlots using Plots using LinearAlgebra using MeshCat vis = Visualizer() open(vis) solver = DIRCOLSolver(Problems.Quadrotor()...,integration=HermiteSimpson) solve!(solver) cost(solver) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Double Integrator solver = ALTROSolver(Problems.DoubleIntegrator()...) benchmark_solve!(solver) iterations(solver) # 8 plot(solver) # Pendulum solver = ALTROSolver(Problems.Pendulum()...) benchmark_solve!(solver) iterations(solver) # 19 delete!(vis) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Cartpole solver = ALTROSolver(Problems.Cartpole()...) benchmark_solve!(solver) iterations(solver) # 40 delete!(vis) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Acrobot solver = ALTROSolver(Problems.Acrobot()...) benchmark_solve!(solver) iterations(solver) # 50 delete!(vis) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Parallel Park solver = ALTROSolver(Problems.DubinsCar(:parallel_park)...) benchmark_solve!(solver) iterations(solver) # 13 delete!(vis) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Three Obstacles solver = ALTROSolver(Problems.DubinsCar(:three_obstacles)...) benchmark_solve!(solver) iterations(solver) # 20 delete!(vis) add_cylinders!(vis, solver, robot_radius=get_model(solver).radius) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Escape solver = ALTROSolver(Problems.DubinsCar(:escape)..., infeasible=true, R_inf=0.1) benchmark_solve!(solver, samples=1, evals=1) iterations(solver) # 13 delete!(vis) set_mesh!(vis, get_model(solver)) add_cylinders!(vis, solver, robot_radius=get_model(solver).model.radius, height=0.2) visualize!(vis, solver) A = rand(10,10) typeof(view(A,1:0,1:0)) # Zig-zag solver = ALTROSolver(Problems.Quadrotor(:zigzag)...) benchmark_solve!(solver) iterations(solver) # 15 delete!(vis) set_mesh!(vis, get_model(solver)) visualize!(vis, solver) # Barrell Roll solver = ALTROSolver(Problems.YakProblems()...) benchmark_solve!(solver) iterations(solver) # 17 max_violation(solver) delete!(vis) set_mesh!(vis, get_model(solver)) visualize!(vis, solver)
[ 3500, 4759, 752, 652, 27871, 320, 1634, 198, 3500, 25187, 4102, 33637, 198, 3500, 4759, 73, 27871, 3646, 1747, 198, 3500, 1345, 1747, 198, 3500, 44800, 2348, 29230, 198, 3500, 47529, 21979, 198, 198, 4703, 796, 15612, 7509, 3419, 198, 9654, 7, 4703, 8, 198, 198, 82, 14375, 796, 360, 4663, 25154, 50, 14375, 7, 2964, 22143, 13, 4507, 324, 10599, 273, 3419, 986, 11, 18908, 1358, 28, 48523, 578, 8890, 8430, 8, 198, 82, 6442, 0, 7, 82, 14375, 8, 198, 15805, 7, 82, 14375, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 11198, 15995, 12392, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 25628, 34500, 12392, 3419, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 807, 198, 29487, 7, 82, 14375, 8, 198, 198, 2, 36865, 14452, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 47, 437, 14452, 3419, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 678, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 13690, 36869, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 43476, 36869, 3419, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 2319, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 4013, 305, 13645, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 12832, 305, 13645, 3419, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 2026, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 42945, 3250, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 37590, 1040, 9914, 7, 25, 1845, 29363, 62, 20928, 8, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 220, 1303, 1511, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 7683, 46378, 9928, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 37590, 1040, 9914, 7, 25, 15542, 62, 672, 301, 9928, 8, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 1160, 198, 33678, 0, 7, 4703, 8, 198, 2860, 62, 38801, 29700, 0, 7, 4703, 11, 1540, 332, 11, 9379, 62, 42172, 28, 1136, 62, 19849, 7, 82, 14375, 737, 42172, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 14473, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 37590, 1040, 9914, 7, 25, 41915, 26513, 11, 1167, 30412, 856, 28, 7942, 11, 371, 62, 10745, 28, 15, 13, 16, 8, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 11, 8405, 28, 16, 11, 819, 874, 28, 16, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 1511, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 2860, 62, 38801, 29700, 0, 7, 4703, 11, 1540, 332, 11, 9379, 62, 42172, 28, 1136, 62, 19849, 7, 82, 14375, 737, 19849, 13, 42172, 11, 6001, 28, 15, 13, 17, 8, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 32, 796, 43720, 7, 940, 11, 940, 8, 198, 4906, 1659, 7, 1177, 7, 32, 11, 16, 25, 15, 11, 16, 25, 15, 4008, 198, 198, 2, 24992, 12, 50183, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 4507, 324, 10599, 273, 7, 25, 38262, 50183, 8, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 1315, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198, 198, 2, 2409, 11252, 8299, 198, 82, 14375, 796, 8355, 5446, 2640, 14375, 7, 2964, 22143, 13, 56, 461, 2964, 22143, 3419, 23029, 198, 26968, 4102, 62, 82, 6442, 0, 7, 82, 14375, 8, 198, 2676, 602, 7, 82, 14375, 8, 1303, 1596, 198, 9806, 62, 17069, 341, 7, 82, 14375, 8, 198, 33678, 0, 7, 4703, 8, 198, 2617, 62, 76, 5069, 0, 7, 4703, 11, 651, 62, 19849, 7, 82, 14375, 4008, 198, 41464, 1096, 0, 7, 4703, 11, 1540, 332, 8, 198 ]
2.437989
895
using LinearAlgebra using FermiCG using Printf using Arpack using Test using OrderedCollections @testset "EST" begin atoms = [] push!(atoms,Atom(1,"H",[0, 0, 0.1])) push!(atoms,Atom(2,"H",[0, 1,-1])) push!(atoms,Atom(3,"H",[0, 1, 1])) push!(atoms,Atom(4,"H",[0, 2, 0])) push!(atoms,Atom(5,"H",[0, 4, 0])) push!(atoms,Atom(6,"H",[0, 5,-1])) push!(atoms,Atom(7,"H",[0, 5, 1])) push!(atoms,Atom(8,"H",[0, 6, 0])) #basis = "6-31g" basis = "sto-3g" na = 4 nb = 4 mol = Molecule(0,1,atoms,basis) mf = FermiCG.pyscf_do_scf(mol) nbas = size(mf.mo_coeff)[1] ints = FermiCG.pyscf_build_ints(mol,mf.mo_coeff, zeros(nbas,nbas)); e_fci, d1_fci, d2_fci = FermiCG.pyscf_fci(ints,na,nb) # @printf(" FCI Energy: %12.8f\n", e_fci) FermiCG.pyscf_write_molden(mol,mf.mo_coeff,filename="scf.molden") C = mf.mo_coeff rdm_mf = C[:,1:2] * C[:,1:2]' Cl = FermiCG.localize(mf.mo_coeff,"lowdin",mf) FermiCG.pyscf_write_molden(mol,Cl,filename="lowdin.molden") S = FermiCG.get_ovlp(mf) U = C' * S * Cl println(" Build Integrals") flush(stdout) ints = FermiCG.orbital_rotation(ints,U) println(" done.") flush(stdout) clusters = [(1:4),(5:8)] init_fspace = [(2,2),(2,2)] clusters = [Cluster(i,collect(clusters[i])) for i = 1:length(clusters)] display(clusters) rdm1 = zeros(size(ints.h1)) rdm1a = rdm_mf*.5 rdm1b = rdm_mf*.5 rdm1a = rdm1 rdm1b = rdm1 display(rdm1a) display(rdm1b) #e_cmf, D1,D2,temp,temp2 = FermiCG.cmf_ci(ints, clusters, init_fspace, rdm1a, verbose=0) #Da = D1 #Db = D1 e_cmf, U, Da, Db = FermiCG.cmf_oo(ints, clusters, init_fspace, rdm1, rdm1, max_iter_oo=40, verbose=0, gconv=1e-6, method="bfgs") ints = FermiCG.orbital_rotation(ints,U) rdm1a = Da rdm1b = Db display(Da) println() display(Db) #for ci in clusters # ints_i = subset(ints, ci.orb_list, rdm1a, rdm1b) # print(ints_i.h1) #end cb_cmf = FermiCG.compute_cluster_eigenbasis(ints, clusters, verbose=1, max_roots=5,rdm1a=Da,rdm1b=Db,init_fspace=init_fspace) cb_est = FermiCG.compute_cluster_est_basis(ints, clusters, rdm1a, rdm1b, thresh_schmidt=1e-4, init_fspace=init_fspace) clustered_ham = FermiCG.extract_ClusteredTerms(ints, clusters) cluster_ops = FermiCG.compute_cluster_ops(cb_est, ints); ci_vector = FermiCG.ClusteredState(clusters) FermiCG.expand_to_full_space!(ci_vector, cb_est, na, nb) display(ci_vector,thresh=-1) ovlp = OrderedDict() for ci in clusters for (key,value) in cb_est[ci.idx] println(key) #display(cb_est[ci.idx][key]) ovlp[ci.idx,key] = cb_cmf[ci.idx].basis[key]'*cb_est[ci.idx].basis[key] end end H = FermiCG.build_full_H(ci_vector, cluster_ops, clustered_ham) #display(size(H)) #display(H) #println() display(ci_vector,root=1) e,v = Arpack.eigs(H, nev = 8, which=:SR) for ei in e @printf(" Energy: %18.12f\n",real(ei)) end ref_e = [-10.18725871 -10.15805362 -10.14789239 -10.12277607 -10.11982911 -10.11553898 -10.03259372 -10.02109892] @test isapprox(e, ref_e, atol=1e-6) S_1_42 =[0.616641; 0.766495; 0.027335; 0.176888; 0.013518] @test isapprox(abs.(ovlp[1,(4,2)]), abs.(S_1_42), atol=1e-4) S_1_41 = [ 0.935067 -0.307226; 0.208181 0.478093; -0.272371 -0.777974; -0.090131 0.267947] @test isapprox(abs.(ovlp[1,(4,1)]), abs.(S_1_41), atol=1e-4) S_1_33 = [-0.32085 -0. 0.851868; -0. 0.616641 0. ; 0. -0.766495 -0. ; -0.711982 -0. -0.110697; -0.137815 0. -0.329198] @test isapprox(abs.(ovlp[1,(3,3)]), abs.(S_1_33), atol=1e-4) S_1_23 = [ 0.674829 0.229042 -0.228784 0.656271 -0.061039 0. -0.024558 -0. ; -0.635893 0.420242 0.073237 0.548461 0.306119 -0. -0.023685 -0. ; -0. -0. 0. 0. -0. -0.935067 -0. -0.307226; 0.036266 -0.099898 0.164285 0.035816 -0.0381 -0. -0.387746 -0. ; 0.226091 0.792939 0.421423 -0.369864 -0.06511 -0. -0.002342 0. ] @test isapprox(abs.(ovlp[1,(2,3)]) , abs.(S_1_23), atol=1e-4) S_2_42 = [-0.032297; 0.981557; -0.012785; -0.187085; -0.004896] @test isapprox(abs.(ovlp[2,(4,2)]) , abs.(S_2_42), atol=1e-4) S_2_41 = [ 0.944586 0.281996; 0.011955 -0.030939; -0.318901 0.908279; 0.07692 0.30749 ;] @test isapprox(abs.(ovlp[2,(4,1)]) , abs.(S_2_41), atol=1e-4) S_2_24 = [ 0.032297; -0.981557; -0.012785; 0.187085; -0.004896] @test isapprox(abs.(ovlp[2,(2,4)]) , abs.(S_2_24), atol=1e-4) end
[ 3500, 44800, 2348, 29230, 198, 3500, 376, 7780, 72, 39816, 198, 3500, 12578, 69, 198, 3500, 943, 8002, 220, 198, 3500, 6208, 198, 3500, 14230, 1068, 5216, 26448, 198, 198, 31, 9288, 2617, 366, 6465, 1, 2221, 198, 220, 220, 220, 23235, 796, 17635, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 16, 553, 39, 1600, 58, 15, 11, 657, 11, 657, 13, 16, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 17, 553, 39, 1600, 58, 15, 11, 352, 12095, 16, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 18, 553, 39, 1600, 58, 15, 11, 352, 11, 352, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 19, 553, 39, 1600, 58, 15, 11, 362, 11, 657, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 20, 553, 39, 1600, 58, 15, 11, 604, 11, 657, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 21, 553, 39, 1600, 58, 15, 11, 642, 12095, 16, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 22, 553, 39, 1600, 58, 15, 11, 642, 11, 352, 60, 4008, 198, 220, 220, 220, 4574, 0, 7, 265, 3150, 11, 2953, 296, 7, 23, 553, 39, 1600, 58, 15, 11, 718, 11, 657, 60, 4008, 198, 220, 220, 220, 1303, 12093, 271, 796, 366, 21, 12, 3132, 70, 1, 198, 220, 220, 220, 4308, 796, 366, 301, 78, 12, 18, 70, 1, 628, 220, 220, 220, 12385, 796, 604, 198, 220, 220, 220, 299, 65, 796, 604, 628, 220, 220, 220, 18605, 220, 220, 220, 220, 796, 25726, 23172, 7, 15, 11, 16, 11, 265, 3150, 11, 12093, 271, 8, 198, 220, 220, 220, 285, 69, 796, 376, 7780, 72, 39816, 13, 79, 893, 12993, 62, 4598, 62, 1416, 69, 7, 43132, 8, 198, 220, 220, 220, 299, 12093, 796, 2546, 7, 76, 69, 13, 5908, 62, 1073, 14822, 38381, 16, 60, 198, 220, 220, 220, 493, 82, 796, 376, 7780, 72, 39816, 13, 79, 893, 12993, 62, 11249, 62, 29503, 7, 43132, 11, 76, 69, 13, 5908, 62, 1073, 14822, 11, 1976, 27498, 7, 77, 12093, 11, 77, 12093, 18125, 198, 220, 220, 220, 304, 62, 69, 979, 11, 288, 16, 62, 69, 979, 11, 288, 17, 62, 69, 979, 796, 376, 7780, 72, 39816, 13, 79, 893, 12993, 62, 69, 979, 7, 29503, 11, 2616, 11, 46803, 8, 198, 220, 220, 220, 1303, 2488, 37435, 7203, 10029, 40, 6682, 25, 4064, 1065, 13, 23, 69, 59, 77, 1600, 304, 62, 69, 979, 8, 628, 220, 220, 220, 376, 7780, 72, 39816, 13, 79, 893, 12993, 62, 13564, 62, 76, 727, 268, 7, 43132, 11, 76, 69, 13, 5908, 62, 1073, 14822, 11, 34345, 2625, 1416, 69, 13, 76, 727, 268, 4943, 628, 220, 220, 220, 327, 796, 285, 69, 13, 5908, 62, 1073, 14822, 198, 220, 220, 220, 374, 36020, 62, 76, 69, 796, 327, 58, 45299, 16, 25, 17, 60, 1635, 327, 58, 45299, 16, 25, 17, 49946, 198, 220, 220, 220, 1012, 796, 376, 7780, 72, 39816, 13, 12001, 1096, 7, 76, 69, 13, 5908, 62, 1073, 14822, 553, 9319, 25194, 1600, 76, 69, 8, 198, 220, 220, 220, 376, 7780, 72, 39816, 13, 79, 893, 12993, 62, 13564, 62, 76, 727, 268, 7, 43132, 11, 2601, 11, 34345, 2625, 9319, 25194, 13, 76, 727, 268, 4943, 198, 220, 220, 220, 311, 796, 376, 7780, 72, 39816, 13, 1136, 62, 709, 34431, 7, 76, 69, 8, 198, 220, 220, 220, 471, 796, 220, 327, 6, 1635, 311, 1635, 1012, 198, 220, 220, 220, 44872, 7203, 10934, 15995, 30691, 4943, 198, 220, 220, 220, 24773, 7, 19282, 448, 8, 198, 220, 220, 220, 493, 82, 796, 376, 7780, 72, 39816, 13, 27688, 1287, 62, 10599, 341, 7, 29503, 11, 52, 8, 198, 220, 220, 220, 44872, 7203, 1760, 19570, 198, 220, 220, 220, 24773, 7, 19282, 448, 8, 628, 220, 220, 220, 23163, 220, 220, 220, 796, 47527, 16, 25, 19, 828, 7, 20, 25, 23, 15437, 198, 220, 220, 220, 2315, 62, 69, 13200, 796, 47527, 17, 11, 17, 828, 7, 17, 11, 17, 15437, 628, 220, 220, 220, 23163, 796, 685, 2601, 5819, 7, 72, 11, 33327, 7, 565, 13654, 58, 72, 60, 4008, 329, 1312, 796, 352, 25, 13664, 7, 565, 13654, 15437, 198, 220, 220, 220, 3359, 7, 565, 13654, 8, 628, 220, 220, 220, 374, 36020, 16, 796, 1976, 27498, 7, 7857, 7, 29503, 13, 71, 16, 4008, 198, 220, 220, 220, 374, 36020, 16, 64, 796, 374, 36020, 62, 76, 69, 24620, 20, 198, 220, 220, 220, 374, 36020, 16, 65, 796, 374, 36020, 62, 76, 69, 24620, 20, 628, 220, 220, 220, 374, 36020, 16, 64, 796, 374, 36020, 16, 198, 220, 220, 220, 374, 36020, 16, 65, 796, 374, 36020, 16, 628, 220, 220, 220, 3359, 7, 4372, 76, 16, 64, 8, 198, 220, 220, 220, 3359, 7, 4372, 76, 16, 65, 8, 198, 220, 220, 220, 220, 628, 220, 220, 220, 1303, 68, 62, 11215, 69, 11, 360, 16, 11, 35, 17, 11, 29510, 11, 29510, 17, 796, 376, 7780, 72, 39816, 13, 11215, 69, 62, 979, 7, 29503, 11, 23163, 11, 2315, 62, 69, 13200, 11, 374, 36020, 16, 64, 11, 15942, 577, 28, 15, 8, 198, 220, 220, 220, 1303, 26531, 796, 360, 16, 198, 220, 220, 220, 1303, 43832, 796, 360, 16, 628, 220, 220, 220, 304, 62, 11215, 69, 11, 471, 11, 9637, 11, 360, 65, 220, 796, 376, 7780, 72, 39816, 13, 11215, 69, 62, 2238, 7, 29503, 11, 23163, 11, 2315, 62, 69, 13200, 11, 374, 36020, 16, 11, 374, 36020, 16, 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, 3509, 62, 2676, 62, 2238, 28, 1821, 11, 15942, 577, 28, 15, 11, 308, 42946, 28, 16, 68, 12, 21, 11, 2446, 2625, 19881, 14542, 4943, 198, 220, 220, 220, 493, 82, 796, 376, 7780, 72, 39816, 13, 27688, 1287, 62, 10599, 341, 7, 29503, 11, 52, 8, 628, 220, 220, 220, 374, 36020, 16, 64, 796, 9637, 198, 220, 220, 220, 374, 36020, 16, 65, 796, 360, 65, 628, 220, 220, 220, 3359, 7, 26531, 8, 198, 220, 220, 220, 44872, 3419, 198, 220, 220, 220, 3359, 7, 43832, 8, 628, 198, 220, 220, 220, 1303, 1640, 269, 72, 287, 23163, 198, 220, 220, 220, 1303, 220, 220, 220, 493, 82, 62, 72, 796, 24637, 7, 29503, 11, 269, 72, 13, 27688, 62, 4868, 11, 374, 36020, 16, 64, 11, 374, 36020, 16, 65, 8, 220, 198, 220, 220, 220, 1303, 197, 4798, 7, 29503, 62, 72, 13, 71, 16, 8, 198, 220, 220, 220, 1303, 437, 628, 198, 220, 220, 220, 269, 65, 62, 11215, 69, 796, 376, 7780, 72, 39816, 13, 5589, 1133, 62, 565, 5819, 62, 68, 9324, 12093, 271, 7, 29503, 11, 23163, 11, 15942, 577, 28, 16, 11, 3509, 62, 19150, 28, 20, 11, 4372, 76, 16, 64, 28, 26531, 11, 4372, 76, 16, 65, 28, 43832, 11, 15003, 62, 69, 13200, 28, 15003, 62, 69, 13200, 8, 220, 198, 220, 220, 220, 269, 65, 62, 395, 796, 376, 7780, 72, 39816, 13, 5589, 1133, 62, 565, 5819, 62, 395, 62, 12093, 271, 7, 29503, 11, 23163, 11, 374, 36020, 16, 64, 11, 374, 36020, 16, 65, 11, 294, 3447, 62, 20601, 21184, 28, 16, 68, 12, 19, 11, 2315, 62, 69, 13200, 28, 15003, 62, 69, 13200, 8, 628, 220, 220, 220, 220, 198, 220, 220, 220, 49480, 62, 2763, 796, 376, 7780, 72, 39816, 13, 2302, 974, 62, 2601, 436, 1068, 15156, 907, 7, 29503, 11, 23163, 8, 198, 220, 220, 220, 13946, 62, 2840, 796, 376, 7780, 72, 39816, 13, 5589, 1133, 62, 565, 5819, 62, 2840, 7, 21101, 62, 395, 11, 493, 82, 1776, 628, 220, 220, 220, 269, 72, 62, 31364, 796, 376, 7780, 72, 39816, 13, 2601, 436, 1068, 9012, 7, 565, 13654, 8, 198, 220, 220, 220, 376, 7780, 72, 39816, 13, 11201, 392, 62, 1462, 62, 12853, 62, 13200, 0, 7, 979, 62, 31364, 11, 269, 65, 62, 395, 11, 12385, 11, 299, 65, 8, 198, 220, 220, 220, 3359, 7, 979, 62, 31364, 11, 400, 3447, 10779, 16, 8, 628, 628, 220, 220, 220, 267, 19279, 79, 796, 14230, 1068, 35, 713, 3419, 198, 220, 220, 220, 329, 269, 72, 287, 23163, 198, 220, 220, 220, 220, 197, 1640, 357, 2539, 11, 8367, 8, 287, 269, 65, 62, 395, 58, 979, 13, 312, 87, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 2539, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 13812, 7, 21101, 62, 395, 58, 979, 13, 312, 87, 7131, 2539, 12962, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 267, 19279, 79, 58, 979, 13, 312, 87, 11, 2539, 60, 796, 269, 65, 62, 11215, 69, 58, 979, 13, 312, 87, 4083, 12093, 271, 58, 2539, 49946, 9, 21101, 62, 395, 58, 979, 13, 312, 87, 4083, 12093, 271, 58, 2539, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 220, 197, 198, 220, 220, 220, 220, 628, 220, 220, 220, 367, 796, 376, 7780, 72, 39816, 13, 11249, 62, 12853, 62, 39, 7, 979, 62, 31364, 11, 13946, 62, 2840, 11, 49480, 62, 2763, 8, 198, 220, 220, 220, 1303, 13812, 7, 7857, 7, 39, 4008, 198, 220, 220, 220, 1303, 13812, 7, 39, 8, 198, 220, 220, 220, 1303, 35235, 3419, 628, 220, 220, 220, 3359, 7, 979, 62, 31364, 11, 15763, 28, 16, 8, 198, 220, 220, 220, 304, 11, 85, 796, 943, 8002, 13, 68, 9235, 7, 39, 11, 497, 85, 796, 807, 11, 543, 28, 25, 12562, 8, 198, 220, 220, 220, 329, 304, 72, 287, 304, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 37435, 7203, 6682, 25, 4064, 1507, 13, 1065, 69, 59, 77, 1600, 5305, 7, 20295, 4008, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1006, 62, 68, 796, 25915, 940, 13, 23451, 25600, 4869, 198, 220, 220, 220, 532, 940, 13, 1314, 28256, 35667, 198, 220, 220, 220, 532, 940, 13, 1415, 40401, 23516, 198, 220, 220, 220, 532, 940, 13, 1065, 27019, 31980, 198, 220, 220, 220, 532, 940, 13, 16315, 23, 1959, 1157, 198, 220, 220, 220, 532, 940, 13, 1157, 2816, 2548, 4089, 198, 220, 220, 220, 532, 940, 13, 3070, 25191, 36720, 198, 220, 220, 220, 532, 940, 13, 2999, 940, 4089, 5892, 60, 628, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 68, 11, 1006, 62, 68, 11, 379, 349, 28, 16, 68, 12, 21, 8, 628, 220, 220, 220, 311, 62, 16, 62, 3682, 796, 58, 15, 13, 44214, 42759, 26, 198, 197, 220, 657, 13, 4304, 2414, 3865, 26, 198, 197, 220, 657, 13, 44698, 27326, 26, 198, 197, 220, 657, 13, 1558, 3104, 3459, 26, 198, 197, 220, 657, 13, 486, 2327, 1507, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 16, 11, 7, 19, 11, 17, 15437, 828, 2352, 12195, 50, 62, 16, 62, 3682, 828, 379, 349, 28, 16, 68, 12, 19, 8, 628, 220, 220, 220, 311, 62, 16, 62, 3901, 796, 685, 657, 13, 6052, 1120, 3134, 532, 15, 13, 22996, 24909, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 21315, 27057, 220, 657, 13, 2857, 1795, 6052, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 1983, 1954, 4869, 532, 15, 13, 3324, 3720, 4524, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 2931, 486, 3132, 220, 657, 13, 2075, 3720, 2857, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 16, 11, 7, 19, 11, 16, 15437, 828, 2352, 12195, 50, 62, 16, 62, 3901, 828, 379, 349, 28, 16, 68, 12, 19, 8, 628, 198, 220, 220, 220, 311, 62, 16, 62, 2091, 796, 25915, 15, 13, 19504, 5332, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 220, 657, 13, 5332, 1507, 3104, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 220, 657, 13, 44214, 42759, 220, 657, 13, 220, 220, 220, 220, 220, 2162, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 4304, 2414, 3865, 532, 15, 13, 220, 220, 220, 220, 220, 2162, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 4869, 30763, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 11442, 40035, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 1485, 3695, 1314, 220, 657, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 37967, 22337, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 16, 11, 7, 18, 11, 18, 15437, 828, 2352, 12195, 50, 62, 16, 62, 2091, 828, 379, 349, 28, 16, 68, 12, 19, 8, 628, 220, 220, 220, 311, 62, 16, 62, 1954, 796, 685, 657, 13, 3134, 2780, 1959, 220, 657, 13, 23539, 3023, 17, 532, 15, 13, 23815, 37688, 220, 657, 13, 37466, 28977, 532, 15, 13, 3312, 940, 2670, 220, 657, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 40839, 40486, 532, 15, 13, 2162, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 48250, 49682, 220, 657, 13, 27211, 27877, 220, 657, 13, 2998, 18, 24693, 220, 657, 13, 49934, 40652, 220, 657, 13, 1270, 5333, 1129, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 45310, 35978, 532, 15, 13, 220, 220, 220, 220, 220, 2162, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 220, 657, 13, 220, 220, 220, 220, 220, 220, 220, 657, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 6052, 1120, 3134, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 22996, 24909, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 48597, 25540, 532, 15, 13, 15, 34808, 4089, 220, 657, 13, 23237, 26279, 220, 657, 13, 15, 31128, 1433, 532, 15, 13, 15, 36626, 220, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 2548, 3324, 3510, 532, 15, 13, 220, 220, 220, 220, 220, 2162, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 1828, 1899, 6420, 220, 657, 13, 3720, 1959, 2670, 220, 657, 13, 3682, 1415, 1954, 532, 15, 13, 2623, 4089, 2414, 532, 15, 13, 15, 2996, 1157, 220, 532, 15, 13, 220, 220, 220, 220, 220, 220, 532, 15, 13, 405, 1954, 3682, 220, 657, 13, 220, 220, 220, 220, 220, 2361, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 16, 11, 7, 17, 11, 18, 8, 12962, 837, 2352, 12195, 50, 62, 16, 62, 1954, 828, 379, 349, 28, 16, 68, 12, 19, 8, 198, 220, 220, 220, 311, 62, 17, 62, 3682, 796, 25915, 15, 13, 3070, 1828, 5607, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4089, 1314, 3553, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 486, 1983, 5332, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 1507, 2154, 5332, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 405, 2780, 4846, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 17, 11, 7, 19, 11, 17, 8, 12962, 837, 2352, 12195, 50, 62, 17, 62, 3682, 828, 379, 349, 28, 16, 68, 12, 19, 8, 198, 220, 220, 220, 311, 62, 17, 62, 3901, 796, 685, 657, 13, 5824, 2231, 4521, 220, 657, 13, 2078, 22288, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 486, 1129, 2816, 532, 15, 13, 15, 26895, 2670, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 18, 23362, 486, 220, 657, 13, 24, 2919, 26050, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 2998, 46589, 220, 220, 657, 13, 22996, 2920, 2162, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 17, 11, 7, 19, 11, 16, 8, 12962, 837, 2352, 12195, 50, 62, 17, 62, 3901, 828, 379, 349, 28, 16, 68, 12, 19, 8, 198, 220, 220, 220, 311, 62, 17, 62, 1731, 796, 685, 657, 13, 3070, 1828, 5607, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 4089, 1314, 3553, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 486, 1983, 5332, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 1507, 2154, 5332, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 532, 15, 13, 405, 2780, 4846, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 8937, 12195, 709, 34431, 58, 17, 11, 7, 17, 11, 19, 8, 12962, 837, 2352, 12195, 50, 62, 17, 62, 1731, 828, 379, 349, 28, 16, 68, 12, 19, 8, 628, 198, 437, 628, 628, 220, 220, 220, 220, 198 ]
1.674799
2,992
using Test using LogicCircuits using ProbabilisticCircuits include("helper/plain_logic_circuits.jl") @testset "probabilistic circuit nodes" begin c1 = little_3var() @test isdisjoint(linearize(ProbCircuit(c1)), linearize(ProbCircuit(c1))) p1 = ProbCircuit(c1) lit3 = children(children(p1)[1])[1] # traits @test p1 isa ProbCircuit @test p1 isa PlainSumNode @test children(p1)[1] isa PlainMulNode @test lit3 isa PlainProbLiteralNode @test issum(p1) @test ismul(children(p1)[1]) @test GateType(lit3) isa LiteralGate @test length(mul_nodes(p1)) == 4 # methods @test num_parameters(p1) == 10 # extension methods @test literal(lit3) === literal(children(children(c1)[1])[1]) @test variable(left_most_descendent(p1)) == Var(3) @test ispositive(left_most_descendent(p1)) @test !isnegative(left_most_descendent(p1)) @test num_nodes(p1) == 15 @test num_edges(p1) == 18 @test num_parameters_node(p1) == 2 r1 = fully_factorized_circuit(ProbCircuit,10) @test num_parameters(r1) == 2*10+1 @test length(mul_nodes(r1)) == 1 # compilation tests @test_throws Exception compile(ProbCircuit, true) v1, v2, v3 = literals(ProbCircuit, 3) r = v1[1] * 0.3 + 0.7 * v1[2] @test r isa PlainSumNode @test all(children(r) .== [v1[1], v1[2]]) @test all(ProbabilisticCircuits.params(r) .≈ log.([0.3, 0.7])) @test r * v2[1] isa PlainMulNode @test num_children(v1[1] * v2[1] * v3[1]) == 3 @test num_children(v1[1] + v2[1] + v3[1]) == 3 end
[ 3500, 6208, 198, 3500, 30146, 31560, 15379, 198, 3500, 30873, 14991, 2569, 31560, 15379, 198, 198, 17256, 7203, 2978, 525, 14, 25638, 62, 6404, 291, 62, 21170, 15379, 13, 20362, 4943, 198, 198, 31, 9288, 2617, 366, 1676, 65, 14991, 2569, 10349, 13760, 1, 2221, 628, 220, 220, 220, 269, 16, 796, 1310, 62, 18, 7785, 3419, 628, 220, 220, 220, 2488, 9288, 318, 6381, 73, 1563, 7, 29127, 1096, 7, 2964, 65, 31560, 5013, 7, 66, 16, 36911, 14174, 1096, 7, 2964, 65, 31560, 5013, 7, 66, 16, 22305, 198, 220, 220, 220, 220, 198, 220, 220, 220, 279, 16, 796, 30873, 31560, 5013, 7, 66, 16, 8, 198, 220, 220, 220, 6578, 18, 796, 1751, 7, 17197, 7, 79, 16, 38381, 16, 12962, 58, 16, 60, 628, 220, 220, 220, 1303, 12796, 198, 220, 220, 220, 2488, 9288, 279, 16, 318, 64, 30873, 31560, 5013, 198, 220, 220, 220, 2488, 9288, 279, 16, 318, 64, 28847, 13065, 19667, 198, 220, 220, 220, 2488, 9288, 1751, 7, 79, 16, 38381, 16, 60, 318, 64, 28847, 44, 377, 19667, 198, 220, 220, 220, 2488, 9288, 6578, 18, 318, 64, 28847, 2964, 65, 43, 270, 1691, 19667, 198, 220, 220, 220, 2488, 9288, 1189, 388, 7, 79, 16, 8, 198, 220, 220, 220, 2488, 9288, 318, 76, 377, 7, 17197, 7, 79, 16, 38381, 16, 12962, 198, 220, 220, 220, 2488, 9288, 12816, 6030, 7, 18250, 18, 8, 318, 64, 25659, 1691, 22628, 198, 220, 220, 220, 2488, 9288, 4129, 7, 76, 377, 62, 77, 4147, 7, 79, 16, 4008, 6624, 604, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 5050, 198, 220, 220, 220, 2488, 9288, 997, 62, 17143, 7307, 7, 79, 16, 8, 6624, 838, 628, 220, 220, 220, 1303, 7552, 5050, 198, 220, 220, 220, 2488, 9288, 18875, 7, 18250, 18, 8, 24844, 18875, 7, 17197, 7, 17197, 7, 66, 16, 38381, 16, 12962, 58, 16, 12962, 198, 220, 220, 220, 2488, 9288, 7885, 7, 9464, 62, 1712, 62, 20147, 437, 298, 7, 79, 16, 4008, 6624, 12372, 7, 18, 8, 198, 220, 220, 220, 2488, 9288, 318, 24561, 7, 9464, 62, 1712, 62, 20147, 437, 298, 7, 79, 16, 4008, 198, 220, 220, 220, 2488, 9288, 5145, 271, 31591, 7, 9464, 62, 1712, 62, 20147, 437, 298, 7, 79, 16, 4008, 198, 220, 220, 220, 2488, 9288, 997, 62, 77, 4147, 7, 79, 16, 8, 6624, 1315, 198, 220, 220, 220, 2488, 9288, 997, 62, 276, 3212, 7, 79, 16, 8, 6624, 1248, 198, 220, 220, 220, 2488, 9288, 997, 62, 17143, 7307, 62, 17440, 7, 79, 16, 8, 6624, 362, 628, 220, 220, 220, 374, 16, 796, 3938, 62, 31412, 1143, 62, 21170, 5013, 7, 2964, 65, 31560, 5013, 11, 940, 8, 198, 220, 220, 220, 2488, 9288, 997, 62, 17143, 7307, 7, 81, 16, 8, 6624, 362, 9, 940, 10, 16, 628, 220, 220, 220, 2488, 9288, 4129, 7, 76, 377, 62, 77, 4147, 7, 81, 16, 4008, 6624, 352, 628, 220, 220, 220, 1303, 23340, 5254, 198, 220, 220, 220, 2488, 9288, 62, 400, 8516, 35528, 17632, 7, 2964, 65, 31560, 5013, 11, 2081, 8, 198, 220, 220, 220, 410, 16, 11, 410, 17, 11, 410, 18, 796, 4187, 874, 7, 2964, 65, 31560, 5013, 11, 513, 8, 198, 220, 220, 220, 374, 796, 410, 16, 58, 16, 60, 1635, 657, 13, 18, 1343, 657, 13, 22, 1635, 410, 16, 58, 17, 60, 198, 220, 220, 220, 2488, 9288, 374, 318, 64, 28847, 13065, 19667, 198, 220, 220, 220, 2488, 9288, 477, 7, 17197, 7, 81, 8, 764, 855, 685, 85, 16, 58, 16, 4357, 410, 16, 58, 17, 11907, 8, 198, 220, 220, 220, 2488, 9288, 477, 7, 2964, 65, 14991, 2569, 31560, 15379, 13, 37266, 7, 81, 8, 764, 35705, 230, 2604, 12195, 58, 15, 13, 18, 11, 657, 13, 22, 60, 4008, 198, 220, 220, 220, 2488, 9288, 374, 1635, 410, 17, 58, 16, 60, 318, 64, 28847, 44, 377, 19667, 198, 220, 220, 220, 2488, 9288, 997, 62, 17197, 7, 85, 16, 58, 16, 60, 1635, 410, 17, 58, 16, 60, 1635, 410, 18, 58, 16, 12962, 6624, 513, 198, 220, 220, 220, 2488, 9288, 997, 62, 17197, 7, 85, 16, 58, 16, 60, 1343, 410, 17, 58, 16, 60, 1343, 410, 18, 58, 16, 12962, 6624, 513, 198, 437 ]
2.171745
722
@testset "logseries dist" begin @test logseriescdf(0.01)[1:3] ≈ [0.0, 0.994992, 0.999967] atol=1.0e-5 @test logseriescdf(0.000000000001)[1:5] ≈ [0., 1., 1., 1., 1.] atol=1.0e-2 #@test logseriesquantile(0.9, [0.25, 0.5, 0.75]) == [1, 2, 5] Random.seed!(43) w = logseriescdf(0.4) v = pmap(i -> findlast(w .< i), rand(1000000)) @test mean(v) ≈ 1.304 atol=1.0e-2 @test std(v) ≈ 0.687 atol=1.0e-2 @test skewness(v) ≈ 3.1 atol=1.0e-2 @test kurtosis(v) ≈ 13.5 atol=1.0 end @testset "stable levy dist" begin Random.seed!(43) @test levyel(2., rand(), rand()) ≈ 0.18170339379413047 Random.seed!(43) @test tiltedlevygen(0.2, 2.; rng = Random.GLOBAL_RNG) ≈ 0.00409133 atol=1.0e-5 Random.seed!(43) @test tiltedlevygen(0.6, 2.; rng = Random.GLOBAL_RNG) ≈ 0.036822009 atol=1.0e-5 end @testset "nested copulas data generators" begin @test Ginv(0.5, 0.5) ≈ 1.2732395447351625 @test InvlaJ(4, 0.5) ≈ 0.7265625 @test sampleInvlaJ(0.5, 0.5) == 1 @test sampleInvlaJ(0.5, 0.8) == 8 Random.seed!(43) w = logseriescdf(1-exp(-4.)) @test elInvlaF(4., 2., w; rng = Random.GLOBAL_RNG) == 7 Random.seed!(43) @test elInvlaF(4., .5, w; rng = Random.GLOBAL_RNG) == 16 @test nestedfrankgen(4., 3., 1, w; rng = Random.GLOBAL_RNG) == 6 end
[ 31, 9288, 2617, 366, 6404, 25076, 1233, 1, 2221, 198, 220, 2488, 9288, 2604, 25076, 66, 7568, 7, 15, 13, 486, 38381, 16, 25, 18, 60, 15139, 230, 685, 15, 13, 15, 11, 657, 13, 2079, 28324, 17, 11, 657, 13, 24214, 3134, 60, 379, 349, 28, 16, 13, 15, 68, 12, 20, 198, 220, 2488, 9288, 2604, 25076, 66, 7568, 7, 15, 13, 8269, 18005, 38381, 16, 25, 20, 60, 15139, 230, 685, 15, 1539, 352, 1539, 352, 1539, 352, 1539, 352, 8183, 379, 349, 28, 16, 13, 15, 68, 12, 17, 198, 220, 1303, 31, 9288, 2604, 25076, 40972, 576, 7, 15, 13, 24, 11, 685, 15, 13, 1495, 11, 657, 13, 20, 11, 657, 13, 2425, 12962, 6624, 685, 16, 11, 362, 11, 642, 60, 198, 220, 14534, 13, 28826, 0, 7, 3559, 8, 198, 220, 266, 796, 2604, 25076, 66, 7568, 7, 15, 13, 19, 8, 198, 220, 410, 796, 279, 8899, 7, 72, 4613, 1064, 12957, 7, 86, 764, 27, 1312, 828, 43720, 7, 16, 10535, 4008, 198, 220, 2488, 9288, 1612, 7, 85, 8, 15139, 230, 352, 13, 21288, 379, 349, 28, 16, 13, 15, 68, 12, 17, 198, 220, 2488, 9288, 14367, 7, 85, 8, 15139, 230, 657, 13, 39925, 379, 349, 28, 16, 13, 15, 68, 12, 17, 198, 220, 2488, 9288, 6146, 675, 408, 7, 85, 8, 15139, 230, 513, 13, 16, 379, 349, 28, 16, 13, 15, 68, 12, 17, 198, 220, 2488, 9288, 479, 3325, 5958, 7, 85, 8, 15139, 230, 1511, 13, 20, 379, 349, 28, 16, 13, 15, 198, 437, 198, 31, 9288, 2617, 366, 31284, 35783, 1233, 1, 2221, 198, 220, 14534, 13, 28826, 0, 7, 3559, 8, 198, 220, 2488, 9288, 35783, 417, 7, 17, 1539, 43720, 22784, 43720, 28955, 15139, 230, 657, 13, 1507, 17279, 29626, 29088, 3901, 1270, 2857, 198, 220, 220, 220, 14534, 13, 28826, 0, 7, 3559, 8, 198, 220, 2488, 9288, 37229, 2768, 88, 5235, 7, 15, 13, 17, 11, 362, 15089, 374, 782, 796, 14534, 13, 8763, 9864, 1847, 62, 49, 10503, 8, 15139, 230, 657, 13, 405, 29416, 16945, 379, 349, 28, 16, 13, 15, 68, 12, 20, 198, 220, 14534, 13, 28826, 0, 7, 3559, 8, 198, 220, 2488, 9288, 37229, 2768, 88, 5235, 7, 15, 13, 21, 11, 362, 15089, 374, 782, 796, 14534, 13, 8763, 9864, 1847, 62, 49, 10503, 8, 15139, 230, 657, 13, 15, 27412, 1828, 28694, 379, 349, 28, 16, 13, 15, 68, 12, 20, 198, 437, 198, 31, 9288, 2617, 366, 77, 7287, 2243, 25283, 1366, 27298, 1, 2221, 198, 220, 2488, 9288, 402, 16340, 7, 15, 13, 20, 11, 657, 13, 20, 8, 15139, 230, 352, 13, 27367, 1954, 3865, 34825, 2327, 1433, 1495, 198, 220, 2488, 9288, 10001, 5031, 41, 7, 19, 11, 657, 13, 20, 8, 15139, 230, 657, 13, 22, 2075, 3980, 1495, 198, 220, 2488, 9288, 6291, 19904, 5031, 41, 7, 15, 13, 20, 11, 657, 13, 20, 8, 6624, 352, 198, 220, 2488, 9288, 6291, 19904, 5031, 41, 7, 15, 13, 20, 11, 657, 13, 23, 8, 6624, 807, 198, 220, 14534, 13, 28826, 0, 7, 3559, 8, 198, 220, 266, 796, 2604, 25076, 66, 7568, 7, 16, 12, 11201, 32590, 19, 2014, 8, 198, 220, 2488, 9288, 1288, 19904, 5031, 37, 7, 19, 1539, 362, 1539, 266, 26, 374, 782, 796, 14534, 13, 8763, 9864, 1847, 62, 49, 10503, 8, 6624, 767, 198, 220, 14534, 13, 28826, 0, 7, 3559, 8, 198, 220, 2488, 9288, 1288, 19904, 5031, 37, 7, 19, 1539, 764, 20, 11, 266, 26, 374, 782, 796, 14534, 13, 8763, 9864, 1847, 62, 49, 10503, 8, 6624, 1467, 198, 220, 2488, 9288, 28376, 8310, 962, 5235, 7, 19, 1539, 513, 1539, 352, 11, 266, 26, 374, 782, 796, 14534, 13, 8763, 9864, 1847, 62, 49, 10503, 8, 6624, 718, 198, 437, 198 ]
1.964119
641
module Unification using InteractiveUtils using Logging include("bindings.jl") include("unify.jl") end
[ 21412, 791, 2649, 198, 198, 3500, 21365, 18274, 4487, 198, 3500, 5972, 2667, 198, 198, 17256, 7203, 21653, 654, 13, 20362, 4943, 198, 17256, 7203, 403, 1958, 13, 20362, 4943, 198, 198, 437, 198 ]
3.117647
34
module Day09 import ..data_dir # from parent module input = read(joinpath(data_dir, "day09"), String) export part1, part2 """ Horrendous logic for converting this string of integers to a matrix. There must be a better way, but I can't find it. """ function string_block_to_matrix(string_block::AbstractString) as_arrays = split.(split(string_block, "\n"), "") as_int_arrays = [parse.(Int64, array) for array in as_arrays] # Transposing changes the type! Matrix(transpose(hcat(as_int_arrays...))) end function out_of_bounds(heatmap::Matrix{Int64}, row::Int64, column::Int64) heatmap_height, heatmap_width = size(heatmap) row < 1 || row > heatmap_height || column < 1 || column > heatmap_width end function identify_neighbours(heatmap::Matrix{Int64}, row::Int64, column::Int64) candidates = [ (row - 1, column), (row + 1, column), (row, column - 1), (row, column + 1) ] filter(candidate -> !out_of_bounds(heatmap, candidate...), candidates) end function risk_level(heatmap::Matrix{Int64}, row::Int64, column::Int64) value = heatmap[row, column] # matrices are indexed row then column if value == 9 return (0) end neighbours = identify_neighbours(heatmap, row, column) is_minimum = all(value < heatmap[neighbour...] for neighbour in neighbours) is_minimum * (1 + value) # non-minima don't get a risk value end function add_to_basin( heatmap::Matrix{Int64}, unclaimed::Vector{Tuple{Int64,Int64}}, row::Int64, column::Int64 ) # can't pop by value, so I need to get the index index_in_unclaimed = findfirst(x -> x == (row, column), unclaimed) if isnothing(index_in_unclaimed) # already claimed by another path return Set{Tuple{Int64,Int64}}() end in_basin = Set([popat!(unclaimed, index_in_unclaimed)]) neighbours = [neighbour for neighbour in identify_neighbours(heatmap, row, column) if neighbour in unclaimed] if length(neighbours) == 0 return (in_basin) end for neighbour in neighbours in_basin = in_basin ∪ add_to_basin(heatmap, unclaimed, neighbour...) end in_basin end function part1(input = input) heatmap = string_block_to_matrix(input) n_rows, n_cols = size(heatmap) total_risk_level = 0 for row = 1:n_rows, column = 1:n_cols total_risk_level += risk_level(heatmap, row, column) end total_risk_level end """ Two things make this second part manageable: * I didn't need to consider the actual values of the heatmap, as long as I knew which ones were 9 and which ones aren't * Every non-9 element of the heatmap is in exactly one basin """ function part2(input = input) heatmap = string_block_to_matrix(input) n_rows, n_cols = size(heatmap) unclaimed = [(row, column) for row in 1:n_rows, column in 1:n_cols if heatmap[row, column] != 9] basins = Vector{Set{Tuple{Int64,Int64}}}() while length(unclaimed) > 0 push!(basins, add_to_basin(heatmap, unclaimed, unclaimed[1]...)) end basin_sizes = map(x -> length(x), basins) last(sort(basin_sizes), 3) |> prod end end #module
[ 21412, 3596, 2931, 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, 2931, 12340, 10903, 8, 198, 198, 39344, 636, 16, 11, 636, 17, 198, 198, 37811, 198, 27991, 10920, 516, 9156, 329, 23202, 428, 4731, 286, 37014, 284, 257, 17593, 13, 198, 1858, 1276, 307, 257, 1365, 835, 11, 475, 314, 460, 470, 1064, 340, 13, 198, 37811, 198, 8818, 4731, 62, 9967, 62, 1462, 62, 6759, 8609, 7, 8841, 62, 9967, 3712, 23839, 10100, 8, 198, 220, 220, 220, 355, 62, 3258, 592, 796, 6626, 12195, 35312, 7, 8841, 62, 9967, 11, 37082, 77, 12340, 366, 4943, 198, 220, 220, 220, 355, 62, 600, 62, 3258, 592, 796, 685, 29572, 12195, 5317, 2414, 11, 7177, 8, 329, 7177, 287, 355, 62, 3258, 592, 60, 198, 220, 220, 220, 1303, 3602, 32927, 2458, 262, 2099, 0, 198, 220, 220, 220, 24936, 7, 7645, 3455, 7, 71, 9246, 7, 292, 62, 600, 62, 3258, 592, 986, 22305, 198, 437, 198, 198, 8818, 503, 62, 1659, 62, 65, 3733, 7, 25080, 8899, 3712, 46912, 90, 5317, 2414, 5512, 5752, 3712, 5317, 2414, 11, 5721, 3712, 5317, 2414, 8, 198, 220, 220, 220, 4894, 8899, 62, 17015, 11, 4894, 8899, 62, 10394, 796, 2546, 7, 25080, 8899, 8, 198, 220, 220, 220, 5752, 1279, 352, 8614, 5752, 1875, 4894, 8899, 62, 17015, 8614, 5721, 1279, 352, 8614, 5721, 1875, 4894, 8899, 62, 10394, 198, 437, 198, 198, 8818, 5911, 62, 710, 394, 65, 4662, 7, 25080, 8899, 3712, 46912, 90, 5317, 2414, 5512, 5752, 3712, 5317, 2414, 11, 5721, 3712, 5317, 2414, 8, 198, 220, 220, 220, 5871, 796, 685, 198, 220, 220, 220, 220, 220, 220, 220, 357, 808, 532, 352, 11, 5721, 828, 357, 808, 1343, 352, 11, 5721, 828, 198, 220, 220, 220, 220, 220, 220, 220, 357, 808, 11, 5721, 532, 352, 828, 357, 808, 11, 5721, 1343, 352, 8, 198, 220, 220, 220, 2361, 198, 220, 220, 220, 8106, 7, 46188, 20540, 4613, 5145, 448, 62, 1659, 62, 65, 3733, 7, 25080, 8899, 11, 4540, 986, 828, 5871, 8, 198, 437, 198, 198, 8818, 2526, 62, 5715, 7, 25080, 8899, 3712, 46912, 90, 5317, 2414, 5512, 5752, 3712, 5317, 2414, 11, 5721, 3712, 5317, 2414, 8, 198, 220, 220, 220, 1988, 796, 4894, 8899, 58, 808, 11, 5721, 60, 1303, 2603, 45977, 389, 41497, 5752, 788, 5721, 198, 220, 220, 220, 611, 1988, 6624, 860, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 15, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 23788, 796, 5911, 62, 710, 394, 65, 4662, 7, 25080, 8899, 11, 5752, 11, 5721, 8, 198, 220, 220, 220, 318, 62, 39504, 796, 477, 7, 8367, 1279, 4894, 8899, 58, 710, 394, 6084, 22345, 329, 12250, 287, 23788, 8, 198, 220, 220, 220, 318, 62, 39504, 1635, 357, 16, 1343, 1988, 8, 1303, 1729, 12, 1084, 8083, 836, 470, 651, 257, 2526, 1988, 198, 437, 198, 198, 8818, 751, 62, 1462, 62, 12093, 259, 7, 198, 220, 220, 220, 4894, 8899, 3712, 46912, 90, 5317, 2414, 5512, 198, 220, 220, 220, 555, 12795, 3712, 38469, 90, 51, 29291, 90, 5317, 2414, 11, 5317, 2414, 92, 5512, 198, 220, 220, 220, 5752, 3712, 5317, 2414, 11, 198, 220, 220, 220, 5721, 3712, 5317, 2414, 198, 8, 198, 220, 220, 220, 1303, 460, 470, 1461, 416, 1988, 11, 523, 314, 761, 284, 651, 262, 6376, 198, 220, 220, 220, 6376, 62, 259, 62, 403, 12795, 796, 1064, 11085, 7, 87, 4613, 2124, 6624, 357, 808, 11, 5721, 828, 555, 12795, 8, 198, 220, 220, 220, 611, 318, 22366, 7, 9630, 62, 259, 62, 403, 12795, 8, 1303, 1541, 4752, 416, 1194, 3108, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 5345, 90, 51, 29291, 90, 5317, 2414, 11, 5317, 2414, 11709, 3419, 198, 220, 220, 220, 886, 198, 220, 220, 220, 287, 62, 12093, 259, 796, 5345, 26933, 12924, 265, 0, 7, 403, 12795, 11, 6376, 62, 259, 62, 403, 12795, 8, 12962, 198, 220, 220, 220, 23788, 796, 685, 710, 394, 6084, 329, 12250, 287, 5911, 62, 710, 394, 65, 4662, 7, 25080, 8899, 11, 5752, 11, 5721, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 12250, 287, 555, 12795, 60, 198, 220, 220, 220, 611, 4129, 7, 710, 394, 65, 4662, 8, 6624, 657, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 259, 62, 12093, 259, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 329, 12250, 287, 23788, 198, 220, 220, 220, 220, 220, 220, 220, 287, 62, 12093, 259, 796, 287, 62, 12093, 259, 18872, 103, 751, 62, 1462, 62, 12093, 259, 7, 25080, 8899, 11, 555, 12795, 11, 12250, 23029, 198, 220, 220, 220, 886, 198, 220, 220, 220, 287, 62, 12093, 259, 198, 437, 198, 198, 8818, 636, 16, 7, 15414, 796, 5128, 8, 198, 220, 220, 220, 4894, 8899, 796, 4731, 62, 9967, 62, 1462, 62, 6759, 8609, 7, 15414, 8, 198, 220, 220, 220, 299, 62, 8516, 11, 299, 62, 4033, 82, 796, 2546, 7, 25080, 8899, 8, 198, 220, 220, 220, 2472, 62, 19121, 62, 5715, 796, 657, 198, 220, 220, 220, 329, 5752, 796, 352, 25, 77, 62, 8516, 11, 5721, 796, 352, 25, 77, 62, 4033, 82, 198, 220, 220, 220, 220, 220, 220, 220, 2472, 62, 19121, 62, 5715, 15853, 2526, 62, 5715, 7, 25080, 8899, 11, 5752, 11, 5721, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 2472, 62, 19121, 62, 5715, 198, 437, 198, 198, 37811, 198, 7571, 1243, 787, 428, 1218, 636, 36426, 25, 198, 198, 9, 314, 1422, 470, 761, 284, 2074, 262, 4036, 3815, 286, 262, 4894, 8899, 11, 198, 220, 220, 220, 355, 890, 355, 314, 2993, 543, 3392, 547, 860, 290, 543, 3392, 3588, 470, 198, 9, 3887, 1729, 12, 24, 5002, 286, 262, 4894, 8899, 318, 287, 3446, 530, 34164, 198, 37811, 198, 8818, 636, 17, 7, 15414, 796, 5128, 8, 198, 220, 220, 220, 4894, 8899, 796, 4731, 62, 9967, 62, 1462, 62, 6759, 8609, 7, 15414, 8, 198, 220, 220, 220, 299, 62, 8516, 11, 299, 62, 4033, 82, 796, 2546, 7, 25080, 8899, 8, 198, 220, 220, 220, 555, 12795, 796, 47527, 808, 11, 5721, 8, 329, 5752, 287, 352, 25, 77, 62, 8516, 11, 5721, 287, 352, 25, 77, 62, 4033, 82, 611, 4894, 8899, 58, 808, 11, 5721, 60, 14512, 860, 60, 198, 220, 220, 220, 1615, 1040, 796, 20650, 90, 7248, 90, 51, 29291, 90, 5317, 2414, 11, 5317, 2414, 42535, 3419, 198, 220, 220, 220, 981, 4129, 7, 403, 12795, 8, 1875, 657, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 12093, 1040, 11, 751, 62, 1462, 62, 12093, 259, 7, 25080, 8899, 11, 555, 12795, 11, 555, 12795, 58, 16, 60, 986, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 34164, 62, 82, 4340, 796, 3975, 7, 87, 4613, 4129, 7, 87, 828, 1615, 1040, 8, 198, 220, 220, 220, 938, 7, 30619, 7, 12093, 259, 62, 82, 4340, 828, 513, 8, 930, 29, 40426, 198, 437, 198, 198, 437, 1303, 21412, 198 ]
2.604305
1,208
# =========================================================================== # VOLUME CONTROL BLOCKETTES function blk_010!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) v > 1 && println("") close(sio) return nothing end function blk_011!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) if v > 1 println("") if v > 2 nsta = stream_int(sio, 3) println(" "^16, lpad("STA", 5), " | SEQ") println(" "^16, "------|-------") @inbounds for i = 1:nsta sta = String(fastread(sio, 5)) seq = stream_int(sio, 6) println(" "^16, sta, " | ", seq) end end end close(sio) return nothing end function blk_012!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) if v > 1 N = stream_int(sio, 4) println(", N_SPANS = ", N) end close(sio) return nothing end # =========================================================================== # ABBREVIATION CONTROL HEADERS # [30] is out of scope for SeisIO function blk_030!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) if v > 1 desc = string_field(sio) code = stream_int(sio, 4) fam = stream_int(sio, 3) println(", CODE ", code, ", DESC ", desc, ", FAM ", fam) if v > 2 ND = stream_int(sio, 2) @inbounds for i = 1:ND desc = string_field(sio) println(" "^18, desc) end end end close(sio) return nothing end function blk_031!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) k = stream_int(sio, 4) class = fastread(sio) desc = string_field(sio) if v > 1 units = stream_int(sio, 3) println(", CODE ", k, ", CLASS ", Char(class), ", DESC ", desc, ", UNITS ", units) end close(sio) comments[k] = replace(desc, "," => "-") return nothing end function blk_032!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) if v > 1 code = stream_int(sio, 2) pub = string_field(sio) date = string_field(sio) name = string_field(sio) println(", CODE ", code, ", REFERENCE ", pub, ", DATE ", date, ", PUBLISHER ", name) end close(sio) return nothing end function blk_033!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) code = stream_int(sio, 3) desc = string_field(sio) close(sio) v > 1 && println(", CODE ", code, ", DESC ", desc) abbrev[code] = desc return nothing end function blk_034!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) code = stream_int(sio, 3) name = string_field(sio) if v > 1 desc = string_field(sio) println(", CODE ", code, ", NAME ", name, ", DESC ", desc) end close(sio) units_lookup[code] = fix_units(name) return nothing end function blk_041!(io::IO, nb::Int64, v::Integer, units::Bool) sio = blk_string_read(io, nb, v) resp_lookup_key = stream_int(sio, 4) skip_string!(sio) symm_code = fastread(sio) uic = stream_int(sio, 3) uoc = stream_int(sio, 3) #= NF can be completely wrong here. Two issues: (1) The SEED manual quietly suggests writing only part of "symmetric" FIR filters to file; in which case NF is not the length of the vector we need. =# NF = stream_int(sio, 4) if symm_code == 0x42 NF = div(NF, 2)+1 elseif symm_code == 0x43 NF = div(NF, 2) end #= (2) buried in the SEED manual, it's noted that the maximum size of a non-data blockette length is 9999 chars, and type [41] can exceed it. In this case, the sample files tell me that NF is dead wrong; workaround is to read as many FIR values as possible and fix with append! of next packet. We've already used 7 chars on blockette type & size; rest are in sio. =# p = fastpos(sio) NF_true = min(NF, div(9992-p, 14)) if v > 1 println(", KEY ", resp_lookup_key, ", SYMM ", Char(symm_code)) if v > 2 println(" "^16, "units in = ", units_lookup[uic]) println(" "^16, "units out = ", units_lookup[uoc]) end println(" "^16, "p = ", p, ", NF = ", NF, ", NF_true = ", NF_true) end #= This appears to fix it but results in some very odd behavior. =# F = Array{Float64, 1}(undef, NF_true) @inbounds for i = 1:NF_true fast_readbytes!(sio, BUF.hdr_old, 14) setindex!(F, buf_to_double(BUF.hdr_old, 14), i) end close(sio) if v > 2 [println("F[", i, "] = ", F[i]) for i = 1:NF_true] end # Process to resps if haskey(responses, resp_lookup_key) R = responses[resp_lookup_key][1] append!(R.b, F) else resp = CoeffResp(F, Float64[]) ui = units ? fix_units(units_lookup[uic]) : "" uo = units ? fix_units(units_lookup[uoc]) : "" responses[resp_lookup_key] = (resp, ui, uo) end return nothing end function blk_043!(io::IO, nb::Int64, v::Integer, units::Bool) sio = blk_string_read(io, nb, v) resp_lookup_key = stream_int(sio, 4) skip_string!(sio) fastskip(sio, 1) uic = stream_int(sio, 3) uoc = stream_int(sio, 3) fast_readbytes!(sio, BUF.hdr_old, 12) A0 = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) F0 = buf_to_double(BUF.hdr_old, 12) NZ = stream_int(sio, 3) Z = Array{ComplexF64, 1}(undef, NZ) @inbounds for i = 1:NZ fast_readbytes!(sio, BUF.hdr_old, 12) rr = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) ii = buf_to_double(BUF.hdr_old, 12) Z[i] = complex(rr, ii) fastskip(sio, 24) end NP = stream_int(sio, 3) P = Array{ComplexF64,1}(undef, NP) @inbounds for i = 1:NP fast_readbytes!(sio, BUF.hdr_old, 12) rr = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) ii = buf_to_double(BUF.hdr_old, 12) P[i] = complex(rr, ii) fastskip(sio, 24) end close(sio) if v > 1 println("A0 = ", string(A0), "F0 = ", string(F0)) if v > 2 println(" "^16, "NZ = ", NZ, ":") @inbounds for i = 1:NZ println(" "^16, Z[i]) end println(" "^16, "NP = ", NP, ":") @inbounds for i = 1:NP println(" "^16, P[i]) end end end # Process to resps R = PZResp64(a0 = A0, f0 = F0, z = Z, p = P) ui = units ? fix_units(units_lookup[uic]) : "" uo = units ? fix_units(units_lookup[uoc]) : "" responses[resp_lookup_key] = (R, ui, uo) return nothing end function blk_044!(io::IO, nb::Int64, v::Integer, units::Bool) sio = blk_string_read(io, nb, v) resp_lookup_key = stream_int(sio, 4) skip_string!(sio) fastskip(sio, 1) uic = stream_int(sio, 3) uoc = stream_int(sio, 3) NN = stream_int(sio, 4) N = Array{Float64,1}(undef, NN) @inbounds for i = 1:NN fast_readbytes!(sio, BUF.hdr_old, 12) N[i] = buf_to_double(BUF.hdr_old, 12) fastskip(sio, 12) end ND = stream_int(sio, 4) D = Array{Float64,1}(undef, ND) @inbounds for i = 1:ND fast_readbytes!(sio, BUF.hdr_old, 12) D[i] = buf_to_double(BUF.hdr_old, 12) fastskip(sio, 12) end close(sio) if v > 1 println(", KEY ", resp_lookup_key) if v > 2 println(" "^16, "units in code = ", uic) println(" "^16, "units out code = ", uoc) println(" "^16, "NN = ", NN, ":") @inbounds for i = 1:NN println(" "^16, N[i]) end println(" "^16, "ND = ", ND, ":") @inbounds for i = 1:min(ND) println(" "^16, D[i]) end end end if units responses[resp_lookup_key] = (CoeffResp(N, D), fix_units(units_lookup[uic]), fix_units(units_lookup[uoc]) ) else responses[resp_lookup_key] = (CoeffResp(N, D), "", "") end return nothing end function blk_047!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) resp_lookup_key = stream_int(sio, 4) skip_string!(sio) fast_readbytes!(sio, BUF.hdr_old, 10) fs = buf_to_double(BUF.hdr_old, 10) fac = stream_int(sio, 5) os = stream_int(sio, 5) fast_readbytes!(sio, BUF.hdr_old, 11) delay = buf_to_double(BUF.hdr_old, 11) fast_readbytes!(sio, BUF.hdr_old, 11) corr = buf_to_double(BUF.hdr_old, 11) close(sio) if v > 1 println(", KEY ", resp_lookup_key) if v > 2 println(" "^16, "fs = ", fs) println(" "^16, "decimation factor = ", fac) println(" "^16, "decimation offset = ", os) println(" "^16, "delay = ", delay) println(" "^16, "delay correction applied = ", corr) end end responses[resp_lookup_key] = Blk47(fs, delay, corr, fac, os) return nothing end function blk_048!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) resp_lookup_key = stream_int(sio, 4) skip_string!(sio) fast_readbytes!(sio, BUF.hdr_old, 12) gain = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) fg = buf_to_double(BUF.hdr_old, 12) nv = stream_int(sio, 2) # channel histories are not in the scope of SeisIO @inbounds for i = 1:nv # fastskip(sio, 24) skip_string!(sio) # should cover the 24-Byte channel history end close(sio) if v > 1 println(", KEY ", resp_lookup_key) if v > 2 println(" "^16, "gain = ", gain, " (f = ", fg, " Hz)") end end responses[resp_lookup_key] = Blk48(gain, fg) return nothing end function blk_050(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) # Station fill!(BUF.hdr, 0x00) p = pointer(BUF.hdr) fast_unsafe_read(sio, p, 5) #= I make the assumption here that channel coordinates are correctly set in blockette 52; if this is not true, then :loc will not be set. This shortcut makes support for multiplexing impossible, though blockette-50 multiplexing has never been encountered in my test files (or in any files of the ObsPy test suite.) Multiplexing would be annoying as one would need to define new SeisData objects S_subnet of length = n_subchans and use append!(S, S_subnet), rather than push!(S, C); indexing would be a mess. But it's doable in theory. =# fastskip(sio, 33) site_name = strip(string_field(sio)) fastskip(sio, 9) ts = string_field(sio) te = string_field(sio) uc = fastread(sio) # Network p = pointer(BUF.hdr, 11) fast_unsafe_read(sio, p, 2) close(sio) if v > 1 println(", ID = ", String(copy(BUF.id))) if v > 2 println(" "^16, "site name = ", site_name) println(" "^16, "start date = ", ts) println(" "^16, "end date = ", te) println(" "^16, "update code = ", Char(uc)) end end return site_name end # =========================================================================== # STATION CONTROL BLOCKETTES # not necessary function blk_051!(io::IO, nb::Int64, v::Integer) sio = blk_string_read(io, nb, v) if v > 1 println("") if v > 2 ts = string_field(sio) te = string_field(sio) k = stream_int(sio, 4) comment_level = stream_int(sio, 6) println(" "^16, "ts = ", ts) println(" "^16, "te = ", te) println(" "^16, "comment code key #", k) println(" "^16, "comment level = ", comment_level) end end close(sio) return nothing end function blk_052!(io::IO, nb::Int64, C::SeisChannel, ts_req::Int64, te_req::Int64, v::Integer) sio = blk_string_read(io, nb, v) # loc p = pointer(BUF.hdr, 6) fast_unsafe_read(sio, p, 2) # cha p = pointer(BUF.hdr, 8) fast_unsafe_read(sio, p, 3) fastskip(sio, 4) inst = stream_int(sio, 3) skip_string!(sio) units_code = stream_int(sio, 3) fastskip(sio, 3) # lat, lon, el, dep, az, inc fast_readbytes!(sio, BUF.hdr_old, 10) lat = buf_to_double(BUF.hdr_old, 10) fast_readbytes!(sio, BUF.hdr_old, 11) lon = buf_to_double(BUF.hdr_old, 11) fast_readbytes!(sio, BUF.hdr_old, 7) el = buf_to_double(BUF.hdr_old, 7) fast_readbytes!(sio, BUF.hdr_old, 5) dep = buf_to_double(BUF.hdr_old, 5) fast_readbytes!(sio, BUF.hdr_old, 5) az = buf_to_double(BUF.hdr_old, 5) fast_readbytes!(sio, BUF.hdr_old, 5) inc = 90.0 - buf_to_double(BUF.hdr_old, 5) fastskip(sio, 6) # fs fast_readbytes!(sio, BUF.hdr_old, 10) fs = buf_to_double(BUF.hdr_old, 10) # don't really need max. drift; skip_string passes it over skip_string!(sio) # ts, te ts = parse_resp_date(sio, BUF.uint16_buf) te = parse_resp_date(sio, BUF.uint16_buf) if te == -56504908800000000 te = 19880899199000000 end close(sio) if v > 1 println(", ID = ", String(copy(BUF.hdr)), ", INST = ", inst) if v > 2 println(" "^16, "lat = ", lat, ", lon = ", lon, ", z = ", el, ", dep = ", dep, ", θ = ", az, ", ϕ = ", inc) println(" "^16, "fs = ", fs) println(" "^16, "ts = ", u2d(div(ts, sμ))) println(" "^16, "te = ", u2d(div(te, sμ))) end end if ts ≤ te_req && te ≥ ts_req update_hdr!(BUF) C.id = getfield(BUF, :id_str) C.fs = fs C.loc = GeoLoc(lat = lat, lon = lon, el = el, dep = dep, az = az, inc = inc) C.resp = MultiStageResp(12) C.misc["ts"] = ts C.misc["te"] = te C.misc["timespan"] = string(u2d(div(ts, 1000000))) * " : " * string(u2d(div(te, 1000000))) C.misc["inst"] = get(abbrev, inst, "") units = get(units_lookup, units_code, "") C.units = fix_units(units) skipping = false else if v > 1 println(" "^16, "Skipping ", String(copy(BUF.hdr)), " (not in requested time range)") end skipping = true end return skipping end function blk_053(io::IO, nb::Int64, v::Integer, R::MultiStageResp, units::Bool) sio = blk_string_read(io, nb, v) tft = Char(fastread(sio)) stage = stream_int(sio, 2) uic = stream_int(sio, 3) uoc = stream_int(sio, 3) fast_readbytes!(sio, BUF.hdr_old, 12) A0 = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) F0 = buf_to_double(BUF.hdr_old, 12) NZ = stream_int(sio, 3) Z = Array{ComplexF64,1}(undef, NZ) @inbounds for i = 1:NZ fast_readbytes!(sio, BUF.hdr_old, 12) rr = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) ii = buf_to_double(BUF.hdr_old, 12) Z[i] = complex(rr, ii) fastskip(sio, 24) end NP = stream_int(sio, 3) P = Array{ComplexF64,1}(undef, NP) @inbounds for i = 1:NP fast_readbytes!(sio, BUF.hdr_old, 12) rr = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) ii = buf_to_double(BUF.hdr_old, 12) P[i] = complex(rr, ii) fastskip(sio, 24) end close(sio) if v > 1 println(", TFT ", tft, ", STAGE ", stage) if v > 2 println(" "^16, "units in code #", uic) println(" "^16, "units out code #", uoc) println(" "^16, "A0 = ", A0) println(" "^16, "F0 = ", F0) println(" "^16, "NZ = ", NZ, ":") @inbounds for i = 1:NZ println(" "^16, Z[i]) end println(" "^16, "NP = ", NP, ":") @inbounds for i = 1:NP println(" "^16, P[i]) end end end if stage > length(R.fs) append!(R, MultiStageResp(6)) end resp = PZResp64(a0 = A0, f0 = F0, z = Z, p = P) ui = units ? fix_units(units_lookup[uic]) : "" uo = units ? fix_units(units_lookup[uoc]) : "" R.stage[stage] = resp R.i[stage] = ui R.o[stage] = uo return stage end function blk_054(io::IO, nb::Int64, v::Integer, R::MultiStageResp, units::Bool) sio = blk_string_read(io, nb, v) fastskip(sio, 1) stage = stream_int(sio, 2) uic = stream_int(sio, 3) uoc = stream_int(sio, 3) NN = stream_int(sio, 4) N = Array{Float64,1}(undef, NN) @inbounds for i = 1:NN fast_readbytes!(sio, BUF.hdr_old, 12) N[i] = buf_to_double(BUF.hdr_old, 12) fastskip(sio, 12) end ND = stream_int(sio, 4) D = Array{Float64,1}(undef, ND) @inbounds for i = 1:ND fast_readbytes!(sio, BUF.hdr_old, 12) D[i] = buf_to_double(BUF.hdr_old, 12) fastskip(sio, 12) end close(sio) if v > 1 println(", STAGE ", stage) if v > 2 println(" "^16, "units in code = ", uic) println(" "^16, "units out code = ", uoc) println(" "^16, "NN = ", NN, ":") @inbounds for i = 1:NN println(" "^16, N[i]) end println(" "^16, "ND = ", ND, ":") @inbounds for i = 1:ND println(" "^16, D[i]) end end end if stage > length(R.fs) append!(R, MultiStageResp(6)) end R.stage[stage] = CoeffResp(N, D) if units @inbounds R.i[stage] = fix_units(units_lookup[uic]) @inbounds R.o[stage] = fix_units(units_lookup[uoc]) end return stage end function blk_057(io::IO, nb::Int64, v::Integer, R::MultiStageResp) sio = blk_string_read(io, nb, v) stage = stream_int(sio, 2) fast_readbytes!(sio, BUF.hdr_old, 10) fs = buf_to_double(BUF.hdr_old, 10) fac = stream_int(sio, 5) os = stream_int(sio, 5) fast_readbytes!(sio, BUF.hdr_old, 11) delay = buf_to_double(BUF.hdr_old, 11) fast_readbytes!(sio, BUF.hdr_old, 11) corr = buf_to_double(BUF.hdr_old, 11) close(sio) if v > 1 println(", STAGE #", stage) if v > 2 println(" "^16, "fs = ", fs) println(" "^16, "decimation factor = ", fac) println(" "^16, "decimation offset = ", os) println(" "^16, "delay = ", delay) println(" "^16, "delay correction applied = ", corr) end end @inbounds R.fs[stage] = fs @inbounds R.delay[stage] = delay @inbounds R.corr[stage] = corr @inbounds R.fac[stage] = fac @inbounds R.os[stage] = os return stage end function blk_058(io::IO, nb::Int64, v::Integer, C::SeisChannel) sio = blk_string_read(io, nb, v) stage = stream_int(sio, 2) fast_readbytes!(sio, BUF.hdr_old, 12) if stage == 0 C.gain = buf_to_double(BUF.hdr_old, 12) close(sio) if v > 1 println(", STAGE #", stage) end return stage else C.resp.gain[stage] = buf_to_double(BUF.hdr_old, 12) fast_readbytes!(sio, BUF.hdr_old, 12) C.resp.fg[stage] = buf_to_double(BUF.hdr_old, 12) if v > 1 println(", STAGE #", stage) if v > 2 println(" "^16, "gain = ", C.resp.gain[stage], " (f = ", C.resp.fg[stage], " Hz)") end end # station history is not in the scope of SeisIO close(sio) return stage end end # Not in scope of SeisIO function blk_059!(io::IO, nb::Int64, v::Integer, C::SeisChannel, units::Bool) sio = blk_string_read(io, nb, v) v > 1 && println("") if units ts = parse_resp_date(sio, BUF.uint16_buf) te = parse_resp_date(sio, BUF.uint16_buf) if te == -56504908800000000 te = 19880899199000000 end k = stream_int(sio, 4) t_str = string("comment,", ts, ",", te, ",", comments[k]) if v > 2 println(u2d(div(ts, 1000000)), "–", u2d(div(te, 1000000)), ": ", comments[k]) end note!(C, t_str) end close(sio) return nothing end # Assign dictionary elements with response info in the 41-49 blockettes function blk_060(io::IO, nb::Int64, v::Integer, R::MultiStageResp) sio = blk_string_read(io, nb, v) nstg = stream_int(sio, 2) if v > 1 println(", # STAGES = ", nstg) end for i = 1:nstg seq = stream_int(sio, 2) nr = stream_int(sio, 2) for j = 1:nr k = stream_int(sio, 4) rr = get(responses, k, "") if v > 2 printstyled(" "^16, " assigning response to stage #", seq, ":\n", color=:green, bold=true) println(rr) end if isa(rr, Blk48) @inbounds R.gain[seq] = rr.gain @inbounds R.fg[seq] = rr.fg elseif isa(rr, Blk47) @inbounds R.fs[seq] = rr.fs @inbounds R.delay[seq] = rr.delay @inbounds R.corr[seq] = rr.corr @inbounds R.fac[seq] = rr.fac @inbounds R.os[seq] = rr.os elseif typeof(rr[1]) <: InstrumentResponse (length(R.fs) < seq) && append!(R, MultiStageResp(6)) @inbounds R.stage[seq] = rr[1] @inbounds R.i[seq] = rr[2] @inbounds R.o[seq] = rr[3] end end end close(sio) return nstg end function blk_061(io::IO, nb::Int64, v::Integer, R::MultiStageResp, units::Bool) sio = blk_string_read(io, nb, v) stage = stream_int(sio, 2) skip_string!(sio) symm_code = Char(fastread(sio)) uic = stream_int(sio, 3) uoc = stream_int(sio, 3) NF = stream_int(sio, 4) F = Array{Float64,1}(undef, NF) @inbounds for i = 1:NF fast_readbytes!(sio, BUF.hdr_old, 14) F[i] = buf_to_double(BUF.hdr_old, 14) end close(sio) if v > 1 println(", STAGE #", stage, " , SYMM = ", Char(symm_code)) if v > 2 println(" "^16, "units in code #", uic) println(" "^16, "units out code #", uoc) println(" "^16, "NF = ", NF) @inbounds for i = 1:NF println(" "^16, F[i]) end end end (length(R.fs) < stage) && append!(R, MultiStageResp(6)) @inbounds R.stage[stage] = CoeffResp(F, Float64[]) if units @inbounds R.i[stage] = fix_units(units_lookup[uic]) @inbounds R.o[stage] = fix_units(units_lookup[uoc]) end return stage end
[ 2, 38093, 2559, 855, 198, 2, 38570, 38340, 49833, 9878, 11290, 2767, 51, 1546, 198, 8818, 698, 74, 62, 20943, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 410, 1875, 352, 11405, 44872, 7203, 4943, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 28555, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7203, 4943, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 299, 38031, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 300, 15636, 7203, 2257, 32, 1600, 642, 828, 366, 930, 7946, 48, 4943, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 23031, 91, 26866, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 77, 38031, 198, 220, 220, 220, 220, 220, 220, 220, 336, 64, 796, 10903, 7, 7217, 961, 7, 82, 952, 11, 642, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 33756, 796, 4269, 62, 600, 7, 82, 952, 11, 718, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 336, 64, 11, 366, 930, 33172, 33756, 8, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 30206, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 399, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 220, 220, 44872, 7, 1600, 399, 62, 4303, 15037, 796, 33172, 399, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 2147, 198, 437, 628, 198, 2, 38093, 2559, 855, 198, 2, 9564, 40438, 12861, 6234, 49833, 39837, 4877, 198, 198, 2, 685, 1270, 60, 318, 503, 286, 8354, 329, 1001, 271, 9399, 198, 8818, 698, 74, 62, 39101, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 1715, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 2438, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 220, 220, 1145, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 220, 220, 44872, 7, 1600, 42714, 33172, 2438, 11, 33172, 22196, 34, 33172, 1715, 11, 33172, 42129, 33172, 1145, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 25524, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 8575, 198, 220, 220, 220, 220, 220, 220, 220, 1715, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1507, 11, 1715, 8, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 43637, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 479, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 1398, 796, 3049, 961, 7, 82, 952, 8, 198, 220, 1715, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 4991, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 220, 220, 44872, 7, 1600, 42714, 33172, 479, 11, 33172, 42715, 33172, 3178, 7, 4871, 828, 33172, 22196, 34, 33172, 1715, 11, 33172, 4725, 29722, 33172, 4991, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 3651, 58, 74, 60, 796, 6330, 7, 20147, 11, 366, 553, 5218, 27444, 4943, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 49959, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 2438, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 220, 220, 2240, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 3128, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 1438, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 44872, 7, 1600, 42714, 33172, 2438, 11, 33172, 4526, 24302, 18310, 33172, 2240, 11, 33172, 360, 6158, 33172, 3128, 11, 33172, 24676, 9148, 1797, 16879, 33172, 1438, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 44427, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 2438, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 1715, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 410, 1875, 352, 11405, 44872, 7, 1600, 42714, 33172, 2438, 11, 33172, 22196, 34, 33172, 1715, 8, 628, 220, 28873, 85, 58, 8189, 60, 796, 1715, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 49841, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 2438, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 1438, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 1715, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 44872, 7, 1600, 42714, 33172, 2438, 11, 33172, 36751, 33172, 1438, 11, 33172, 22196, 34, 33172, 1715, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 4991, 62, 5460, 929, 58, 8189, 60, 796, 4259, 62, 41667, 7, 3672, 8, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 50049, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 1217, 62, 5460, 929, 62, 2539, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 23606, 62, 8189, 796, 3049, 961, 7, 82, 952, 8, 198, 220, 334, 291, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 334, 420, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 628, 220, 1303, 28, 41288, 460, 307, 3190, 2642, 994, 13, 4930, 2428, 25, 198, 220, 357, 16, 8, 383, 7946, 1961, 10107, 12703, 5644, 3597, 691, 636, 286, 366, 1837, 3020, 19482, 1, 23703, 198, 220, 16628, 284, 2393, 26, 287, 543, 1339, 41288, 318, 407, 262, 4129, 286, 262, 15879, 356, 761, 13, 796, 2, 198, 220, 41288, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 611, 23606, 62, 8189, 6624, 657, 87, 3682, 198, 220, 220, 220, 41288, 796, 2659, 7, 21870, 11, 362, 47762, 16, 198, 220, 2073, 361, 23606, 62, 8189, 6624, 657, 87, 3559, 198, 220, 220, 220, 41288, 796, 2659, 7, 21870, 11, 362, 8, 198, 220, 886, 628, 220, 1303, 28, 357, 17, 8, 11694, 287, 262, 7946, 1961, 10107, 11, 340, 338, 4367, 326, 262, 5415, 2546, 286, 198, 220, 257, 1729, 12, 7890, 2512, 5857, 4129, 318, 860, 17032, 34534, 11, 290, 2099, 685, 3901, 60, 460, 7074, 340, 13, 198, 220, 554, 428, 1339, 11, 262, 6291, 3696, 1560, 502, 326, 41288, 318, 2636, 2642, 26, 46513, 318, 198, 220, 284, 1100, 355, 867, 23703, 3815, 355, 1744, 290, 4259, 351, 24443, 0, 286, 1306, 19638, 13, 628, 220, 775, 1053, 1541, 973, 767, 34534, 319, 2512, 5857, 2099, 1222, 2546, 26, 1334, 389, 287, 264, 952, 13, 198, 220, 796, 2, 198, 220, 279, 796, 3049, 1930, 7, 82, 952, 8, 198, 220, 41288, 62, 7942, 796, 949, 7, 21870, 11, 2659, 7, 2079, 5892, 12, 79, 11, 1478, 4008, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 35374, 33172, 1217, 62, 5460, 929, 62, 2539, 11, 33172, 19704, 12038, 33172, 3178, 7, 1837, 3020, 62, 8189, 4008, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 287, 796, 33172, 4991, 62, 5460, 929, 58, 84, 291, 12962, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 503, 796, 33172, 4991, 62, 5460, 929, 58, 84, 420, 12962, 198, 220, 220, 220, 886, 198, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 79, 796, 33172, 279, 11, 33172, 41288, 796, 33172, 41288, 11, 33172, 41288, 62, 7942, 796, 33172, 41288, 62, 7942, 8, 198, 220, 886, 198, 220, 1303, 28, 770, 3568, 284, 4259, 340, 475, 2482, 287, 617, 845, 5629, 4069, 13, 796, 2, 628, 220, 376, 796, 15690, 90, 43879, 2414, 11, 352, 92, 7, 917, 891, 11, 41288, 62, 7942, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 21870, 62, 7942, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1478, 8, 198, 220, 220, 220, 900, 9630, 0, 7, 37, 11, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1478, 828, 1312, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 685, 35235, 7203, 37, 58, 1600, 1312, 11, 366, 60, 796, 33172, 376, 58, 72, 12962, 329, 1312, 796, 352, 25, 21870, 62, 7942, 60, 198, 220, 886, 628, 220, 1303, 10854, 284, 581, 862, 628, 220, 611, 468, 2539, 7, 16733, 274, 11, 1217, 62, 5460, 929, 62, 2539, 8, 198, 220, 220, 220, 371, 796, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 7131, 16, 60, 198, 220, 220, 220, 24443, 0, 7, 49, 13, 65, 11, 376, 8, 198, 220, 2073, 198, 220, 220, 220, 1217, 796, 1766, 14822, 19309, 7, 37, 11, 48436, 2414, 58, 12962, 198, 220, 220, 220, 334, 72, 796, 4991, 5633, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 291, 12962, 1058, 13538, 198, 220, 220, 220, 334, 78, 796, 4991, 5633, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 420, 12962, 1058, 13538, 198, 220, 220, 220, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 60, 796, 357, 4363, 11, 334, 72, 11, 334, 78, 8, 198, 220, 886, 198, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 48768, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 1217, 62, 5460, 929, 62, 2539, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 3049, 48267, 7, 82, 952, 11, 352, 8, 198, 220, 334, 291, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 334, 420, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 317, 15, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 376, 15, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 26905, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 1168, 796, 15690, 90, 5377, 11141, 37, 2414, 11, 352, 92, 7, 917, 891, 11, 26905, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 37371, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 374, 81, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 21065, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 1168, 58, 72, 60, 796, 3716, 7, 21062, 11, 21065, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1987, 8, 198, 220, 886, 198, 220, 28498, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 350, 796, 15690, 90, 5377, 11141, 37, 2414, 11, 16, 92, 7, 917, 891, 11, 28498, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 22182, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 374, 81, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 21065, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 350, 58, 72, 60, 796, 3716, 7, 21062, 11, 21065, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1987, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7203, 32, 15, 796, 33172, 4731, 7, 32, 15, 828, 366, 37, 15, 796, 33172, 4731, 7, 37, 15, 4008, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 37371, 796, 33172, 26905, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 37371, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 1168, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 22182, 796, 33172, 28498, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 22182, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 350, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 1303, 10854, 284, 581, 862, 198, 220, 371, 796, 350, 57, 19309, 2414, 7, 64, 15, 796, 317, 15, 11, 277, 15, 796, 376, 15, 11, 1976, 796, 1168, 11, 279, 796, 350, 8, 198, 220, 334, 72, 796, 4991, 5633, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 291, 12962, 1058, 13538, 198, 220, 334, 78, 796, 4991, 5633, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 420, 12962, 1058, 13538, 198, 220, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 60, 796, 357, 49, 11, 334, 72, 11, 334, 78, 8, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 43977, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 1217, 62, 5460, 929, 62, 2539, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 3049, 48267, 7, 82, 952, 11, 352, 8, 198, 220, 334, 291, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 334, 420, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 399, 45, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 399, 796, 15690, 90, 43879, 2414, 11, 16, 92, 7, 917, 891, 11, 399, 45, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 6144, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 399, 58, 72, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1105, 8, 198, 220, 886, 198, 220, 25524, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 360, 796, 15690, 90, 43879, 2414, 11, 16, 92, 7, 917, 891, 11, 25524, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 8575, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 360, 58, 72, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1105, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 35374, 33172, 1217, 62, 5460, 929, 62, 2539, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 287, 2438, 796, 33172, 334, 291, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 503, 2438, 796, 33172, 334, 420, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 6144, 796, 33172, 399, 45, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 6144, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 399, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 8575, 796, 33172, 25524, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 1084, 7, 8575, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 360, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 611, 4991, 198, 220, 220, 220, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 60, 796, 357, 34, 2577, 487, 19309, 7, 45, 11, 360, 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, 220, 220, 220, 220, 220, 220, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 291, 46570, 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, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 420, 12962, 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, 1267, 198, 220, 2073, 198, 220, 220, 220, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 60, 796, 357, 34, 2577, 487, 19309, 7, 45, 11, 360, 828, 366, 1600, 366, 4943, 198, 220, 886, 198, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 48000, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 1217, 62, 5460, 929, 62, 2539, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 43458, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 1777, 796, 4269, 62, 600, 7, 82, 952, 11, 642, 8, 198, 220, 28686, 796, 4269, 62, 600, 7, 82, 952, 11, 642, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 5711, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 1162, 81, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 35374, 33172, 1217, 62, 5460, 929, 62, 2539, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 9501, 796, 33172, 43458, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 12501, 18991, 5766, 796, 33172, 1777, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 12501, 18991, 11677, 796, 33172, 28686, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 40850, 796, 33172, 5711, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 40850, 17137, 5625, 796, 33172, 1162, 81, 8, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 60, 796, 1086, 74, 2857, 7, 9501, 11, 5711, 11, 1162, 81, 11, 1777, 11, 28686, 8, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 47202, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 1217, 62, 5460, 929, 62, 2539, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 4461, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 277, 70, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 299, 85, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 1303, 6518, 25985, 389, 407, 287, 262, 8354, 286, 1001, 271, 9399, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 48005, 198, 220, 220, 220, 1303, 3049, 48267, 7, 82, 952, 11, 1987, 8, 198, 220, 220, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 1303, 815, 3002, 262, 1987, 12, 40778, 6518, 2106, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 35374, 33172, 1217, 62, 5460, 929, 62, 2539, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 48544, 796, 33172, 4461, 11, 366, 357, 69, 796, 33172, 277, 70, 11, 366, 26109, 8, 4943, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 9109, 58, 4363, 62, 5460, 929, 62, 2539, 60, 796, 1086, 74, 2780, 7, 48544, 11, 277, 70, 8, 628, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 28669, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 1303, 9327, 198, 220, 6070, 0, 7, 19499, 37, 13, 71, 7109, 11, 657, 87, 405, 8, 198, 220, 279, 796, 17562, 7, 19499, 37, 13, 71, 7109, 8, 198, 220, 3049, 62, 13271, 8635, 62, 961, 7, 82, 952, 11, 279, 11, 642, 8, 628, 220, 1303, 28, 314, 787, 262, 13196, 994, 326, 6518, 22715, 389, 198, 220, 9380, 900, 287, 2512, 5857, 6740, 26, 611, 428, 318, 407, 2081, 11, 788, 198, 220, 1058, 17946, 481, 407, 307, 900, 13, 628, 220, 770, 29401, 1838, 1104, 329, 3294, 87, 278, 5340, 11, 996, 198, 220, 2512, 5857, 12, 1120, 3294, 87, 278, 468, 1239, 587, 12956, 287, 616, 198, 220, 1332, 3696, 357, 273, 287, 597, 3696, 286, 262, 11086, 20519, 1332, 18389, 2014, 628, 220, 20401, 87, 278, 561, 307, 15774, 355, 530, 561, 761, 284, 8160, 198, 220, 649, 1001, 271, 6601, 5563, 311, 62, 7266, 3262, 286, 4129, 796, 299, 62, 7266, 354, 504, 290, 779, 198, 220, 24443, 0, 7, 50, 11, 311, 62, 7266, 3262, 828, 2138, 621, 4574, 0, 7, 50, 11, 327, 1776, 6376, 278, 561, 198, 220, 307, 257, 2085, 13, 887, 340, 338, 466, 540, 287, 4583, 13, 198, 220, 796, 2, 198, 220, 3049, 48267, 7, 82, 952, 11, 4747, 8, 198, 220, 2524, 62, 3672, 796, 10283, 7, 8841, 62, 3245, 7, 82, 952, 4008, 198, 220, 3049, 48267, 7, 82, 952, 11, 860, 8, 198, 220, 40379, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 573, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 334, 66, 796, 3049, 961, 7, 82, 952, 8, 628, 220, 1303, 7311, 198, 220, 279, 796, 17562, 7, 19499, 37, 13, 71, 7109, 11, 1367, 8, 198, 220, 3049, 62, 13271, 8635, 62, 961, 7, 82, 952, 11, 279, 11, 362, 8, 628, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 220, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 4522, 796, 33172, 10903, 7, 30073, 7, 19499, 37, 13, 312, 22305, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 15654, 1438, 796, 33172, 2524, 62, 3672, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 9688, 3128, 796, 33172, 40379, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 437, 3128, 796, 33172, 573, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 19119, 2438, 796, 33172, 3178, 7, 1229, 4008, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 1441, 2524, 62, 3672, 198, 437, 198, 198, 2, 38093, 2559, 855, 198, 2, 3563, 6234, 49833, 9878, 11290, 2767, 51, 1546, 198, 198, 2, 407, 3306, 198, 8818, 698, 74, 62, 2713, 16, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 220, 44872, 7203, 4943, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 40379, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 220, 220, 573, 796, 4731, 62, 3245, 7, 82, 952, 8, 198, 220, 220, 220, 220, 220, 479, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 220, 220, 220, 220, 2912, 62, 5715, 796, 4269, 62, 600, 7, 82, 952, 11, 718, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 912, 796, 33172, 40379, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 660, 796, 33172, 573, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 23893, 2438, 1994, 1303, 1600, 479, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 23893, 1241, 796, 33172, 2912, 62, 5715, 8, 198, 220, 220, 220, 886, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 2147, 198, 437, 198, 198, 8818, 698, 74, 62, 37841, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 327, 3712, 4653, 271, 29239, 11, 40379, 62, 42180, 3712, 5317, 2414, 11, 573, 62, 42180, 3712, 5317, 2414, 11, 410, 3712, 46541, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 1303, 1179, 198, 220, 279, 796, 17562, 7, 19499, 37, 13, 71, 7109, 11, 718, 8, 198, 220, 3049, 62, 13271, 8635, 62, 961, 7, 82, 952, 11, 279, 11, 362, 8, 628, 220, 1303, 17792, 198, 220, 279, 796, 17562, 7, 19499, 37, 13, 71, 7109, 11, 807, 8, 198, 220, 3049, 62, 13271, 8635, 62, 961, 7, 82, 952, 11, 279, 11, 513, 8, 198, 220, 3049, 48267, 7, 82, 952, 11, 604, 8, 198, 220, 916, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 4991, 62, 8189, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 3049, 48267, 7, 82, 952, 11, 513, 8, 628, 220, 1303, 3042, 11, 300, 261, 11, 1288, 11, 1207, 11, 35560, 11, 753, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 3042, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 300, 261, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 767, 8, 198, 220, 1288, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 767, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 642, 8, 198, 220, 1207, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 642, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 642, 8, 198, 220, 35560, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 642, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 642, 8, 198, 220, 753, 796, 4101, 13, 15, 532, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 642, 8, 198, 220, 3049, 48267, 7, 82, 952, 11, 718, 8, 628, 220, 1303, 43458, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 43458, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 628, 220, 1303, 836, 470, 1107, 761, 3509, 13, 24260, 26, 14267, 62, 8841, 8318, 340, 625, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 628, 220, 1303, 40379, 11, 573, 198, 220, 40379, 796, 21136, 62, 4363, 62, 4475, 7, 82, 952, 11, 20571, 37, 13, 28611, 1433, 62, 29325, 8, 198, 220, 573, 796, 21136, 62, 4363, 62, 4475, 7, 82, 952, 11, 20571, 37, 13, 28611, 1433, 62, 29325, 8, 198, 220, 611, 573, 6624, 532, 3980, 1120, 2920, 46556, 8269, 198, 220, 220, 220, 573, 796, 2757, 28362, 2079, 19104, 10535, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 4522, 796, 33172, 10903, 7, 30073, 7, 19499, 37, 13, 71, 7109, 36911, 33172, 40589, 796, 33172, 916, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 15460, 796, 33172, 3042, 11, 33172, 300, 261, 796, 33172, 300, 261, 11, 33172, 1976, 796, 33172, 1288, 11, 33172, 1207, 796, 33172, 1207, 11, 33172, 7377, 116, 796, 33172, 35560, 11, 33172, 18074, 243, 796, 33172, 753, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 9501, 796, 33172, 43458, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 912, 796, 33172, 334, 17, 67, 7, 7146, 7, 912, 11, 264, 34703, 22305, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 660, 796, 33172, 334, 17, 67, 7, 7146, 7, 660, 11, 264, 34703, 22305, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 611, 40379, 41305, 573, 62, 42180, 11405, 573, 26870, 40379, 62, 42180, 198, 220, 220, 220, 4296, 62, 71, 7109, 0, 7, 19499, 37, 8, 198, 220, 220, 220, 327, 13, 312, 796, 651, 3245, 7, 19499, 37, 11, 1058, 312, 62, 2536, 8, 198, 220, 220, 220, 327, 13, 9501, 796, 43458, 198, 220, 220, 220, 327, 13, 17946, 796, 32960, 33711, 7, 15460, 796, 3042, 11, 300, 261, 796, 300, 261, 11, 1288, 796, 1288, 11, 1207, 796, 1207, 11, 35560, 796, 35560, 11, 753, 796, 753, 8, 198, 220, 220, 220, 327, 13, 4363, 796, 15237, 29391, 19309, 7, 1065, 8, 198, 220, 220, 220, 327, 13, 44374, 14692, 912, 8973, 796, 40379, 198, 220, 220, 220, 327, 13, 44374, 14692, 660, 8973, 796, 573, 198, 220, 220, 220, 327, 13, 44374, 14692, 22355, 6839, 8973, 796, 4731, 7, 84, 17, 67, 7, 7146, 7, 912, 11, 1802, 2388, 22305, 1635, 366, 1058, 366, 1635, 220, 4731, 7, 84, 17, 67, 7, 7146, 7, 660, 11, 1802, 2388, 22305, 198, 220, 220, 220, 327, 13, 44374, 14692, 8625, 8973, 796, 651, 7, 397, 4679, 85, 11, 916, 11, 366, 4943, 198, 220, 220, 220, 4991, 796, 651, 7, 41667, 62, 5460, 929, 11, 4991, 62, 8189, 11, 366, 4943, 198, 220, 220, 220, 327, 13, 41667, 796, 4259, 62, 41667, 7, 41667, 8, 198, 220, 220, 220, 31017, 796, 3991, 198, 220, 2073, 198, 220, 220, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 50, 4106, 2105, 33172, 10903, 7, 30073, 7, 19499, 37, 13, 71, 7109, 36911, 366, 357, 1662, 287, 9167, 640, 2837, 8, 4943, 198, 220, 220, 220, 886, 198, 220, 220, 220, 31017, 796, 2081, 198, 220, 886, 198, 220, 1441, 31017, 198, 437, 198, 198, 8818, 698, 74, 62, 2713, 18, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 371, 3712, 29800, 29391, 19309, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 256, 701, 796, 3178, 7, 7217, 961, 7, 82, 952, 4008, 198, 220, 3800, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 334, 291, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 334, 420, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 317, 15, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 376, 15, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 26905, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 1168, 796, 15690, 90, 5377, 11141, 37, 2414, 11, 16, 92, 7, 917, 891, 11, 26905, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 37371, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 374, 81, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 21065, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 1168, 58, 72, 60, 796, 3716, 7, 21062, 11, 21065, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1987, 8, 198, 220, 886, 198, 220, 28498, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 350, 796, 15690, 90, 5377, 11141, 37, 2414, 11, 16, 92, 7, 917, 891, 11, 28498, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 22182, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 374, 81, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 21065, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 350, 58, 72, 60, 796, 3716, 7, 21062, 11, 21065, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1987, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 309, 9792, 33172, 256, 701, 11, 33172, 3563, 11879, 33172, 3800, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 287, 2438, 1303, 1600, 334, 291, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 503, 2438, 1303, 1600, 334, 420, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 32, 15, 796, 33172, 317, 15, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 37, 15, 796, 33172, 376, 15, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 37371, 796, 33172, 26905, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 37371, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 1168, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 22182, 796, 33172, 28498, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 22182, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 350, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 611, 3800, 1875, 4129, 7, 49, 13, 9501, 8, 198, 220, 220, 220, 24443, 0, 7, 49, 11, 15237, 29391, 19309, 7, 21, 4008, 198, 220, 886, 198, 220, 1217, 796, 350, 57, 19309, 2414, 7, 64, 15, 796, 317, 15, 11, 277, 15, 796, 376, 15, 11, 1976, 796, 1168, 11, 279, 796, 350, 8, 198, 220, 334, 72, 796, 4991, 5633, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 291, 12962, 1058, 13538, 198, 220, 334, 78, 796, 4991, 5633, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 420, 12962, 1058, 13538, 198, 220, 371, 13, 14247, 58, 14247, 60, 796, 1217, 198, 220, 371, 13, 72, 58, 14247, 60, 796, 334, 72, 198, 220, 371, 13, 78, 58, 14247, 60, 796, 334, 78, 198, 220, 1441, 3800, 198, 437, 198, 198, 8818, 698, 74, 62, 2713, 19, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 371, 3712, 29800, 29391, 19309, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 3049, 48267, 7, 82, 952, 11, 352, 8, 198, 220, 3800, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 334, 291, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 334, 420, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 399, 45, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 399, 796, 15690, 90, 43879, 2414, 11, 16, 92, 7, 917, 891, 11, 399, 45, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 6144, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 399, 58, 72, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1105, 8, 198, 220, 886, 198, 220, 25524, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 360, 796, 15690, 90, 43879, 2414, 11, 16, 92, 7, 917, 891, 11, 25524, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 8575, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 360, 58, 72, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 48267, 7, 82, 952, 11, 1105, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 3563, 11879, 33172, 3800, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 287, 2438, 796, 33172, 334, 291, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 503, 2438, 796, 33172, 334, 420, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 6144, 796, 33172, 399, 45, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 6144, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 399, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 8575, 796, 33172, 25524, 11, 366, 25, 4943, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 8575, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 360, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 611, 3800, 1875, 4129, 7, 49, 13, 9501, 8, 198, 220, 220, 220, 24443, 0, 7, 49, 11, 15237, 29391, 19309, 7, 21, 4008, 198, 220, 886, 198, 220, 371, 13, 14247, 58, 14247, 60, 796, 1766, 14822, 19309, 7, 45, 11, 360, 8, 198, 220, 611, 4991, 198, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 72, 58, 14247, 60, 796, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 291, 12962, 198, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 78, 58, 14247, 60, 796, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 420, 12962, 198, 220, 886, 198, 220, 1441, 3800, 198, 437, 198, 198, 8818, 698, 74, 62, 43526, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 371, 3712, 29800, 29391, 19309, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 3800, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 43458, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 838, 8, 198, 220, 1777, 796, 4269, 62, 600, 7, 82, 952, 11, 642, 8, 198, 220, 28686, 796, 4269, 62, 600, 7, 82, 952, 11, 642, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 5711, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 1162, 81, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1367, 8, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 3563, 11879, 1303, 1600, 3800, 8, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 9501, 796, 33172, 43458, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 12501, 18991, 5766, 796, 33172, 1777, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 12501, 18991, 11677, 796, 33172, 28686, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 40850, 796, 33172, 5711, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 40850, 17137, 5625, 796, 33172, 1162, 81, 8, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 2488, 259, 65, 3733, 371, 13, 9501, 58, 14247, 60, 796, 43458, 198, 220, 2488, 259, 65, 3733, 371, 13, 40850, 58, 14247, 60, 796, 5711, 198, 220, 2488, 259, 65, 3733, 371, 13, 10215, 81, 58, 14247, 60, 796, 1162, 81, 198, 220, 2488, 259, 65, 3733, 371, 13, 38942, 58, 14247, 60, 796, 1777, 198, 220, 2488, 259, 65, 3733, 371, 13, 418, 58, 14247, 60, 796, 28686, 198, 220, 1441, 3800, 198, 437, 198, 198, 8818, 698, 74, 62, 2713, 23, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 327, 3712, 4653, 271, 29239, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 3800, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 611, 3800, 6624, 657, 198, 220, 220, 220, 327, 13, 48544, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 1969, 7, 82, 952, 8, 198, 220, 220, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 220, 220, 44872, 7, 1600, 3563, 11879, 1303, 1600, 3800, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 3800, 198, 220, 2073, 198, 220, 220, 220, 327, 13, 4363, 13, 48544, 58, 14247, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 198, 220, 220, 220, 327, 13, 4363, 13, 40616, 58, 14247, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1105, 8, 628, 220, 220, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 220, 220, 44872, 7, 1600, 3563, 11879, 1303, 1600, 3800, 8, 198, 220, 220, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 48544, 796, 33172, 327, 13, 4363, 13, 48544, 58, 14247, 4357, 366, 357, 69, 796, 33172, 327, 13, 4363, 13, 40616, 58, 14247, 4357, 366, 26109, 8, 4943, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1303, 4429, 2106, 318, 407, 287, 262, 8354, 286, 1001, 271, 9399, 198, 220, 220, 220, 1969, 7, 82, 952, 8, 198, 220, 220, 220, 1441, 3800, 198, 220, 886, 198, 437, 198, 198, 2, 1892, 287, 8354, 286, 1001, 271, 9399, 198, 8818, 698, 74, 62, 46712, 0, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 327, 3712, 4653, 271, 29239, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 198, 220, 410, 1875, 352, 11405, 44872, 7203, 4943, 198, 220, 611, 4991, 198, 220, 220, 220, 40379, 796, 21136, 62, 4363, 62, 4475, 7, 82, 952, 11, 20571, 37, 13, 28611, 1433, 62, 29325, 8, 198, 220, 220, 220, 573, 796, 21136, 62, 4363, 62, 4475, 7, 82, 952, 11, 20571, 37, 13, 28611, 1433, 62, 29325, 8, 198, 220, 220, 220, 611, 573, 6624, 532, 3980, 1120, 2920, 46556, 8269, 198, 220, 220, 220, 220, 220, 573, 796, 2757, 28362, 2079, 19104, 10535, 198, 220, 220, 220, 886, 198, 220, 220, 220, 479, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 220, 220, 256, 62, 2536, 796, 4731, 7203, 23893, 553, 11, 40379, 11, 366, 553, 11, 573, 11, 366, 553, 11, 3651, 58, 74, 12962, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7, 84, 17, 67, 7, 7146, 7, 912, 11, 1802, 2388, 36911, 366, 1906, 1600, 334, 17, 67, 7, 7146, 7, 660, 11, 1802, 2388, 36911, 366, 25, 33172, 3651, 58, 74, 12962, 198, 220, 220, 220, 886, 198, 220, 220, 220, 3465, 0, 7, 34, 11, 256, 62, 2536, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 2147, 198, 437, 198, 198, 2, 2195, 570, 22155, 4847, 351, 2882, 7508, 287, 262, 6073, 12, 2920, 2512, 23014, 198, 8818, 698, 74, 62, 41322, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 371, 3712, 29800, 29391, 19309, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 299, 301, 70, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 1303, 3563, 25552, 796, 33172, 299, 301, 70, 8, 198, 220, 886, 628, 220, 329, 1312, 796, 352, 25, 77, 301, 70, 198, 220, 220, 220, 33756, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 220, 220, 299, 81, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 220, 220, 329, 474, 796, 352, 25, 48624, 198, 220, 220, 220, 220, 220, 479, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 220, 220, 220, 220, 374, 81, 796, 651, 7, 16733, 274, 11, 479, 11, 366, 4943, 198, 220, 220, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 220, 220, 3601, 34365, 992, 7203, 366, 61, 1433, 11, 366, 38875, 2882, 284, 3800, 1303, 1600, 33756, 11, 366, 7479, 77, 1600, 3124, 28, 25, 14809, 11, 10758, 28, 7942, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 21062, 8, 198, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 611, 318, 64, 7, 21062, 11, 1086, 74, 2780, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 48544, 58, 41068, 60, 796, 374, 81, 13, 48544, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 40616, 58, 41068, 60, 796, 374, 81, 13, 40616, 198, 220, 220, 220, 220, 220, 2073, 361, 318, 64, 7, 21062, 11, 1086, 74, 2857, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 9501, 58, 41068, 60, 796, 374, 81, 13, 9501, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 40850, 58, 41068, 60, 796, 374, 81, 13, 40850, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 10215, 81, 58, 41068, 60, 796, 374, 81, 13, 10215, 81, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 38942, 58, 41068, 60, 796, 374, 81, 13, 38942, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 418, 58, 41068, 60, 796, 374, 81, 13, 418, 198, 220, 220, 220, 220, 220, 2073, 361, 2099, 1659, 7, 21062, 58, 16, 12962, 1279, 25, 42410, 31077, 198, 220, 220, 220, 220, 220, 220, 220, 357, 13664, 7, 49, 13, 9501, 8, 1279, 33756, 8, 11405, 24443, 0, 7, 49, 11, 15237, 29391, 19309, 7, 21, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 14247, 58, 41068, 60, 796, 374, 81, 58, 16, 60, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 72, 58, 41068, 60, 796, 374, 81, 58, 17, 60, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 78, 58, 41068, 60, 796, 374, 81, 58, 18, 60, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 198, 220, 1441, 299, 301, 70, 198, 437, 198, 198, 8818, 698, 74, 62, 3312, 16, 7, 952, 3712, 9399, 11, 299, 65, 3712, 5317, 2414, 11, 410, 3712, 46541, 11, 371, 3712, 29800, 29391, 19309, 11, 4991, 3712, 33, 970, 8, 198, 220, 264, 952, 796, 698, 74, 62, 8841, 62, 961, 7, 952, 11, 299, 65, 11, 410, 8, 628, 220, 3800, 796, 4269, 62, 600, 7, 82, 952, 11, 362, 8, 198, 220, 14267, 62, 8841, 0, 7, 82, 952, 8, 198, 220, 23606, 62, 8189, 796, 3178, 7, 7217, 961, 7, 82, 952, 4008, 198, 220, 334, 291, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 334, 420, 796, 4269, 62, 600, 7, 82, 952, 11, 513, 8, 198, 220, 41288, 796, 4269, 62, 600, 7, 82, 952, 11, 604, 8, 198, 220, 376, 796, 15690, 90, 43879, 2414, 11, 16, 92, 7, 917, 891, 11, 41288, 8, 198, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 21870, 198, 220, 220, 220, 3049, 62, 961, 33661, 0, 7, 82, 952, 11, 20571, 37, 13, 71, 7109, 62, 727, 11, 1478, 8, 198, 220, 220, 220, 376, 58, 72, 60, 796, 42684, 62, 1462, 62, 23352, 7, 19499, 37, 13, 71, 7109, 62, 727, 11, 1478, 8, 198, 220, 886, 198, 220, 1969, 7, 82, 952, 8, 628, 220, 611, 410, 1875, 352, 198, 220, 220, 220, 44872, 7, 1600, 3563, 11879, 1303, 1600, 3800, 11, 366, 837, 19704, 12038, 796, 33172, 3178, 7, 1837, 3020, 62, 8189, 4008, 198, 220, 220, 220, 611, 410, 1875, 362, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 287, 2438, 1303, 1600, 334, 291, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 41667, 503, 2438, 1303, 1600, 334, 420, 8, 198, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 366, 21870, 796, 33172, 41288, 8, 198, 220, 220, 220, 220, 220, 2488, 259, 65, 3733, 329, 1312, 796, 352, 25, 21870, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 366, 61, 1433, 11, 376, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 357, 13664, 7, 49, 13, 9501, 8, 1279, 3800, 8, 11405, 24443, 0, 7, 49, 11, 15237, 29391, 19309, 7, 21, 4008, 198, 220, 2488, 259, 65, 3733, 371, 13, 14247, 58, 14247, 60, 796, 1766, 14822, 19309, 7, 37, 11, 48436, 2414, 58, 12962, 198, 220, 611, 4991, 198, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 72, 58, 14247, 60, 796, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 291, 12962, 198, 220, 220, 220, 2488, 259, 65, 3733, 371, 13, 78, 58, 14247, 60, 796, 4259, 62, 41667, 7, 41667, 62, 5460, 929, 58, 84, 420, 12962, 198, 220, 886, 198, 220, 1441, 3800, 198, 437, 198 ]
2.118763
9,801
using MeshSignedDistance using Test @testset "MeshSignedDistance.jl" begin # Write your tests here. end
[ 3500, 47529, 50, 3916, 45767, 198, 3500, 6208, 198, 198, 31, 9288, 2617, 366, 37031, 50, 3916, 45767, 13, 20362, 1, 2221, 198, 220, 220, 220, 1303, 19430, 534, 5254, 994, 13, 198, 437, 198 ]
3.114286
35
""" Quadrature information Most spectral-element operations require calculation of integrals and derivatives. The `QuadType` structure stores the required information when calculating integrals and derivatives """ type QuadType{T<:Number} Q::Int z::Vector{T} w::Vector{T} D::Matrix{T} end """ Constructs quadrature rules for Gauss-type quadrature. """ function QuadType{T<:Number,QT<:QUADRATURE_TYPE}(q::Int, ::Type{QT}=GLJ, ::Type{T}=Float64, a=0, b=0) z = Jacobi.qzeros(QT, q, a, b, T) w = Jacobi.qweights(QT, z, a, b) D = Jacobi.qdiff(QT, z, a, b) QuadType(q, z, w, D) end """ Creates the ith Lagrange polynomial from a vector of nodes Explicit construction of Lagrange polynomials from the nodes. This function builds a `Poly` object. * `i` Index specifying which Lagrange polynomial should be returned. * `z` Vector containing the nodes of the Lagrange polynomials. """ function lagrange_poly{T<:Number}(i::Integer, z::AbstractVector{T}) np = length(z) y = zeros(T, np-1) for j = 1:(i-1) y[j] = z[j] end for j = (i+1):np y[j-1] = z[j] end den = one(T) for j = 1:(np-1) den = den * (z[i] - y[j]) end p = poly(y) return p/den end """ Build Lagrange basis from any nodes Probably not the fastest algorithm. But this won't be seriously used. """ function QuadType{T<:Number}(x::AbstractVector{T}) # Generic numbers: np = length(x) z = zeros(T,np) for i = 1:np z[i] = x[i] end w = zeros(T, np) D = zeros(T, np, np) for i = 1:np p = lagrange_poly(i, z) pint = polyint(p) pder = polyder(p) w[i] = polyval(pint, one(T)) - polyval(pint, -one(T)) # Compute the rows of the derivative matrix for k = 1:np D[k,i] = polyval(pder, z[k]) end end QuadType(np, z, w, D) end
[ 198, 37811, 198, 4507, 41909, 1300, 1321, 198, 198, 6943, 37410, 12, 30854, 4560, 2421, 17952, 286, 4132, 30691, 290, 28486, 13, 198, 464, 4600, 4507, 324, 6030, 63, 4645, 7000, 262, 2672, 1321, 618, 26019, 4132, 30691, 198, 392, 28486, 198, 37811, 198, 4906, 20648, 6030, 90, 51, 27, 25, 15057, 92, 198, 220, 220, 220, 1195, 3712, 5317, 198, 220, 220, 220, 1976, 3712, 38469, 90, 51, 92, 198, 220, 220, 220, 266, 3712, 38469, 90, 51, 92, 198, 220, 220, 220, 360, 3712, 46912, 90, 51, 92, 198, 437, 198, 198, 37811, 198, 42316, 82, 15094, 81, 1300, 3173, 329, 12822, 1046, 12, 4906, 15094, 81, 1300, 13, 198, 37811, 198, 8818, 20648, 6030, 90, 51, 27, 25, 15057, 11, 48, 51, 27, 25, 10917, 2885, 49, 40086, 62, 25216, 92, 7, 80, 3712, 5317, 11, 7904, 6030, 90, 48, 51, 92, 28, 8763, 41, 11, 7904, 6030, 90, 51, 92, 28, 43879, 2414, 11, 257, 28, 15, 11, 275, 28, 15, 8, 198, 220, 220, 220, 1976, 796, 12806, 72, 13, 80, 9107, 418, 7, 48, 51, 11, 10662, 11, 257, 11, 275, 11, 309, 8, 198, 220, 220, 220, 266, 796, 12806, 72, 13, 80, 43775, 7, 48, 51, 11, 1976, 11, 257, 11, 275, 8, 198, 220, 220, 220, 360, 796, 12806, 72, 13, 80, 26069, 7, 48, 51, 11, 1976, 11, 257, 11, 275, 8, 198, 220, 220, 220, 20648, 6030, 7, 80, 11, 1976, 11, 266, 11, 360, 8, 198, 437, 198, 198, 37811, 198, 16719, 274, 262, 340, 71, 21003, 9521, 745, 6213, 49070, 422, 257, 15879, 286, 13760, 198, 198, 18438, 3628, 5103, 286, 21003, 9521, 745, 6213, 296, 8231, 422, 262, 13760, 13, 198, 1212, 2163, 12188, 257, 4600, 34220, 63, 2134, 13, 628, 1635, 4600, 72, 63, 12901, 31577, 543, 21003, 9521, 745, 6213, 49070, 815, 307, 4504, 13, 198, 1635, 4600, 89, 63, 20650, 7268, 262, 13760, 286, 262, 21003, 9521, 745, 6213, 296, 8231, 13, 198, 37811, 198, 8818, 19470, 9521, 62, 35428, 90, 51, 27, 25, 15057, 92, 7, 72, 3712, 46541, 11, 1976, 3712, 23839, 38469, 90, 51, 30072, 198, 220, 220, 220, 45941, 796, 4129, 7, 89, 8, 628, 220, 220, 220, 331, 796, 1976, 27498, 7, 51, 11, 45941, 12, 16, 8, 628, 220, 220, 220, 329, 474, 796, 352, 37498, 72, 12, 16, 8, 198, 220, 220, 220, 220, 220, 220, 220, 331, 58, 73, 60, 796, 1976, 58, 73, 60, 198, 220, 220, 220, 886, 198, 220, 220, 220, 329, 474, 796, 357, 72, 10, 16, 2599, 37659, 198, 220, 220, 220, 220, 220, 220, 220, 331, 58, 73, 12, 16, 60, 796, 1976, 58, 73, 60, 198, 220, 220, 220, 886, 198, 220, 220, 220, 2853, 796, 530, 7, 51, 8, 198, 220, 220, 220, 329, 474, 796, 352, 37498, 37659, 12, 16, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2853, 796, 2853, 1635, 357, 89, 58, 72, 60, 532, 331, 58, 73, 12962, 198, 220, 220, 220, 886, 198, 220, 220, 220, 279, 796, 7514, 7, 88, 8, 198, 220, 220, 220, 1441, 279, 14, 6559, 198, 437, 198, 198, 37811, 198, 15580, 21003, 9521, 4308, 422, 597, 13760, 198, 198, 34784, 407, 262, 14162, 11862, 13, 887, 428, 1839, 470, 307, 6411, 973, 13, 198, 37811, 198, 8818, 20648, 6030, 90, 51, 27, 25, 15057, 92, 7, 87, 3712, 23839, 38469, 90, 51, 30072, 220, 1303, 42044, 3146, 25, 198, 220, 220, 220, 45941, 796, 4129, 7, 87, 8, 198, 220, 220, 220, 1976, 796, 1976, 27498, 7, 51, 11, 37659, 8, 198, 220, 220, 220, 329, 1312, 796, 352, 25, 37659, 198, 220, 220, 220, 220, 220, 220, 220, 1976, 58, 72, 60, 796, 2124, 58, 72, 60, 198, 220, 220, 220, 886, 628, 220, 220, 220, 266, 796, 1976, 27498, 7, 51, 11, 45941, 8, 198, 220, 220, 220, 360, 796, 1976, 27498, 7, 51, 11, 45941, 11, 45941, 8, 628, 220, 220, 220, 329, 1312, 796, 352, 25, 37659, 198, 220, 220, 220, 220, 220, 220, 220, 279, 796, 19470, 9521, 62, 35428, 7, 72, 11, 1976, 8, 198, 220, 220, 220, 220, 220, 220, 220, 35245, 796, 7514, 600, 7, 79, 8, 198, 220, 220, 220, 220, 220, 220, 220, 279, 1082, 796, 7514, 1082, 7, 79, 8, 198, 220, 220, 220, 220, 220, 220, 220, 266, 58, 72, 60, 796, 7514, 2100, 7, 79, 600, 11, 530, 7, 51, 4008, 532, 7514, 2100, 7, 79, 600, 11, 532, 505, 7, 51, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 3082, 1133, 262, 15274, 286, 262, 27255, 17593, 198, 220, 220, 220, 220, 220, 220, 220, 329, 479, 796, 352, 25, 37659, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 360, 58, 74, 11, 72, 60, 796, 7514, 2100, 7, 79, 1082, 11, 1976, 58, 74, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 20648, 6030, 7, 37659, 11, 1976, 11, 266, 11, 360, 8, 198, 437, 198 ]
2.238152
844
#!/usr/bin/env julia # Comprehension and Generators # https://teaching.healthtech.dtu.dk/22110/index.php/Comprehension_and_Generators # Ex 1 matrix1 = readdlm("data/matrix1", '\t', Int, '\n') matrix2 = readdlm("data/matrix2", '\t', Int, '\n') dot = matrix1*matrix2 matrix_product(a,b) = [sum([a[i,r]*b[r,j] for r = 1:size(a,2)]) for i = 1:size(a,1), j = 1:size(b,2)] matrix_product(matrix1,matrix2) # Ex 2 function _read_experiment(f, acc_match) status = Float64[] for line = eachline(f) line_split = split(line, "\t") acc = string(line_split[2]) if line_split[1] == "COL_CLASSES" status = [parse(Int64, x) for x in line_split[4:end]] elseif acc == acc_match nums = [parse(Float64, x) for x in line_split[4:end]] return nums[status .== 0], nums[status .== 1] end end return Float64[], Float64[] end function read_experiment(acc_search, outfilename) out = open(outfilename, "w") cancer, control = open(f->_read_experiment(f, acc_search), "data/dna-array.dat") if length(cancer) == 0 && length(control) == 0 println("Accession number not found.") close(out) return nothing end min_len = min(length(cancer), length(control)) for i = 1:min_len println(out, cancer[i], "\t", control[i]) end if length(cancer) > length(control) for i = (min_len+1):length(cancer) println(out, cancer[i]) end else for i = (min_len+1):length(control) println(out, "\t", cancer[i]) end end close(out) end println("Enter accession number:") read_experiment(chomp(readline()), "data/dna-array-subset.dat")
[ 2, 48443, 14629, 14, 8800, 14, 24330, 474, 43640, 198, 2, 3082, 7345, 295, 290, 2980, 2024, 198, 2, 3740, 1378, 660, 8103, 13, 13948, 13670, 13, 67, 28047, 13, 34388, 14, 1828, 11442, 14, 9630, 13, 10121, 14, 7293, 7345, 295, 62, 392, 62, 8645, 2024, 198, 198, 2, 1475, 352, 198, 6759, 8609, 16, 796, 1100, 25404, 76, 7203, 7890, 14, 6759, 8609, 16, 1600, 705, 59, 83, 3256, 2558, 11, 705, 59, 77, 11537, 198, 6759, 8609, 17, 796, 1100, 25404, 76, 7203, 7890, 14, 6759, 8609, 17, 1600, 705, 59, 83, 3256, 2558, 11, 705, 59, 77, 11537, 198, 198, 26518, 796, 17593, 16, 9, 6759, 8609, 17, 198, 6759, 8609, 62, 11167, 7, 64, 11, 65, 8, 796, 685, 16345, 26933, 64, 58, 72, 11, 81, 60, 9, 65, 58, 81, 11, 73, 60, 329, 374, 796, 352, 25, 7857, 7, 64, 11, 17, 8, 12962, 198, 220, 220, 220, 329, 1312, 796, 352, 25, 7857, 7, 64, 11, 16, 828, 474, 796, 352, 25, 7857, 7, 65, 11, 17, 15437, 198, 198, 6759, 8609, 62, 11167, 7, 6759, 8609, 16, 11, 6759, 8609, 17, 8, 198, 198, 2, 1475, 362, 198, 8818, 4808, 961, 62, 23100, 3681, 7, 69, 11, 697, 62, 15699, 8, 198, 220, 220, 220, 3722, 796, 48436, 2414, 21737, 198, 220, 220, 220, 329, 1627, 796, 1123, 1370, 7, 69, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1627, 62, 35312, 796, 6626, 7, 1370, 11, 37082, 83, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 697, 796, 4731, 7, 1370, 62, 35312, 58, 17, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 611, 1627, 62, 35312, 58, 16, 60, 6624, 366, 25154, 62, 31631, 1546, 1, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3722, 796, 685, 29572, 7, 5317, 2414, 11, 2124, 8, 329, 2124, 287, 1627, 62, 35312, 58, 19, 25, 437, 11907, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 697, 6624, 697, 62, 15699, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 997, 82, 796, 685, 29572, 7, 43879, 2414, 11, 2124, 8, 329, 2124, 287, 1627, 62, 35312, 58, 19, 25, 437, 11907, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 997, 82, 58, 13376, 764, 855, 657, 4357, 997, 82, 58, 13376, 764, 855, 352, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 48436, 2414, 58, 4357, 48436, 2414, 21737, 198, 437, 628, 198, 8818, 1100, 62, 23100, 3681, 7, 4134, 62, 12947, 11, 503, 34345, 8, 198, 220, 220, 220, 503, 796, 1280, 7, 448, 34345, 11, 366, 86, 4943, 198, 220, 220, 220, 4890, 11, 1630, 796, 1280, 7, 69, 3784, 62, 961, 62, 23100, 3681, 7, 69, 11, 697, 62, 12947, 828, 366, 7890, 14, 67, 2616, 12, 18747, 13, 19608, 4943, 198, 220, 220, 220, 611, 4129, 7, 48870, 8, 6624, 657, 11405, 4129, 7, 13716, 8, 6624, 657, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 15457, 295, 1271, 407, 1043, 19570, 198, 220, 220, 220, 220, 220, 220, 220, 1969, 7, 448, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2147, 198, 220, 220, 220, 886, 198, 220, 220, 220, 949, 62, 11925, 796, 949, 7, 13664, 7, 48870, 828, 4129, 7, 13716, 4008, 198, 220, 220, 220, 329, 1312, 796, 352, 25, 1084, 62, 11925, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 448, 11, 4890, 58, 72, 4357, 37082, 83, 1600, 1630, 58, 72, 12962, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 4129, 7, 48870, 8, 1875, 4129, 7, 13716, 8, 198, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 796, 357, 1084, 62, 11925, 10, 16, 2599, 13664, 7, 48870, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 448, 11, 4890, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 796, 357, 1084, 62, 11925, 10, 16, 2599, 13664, 7, 13716, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 448, 11, 37082, 83, 1600, 4890, 58, 72, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1969, 7, 448, 8, 198, 437, 628, 198, 35235, 7203, 17469, 1895, 295, 1271, 25, 4943, 198, 961, 62, 23100, 3681, 7, 354, 3361, 7, 961, 1370, 3419, 828, 366, 7890, 14, 67, 2616, 12, 18747, 12, 7266, 2617, 13, 19608, 4943, 198 ]
2.177891
787
using DICOMClient using HTTP using Test @testset "version" begin @test DICOMClient.package_version() isa VersionNumber @test DICOMClient.package_version() > v"0" end @testset "_add_trailing_slash" begin @test DICOMClient._add_trailing_slash(HTTP.URI("https://juliahealth.org")) == HTTP.URI("https://juliahealth.org/") @test DICOMClient._add_trailing_slash(HTTP.URI("https://juliahealth.org/")) == HTTP.URI("https://juliahealth.org/") end @testset "parse_multipart_image" begin @test_throws ArgumentError DICOMClient.parse_multipart_image(Val(:jpeg), UInt8[0xff, 0xd8, 0xff, 0xd9, 0xff, 0xd8]) end
[ 3500, 360, 2149, 2662, 11792, 198, 198, 3500, 14626, 198, 3500, 6208, 198, 198, 31, 9288, 2617, 366, 9641, 1, 2221, 198, 220, 220, 220, 2488, 9288, 360, 2149, 2662, 11792, 13, 26495, 62, 9641, 3419, 318, 64, 10628, 15057, 198, 220, 220, 220, 2488, 9288, 360, 2149, 2662, 11792, 13, 26495, 62, 9641, 3419, 1875, 410, 1, 15, 1, 198, 437, 198, 198, 31, 9288, 2617, 45434, 2860, 62, 9535, 4386, 62, 6649, 1077, 1, 2221, 198, 220, 220, 220, 2488, 9288, 360, 2149, 2662, 11792, 13557, 2860, 62, 9535, 4386, 62, 6649, 1077, 7, 40717, 13, 47269, 7203, 5450, 1378, 73, 43640, 13948, 13, 2398, 48774, 6624, 14626, 13, 47269, 7203, 5450, 1378, 73, 43640, 13948, 13, 2398, 14, 4943, 198, 220, 220, 220, 2488, 9288, 360, 2149, 2662, 11792, 13557, 2860, 62, 9535, 4386, 62, 6649, 1077, 7, 40717, 13, 47269, 7203, 5450, 1378, 73, 43640, 13948, 13, 2398, 30487, 4008, 6624, 14626, 13, 47269, 7203, 5450, 1378, 73, 43640, 13948, 13, 2398, 14, 4943, 198, 437, 198, 198, 31, 9288, 2617, 366, 29572, 62, 16680, 541, 433, 62, 9060, 1, 2221, 198, 220, 220, 220, 2488, 9288, 62, 400, 8516, 45751, 12331, 360, 2149, 2662, 11792, 13, 29572, 62, 16680, 541, 433, 62, 9060, 7, 7762, 7, 25, 73, 22071, 828, 471, 5317, 23, 58, 15, 47596, 11, 657, 24954, 23, 11, 657, 47596, 11, 657, 24954, 24, 11, 657, 47596, 11, 657, 24954, 23, 12962, 198, 437, 198 ]
2.555556
243
struct WangLi3SMil_AConstantCache <: StochasticDiffEqConstantCache end @cache struct WangLi3SMil_ACache{uType,rateType} <: StochasticDiffEqMutableCache u::uType uprev::uType k::rateType k₁::rateType tmp::uType end alg_cache(alg::WangLi3SMil_A,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{false}}) = WangLi3SMil_AConstantCache() function alg_cache(alg::WangLi3SMil_A,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{true}}) k = zero(rate_prototype) k₁ = zero(rate_prototype) tmp = zero(u) WangLi3SMil_ACache(u,uprev,k,k₁,tmp) end struct WangLi3SMil_BConstantCache <: StochasticDiffEqConstantCache end @cache struct WangLi3SMil_BCache{uType,rateType} <: StochasticDiffEqMutableCache u::uType uprev::uType k::rateType k₁::rateType tmp::uType end alg_cache(alg::WangLi3SMil_B,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{false}}) = WangLi3SMil_BConstantCache() function alg_cache(alg::WangLi3SMil_B,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{true}}) k = zero(rate_prototype) k₁ = zero(rate_prototype) tmp = zero(u) WangLi3SMil_BCache(u,uprev,k,k₁,tmp) end struct WangLi3SMil_CConstantCache <: StochasticDiffEqConstantCache end @cache struct WangLi3SMil_CCache{uType,rateType} <: StochasticDiffEqMutableCache u::uType uprev::uType k::rateType k₁::rateType tmp::uType end alg_cache(alg::WangLi3SMil_C,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{false}}) = WangLi3SMil_CConstantCache() function alg_cache(alg::WangLi3SMil_C,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{true}}) k = zero(rate_prototype) k₁ = zero(rate_prototype) tmp = zero(u) WangLi3SMil_CCache(u,uprev,k,k₁,tmp) end struct WangLi3SMil_DConstantCache <: StochasticDiffEqConstantCache end @cache struct WangLi3SMil_DCache{uType,rateType} <: StochasticDiffEqMutableCache u::uType uprev::uType k::rateType k₁::rateType tmp::uType end alg_cache(alg::WangLi3SMil_D,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{false}}) = WangLi3SMil_DConstantCache() function alg_cache(alg::WangLi3SMil_D,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{true}}) k = zero(rate_prototype) k₁ = zero(rate_prototype) tmp = zero(u) WangLi3SMil_DCache(u,uprev,k,k₁,tmp) end struct WangLi3SMil_EConstantCache <: StochasticDiffEqConstantCache end @cache struct WangLi3SMil_ECache{uType,rateType} <: StochasticDiffEqMutableCache u::uType uprev::uType k::rateType k₁::rateType tmp::uType end alg_cache(alg::WangLi3SMil_E,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{false}}) = WangLi3SMil_EConstantCache() function alg_cache(alg::WangLi3SMil_E,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{true}}) k = zero(rate_prototype) k₁ = zero(rate_prototype) tmp = zero(u) WangLi3SMil_ECache(u,uprev,k,k₁,tmp) end struct WangLi3SMil_FConstantCache <: StochasticDiffEqConstantCache end @cache struct WangLi3SMil_FCache{uType,rateType} <: StochasticDiffEqMutableCache u::uType uprev::uType k::rateType k₁::rateType tmp::uType end alg_cache(alg::WangLi3SMil_F,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{false}}) = WangLi3SMil_FConstantCache() function alg_cache(alg::WangLi3SMil_F,prob,u,ΔW,ΔZ,p,rate_prototype,noise_rate_prototype,jump_rate_prototype,uEltypeNoUnits,uBottomEltypeNoUnits,tTypeNoUnits,uprev,f,t,dt,::Type{Val{true}}) k = zero(rate_prototype) k₁ = zero(rate_prototype) tmp = zero(u) WangLi3SMil_FCache(u,uprev,k,k₁,tmp) end
[ 7249, 15233, 32304, 18, 12310, 346, 62, 2246, 261, 18797, 30562, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 3103, 18797, 30562, 886, 198, 31, 23870, 2878, 15233, 32304, 18, 12310, 346, 62, 2246, 4891, 90, 84, 6030, 11, 4873, 6030, 92, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 44, 18187, 30562, 198, 220, 334, 3712, 84, 6030, 198, 220, 510, 18218, 3712, 84, 6030, 198, 220, 479, 3712, 4873, 6030, 198, 220, 479, 158, 224, 223, 3712, 4873, 6030, 198, 220, 45218, 3712, 84, 6030, 198, 437, 198, 198, 14016, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 32, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 9562, 11709, 8, 796, 15233, 32304, 18, 12310, 346, 62, 2246, 261, 18797, 30562, 3419, 198, 198, 8818, 435, 70, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 32, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 7942, 11709, 8, 198, 220, 479, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 479, 158, 224, 223, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 45218, 796, 6632, 7, 84, 8, 198, 220, 15233, 32304, 18, 12310, 346, 62, 2246, 4891, 7, 84, 11, 929, 18218, 11, 74, 11, 74, 158, 224, 223, 11, 22065, 8, 198, 437, 198, 198, 7249, 15233, 32304, 18, 12310, 346, 62, 2749, 261, 18797, 30562, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 3103, 18797, 30562, 886, 198, 31, 23870, 2878, 15233, 32304, 18, 12310, 346, 62, 2749, 4891, 90, 84, 6030, 11, 4873, 6030, 92, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 44, 18187, 30562, 198, 220, 334, 3712, 84, 6030, 198, 220, 510, 18218, 3712, 84, 6030, 198, 220, 479, 3712, 4873, 6030, 198, 220, 479, 158, 224, 223, 3712, 4873, 6030, 198, 220, 45218, 3712, 84, 6030, 198, 437, 198, 198, 14016, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 33, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 9562, 11709, 8, 796, 15233, 32304, 18, 12310, 346, 62, 2749, 261, 18797, 30562, 3419, 198, 198, 8818, 435, 70, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 33, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 7942, 11709, 8, 198, 220, 479, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 479, 158, 224, 223, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 45218, 796, 6632, 7, 84, 8, 198, 220, 15233, 32304, 18, 12310, 346, 62, 2749, 4891, 7, 84, 11, 929, 18218, 11, 74, 11, 74, 158, 224, 223, 11, 22065, 8, 198, 437, 198, 198, 7249, 15233, 32304, 18, 12310, 346, 62, 34, 3103, 18797, 30562, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 3103, 18797, 30562, 886, 198, 31, 23870, 2878, 15233, 32304, 18, 12310, 346, 62, 4093, 4891, 90, 84, 6030, 11, 4873, 6030, 92, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 44, 18187, 30562, 198, 220, 334, 3712, 84, 6030, 198, 220, 510, 18218, 3712, 84, 6030, 198, 220, 479, 3712, 4873, 6030, 198, 220, 479, 158, 224, 223, 3712, 4873, 6030, 198, 220, 45218, 3712, 84, 6030, 198, 437, 198, 198, 14016, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 34, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 9562, 11709, 8, 796, 15233, 32304, 18, 12310, 346, 62, 34, 3103, 18797, 30562, 3419, 198, 198, 8818, 435, 70, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 34, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 7942, 11709, 8, 198, 220, 479, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 479, 158, 224, 223, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 45218, 796, 6632, 7, 84, 8, 198, 220, 15233, 32304, 18, 12310, 346, 62, 4093, 4891, 7, 84, 11, 929, 18218, 11, 74, 11, 74, 158, 224, 223, 11, 22065, 8, 198, 437, 198, 198, 7249, 15233, 32304, 18, 12310, 346, 62, 35, 3103, 18797, 30562, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 3103, 18797, 30562, 886, 198, 31, 23870, 2878, 15233, 32304, 18, 12310, 346, 62, 9697, 4891, 90, 84, 6030, 11, 4873, 6030, 92, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 44, 18187, 30562, 198, 220, 334, 3712, 84, 6030, 198, 220, 510, 18218, 3712, 84, 6030, 198, 220, 479, 3712, 4873, 6030, 198, 220, 479, 158, 224, 223, 3712, 4873, 6030, 198, 220, 45218, 3712, 84, 6030, 198, 437, 198, 198, 14016, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 35, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 9562, 11709, 8, 796, 15233, 32304, 18, 12310, 346, 62, 35, 3103, 18797, 30562, 3419, 198, 198, 8818, 435, 70, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 35, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 7942, 11709, 8, 198, 220, 479, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 479, 158, 224, 223, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 45218, 796, 6632, 7, 84, 8, 198, 220, 15233, 32304, 18, 12310, 346, 62, 9697, 4891, 7, 84, 11, 929, 18218, 11, 74, 11, 74, 158, 224, 223, 11, 22065, 8, 198, 437, 198, 198, 7249, 15233, 32304, 18, 12310, 346, 62, 2943, 261, 18797, 30562, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 3103, 18797, 30562, 886, 198, 31, 23870, 2878, 15233, 32304, 18, 12310, 346, 62, 2943, 4891, 90, 84, 6030, 11, 4873, 6030, 92, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 44, 18187, 30562, 198, 220, 334, 3712, 84, 6030, 198, 220, 510, 18218, 3712, 84, 6030, 198, 220, 479, 3712, 4873, 6030, 198, 220, 479, 158, 224, 223, 3712, 4873, 6030, 198, 220, 45218, 3712, 84, 6030, 198, 437, 198, 198, 14016, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 36, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 9562, 11709, 8, 796, 15233, 32304, 18, 12310, 346, 62, 2943, 261, 18797, 30562, 3419, 198, 198, 8818, 435, 70, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 36, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 7942, 11709, 8, 198, 220, 479, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 479, 158, 224, 223, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 45218, 796, 6632, 7, 84, 8, 198, 220, 15233, 32304, 18, 12310, 346, 62, 2943, 4891, 7, 84, 11, 929, 18218, 11, 74, 11, 74, 158, 224, 223, 11, 22065, 8, 198, 437, 198, 198, 7249, 15233, 32304, 18, 12310, 346, 62, 37, 3103, 18797, 30562, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 3103, 18797, 30562, 886, 198, 31, 23870, 2878, 15233, 32304, 18, 12310, 346, 62, 4851, 4891, 90, 84, 6030, 11, 4873, 6030, 92, 1279, 25, 520, 5374, 3477, 28813, 36, 80, 44, 18187, 30562, 198, 220, 334, 3712, 84, 6030, 198, 220, 510, 18218, 3712, 84, 6030, 198, 220, 479, 3712, 4873, 6030, 198, 220, 479, 158, 224, 223, 3712, 4873, 6030, 198, 220, 45218, 3712, 84, 6030, 198, 437, 198, 198, 14016, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 37, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 9562, 11709, 8, 796, 15233, 32304, 18, 12310, 346, 62, 37, 3103, 18797, 30562, 3419, 198, 198, 8818, 435, 70, 62, 23870, 7, 14016, 3712, 54, 648, 32304, 18, 12310, 346, 62, 37, 11, 1676, 65, 11, 84, 11, 138, 242, 54, 11, 138, 242, 57, 11, 79, 11, 4873, 62, 38124, 11, 3919, 786, 62, 4873, 62, 38124, 11, 43327, 62, 4873, 62, 38124, 11, 84, 9527, 4906, 2949, 3118, 896, 11, 84, 34104, 9527, 4906, 2949, 3118, 896, 11, 83, 6030, 2949, 3118, 896, 11, 929, 18218, 11, 69, 11, 83, 11, 28664, 11, 3712, 6030, 90, 7762, 90, 7942, 11709, 8, 198, 220, 479, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 479, 158, 224, 223, 796, 6632, 7, 4873, 62, 38124, 8, 198, 220, 45218, 796, 6632, 7, 84, 8, 198, 220, 15233, 32304, 18, 12310, 346, 62, 4851, 4891, 7, 84, 11, 929, 18218, 11, 74, 11, 74, 158, 224, 223, 11, 22065, 8, 198, 437, 198 ]
2.208313
2,021
pillars(numpill, dist, width) = max(0, numpill-1)*100*dist + max(0, numpill-2)*width
[ 27215, 945, 7, 77, 931, 359, 11, 1233, 11, 9647, 8, 796, 198, 220, 220, 220, 3509, 7, 15, 11, 299, 931, 359, 12, 16, 27493, 3064, 9, 17080, 1343, 198, 220, 220, 220, 3509, 7, 15, 11, 299, 931, 359, 12, 17, 27493, 10394 ]
2.044444
45
module FighterJets export FighterJet using Base: Bool, Float64 #FigherJet is avery fast vehicle with powerful weapons. It mutable struct FighterJet "power status: true - on, false - off" power::Bool "current direction in radians" direction::Float64 "current position coordinate (x, y)" position::Tuple{Float64, Float64} end # Import generic functions from include("../../Vehicles/src/Vehicles.jl") using .Vehicles: power_on!, power_off!, turn!, move!, position!, Vehicles # Implementation of Vehicle interface function power_on!(fj::FighterJet) fj.power =true println("Powered on: ", fj) nothing end function power_off!(fj::FighterJet) fj.power = false println("Powered off: ", fj) nothing end function turn!(fj::FighterJet, direction) fj.direction = direction println("Changed direction to ", direction, ": ", fj) nothing end function move!(fj::FighterJet, distance) x, y = fj.position dx = round(distance * cos(fj.direction), digits = 2) dy = round(distance * sin(fj.direction), digits = 2) fj.position = (x + dx, y + dy) println("Moved (", dx, ",", dy, "): ", fj) nothing end function position(fj::FighterJet) fj.position end end # module
[ 21412, 15411, 41, 1039, 198, 198, 39344, 15411, 42273, 198, 198, 3500, 7308, 25, 347, 970, 11, 48436, 2414, 198, 2, 14989, 372, 42273, 318, 257, 548, 3049, 4038, 351, 3665, 3777, 13, 632, 198, 76, 18187, 2878, 15411, 42273, 628, 220, 220, 220, 366, 6477, 3722, 25, 2081, 532, 319, 11, 3991, 532, 572, 1, 198, 220, 220, 220, 1176, 3712, 33, 970, 628, 220, 220, 220, 366, 14421, 4571, 287, 2511, 1547, 1, 198, 220, 220, 220, 4571, 3712, 43879, 2414, 628, 220, 220, 220, 366, 14421, 2292, 20435, 357, 87, 11, 331, 16725, 198, 220, 220, 220, 2292, 3712, 51, 29291, 90, 43879, 2414, 11, 48436, 2414, 92, 198, 437, 198, 198, 2, 17267, 14276, 5499, 422, 198, 17256, 7203, 40720, 40720, 37870, 2983, 14, 10677, 14, 37870, 2983, 13, 20362, 4943, 198, 3500, 764, 37870, 2983, 25, 1176, 62, 261, 28265, 1176, 62, 2364, 28265, 1210, 28265, 1445, 28265, 2292, 28265, 31365, 198, 198, 2, 46333, 286, 21501, 7071, 198, 8818, 1176, 62, 261, 0, 7, 69, 73, 3712, 37, 4799, 42273, 8, 198, 220, 220, 220, 277, 73, 13, 6477, 796, 7942, 198, 220, 220, 220, 44872, 7203, 47, 10387, 319, 25, 33172, 277, 73, 8, 198, 220, 220, 220, 2147, 198, 437, 198, 198, 8818, 1176, 62, 2364, 0, 7, 69, 73, 3712, 37, 4799, 42273, 8, 198, 220, 220, 220, 277, 73, 13, 6477, 796, 3991, 198, 220, 220, 220, 44872, 7203, 47, 10387, 572, 25, 33172, 277, 73, 8, 198, 220, 220, 220, 2147, 198, 437, 198, 198, 8818, 1210, 0, 7, 69, 73, 3712, 37, 4799, 42273, 11, 4571, 8, 198, 220, 220, 220, 277, 73, 13, 37295, 796, 4571, 198, 220, 220, 220, 44872, 7203, 31813, 4571, 284, 33172, 4571, 11, 366, 25, 33172, 277, 73, 8, 198, 220, 220, 220, 2147, 198, 437, 198, 198, 8818, 1445, 0, 7, 69, 73, 3712, 37, 4799, 42273, 11, 5253, 8, 198, 220, 220, 220, 2124, 11, 331, 796, 277, 73, 13, 9150, 198, 220, 220, 220, 44332, 796, 220, 2835, 7, 30246, 1635, 8615, 7, 69, 73, 13, 37295, 828, 19561, 796, 362, 8, 198, 220, 220, 220, 20268, 796, 220, 2835, 7, 30246, 1635, 7813, 7, 69, 73, 13, 37295, 828, 19561, 796, 362, 8, 198, 220, 220, 220, 277, 73, 13, 9150, 796, 357, 87, 1343, 44332, 11, 331, 1343, 20268, 8, 198, 220, 220, 220, 44872, 7203, 44, 2668, 357, 1600, 44332, 11, 366, 553, 11, 20268, 11, 366, 2599, 33172, 277, 73, 8, 198, 220, 220, 220, 2147, 198, 437, 198, 198, 8818, 2292, 7, 69, 73, 3712, 37, 4799, 42273, 8, 198, 220, 220, 220, 277, 73, 13, 9150, 198, 437, 198, 198, 437, 1303, 8265, 198 ]
2.758315
451
using Pkg dependencies = [ "GraphRecipes", "LightGraphs", "SimpleWeightedGraphs", "GraphPlot", "MetaGraphs", "Documenter", "StatsBase", "LinearAlgebra", "Statistics", "Colors", "Plots", "LaTeXStrings", "Cairo", "Compose", "SparseArrays", "QuadGK", "SatelliteToolbox", "GR"] Pkg.add(dependencies) Pkg.update(dependencies)
[ 3500, 350, 10025, 198, 198, 45841, 3976, 796, 685, 198, 220, 220, 220, 366, 37065, 6690, 18636, 1600, 198, 220, 220, 220, 366, 15047, 37065, 82, 1600, 198, 220, 220, 220, 366, 26437, 25844, 276, 37065, 82, 1600, 198, 220, 220, 220, 366, 37065, 43328, 1600, 198, 220, 220, 220, 366, 48526, 37065, 82, 1600, 198, 220, 220, 220, 366, 24941, 263, 1600, 198, 220, 220, 220, 366, 29668, 14881, 1600, 198, 220, 220, 220, 366, 14993, 451, 2348, 29230, 1600, 198, 220, 220, 220, 366, 48346, 1600, 198, 220, 220, 220, 366, 5216, 669, 1600, 198, 220, 220, 220, 366, 3646, 1747, 1600, 198, 220, 220, 220, 366, 14772, 49568, 13290, 654, 1600, 198, 220, 220, 220, 366, 34, 18131, 1600, 198, 220, 220, 220, 366, 7293, 577, 1600, 198, 220, 220, 220, 366, 50, 29572, 3163, 20477, 1600, 198, 220, 220, 220, 366, 4507, 324, 38, 42, 1600, 198, 220, 220, 220, 366, 50, 26493, 25391, 3524, 1600, 198, 220, 220, 220, 366, 10761, 8973, 198, 198, 47, 10025, 13, 2860, 7, 45841, 3976, 8, 198, 47, 10025, 13, 19119, 7, 45841, 3976, 8, 198 ]
2.112299
187
## Definition of Link types and methods for link, invlink and μη, the derivative of μ w.r.t. η abstract Link immutable IdentityLink <: Link end immutable InverseLink <: Link end immutable LogLink <: Link end immutable LogitLink <: Link end link(::IdentityLink,μ) = μ invlink(::IdentityLink,η) = η μη(::IdentityLink,η) = one(η) link(::LogitLink,μ) = log(μ/(one(μ)-μ)) invlink(::LogitLink,η) = inv(one(η) + exp(-η)) μη(::LogitLink,η) = (ee = exp(-η); ee/abs2(one(η)+ee)) link(::LogLink,μ) = log(μ) invlink(::LogLink,η) = exp(η) μη(::LogLink,η) = exp(η) link(::InverseLink,μ) = inv(μ) invlink(::InverseLink,η) = inv(η) μη(::InverseLink,η) = -inv(abs2(η))
[ 2235, 30396, 286, 7502, 3858, 290, 5050, 329, 2792, 11, 800, 8726, 290, 18919, 138, 115, 11, 262, 27255, 286, 18919, 266, 13, 81, 13, 83, 13, 7377, 115, 198, 198, 397, 8709, 7502, 198, 198, 8608, 18187, 27207, 11280, 1279, 25, 7502, 886, 198, 8608, 18187, 554, 4399, 11280, 1279, 25, 7502, 886, 198, 8608, 18187, 5972, 11280, 1279, 25, 7502, 886, 198, 8608, 18187, 5972, 270, 11280, 1279, 25, 7502, 886, 198, 198, 8726, 7, 3712, 7390, 26858, 11280, 11, 34703, 8, 796, 18919, 198, 16340, 8726, 7, 3712, 7390, 26858, 11280, 11, 138, 115, 8, 796, 7377, 115, 198, 34703, 138, 115, 7, 3712, 7390, 26858, 11280, 11, 138, 115, 8, 796, 530, 7, 138, 115, 8, 198, 198, 8726, 7, 3712, 11187, 270, 11280, 11, 34703, 8, 796, 2604, 7, 34703, 29006, 505, 7, 34703, 13219, 34703, 4008, 198, 16340, 8726, 7, 3712, 11187, 270, 11280, 11, 138, 115, 8, 796, 800, 7, 505, 7, 138, 115, 8, 1343, 1033, 32590, 138, 115, 4008, 198, 34703, 138, 115, 7, 3712, 11187, 270, 11280, 11, 138, 115, 8, 796, 357, 1453, 796, 1033, 32590, 138, 115, 1776, 304, 68, 14, 8937, 17, 7, 505, 7, 138, 115, 47762, 1453, 4008, 198, 198, 8726, 7, 3712, 11187, 11280, 11, 34703, 8, 796, 2604, 7, 34703, 8, 198, 16340, 8726, 7, 3712, 11187, 11280, 11, 138, 115, 8, 796, 1033, 7, 138, 115, 8, 198, 34703, 138, 115, 7, 3712, 11187, 11280, 11, 138, 115, 8, 796, 1033, 7, 138, 115, 8, 198, 198, 8726, 7, 3712, 818, 4399, 11280, 11, 34703, 8, 796, 800, 7, 34703, 8, 198, 16340, 8726, 7, 3712, 818, 4399, 11280, 11, 138, 115, 8, 796, 800, 7, 138, 115, 8, 198, 34703, 138, 115, 7, 3712, 818, 4399, 11280, 11, 138, 115, 8, 796, 532, 16340, 7, 8937, 17, 7, 138, 115, 4008, 628 ]
2.118971
311
using Compat, Calculus, QuadGK using Test: @test function psm(nip) @test nip >= 1 # Integrate to compute coefficient in rhs rhs(n, nip) = QuadGK.quadgk((x)-> x^nip, -n, n)[1] local hn if nip == 1 w = [1.0] elseif nip == 2 w = [1/2, 1/2] else if isodd(nip) n = floor(Int, nip/2) hn = range(-n, stop=n, length=nip) else n = floor(Int, 2*(nip/2)-1) hn = range(-n, stop=n, length=nip) end m = ones(nip, nip) for i in 0:nip-1 for j in 1:nip m[i+1, j] = (hn[j])^i end end v = [rhs(n, ni) for ni in 0:nip-1] w = m \ v iseven(nip) && (w = w / 2.0) end w' end function nc(func, lb, ub, nip) @test ub > lb @test nip >= 1 if nip == 1 h = ub - lb x = [lb] elseif nip ==2 h = ub - lb x = [lb, ub] else h = (ub - lb)/(nip-1) x = collect(range(lb, stop=ub, length=nip)) end w = psm(nip) res = h * w *func.(x) (w, res) end lb = pi/4 ub = pi/2 func = sin nip = 7 w, res = nc(func, lb, ub, nip) @test res[1] ≈ QuadGK.quadgk(sin, pi/4, pi/2)[1]
[ 3500, 3082, 265, 11, 2199, 17576, 11, 20648, 38, 42, 198, 3500, 6208, 25, 2488, 9288, 628, 198, 8818, 279, 5796, 7, 77, 541, 8, 198, 220, 2488, 9288, 299, 541, 18189, 352, 198, 220, 1303, 15995, 4873, 284, 24061, 35381, 287, 9529, 82, 198, 220, 9529, 82, 7, 77, 11, 299, 541, 8, 796, 20648, 38, 42, 13, 47003, 70, 74, 19510, 87, 8, 3784, 2124, 61, 77, 541, 11, 532, 77, 11, 299, 38381, 16, 60, 198, 220, 1957, 289, 77, 198, 220, 611, 299, 541, 6624, 352, 198, 220, 220, 220, 266, 796, 685, 16, 13, 15, 60, 198, 220, 2073, 361, 299, 541, 6624, 362, 198, 220, 220, 220, 266, 796, 685, 16, 14, 17, 11, 352, 14, 17, 60, 198, 220, 2073, 198, 220, 220, 220, 611, 318, 5088, 7, 77, 541, 8, 198, 220, 220, 220, 220, 220, 299, 796, 4314, 7, 5317, 11, 299, 541, 14, 17, 8, 198, 220, 220, 220, 220, 220, 289, 77, 796, 2837, 32590, 77, 11, 2245, 28, 77, 11, 4129, 28, 77, 541, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 299, 796, 4314, 7, 5317, 11, 362, 9, 7, 77, 541, 14, 17, 13219, 16, 8, 198, 220, 220, 220, 220, 220, 289, 77, 796, 2837, 32590, 77, 11, 2245, 28, 77, 11, 4129, 28, 77, 541, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 285, 796, 3392, 7, 77, 541, 11, 299, 541, 8, 198, 220, 220, 220, 329, 1312, 287, 657, 25, 77, 541, 12, 16, 198, 220, 220, 220, 220, 220, 329, 474, 287, 352, 25, 77, 541, 198, 220, 220, 220, 220, 220, 220, 220, 285, 58, 72, 10, 16, 11, 474, 60, 796, 357, 21116, 58, 73, 12962, 61, 72, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 410, 796, 685, 81, 11994, 7, 77, 11, 37628, 8, 329, 37628, 287, 657, 25, 77, 541, 12, 16, 60, 198, 220, 220, 220, 266, 796, 285, 3467, 410, 198, 220, 220, 220, 318, 10197, 7, 77, 541, 8, 11405, 357, 86, 796, 266, 1220, 362, 13, 15, 8, 198, 220, 886, 198, 220, 266, 6, 198, 437, 198, 198, 8818, 299, 66, 7, 20786, 11, 18360, 11, 20967, 11, 299, 541, 8, 198, 220, 2488, 9288, 20967, 1875, 18360, 198, 220, 2488, 9288, 299, 541, 18189, 352, 198, 220, 611, 299, 541, 6624, 352, 198, 220, 220, 220, 289, 796, 20967, 532, 18360, 198, 220, 220, 220, 2124, 796, 685, 23160, 60, 198, 220, 2073, 361, 299, 541, 6624, 17, 198, 220, 220, 220, 289, 796, 20967, 532, 18360, 198, 220, 220, 220, 2124, 796, 685, 23160, 11, 20967, 60, 198, 220, 2073, 198, 220, 220, 220, 289, 796, 357, 549, 532, 18360, 20679, 7, 77, 541, 12, 16, 8, 198, 220, 220, 220, 2124, 796, 2824, 7, 9521, 7, 23160, 11, 2245, 28, 549, 11, 4129, 28, 77, 541, 4008, 198, 220, 886, 198, 220, 266, 796, 279, 5796, 7, 77, 541, 8, 198, 220, 581, 796, 289, 1635, 266, 1635, 20786, 12195, 87, 8, 198, 220, 357, 86, 11, 581, 8, 198, 437, 198, 198, 23160, 796, 31028, 14, 19, 198, 549, 796, 31028, 14, 17, 198, 20786, 796, 7813, 198, 77, 541, 796, 767, 198, 86, 11, 581, 796, 299, 66, 7, 20786, 11, 18360, 11, 20967, 11, 299, 541, 8, 198, 198, 31, 9288, 581, 58, 16, 60, 15139, 230, 20648, 38, 42, 13, 47003, 70, 74, 7, 31369, 11, 31028, 14, 19, 11, 31028, 14, 17, 38381, 16, 60, 628 ]
1.809045
597
# some utility functions const Γ = gamma function generalized_binomial(α::T, n::S) where {T,S <: Integer} R = Base.promote_op(/,T,S) out = one(R) for i in n:-1:1 out *= α/i α -= 1 end out end ## memoized version of the above @memoize function generalized_binomial′(a, k::Int) k < 0 && return NaN * one(a) k == 0 && return one(a)/1 generalized_binomial′(a,k-1) * (a-k+1)/k end ## x⁽ⁱ⁾ is falling (x)⋅(x-1)⋯(x-n+1) function Pochhammer(::Val{:falling}, z::T,n::Int) where {T} iszero(n) && return one(T) out = z for i in 1:n-1 z -= 1 out *= z end out end ## (x)ᵢ is rising (x)⋅(x+1)⋯(x+n-1) = Γ(z+n)/Γ(z) function Pochhammer(::Val{:rising}, z::T,n::Int) where {T} iszero(n) && return one(T) out = z for i in 1:n-1 z += 1 out *= z end out end # default is (x)ᵢ Pochhammer(z,n::Int) = Pochhammer(Val(:rising), z, n) # (x)_n/n! Pochhammer_factorial(z, n) = Pochhammer_factorial(Val(:rising), z, n) function Pochhammer_factorial(::Val{:rising}, z, n) iszero(n) && return one(z)/1 prod((z+i)/(n-i) for i in 0:n-1) end ## Alternative to HypergeometricFunctions.jl so that ## variables can be inserted into the numerator """ pFq(as, bs, z; [maxevals=1000]) Compute the generalized [hypergeometric](https://en.wikipedia.org/wiki/Generalized_hypergeometric_function) function. The `HypergeometricFunction.jl` package would normally be used for such calculations, but this one accepts polynomial values for the `as` and `z` values. # Example From [mathworld](https://mathworld.wolfram.com/HypergeometricFunction.html) ```jldoctest julia> using Polynomials, SpecialPolynomials julia> import SpecialPolynomials: pFq, Pochhammer julia> pFq((1/3,2/3), 5/6, 27/32) ≈ 8/5 true julia> pFq([1/4, 1/2], [3/4], 80/81; maxevals=2000) ≈ 9/5 true julia> x = variable() Polynomial(x) julia> n = 5 5 julia> pFq((-n,n+1), 1, (1-x)/2) ≈ basis(Legendre,n)(x) true julia> α, β, n = 1/2, 1/2, 5; julia> Pochhammer(α+1,n)/factorial(n) * pFq((-n,n+α+β+1), α+1, (1-x)/2) ≈ basis(Jacobi{α,β}, n)(x) true ``` """ function pFq(as, bs, z; maxevals=1000) n = 1 acc = trm = one(z) p,q = length(as), length(bs) # element in `as` is negative integer or 0 && converges # p ≤ q && converges # p = q + 1 |x| < 1 && converge # p > q + 1 && diverges while n < maxevals a = isempty(as) ? 1 : prod(as) b = isempty(bs) ? 1 : prod(bs) iszero(a) && return acc iszero(b) && return Inf # check on b trm *= a /b * z /n acc += trm as = plus_1(as) bs = plus_1(bs) n += 1 end if (p > q + 1 || (p == q+1 && abs(z) < 1)) return acc else NaN*acc end end ## tuples @inline plus_1(as) = map(x->x+1, as) # use HypergeometricFunction.mFn if possible function pFq(as::Tuple{A,B}, bs::Tuple{C}, z::AbstractFloat) where {A,B,C} HypergeometricFunctions._₂F₁(as[1],as[2],bs[1],z) end function pFq(as::Tuple{A,B,C}, bs::Tuple{D,E}, z::AbstractFloat) where {A,B,C,D,E} HypergeometricFunctions._₃F₂(as[1],as[2],as[3],bs[1],bs[2],z) end ## Try to speed up quadgk by not specializing on F mutable struct Wrapper F end (F::Wrapper)(x) = F.F(x) _quadgk(f, a, b) = quadgk(Wrapper(f), a, b)[1] const ∫ = _quadgk checked_div(a, b) = (iszero(a) && iszero(b)) ? a : a/b
[ 2, 617, 10361, 5499, 198, 9979, 7377, 241, 796, 34236, 628, 198, 8818, 38284, 62, 8800, 49070, 7, 17394, 3712, 51, 11, 299, 3712, 50, 8, 810, 1391, 51, 11, 50, 1279, 25, 34142, 92, 198, 220, 220, 220, 371, 796, 7308, 13, 16963, 1258, 62, 404, 7, 47454, 51, 11, 50, 8, 198, 220, 220, 220, 503, 796, 530, 7, 49, 8, 198, 220, 220, 220, 329, 1312, 287, 299, 21912, 16, 25, 16, 198, 220, 220, 220, 220, 220, 220, 220, 503, 1635, 28, 26367, 14, 72, 198, 220, 220, 220, 220, 220, 220, 220, 26367, 48185, 352, 198, 220, 220, 220, 886, 198, 220, 220, 220, 503, 198, 437, 198, 198, 2235, 16155, 1143, 2196, 286, 262, 2029, 198, 31, 11883, 78, 1096, 2163, 38284, 62, 8800, 49070, 17478, 7, 64, 11, 479, 3712, 5317, 8, 198, 220, 220, 220, 479, 1279, 657, 11405, 1441, 11013, 45, 1635, 530, 7, 64, 8, 198, 220, 220, 220, 479, 6624, 657, 11405, 1441, 530, 7, 64, 20679, 16, 198, 220, 220, 220, 38284, 62, 8800, 49070, 17478, 7, 64, 11, 74, 12, 16, 8, 1635, 357, 64, 12, 74, 10, 16, 20679, 74, 198, 437, 628, 198, 198, 2235, 2124, 46256, 121, 46256, 109, 46256, 122, 318, 7463, 357, 87, 8, 158, 233, 227, 7, 87, 12, 16, 8, 158, 233, 107, 7, 87, 12, 77, 10, 16, 8, 198, 8818, 350, 5374, 17980, 7, 3712, 7762, 90, 25, 7207, 278, 5512, 1976, 3712, 51, 11, 77, 3712, 5317, 8, 810, 1391, 51, 92, 198, 220, 220, 220, 318, 22570, 7, 77, 8, 11405, 1441, 530, 7, 51, 8, 220, 220, 220, 220, 198, 220, 220, 220, 503, 796, 1976, 198, 220, 220, 220, 329, 1312, 287, 352, 25, 77, 12, 16, 198, 220, 220, 220, 220, 220, 220, 220, 1976, 48185, 352, 198, 220, 220, 220, 220, 220, 220, 220, 503, 1635, 28, 1976, 198, 220, 220, 220, 886, 198, 220, 220, 220, 503, 198, 437, 198, 198, 2235, 357, 87, 8, 39611, 95, 318, 7396, 357, 87, 8, 158, 233, 227, 7, 87, 10, 16, 8, 158, 233, 107, 7, 87, 10, 77, 12, 16, 8, 796, 7377, 241, 7, 89, 10, 77, 20679, 138, 241, 7, 89, 8, 198, 8818, 350, 5374, 17980, 7, 3712, 7762, 90, 25, 22610, 5512, 1976, 3712, 51, 11, 77, 3712, 5317, 8, 810, 1391, 51, 92, 198, 220, 220, 220, 318, 22570, 7, 77, 8, 11405, 1441, 530, 7, 51, 8, 198, 220, 220, 220, 503, 796, 1976, 198, 220, 220, 220, 329, 1312, 287, 352, 25, 77, 12, 16, 198, 220, 220, 220, 220, 220, 220, 220, 1976, 15853, 352, 198, 220, 220, 220, 220, 220, 220, 220, 503, 1635, 28, 1976, 198, 220, 220, 220, 886, 198, 220, 220, 220, 503, 198, 437, 198, 2, 4277, 318, 357, 87, 8, 39611, 95, 198, 47, 5374, 17980, 7, 89, 11, 77, 3712, 5317, 8, 796, 350, 5374, 17980, 7, 7762, 7, 25, 22610, 828, 220, 1976, 11, 299, 8, 628, 198, 2, 357, 87, 8, 62, 77, 14, 77, 0, 198, 47, 5374, 17980, 62, 22584, 5132, 7, 89, 11, 299, 8, 796, 350, 5374, 17980, 62, 22584, 5132, 7, 7762, 7, 25, 22610, 828, 1976, 11, 299, 8, 198, 198, 8818, 350, 5374, 17980, 62, 22584, 5132, 7, 3712, 7762, 90, 25, 22610, 5512, 1976, 11, 299, 8, 198, 220, 220, 220, 318, 22570, 7, 77, 8, 11405, 1441, 530, 7, 89, 20679, 16, 198, 220, 220, 220, 40426, 19510, 89, 10, 72, 20679, 7, 77, 12, 72, 8, 329, 1312, 287, 657, 25, 77, 12, 16, 8, 198, 437, 198, 198, 2235, 27182, 284, 15079, 469, 16996, 24629, 2733, 13, 20362, 523, 326, 198, 2235, 9633, 460, 307, 18846, 656, 262, 5470, 1352, 198, 37811, 198, 220, 220, 220, 279, 37, 80, 7, 292, 11, 275, 82, 11, 1976, 26, 685, 9806, 1990, 874, 28, 12825, 12962, 198, 198, 7293, 1133, 262, 38284, 685, 49229, 469, 16996, 16151, 5450, 1378, 268, 13, 31266, 13, 2398, 14, 15466, 14, 12218, 1143, 62, 49229, 469, 16996, 62, 8818, 8, 2163, 13, 383, 4600, 38197, 469, 16996, 22203, 13, 20362, 63, 5301, 561, 7685, 307, 973, 329, 884, 16765, 11, 475, 428, 530, 18178, 745, 6213, 49070, 3815, 329, 262, 4600, 292, 63, 290, 4600, 89, 63, 3815, 13, 198, 198, 2, 17934, 198, 198, 4863, 685, 11018, 6894, 16151, 5450, 1378, 11018, 6894, 13, 18829, 859, 13, 785, 14, 38197, 469, 16996, 22203, 13, 6494, 8, 198, 198, 15506, 63, 73, 335, 38441, 395, 198, 73, 43640, 29, 1262, 12280, 26601, 8231, 11, 6093, 34220, 26601, 8231, 198, 198, 73, 43640, 29, 1330, 6093, 34220, 26601, 8231, 25, 279, 37, 80, 11, 350, 5374, 17980, 198, 198, 73, 43640, 29, 279, 37, 80, 19510, 16, 14, 18, 11, 17, 14, 18, 828, 642, 14, 21, 11, 2681, 14, 2624, 8, 15139, 230, 807, 14, 20, 198, 7942, 198, 198, 73, 43640, 29, 279, 37, 80, 26933, 16, 14, 19, 11, 352, 14, 17, 4357, 685, 18, 14, 19, 4357, 4019, 14, 6659, 26, 3509, 1990, 874, 28, 11024, 8, 15139, 230, 860, 14, 20, 198, 7942, 198, 198, 73, 43640, 29, 2124, 796, 7885, 3419, 198, 34220, 26601, 498, 7, 87, 8, 198, 198, 73, 43640, 29, 299, 796, 642, 198, 20, 198, 198, 73, 43640, 29, 279, 37, 80, 19510, 12, 77, 11, 77, 10, 16, 828, 352, 11, 357, 16, 12, 87, 20679, 17, 8, 15139, 230, 4308, 7, 21351, 260, 11, 77, 5769, 87, 8, 198, 7942, 198, 198, 73, 43640, 29, 26367, 11, 27169, 11, 299, 796, 352, 14, 17, 11, 352, 14, 17, 11, 642, 26, 198, 198, 73, 43640, 29, 350, 5374, 17980, 7, 17394, 10, 16, 11, 77, 20679, 22584, 5132, 7, 77, 8, 1635, 279, 37, 80, 19510, 12, 77, 11, 77, 10, 17394, 10, 26638, 10, 16, 828, 26367, 10, 16, 11, 357, 16, 12, 87, 20679, 17, 8, 15139, 230, 4308, 7, 28821, 13411, 90, 17394, 11, 26638, 5512, 299, 5769, 87, 8, 198, 7942, 198, 15506, 63, 198, 37811, 198, 8818, 279, 37, 80, 7, 292, 11, 275, 82, 11, 1976, 26, 3509, 1990, 874, 28, 12825, 8, 198, 220, 220, 220, 299, 796, 352, 198, 220, 220, 220, 697, 796, 491, 76, 796, 530, 7, 89, 8, 628, 220, 220, 220, 279, 11, 80, 796, 4129, 7, 292, 828, 4129, 7, 1443, 8, 628, 220, 220, 220, 1303, 5002, 287, 4600, 292, 63, 318, 4633, 18253, 393, 657, 11405, 6718, 3212, 198, 220, 220, 220, 1303, 279, 41305, 10662, 11405, 6718, 3212, 198, 220, 220, 220, 1303, 279, 796, 10662, 1343, 352, 930, 87, 91, 1279, 352, 11405, 47873, 198, 220, 220, 220, 1303, 279, 1875, 10662, 1343, 352, 11405, 12312, 3212, 198, 220, 220, 220, 981, 299, 1279, 3509, 1990, 874, 198, 220, 220, 220, 220, 220, 220, 220, 257, 796, 318, 28920, 7, 292, 8, 5633, 352, 1058, 40426, 7, 292, 8, 198, 220, 220, 220, 220, 220, 220, 220, 275, 796, 318, 28920, 7, 1443, 8, 5633, 352, 1058, 40426, 7, 1443, 8, 628, 220, 220, 220, 220, 220, 220, 220, 318, 22570, 7, 64, 8, 11405, 1441, 697, 198, 220, 220, 220, 220, 220, 220, 220, 318, 22570, 7, 65, 8, 11405, 1441, 4806, 220, 1303, 2198, 319, 275, 628, 220, 220, 220, 220, 220, 220, 220, 491, 76, 1635, 28, 257, 1220, 65, 1635, 1976, 220, 1220, 77, 198, 220, 220, 220, 220, 220, 220, 220, 697, 15853, 491, 76, 628, 220, 220, 220, 220, 220, 220, 220, 355, 796, 5556, 62, 16, 7, 292, 8, 628, 220, 220, 220, 220, 220, 220, 220, 275, 82, 796, 5556, 62, 16, 7, 1443, 8, 198, 220, 220, 220, 220, 220, 220, 220, 299, 15853, 352, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 357, 79, 1875, 10662, 1343, 352, 8614, 357, 79, 6624, 10662, 10, 16, 11405, 2352, 7, 89, 8, 1279, 352, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 697, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 11013, 45, 9, 4134, 198, 220, 220, 220, 886, 198, 437, 198, 2235, 12777, 2374, 198, 31, 45145, 5556, 62, 16, 7, 292, 8, 796, 3975, 7, 87, 3784, 87, 10, 16, 11, 355, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 198, 198, 2, 779, 15079, 469, 16996, 22203, 13, 76, 37, 77, 611, 1744, 198, 8818, 279, 37, 80, 7, 292, 3712, 51, 29291, 90, 32, 11, 33, 5512, 275, 82, 3712, 51, 29291, 90, 34, 5512, 1976, 3712, 23839, 43879, 8, 810, 1391, 32, 11, 33, 11, 34, 92, 198, 220, 220, 220, 15079, 469, 16996, 24629, 2733, 13557, 158, 224, 224, 37, 158, 224, 223, 7, 292, 58, 16, 4357, 292, 58, 17, 4357, 1443, 58, 16, 4357, 89, 8, 198, 437, 198, 8818, 279, 37, 80, 7, 292, 3712, 51, 29291, 90, 32, 11, 33, 11, 34, 5512, 275, 82, 3712, 51, 29291, 90, 35, 11, 36, 5512, 1976, 3712, 23839, 43879, 8, 810, 1391, 32, 11, 33, 11, 34, 11, 35, 11, 36, 92, 198, 220, 220, 220, 15079, 469, 16996, 24629, 2733, 13557, 158, 224, 225, 37, 158, 224, 224, 7, 292, 58, 16, 4357, 292, 58, 17, 4357, 292, 58, 18, 4357, 1443, 58, 16, 4357, 1443, 58, 17, 4357, 89, 8, 198, 437, 198, 220, 220, 220, 220, 628, 198, 2235, 9993, 284, 2866, 510, 220, 15094, 70, 74, 416, 407, 40847, 319, 376, 198, 76, 18187, 2878, 27323, 2848, 198, 220, 220, 220, 376, 198, 437, 198, 7, 37, 3712, 36918, 2848, 5769, 87, 8, 796, 376, 13, 37, 7, 87, 8, 198, 198, 62, 47003, 70, 74, 7, 69, 11, 257, 11, 275, 8, 796, 15094, 70, 74, 7, 36918, 2848, 7, 69, 828, 257, 11, 275, 38381, 16, 60, 198, 9979, 18872, 104, 796, 4808, 47003, 70, 74, 628, 198, 26752, 62, 7146, 7, 64, 11, 275, 8, 796, 357, 271, 22570, 7, 64, 8, 11405, 318, 22570, 7, 65, 4008, 5633, 257, 1058, 257, 14, 65, 198 ]
2.039928
1,678
## Display graph with weigthed edges Lwidth=decisionTree.Edges.Weight*19+1 Lwidth=10*Lwidth/maximum(Lwidth) graphPlot=plot(decisionTree,"Layout','layered','NodeLabel",nodeLabel,... "LineWidth",Lwidth) toHL=find(decisionTree.Nodes.Sum~=0) for HL=1:length(toHL) highlight[graphPlot,toHL[HL],"Marker','s','NodeColor','r','MarkerSize",decisionTree.Nodes.Sum[toHL[HL]]+5] end toHL=find(decisionTree.Nodes.Sum==maximum(decisionTree.Nodes.Sum)) highlight[graphPlot,toHL,"NodeColor','y"]
[ 2235, 16531, 4823, 351, 356, 328, 83, 704, 13015, 198, 43, 10394, 28, 12501, 1166, 27660, 13, 7407, 3212, 13, 25844, 9, 1129, 10, 16, 198, 43, 10394, 28, 940, 9, 43, 10394, 14, 47033, 7, 43, 10394, 8, 198, 34960, 43328, 28, 29487, 7, 12501, 1166, 27660, 553, 32517, 41707, 10724, 1068, 41707, 19667, 33986, 1600, 17440, 33986, 42303, 198, 220, 220, 220, 366, 13949, 30916, 1600, 43, 10394, 8, 198, 1462, 6581, 28, 19796, 7, 12501, 1166, 27660, 13, 45, 4147, 13, 13065, 93, 28, 15, 8, 198, 1640, 38312, 28, 16, 25, 13664, 7, 1462, 6581, 8, 198, 8929, 2971, 58, 34960, 43328, 11, 1462, 6581, 58, 6581, 17241, 9704, 263, 41707, 82, 41707, 19667, 10258, 41707, 81, 41707, 9704, 263, 10699, 1600, 12501, 1166, 27660, 13, 45, 4147, 13, 13065, 58, 1462, 6581, 58, 6581, 11907, 10, 20, 60, 198, 437, 198, 1462, 6581, 28, 19796, 7, 12501, 1166, 27660, 13, 45, 4147, 13, 13065, 855, 47033, 7, 12501, 1166, 27660, 13, 45, 4147, 13, 13065, 4008, 198, 8929, 2971, 58, 34960, 43328, 11, 1462, 6581, 553, 19667, 10258, 41707, 88, 8973, 198 ]
2.588235
187
immutable ConfidenceInterval lower::Float64 upper::Float64 end
[ 8608, 18187, 7326, 1704, 9492, 2100, 198, 220, 220, 220, 2793, 3712, 43879, 2414, 198, 220, 220, 220, 6727, 3712, 43879, 2414, 198, 437, 198 ]
2.84
25
""" Computing in the category of finite sets and functions, and its skeleton. """ module FinSets export FinOrd, FinOrdFunction, FinOrdFunc, FinOrdVector, force, terminal, product, equalizer, pullback, limit, initial, coproduct, coequalizer, pushout, colimit using AutoHashEquals using DataStructures: IntDisjointSets, union!, find_root using ...GAT using ...Theories: Category import ...Theories: dom, codom, id, compose, ⋅, ∘, terminal, product, equalizer, initial, coproduct, coequalizer using ..ShapeDiagrams # Category of finite ordinals ############################# """ Finite ordinal (natural number). An object in the category of finite ordinals, which is the skeleton of the category of finite sets. """ @auto_hash_equals struct FinOrd n::Int end """ Function between sets in the form of finite ordinals. A morphism in the category of finite ordinals, which is the skeleton of the category of finite sets. The function can be defined implicitly by an arbitrary Julia function, in which case it is evaluated lazily, or explictly by a vector of integers. In the latter case, the function (1↦1, 2↦3, 3↦2, 4↦3), for example, is represented by the vector [1,3,2,3]. """ abstract type FinOrdFunction end FinOrdFunction(f, dom::FinOrd, codom::FinOrd) = FinOrdFunction(f, dom.n, codom.n) """ Function in FinOrd defined by an arbitrary Julia function. To be evaluated lazily unless forced. """ @auto_hash_equals struct FinOrdFunc <: FinOrdFunction func::Function dom::Int codom::Int end FinOrdFunction(f::Function, dom::Int, codom::Int) = FinOrdFunc(f, dom, codom) (f::FinOrdFunc)(x) = f.func(x) """ Function in FinOrd represented explicitly by a vector. """ @auto_hash_equals struct FinOrdVector{T<:AbstractVector{Int}} <: FinOrdFunction func::T codom::Int end FinOrdFunction(f::AbstractVector) = FinOrdVector(f, maximum(f)) FinOrdFunction(f::AbstractVector, codom::Int) = FinOrdVector(f, codom) function FinOrdFunction(f::AbstractVector, dom::Int, codom::Int) @assert length(f) == dom FinOrdVector(f, codom) end (f::FinOrdVector)(x) = f.func[x] """ Force evaluation of lazy function or relation. """ force(f::FinOrdFunction) = FinOrdVector(map(f, 1:dom(f).n), codom(f).n) force(f::FinOrdVector) = f Base.collect(f::FinOrdFunction) = force(f).func """ Category of finite ordinals and functions. """ @instance Category(FinOrd, FinOrdFunction) begin dom(f::FinOrdFunction) = FinOrd(f.dom) codom(f::FinOrdFunction) = FinOrd(f.codom) id(A::FinOrd) = FinOrdFunction(identity, A, A) function compose(f::FinOrdFunction, g::FinOrdFunction) @assert codom(f) == dom(g) FinOrdFunction(compose_impl(f,g), dom(f), codom(g)) end end dom(f::FinOrdVector) = FinOrd(length(f.func)) compose_impl(f::FinOrdFunction, g::FinOrdFunction) = g ∘ f compose_impl(f::FinOrdVector, g::FinOrdVector) = g.func[f.func] # Limits ######## terminal(::Type{FinOrd}) = FinOrd(1) function product(A::FinOrd, B::FinOrd) m, n = A.n, B.n indices = CartesianIndices((m, n)) π1 = FinOrdFunction(i -> indices[i][1], m*n, m) π2 = FinOrdFunction(i -> indices[i][2], m*n, n) Span(π1, π2) end function product(Xs::Vector{<:FinOrd}) ns = Int[X.n for X in Xs] indices = CartesianIndices(tuple(ns...)) apex = prod(ns) πs = [FinOrdFunction(i -> indices[i][j],apex,ns[j]) for j in 1:length(ns)] Cone(FinOrd(apex),πs) end function equalizer(f::FinOrdFunction, g::FinOrdFunction) @assert dom(f) == dom(g) && codom(f) == codom(g) m = dom(f).n FinOrdFunction(filter(i -> f(i) == g(i), 1:m), m) end function equalizer(fs::Vector{<:FinOrdFunction}) @assert length(fs) >= 1 f1 = fs[1] frest = fs[2:end] @assert all(dom(f) == dom(f1) && codom(f) == codom(f1) for f in frest) m = dom(f1).n FinOrdFunction(filter(i -> all(f1(i) == f(i) for f in frest), 1:m),m) end """ Pullback of cospan of functions between finite ordinals. TODO: This logic is completely generic. Make it independent of FinOrd. """ function pullback(cospan::Cospan{<:FinOrdFunction,<:FinOrdFunction}) f, g = left(cospan), right(cospan) prod = product(dom(f), dom(g)) π1, π2 = left(prod), right(prod) eq = equalizer(π1⋅f, π2⋅g) Span(eq⋅π1, eq⋅π2) end function limit(d::Diagram{<:FinOrd, <:FinOrdFunction}) p = product(d.obs) n = apex(p).n satisfy((s,t,g),x) = g(leg(p,s)(x)) == leg(p,t)(x) f = FinOrdFunction(filter(i -> all(satisfy(h,i) for h in d.homs), 1:n), n) Cone(dom(f),[compose(f,leg(p,i)) for i in 1:length(d.obs)]) end # Colimits ########## initial(::Type{FinOrd}) = FinOrd(0) function coproduct(A::FinOrd, B::FinOrd) m, n = A.n, B.n ι1 = FinOrdFunction(1:m, m, m+n) ι2 = FinOrdFunction(m+1:m+n, n, m+n) Cospan(ι1, ι2) end function coproduct(Xs::Vector{<:FinOrd}) ns = Int[X.n for X in Xs] base = sum(ns) offsets = [0,cumsum(ns)...] πs = [FinOrdFunction((1:ns[j]) .+ offsets[j],ns[j],base) for j in 1:length(ns)] Cocone(FinOrd(base),πs) end function coequalizer(f::FinOrdFunction, g::FinOrdFunction) @assert dom(f) == dom(g) && codom(f) == codom(g) m, n = dom(f).n, codom(f).n sets = IntDisjointSets(n) for i in 1:m union!(sets, f(i), g(i)) end h = [ find_root(sets, i) for i in 1:n ] roots = unique!(sort(h)) FinOrdFunction([ searchsortedfirst(roots, r) for r in h], length(roots)) end function coequalizer(fs::Vector{<:FinOrdFunction}) @assert length(fs) >= 1 f1 = fs[1] frest = fs[2:end] @assert all(dom(f) == dom(f1) && codom(f) == codom(f1) for f in frest) m,n = dom(f1).n, codom(f1).n sets = IntDisjointSets(n) for i in 1:m for f in frest union!(sets, f1(i), f(i)) end end h = [ find_root(sets, i) for i in 1:n ] roots = unique!(sort(h)) FinOrdFunction([searchsortedfirst(roots, r) for r in h], length(roots)) end """ Pushout of span of functions between finite ordinals. TODO: This logic is completely generic. Make it independent of FinOrd. """ function pushout(span::Span{<:FinOrdFunction,<:FinOrdFunction}) f, g = left(span), right(span) coprod = coproduct(codom(f), codom(g)) ι1, ι2 = left(coprod), right(coprod) coeq = coequalizer(f⋅ι1, g⋅ι2) Cospan(ι1⋅coeq, ι2⋅coeq) end function colimit(d::Diagram{<:FinOrd, <:FinOrdFunction}) cp = coproduct(d.obs) n = base(cp).n sets = IntDisjointSets(n) for (s,t,h) in d.homs for i in 1:d.obs[s].n union!(sets,leg(cp,s)(i),leg(cp,t)(h(i))) end end h = [ find_root(sets, i) for i in 1:n ] roots = unique!(sort(h)) m = length(roots) f = FinOrdFunction([searchsortedfirst(roots, r) for r in h], m) Cocone(FinOrd(m),[compose(leg(cp,i),f) for i in 1:length(d.obs)]) end end
[ 37811, 38589, 287, 262, 6536, 286, 27454, 5621, 290, 5499, 11, 290, 663, 18328, 13, 198, 37811, 198, 21412, 4463, 50, 1039, 198, 39344, 4463, 35422, 11, 4463, 35422, 22203, 11, 4463, 35422, 37, 19524, 11, 4463, 35422, 38469, 11, 2700, 11, 198, 220, 12094, 11, 1720, 11, 4961, 7509, 11, 2834, 1891, 11, 4179, 11, 198, 220, 4238, 11, 2243, 2076, 310, 11, 763, 40496, 7509, 11, 4574, 448, 11, 951, 320, 270, 198, 198, 3500, 11160, 26257, 23588, 874, 198, 3500, 6060, 44909, 942, 25, 2558, 7279, 73, 1563, 50, 1039, 11, 6441, 28265, 1064, 62, 15763, 198, 198, 3500, 2644, 38, 1404, 198, 3500, 2644, 464, 1749, 25, 21743, 198, 11748, 2644, 464, 1749, 25, 2401, 11, 14873, 296, 11, 4686, 11, 36664, 11, 2343, 233, 227, 11, 18872, 246, 11, 198, 220, 12094, 11, 1720, 11, 4961, 7509, 11, 4238, 11, 2243, 2076, 310, 11, 763, 40496, 7509, 198, 3500, 11485, 33383, 18683, 6713, 82, 198, 198, 2, 21743, 286, 27454, 2760, 6897, 198, 14468, 7804, 4242, 2, 198, 198, 37811, 4463, 578, 2760, 1292, 357, 11802, 1271, 737, 198, 198, 2025, 2134, 287, 262, 6536, 286, 27454, 2760, 6897, 11, 543, 318, 262, 18328, 286, 262, 198, 22872, 286, 27454, 5621, 13, 198, 37811, 198, 31, 23736, 62, 17831, 62, 4853, 874, 2878, 4463, 35422, 198, 220, 299, 3712, 5317, 198, 437, 198, 198, 37811, 15553, 1022, 5621, 287, 262, 1296, 286, 27454, 2760, 6897, 13, 198, 198, 32, 17488, 1042, 287, 262, 6536, 286, 27454, 2760, 6897, 11, 543, 318, 262, 18328, 286, 262, 198, 22872, 286, 27454, 5621, 13, 383, 2163, 460, 307, 5447, 31821, 416, 281, 14977, 198, 16980, 544, 2163, 11, 287, 543, 1339, 340, 318, 16726, 37296, 813, 11, 393, 1193, 713, 306, 416, 257, 15879, 198, 1659, 37014, 13, 554, 262, 6846, 1339, 11, 262, 2163, 357, 16, 29705, 99, 16, 11, 362, 29705, 99, 18, 11, 513, 29705, 99, 17, 11, 604, 29705, 99, 18, 828, 329, 1672, 11, 198, 271, 7997, 416, 262, 15879, 685, 16, 11, 18, 11, 17, 11, 18, 4083, 198, 37811, 198, 397, 8709, 2099, 4463, 35422, 22203, 886, 198, 198, 18467, 35422, 22203, 7, 69, 11, 2401, 3712, 18467, 35422, 11, 14873, 296, 3712, 18467, 35422, 8, 796, 198, 220, 4463, 35422, 22203, 7, 69, 11, 2401, 13, 77, 11, 14873, 296, 13, 77, 8, 198, 198, 37811, 15553, 287, 4463, 35422, 5447, 416, 281, 14977, 22300, 2163, 13, 198, 198, 2514, 307, 16726, 37296, 813, 4556, 4137, 13, 198, 37811, 198, 31, 23736, 62, 17831, 62, 4853, 874, 2878, 4463, 35422, 37, 19524, 1279, 25, 4463, 35422, 22203, 198, 220, 25439, 3712, 22203, 198, 220, 2401, 3712, 5317, 198, 220, 14873, 296, 3712, 5317, 198, 437, 198, 18467, 35422, 22203, 7, 69, 3712, 22203, 11, 2401, 3712, 5317, 11, 14873, 296, 3712, 5317, 8, 796, 198, 220, 4463, 35422, 37, 19524, 7, 69, 11, 2401, 11, 14873, 296, 8, 198, 198, 7, 69, 3712, 18467, 35422, 37, 19524, 5769, 87, 8, 796, 277, 13, 20786, 7, 87, 8, 198, 198, 37811, 15553, 287, 4463, 35422, 7997, 11777, 416, 257, 15879, 13, 198, 37811, 198, 31, 23736, 62, 17831, 62, 4853, 874, 2878, 4463, 35422, 38469, 90, 51, 27, 25, 23839, 38469, 90, 5317, 11709, 1279, 25, 4463, 35422, 22203, 198, 220, 25439, 3712, 51, 198, 220, 14873, 296, 3712, 5317, 198, 437, 198, 18467, 35422, 22203, 7, 69, 3712, 23839, 38469, 8, 796, 4463, 35422, 38469, 7, 69, 11, 5415, 7, 69, 4008, 198, 18467, 35422, 22203, 7, 69, 3712, 23839, 38469, 11, 14873, 296, 3712, 5317, 8, 796, 4463, 35422, 38469, 7, 69, 11, 14873, 296, 8, 198, 198, 8818, 4463, 35422, 22203, 7, 69, 3712, 23839, 38469, 11, 2401, 3712, 5317, 11, 14873, 296, 3712, 5317, 8, 198, 220, 2488, 30493, 4129, 7, 69, 8, 6624, 2401, 198, 220, 4463, 35422, 38469, 7, 69, 11, 14873, 296, 8, 198, 437, 198, 198, 7, 69, 3712, 18467, 35422, 38469, 5769, 87, 8, 796, 277, 13, 20786, 58, 87, 60, 198, 198, 37811, 5221, 12660, 286, 16931, 2163, 393, 8695, 13, 198, 37811, 198, 3174, 7, 69, 3712, 18467, 35422, 22203, 8, 796, 4463, 35422, 38469, 7, 8899, 7, 69, 11, 352, 25, 3438, 7, 69, 737, 77, 828, 14873, 296, 7, 69, 737, 77, 8, 198, 3174, 7, 69, 3712, 18467, 35422, 38469, 8, 796, 277, 198, 198, 14881, 13, 33327, 7, 69, 3712, 18467, 35422, 22203, 8, 796, 2700, 7, 69, 737, 20786, 198, 198, 37811, 21743, 286, 27454, 2760, 6897, 290, 5499, 13, 198, 37811, 198, 31, 39098, 21743, 7, 18467, 35422, 11, 4463, 35422, 22203, 8, 2221, 198, 220, 2401, 7, 69, 3712, 18467, 35422, 22203, 8, 796, 4463, 35422, 7, 69, 13, 3438, 8, 198, 220, 14873, 296, 7, 69, 3712, 18467, 35422, 22203, 8, 796, 4463, 35422, 7, 69, 13, 19815, 296, 8, 198, 220, 220, 198, 220, 4686, 7, 32, 3712, 18467, 35422, 8, 796, 4463, 35422, 22203, 7, 738, 414, 11, 317, 11, 317, 8, 198, 220, 220, 198, 220, 2163, 36664, 7, 69, 3712, 18467, 35422, 22203, 11, 308, 3712, 18467, 35422, 22203, 8, 198, 220, 220, 220, 2488, 30493, 14873, 296, 7, 69, 8, 6624, 2401, 7, 70, 8, 198, 220, 220, 220, 4463, 35422, 22203, 7, 785, 3455, 62, 23928, 7, 69, 11, 70, 828, 2401, 7, 69, 828, 14873, 296, 7, 70, 4008, 198, 220, 886, 198, 437, 198, 198, 3438, 7, 69, 3712, 18467, 35422, 38469, 8, 796, 4463, 35422, 7, 13664, 7, 69, 13, 20786, 4008, 198, 785, 3455, 62, 23928, 7, 69, 3712, 18467, 35422, 22203, 11, 308, 3712, 18467, 35422, 22203, 8, 796, 308, 18872, 246, 277, 198, 785, 3455, 62, 23928, 7, 69, 3712, 18467, 35422, 38469, 11, 308, 3712, 18467, 35422, 38469, 8, 796, 308, 13, 20786, 58, 69, 13, 20786, 60, 198, 198, 2, 44943, 198, 7804, 198, 198, 23705, 282, 7, 3712, 6030, 90, 18467, 35422, 30072, 796, 4463, 35422, 7, 16, 8, 198, 198, 8818, 1720, 7, 32, 3712, 18467, 35422, 11, 347, 3712, 18467, 35422, 8, 198, 220, 285, 11, 299, 796, 317, 13, 77, 11, 347, 13, 77, 198, 220, 36525, 796, 13690, 35610, 5497, 1063, 19510, 76, 11, 299, 4008, 198, 220, 18074, 222, 16, 796, 4463, 35422, 22203, 7, 72, 4613, 36525, 58, 72, 7131, 16, 4357, 285, 9, 77, 11, 285, 8, 198, 220, 18074, 222, 17, 796, 4463, 35422, 22203, 7, 72, 4613, 36525, 58, 72, 7131, 17, 4357, 285, 9, 77, 11, 299, 8, 198, 220, 49101, 7, 46582, 16, 11, 18074, 222, 17, 8, 198, 437, 198, 198, 8818, 1720, 7, 55, 82, 3712, 38469, 90, 27, 25, 18467, 35422, 30072, 198, 220, 36545, 796, 2558, 58, 55, 13, 77, 329, 1395, 287, 1395, 82, 60, 198, 220, 36525, 796, 13690, 35610, 5497, 1063, 7, 83, 29291, 7, 5907, 986, 4008, 198, 220, 40167, 796, 40426, 7, 5907, 8, 198, 220, 18074, 222, 82, 796, 685, 18467, 35422, 22203, 7, 72, 4613, 36525, 58, 72, 7131, 73, 4357, 1758, 87, 11, 5907, 58, 73, 12962, 329, 474, 287, 352, 25, 13664, 7, 5907, 15437, 198, 220, 327, 505, 7, 18467, 35422, 7, 1758, 87, 828, 46582, 82, 8, 198, 437, 198, 198, 8818, 4961, 7509, 7, 69, 3712, 18467, 35422, 22203, 11, 308, 3712, 18467, 35422, 22203, 8, 198, 220, 2488, 30493, 2401, 7, 69, 8, 6624, 2401, 7, 70, 8, 11405, 14873, 296, 7, 69, 8, 6624, 14873, 296, 7, 70, 8, 198, 220, 285, 796, 2401, 7, 69, 737, 77, 198, 220, 4463, 35422, 22203, 7, 24455, 7, 72, 4613, 277, 7, 72, 8, 6624, 308, 7, 72, 828, 352, 25, 76, 828, 285, 8, 198, 437, 198, 198, 8818, 4961, 7509, 7, 9501, 3712, 38469, 90, 27, 25, 18467, 35422, 22203, 30072, 198, 220, 2488, 30493, 4129, 7, 9501, 8, 18189, 352, 198, 220, 277, 16, 796, 43458, 58, 16, 60, 198, 220, 2030, 301, 796, 43458, 58, 17, 25, 437, 60, 198, 220, 2488, 30493, 477, 7, 3438, 7, 69, 8, 6624, 2401, 7, 69, 16, 8, 11405, 14873, 296, 7, 69, 8, 6624, 14873, 296, 7, 69, 16, 8, 329, 277, 287, 2030, 301, 8, 198, 220, 285, 796, 2401, 7, 69, 16, 737, 77, 198, 220, 4463, 35422, 22203, 7, 24455, 7, 72, 4613, 477, 7, 69, 16, 7, 72, 8, 6624, 277, 7, 72, 8, 329, 277, 287, 2030, 301, 828, 352, 25, 76, 828, 76, 8, 198, 437, 198, 198, 37811, 21429, 1891, 286, 269, 2117, 272, 286, 5499, 1022, 27454, 2760, 6897, 13, 198, 198, 51, 3727, 46, 25, 770, 9156, 318, 3190, 14276, 13, 6889, 340, 4795, 286, 4463, 35422, 13, 198, 37811, 198, 8818, 2834, 1891, 7, 66, 2117, 272, 3712, 34, 2117, 272, 90, 27, 25, 18467, 35422, 22203, 11, 27, 25, 18467, 35422, 22203, 30072, 198, 220, 277, 11, 308, 796, 1364, 7, 66, 2117, 272, 828, 826, 7, 66, 2117, 272, 8, 198, 220, 40426, 796, 1720, 7, 3438, 7, 69, 828, 2401, 7, 70, 4008, 198, 220, 18074, 222, 16, 11, 18074, 222, 17, 796, 1364, 7, 1676, 67, 828, 826, 7, 1676, 67, 8, 198, 220, 37430, 796, 4961, 7509, 7, 46582, 16, 158, 233, 227, 69, 11, 18074, 222, 17, 158, 233, 227, 70, 8, 198, 220, 49101, 7, 27363, 158, 233, 227, 46582, 16, 11, 37430, 158, 233, 227, 46582, 17, 8, 198, 437, 198, 198, 8818, 4179, 7, 67, 3712, 18683, 6713, 90, 27, 25, 18467, 35422, 11, 1279, 25, 18467, 35422, 22203, 30072, 198, 220, 279, 796, 1720, 7, 67, 13, 8158, 8, 198, 220, 299, 796, 40167, 7, 79, 737, 77, 198, 220, 15959, 19510, 82, 11, 83, 11, 70, 828, 87, 8, 796, 308, 7, 1455, 7, 79, 11, 82, 5769, 87, 4008, 6624, 1232, 7, 79, 11, 83, 5769, 87, 8, 198, 220, 277, 796, 4463, 35422, 22203, 7, 24455, 7, 72, 4613, 477, 7, 82, 17403, 88, 7, 71, 11, 72, 8, 329, 289, 287, 288, 13, 71, 3150, 828, 352, 25, 77, 828, 299, 8, 198, 220, 327, 505, 7, 3438, 7, 69, 828, 58, 785, 3455, 7, 69, 11, 1455, 7, 79, 11, 72, 4008, 329, 1312, 287, 352, 25, 13664, 7, 67, 13, 8158, 8, 12962, 198, 437, 628, 198, 2, 1623, 320, 896, 198, 7804, 2235, 198, 198, 36733, 7, 3712, 6030, 90, 18467, 35422, 30072, 796, 4463, 35422, 7, 15, 8, 198, 198, 8818, 2243, 2076, 310, 7, 32, 3712, 18467, 35422, 11, 347, 3712, 18467, 35422, 8, 198, 220, 285, 11, 299, 796, 317, 13, 77, 11, 347, 13, 77, 198, 220, 7377, 117, 16, 796, 4463, 35422, 22203, 7, 16, 25, 76, 11, 285, 11, 285, 10, 77, 8, 198, 220, 7377, 117, 17, 796, 4463, 35422, 22203, 7, 76, 10, 16, 25, 76, 10, 77, 11, 299, 11, 285, 10, 77, 8, 198, 220, 327, 2117, 272, 7, 29945, 16, 11, 7377, 117, 17, 8, 198, 437, 198, 198, 8818, 2243, 2076, 310, 7, 55, 82, 3712, 38469, 90, 27, 25, 18467, 35422, 30072, 198, 220, 36545, 796, 2558, 58, 55, 13, 77, 329, 1395, 287, 1395, 82, 60, 198, 220, 2779, 796, 2160, 7, 5907, 8, 198, 220, 49005, 796, 685, 15, 11, 66, 5700, 388, 7, 5907, 8, 22345, 198, 220, 18074, 222, 82, 796, 685, 18467, 35422, 22203, 19510, 16, 25, 5907, 58, 73, 12962, 764, 10, 49005, 58, 73, 4357, 5907, 58, 73, 4357, 8692, 8, 329, 474, 287, 352, 25, 13664, 7, 5907, 15437, 198, 220, 18490, 505, 7, 18467, 35422, 7, 8692, 828, 46582, 82, 8, 198, 437, 198, 198, 8818, 763, 40496, 7509, 7, 69, 3712, 18467, 35422, 22203, 11, 308, 3712, 18467, 35422, 22203, 8, 198, 220, 2488, 30493, 2401, 7, 69, 8, 6624, 2401, 7, 70, 8, 11405, 14873, 296, 7, 69, 8, 6624, 14873, 296, 7, 70, 8, 198, 220, 285, 11, 299, 796, 2401, 7, 69, 737, 77, 11, 14873, 296, 7, 69, 737, 77, 198, 220, 5621, 796, 2558, 7279, 73, 1563, 50, 1039, 7, 77, 8, 198, 220, 329, 1312, 287, 352, 25, 76, 198, 220, 220, 220, 6441, 0, 7, 28709, 11, 277, 7, 72, 828, 308, 7, 72, 4008, 198, 220, 886, 198, 220, 289, 796, 685, 1064, 62, 15763, 7, 28709, 11, 1312, 8, 329, 1312, 287, 352, 25, 77, 2361, 198, 220, 11135, 796, 3748, 0, 7, 30619, 7, 71, 4008, 198, 220, 4463, 35422, 22203, 26933, 2989, 82, 9741, 11085, 7, 19150, 11, 374, 8, 329, 374, 287, 289, 4357, 4129, 7, 19150, 4008, 198, 437, 198, 198, 8818, 763, 40496, 7509, 7, 9501, 3712, 38469, 90, 27, 25, 18467, 35422, 22203, 30072, 198, 220, 2488, 30493, 4129, 7, 9501, 8, 18189, 352, 198, 220, 277, 16, 796, 43458, 58, 16, 60, 198, 220, 2030, 301, 796, 43458, 58, 17, 25, 437, 60, 198, 220, 2488, 30493, 477, 7, 3438, 7, 69, 8, 6624, 2401, 7, 69, 16, 8, 11405, 14873, 296, 7, 69, 8, 6624, 14873, 296, 7, 69, 16, 8, 329, 277, 287, 2030, 301, 8, 198, 220, 285, 11, 77, 796, 2401, 7, 69, 16, 737, 77, 11, 14873, 296, 7, 69, 16, 737, 77, 198, 220, 5621, 796, 2558, 7279, 73, 1563, 50, 1039, 7, 77, 8, 198, 220, 329, 1312, 287, 352, 25, 76, 198, 220, 220, 220, 329, 277, 287, 2030, 301, 198, 220, 220, 220, 220, 220, 6441, 0, 7, 28709, 11, 277, 16, 7, 72, 828, 277, 7, 72, 4008, 198, 220, 220, 220, 886, 198, 220, 886, 198, 220, 289, 796, 685, 1064, 62, 15763, 7, 28709, 11, 1312, 8, 329, 1312, 287, 352, 25, 77, 2361, 198, 220, 11135, 796, 3748, 0, 7, 30619, 7, 71, 4008, 198, 220, 4463, 35422, 22203, 26933, 12947, 82, 9741, 11085, 7, 19150, 11, 374, 8, 329, 374, 287, 289, 4357, 4129, 7, 19150, 4008, 198, 437, 198, 198, 37811, 23691, 448, 286, 11506, 286, 5499, 1022, 27454, 2760, 6897, 13, 198, 198, 51, 3727, 46, 25, 770, 9156, 318, 3190, 14276, 13, 6889, 340, 4795, 286, 4463, 35422, 13, 198, 37811, 198, 8818, 4574, 448, 7, 12626, 3712, 4561, 272, 90, 27, 25, 18467, 35422, 22203, 11, 27, 25, 18467, 35422, 22203, 30072, 198, 220, 277, 11, 308, 796, 1364, 7, 12626, 828, 826, 7, 12626, 8, 198, 220, 2243, 14892, 796, 2243, 2076, 310, 7, 19815, 296, 7, 69, 828, 14873, 296, 7, 70, 4008, 198, 220, 7377, 117, 16, 11, 7377, 117, 17, 796, 1364, 7, 22163, 14892, 828, 826, 7, 22163, 14892, 8, 198, 220, 763, 27363, 796, 763, 40496, 7509, 7, 69, 158, 233, 227, 29945, 16, 11, 308, 158, 233, 227, 29945, 17, 8, 198, 220, 327, 2117, 272, 7, 29945, 16, 158, 233, 227, 1073, 27363, 11, 7377, 117, 17, 158, 233, 227, 1073, 27363, 8, 198, 437, 198, 198, 8818, 951, 320, 270, 7, 67, 3712, 18683, 6713, 90, 27, 25, 18467, 35422, 11, 1279, 25, 18467, 35422, 22203, 30072, 198, 220, 31396, 796, 2243, 2076, 310, 7, 67, 13, 8158, 8, 198, 220, 299, 796, 2779, 7, 13155, 737, 77, 198, 220, 5621, 796, 2558, 7279, 73, 1563, 50, 1039, 7, 77, 8, 198, 220, 329, 357, 82, 11, 83, 11, 71, 8, 287, 288, 13, 71, 3150, 198, 220, 220, 220, 329, 1312, 287, 352, 25, 67, 13, 8158, 58, 82, 4083, 77, 198, 220, 220, 220, 220, 220, 6441, 0, 7, 28709, 11, 1455, 7, 13155, 11, 82, 5769, 72, 828, 1455, 7, 13155, 11, 83, 5769, 71, 7, 72, 22305, 198, 220, 220, 220, 886, 198, 220, 886, 198, 220, 289, 796, 685, 1064, 62, 15763, 7, 28709, 11, 1312, 8, 329, 1312, 287, 352, 25, 77, 2361, 198, 220, 11135, 796, 3748, 0, 7, 30619, 7, 71, 4008, 198, 220, 285, 796, 4129, 7, 19150, 8, 198, 220, 277, 796, 4463, 35422, 22203, 26933, 12947, 82, 9741, 11085, 7, 19150, 11, 374, 8, 329, 374, 287, 289, 4357, 285, 8, 198, 220, 18490, 505, 7, 18467, 35422, 7, 76, 828, 58, 785, 3455, 7, 1455, 7, 13155, 11, 72, 828, 69, 8, 329, 1312, 287, 352, 25, 13664, 7, 67, 13, 8158, 8, 12962, 198, 437, 198, 198, 437, 198 ]
2.456271
2,687
import NMRDataSetup import NMRSpectraSimulator import NMRSpecifyRegions include("../src/NMRCalibrate.jl") import .NMRCalibrate using LinearAlgebra using FFTW import PyPlot import BSON import JLD #import Clustering import Statistics import Random include("./helpers/final_helpers.jl") include("./helpers/solute_calibrate.jl") include("./helpers/loop_entries1.jl") PyPlot.close("all") fig_num = 1 Random.seed!(25) PyPlot.matplotlib["rcParams"][:update](["font.size" => 22, "font.family" => "serif"]) p_set = Vector{String}(undef, 0) m_set = Vector{Vector{String}}(undef, 0) w_set = Vector{Vector{Float64}}(undef, 0) #setupcalibrateserine!(p_set, m_set, w_set) setupcalibrateentries1!(p_set, m_set, w_set) #setupcalibrateentriesNamJan2022!(p_set, m_set, w_set) projects_dir = "/home/roy/MEGAsync/outputs/NMR/calibrate/final" base_path_JLD = "/home/roy/Documents/repo/NMRData//src/input/molecules" cs_config_path = "/home/roy/Documents/repo/NMRData/src/input/reduced_cs_config.txt" function loopscript(p_name_set, m_names_set, w_set, max_iters, projects_dir, base_path_JLD, cs_config_path) for i = 1:length(p_name_set) project_name = p_name_set[i] molecule_names = m_names_set[i] w = w_set[i] calibratesolute(project_name, molecule_names, w; max_iters = max_iters, projects_dir = projects_dir, base_path_JLD = base_path_JLD, cs_config_path = cs_config_path) println() end end ### batch. max_iters = 50000 loopscript(p_set, m_set, w_set, max_iters, projects_dir, base_path_JLD, cs_config_path) ### end batch. # #### singular. # # project_name = "Nam2022_Serine" # # molecule_names = ["D-(+)-Glucose"; "L-Serine";] # # w = [1.0; 1.0] # # # println("Now on $(project_name)") # max_iters = 50000 # #max_iters = 5 # include("solute_calibrate.jl") # println() # ### end singular.
[ 198, 11748, 399, 13599, 6601, 40786, 198, 11748, 28692, 6998, 806, 430, 8890, 8927, 198, 11748, 399, 13599, 22882, 1958, 8081, 507, 198, 198, 17256, 7203, 40720, 10677, 14, 32755, 7397, 282, 2889, 378, 13, 20362, 4943, 198, 11748, 764, 32755, 7397, 282, 2889, 378, 198, 198, 3500, 44800, 2348, 29230, 198, 3500, 376, 9792, 54, 198, 11748, 9485, 43328, 198, 11748, 347, 11782, 198, 11748, 449, 11163, 198, 198, 2, 11748, 1012, 436, 1586, 198, 11748, 14370, 198, 11748, 14534, 198, 198, 17256, 7, 1911, 14, 16794, 364, 14, 20311, 62, 16794, 364, 13, 20362, 4943, 198, 17256, 7, 1911, 14, 16794, 364, 14, 82, 3552, 62, 9948, 2889, 378, 13, 20362, 4943, 198, 17256, 7, 1911, 14, 16794, 364, 14, 26268, 62, 298, 1678, 16, 13, 20362, 4943, 198, 198, 20519, 43328, 13, 19836, 7203, 439, 4943, 198, 5647, 62, 22510, 796, 352, 198, 198, 29531, 13, 28826, 0, 7, 1495, 8, 198, 20519, 43328, 13, 6759, 29487, 8019, 14692, 6015, 10044, 4105, 1, 7131, 25, 19119, 16151, 14692, 10331, 13, 7857, 1, 5218, 2534, 11, 366, 10331, 13, 17989, 1, 5218, 366, 2655, 361, 8973, 8, 628, 198, 79, 62, 2617, 796, 20650, 90, 10100, 92, 7, 917, 891, 11, 657, 8, 198, 76, 62, 2617, 796, 20650, 90, 38469, 90, 10100, 11709, 7, 917, 891, 11, 657, 8, 198, 86, 62, 2617, 796, 20650, 90, 38469, 90, 43879, 2414, 11709, 7, 917, 891, 11, 657, 8, 198, 198, 2, 40406, 9948, 2889, 689, 263, 500, 0, 7, 79, 62, 2617, 11, 285, 62, 2617, 11, 266, 62, 2617, 8, 198, 40406, 9948, 2889, 378, 298, 1678, 16, 0, 7, 79, 62, 2617, 11, 285, 62, 2617, 11, 266, 62, 2617, 8, 198, 2, 40406, 9948, 2889, 378, 298, 1678, 45, 321, 12128, 1238, 1828, 0, 7, 79, 62, 2617, 11, 285, 62, 2617, 11, 266, 62, 2617, 8, 198, 198, 42068, 62, 15908, 796, 12813, 11195, 14, 3287, 14, 44, 7156, 42367, 14, 22915, 82, 14, 45, 13599, 14, 9948, 2889, 378, 14, 20311, 1, 198, 8692, 62, 6978, 62, 41, 11163, 796, 12813, 11195, 14, 3287, 14, 38354, 14, 260, 7501, 14, 45, 13599, 6601, 1003, 10677, 14, 15414, 14, 76, 2305, 13930, 1, 198, 6359, 62, 11250, 62, 6978, 796, 12813, 11195, 14, 3287, 14, 38354, 14, 260, 7501, 14, 45, 13599, 6601, 14, 10677, 14, 15414, 14, 445, 19513, 62, 6359, 62, 11250, 13, 14116, 1, 198, 198, 8818, 9052, 12048, 7, 79, 62, 3672, 62, 2617, 11, 285, 62, 14933, 62, 2617, 11, 266, 62, 2617, 11, 198, 220, 220, 220, 3509, 62, 270, 364, 11, 4493, 62, 15908, 11, 2779, 62, 6978, 62, 41, 11163, 11, 50115, 62, 11250, 62, 6978, 8, 628, 220, 220, 220, 329, 1312, 796, 352, 25, 13664, 7, 79, 62, 3672, 62, 2617, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1628, 62, 3672, 796, 279, 62, 3672, 62, 2617, 58, 72, 60, 198, 220, 220, 220, 220, 220, 220, 220, 27756, 62, 14933, 796, 285, 62, 14933, 62, 2617, 58, 72, 60, 198, 220, 220, 220, 220, 220, 220, 220, 266, 796, 266, 62, 2617, 58, 72, 60, 628, 220, 220, 220, 220, 220, 220, 220, 33801, 689, 3552, 7, 16302, 62, 3672, 11, 27756, 62, 14933, 11, 266, 26, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3509, 62, 270, 364, 796, 3509, 62, 270, 364, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4493, 62, 15908, 796, 4493, 62, 15908, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2779, 62, 6978, 62, 41, 11163, 796, 2779, 62, 6978, 62, 41, 11163, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 50115, 62, 11250, 62, 6978, 796, 50115, 62, 11250, 62, 6978, 8, 628, 220, 220, 220, 220, 220, 220, 220, 44872, 3419, 198, 220, 220, 220, 886, 198, 198, 437, 628, 198, 21017, 15458, 13, 198, 9806, 62, 270, 364, 796, 642, 2388, 198, 26268, 12048, 7, 79, 62, 2617, 11, 285, 62, 2617, 11, 266, 62, 2617, 11, 3509, 62, 270, 364, 11, 4493, 62, 15908, 11, 2779, 62, 6978, 62, 41, 11163, 11, 50115, 62, 11250, 62, 6978, 8, 198, 21017, 886, 15458, 13, 198, 198, 2, 1303, 21017, 18032, 13, 198, 2, 1303, 1628, 62, 3672, 796, 366, 45, 321, 1238, 1828, 62, 7089, 500, 1, 198, 2, 1303, 27756, 62, 14933, 796, 14631, 35, 30420, 10, 13219, 9861, 1229, 577, 8172, 366, 43, 12, 7089, 500, 8172, 60, 198, 2, 1303, 266, 796, 685, 16, 13, 15, 26, 352, 13, 15, 60, 1303, 198, 2, 198, 2, 44872, 7203, 3844, 319, 29568, 16302, 62, 3672, 8, 4943, 198, 2, 3509, 62, 270, 364, 796, 642, 2388, 198, 2, 1303, 9806, 62, 270, 364, 796, 642, 198, 2, 2291, 7203, 82, 3552, 62, 9948, 2889, 378, 13, 20362, 4943, 198, 2, 44872, 3419, 198, 2, 44386, 886, 18032, 13, 198 ]
2.278649
829
using Flux using DiffEqSensitivity using DifferentialEquations using LinearAlgebra using Statistics using Distributions using Plots using Random # set random seed for reproducible results Random.seed!(1) ## ----- setup true solution ------------------------------------ # define function for RHS of lorenz system function lorenz!(du, u, p, t) x,y,z = u σ,ρ,β = p du[1] = σ*(y - x) du[2] = x*(ρ - z) - y du[3] = x*y - β*z end θ = [10.0, 28.0, (8/3)] # true parameter values dt = 0.01 # time step for simulation (this may be unnecessary) tend = 10.0 # max time for total simulation ts_sim = (0.0, tend) u0True = [1.0, 1.0, 1.0] # true initial condition # integrate to obtain the true solution prob_true = ODEProblem(lorenz!, u0True, ts_sim, θ, saveat=dt) sol_true = solve(prob_true) ## ----- setup observation data ------------------------------------ # set up observation uncertainties σ_m = 0.15 # i.e. observation std # set up observation error covariance matrix R = σ_m^2 .* I(3) # set up details for measurement points dt_m = 0.2 tm_end = 2.0 # final observation time ts_m = dt_m:dt_m:tm_end # define observation operator function h(u) w = u return w end # populate observation vector w = hcat([h(sol_true(tᵢ))+rand(MvNormal(zeros(3), R)) for tᵢ ∈ ts_m]...) ## ----- perform the assimilation ------------------------------------ # initial condition guess u0a = [2.0, 3.0, 4.0] # set up problem for (bad) forecast prob = ODEProblem(lorenz!, u0a, (0.0,tend), θ) sol_forecast = solve(prob) function timeindex(t, Δt) return Int(round(t/Δt)) + 1 end # for some reason I need to collect the matrices first Rinv = collect(inv(R)) u0b = copy(u0a) σ_b = 0.1 # model error std B = σ_b^2 .* I(3) # initial model error covariance Binv = collect(inv(B)) function loss() res = Array(solve(ODEProblem(lorenz!, u0a, (0.0,tm_end), θ), saveat=dt_m:dt_m:tm_end)) # ℓ = 0.5*(u0a-u0b)'*Binv*(u0a-u0b) + 0.5*sum((w[:,i]-h(res[:,i]))'*Rinv*(w[:,i]-h(res[:,i])) for i ∈ 1:size(res,2)) ℓ = 0.5*sum((w[:,i]-h(res[:,i]))'*Rinv*(w[:,i]-h(res[:,i])) for i ∈ 1:size(res,2)) return ℓ end u0a = [2.0, 3.0, 4.0] loss() # let's do the optimization data = Iterators.repeated((), 500) opt = ADAM(0.1) cb = function () display(loss()) end Flux.train!(loss, Flux.params(u0a), data, opt, cb=cb) u0a prob = ODEProblem(lorenz!, u0a, (0.0, tend), θ) sol_analysis = solve(prob) var_names = ["x(t)", "y(t)", "z(t)"] plots = [] for i ∈ 1:3 p = plot(sol_true, vars=(0,i), color=:black, alpha=0.75, linewidth=2, label="true system") plot!(p, ts_m, w[i, :], seriestype=:scatter, color="light green", label="observation" ) plot!(p, sol_forecast, vars=(0, i), linestyle=:dashdot, color="purple", label="forecast") plot!(p, sol_analysis, vars=(0,i), color="royal blue", alpha=1, linewidth = 1, label="analysis") xlabel!(p, "t") ylabel!(p, var_names[i]) push!(plots, p) end plot(plots..., layout=(3,1)) savefig("4dvar_using_flux.svg") savefig("4dvar_using_flux.png")
[ 3500, 1610, 2821, 198, 3500, 10631, 36, 80, 50, 40545, 198, 3500, 20615, 498, 23588, 602, 198, 3500, 44800, 2348, 29230, 198, 3500, 14370, 198, 3500, 46567, 507, 198, 3500, 1345, 1747, 198, 3500, 14534, 198, 198, 2, 900, 4738, 9403, 329, 8186, 37369, 2482, 198, 29531, 13, 28826, 0, 7, 16, 8, 628, 198, 198, 2235, 37404, 9058, 2081, 4610, 20368, 650, 628, 198, 2, 8160, 2163, 329, 371, 7998, 286, 24044, 27305, 1080, 198, 8818, 24044, 27305, 0, 7, 646, 11, 334, 11, 279, 11, 256, 8, 198, 220, 220, 220, 2124, 11, 88, 11, 89, 796, 334, 198, 220, 220, 220, 18074, 225, 11, 33643, 11, 26638, 796, 279, 628, 220, 220, 220, 7043, 58, 16, 60, 796, 18074, 225, 9, 7, 88, 532, 2124, 8, 198, 220, 220, 220, 7043, 58, 17, 60, 796, 2124, 9, 7, 33643, 532, 1976, 8, 532, 331, 198, 220, 220, 220, 7043, 58, 18, 60, 796, 2124, 9, 88, 532, 27169, 9, 89, 198, 437, 198, 198, 138, 116, 796, 685, 940, 13, 15, 11, 2579, 13, 15, 11, 357, 23, 14, 18, 15437, 220, 1303, 2081, 11507, 3815, 198, 28664, 796, 657, 13, 486, 220, 1303, 640, 2239, 329, 18640, 357, 5661, 743, 307, 13114, 8, 198, 83, 437, 796, 838, 13, 15, 220, 1303, 3509, 640, 329, 2472, 18640, 198, 912, 62, 14323, 796, 357, 15, 13, 15, 11, 4327, 8, 198, 84, 15, 17821, 796, 685, 16, 13, 15, 11, 352, 13, 15, 11, 352, 13, 15, 60, 220, 1303, 2081, 4238, 4006, 198, 198, 2, 19386, 284, 7330, 262, 2081, 4610, 198, 1676, 65, 62, 7942, 796, 440, 7206, 40781, 7, 31131, 27305, 28265, 334, 15, 17821, 11, 40379, 62, 14323, 11, 7377, 116, 11, 3613, 265, 28, 28664, 8, 198, 34453, 62, 7942, 796, 8494, 7, 1676, 65, 62, 7942, 8, 628, 198, 198, 2235, 37404, 9058, 13432, 1366, 20368, 650, 198, 198, 2, 900, 510, 13432, 36553, 198, 38392, 62, 76, 796, 657, 13, 1314, 220, 1303, 1312, 13, 68, 13, 13432, 14367, 198, 2, 900, 510, 13432, 4049, 44829, 590, 17593, 198, 49, 796, 18074, 225, 62, 76, 61, 17, 764, 9, 314, 7, 18, 8, 198, 198, 2, 900, 510, 3307, 329, 15558, 2173, 198, 28664, 62, 76, 796, 657, 13, 17, 198, 17209, 62, 437, 796, 362, 13, 15, 220, 1303, 2457, 13432, 640, 198, 912, 62, 76, 796, 288, 83, 62, 76, 25, 28664, 62, 76, 25, 17209, 62, 437, 198, 198, 2, 8160, 13432, 10088, 198, 8818, 289, 7, 84, 8, 198, 220, 220, 220, 266, 796, 334, 198, 220, 220, 220, 1441, 266, 198, 437, 628, 198, 2, 48040, 13432, 15879, 198, 86, 796, 289, 9246, 26933, 71, 7, 34453, 62, 7942, 7, 83, 39611, 95, 4008, 10, 25192, 7, 44, 85, 26447, 7, 9107, 418, 7, 18, 828, 371, 4008, 329, 256, 39611, 95, 18872, 230, 40379, 62, 76, 60, 23029, 628, 198, 198, 2235, 37404, 1620, 262, 840, 42963, 20368, 650, 198, 198, 2, 4238, 4006, 4724, 198, 84, 15, 64, 796, 685, 17, 13, 15, 11, 513, 13, 15, 11, 604, 13, 15, 60, 198, 198, 2, 900, 510, 1917, 329, 357, 14774, 8, 11092, 198, 1676, 65, 796, 440, 7206, 40781, 7, 31131, 27305, 28265, 334, 15, 64, 11, 357, 15, 13, 15, 11, 83, 437, 828, 7377, 116, 8, 198, 34453, 62, 754, 2701, 796, 8494, 7, 1676, 65, 8, 628, 628, 198, 8818, 640, 9630, 7, 83, 11, 37455, 83, 8, 198, 220, 220, 220, 1441, 2558, 7, 744, 7, 83, 14, 138, 242, 83, 4008, 1343, 352, 198, 437, 628, 198, 198, 2, 329, 617, 1738, 314, 761, 284, 2824, 262, 2603, 45977, 717, 198, 49, 16340, 796, 2824, 7, 16340, 7, 49, 4008, 198, 84, 15, 65, 796, 4866, 7, 84, 15, 64, 8, 198, 38392, 62, 65, 796, 657, 13, 16, 220, 1303, 2746, 4049, 14367, 198, 33, 796, 18074, 225, 62, 65, 61, 17, 764, 9, 314, 7, 18, 8, 220, 1303, 4238, 2746, 4049, 44829, 590, 198, 33, 16340, 796, 2824, 7, 16340, 7, 33, 4008, 198, 198, 8818, 2994, 3419, 198, 220, 220, 220, 581, 796, 15690, 7, 82, 6442, 7, 16820, 40781, 7, 31131, 27305, 28265, 334, 15, 64, 11, 357, 15, 13, 15, 11, 17209, 62, 437, 828, 7377, 116, 828, 3613, 265, 28, 28664, 62, 76, 25, 28664, 62, 76, 25, 17209, 62, 437, 4008, 198, 220, 220, 220, 1303, 2343, 226, 241, 796, 657, 13, 20, 9, 7, 84, 15, 64, 12, 84, 15, 65, 33047, 9, 33, 16340, 9, 7, 84, 15, 64, 12, 84, 15, 65, 8, 1343, 657, 13, 20, 9, 16345, 19510, 86, 58, 45299, 72, 45297, 71, 7, 411, 58, 45299, 72, 60, 4008, 6, 9, 49, 16340, 9, 7, 86, 58, 45299, 72, 45297, 71, 7, 411, 58, 45299, 72, 60, 4008, 329, 1312, 18872, 230, 352, 25, 7857, 7, 411, 11, 17, 4008, 198, 220, 220, 220, 2343, 226, 241, 796, 657, 13, 20, 9, 16345, 19510, 86, 58, 45299, 72, 45297, 71, 7, 411, 58, 45299, 72, 60, 4008, 6, 9, 49, 16340, 9, 7, 86, 58, 45299, 72, 45297, 71, 7, 411, 58, 45299, 72, 60, 4008, 329, 1312, 18872, 230, 352, 25, 7857, 7, 411, 11, 17, 4008, 198, 220, 220, 220, 1441, 2343, 226, 241, 198, 437, 628, 198, 84, 15, 64, 796, 685, 17, 13, 15, 11, 513, 13, 15, 11, 604, 13, 15, 60, 198, 22462, 3419, 198, 198, 2, 1309, 338, 466, 262, 23989, 198, 7890, 796, 40806, 2024, 13, 45956, 515, 19510, 828, 5323, 8, 198, 8738, 796, 5984, 2390, 7, 15, 13, 16, 8, 198, 198, 21101, 796, 2163, 7499, 198, 220, 220, 220, 3359, 7, 22462, 28955, 198, 437, 198, 198, 37, 22564, 13, 27432, 0, 7, 22462, 11, 1610, 2821, 13, 37266, 7, 84, 15, 64, 828, 1366, 11, 2172, 11, 269, 65, 28, 21101, 8, 628, 198, 84, 15, 64, 198, 198, 1676, 65, 796, 440, 7206, 40781, 7, 31131, 27305, 28265, 334, 15, 64, 11, 357, 15, 13, 15, 11, 4327, 828, 7377, 116, 8, 198, 34453, 62, 20930, 796, 8494, 7, 1676, 65, 8, 628, 198, 198, 7785, 62, 14933, 796, 14631, 87, 7, 83, 42501, 366, 88, 7, 83, 42501, 366, 89, 7, 83, 8, 8973, 198, 489, 1747, 796, 17635, 198, 1640, 1312, 18872, 230, 352, 25, 18, 198, 220, 220, 220, 279, 796, 7110, 7, 34453, 62, 7942, 11, 410, 945, 16193, 15, 11, 72, 828, 3124, 28, 25, 13424, 11, 17130, 28, 15, 13, 2425, 11, 9493, 413, 5649, 28, 17, 11, 6167, 2625, 7942, 1080, 4943, 198, 220, 220, 220, 7110, 0, 7, 79, 11, 40379, 62, 76, 11, 266, 58, 72, 11, 1058, 4357, 1055, 6386, 2981, 28, 25, 1416, 1436, 11, 3124, 2625, 2971, 4077, 1600, 6167, 2625, 672, 3168, 341, 1, 1267, 198, 220, 220, 220, 7110, 0, 7, 79, 11, 1540, 62, 754, 2701, 11, 410, 945, 16193, 15, 11, 1312, 828, 9493, 10992, 28, 25, 42460, 26518, 11, 3124, 2625, 14225, 1154, 1600, 6167, 2625, 754, 2701, 4943, 198, 220, 220, 220, 7110, 0, 7, 79, 11, 1540, 62, 20930, 11, 410, 945, 16193, 15, 11, 72, 828, 3124, 2625, 3287, 282, 4171, 1600, 17130, 28, 16, 11, 9493, 413, 5649, 796, 352, 11, 6167, 2625, 20930, 4943, 198, 220, 220, 220, 2124, 18242, 0, 7, 79, 11, 366, 83, 4943, 198, 220, 220, 220, 331, 18242, 0, 7, 79, 11, 1401, 62, 14933, 58, 72, 12962, 198, 220, 220, 220, 4574, 0, 7, 489, 1747, 11, 279, 8, 198, 437, 198, 198, 29487, 7, 489, 1747, 986, 11, 12461, 16193, 18, 11, 16, 4008, 198, 198, 21928, 5647, 7203, 19, 67, 7785, 62, 3500, 62, 69, 22564, 13, 21370, 70, 4943, 198, 21928, 5647, 7203, 19, 67, 7785, 62, 3500, 62, 69, 22564, 13, 11134, 4943, 628, 198 ]
2.332569
1,308
using DrWatson quickactivate(@__DIR__, "AccuracyAtTopPrimal_oms") using Experiments using Experiments: AccuracyAtTopPrimal, DatasetProvider using DatasetProvider: Ionosphere, Spambase, Gisette, MNIST, FashionMNIST, CIFAR10, CIFAR20, CIFAR100, SVHN2, HEPMASS # ------------------------------------------------------------------------------------------ # Model settings # ------------------------------------------------------------------------------------------ τ = [0.01, 0.05] K = [1, 3, 5, 10, 15, 20] β = [10, 1, 0.1, 0.01, 0.001, 0.0001] λ = [0, 1e-1, 1e-2, 1e-3, 1e-4, 1e-5] surrogate = hinge models = vcat( Model(PatMat; τ, β, surrogate), Model(PatMatNP; τ, β, surrogate), Model(TopPush; λ), Model(TopPushK; K), Model(τFPL; τ, λ, surrogate), Model(TopMean; τ, λ, surrogate), Model(Grill; τ, λ, surrogate), Model(GrillNP; τ, λ, surrogate), ) # ------------------------------------------------------------------------------------------ # Datasets with 10 seeds # ------------------------------------------------------------------------------------------ datasets = [ Data(Ionosphere), Data(Spambase), Data(Gisette; batchsize = 512), Data(MNIST; poslabels = 1, batchsize = 512), Data(FashionMNIST; poslabels = 1, batchsize = 512), Data(CIFAR10; poslabels = 1, batchsize = 512), Data(CIFAR20; poslabels = 1, batchsize = 512), Data(CIFAR100; poslabels = 1, batchsize = 512), Data(SVHN2; poslabels = 1, batchsize = 512), ] train = [Train(; seed = seed, iters = 10000, saveat = 500, optimiser = ADAM, step = 0.01, ) for seed in 1:10] run_simulations(datasets, train, models) # HEPMASS train_hep = [Train(; seed = seed, iters = 10000, saveat = 10000, optimiser = ADAM, step = 0.01, ) for seed in 1:10] run_simulations(Data(HEPMASS; batchsize = 512), train_hep, models) # ------------------------------------------------------------------------------------------ # Datasets with 1 seeds # ------------------------------------------------------------------------------------------ datasets_1 = reduce(vcat, [[ Data(MNIST; poslabels = l, batchsize = 512), Data(FashionMNIST; poslabels = l, batchsize = 512), Data(CIFAR10; poslabels = l, batchsize = 512), Data(CIFAR20; poslabels = l, batchsize = 512), Data(CIFAR100; poslabels = l, batchsize = 512), Data(SVHN2; poslabels = l + 1, batchsize = 512), ] for l in 0:9]) train_1 = Train(; seed = 1, iters = 10000, saveat = 500, optimiser = ADAM, step = 0.01, ) run_simulations(datasets_1, train_1, models) # ------------------------------------------------------------------------------------------ # Benchmarks # ------------------------------------------------------------------------------------------ datasets_bench = [ Data(Ionosphere), Data(Spambase), Data(Gisette; batchsize = 512), Data(MNIST; poslabels = 1, batchsize = 512), Data(FashionMNIST; poslabels = 1, batchsize = 512), Data(CIFAR10; poslabels = 1, batchsize = 512), Data(SVHN2; poslabels = 1, batchsize = 512), Data(HEPMASS; batchsize = 512), ] table = run_benchmarks(datasets_bench; force = true)
[ 3500, 1583, 54, 13506, 198, 24209, 39022, 7, 31, 834, 34720, 834, 11, 366, 17320, 23843, 2953, 9126, 23828, 282, 62, 3150, 4943, 198, 198, 3500, 8170, 6800, 198, 3500, 8170, 6800, 25, 33222, 2953, 9126, 23828, 282, 11, 16092, 292, 316, 29495, 198, 198, 3500, 16092, 292, 316, 29495, 25, 36404, 22829, 11, 1338, 4131, 589, 11, 402, 271, 5857, 11, 29060, 8808, 11, 30958, 39764, 8808, 11, 327, 5064, 1503, 940, 11, 327, 5064, 1503, 1238, 11, 327, 5064, 1503, 3064, 11, 20546, 39, 45, 17, 11, 11179, 5868, 10705, 198, 198, 2, 16529, 22369, 438, 198, 2, 9104, 6460, 198, 2, 16529, 22369, 438, 198, 32830, 796, 685, 15, 13, 486, 11, 657, 13, 2713, 60, 198, 42, 796, 685, 16, 11, 513, 11, 642, 11, 838, 11, 1315, 11, 1160, 60, 198, 26638, 796, 685, 940, 11, 352, 11, 657, 13, 16, 11, 657, 13, 486, 11, 657, 13, 8298, 11, 657, 13, 18005, 60, 198, 39377, 796, 685, 15, 11, 352, 68, 12, 16, 11, 352, 68, 12, 17, 11, 352, 68, 12, 18, 11, 352, 68, 12, 19, 11, 352, 68, 12, 20, 60, 198, 11793, 3828, 378, 796, 41968, 198, 198, 27530, 796, 410, 9246, 7, 198, 220, 220, 220, 9104, 7, 12130, 19044, 26, 46651, 11, 27169, 11, 37660, 828, 198, 220, 220, 220, 9104, 7, 12130, 19044, 22182, 26, 46651, 11, 27169, 11, 37660, 828, 198, 220, 220, 220, 9104, 7, 9126, 49222, 26, 7377, 119, 828, 198, 220, 220, 220, 9104, 7, 9126, 49222, 42, 26, 509, 828, 198, 220, 220, 220, 9104, 7, 32830, 5837, 43, 26, 46651, 11, 7377, 119, 11, 37660, 828, 198, 220, 220, 220, 9104, 7, 9126, 5308, 272, 26, 46651, 11, 7377, 119, 11, 37660, 828, 198, 220, 220, 220, 9104, 7, 8642, 359, 26, 46651, 11, 7377, 119, 11, 37660, 828, 198, 220, 220, 220, 9104, 7, 8642, 359, 22182, 26, 46651, 11, 7377, 119, 11, 37660, 828, 198, 8, 198, 198, 2, 16529, 22369, 438, 198, 2, 16092, 292, 1039, 351, 838, 11904, 198, 2, 16529, 22369, 438, 198, 19608, 292, 1039, 796, 685, 198, 220, 220, 220, 6060, 7, 40, 261, 22829, 828, 198, 220, 220, 220, 6060, 7, 4561, 4131, 589, 828, 198, 220, 220, 220, 6060, 7, 38, 271, 5857, 26, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 39764, 8808, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 37, 5880, 39764, 8808, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 940, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 1238, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 3064, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 50, 53, 39, 45, 17, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 60, 198, 198, 27432, 796, 685, 44077, 7, 26, 198, 220, 220, 220, 9403, 796, 9403, 11, 198, 220, 220, 220, 340, 364, 796, 33028, 11, 198, 220, 220, 220, 3613, 265, 796, 5323, 11, 198, 220, 220, 220, 6436, 5847, 796, 5984, 2390, 11, 198, 220, 220, 220, 2239, 796, 657, 13, 486, 11, 198, 8, 329, 9403, 287, 352, 25, 940, 60, 198, 198, 5143, 62, 14323, 5768, 7, 19608, 292, 1039, 11, 4512, 11, 4981, 8, 198, 198, 2, 11179, 5868, 10705, 198, 27432, 62, 258, 79, 796, 685, 44077, 7, 26, 198, 220, 220, 220, 9403, 796, 9403, 11, 198, 220, 220, 220, 340, 364, 796, 33028, 11, 198, 220, 220, 220, 3613, 265, 796, 33028, 11, 198, 220, 220, 220, 6436, 5847, 796, 5984, 2390, 11, 198, 220, 220, 220, 2239, 796, 657, 13, 486, 11, 198, 8, 329, 9403, 287, 352, 25, 940, 60, 198, 198, 5143, 62, 14323, 5768, 7, 6601, 7, 13909, 5868, 10705, 26, 15458, 7857, 796, 22243, 828, 4512, 62, 258, 79, 11, 4981, 8, 628, 198, 2, 16529, 22369, 438, 198, 2, 16092, 292, 1039, 351, 352, 11904, 198, 2, 16529, 22369, 438, 198, 19608, 292, 1039, 62, 16, 796, 4646, 7, 85, 9246, 11, 16410, 198, 220, 220, 220, 6060, 7, 39764, 8808, 26, 1426, 23912, 1424, 796, 300, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 37, 5880, 39764, 8808, 26, 1426, 23912, 1424, 796, 300, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 940, 26, 1426, 23912, 1424, 796, 300, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 1238, 26, 1426, 23912, 1424, 796, 300, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 3064, 26, 1426, 23912, 1424, 796, 300, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 50, 53, 39, 45, 17, 26, 1426, 23912, 1424, 796, 300, 1343, 352, 11, 15458, 7857, 796, 22243, 828, 198, 60, 329, 300, 287, 657, 25, 24, 12962, 198, 198, 27432, 62, 16, 796, 16835, 7, 26, 198, 220, 220, 220, 9403, 796, 352, 11, 198, 220, 220, 220, 340, 364, 796, 33028, 11, 198, 220, 220, 220, 3613, 265, 796, 5323, 11, 198, 220, 220, 220, 6436, 5847, 796, 5984, 2390, 11, 198, 220, 220, 220, 2239, 796, 657, 13, 486, 11, 198, 8, 198, 198, 5143, 62, 14323, 5768, 7, 19608, 292, 1039, 62, 16, 11, 4512, 62, 16, 11, 4981, 8, 628, 198, 2, 16529, 22369, 438, 198, 2, 25187, 14306, 198, 2, 16529, 22369, 438, 198, 19608, 292, 1039, 62, 26968, 796, 685, 198, 220, 220, 220, 6060, 7, 40, 261, 22829, 828, 198, 220, 220, 220, 6060, 7, 4561, 4131, 589, 828, 198, 220, 220, 220, 6060, 7, 38, 271, 5857, 26, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 39764, 8808, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 37, 5880, 39764, 8808, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 34, 5064, 1503, 940, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 50, 53, 39, 45, 17, 26, 1426, 23912, 1424, 796, 352, 11, 15458, 7857, 796, 22243, 828, 198, 220, 220, 220, 6060, 7, 13909, 5868, 10705, 26, 15458, 7857, 796, 22243, 828, 198, 60, 198, 198, 11487, 796, 1057, 62, 26968, 14306, 7, 19608, 292, 1039, 62, 26968, 26, 2700, 796, 2081, 8, 198 ]
2.847247
1,126
@testset "AWSException" begin function _test_exception( ex::AWSException, expected::AbstractDict, msg::String ) @test ex.code == expected["code"] @test ex.message == ex.info[msg] == expected["message"] @test String(ex.cause.response.body) == expected["body"] @test ex.cause.status == expected["status_code"] @test ex.cause.response.headers == expected["headers"] end cases = [ ("Error", "message"), ("Error", "Message"), ("Errors", "message"), ("Errors", "Message"), ] @testset "XMLRequest $err -- $msg" for (err, msg) in cases expected = Dict( "code"=>"NoSuchKey", "message"=>"The resource you requested does not exist", "resource"=>"/mybucket/myfoto.jpg", "requestId"=>"4442587FB7D0A2F9", "headers"=>["Content-Type" => "application/xml"], "status_code"=>400, ) body = """ <?xml version="1.0" encoding="UTF-8"?> <$err> <Code>$(expected["code"])</Code> <$msg>$(expected["message"])</$msg> <Resource>$(expected["resource"])</Resource> <RequestId>$(expected["requestId"])</RequestId> </$err> """ expected["body"] = body # This does not actually send a request, just creates the object to test with req = HTTP.Request("GET", "https://amazon.ca", expected["headers"], expected["body"]) resp = HTTP.Response(expected["status_code"], expected["headers"]; body=expected["body"], request=req) ex = AWSException(HTTP.StatusError(expected["status_code"], resp)) _test_exception(ex, expected, msg) @test ex.info["Resource"] == expected["resource"] @test ex.info["RequestId"] == expected["requestId"] end @testset "XMLRequest - Invalid XML" begin expected = Dict( "body"=>"InvalidXML", "headers"=>["Content-Type" => "application/xml"], "status_code"=>404, ) req = HTTP.Request("GET", "https://amazon.ca", expected["headers"], expected["body"]) resp = HTTP.Response(expected["status_code"], expected["headers"]; body=expected["body"], request=req) ex = AWSException(HTTP.StatusError(expected["status_code"], resp)) @test ex.code == "404" end @testset "JSON Request -- $msg" for msg in ["message", "Message"] expected = Dict( "code" => "InvalidSignatureException", "message" => "Signature expired: ...", "headers" => ["Content-Type" => "application/x-amz-json-1.1"], "status_code" => 400, ) body = """ { "__type": "$(expected["code"])", "$msg": "$(expected["message"])" } """ expected["body"] = body # This does not actually send a request, just creates the object to test with req = HTTP.Request("GET", "https://amazon.ca", expected["headers"], body) resp = HTTP.Response(expected["status_code"], expected["headers"]; body=body, request=req) ex = AWSException(HTTP.StatusError(expected["status_code"], resp)) _test_exception(ex, expected, "$msg") @test ex.info["__type"] == expected["code"] end end
[ 31, 9288, 2617, 366, 12298, 50, 16922, 1, 2221, 198, 220, 220, 220, 2163, 4808, 9288, 62, 1069, 4516, 7, 198, 220, 220, 220, 220, 220, 220, 220, 409, 3712, 12298, 50, 16922, 11, 198, 220, 220, 220, 220, 220, 220, 220, 2938, 3712, 23839, 35, 713, 11, 198, 220, 220, 220, 220, 220, 220, 220, 31456, 3712, 10100, 198, 220, 220, 220, 1267, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 8189, 6624, 2938, 14692, 8189, 8973, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 20500, 6624, 409, 13, 10951, 58, 19662, 60, 6624, 2938, 14692, 20500, 8973, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 10903, 7, 1069, 13, 25587, 13, 26209, 13, 2618, 8, 6624, 2938, 14692, 2618, 8973, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 25587, 13, 13376, 6624, 2938, 14692, 13376, 62, 8189, 8973, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 25587, 13, 26209, 13, 50145, 6624, 2938, 14692, 50145, 8973, 198, 220, 220, 220, 886, 628, 220, 220, 220, 2663, 796, 685, 198, 220, 220, 220, 220, 220, 220, 220, 5855, 12331, 1600, 366, 20500, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 5855, 12331, 1600, 366, 12837, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 5855, 9139, 5965, 1600, 366, 20500, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 5855, 9139, 5965, 1600, 366, 12837, 12340, 198, 220, 220, 220, 2361, 198, 220, 220, 220, 2488, 9288, 2617, 366, 55, 5805, 18453, 720, 8056, 1377, 720, 19662, 1, 329, 357, 8056, 11, 31456, 8, 287, 2663, 198, 220, 220, 220, 220, 220, 220, 220, 2938, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 8189, 1, 14804, 1, 2949, 16678, 9218, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 20500, 1, 14804, 1, 464, 8271, 345, 9167, 857, 407, 2152, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 31092, 1, 14804, 1, 14, 1820, 27041, 316, 14, 1820, 69, 2069, 13, 9479, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 25927, 7390, 1, 14804, 1, 30272, 1495, 5774, 26001, 22, 35, 15, 32, 17, 37, 24, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 50145, 1, 14804, 14692, 19746, 12, 6030, 1, 5218, 366, 31438, 14, 19875, 33116, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 13376, 62, 8189, 1, 14804, 7029, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 628, 220, 220, 220, 220, 220, 220, 220, 1767, 796, 37227, 198, 220, 220, 220, 220, 220, 220, 220, 1279, 30, 19875, 2196, 2625, 16, 13, 15, 1, 21004, 2625, 48504, 12, 23, 13984, 29, 198, 220, 220, 220, 220, 220, 220, 220, 1279, 3, 8056, 29, 198, 220, 220, 220, 220, 220, 220, 220, 1279, 10669, 29, 3, 7, 40319, 14692, 8189, 8973, 36475, 10669, 29, 198, 220, 220, 220, 220, 220, 220, 220, 1279, 3, 19662, 29, 3, 7, 40319, 14692, 20500, 8973, 36475, 3, 19662, 29, 198, 220, 220, 220, 220, 220, 220, 220, 1279, 26198, 29, 3, 7, 40319, 14692, 31092, 8973, 36475, 26198, 29, 198, 220, 220, 220, 220, 220, 220, 220, 1279, 18453, 7390, 29, 3, 7, 40319, 14692, 25927, 7390, 8973, 36475, 18453, 7390, 29, 198, 220, 220, 220, 220, 220, 220, 220, 7359, 3, 8056, 29, 198, 220, 220, 220, 220, 220, 220, 220, 37227, 628, 220, 220, 220, 220, 220, 220, 220, 2938, 14692, 2618, 8973, 796, 1767, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 770, 857, 407, 1682, 3758, 257, 2581, 11, 655, 8075, 262, 2134, 284, 1332, 351, 198, 220, 220, 220, 220, 220, 220, 220, 43089, 796, 14626, 13, 18453, 7203, 18851, 1600, 366, 5450, 1378, 33103, 13, 6888, 1600, 2938, 14692, 50145, 33116, 2938, 14692, 2618, 8973, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1217, 796, 14626, 13, 31077, 7, 40319, 14692, 13376, 62, 8189, 33116, 2938, 14692, 50145, 8973, 26, 1767, 28, 40319, 14692, 2618, 33116, 2581, 28, 42180, 8, 198, 220, 220, 220, 220, 220, 220, 220, 409, 796, 30865, 16922, 7, 40717, 13, 19580, 12331, 7, 40319, 14692, 13376, 62, 8189, 33116, 1217, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 4808, 9288, 62, 1069, 4516, 7, 1069, 11, 2938, 11, 31456, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 10951, 14692, 26198, 8973, 6624, 2938, 14692, 31092, 8973, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 10951, 14692, 18453, 7390, 8973, 6624, 2938, 14692, 25927, 7390, 8973, 198, 220, 220, 220, 886, 628, 220, 220, 220, 2488, 9288, 2617, 366, 55, 5805, 18453, 532, 17665, 23735, 1, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 2938, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 2618, 1, 14804, 1, 44651, 55, 5805, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 50145, 1, 14804, 14692, 19746, 12, 6030, 1, 5218, 366, 31438, 14, 19875, 33116, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 13376, 62, 8189, 1, 14804, 26429, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 198, 220, 220, 220, 220, 220, 220, 220, 43089, 796, 14626, 13, 18453, 7203, 18851, 1600, 366, 5450, 1378, 33103, 13, 6888, 1600, 2938, 14692, 50145, 33116, 2938, 14692, 2618, 8973, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1217, 796, 14626, 13, 31077, 7, 40319, 14692, 13376, 62, 8189, 33116, 2938, 14692, 50145, 8973, 26, 1767, 28, 40319, 14692, 2618, 33116, 2581, 28, 42180, 8, 198, 220, 220, 220, 220, 220, 220, 220, 409, 796, 30865, 16922, 7, 40717, 13, 19580, 12331, 7, 40319, 14692, 13376, 62, 8189, 33116, 1217, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 8189, 6624, 366, 26429, 1, 198, 220, 220, 220, 886, 628, 220, 220, 220, 2488, 9288, 2617, 366, 40386, 19390, 1377, 720, 19662, 1, 329, 31456, 287, 14631, 20500, 1600, 366, 12837, 8973, 198, 220, 220, 220, 220, 220, 220, 220, 2938, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 8189, 1, 5218, 366, 44651, 11712, 1300, 16922, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 20500, 1, 5218, 366, 11712, 1300, 21350, 25, 35713, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 50145, 1, 5218, 14631, 19746, 12, 6030, 1, 5218, 366, 31438, 14, 87, 12, 321, 89, 12, 17752, 12, 16, 13, 16, 33116, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 13376, 62, 8189, 1, 5218, 7337, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 628, 220, 220, 220, 220, 220, 220, 220, 1767, 796, 37227, 198, 220, 220, 220, 220, 220, 220, 220, 1391, 198, 220, 220, 220, 220, 220, 220, 220, 366, 834, 4906, 1298, 17971, 7, 40319, 14692, 8189, 8973, 42501, 198, 220, 220, 220, 220, 220, 220, 220, 17971, 19662, 1298, 17971, 7, 40319, 14692, 20500, 8973, 16725, 198, 220, 220, 220, 220, 220, 220, 220, 1782, 198, 220, 220, 220, 220, 220, 220, 220, 37227, 198, 220, 220, 220, 220, 220, 220, 220, 2938, 14692, 2618, 8973, 796, 1767, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 770, 857, 407, 1682, 3758, 257, 2581, 11, 655, 8075, 262, 2134, 284, 1332, 351, 198, 220, 220, 220, 220, 220, 220, 220, 43089, 796, 14626, 13, 18453, 7203, 18851, 1600, 366, 5450, 1378, 33103, 13, 6888, 1600, 2938, 14692, 50145, 33116, 1767, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1217, 796, 14626, 13, 31077, 7, 40319, 14692, 13376, 62, 8189, 33116, 2938, 14692, 50145, 8973, 26, 1767, 28, 2618, 11, 2581, 28, 42180, 8, 198, 220, 220, 220, 220, 220, 220, 220, 409, 796, 30865, 16922, 7, 40717, 13, 19580, 12331, 7, 40319, 14692, 13376, 62, 8189, 33116, 1217, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 4808, 9288, 62, 1069, 4516, 7, 1069, 11, 2938, 11, 17971, 19662, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 409, 13, 10951, 14692, 834, 4906, 8973, 6624, 2938, 14692, 8189, 8973, 198, 220, 220, 220, 886, 198, 437, 198 ]
2.331457
1,421
using Base.Test using JuLIP, ForwardDiff using JuLIPMaterials using StaticArrays MST = JuLIPMaterials CB = MST.CauchyBorn CLE = MST.CLE FD = ForwardDiff Id = one(SMatrix{3,3,Float64}) println("------------------------------------------------------------") println(" Testing Simple Lattice Cauchy--Born Implementation") println("------------------------------------------------------------") at = bulk(:Fe) r0 = rnn(:Fe) calc = LennardJones(σ = r0) * C2Shift(2.7*r0) set_calculator!(at, calc) variablecell!((at)) # minimise!(at) println("Constructing Wcb . . .") W = CB.Wcb(at, calc) println("generate a cauchy Born potential . . . ") println("check W, grad(W..) evaluate ok . . .") @test W(Id) == energy(at) / det(defm(at)) @test CB.grad(W, Id) isa AbstractMatrix println("Finite-difference consistency test") F = Id + (rand(3,3) - 0.5) * 0.01 W0 = W(F) dW0 = CB.grad(W, F)[:] errors = [] for p = 2:10 h = .1^p dWh = zeros(9) for i = 1:9 F[i] += h dWh[i] = (W(F) - W0) / h F[i] -= h end push!(errors, norm(dWh-dW0, Inf)) @printf(" %2d | %.3e \n", p, errors[end]) end passed = minimum(errors) <= 1e-3 * maximum(errors) if passed println("passed") else warn("""It seems the finite-difference test has failed, which indicates that there is an inconsistency between the function and gradient evaluation. Please double-check this manually / visually. (It is also possible that the function being tested is poorly scaled.)""") end # ------ some more random tests left-over from debugging ------- # setup a Cauchy-Born model for bulk Fe atu = bulk(:Fe) r0 = rnn(:Fe) calc = LennardJones(σ = r0) * C2Shift(2.7*r0) set_calculator!(atu, calc) variablecell!(atu) println("Constructing Wcb . . .") W = CB.Wcb(atu, calc, normalise = :atoms) energy(atu) W(Id) @test CB.grad(W, Id) ≈ -virial(atu) @test stress(atu) == CB.grad(W, Id) / det(cell(atu)) at1 = deepcopy(atu) F0 = defm(at1) for n = 1:5 F = Id + 0.1 * rand(3,3) set_defm!(at1, F * F0) @test energy(calc, at1) == W(F) end
[ 198, 3500, 7308, 13, 14402, 198, 3500, 12585, 43, 4061, 11, 19530, 28813, 198, 3500, 12585, 43, 4061, 41657, 198, 3500, 36125, 3163, 20477, 198, 198, 44, 2257, 796, 12585, 43, 4061, 41657, 198, 23199, 796, 337, 2257, 13, 34, 559, 29658, 28524, 198, 29931, 796, 337, 2257, 13, 29931, 198, 26009, 796, 19530, 28813, 198, 198, 7390, 796, 530, 7, 12310, 265, 8609, 90, 18, 11, 18, 11, 43879, 2414, 30072, 198, 198, 35235, 7203, 47232, 10541, 4943, 198, 35235, 7203, 23983, 17427, 406, 1078, 501, 327, 559, 29658, 438, 28524, 46333, 4943, 198, 35235, 7203, 47232, 10541, 4943, 198, 198, 265, 796, 11963, 7, 25, 14304, 8, 198, 81, 15, 796, 374, 20471, 7, 25, 14304, 8, 198, 9948, 66, 796, 28423, 446, 25784, 7, 38392, 796, 374, 15, 8, 1635, 327, 17, 33377, 7, 17, 13, 22, 9, 81, 15, 8, 198, 2617, 62, 9948, 3129, 1352, 0, 7, 265, 11, 42302, 8, 198, 45286, 3846, 0, 19510, 265, 4008, 198, 2, 10356, 786, 0, 7, 265, 8, 198, 35235, 7203, 42316, 278, 370, 21101, 764, 764, 220, 19570, 198, 54, 796, 10078, 13, 54, 21101, 7, 265, 11, 42302, 8, 198, 198, 35235, 7203, 8612, 378, 257, 269, 559, 29658, 18889, 2785, 764, 764, 764, 366, 8, 198, 35235, 7203, 9122, 370, 11, 3915, 7, 54, 492, 8, 13446, 12876, 764, 764, 220, 19570, 198, 31, 9288, 370, 7, 7390, 8, 6624, 2568, 7, 265, 8, 1220, 1062, 7, 4299, 76, 7, 265, 4008, 198, 31, 9288, 10078, 13, 9744, 7, 54, 11, 5121, 8, 318, 64, 27741, 46912, 198, 198, 35235, 7203, 37, 9504, 12, 26069, 1945, 15794, 1332, 4943, 198, 37, 796, 5121, 1343, 357, 25192, 7, 18, 11, 18, 8, 532, 657, 13, 20, 8, 1635, 657, 13, 486, 198, 54, 15, 796, 370, 7, 37, 8, 198, 67, 54, 15, 796, 10078, 13, 9744, 7, 54, 11, 376, 38381, 47715, 198, 48277, 796, 17635, 198, 1640, 279, 796, 362, 25, 940, 198, 220, 220, 289, 796, 764, 16, 61, 79, 198, 220, 220, 288, 1199, 796, 1976, 27498, 7, 24, 8, 198, 220, 220, 329, 1312, 796, 352, 25, 24, 198, 220, 220, 220, 220, 220, 376, 58, 72, 60, 15853, 289, 198, 220, 220, 220, 220, 220, 288, 1199, 58, 72, 60, 796, 357, 54, 7, 37, 8, 532, 370, 15, 8, 1220, 289, 198, 220, 220, 220, 220, 220, 376, 58, 72, 60, 48185, 289, 198, 220, 220, 886, 198, 220, 220, 4574, 0, 7, 48277, 11, 2593, 7, 67, 1199, 12, 67, 54, 15, 11, 4806, 4008, 198, 220, 220, 2488, 37435, 7203, 4064, 17, 67, 220, 930, 220, 4064, 13, 18, 68, 3467, 77, 1600, 279, 11, 8563, 58, 437, 12962, 198, 437, 198, 6603, 276, 796, 5288, 7, 48277, 8, 19841, 352, 68, 12, 18, 1635, 5415, 7, 48277, 8, 198, 361, 3804, 198, 220, 220, 44872, 7203, 6603, 276, 4943, 198, 17772, 198, 220, 220, 9828, 7203, 15931, 1026, 2331, 262, 27454, 12, 26069, 1945, 1332, 468, 4054, 11, 543, 9217, 198, 220, 220, 326, 612, 318, 281, 43831, 1022, 262, 2163, 290, 31312, 198, 220, 220, 12660, 13, 4222, 4274, 12, 9122, 428, 14500, 1220, 22632, 13, 357, 1026, 318, 198, 220, 220, 635, 1744, 326, 262, 2163, 852, 6789, 318, 13455, 27464, 2014, 15931, 4943, 198, 437, 198, 198, 2, 40103, 617, 517, 4738, 5254, 1364, 12, 2502, 422, 28769, 35656, 198, 198, 2, 9058, 257, 327, 559, 29658, 12, 28524, 2746, 329, 11963, 5452, 198, 33419, 796, 11963, 7, 25, 14304, 8, 198, 81, 15, 796, 374, 20471, 7, 25, 14304, 8, 198, 9948, 66, 796, 28423, 446, 25784, 7, 38392, 796, 374, 15, 8, 1635, 327, 17, 33377, 7, 17, 13, 22, 9, 81, 15, 8, 198, 2617, 62, 9948, 3129, 1352, 0, 7, 33419, 11, 42302, 8, 198, 45286, 3846, 0, 7, 33419, 8, 198, 35235, 7203, 42316, 278, 370, 21101, 764, 764, 220, 19570, 198, 54, 796, 10078, 13, 54, 21101, 7, 33419, 11, 42302, 11, 3487, 786, 796, 1058, 265, 3150, 8, 198, 198, 22554, 7, 33419, 8, 198, 54, 7, 7390, 8, 198, 198, 31, 9288, 10078, 13, 9744, 7, 54, 11, 5121, 8, 15139, 230, 532, 37040, 498, 7, 33419, 8, 198, 31, 9288, 5503, 7, 33419, 8, 6624, 10078, 13, 9744, 7, 54, 11, 5121, 8, 1220, 1062, 7, 3846, 7, 33419, 4008, 198, 198, 265, 16, 796, 2769, 30073, 7, 33419, 8, 198, 37, 15, 796, 825, 76, 7, 265, 16, 8, 198, 1640, 299, 796, 352, 25, 20, 198, 220, 220, 376, 796, 5121, 1343, 657, 13, 16, 1635, 43720, 7, 18, 11, 18, 8, 198, 220, 220, 900, 62, 4299, 76, 0, 7, 265, 16, 11, 376, 1635, 376, 15, 8, 198, 220, 220, 2488, 9288, 2568, 7, 9948, 66, 11, 379, 16, 8, 6624, 370, 7, 37, 8, 198, 437, 198 ]
2.521632
809
using VLConstraintBasedModelGenerationUtilities # setup path to sequence file - path_to_protein_sequence_file = "/Users/jeffreyvarner/Desktop/julia_work/VLConstraintBasedModelGenerationUtilities.jl/test/data/P-MZ373340.fasta" # load - result = build_protein_table(path_to_protein_sequence_file) |> check
[ 3500, 569, 43, 3103, 2536, 2913, 15001, 17633, 8645, 341, 18274, 2410, 198, 198, 2, 9058, 3108, 284, 8379, 2393, 532, 198, 6978, 62, 1462, 62, 48693, 62, 43167, 62, 7753, 796, 12813, 14490, 14, 73, 14822, 4364, 7785, 1008, 14, 36881, 14, 73, 43640, 62, 1818, 14, 47468, 3103, 2536, 2913, 15001, 17633, 8645, 341, 18274, 2410, 13, 20362, 14, 9288, 14, 7890, 14, 47, 12, 44, 57, 2718, 2091, 1821, 13, 7217, 64, 1, 198, 198, 2, 3440, 532, 198, 20274, 796, 1382, 62, 48693, 62, 11487, 7, 6978, 62, 1462, 62, 48693, 62, 43167, 62, 7753, 8, 930, 29, 2198 ]
2.961165
103
using SortingAlgorithms raw_rel = readdlm("C:\\Users\\bernhard.konig\\Documents\\ASync\\irobot\\data_tmp\\eraw_rel.csv"); orig = deepcopy(raw_rel[:]); r = deepcopy(orig);i = zeros(Int, length(r)); @benchmark mysortperm!(i, r) r2 = deepcopy(orig);i2 = zeros(Int, length(r2)); @benchmark sortperm!(i2, r2) @assert isequal(r2[i2], r[i]) isequal(i,i2) r = deepcopy(orig); a = sortperm(r) r = deepcopy(orig); a1, b1 = mysortperm(r) isequal(a,a1) isequal(raw_rel[a],b1) r = deepcopy(orig); @btime sort!(r); r = deepcopy(orig); @btime sort!(r); r = deepcopy(orig); @btime sort!(r, alg=QuickSort); r = deepcopy(orig); @btime sort!(r, alg=RadixSort); r = deepcopy(orig); @btime sortperm(r); r = deepcopy(orig); @btime mysortperm(r); r = deepcopy(orig); @btime sortperm(r, alg=QuickSort); r = deepcopy(orig); @benchmark mysortperm(r) r = deepcopy(orig); @benchmark sortperm(r, alg=QuickSort) r = deepcopy(orig);i = zeros(Int, length(r)); @btime sortperm!(i, r, alg=QuickSort); size(orig) xx = rand(length(orig));@btime sortperm(xx); xx = rand(length(orig));@btime sort!(xx); export mysortperm function mysortperm!(ii, A) n = length(A) # ii = Array(Int,n) for i = 1:n ii[i] = i end B = copy(A) quicksort!(B, ii) # return ii, B return nothing end # function mysortperm! function mysortperm(A) n = length(A) ii = Array(Int, n) for i = 1:n ii[i] = i end B = copy(A) quicksort!(B, ii) return ii, B end # function mysortperm function quicksort!(A, order, i=1, j=length(A)) # modified from: # http://rosettacode.org/wiki/Sorting_algorithms/Quicksort#Julia if j > i if j - i <= 50 # Insertion sort for small groups is faster than Quicksort InsertionSort!(A, order, i, j) return A end # pivot = A[rand(i:j)] # random element of A pivot = A[ div(i + j, 2) ] left, right = i, j while left <= right while A[left] < pivot left += 1 end while A[right] > pivot right -= 1 end if left <= right A[left], A[right] = A[right], A[left] order[left], order[right] = order[right], order[left] left += 1 right -= 1 end end # left <= right quicksort!(A, order, i, right) quicksort!(A, order, left, j) end # j > i return A end # function quicksort! function InsertionSort!(A, order, ii=1, jj=length(A)) for i = ii + 1:jj j = i - 1 temp = A[i] itemp = order[i] while true if j == ii - 1 break end if A[j] <= temp break end A[j + 1] = A[j] order[j + 1] = order[j] j -= 1 end A[j + 1] = temp order[j + 1] = itemp end # i return end # function InsertionSort!
[ 3500, 311, 24707, 2348, 7727, 907, 198, 198, 1831, 62, 2411, 796, 1100, 25404, 76, 7203, 34, 25, 6852, 14490, 6852, 33900, 10424, 13, 74, 261, 328, 6852, 38354, 6852, 1921, 13361, 6852, 7058, 13645, 6852, 7890, 62, 22065, 6852, 263, 707, 62, 2411, 13, 40664, 15341, 198, 11612, 796, 2769, 30073, 7, 1831, 62, 2411, 58, 25, 36563, 198, 220, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 72, 796, 1976, 27498, 7, 5317, 11, 4129, 7, 81, 18125, 2488, 26968, 4102, 616, 30619, 16321, 0, 7, 72, 11, 374, 8, 198, 81, 17, 796, 2769, 30073, 7, 11612, 1776, 72, 17, 796, 1976, 27498, 7, 5317, 11, 4129, 7, 81, 17, 18125, 2488, 26968, 4102, 3297, 16321, 0, 7, 72, 17, 11, 374, 17, 8, 198, 31, 30493, 318, 40496, 7, 81, 17, 58, 72, 17, 4357, 374, 58, 72, 12962, 198, 198, 786, 13255, 7, 72, 11, 72, 17, 8, 628, 198, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 257, 796, 3297, 16321, 7, 81, 8, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 257, 16, 11, 275, 16, 796, 616, 30619, 16321, 7, 81, 8, 198, 198, 786, 13255, 7, 64, 11, 64, 16, 8, 198, 786, 13255, 7, 1831, 62, 2411, 58, 64, 4357, 65, 16, 8, 198, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 3297, 0, 7, 81, 1776, 198, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 3297, 0, 7, 81, 1776, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 3297, 0, 7, 81, 11, 435, 70, 28, 21063, 42758, 1776, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 3297, 0, 7, 81, 11, 435, 70, 28, 15546, 844, 42758, 1776, 198, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 3297, 16321, 7, 81, 1776, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 616, 30619, 16321, 7, 81, 1776, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 65, 2435, 3297, 16321, 7, 81, 11, 435, 70, 28, 21063, 42758, 1776, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 26968, 4102, 616, 30619, 16321, 7, 81, 8, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 2488, 26968, 4102, 3297, 16321, 7, 81, 11, 435, 70, 28, 21063, 42758, 8, 628, 198, 81, 796, 2769, 30073, 7, 11612, 1776, 72, 796, 1976, 27498, 7, 5317, 11, 4129, 7, 81, 18125, 2488, 65, 2435, 3297, 16321, 0, 7, 72, 11, 374, 11, 435, 70, 28, 21063, 42758, 1776, 628, 198, 198, 7857, 7, 11612, 8, 198, 198, 5324, 796, 43720, 7, 13664, 7, 11612, 18125, 31, 65, 2435, 3297, 16321, 7, 5324, 1776, 198, 5324, 796, 43720, 7, 13664, 7, 11612, 18125, 31, 65, 2435, 3297, 0, 7, 5324, 1776, 628, 628, 198, 198, 39344, 616, 30619, 16321, 628, 198, 8818, 616, 30619, 16321, 0, 7, 4178, 11, 317, 8, 198, 220, 220, 220, 299, 796, 4129, 7, 32, 8, 198, 220, 220, 1303, 21065, 796, 15690, 7, 5317, 11, 77, 8, 628, 220, 220, 220, 329, 1312, 796, 352, 25, 77, 198, 220, 220, 220, 220, 220, 220, 220, 21065, 58, 72, 60, 796, 1312, 198, 220, 220, 220, 886, 628, 220, 220, 220, 347, 796, 4866, 7, 32, 8, 198, 220, 220, 220, 627, 3378, 419, 0, 7, 33, 11, 21065, 8, 628, 220, 220, 1303, 1441, 21065, 11, 347, 198, 220, 220, 220, 1441, 2147, 198, 437, 1303, 2163, 616, 30619, 16321, 0, 628, 198, 198, 8818, 616, 30619, 16321, 7, 32, 8, 198, 220, 220, 220, 299, 796, 4129, 7, 32, 8, 198, 220, 220, 220, 21065, 796, 15690, 7, 5317, 11, 299, 8, 628, 220, 220, 220, 329, 1312, 796, 352, 25, 77, 198, 220, 220, 220, 220, 220, 220, 220, 21065, 58, 72, 60, 796, 1312, 198, 220, 220, 220, 886, 628, 220, 220, 220, 347, 796, 4866, 7, 32, 8, 198, 220, 220, 220, 627, 3378, 419, 0, 7, 33, 11, 21065, 8, 628, 220, 220, 220, 1441, 21065, 11, 347, 198, 437, 1303, 2163, 616, 30619, 16321, 628, 198, 8818, 627, 3378, 419, 0, 7, 32, 11, 1502, 11, 1312, 28, 16, 11, 474, 28, 13664, 7, 32, 4008, 198, 2, 9518, 422, 25, 198, 2, 2638, 1378, 305, 17744, 330, 1098, 13, 2398, 14, 15466, 14, 50, 24707, 62, 282, 7727, 907, 14, 4507, 3378, 419, 2, 16980, 544, 220, 220, 220, 198, 220, 220, 220, 611, 474, 1875, 1312, 198, 220, 220, 220, 220, 220, 220, 220, 611, 474, 532, 1312, 19841, 2026, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 35835, 295, 3297, 329, 1402, 2628, 318, 5443, 621, 2264, 3378, 419, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 35835, 295, 42758, 0, 7, 32, 11, 1502, 11, 1312, 11, 474, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 317, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 30355, 796, 317, 58, 25192, 7, 72, 25, 73, 15437, 1303, 4738, 5002, 286, 317, 198, 220, 220, 220, 220, 220, 220, 220, 30355, 796, 317, 58, 2659, 7, 72, 1343, 474, 11, 362, 8, 2361, 220, 198, 220, 220, 220, 220, 220, 220, 220, 1364, 11, 826, 796, 1312, 11, 474, 198, 220, 220, 220, 220, 220, 220, 220, 981, 1364, 19841, 826, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 981, 317, 58, 9464, 60, 1279, 30355, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1364, 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, 981, 317, 58, 3506, 60, 1875, 30355, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 826, 48185, 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, 611, 1364, 19841, 826, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 317, 58, 9464, 4357, 317, 58, 3506, 60, 796, 317, 58, 3506, 4357, 317, 58, 9464, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1502, 58, 9464, 4357, 1502, 58, 3506, 60, 796, 1502, 58, 3506, 4357, 1502, 58, 9464, 60, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1364, 15853, 352, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 826, 48185, 352, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 886, 220, 1303, 1364, 19841, 826, 628, 220, 220, 220, 220, 220, 220, 220, 627, 3378, 419, 0, 7, 32, 11, 1502, 11, 1312, 11, 220, 220, 826, 8, 198, 220, 220, 220, 220, 220, 220, 220, 627, 3378, 419, 0, 7, 32, 11, 1502, 11, 1364, 11, 474, 8, 198, 220, 220, 220, 886, 220, 1303, 474, 1875, 1312, 628, 220, 220, 220, 1441, 317, 198, 437, 1303, 2163, 627, 3378, 419, 0, 628, 198, 8818, 35835, 295, 42758, 0, 7, 32, 11, 1502, 11, 21065, 28, 16, 11, 474, 73, 28, 13664, 7, 32, 4008, 628, 220, 220, 220, 329, 1312, 796, 21065, 1343, 352, 25, 41098, 198, 220, 220, 220, 220, 220, 220, 220, 474, 796, 1312, 532, 352, 198, 220, 220, 220, 220, 220, 220, 220, 20218, 220, 796, 317, 58, 72, 60, 198, 220, 220, 220, 220, 220, 220, 220, 2378, 79, 796, 1502, 58, 72, 60, 628, 220, 220, 220, 220, 220, 220, 220, 981, 2081, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 474, 6624, 21065, 532, 352, 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, 220, 220, 220, 220, 611, 317, 58, 73, 60, 19841, 20218, 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, 220, 220, 220, 220, 317, 58, 73, 1343, 352, 60, 796, 317, 58, 73, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1502, 58, 73, 1343, 352, 60, 796, 1502, 58, 73, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 474, 48185, 352, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 317, 58, 73, 1343, 352, 60, 796, 20218, 198, 220, 220, 220, 220, 220, 220, 220, 1502, 58, 73, 1343, 352, 60, 796, 2378, 79, 198, 220, 220, 220, 886, 220, 1303, 1312, 628, 220, 220, 220, 1441, 198, 437, 1303, 2163, 35835, 295, 42758, 0 ]
1.970013
1,534
# verbose flag const VERBOSE = Ref(false) """ set_verbose(::Bool) For debugging - set flag to print macro expansions """ function set_verbose(verbose::Bool) VERBOSE[] = verbose end
[ 198, 2, 15942, 577, 6056, 198, 9979, 33310, 33, 14058, 796, 6524, 7, 9562, 8, 198, 198, 37811, 198, 220, 220, 220, 900, 62, 19011, 577, 7, 3712, 33, 970, 8, 198, 198, 1890, 28769, 532, 900, 6056, 284, 3601, 15021, 36383, 198, 37811, 198, 8818, 900, 62, 19011, 577, 7, 19011, 577, 3712, 33, 970, 8, 198, 220, 220, 220, 33310, 33, 14058, 21737, 796, 15942, 577, 198, 437, 628 ]
2.71831
71
module ProcessingStd import GLFW using ModernGL using GLUtil using GLText using GLWindow using Events using Color using Tau include("constants.jl") export animate, coordSystem export size, Height, Width, displayHeight, displayWidth export focused, cursor, noCursor # export frameCount, frameRate # export createShape, loadShape export arc, ellipse, line, point, quad, rect, triangle export bezier # export bezierDetail, bezierPoint, bezierTangent, curve, curveDetail, curvePoint, curveTangent, curveTightness export strokeWeight, strokeCap, strokeJoin, noSmooth, smooth export ellipseMode, rectMode # export beginShape, endShape, vertex # export bezierVertex, curveVertex, quadraticVertex # export shape, shapeMode export mouseButton, mouseClicked, mouseDragged, mouseMoved, mousePressed export mouseReleased, mouseWheel, mouseX, mouseY, pmouseX, pmouseY export background, fill, noFill, colorMode, noStroke, stroke # export applyMatrix export popMatrix, printMatrix, pushMatrix, resetMatrix, rotate export scale, shearX, shearY, translate export alpha, blue, brightness, color, green, hue, lerpColor, red, saturation # export createImage export image, loadImage, noTint # export imageMode, tint, requestImage # export texture, textureMode, textureWrap # export blend, copy, filter, get, loadPixels, set, updatePixels # export blendMode # export createGraphics export createFont, text, textFont # export loadFont export textSize, textWidth # export textAlign, textLeading, textMode # export textAscent, textDescent # state variables # bgCol = RGB(0.94, 0.92, 0.9) #pleasant default background color from Jeff Bezanson's Fractals iJulia notebook (http://nbviewer.ipython.org/url/beowulf.csail.mit.edu/18.337/fractals.ipynb) # fillStuff = true #should drawing elements be filled or not? # fillCol = RGB(0.7,0.7,0.7) #color to be used for filling elements # strokeStuff = true #should drawing elements be stroked or not? # strokeCol = RGB(0,0,0) #color to be used for stroking elements # h = 275 #height of display window # w = 275 #width of display window # left = -1 #scaling of left-hand of x-axis in plotting coordinate system # right = 1 #scaling of right-hand of x-axis in plotting coordinate system # top = 1 #scaling of top-hand of x-axis in plotting coordinate system # bottom = -1 #scaling of bottom-hand of x-axis in plotting coordinate system # cMode = "RGB" #what color space are we using for colors? # title = "Processing.jl" #window title # ellipseMode = CENTER #specify ellipses center, width, and height when drawing it by default # rectMode = CORNER #specficy rects upper-left corner coordinate and its width and height when drawing it by default # cmX # cmY # pmX # pmY # mouse1Pressed # mouse2Pressed # mouse3Pressed # mouse1Released # mouse2Released # mouse3Released # mouse1Dragged # state structure type stateStruct bgCol::ColorValue fillStuff::Bool fillCol::ColorValue strokeStuff::Bool strokeCol::ColorValue h::Int w::Int left::Float32 right::Float32 top::Float32 bottom::Float32 cMode::String title::String tintStuff::Bool ellipseMode::Int rectMode::Int cmX::Int cmY::Int pmX::Int pmY::Int mouse1Pressed::Bool mouse2Pressed::Bool mouse3Pressed::Bool mouse1Released::Bool mouse2Released::Bool mouse3Released::Bool mouse1Dragged::Bool end # initialize state structure and open drawing window state = stateStruct(RGB(0.94, 0.92, 0.9), true, RGB(0.7,0.7,0.7), true, RGB(0,0,0), 275, 275, -1., 1., 1., -1., "RGB", "Processing.jl", false, CENTER, CORNER, 0, 0, 0, 0, false, false, false, true, true, true, false) export state function size(w, h) state.w = w state.h = h GLFW.Init() @osx_only begin GLFW.WindowHint(GLFW.CONTEXT_VERSION_MAJOR, 3) GLFW.WindowHint(GLFW.CONTEXT_VERSION_MINOR, 2) GLFW.WindowHint(GLFW.OPENGL_PROFILE, GLFW.OPENGL_CORE_PROFILE) GLFW.WindowHint(GLFW.OPENGL_FORWARD_COMPAT, GL_TRUE) end state.window = GLFW.CreateWindow(state.w, state.h, "Processing.jl") GLFW.MakeContextCurrent(state.window) end function size() GLFW.Init() @osx_only begin GLFW.WindowHint(GLFW.CONTEXT_VERSION_MAJOR, 3) GLFW.WindowHint(GLFW.CONTEXT_VERSION_MINOR, 2) GLFW.WindowHint(GLFW.OPENGL_PROFILE, GLFW.OPENGL_CORE_PROFILE) GLFW.WindowHint(GLFW.OPENGL_FORWARD_COMPAT, GL_TRUE) end state.window = GLFW.CreateWindow(state.w, state.h, "Processing.jl") GLFW.MakeContextCurrent(state.window) end # special Processing.jl animate() command for smoother animations function animate() GLFW.SwapBuffers(state.window) GLFW.PollEvents() end # allow user to control coordinate system function coordSystem(left, right, top, bottom) Base.Graphics.set_coords(cr, 0, 0, state.w, state.h, left, right, top, bottom) end # Environment # exported environment variables displayHeight = tcl("winfo", "screenwidth", win) displayWidth = tcl("winfo", "screenheight", win) function cursor(cursorType) if cursorType == ARROW elseif cursorType == CROSS elseif cursorType == HAND elseif cursorType == MOVE elseif cursorType == TEXT elseif cursorType == WAIT end end function focused() if return false else return true end end #frameCount #frameRate function Height() (pixelwidth::Float64, pixelheight::Float64) = GLFW.GetFramebufferSize(window) return pixelheight end function noCursor() end function Width() (pixelwidth::Float64, pixelheight::Float64) = GLFW.GetFramebufferSize(window) return pixelwidth end # Shape #createShape #loadShape ## 2D Primitives function arc(xcent, ycent, ellipseW, ellipseH, angle1, angle2, mode) save(cr) move_to(cr, xcent, ycent) scale(cr, ellipseW, ellipseH) new_sub_path(cr) if mode == OPEN arc(cr, 0, 0, 1, angle1, angle2) elseif mode == PIE end if state.strokeStuff set_source(cr, state.strokeCol) stroke_preserve(cr) end if state.fillStuff set_source(cr, state.fillCol) fill(cr) end if mode == CHORD move_to(cos(angle1), sin(angle1)) line_to(cos(angle2), sin(angle2)) end restore(cr) end function ellipse(xcent, ycent, ellipseW, ellipseH) save(cr) if state.ellipseMode == RADIUS move_to(cr, xcent, ycent) scale(cr, ellipseW/2, ellipseH/2) elseif state.ellipseMode == CENTER move_to(cr, xcent, ycent) scale(cr, ellipseW, ellipseH) elseif state.ellipseMode == CORNER move_to(cr, xcent+ellipseW/2, ycent+ellipseH/2) scale(cr, ellipseW, ellipseH) elseif state.ellipseMode == CORNERS move_to(cr, xcent, ycent) scale(cr, ellipseW, ellipseH) end new_sub_path(cr) arc(cr, 0, 0, 1, 0, 2*pi) if state.strokeStuff set_source(cr, state.strokeCol) stroke_preserve(cr) end if state.fillStuff set_source(cr, state.fillCol) fill(cr) end restore(cr) end function line(x1, y1, x2, y2) move_to(cr,x1,y1) line_to(cr,x2,y2) if state.strokeStuff set_source(cr, state.strokeCol) stroke(cr) end end function point(x, y) move_to(cr,x,y) dx, dy = device_to_user_distance!(cr,[1., 0.]) rectangle(cr,x,y,dx,dx) if state.strokeStuff set_source(cr, state.strokeCol) stroke(cr) end end function quad(x1, y1, x2, y2, x3, y3, x4, y4) move_to(cr, x1, y1) line_to(cr, x2, y2) line_to(cr, x3, y3) line_to(cr, x4, y4) close_path(cr) if state.strokeStuff set_source(cr, state.strokeCol) stroke_preserve(cr) end if state.fillStuff set_source(cr, state.fillCol) fill(cr) end end function rect(xtopleft, ytopleft, width, height) if state.rectMode == CORNER rectangle(cr, xtopleft, ytopleft, width, height) elseif state.rectMode == CORNERS # in this case, width and height are # reinterpreted as (x,y) coords of # bottom-right corner rectangle(cr, xtopleft, ytopleft, width-xtopleft, height-ytopleft) elseif state.rectMode == CENTER rectangle(cr, xtopleft-width/2, ytopleft-height/2, width, height) elseif state.rectMode == RADIUS rectangle(cr, xtopleft-width/2, ytopleft-height/2, width/2, height/2) end if state.strokeStuff set_source(cr, state.strokeCol) stroke_preserve(cr) end if state.fillStuff set_source(cr, state.fillCol) fill(cr) end end function triangle(x1,y1,x2,y2,x3,y3) move_to(cr, x1, y1) line_to(cr, x2, y2) line_to(cr, x3, y3) close_path(cr) if state.strokeStuff set_source(cr, state.strokeCol) stroke_preserve(cr) end if state.fillStuff set_source(cr, state.fillCol) fill(cr) end end ## Curves function bezier(x1, y1, x2, y2, x3, y3, x4, y4) move_to(cr, x1, y1); curve_to(cr, x2, y2, x3, y3, x4, y4); if state.strokeStuff set_source(cr, state.strokeCol) stroke_preserve(cr) end end #bezierDetail #bezierPoint #bezierTangent #curve #curveDetail #curvePoint #curveTangent #curveTightness ## Attributes function ellipseMode(eMode) state.ellipseMode = eMode end function noSmooth() end function rectMode(rMode) state.rectMode = rMode end function smooth() end function strokeCap(capType) if capType == ROUND elseif capType == SQUARE elseif capType == PROJECT end end function strokeJoin(joinType) if joinType == MITER elseif joinType == BEVEL elseif joinType == ROUND end end function strokeWeight(newWeight) end ## Vertex # function beginShape() # # end #bezierVertex #curveVertex # function endShape() # # end #quadraticVertex # function vertex(x,y) # # end ## Loading & Displaying #shape #shapeMode ## Input # Mouse function mouseButton() if state.mouse1Pressed return LEFT elseif state.mouse2Pressed return CENTER elseif state.mouse3Pressed return RIGHT end end function mouseClicked() end function mouseDragged() end function mouseMoved() end function mousePressed() return pressed = GLFW.GetMouseButton(window, GLFW.MOUSE_BUTTON_LEFT) == GLFW.PRESS end function mouseReleased() end function mouseWheel() end function mouseX() (mx, my) = GLFW.GetCursorPos(window) return mx end function mouseY() (mx, my) = GLFW.GetCursorPos(window) return my end function pmouseX() return state.pmX end function pmouseY() return state.pmY end ## Transform #applyMatrix() function popMatrix() end function printMatrix() end function pushMatrix() end function resetMatrix() end function rotate(ang) end function scale(sx, sy) end #shearX() #shearY() function translate(x, y) end # Color ## Setting function background(r, g, b, a) state.bgCol = RGB(r, g, b) glClearColor(r, g, b, a) glClear(GL_COLOR_BUFFER_BIT) end function colorMode(mode::String) state.cMode = mode end function fill(r, g, b, a) if state.fillStuff == false state.fillStuff = true end if state.cMode == "RGB" state.fillCol = RGB(r, g, b) else end end function noFill() state.fillStuff = false end function noStroke() state.strokeStuff = false end function stroke(r, g, b, a) if state.strokeStuff == false state.strokeStuff = true end if state.cMode == "RGB" state.strokeCol = RGB(r, g, b) else end end ## Creating & Reading function alpha(c::ColorValue) return c.a end function blue(c::ColorValue) return c.b end function brightness(c::ColorValue) hsv = convert(HSV, c) return hsv.v end function color(r, g, b) return RGB(r, g, b) end function green(c::ColorValue) return c.g end function hue(c::ColorValue) hsv = convert(HSV, c) return hsv.h end function lerpColor(c1::ColorValue, c2::ColorValue, amt::Float32) return weighted_color_mean(amt, c1, c2) end function red(c::ColorValue) return c.r end function saturation(c::ColorValue) hsv = convert(HSV, c) return hsv.s end # Image #function createImage(x, y, colorSpace::String) # #end ## Loading & Displaying function image(img, x, y, w, h) end #imageMode function loadImage(fileName::String) return end function noTint() state.tintStuff = false end #requestImage #function tint() # #end ## Textures #texture #textureMode #textureWrap ## Pixels #blend #copy #filter #get #loadPixels #set #updatePixels # Rendering # function blendMode() # # end #createGraphics # Typography ## Loading & Displaying function createFont(fontName::String, fontSize::Float32) end #loadFont function text(str::String, x, y) end function textFont(fontName::String) end ## Attributes #function textAlign() # #end #textLeading #textMode function textSize(fontSize) end function textWidth(str::String) end ## Metrics #function textAscent(str::String) # extents = scaled_font_extents(cr, str) # return extents[1] #end #function textDescent(str::String) # extents = scaled_font_extents(cr, str) # return extents[2] #end end # module Processing
[ 21412, 28403, 1273, 67, 198, 198, 11748, 10188, 24160, 198, 3500, 12495, 8763, 198, 3500, 10188, 18274, 346, 198, 3500, 10188, 8206, 198, 3500, 10188, 27703, 198, 3500, 18715, 198, 3500, 5315, 198, 3500, 36849, 198, 198, 17256, 7203, 9979, 1187, 13, 20362, 4943, 198, 198, 39344, 43828, 11, 6349, 11964, 198, 39344, 2546, 11, 27280, 11, 38807, 11, 3359, 23106, 11, 3359, 30916, 198, 39344, 5670, 11, 23493, 11, 645, 34, 21471, 198, 2, 10784, 5739, 12332, 11, 5739, 32184, 198, 2, 10784, 2251, 33383, 11, 3440, 33383, 198, 39344, 10389, 11, 30004, 541, 325, 11, 1627, 11, 966, 11, 15094, 11, 13621, 11, 22950, 198, 39344, 307, 89, 959, 198, 2, 10784, 307, 89, 959, 11242, 603, 11, 307, 89, 959, 12727, 11, 307, 89, 959, 43909, 298, 11, 12133, 11, 12133, 11242, 603, 11, 12133, 12727, 11, 12133, 43909, 298, 11, 12133, 51, 432, 1108, 198, 39344, 14000, 25844, 11, 14000, 15610, 11, 14000, 18234, 11, 645, 7556, 5226, 11, 7209, 198, 39344, 30004, 541, 325, 19076, 11, 13621, 19076, 198, 2, 10784, 2221, 33383, 11, 886, 33383, 11, 37423, 198, 2, 10784, 307, 89, 959, 13414, 16886, 11, 12133, 13414, 16886, 11, 15094, 81, 1512, 13414, 16886, 198, 2, 10784, 5485, 11, 5485, 19076, 198, 39344, 10211, 21864, 11, 10211, 8164, 276, 11, 10211, 6187, 14655, 11, 10211, 44, 2668, 11, 10211, 47, 2790, 198, 39344, 10211, 45037, 11, 10211, 45307, 11, 10211, 55, 11, 10211, 56, 11, 9114, 1076, 55, 11, 9114, 1076, 56, 198, 39344, 4469, 11, 6070, 11, 645, 33762, 11, 3124, 19076, 11, 645, 1273, 305, 365, 11, 14000, 198, 2, 10784, 4174, 46912, 198, 39344, 1461, 46912, 11, 3601, 46912, 11, 4574, 46912, 11, 13259, 46912, 11, 23064, 198, 39344, 5046, 11, 673, 283, 55, 11, 673, 283, 56, 11, 15772, 198, 39344, 17130, 11, 4171, 11, 22204, 11, 3124, 11, 4077, 11, 37409, 11, 300, 263, 79, 10258, 11, 2266, 11, 36275, 198, 2, 10784, 2251, 5159, 198, 39344, 2939, 11, 3440, 5159, 11, 645, 51, 600, 198, 2, 10784, 2939, 19076, 11, 34791, 11, 2581, 5159, 198, 2, 10784, 11743, 11, 11743, 19076, 11, 11743, 54, 2416, 198, 2, 10784, 13516, 11, 4866, 11, 8106, 11, 651, 11, 3440, 47, 14810, 11, 900, 11, 4296, 47, 14810, 198, 2, 10784, 13516, 19076, 198, 2, 10784, 2251, 18172, 198, 39344, 2251, 23252, 11, 2420, 11, 2420, 23252, 198, 2, 10784, 3440, 23252, 198, 39344, 2420, 10699, 11, 2420, 30916, 198, 2, 10784, 2420, 2348, 570, 11, 2420, 20451, 278, 11, 2420, 19076, 198, 2, 10784, 2420, 1722, 1087, 11, 2420, 5960, 1087, 198, 198, 2, 1181, 9633, 198, 198, 2, 275, 70, 5216, 796, 25228, 7, 15, 13, 5824, 11, 657, 13, 5892, 11, 657, 13, 24, 8, 1303, 21109, 4277, 4469, 3124, 422, 5502, 1355, 89, 23103, 338, 40548, 874, 1312, 16980, 544, 20922, 357, 4023, 1378, 46803, 1177, 263, 13, 541, 7535, 13, 2398, 14, 6371, 14, 1350, 322, 4754, 13, 6359, 603, 13, 2781, 13, 15532, 14, 1507, 13, 31496, 14, 69, 974, 874, 13, 541, 2047, 65, 8, 198, 2, 6070, 1273, 1648, 796, 2081, 1303, 21754, 8263, 4847, 307, 5901, 393, 407, 30, 198, 2, 6070, 5216, 796, 25228, 7, 15, 13, 22, 11, 15, 13, 22, 11, 15, 13, 22, 8, 1303, 8043, 284, 307, 973, 329, 12591, 4847, 198, 2, 14000, 1273, 1648, 796, 2081, 1303, 21754, 8263, 4847, 307, 9660, 9091, 393, 407, 30, 198, 2, 14000, 5216, 796, 25228, 7, 15, 11, 15, 11, 15, 8, 1303, 8043, 284, 307, 973, 329, 9660, 3364, 4847, 198, 2, 289, 796, 25829, 1303, 17015, 286, 3359, 4324, 198, 2, 266, 796, 25829, 1303, 10394, 286, 3359, 4324, 198, 2, 1364, 796, 532, 16, 1303, 1416, 4272, 286, 1364, 12, 4993, 286, 2124, 12, 22704, 287, 29353, 20435, 1080, 198, 2, 826, 796, 352, 1303, 1416, 4272, 286, 826, 12, 4993, 286, 2124, 12, 22704, 287, 29353, 20435, 1080, 198, 2, 1353, 796, 352, 1303, 1416, 4272, 286, 1353, 12, 4993, 286, 2124, 12, 22704, 287, 29353, 20435, 1080, 198, 2, 4220, 796, 532, 16, 1303, 1416, 4272, 286, 4220, 12, 4993, 286, 2124, 12, 22704, 287, 29353, 20435, 1080, 198, 2, 269, 19076, 796, 366, 36982, 1, 1303, 10919, 3124, 2272, 389, 356, 1262, 329, 7577, 30, 198, 2, 3670, 796, 366, 18709, 278, 13, 20362, 1, 1303, 17497, 3670, 198, 2, 30004, 541, 325, 19076, 796, 33269, 1137, 1303, 16684, 1958, 30004, 2419, 274, 3641, 11, 9647, 11, 290, 6001, 618, 8263, 340, 416, 4277, 198, 2, 13621, 19076, 796, 23929, 21479, 1303, 4125, 12993, 4611, 13621, 82, 6727, 12, 9464, 5228, 20435, 290, 663, 9647, 290, 6001, 618, 8263, 340, 416, 4277, 198, 2, 12067, 55, 198, 2, 12067, 56, 198, 2, 9114, 55, 198, 2, 9114, 56, 198, 2, 10211, 16, 47, 2790, 198, 2, 10211, 17, 47, 2790, 198, 2, 10211, 18, 47, 2790, 198, 2, 10211, 16, 45037, 198, 2, 10211, 17, 45037, 198, 2, 10211, 18, 45037, 198, 2, 10211, 16, 6187, 14655, 198, 198, 2, 1181, 4645, 198, 198, 4906, 1181, 44909, 198, 220, 220, 220, 275, 70, 5216, 3712, 10258, 11395, 198, 220, 220, 220, 6070, 1273, 1648, 3712, 33, 970, 198, 220, 220, 220, 6070, 5216, 3712, 10258, 11395, 198, 220, 220, 220, 14000, 1273, 1648, 3712, 33, 970, 198, 220, 220, 220, 14000, 5216, 3712, 10258, 11395, 198, 220, 220, 220, 289, 3712, 5317, 198, 220, 220, 220, 266, 3712, 5317, 198, 220, 220, 220, 1364, 3712, 43879, 2624, 198, 220, 220, 220, 826, 3712, 43879, 2624, 198, 220, 220, 220, 1353, 3712, 43879, 2624, 198, 220, 220, 220, 4220, 3712, 43879, 2624, 198, 220, 220, 220, 269, 19076, 3712, 10100, 198, 220, 220, 220, 3670, 3712, 10100, 198, 220, 220, 220, 34791, 1273, 1648, 3712, 33, 970, 198, 220, 220, 220, 30004, 541, 325, 19076, 3712, 5317, 198, 220, 220, 220, 13621, 19076, 3712, 5317, 198, 220, 220, 220, 12067, 55, 3712, 5317, 198, 220, 220, 220, 12067, 56, 3712, 5317, 198, 220, 220, 220, 9114, 55, 3712, 5317, 198, 220, 220, 220, 9114, 56, 3712, 5317, 198, 220, 220, 220, 10211, 16, 47, 2790, 3712, 33, 970, 198, 220, 220, 220, 10211, 17, 47, 2790, 3712, 33, 970, 198, 220, 220, 220, 10211, 18, 47, 2790, 3712, 33, 970, 198, 220, 220, 220, 10211, 16, 45037, 3712, 33, 970, 198, 220, 220, 220, 10211, 17, 45037, 3712, 33, 970, 198, 220, 220, 220, 10211, 18, 45037, 3712, 33, 970, 198, 220, 220, 220, 10211, 16, 6187, 14655, 3712, 33, 970, 198, 437, 198, 198, 2, 41216, 1181, 4645, 290, 1280, 8263, 4324, 198, 5219, 796, 1181, 44909, 7, 36982, 7, 15, 13, 5824, 11, 657, 13, 5892, 11, 657, 13, 24, 828, 2081, 11, 25228, 7, 15, 13, 22, 11, 15, 13, 22, 11, 15, 13, 22, 828, 2081, 11, 25228, 7, 15, 11, 15, 11, 15, 828, 25829, 11, 25829, 11, 532, 16, 1539, 352, 1539, 352, 1539, 532, 16, 1539, 366, 36982, 1600, 366, 18709, 278, 13, 20362, 1600, 3991, 11, 33269, 1137, 11, 23929, 21479, 11, 657, 11, 657, 11, 657, 11, 657, 11, 3991, 11, 3991, 11, 3991, 11, 2081, 11, 2081, 11, 2081, 11, 3991, 8, 198, 39344, 1181, 198, 198, 8818, 2546, 7, 86, 11, 289, 8, 198, 220, 220, 220, 1181, 13, 86, 796, 266, 198, 220, 220, 220, 1181, 13, 71, 796, 289, 628, 220, 220, 220, 10188, 24160, 13, 31768, 3419, 628, 220, 220, 220, 2488, 418, 87, 62, 8807, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 10943, 32541, 62, 43717, 62, 5673, 41, 1581, 11, 513, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 10943, 32541, 62, 43717, 62, 23678, 1581, 11, 362, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 3185, 1677, 8763, 62, 31190, 25664, 11, 10188, 24160, 13, 3185, 1677, 8763, 62, 34, 6965, 62, 31190, 25664, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 3185, 1677, 8763, 62, 13775, 39743, 62, 9858, 47, 1404, 11, 10188, 62, 5446, 8924, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1181, 13, 17497, 796, 10188, 24160, 13, 16447, 27703, 7, 5219, 13, 86, 11, 1181, 13, 71, 11, 366, 18709, 278, 13, 20362, 4943, 198, 220, 220, 220, 10188, 24160, 13, 12050, 21947, 11297, 7, 5219, 13, 17497, 8, 198, 437, 198, 198, 8818, 2546, 3419, 198, 220, 220, 220, 10188, 24160, 13, 31768, 3419, 628, 220, 220, 220, 2488, 418, 87, 62, 8807, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 10943, 32541, 62, 43717, 62, 5673, 41, 1581, 11, 513, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 10943, 32541, 62, 43717, 62, 23678, 1581, 11, 362, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 3185, 1677, 8763, 62, 31190, 25664, 11, 10188, 24160, 13, 3185, 1677, 8763, 62, 34, 6965, 62, 31190, 25664, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 24160, 13, 27703, 39, 600, 7, 8763, 24160, 13, 3185, 1677, 8763, 62, 13775, 39743, 62, 9858, 47, 1404, 11, 10188, 62, 5446, 8924, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1181, 13, 17497, 796, 10188, 24160, 13, 16447, 27703, 7, 5219, 13, 86, 11, 1181, 13, 71, 11, 366, 18709, 278, 13, 20362, 4943, 198, 220, 220, 220, 10188, 24160, 13, 12050, 21947, 11297, 7, 5219, 13, 17497, 8, 198, 437, 198, 198, 2, 2041, 28403, 13, 20362, 43828, 3419, 3141, 329, 32686, 22407, 198, 8818, 43828, 3419, 198, 220, 220, 220, 10188, 24160, 13, 10462, 499, 36474, 364, 7, 5219, 13, 17497, 8, 198, 220, 220, 220, 10188, 24160, 13, 39176, 37103, 3419, 198, 437, 198, 198, 2, 1249, 2836, 284, 1630, 20435, 1080, 198, 8818, 6349, 11964, 7, 9464, 11, 826, 11, 1353, 11, 4220, 8, 198, 220, 220, 220, 7308, 13, 18172, 13, 2617, 62, 1073, 3669, 7, 6098, 11, 657, 11, 657, 11, 1181, 13, 86, 11, 1181, 13, 71, 11, 1364, 11, 826, 11, 1353, 11, 4220, 8, 198, 437, 198, 198, 2, 9344, 198, 198, 2, 29050, 2858, 9633, 198, 13812, 23106, 796, 256, 565, 7203, 5404, 6513, 1600, 366, 9612, 10394, 1600, 1592, 8, 198, 13812, 30916, 796, 256, 565, 7203, 5404, 6513, 1600, 366, 9612, 17015, 1600, 1592, 8, 198, 198, 8818, 23493, 7, 66, 21471, 6030, 8, 198, 220, 220, 220, 611, 23493, 6030, 6624, 5923, 49, 3913, 628, 220, 220, 220, 2073, 361, 23493, 6030, 6624, 8740, 18420, 628, 220, 220, 220, 2073, 361, 23493, 6030, 6624, 367, 6981, 628, 220, 220, 220, 2073, 361, 23493, 6030, 6624, 13070, 6089, 628, 220, 220, 220, 2073, 361, 23493, 6030, 6624, 40383, 628, 220, 220, 220, 2073, 361, 23493, 6030, 6624, 16400, 2043, 628, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 5670, 3419, 198, 220, 220, 220, 611, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 3991, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2081, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2, 14535, 12332, 198, 2, 14535, 32184, 198, 198, 8818, 27280, 3419, 198, 197, 7, 32515, 10394, 3712, 43879, 2414, 11, 17465, 17015, 3712, 43879, 2414, 8, 796, 10188, 24160, 13, 3855, 19778, 22252, 10699, 7, 17497, 8, 198, 220, 220, 220, 1441, 17465, 17015, 198, 437, 198, 198, 8818, 645, 34, 21471, 3419, 198, 198, 437, 198, 198, 8818, 38807, 3419, 198, 197, 7, 32515, 10394, 3712, 43879, 2414, 11, 17465, 17015, 3712, 43879, 2414, 8, 796, 10188, 24160, 13, 3855, 19778, 22252, 10699, 7, 17497, 8, 198, 220, 220, 220, 1441, 17465, 10394, 198, 437, 198, 198, 2, 25959, 198, 198, 2, 17953, 33383, 198, 2, 2220, 33383, 198, 198, 2235, 362, 35, 11460, 20288, 198, 198, 8818, 10389, 7, 87, 1087, 11, 331, 1087, 11, 30004, 541, 325, 54, 11, 30004, 541, 325, 39, 11, 9848, 16, 11, 9848, 17, 11, 4235, 8, 198, 220, 220, 220, 3613, 7, 6098, 8, 198, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 1087, 11, 331, 1087, 8, 198, 220, 220, 220, 5046, 7, 6098, 11, 30004, 541, 325, 54, 11, 30004, 541, 325, 39, 8, 198, 220, 220, 220, 649, 62, 7266, 62, 6978, 7, 6098, 8, 198, 220, 220, 220, 611, 4235, 6624, 38303, 198, 220, 220, 220, 220, 220, 220, 220, 10389, 7, 6098, 11, 657, 11, 657, 11, 352, 11, 9848, 16, 11, 9848, 17, 8, 198, 220, 220, 220, 2073, 361, 4235, 6624, 350, 10008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 62, 18302, 3760, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 20797, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 20797, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 6070, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 4235, 6624, 5870, 12532, 198, 220, 220, 220, 220, 220, 220, 220, 1445, 62, 1462, 7, 6966, 7, 9248, 16, 828, 7813, 7, 9248, 16, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 1627, 62, 1462, 7, 6966, 7, 9248, 17, 828, 7813, 7, 9248, 17, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 11169, 7, 6098, 8, 198, 437, 198, 198, 8818, 30004, 541, 325, 7, 87, 1087, 11, 331, 1087, 11, 30004, 541, 325, 54, 11, 30004, 541, 325, 39, 8, 198, 220, 220, 220, 3613, 7, 6098, 8, 198, 220, 220, 220, 611, 1181, 13, 695, 541, 325, 19076, 6624, 33540, 40, 2937, 198, 220, 220, 220, 220, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 1087, 11, 331, 1087, 8, 198, 220, 220, 220, 220, 220, 220, 220, 5046, 7, 6098, 11, 30004, 541, 325, 54, 14, 17, 11, 30004, 541, 325, 39, 14, 17, 8, 198, 220, 220, 220, 2073, 361, 1181, 13, 695, 541, 325, 19076, 6624, 33269, 1137, 198, 220, 220, 220, 220, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 1087, 11, 331, 1087, 8, 198, 220, 220, 220, 220, 220, 220, 220, 5046, 7, 6098, 11, 30004, 541, 325, 54, 11, 30004, 541, 325, 39, 8, 198, 220, 220, 220, 2073, 361, 1181, 13, 695, 541, 325, 19076, 6624, 23929, 21479, 198, 220, 220, 220, 220, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 1087, 10, 695, 541, 325, 54, 14, 17, 11, 331, 1087, 10, 695, 541, 325, 39, 14, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 5046, 7, 6098, 11, 30004, 541, 325, 54, 11, 30004, 541, 325, 39, 8, 198, 220, 220, 220, 2073, 361, 1181, 13, 695, 541, 325, 19076, 6624, 23929, 45, 4877, 198, 220, 220, 220, 220, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 1087, 11, 331, 1087, 8, 198, 220, 220, 220, 220, 220, 220, 220, 5046, 7, 6098, 11, 30004, 541, 325, 54, 11, 30004, 541, 325, 39, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 649, 62, 7266, 62, 6978, 7, 6098, 8, 198, 220, 220, 220, 10389, 7, 6098, 11, 657, 11, 657, 11, 352, 11, 657, 11, 362, 9, 14415, 8, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 62, 18302, 3760, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 20797, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 20797, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 6070, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 11169, 7, 6098, 8, 198, 437, 198, 198, 8818, 1627, 7, 87, 16, 11, 331, 16, 11, 2124, 17, 11, 331, 17, 8, 198, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 87, 16, 11, 88, 16, 8, 198, 220, 220, 220, 1627, 62, 1462, 7, 6098, 11, 87, 17, 11, 88, 17, 8, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 966, 7, 87, 11, 331, 8, 198, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 87, 11, 88, 8, 198, 220, 220, 220, 44332, 11, 20268, 796, 3335, 62, 1462, 62, 7220, 62, 30246, 0, 7, 6098, 17414, 16, 1539, 657, 8183, 8, 198, 220, 220, 220, 35991, 7, 6098, 11, 87, 11, 88, 11, 34350, 11, 34350, 8, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 15094, 7, 87, 16, 11, 331, 16, 11, 2124, 17, 11, 331, 17, 11, 2124, 18, 11, 331, 18, 11, 2124, 19, 11, 331, 19, 8, 198, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 16, 11, 331, 16, 8, 198, 220, 220, 220, 1627, 62, 1462, 7, 6098, 11, 2124, 17, 11, 331, 17, 8, 198, 220, 220, 220, 1627, 62, 1462, 7, 6098, 11, 2124, 18, 11, 331, 18, 8, 198, 220, 220, 220, 1627, 62, 1462, 7, 6098, 11, 2124, 19, 11, 331, 19, 8, 198, 220, 220, 220, 1969, 62, 6978, 7, 6098, 8, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 62, 18302, 3760, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 20797, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 20797, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 6070, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 13621, 7, 742, 643, 701, 11, 331, 83, 643, 701, 11, 9647, 11, 6001, 8, 198, 220, 220, 220, 611, 1181, 13, 2554, 19076, 6624, 23929, 21479, 198, 220, 220, 220, 220, 220, 220, 220, 35991, 7, 6098, 11, 220, 742, 643, 701, 11, 331, 83, 643, 701, 11, 9647, 11, 6001, 8, 198, 220, 220, 220, 2073, 361, 1181, 13, 2554, 19076, 6624, 23929, 45, 4877, 1303, 287, 428, 1339, 11, 9647, 290, 6001, 389, 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, 1303, 302, 27381, 276, 355, 357, 87, 11, 88, 8, 763, 3669, 286, 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, 1303, 4220, 12, 3506, 5228, 198, 220, 220, 220, 220, 220, 220, 220, 35991, 7, 6098, 11, 220, 742, 643, 701, 11, 331, 83, 643, 701, 11, 9647, 12, 742, 643, 701, 11, 6001, 12, 20760, 643, 701, 8, 198, 220, 220, 220, 2073, 361, 1181, 13, 2554, 19076, 6624, 33269, 1137, 198, 220, 220, 220, 220, 220, 220, 220, 35991, 7, 6098, 11, 220, 742, 643, 701, 12, 10394, 14, 17, 11, 331, 83, 643, 701, 12, 17015, 14, 17, 11, 9647, 11, 6001, 8, 198, 220, 220, 220, 2073, 361, 1181, 13, 2554, 19076, 6624, 33540, 40, 2937, 198, 220, 220, 220, 220, 220, 220, 220, 35991, 7, 6098, 11, 220, 742, 643, 701, 12, 10394, 14, 17, 11, 331, 83, 643, 701, 12, 17015, 14, 17, 11, 9647, 14, 17, 11, 6001, 14, 17, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 62, 18302, 3760, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 20797, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 20797, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 6070, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 22950, 7, 87, 16, 11, 88, 16, 11, 87, 17, 11, 88, 17, 11, 87, 18, 11, 88, 18, 8, 198, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 16, 11, 331, 16, 8, 198, 220, 220, 220, 1627, 62, 1462, 7, 6098, 11, 2124, 17, 11, 331, 17, 8, 198, 220, 220, 220, 1627, 62, 1462, 7, 6098, 11, 2124, 18, 11, 331, 18, 8, 198, 220, 220, 220, 1969, 62, 6978, 7, 6098, 8, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 62, 18302, 3760, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 20797, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 20797, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 6070, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2235, 4424, 1158, 198, 198, 8818, 307, 89, 959, 7, 87, 16, 11, 331, 16, 11, 2124, 17, 11, 331, 17, 11, 2124, 18, 11, 331, 18, 11, 2124, 19, 11, 331, 19, 8, 198, 220, 220, 220, 1445, 62, 1462, 7, 6098, 11, 2124, 16, 11, 331, 16, 1776, 198, 220, 220, 220, 12133, 62, 1462, 7, 6098, 11, 2124, 17, 11, 331, 17, 11, 2124, 18, 11, 331, 18, 11, 2124, 19, 11, 331, 19, 1776, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 10459, 7, 6098, 11, 1181, 13, 30757, 5216, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14000, 62, 18302, 3760, 7, 6098, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2, 1350, 89, 959, 11242, 603, 198, 2, 1350, 89, 959, 12727, 198, 2, 1350, 89, 959, 43909, 298, 198, 2, 22019, 303, 198, 2, 22019, 303, 11242, 603, 198, 2, 22019, 303, 12727, 198, 2, 22019, 303, 43909, 298, 198, 2, 22019, 303, 51, 432, 1108, 198, 198, 2235, 49213, 198, 198, 8818, 30004, 541, 325, 19076, 7, 68, 19076, 8, 198, 220, 220, 220, 1181, 13, 695, 541, 325, 19076, 796, 304, 19076, 198, 437, 198, 198, 8818, 645, 7556, 5226, 3419, 198, 198, 437, 198, 198, 8818, 13621, 19076, 7, 81, 19076, 8, 198, 220, 220, 220, 1181, 13, 2554, 19076, 796, 374, 19076, 198, 437, 198, 198, 8818, 7209, 3419, 198, 198, 437, 198, 198, 8818, 14000, 15610, 7, 11128, 6030, 8, 198, 220, 220, 220, 611, 1451, 6030, 6624, 371, 15919, 628, 220, 220, 220, 2073, 361, 1451, 6030, 6624, 45880, 12203, 628, 220, 220, 220, 2073, 361, 1451, 6030, 6624, 21965, 23680, 628, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 14000, 18234, 7, 22179, 6030, 8, 198, 220, 220, 220, 611, 4654, 6030, 6624, 17168, 1137, 628, 220, 220, 220, 2073, 361, 4654, 6030, 6624, 9348, 18697, 628, 220, 220, 220, 2073, 361, 4654, 6030, 6624, 371, 15919, 628, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 14000, 25844, 7, 3605, 25844, 8, 198, 198, 437, 198, 198, 2235, 4643, 16886, 198, 198, 2, 2163, 2221, 33383, 3419, 198, 2, 198, 2, 886, 198, 198, 2, 1350, 89, 959, 13414, 16886, 198, 2, 22019, 303, 13414, 16886, 198, 198, 2, 2163, 886, 33383, 3419, 198, 2, 198, 2, 886, 198, 198, 2, 421, 41909, 1512, 13414, 16886, 198, 198, 2, 2163, 37423, 7, 87, 11, 88, 8, 198, 2, 198, 2, 886, 198, 198, 2235, 12320, 1222, 16531, 278, 198, 198, 2, 43358, 198, 2, 43358, 19076, 198, 198, 2235, 23412, 198, 198, 2, 21839, 198, 198, 8818, 10211, 21864, 3419, 198, 220, 220, 220, 611, 1181, 13, 35888, 16, 47, 2790, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 12509, 9792, 198, 220, 220, 220, 2073, 361, 1181, 13, 35888, 17, 47, 2790, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 33269, 1137, 198, 220, 220, 220, 2073, 361, 1181, 13, 35888, 18, 47, 2790, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 33621, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 10211, 8164, 276, 3419, 198, 198, 437, 198, 198, 8818, 10211, 6187, 14655, 3419, 198, 198, 437, 198, 198, 8818, 10211, 44, 2668, 3419, 198, 198, 437, 198, 198, 8818, 10211, 47, 2790, 3419, 198, 220, 220, 220, 1441, 12070, 796, 10188, 24160, 13, 3855, 39643, 21864, 7, 17497, 11, 10188, 24160, 13, 44, 2606, 5188, 62, 47526, 11357, 62, 2538, 9792, 8, 6624, 10188, 24160, 13, 32761, 198, 437, 198, 198, 8818, 10211, 45037, 3419, 198, 198, 437, 198, 198, 8818, 10211, 45307, 3419, 198, 198, 437, 198, 198, 8818, 10211, 55, 3419, 198, 220, 220, 220, 357, 36802, 11, 616, 8, 796, 10188, 24160, 13, 3855, 34, 21471, 21604, 7, 17497, 8, 198, 220, 220, 220, 1441, 285, 87, 198, 437, 198, 198, 8818, 10211, 56, 3419, 198, 220, 220, 220, 357, 36802, 11, 616, 8, 796, 10188, 24160, 13, 3855, 34, 21471, 21604, 7, 17497, 8, 198, 220, 220, 220, 1441, 616, 198, 437, 198, 198, 8818, 9114, 1076, 55, 3419, 198, 220, 220, 220, 1441, 1181, 13, 4426, 55, 198, 437, 198, 198, 8818, 9114, 1076, 56, 3419, 198, 220, 220, 220, 1441, 1181, 13, 4426, 56, 198, 437, 198, 198, 2235, 26981, 198, 198, 2, 39014, 46912, 3419, 198, 198, 8818, 1461, 46912, 3419, 198, 198, 437, 198, 198, 8818, 3601, 46912, 3419, 198, 198, 437, 198, 198, 8818, 4574, 46912, 3419, 198, 198, 437, 198, 198, 8818, 13259, 46912, 3419, 198, 198, 437, 198, 198, 8818, 23064, 7, 648, 8, 198, 198, 437, 198, 198, 8818, 5046, 7, 82, 87, 11, 827, 8, 198, 198, 437, 198, 198, 2, 7091, 283, 55, 3419, 198, 2, 7091, 283, 56, 3419, 198, 198, 8818, 15772, 7, 87, 11, 331, 8, 198, 198, 437, 198, 198, 2, 5315, 198, 198, 2235, 25700, 198, 198, 8818, 4469, 7, 81, 11, 308, 11, 275, 11, 257, 8, 198, 220, 220, 220, 1181, 13, 35904, 5216, 796, 25228, 7, 81, 11, 308, 11, 275, 8, 198, 220, 220, 220, 1278, 19856, 10258, 7, 81, 11, 308, 11, 275, 11, 257, 8, 198, 220, 220, 220, 1278, 19856, 7, 8763, 62, 46786, 62, 19499, 45746, 62, 26094, 8, 198, 437, 198, 198, 8818, 3124, 19076, 7, 14171, 3712, 10100, 8, 198, 220, 220, 220, 1181, 13, 66, 19076, 796, 4235, 198, 437, 198, 198, 8818, 6070, 7, 81, 11, 308, 11, 275, 11, 257, 8, 198, 220, 220, 220, 611, 1181, 13, 20797, 1273, 1648, 6624, 3991, 198, 220, 220, 220, 220, 220, 220, 220, 1181, 13, 20797, 1273, 1648, 796, 2081, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 66, 19076, 6624, 366, 36982, 1, 198, 220, 220, 220, 220, 220, 220, 220, 1181, 13, 20797, 5216, 796, 25228, 7, 81, 11, 308, 11, 275, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 645, 33762, 3419, 198, 220, 220, 220, 1181, 13, 20797, 1273, 1648, 796, 3991, 198, 437, 198, 198, 8818, 645, 1273, 305, 365, 3419, 198, 220, 220, 220, 1181, 13, 30757, 1273, 1648, 796, 3991, 198, 437, 198, 198, 8818, 14000, 7, 81, 11, 308, 11, 275, 11, 257, 8, 198, 220, 220, 220, 611, 1181, 13, 30757, 1273, 1648, 6624, 3991, 198, 220, 220, 220, 220, 220, 220, 220, 1181, 13, 30757, 1273, 1648, 796, 2081, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 1181, 13, 66, 19076, 6624, 366, 36982, 1, 198, 220, 220, 220, 220, 220, 220, 220, 1181, 13, 30757, 5216, 796, 25228, 7, 81, 11, 308, 11, 275, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2235, 30481, 1222, 11725, 198, 198, 8818, 17130, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 1441, 269, 13, 64, 198, 437, 198, 198, 8818, 4171, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 1441, 269, 13, 65, 198, 437, 198, 198, 8818, 22204, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 289, 21370, 796, 10385, 7, 7998, 53, 11, 269, 8, 198, 220, 220, 220, 1441, 289, 21370, 13, 85, 198, 437, 198, 198, 8818, 3124, 7, 81, 11, 308, 11, 275, 8, 198, 220, 220, 220, 1441, 25228, 7, 81, 11, 308, 11, 275, 8, 198, 437, 198, 198, 8818, 4077, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 1441, 269, 13, 70, 198, 437, 198, 198, 8818, 37409, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 289, 21370, 796, 10385, 7, 7998, 53, 11, 269, 8, 198, 220, 220, 220, 1441, 289, 21370, 13, 71, 198, 437, 198, 198, 8818, 300, 263, 79, 10258, 7, 66, 16, 3712, 10258, 11395, 11, 269, 17, 3712, 10258, 11395, 11, 716, 83, 3712, 43879, 2624, 8, 198, 220, 220, 220, 1441, 26356, 62, 8043, 62, 32604, 7, 321, 83, 11, 269, 16, 11, 269, 17, 8, 198, 437, 198, 198, 8818, 2266, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 1441, 269, 13, 81, 198, 437, 198, 198, 8818, 36275, 7, 66, 3712, 10258, 11395, 8, 198, 220, 220, 220, 289, 21370, 796, 10385, 7, 7998, 53, 11, 269, 8, 198, 220, 220, 220, 1441, 289, 21370, 13, 82, 198, 437, 198, 198, 2, 7412, 198, 198, 2, 8818, 2251, 5159, 7, 87, 11, 331, 11, 3124, 14106, 3712, 10100, 8, 198, 2, 198, 2, 437, 198, 198, 2235, 12320, 1222, 16531, 278, 198, 198, 8818, 2939, 7, 9600, 11, 2124, 11, 331, 11, 266, 11, 289, 8, 198, 198, 437, 198, 198, 2, 9060, 19076, 198, 198, 8818, 3440, 5159, 7, 7753, 5376, 3712, 10100, 8, 198, 220, 220, 220, 1441, 198, 437, 198, 198, 8818, 645, 51, 600, 3419, 198, 220, 220, 220, 1181, 13, 83, 600, 1273, 1648, 796, 3991, 198, 437, 198, 198, 2, 25927, 5159, 198, 198, 2, 8818, 34791, 3419, 198, 2, 198, 2, 437, 198, 198, 2235, 8255, 942, 198, 198, 2, 41293, 198, 2, 41293, 19076, 198, 2, 41293, 54, 2416, 198, 198, 2235, 350, 14810, 198, 198, 2, 2436, 437, 198, 2, 30073, 198, 2, 24455, 198, 2, 1136, 198, 2, 2220, 47, 14810, 198, 2, 2617, 198, 2, 19119, 47, 14810, 198, 198, 2, 28703, 1586, 198, 198, 2, 2163, 13516, 19076, 3419, 198, 2, 198, 2, 886, 198, 198, 2, 17953, 18172, 198, 198, 2, 17134, 4867, 198, 198, 2235, 12320, 1222, 16531, 278, 198, 198, 8818, 2251, 23252, 7, 10331, 5376, 3712, 10100, 11, 10369, 10699, 3712, 43879, 2624, 8, 198, 198, 437, 198, 198, 2, 2220, 23252, 198, 198, 8818, 2420, 7, 2536, 3712, 10100, 11, 2124, 11, 331, 8, 198, 198, 437, 198, 198, 8818, 2420, 23252, 7, 10331, 5376, 3712, 10100, 8, 198, 198, 437, 198, 198, 2235, 49213, 198, 198, 2, 8818, 2420, 2348, 570, 3419, 198, 2, 198, 2, 437, 198, 198, 2, 5239, 20451, 278, 198, 2, 5239, 19076, 198, 198, 8818, 2420, 10699, 7, 10331, 10699, 8, 198, 198, 437, 198, 198, 8818, 2420, 30916, 7, 2536, 3712, 10100, 8, 198, 198, 437, 198, 198, 2235, 3395, 10466, 198, 198, 2, 8818, 2420, 1722, 1087, 7, 2536, 3712, 10100, 8, 198, 2, 220, 220, 220, 1070, 658, 796, 27464, 62, 10331, 62, 2302, 658, 7, 6098, 11, 965, 8, 198, 2, 220, 220, 220, 1441, 1070, 658, 58, 16, 60, 198, 2, 437, 198, 198, 2, 8818, 2420, 5960, 1087, 7, 2536, 3712, 10100, 8, 198, 2, 220, 220, 220, 1070, 658, 796, 27464, 62, 10331, 62, 2302, 658, 7, 6098, 11, 965, 8, 198, 2, 220, 220, 220, 1441, 1070, 658, 58, 17, 60, 198, 2, 437, 198, 198, 437, 1303, 8265, 28403, 198 ]
2.409593
5,525
using GeometryBasics using GeometryBasics: Mesh using Colors # # Meshes in 3d space # "Compute a mesh from points (vertices) and faces" function mesh3d(ps,fs; vertexColors = nothing ) pps = [Point(ps[i,1],ps[i,2],ps[i,3]) for i in 1:size(ps)[1]] ffs = [TriangleFace(fs[i,1],fs[i,2],fs[i,3]) for i in 1:size(fs)[1]] if(vertexColors != nothing) return meta(Mesh(pps, ffs),vertexColors=vertexColors) end Mesh(pps, ffs) end "Compute Mesh from the coordinates of triangles" function mesh3d(faces_coords::Array{<:Real,2}) nps = Point{3, Float64}[] nfs = NgonFace{3,Int}[] normals = Point{3,Float64}[] vcnt = 1 for i in 1:size(faces_coords,1) p1 = faces_coords[i,1:3] p2 = faces_coords[i,4:6] p3 = faces_coords[i,7:9] push!(nps, Point(p1[1],p1[2],p1[3])) push!(nps, Point(p2[1],p2[2],p2[3])) push!(nps, Point(p3[1],p3[2],p3[3])) push!(nfs, TriangleFace(vcnt,vcnt+1,vcnt+2)) vcnt = vcnt + 3 end Mesh(nps,nfs) end "Compute line segments from vertices coordinates and edges" function edges3d(ps,es; color=RGBA(1,1,1,1), linewidth=1) xs = ps[:,1] ys = ps[:,2] zs = ps[:,3] xes = transpose(xs[es]) yes = transpose(ys[es]) zes = transpose(zs[es]) xes = vec(xes) yes = vec(yes) zes = vec(zes) MeshCat.LineSegments(Point.(xes,yes,zes),LineBasicMaterial(color=color, linewidth=linewidth)) end "Compute line segments from the edges coordinates" function edges3d(es_ps::Array{<:Real,2}; color=RGBA(1,1,1,1), linewidth=1) cnt = 2*size(es_ps,1) x = zeros(cnt) y = zeros(cnt) z = zeros(cnt) x[1:2:cnt] = es_ps[:,1] x[2:2:cnt] = es_ps[:,4] y[1:2:cnt] = es_ps[:,2] y[2:2:cnt] = es_ps[:,5] z[1:2:cnt] = es_ps[:,3] z[2:2:cnt] = es_ps[:,6] mat = LineBasicMaterial(color=color, linewidth=linewidth) LineSegments(Point.(x,y,z),mat) end
[ 3500, 2269, 15748, 15522, 873, 198, 3500, 2269, 15748, 15522, 873, 25, 47529, 198, 3500, 29792, 198, 2, 198, 2, 14937, 956, 287, 513, 67, 2272, 198, 2, 198, 198, 1, 7293, 1133, 257, 19609, 422, 2173, 357, 1851, 1063, 8, 290, 6698, 1, 198, 8818, 19609, 18, 67, 7, 862, 11, 9501, 26, 37423, 5216, 669, 796, 2147, 1267, 198, 220, 220, 220, 279, 862, 796, 685, 12727, 7, 862, 58, 72, 11, 16, 4357, 862, 58, 72, 11, 17, 4357, 862, 58, 72, 11, 18, 12962, 329, 1312, 287, 352, 25, 7857, 7, 862, 38381, 16, 11907, 198, 220, 220, 220, 277, 9501, 796, 685, 14824, 9248, 32388, 7, 9501, 58, 72, 11, 16, 4357, 9501, 58, 72, 11, 17, 4357, 9501, 58, 72, 11, 18, 12962, 329, 1312, 287, 352, 25, 7857, 7, 9501, 38381, 16, 11907, 198, 220, 220, 220, 611, 7, 332, 16886, 5216, 669, 14512, 2147, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 220, 13634, 7, 37031, 7, 41799, 11, 277, 9501, 828, 332, 16886, 5216, 669, 28, 332, 16886, 5216, 669, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 47529, 7, 41799, 11, 277, 9501, 8, 198, 437, 198, 198, 1, 7293, 1133, 47529, 422, 262, 22715, 286, 44360, 1, 198, 8818, 19609, 18, 67, 7, 32186, 62, 1073, 3669, 3712, 19182, 90, 27, 25, 15633, 11, 17, 30072, 198, 220, 220, 220, 299, 862, 796, 6252, 90, 18, 11, 48436, 2414, 92, 21737, 198, 220, 220, 220, 299, 9501, 796, 399, 14520, 32388, 90, 18, 11, 5317, 92, 21737, 198, 220, 220, 220, 2593, 874, 796, 6252, 90, 18, 11, 43879, 2414, 92, 21737, 198, 220, 220, 220, 410, 66, 429, 796, 352, 198, 220, 220, 220, 329, 1312, 287, 352, 25, 7857, 7, 32186, 62, 1073, 3669, 11, 16, 8, 198, 220, 220, 220, 220, 220, 220, 220, 279, 16, 796, 6698, 62, 1073, 3669, 58, 72, 11, 16, 25, 18, 60, 198, 220, 220, 220, 220, 220, 220, 220, 279, 17, 796, 6698, 62, 1073, 3669, 58, 72, 11, 19, 25, 21, 60, 198, 220, 220, 220, 220, 220, 220, 220, 279, 18, 796, 6698, 62, 1073, 3669, 58, 72, 11, 22, 25, 24, 60, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 77, 862, 11, 6252, 7, 79, 16, 58, 16, 4357, 79, 16, 58, 17, 4357, 79, 16, 58, 18, 60, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 77, 862, 11, 6252, 7, 79, 17, 58, 16, 4357, 79, 17, 58, 17, 4357, 79, 17, 58, 18, 60, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 77, 862, 11, 6252, 7, 79, 18, 58, 16, 4357, 79, 18, 58, 17, 4357, 79, 18, 58, 18, 60, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 77, 9501, 11, 33233, 32388, 7, 28435, 429, 11, 28435, 429, 10, 16, 11, 28435, 429, 10, 17, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 410, 66, 429, 796, 410, 66, 429, 1343, 513, 198, 220, 220, 220, 886, 198, 220, 220, 220, 47529, 7, 77, 862, 11, 77, 9501, 8, 198, 437, 198, 198, 1, 7293, 1133, 1627, 17894, 422, 9421, 1063, 22715, 290, 13015, 1, 198, 8818, 13015, 18, 67, 7, 862, 11, 274, 26, 3124, 28, 48192, 4339, 7, 16, 11, 16, 11, 16, 11, 16, 828, 9493, 413, 5649, 28, 16, 8, 198, 220, 220, 220, 2124, 82, 796, 26692, 58, 45299, 16, 60, 198, 220, 220, 220, 331, 82, 796, 26692, 58, 45299, 17, 60, 198, 220, 220, 220, 1976, 82, 796, 26692, 58, 45299, 18, 60, 198, 220, 220, 220, 2124, 274, 796, 1007, 3455, 7, 34223, 58, 274, 12962, 198, 220, 220, 220, 3763, 796, 1007, 3455, 7, 893, 58, 274, 12962, 198, 220, 220, 220, 1976, 274, 796, 1007, 3455, 7, 89, 82, 58, 274, 12962, 198, 220, 220, 220, 2124, 274, 796, 43030, 7, 48169, 8, 198, 220, 220, 220, 3763, 796, 43030, 7, 8505, 8, 198, 220, 220, 220, 1976, 274, 796, 43030, 7, 12271, 8, 198, 220, 220, 220, 47529, 21979, 13, 13949, 41030, 902, 7, 12727, 12195, 48169, 11, 8505, 11, 12271, 828, 13949, 26416, 17518, 7, 8043, 28, 8043, 11, 9493, 413, 5649, 28, 2815, 413, 5649, 4008, 198, 437, 198, 198, 1, 7293, 1133, 1627, 17894, 422, 262, 13015, 22715, 1, 198, 8818, 13015, 18, 67, 7, 274, 62, 862, 3712, 19182, 90, 27, 25, 15633, 11, 17, 19629, 3124, 28, 48192, 4339, 7, 16, 11, 16, 11, 16, 11, 16, 828, 9493, 413, 5649, 28, 16, 8, 198, 220, 220, 220, 269, 429, 796, 362, 9, 7857, 7, 274, 62, 862, 11, 16, 8, 198, 220, 220, 220, 2124, 796, 1976, 27498, 7, 66, 429, 8, 198, 220, 220, 220, 331, 796, 1976, 27498, 7, 66, 429, 8, 198, 220, 220, 220, 1976, 796, 1976, 27498, 7, 66, 429, 8, 198, 220, 220, 220, 2124, 58, 16, 25, 17, 25, 66, 429, 60, 796, 1658, 62, 862, 58, 45299, 16, 60, 198, 220, 220, 220, 2124, 58, 17, 25, 17, 25, 66, 429, 60, 796, 1658, 62, 862, 58, 45299, 19, 60, 198, 220, 220, 220, 331, 58, 16, 25, 17, 25, 66, 429, 60, 796, 1658, 62, 862, 58, 45299, 17, 60, 198, 220, 220, 220, 331, 58, 17, 25, 17, 25, 66, 429, 60, 796, 1658, 62, 862, 58, 45299, 20, 60, 198, 220, 220, 220, 1976, 58, 16, 25, 17, 25, 66, 429, 60, 796, 1658, 62, 862, 58, 45299, 18, 60, 198, 220, 220, 220, 1976, 58, 17, 25, 17, 25, 66, 429, 60, 796, 1658, 62, 862, 58, 45299, 21, 60, 198, 220, 220, 220, 2603, 796, 6910, 26416, 17518, 7, 8043, 28, 8043, 11, 9493, 413, 5649, 28, 2815, 413, 5649, 8, 198, 220, 220, 220, 6910, 41030, 902, 7, 12727, 12195, 87, 11, 88, 11, 89, 828, 6759, 8, 198, 437, 198 ]
1.934542
993
# SAM Reader # ========= mutable struct Reader{S <: TranscodingStream} <: BioGenerics.IO.AbstractReader state::State{S} header::Header end function Reader(state::State{S}) where {S <: TranscodingStream} rdr = Reader(state, Header()) cs, ln, f = readheader!(rdr.state.stream, rdr.header, (sam_machine_header.start_state, rdr.state.linenum)) rdr.state.state = sam_machine_body.start_state rdr.state.linenum = ln rdr.state.filled = false return rdr end """ SAM.Reader(input::IO) Create a data reader of the SAM file format. # Arguments * `input`: data source """ function Reader(input::IO) if input isa TranscodingStream return Reader(State(input, 1, 1, false)) end stream = TranscodingStreams.NoopStream(input) return Reader(State(stream, 1, 1, false)) end function Base.eltype(::Type{<:Reader}) return Record end function BioGenerics.IO.stream(reader::Reader) return reader.state.stream end """ header(reader::Reader)::Header Get the header of `reader`. """ function header(reader::Reader)::Header return reader.header end function Base.close(reader::Reader) if reader.state.stream isa IO close(reader.state.stream) end return nothing end function index!(record::MetaInfo) stream = TranscodingStreams.NoopStream(IOBuffer(record.data)) found = index!(stream, record) if !found throw(ArgumentError("invalid SAM metadata")) end return record end function index!(record::Record) stream = TranscodingStreams.NoopStream(IOBuffer(record.data)) found = index!(stream, record) if !found throw(ArgumentError("invalid SAM record")) end return record end function Base.iterate(reader::Reader, nextone::Record = Record()) if BioGenerics.IO.tryread!(reader, nextone) === nothing return nothing end return copy(nextone), empty!(nextone) end """ read!(rdr::Reader, rec::Record) Read a `Record` into `rec`; overwriting or adding to existing field values. It is assumed that `rec` is already initialized or empty. """ function Base.read!(rdr::Reader, record::Record) cs, ln, found = readrecord!(rdr.state.stream, record, (rdr.state.state, rdr.state.linenum)) rdr.state.state = cs rdr.state.linenum = ln rdr.state.filled = found if found return record end if cs == 0 || eof(rdr.state.stream) throw(EOFError()) end throw(ArgumentError("malformed SAM file")) end
[ 2, 28844, 25342, 198, 2, 796, 2559, 198, 198, 76, 18187, 2878, 25342, 90, 50, 1279, 25, 3602, 66, 7656, 12124, 92, 1279, 25, 16024, 8645, 873, 13, 9399, 13, 23839, 33634, 198, 220, 220, 220, 1181, 3712, 9012, 90, 50, 92, 198, 220, 220, 220, 13639, 3712, 39681, 198, 437, 198, 198, 8818, 25342, 7, 5219, 3712, 9012, 90, 50, 30072, 810, 1391, 50, 1279, 25, 3602, 66, 7656, 12124, 92, 628, 220, 220, 220, 374, 7109, 796, 25342, 7, 5219, 11, 48900, 28955, 628, 220, 220, 220, 50115, 11, 300, 77, 11, 277, 796, 1100, 25677, 0, 7, 4372, 81, 13, 5219, 13, 5532, 11, 374, 7109, 13, 25677, 11, 357, 37687, 62, 30243, 62, 25677, 13, 9688, 62, 5219, 11, 374, 7109, 13, 5219, 13, 2815, 44709, 4008, 628, 220, 220, 220, 374, 7109, 13, 5219, 13, 5219, 796, 6072, 62, 30243, 62, 2618, 13, 9688, 62, 5219, 198, 220, 220, 220, 374, 7109, 13, 5219, 13, 2815, 44709, 796, 300, 77, 198, 220, 220, 220, 374, 7109, 13, 5219, 13, 20286, 796, 3991, 628, 220, 220, 220, 1441, 374, 7109, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 28844, 13, 33634, 7, 15414, 3712, 9399, 8, 198, 198, 16447, 257, 1366, 9173, 286, 262, 28844, 2393, 5794, 13, 198, 198, 2, 20559, 2886, 198, 9, 4600, 15414, 63, 25, 1366, 2723, 198, 37811, 198, 8818, 25342, 7, 15414, 3712, 9399, 8, 628, 220, 220, 220, 611, 5128, 318, 64, 3602, 66, 7656, 12124, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 25342, 7, 9012, 7, 15414, 11, 352, 11, 352, 11, 3991, 4008, 198, 220, 220, 220, 886, 628, 220, 220, 220, 4269, 796, 3602, 66, 7656, 12124, 82, 13, 2949, 404, 12124, 7, 15414, 8, 628, 220, 220, 220, 1441, 25342, 7, 9012, 7, 5532, 11, 352, 11, 352, 11, 3991, 4008, 198, 198, 437, 198, 198, 8818, 7308, 13, 417, 4906, 7, 3712, 6030, 90, 27, 25, 33634, 30072, 198, 220, 220, 220, 1441, 13266, 198, 437, 198, 198, 8818, 16024, 8645, 873, 13, 9399, 13, 5532, 7, 46862, 3712, 33634, 8, 198, 220, 220, 220, 1441, 9173, 13, 5219, 13, 5532, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 13639, 7, 46862, 3712, 33634, 2599, 25, 39681, 198, 198, 3855, 262, 13639, 286, 4600, 46862, 44646, 198, 37811, 198, 8818, 13639, 7, 46862, 3712, 33634, 2599, 25, 39681, 198, 220, 220, 220, 1441, 9173, 13, 25677, 198, 437, 198, 198, 8818, 7308, 13, 19836, 7, 46862, 3712, 33634, 8, 198, 220, 220, 220, 611, 9173, 13, 5219, 13, 5532, 318, 64, 24418, 198, 220, 220, 220, 220, 220, 220, 220, 1969, 7, 46862, 13, 5219, 13, 5532, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 2147, 198, 437, 198, 198, 8818, 6376, 0, 7, 22105, 3712, 48526, 12360, 8, 198, 220, 220, 220, 4269, 796, 3602, 66, 7656, 12124, 82, 13, 2949, 404, 12124, 7, 9399, 28632, 7, 22105, 13, 7890, 4008, 198, 220, 220, 220, 1043, 796, 6376, 0, 7, 5532, 11, 1700, 8, 198, 220, 220, 220, 611, 5145, 9275, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 28100, 1713, 12331, 7203, 259, 12102, 28844, 20150, 48774, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 1700, 198, 437, 198, 198, 8818, 6376, 0, 7, 22105, 3712, 23739, 8, 198, 220, 220, 220, 4269, 796, 3602, 66, 7656, 12124, 82, 13, 2949, 404, 12124, 7, 9399, 28632, 7, 22105, 13, 7890, 4008, 198, 220, 220, 220, 1043, 796, 6376, 0, 7, 5532, 11, 1700, 8, 198, 220, 220, 220, 611, 5145, 9275, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 28100, 1713, 12331, 7203, 259, 12102, 28844, 1700, 48774, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 1700, 198, 437, 198, 198, 8818, 7308, 13, 2676, 378, 7, 46862, 3712, 33634, 11, 1306, 505, 3712, 23739, 796, 13266, 28955, 198, 220, 220, 220, 611, 16024, 8645, 873, 13, 9399, 13, 28311, 961, 0, 7, 46862, 11, 1306, 505, 8, 24844, 2147, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2147, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 4866, 7, 19545, 505, 828, 6565, 0, 7, 19545, 505, 8, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 1100, 0, 7, 4372, 81, 3712, 33634, 11, 664, 3712, 23739, 8, 198, 198, 5569, 257, 4600, 23739, 63, 656, 4600, 8344, 63, 26, 6993, 799, 278, 393, 4375, 284, 4683, 2214, 3815, 13, 198, 1026, 318, 9672, 326, 4600, 8344, 63, 318, 1541, 23224, 393, 6565, 13, 198, 37811, 198, 8818, 7308, 13, 961, 0, 7, 4372, 81, 3712, 33634, 11, 1700, 3712, 23739, 8, 628, 220, 220, 220, 50115, 11, 300, 77, 11, 1043, 796, 1100, 22105, 0, 7, 4372, 81, 13, 5219, 13, 5532, 11, 1700, 11, 357, 4372, 81, 13, 5219, 13, 5219, 11, 374, 7109, 13, 5219, 13, 2815, 44709, 4008, 628, 220, 220, 220, 374, 7109, 13, 5219, 13, 5219, 796, 50115, 198, 220, 220, 220, 374, 7109, 13, 5219, 13, 2815, 44709, 796, 300, 77, 198, 220, 220, 220, 374, 7109, 13, 5219, 13, 20286, 796, 1043, 628, 220, 220, 220, 611, 1043, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 1700, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 50115, 6624, 657, 8614, 304, 1659, 7, 4372, 81, 13, 5219, 13, 5532, 8, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 4720, 37, 12331, 28955, 198, 220, 220, 220, 886, 628, 220, 220, 220, 3714, 7, 28100, 1713, 12331, 7203, 7617, 12214, 28844, 2393, 48774, 198, 437, 198 ]
2.673448
934
using DistributedControl using Test @testset "DistributedControl.jl" begin # Write your tests here. end
[ 3500, 4307, 6169, 15988, 198, 3500, 6208, 198, 198, 31, 9288, 2617, 366, 20344, 6169, 15988, 13, 20362, 1, 2221, 198, 220, 220, 220, 1303, 19430, 534, 5254, 994, 13, 198, 437, 198 ]
3.30303
33
# -------------------------------------------------------------------------- # ACE1.jl: Julia implementation of the Atomic Cluster Expansion # Copyright (c) 2019 Christoph Ortner <christophortner0@gmail.com> # Licensed under ASL - see ASL.md for terms and conditions. # -------------------------------------------------------------------------- @testset "PIPotential" begin #--- using ACE1, JuLIP, Test using ACE1: combine #--- @info("Testing :Any Potential to evaluate energy, forces, virial") basis = ACE1.Utils.rpi_basis(species = :Any, N = 3, r0 = 2.7, rcut = 5.0, maxdeg = 8) c = ACE1.Random.randcoeffs(basis) V = combine(basis, c) #--- at1 = rattle!(bulk(:Fe, cubic=true) * (2,2,2), 0.1) at2 = deepcopy(at1); at2.Z[:] .= AtomicNumber(:Al) at3 = deepcopy(at1); at2.Z[1:3:end] .= AtomicNumber(:Al) for f in (energy, forces, virial) println(@test f(V, at1) ≈ f(V, at2) ≈ f(V, at3)) end #--- @info(" ... check that a non-Any potential will fail this test") basis1 = ACE1.Utils.rpi_basis(species = :Fe, N = 3, r0 = 2.7, rcut = 5.0, maxdeg = 8) V1 = combine(basis1, c) # same coefficients println(@test energy(V1, at1) ≈ energy(V, at1)) for at in (at2, at3) println(@test ( try energy(V1, at2) false catch true end )) end #--- end
[ 628, 198, 2, 16529, 35937, 198, 2, 40488, 16, 13, 20362, 25, 22300, 7822, 286, 262, 28976, 38279, 25042, 198, 2, 15069, 357, 66, 8, 13130, 1951, 2522, 31427, 1008, 1279, 43533, 2522, 419, 1008, 15, 31, 14816, 13, 785, 29, 198, 2, 49962, 739, 7054, 43, 532, 766, 7054, 43, 13, 9132, 329, 2846, 290, 3403, 13, 198, 2, 16529, 35937, 628, 198, 31, 9288, 2617, 366, 47, 4061, 313, 1843, 1, 220, 2221, 198, 198, 2, 6329, 628, 198, 3500, 40488, 16, 11, 12585, 43, 4061, 11, 6208, 198, 3500, 40488, 16, 25, 12082, 198, 198, 2, 6329, 198, 198, 31, 10951, 7203, 44154, 1058, 7149, 32480, 284, 13446, 2568, 11, 3386, 11, 5709, 498, 4943, 198, 12093, 271, 796, 40488, 16, 13, 18274, 4487, 13, 81, 14415, 62, 12093, 271, 7, 35448, 796, 1058, 7149, 11, 399, 796, 513, 11, 374, 15, 796, 362, 13, 22, 11, 374, 8968, 796, 642, 13, 15, 11, 3509, 13500, 796, 807, 8, 198, 66, 796, 40488, 16, 13, 29531, 13, 25192, 1073, 14822, 82, 7, 12093, 271, 8, 198, 53, 796, 12082, 7, 12093, 271, 11, 269, 8, 198, 198, 2, 6329, 198, 198, 265, 16, 796, 374, 1999, 0, 7, 65, 12171, 7, 25, 14304, 11, 27216, 28, 7942, 8, 1635, 357, 17, 11, 17, 11, 17, 828, 657, 13, 16, 8, 198, 265, 17, 796, 2769, 30073, 7, 265, 16, 1776, 379, 17, 13, 57, 58, 47715, 764, 28, 28976, 15057, 7, 25, 2348, 8, 198, 265, 18, 796, 2769, 30073, 7, 265, 16, 1776, 379, 17, 13, 57, 58, 16, 25, 18, 25, 437, 60, 764, 28, 28976, 15057, 7, 25, 2348, 8, 198, 198, 1640, 277, 287, 357, 22554, 11, 3386, 11, 5709, 498, 8, 198, 220, 220, 44872, 7, 31, 9288, 277, 7, 53, 11, 379, 16, 8, 15139, 230, 277, 7, 53, 11, 379, 17, 8, 15139, 230, 277, 7, 53, 11, 379, 18, 4008, 198, 437, 198, 198, 2, 6329, 198, 198, 31, 10951, 7203, 2644, 2198, 326, 257, 1729, 12, 7149, 2785, 481, 2038, 428, 1332, 4943, 198, 12093, 271, 16, 796, 40488, 16, 13, 18274, 4487, 13, 81, 14415, 62, 12093, 271, 7, 35448, 796, 1058, 14304, 11, 399, 796, 513, 11, 374, 15, 796, 362, 13, 22, 11, 374, 8968, 796, 642, 13, 15, 11, 3509, 13500, 796, 807, 8, 198, 53, 16, 796, 12082, 7, 12093, 271, 16, 11, 269, 8, 220, 220, 1303, 976, 44036, 198, 198, 35235, 7, 31, 9288, 2568, 7, 53, 16, 11, 379, 16, 8, 15139, 230, 2568, 7, 53, 11, 379, 16, 4008, 198, 1640, 379, 287, 357, 265, 17, 11, 379, 18, 8, 198, 220, 220, 44872, 7, 31, 9288, 357, 198, 220, 220, 220, 220, 220, 1949, 198, 220, 220, 220, 220, 220, 220, 220, 220, 2568, 7, 53, 16, 11, 379, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 3991, 198, 220, 220, 220, 220, 220, 4929, 198, 220, 220, 220, 220, 220, 220, 220, 220, 2081, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 15306, 198, 437, 628, 198, 2, 6329, 198, 198, 437, 198 ]
2.508637
521
using Try: Try, Ok, Err using ...TryExperimental: ConcreteResult Maybe.ok(result::Ok) = Some{Try.oktype(result)}(result.value) Maybe.ok(::Err) = nothing function Maybe.ok(result::ConcreteResult) value = result.value if value isa Ok return Maybe.ok(value) else return nothing end end Maybe.err(::Ok) = nothing Maybe.err(result::Err) = Some{Try.errtype(result)}(result.value) function Maybe.err(result::ConcreteResult) value = result.value if value isa Err return Maybe.err(value) else return nothing end end
[ 3500, 9993, 25, 9993, 11, 6762, 11, 41512, 198, 3500, 2644, 23433, 20468, 9134, 25, 1482, 38669, 23004, 198, 198, 13300, 13, 482, 7, 20274, 3712, 18690, 8, 796, 2773, 90, 23433, 13, 482, 4906, 7, 20274, 38165, 7, 20274, 13, 8367, 8, 198, 13300, 13, 482, 7, 3712, 9139, 81, 8, 796, 2147, 198, 8818, 6674, 13, 482, 7, 20274, 3712, 3103, 38669, 23004, 8, 198, 220, 220, 220, 1988, 796, 1255, 13, 8367, 198, 220, 220, 220, 611, 1988, 318, 64, 6762, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 6674, 13, 482, 7, 8367, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2147, 198, 220, 220, 220, 886, 198, 437, 198, 198, 13300, 13, 8056, 7, 3712, 18690, 8, 796, 2147, 198, 13300, 13, 8056, 7, 20274, 3712, 9139, 81, 8, 796, 2773, 90, 23433, 13, 8056, 4906, 7, 20274, 38165, 7, 20274, 13, 8367, 8, 198, 8818, 6674, 13, 8056, 7, 20274, 3712, 3103, 38669, 23004, 8, 198, 220, 220, 220, 1988, 796, 1255, 13, 8367, 198, 220, 220, 220, 611, 1988, 318, 64, 41512, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 6674, 13, 8056, 7, 8367, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 2147, 198, 220, 220, 220, 886, 198, 437, 198 ]
2.546667
225
using CartesianGP using Base.Test reload("Utilities.jl") @test output_mask(1) == convert(BitString,0b11) @test output_mask(2) == convert(BitString,0b1111) @test output_mask(3) == convert(BitString,0b11111111) @test output_mask(4) == convert(BitString,0b1111111111111111) @test std_input_context(1) == BitString[0b10] @test std_input_context(2) == BitString[0b1100,0b1010] @test std_input_context(3) == BitString[0b11110000,0b11001100,0b10101010] @test std_input_context(4) == BitString[0b1111111100000000,0b1111000011110000,0b1100110011001100,0b1010101010101010]
[ 3500, 13690, 35610, 16960, 198, 3500, 7308, 13, 14402, 198, 198, 260, 2220, 7203, 18274, 2410, 13, 20362, 4943, 198, 198, 31, 9288, 5072, 62, 27932, 7, 16, 8, 6624, 10385, 7, 13128, 10100, 11, 15, 65, 1157, 8, 198, 31, 9288, 5072, 62, 27932, 7, 17, 8, 6624, 10385, 7, 13128, 10100, 11, 15, 65, 26259, 8, 198, 31, 9288, 5072, 62, 27932, 7, 18, 8, 6624, 10385, 7, 13128, 10100, 11, 15, 65, 26259, 26259, 8, 198, 31, 9288, 5072, 62, 27932, 7, 19, 8, 6624, 10385, 7, 13128, 10100, 11, 15, 65, 26259, 26259, 26259, 26259, 8, 198, 198, 31, 9288, 14367, 62, 15414, 62, 22866, 7, 16, 8, 6624, 4722, 10100, 58, 15, 65, 940, 60, 198, 31, 9288, 14367, 62, 15414, 62, 22866, 7, 17, 8, 6624, 4722, 10100, 58, 15, 65, 42060, 11, 15, 65, 8784, 15, 60, 198, 31, 9288, 14367, 62, 15414, 62, 22866, 7, 18, 8, 6624, 4722, 10100, 58, 15, 65, 26259, 2388, 11, 15, 65, 42060, 42060, 11, 15, 65, 8784, 486, 20943, 60, 198, 31, 9288, 14367, 62, 15414, 62, 22866, 7, 19, 8, 6624, 4722, 10100, 58, 15, 65, 26259, 26259, 8269, 11, 15, 65, 26259, 2388, 26259, 2388, 11, 15, 65, 42060, 42060, 42060, 42060, 11, 15, 65, 8784, 486, 486, 486, 486, 486, 20943, 60, 628 ]
2.565611
221
""" ReLU() (l::ReLU)(x) = max(0,x) Rectified Linear Unit function. """ struct ReLU <: Activation end (l::ReLU)(x) = relu.(x) """ Sigm() (l::Sigm)(x) = sigm(x) Sigmoid function """ struct Sigm <: Activation end (l::Sigm)(x) = sigm.(x) """ Tanh() (l::Tanh)(x) = tanh(x) Tangent hyperbolic function """ struct Tanh <: Activation end (l::Tanh)(x) = tanh.(x) """ ELU() (l::ELU)(x) = elu(x) -> Computes x < 0 ? exp(x) - 1 : x Exponential Linear Unit nonlineariy. """ struct ELU <: Activation end (l::ELU)(x) = elu.(x) """ LeakyReLU(α=0.2) (l::LeakyReLU)(x) -> Computes x < 0 ? α*x : x """ mutable struct LeakyReLU <: Activation α::AbstractFloat LeakyReLU(alpha::AbstractFloat=0.2) = new(alpha) end (l::LeakyReLU)(x) = relu.(x) .+ l.α*min.(0,x) """ Dropout(p=0) Dropout Layer. `p` is the droput probability. """ mutable struct Dropout <: Activation p::Real end Dropout(;p=0) = Dropout(p) (l::Dropout)(x; enable=true) = enable ? dropout(x,l.p) : x """ LogSoftMax(dims=:) (l::LogSoftMax)(x) Treat entries in x as as unnormalized log probabilities and return normalized log probabilities. dims is an optional argument, if not specified the normalization is over the whole x, otherwise the normalization is performed over the given dimensions. In particular, if x is a matrix, dims=1 normalizes columns of x and dims=2 normalizes rows of x. """ struct LogSoftMax <: Activation dims::Union{Integer,Colon} end LogSoftMax(;dims=:) = LogSoftMax(dims) (l::LogSoftMax)(x) = logp(x;dims=l.dims) """ SoftMax(dims=:) (l::SoftMax)(x) Treat entries in x as as unnormalized scores and return softmax probabilities. dims is an optional argument, if not specified the normalization is over the whole x, otherwise the normalization is performed over the given dimensions. In particular, if x is a matrix, dims=1 normalizes columns of x and dims=2 normalizes rows of x. """ struct SoftMax <: Activation dims::Union{Integer,Colon} end SoftMax(;dims=:) = SoftMax(dims) (l::SoftMax)(x) = softmax(x;dims=l.dims) """ LogSumExp(dims=:) (l::LogSumExp)(x) Compute log(sum(exp(x);dims)) in a numerically stable manner. dims is an optional argument, if not specified the summation is over the whole x, otherwise the summation is performed over the given dimensions. In particular if x is a matrix, dims=1 sums columns of x and dims=2 sums rows of x. """ struct LogSumExp <: Activation dims::Union{Integer,Colon} end LogSumExp(;dims=:) = LogSumExp(dims) (l::LogSumExp)(x) = logsumexp(x;dims=l.dims)
[ 37811, 198, 220, 220, 220, 797, 41596, 3419, 198, 220, 220, 220, 357, 75, 3712, 3041, 41596, 5769, 87, 8, 796, 3509, 7, 15, 11, 87, 8, 198, 198, 45474, 1431, 44800, 11801, 2163, 13, 198, 37811, 198, 7249, 797, 41596, 1279, 25, 13144, 341, 886, 198, 7, 75, 3712, 3041, 41596, 5769, 87, 8, 796, 823, 84, 12195, 87, 8, 198, 198, 37811, 198, 220, 220, 220, 311, 17225, 3419, 198, 220, 220, 220, 357, 75, 3712, 50, 17225, 5769, 87, 8, 796, 264, 17225, 7, 87, 8, 198, 198, 50, 17225, 1868, 2163, 198, 37811, 198, 7249, 311, 17225, 1279, 25, 13144, 341, 886, 198, 7, 75, 3712, 50, 17225, 5769, 87, 8, 796, 264, 17225, 12195, 87, 8, 198, 198, 37811, 198, 220, 220, 220, 11818, 71, 3419, 198, 220, 220, 220, 357, 75, 3712, 45557, 71, 5769, 87, 8, 796, 25706, 71, 7, 87, 8, 198, 198, 43909, 298, 8718, 65, 4160, 2163, 198, 37811, 198, 7249, 11818, 71, 1279, 25, 13144, 341, 886, 198, 7, 75, 3712, 45557, 71, 5769, 87, 8, 796, 25706, 71, 12195, 87, 8, 628, 198, 37811, 198, 220, 220, 220, 17852, 52, 3419, 198, 220, 220, 220, 357, 75, 3712, 3698, 52, 5769, 87, 8, 796, 1288, 84, 7, 87, 8, 4613, 3082, 1769, 2124, 1279, 657, 5633, 1033, 7, 87, 8, 532, 352, 1058, 2124, 198, 198, 16870, 35470, 44800, 11801, 1729, 29127, 7745, 13, 198, 37811, 198, 7249, 17852, 52, 1279, 25, 13144, 341, 886, 198, 7, 75, 3712, 3698, 52, 5769, 87, 8, 796, 1288, 84, 12195, 87, 8, 198, 198, 37811, 198, 220, 220, 220, 1004, 15492, 3041, 41596, 7, 17394, 28, 15, 13, 17, 8, 198, 220, 220, 220, 357, 75, 3712, 3123, 15492, 3041, 41596, 5769, 87, 8, 4613, 3082, 1769, 2124, 1279, 657, 5633, 26367, 9, 87, 1058, 2124, 198, 37811, 198, 76, 18187, 2878, 1004, 15492, 3041, 41596, 1279, 25, 13144, 341, 198, 220, 220, 220, 26367, 3712, 23839, 43879, 198, 220, 220, 220, 1004, 15492, 3041, 41596, 7, 26591, 3712, 23839, 43879, 28, 15, 13, 17, 8, 796, 649, 7, 26591, 8, 198, 437, 198, 7, 75, 3712, 3123, 15492, 3041, 41596, 5769, 87, 8, 796, 823, 84, 12195, 87, 8, 764, 10, 300, 13, 17394, 9, 1084, 12195, 15, 11, 87, 8, 198, 198, 37811, 198, 220, 220, 220, 14258, 448, 7, 79, 28, 15, 8, 198, 198, 26932, 448, 34398, 13, 4600, 79, 63, 318, 262, 4268, 315, 12867, 13, 198, 37811, 198, 76, 18187, 2878, 14258, 448, 1279, 25, 13144, 341, 198, 220, 220, 220, 279, 3712, 15633, 198, 437, 198, 26932, 448, 7, 26, 79, 28, 15, 8, 796, 14258, 448, 7, 79, 8, 198, 7, 75, 3712, 26932, 448, 5769, 87, 26, 7139, 28, 7942, 8, 796, 7139, 5633, 4268, 448, 7, 87, 11, 75, 13, 79, 8, 1058, 2124, 198, 198, 37811, 198, 220, 220, 220, 5972, 18380, 11518, 7, 67, 12078, 28, 25, 8, 198, 220, 220, 220, 357, 75, 3712, 11187, 18380, 11518, 5769, 87, 8, 198, 198, 51, 630, 12784, 287, 2124, 355, 355, 555, 11265, 1143, 2604, 39522, 290, 1441, 39279, 2604, 39522, 13, 198, 198, 67, 12078, 318, 281, 11902, 4578, 11, 611, 407, 7368, 262, 3487, 1634, 318, 625, 262, 2187, 2124, 11, 4306, 262, 3487, 1634, 318, 6157, 625, 262, 1813, 15225, 13, 554, 198, 3911, 13174, 11, 611, 2124, 318, 257, 17593, 11, 5391, 82, 28, 16, 3487, 4340, 15180, 286, 2124, 290, 5391, 82, 28, 17, 3487, 4340, 15274, 286, 2124, 13, 198, 37811, 198, 7249, 5972, 18380, 11518, 1279, 25, 13144, 341, 198, 220, 220, 220, 5391, 82, 3712, 38176, 90, 46541, 11, 5216, 261, 92, 198, 437, 198, 11187, 18380, 11518, 7, 26, 67, 12078, 28, 25, 8, 796, 5972, 18380, 11518, 7, 67, 12078, 8, 198, 7, 75, 3712, 11187, 18380, 11518, 5769, 87, 8, 796, 2604, 79, 7, 87, 26, 67, 12078, 28, 75, 13, 67, 12078, 8, 198, 198, 37811, 198, 220, 220, 220, 8297, 11518, 7, 67, 12078, 28, 25, 8, 198, 220, 220, 220, 357, 75, 3712, 18380, 11518, 5769, 87, 8, 198, 198, 51, 630, 12784, 287, 2124, 355, 355, 555, 11265, 1143, 8198, 290, 1441, 2705, 9806, 39522, 13, 198, 198, 67, 12078, 318, 281, 11902, 4578, 11, 611, 407, 7368, 262, 3487, 1634, 318, 625, 262, 2187, 2124, 11, 4306, 262, 3487, 1634, 318, 6157, 625, 262, 1813, 15225, 13, 554, 198, 3911, 13174, 11, 611, 2124, 318, 257, 17593, 11, 5391, 82, 28, 16, 3487, 4340, 15180, 286, 2124, 290, 5391, 82, 28, 17, 3487, 4340, 15274, 286, 2124, 13, 198, 37811, 198, 7249, 8297, 11518, 1279, 25, 13144, 341, 198, 220, 220, 220, 5391, 82, 3712, 38176, 90, 46541, 11, 5216, 261, 92, 198, 437, 198, 18380, 11518, 7, 26, 67, 12078, 28, 25, 8, 796, 8297, 11518, 7, 67, 12078, 8, 198, 7, 75, 3712, 18380, 11518, 5769, 87, 8, 796, 2705, 9806, 7, 87, 26, 67, 12078, 28, 75, 13, 67, 12078, 8, 198, 198, 37811, 198, 220, 220, 220, 5972, 13065, 16870, 7, 67, 12078, 28, 25, 8, 198, 220, 220, 220, 357, 75, 3712, 11187, 13065, 16870, 5769, 87, 8, 628, 220, 3082, 1133, 2604, 7, 16345, 7, 11201, 7, 87, 1776, 67, 12078, 4008, 287, 257, 5470, 1146, 8245, 5642, 13, 628, 220, 5391, 82, 318, 281, 11902, 4578, 11, 611, 407, 7368, 262, 30114, 341, 318, 625, 262, 2187, 2124, 11, 4306, 262, 30114, 341, 318, 6157, 625, 262, 1813, 15225, 13, 554, 1948, 611, 2124, 198, 220, 318, 257, 17593, 11, 5391, 82, 28, 16, 21784, 15180, 286, 2124, 290, 5391, 82, 28, 17, 21784, 15274, 286, 2124, 13, 198, 37811, 198, 7249, 5972, 13065, 16870, 1279, 25, 13144, 341, 198, 220, 220, 220, 5391, 82, 3712, 38176, 90, 46541, 11, 5216, 261, 92, 198, 437, 198, 11187, 13065, 16870, 7, 26, 67, 12078, 28, 25, 8, 796, 5972, 13065, 16870, 7, 67, 12078, 8, 198, 7, 75, 3712, 11187, 13065, 16870, 5769, 87, 8, 796, 2604, 16345, 11201, 7, 87, 26, 67, 12078, 28, 75, 13, 67, 12078, 8, 198 ]
2.543393
1,014
using TidalFluxConfigurations, ADCPDataProcessing, PIEMetData, TidalFluxPlots, TidalFluxExampleData, Plots using Base.Test TidalFluxConfigurations.config[:_ADCPDATA_DIR] = Pkg.dir("TidalFluxExampleData","data","adcp") TidalFluxConfigurations.config[:_METDATA_DIR] = Pkg.dir("TidalFluxExampleData","data","met") creek = Creek{:sweeney}() deps = parse_deps(creek) ad1 = load_data(deps[1]) plot(ad1) cs = parse_cs(creek) csd = load_data(cs) # Test the cross-section plot plot(csd) h1,Q1 = computedischarge(ad1,csd) # Test a few Quantities plot(h1) plot(Q1) cals = parse_cals(creek) cald = load_data(cals[1]) plot(cald) calscatter([cald])
[ 3500, 309, 11624, 37, 22564, 16934, 20074, 11, 49169, 5760, 1045, 18709, 278, 11, 30434, 3620, 316, 6601, 11, 309, 11624, 37, 22564, 3646, 1747, 11, 309, 11624, 37, 22564, 16281, 6601, 11, 1345, 1747, 198, 3500, 7308, 13, 14402, 198, 198, 51, 11624, 37, 22564, 16934, 20074, 13, 11250, 58, 25, 62, 2885, 34, 5760, 13563, 62, 34720, 60, 796, 350, 10025, 13, 15908, 7203, 51, 11624, 37, 22564, 16281, 6601, 2430, 7890, 2430, 324, 13155, 4943, 198, 51, 11624, 37, 22564, 16934, 20074, 13, 11250, 58, 25, 62, 47123, 26947, 62, 34720, 60, 796, 350, 10025, 13, 15908, 7203, 51, 11624, 37, 22564, 16281, 6601, 2430, 7890, 2430, 4164, 4943, 198, 198, 66, 10316, 796, 13509, 90, 25, 82, 41681, 92, 3419, 198, 10378, 82, 796, 21136, 62, 10378, 82, 7, 66, 10316, 8, 198, 324, 16, 796, 3440, 62, 7890, 7, 10378, 82, 58, 16, 12962, 198, 198, 29487, 7, 324, 16, 8, 198, 198, 6359, 796, 21136, 62, 6359, 7, 66, 10316, 8, 198, 6359, 67, 796, 3440, 62, 7890, 7, 6359, 8, 198, 198, 2, 6208, 262, 3272, 12, 5458, 7110, 198, 29487, 7, 6359, 67, 8, 198, 198, 71, 16, 11, 48, 16, 796, 29231, 271, 10136, 7, 324, 16, 11, 6359, 67, 8, 198, 198, 2, 6208, 257, 1178, 16972, 871, 198, 29487, 7, 71, 16, 8, 198, 29487, 7, 48, 16, 8, 198, 198, 66, 874, 796, 21136, 62, 66, 874, 7, 66, 10316, 8, 198, 66, 1940, 796, 3440, 62, 7890, 7, 66, 874, 58, 16, 12962, 198, 198, 29487, 7, 66, 1940, 8, 198, 66, 874, 66, 1436, 26933, 66, 1940, 12962, 628 ]
2.362637
273
module IWSLT using Fetch using DataDeps using ..Datasets: Dataset import ..Datasets: testfile, devfile, trainfile import ..Datasets: token_freq, get_vocab export IWSLT2016 function __init__() iwslt2016_init() end include("./iwslt2016.jl") end
[ 21412, 314, 54, 8634, 51, 198, 3500, 376, 7569, 198, 3500, 6060, 12156, 82, 198, 198, 3500, 11485, 27354, 292, 1039, 25, 16092, 292, 316, 198, 11748, 11485, 27354, 292, 1039, 25, 1332, 7753, 11, 1614, 7753, 11, 4512, 7753, 198, 11748, 11485, 27354, 292, 1039, 25, 11241, 62, 19503, 80, 11, 651, 62, 18893, 397, 198, 198, 39344, 314, 54, 8634, 51, 5304, 198, 198, 8818, 11593, 15003, 834, 3419, 198, 220, 220, 220, 1312, 18504, 2528, 5304, 62, 15003, 3419, 198, 437, 198, 198, 17256, 7, 1911, 14, 14246, 82, 2528, 5304, 13, 20362, 4943, 628, 198, 437, 198 ]
2.50495
101
module StructsOfArrays export StructOfArrays immutable StructOfArrays{T,N,U<:Tuple} <: AbstractArray{T,N} arrays::U end @generated function StructOfArrays{T}(::Type{T}, dims::Integer...) (!isleaftype(T) || T.mutable) && return :(throw(ArgumentError("can only create an StructOfArrays of leaf type immutables"))) isempty(T.types) && return :(throw(ArgumentError("cannot create an StructOfArrays of an empty or bitstype"))) N = length(dims) arrtuple = Tuple{[Array{T.types[i],N} for i = 1:length(T.types)]...} :(StructOfArrays{T,$N,$arrtuple}(($([:(Array($(T.types[i]), dims)) for i = 1:length(T.types)]...),))) end StructOfArrays(T::Type, dims::Tuple{Vararg{Integer}}) = StructOfArrays(T, dims...) Base.linearindexing{T<:StructOfArrays}(::Type{T}) = Base.LinearFast() @generated function Base.similar{T}(A::StructOfArrays, ::Type{T}, dims::Dims) if isbits(T) && length(T.types) > 1 :(StructOfArrays(T, dims)) else :(Array(T, dims)) end end Base.convert{T,S,N}(::Type{StructOfArrays{T,N}}, A::AbstractArray{S,N}) = copy!(StructOfArrays(T, size(A)), A) Base.convert{T,S,N}(::Type{StructOfArrays{T}}, A::AbstractArray{S,N}) = convert(StructOfArrays{T,N}, A) Base.convert{T,N}(::Type{StructOfArrays}, A::AbstractArray{T,N}) = convert(StructOfArrays{T,N}, A) Base.size(A::StructOfArrays) = size(A.arrays[1]) Base.size(A::StructOfArrays, d) = size(A.arrays[1], d) @generated function Base.getindex{T}(A::StructOfArrays{T}, i::Integer...) Expr(:block, Expr(:meta, :inline), Expr(:new, T, [:(A.arrays[$j][i...]) for j = 1:length(T.types)]...)) end @generated function Base.setindex!{T}(A::StructOfArrays{T}, x, i::Integer...) quote $(Expr(:meta, :inline)) v = convert(T, x) $([:(A.arrays[$j][i...] = getfield(v, $j)) for j = 1:length(T.types)]...) x end end end # module
[ 21412, 32112, 82, 5189, 3163, 20477, 198, 39344, 32112, 5189, 3163, 20477, 198, 198, 8608, 18187, 32112, 5189, 3163, 20477, 90, 51, 11, 45, 11, 52, 27, 25, 51, 29291, 92, 1279, 25, 27741, 19182, 90, 51, 11, 45, 92, 198, 220, 220, 220, 26515, 3712, 52, 198, 437, 198, 198, 31, 27568, 2163, 32112, 5189, 3163, 20477, 90, 51, 92, 7, 3712, 6030, 90, 51, 5512, 5391, 82, 3712, 46541, 23029, 198, 220, 220, 220, 22759, 20919, 14940, 2981, 7, 51, 8, 8614, 309, 13, 76, 18187, 8, 11405, 1441, 36147, 16939, 7, 28100, 1713, 12331, 7203, 5171, 691, 2251, 281, 32112, 5189, 3163, 20477, 286, 12835, 2099, 2296, 315, 2977, 1, 22305, 198, 220, 220, 220, 318, 28920, 7, 51, 13, 19199, 8, 11405, 1441, 36147, 16939, 7, 28100, 1713, 12331, 7203, 66, 34574, 2251, 281, 32112, 5189, 3163, 20477, 286, 281, 6565, 393, 1643, 301, 2981, 1, 22305, 198, 220, 220, 220, 399, 796, 4129, 7, 67, 12078, 8, 198, 220, 220, 220, 5240, 83, 29291, 796, 309, 29291, 90, 58, 19182, 90, 51, 13, 19199, 58, 72, 4357, 45, 92, 329, 1312, 796, 352, 25, 13664, 7, 51, 13, 19199, 15437, 986, 92, 198, 220, 220, 220, 36147, 44909, 5189, 3163, 20477, 90, 51, 11, 3, 45, 11, 3, 3258, 83, 29291, 92, 7, 16763, 26933, 37498, 19182, 16763, 7, 51, 13, 19199, 58, 72, 46570, 5391, 82, 4008, 329, 1312, 796, 352, 25, 13664, 7, 51, 13, 19199, 15437, 986, 828, 22305, 198, 437, 198, 44909, 5189, 3163, 20477, 7, 51, 3712, 6030, 11, 5391, 82, 3712, 51, 29291, 90, 19852, 853, 90, 46541, 11709, 8, 796, 32112, 5189, 3163, 20477, 7, 51, 11, 5391, 82, 23029, 198, 198, 14881, 13, 29127, 9630, 278, 90, 51, 27, 25, 44909, 5189, 3163, 20477, 92, 7, 3712, 6030, 90, 51, 30072, 796, 7308, 13, 14993, 451, 22968, 3419, 198, 198, 31, 27568, 2163, 7308, 13, 38610, 90, 51, 92, 7, 32, 3712, 44909, 5189, 3163, 20477, 11, 7904, 6030, 90, 51, 5512, 5391, 82, 3712, 35, 12078, 8, 198, 220, 220, 220, 611, 318, 9895, 7, 51, 8, 11405, 4129, 7, 51, 13, 19199, 8, 1875, 352, 198, 220, 220, 220, 220, 220, 220, 220, 36147, 44909, 5189, 3163, 20477, 7, 51, 11, 5391, 82, 4008, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 36147, 19182, 7, 51, 11, 5391, 82, 4008, 198, 220, 220, 220, 886, 198, 437, 198, 198, 14881, 13, 1102, 1851, 90, 51, 11, 50, 11, 45, 92, 7, 3712, 6030, 90, 44909, 5189, 3163, 20477, 90, 51, 11, 45, 92, 5512, 317, 3712, 23839, 19182, 90, 50, 11, 45, 30072, 796, 198, 220, 220, 220, 4866, 0, 7, 44909, 5189, 3163, 20477, 7, 51, 11, 2546, 7, 32, 36911, 317, 8, 198, 14881, 13, 1102, 1851, 90, 51, 11, 50, 11, 45, 92, 7, 3712, 6030, 90, 44909, 5189, 3163, 20477, 90, 51, 92, 5512, 317, 3712, 23839, 19182, 90, 50, 11, 45, 30072, 796, 198, 220, 220, 220, 10385, 7, 44909, 5189, 3163, 20477, 90, 51, 11, 45, 5512, 317, 8, 198, 14881, 13, 1102, 1851, 90, 51, 11, 45, 92, 7, 3712, 6030, 90, 44909, 5189, 3163, 20477, 5512, 317, 3712, 23839, 19182, 90, 51, 11, 45, 30072, 796, 198, 220, 220, 220, 10385, 7, 44909, 5189, 3163, 20477, 90, 51, 11, 45, 5512, 317, 8, 198, 198, 14881, 13, 7857, 7, 32, 3712, 44909, 5189, 3163, 20477, 8, 796, 2546, 7, 32, 13, 3258, 592, 58, 16, 12962, 198, 14881, 13, 7857, 7, 32, 3712, 44909, 5189, 3163, 20477, 11, 288, 8, 796, 2546, 7, 32, 13, 3258, 592, 58, 16, 4357, 288, 8, 198, 198, 31, 27568, 2163, 7308, 13, 1136, 9630, 90, 51, 92, 7, 32, 3712, 44909, 5189, 3163, 20477, 90, 51, 5512, 1312, 3712, 46541, 23029, 198, 220, 220, 220, 1475, 1050, 7, 25, 9967, 11, 1475, 1050, 7, 25, 28961, 11, 1058, 45145, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 1475, 1050, 7, 25, 3605, 11, 309, 11, 685, 37498, 32, 13, 3258, 592, 58, 3, 73, 7131, 72, 986, 12962, 329, 474, 796, 352, 25, 13664, 7, 51, 13, 19199, 15437, 986, 4008, 198, 437, 198, 31, 27568, 2163, 7308, 13, 2617, 9630, 0, 90, 51, 92, 7, 32, 3712, 44909, 5189, 3163, 20477, 90, 51, 5512, 2124, 11, 1312, 3712, 46541, 23029, 198, 220, 220, 220, 9577, 198, 220, 220, 220, 220, 220, 220, 220, 29568, 3109, 1050, 7, 25, 28961, 11, 1058, 45145, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 410, 796, 10385, 7, 51, 11, 2124, 8, 198, 220, 220, 220, 220, 220, 220, 220, 720, 26933, 37498, 32, 13, 3258, 592, 58, 3, 73, 7131, 72, 22345, 796, 651, 3245, 7, 85, 11, 720, 73, 4008, 329, 474, 796, 352, 25, 13664, 7, 51, 13, 19199, 15437, 23029, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 198, 220, 220, 220, 886, 198, 437, 198, 437, 1303, 8265, 198 ]
2.272289
830
mutable struct DataTable dims :: Dict grid_dims :: Dict grid_dims2_str :: Dict data_units :: Dict missing_idx1 :: Dict # with shape (z, x, y) missing_idx2 :: Dict # with shape (x, y, z) flags :: Dict # What are flags for? function DataTable(; Nx, Ny, Nz, mask_sT :: Union{Nothing, AbstractArray{Float64, 3}} = nothing, mask_T :: Union{Nothing, AbstractArray{Float64, 3}} = nothing, ) N1 = 1 Nyp1 = Ny+1 Nzp1 = Nz+1 dims = Dict( "N1" => N1, "Nx" => Nx, "Ny" => Ny, "Nz" => Nz, "Nyp1" => Nyp1, "Nzp1" => Nzp1, ) grid_dims = Dict( :T => (Nz, Nx , Ny ), :U => (Nz, Nx , Ny ), :V => (Nz, Nx , Nyp1), :W => (Nzp1, Nx , Ny ), :sT => (N1, Nx, Ny ), :sU => (N1, Nx, Ny ), :sV => (N1, Nx, Nyp1), :SCALAR => (N1, N1, N1), :cW => (Nzp1, N1, N1), :cT => (Nz, N1, N1), ) # This is used for RecordTool output # Notice that this is oriented dimension so z is the last one grid_dims2_str = Dict( :T => ("Nx", "Ny", "Nz"), :U => ("Nx", "Ny", "Nz"), :V => ("Nx", "Nyp1", "Nz"), :W => ("Nx", "Ny", "Nzp1"), :sT => ("Nx", "Ny", "N1"), :sU => ("Nx", "Ny", "N1"), :sV => ("Nx", "Nyp1", "N1"), :SCALAR => ("N1", "N1", "N1"), :cW => ("N1", "N1", "Nzp1",), :cT => ("N1", "N1", "Nz",), ) data_units = Dict() flags = Dict() missing_idx1 = Dict( :sT => (mask_sT == nothing) ? nothing : mask_sT .== 0, :T => (mask_T == nothing) ? nothing : mask_T .== 0, :U => nothing, :V => nothing, :W => nothing, :UV => nothing, nothing => nothing, ) missing_idx2 = Dict() for (k,v) in missing_idx1 missing_idx2[k] = (v != nothing) ? permutedims(v, [2, 3, 1]) : nothing end return new( dims, grid_dims, grid_dims2_str, data_units, missing_idx1, missing_idx2, flags, ) end end function regVariable!( dt :: DataTable, id :: Union{Symbol, String}, grid :: Symbol, mask :: Union{Symbol, Nothing}, data :: AbstractArray{T}, ) where T N1 = dt.dims["N1"] Nx = dt.dims["Nx"] Ny = dt.dims["Ny"] Nz = dt.dims["Nz"] Nyp1 = dt.dims["Nyp1"] Nzp1 = dt.dims["Nzp1"] if haskey(dt.data_units, id) throw(ErrorException("Error: variable id " * String(id) * " already exists.")) end dim = dt.grid_dims[grid] dtype = eltype(data) if ! (dtype in (Float64, Int64)) throw(ErrorException("Invalid data type. Only Float64 and Int64 are accepted")) end if Tuple(dim) != size(data) println("Expect ", dim) println("Get ", size(data)) throw(ErrorException("Provided data does not have correct dimension: " * string(id))) end if dtype != T throw(ErrorException("dtype and provided data does not match.")) end dt.data_units[id] = DataUnit( dt, id, grid, mask, data, ) dt.flags[id] = 0 end
[ 198, 76, 18187, 2878, 6060, 10962, 628, 220, 220, 220, 5391, 82, 220, 220, 220, 220, 220, 220, 220, 7904, 360, 713, 198, 220, 220, 220, 10706, 62, 67, 12078, 220, 220, 7904, 360, 713, 198, 220, 220, 220, 10706, 62, 67, 12078, 17, 62, 2536, 220, 7904, 360, 713, 198, 220, 220, 220, 1366, 62, 41667, 220, 7904, 360, 713, 198, 220, 220, 220, 4814, 62, 312, 87, 16, 7904, 360, 713, 220, 220, 1303, 351, 5485, 357, 89, 11, 2124, 11, 331, 8, 198, 220, 220, 220, 4814, 62, 312, 87, 17, 7904, 360, 713, 220, 220, 1303, 351, 5485, 357, 87, 11, 331, 11, 1976, 8, 198, 220, 220, 220, 9701, 220, 220, 220, 220, 220, 220, 7904, 360, 713, 220, 220, 220, 1303, 1867, 389, 9701, 329, 30, 220, 628, 220, 220, 220, 2163, 6060, 10962, 7, 26, 198, 220, 220, 220, 220, 220, 220, 220, 399, 87, 11, 198, 220, 220, 220, 220, 220, 220, 220, 17735, 11, 198, 220, 220, 220, 220, 220, 220, 220, 399, 89, 11, 198, 220, 220, 220, 220, 220, 220, 220, 9335, 62, 82, 51, 220, 220, 220, 7904, 4479, 90, 18465, 11, 27741, 19182, 90, 43879, 2414, 11, 513, 11709, 796, 2147, 11, 198, 220, 220, 220, 220, 220, 220, 220, 9335, 62, 51, 220, 220, 220, 220, 7904, 4479, 90, 18465, 11, 27741, 19182, 90, 43879, 2414, 11, 513, 11709, 796, 2147, 11, 198, 220, 220, 220, 1267, 628, 220, 220, 220, 220, 220, 220, 220, 399, 16, 796, 352, 198, 220, 220, 220, 220, 220, 220, 220, 399, 4464, 16, 796, 17735, 10, 16, 198, 220, 220, 220, 220, 220, 220, 220, 399, 89, 79, 16, 796, 399, 89, 10, 16, 628, 220, 220, 220, 220, 220, 220, 220, 5391, 82, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 45, 16, 1, 5218, 399, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 45, 87, 1, 5218, 399, 87, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 45, 88, 1, 5218, 17735, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 45, 89, 1, 5218, 399, 89, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 45, 4464, 16, 1, 5218, 399, 4464, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 45, 89, 79, 16, 1, 5218, 399, 89, 79, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 628, 198, 220, 220, 220, 220, 220, 220, 220, 10706, 62, 67, 12078, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 51, 220, 5218, 357, 45, 89, 11, 220, 220, 399, 87, 220, 837, 17735, 220, 10612, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 52, 220, 5218, 357, 45, 89, 11, 220, 220, 399, 87, 220, 837, 17735, 220, 10612, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 53, 220, 5218, 357, 45, 89, 11, 220, 220, 399, 87, 220, 837, 399, 4464, 16, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 54, 220, 5218, 357, 45, 89, 79, 16, 11, 399, 87, 220, 837, 17735, 220, 10612, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 51, 5218, 357, 45, 16, 11, 399, 87, 11, 17735, 220, 10612, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 52, 5218, 357, 45, 16, 11, 399, 87, 11, 17735, 220, 10612, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 53, 5218, 357, 45, 16, 11, 399, 87, 11, 399, 4464, 16, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 6173, 1847, 1503, 5218, 357, 45, 16, 11, 399, 16, 11, 399, 16, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 66, 54, 5218, 357, 45, 89, 79, 16, 11, 399, 16, 11, 399, 16, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 66, 51, 5218, 357, 45, 89, 11, 399, 16, 11, 399, 16, 828, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 770, 318, 973, 329, 13266, 25391, 5072, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 17641, 326, 428, 318, 25921, 15793, 523, 1976, 318, 262, 938, 530, 198, 220, 220, 220, 220, 220, 220, 220, 10706, 62, 67, 12078, 17, 62, 2536, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 51, 220, 5218, 5855, 45, 87, 1600, 366, 45, 88, 1600, 366, 45, 89, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 52, 220, 5218, 5855, 45, 87, 1600, 366, 45, 88, 1600, 366, 45, 89, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 53, 220, 5218, 5855, 45, 87, 1600, 366, 45, 4464, 16, 1600, 366, 45, 89, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 54, 220, 5218, 5855, 45, 87, 1600, 366, 45, 88, 1600, 366, 45, 89, 79, 16, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 51, 5218, 5855, 45, 87, 1600, 366, 45, 88, 1600, 366, 45, 16, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 52, 5218, 5855, 45, 87, 1600, 366, 45, 88, 1600, 366, 45, 16, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 53, 5218, 5855, 45, 87, 1600, 366, 45, 4464, 16, 1600, 366, 45, 16, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 6173, 1847, 1503, 5218, 5855, 45, 16, 1600, 366, 45, 16, 1600, 366, 45, 16, 12340, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 66, 54, 5218, 5855, 45, 16, 1600, 366, 45, 16, 1600, 366, 45, 89, 79, 16, 1600, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 66, 51, 5218, 5855, 45, 16, 1600, 366, 45, 16, 1600, 366, 45, 89, 1600, 828, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 628, 628, 220, 220, 220, 220, 220, 220, 220, 1366, 62, 41667, 796, 360, 713, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 9701, 220, 220, 220, 220, 220, 796, 360, 713, 3419, 628, 198, 220, 220, 220, 220, 220, 220, 220, 4814, 62, 312, 87, 16, 796, 360, 713, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 82, 51, 5218, 357, 27932, 62, 82, 51, 6624, 2147, 8, 5633, 2147, 1058, 9335, 62, 82, 51, 764, 855, 657, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 51, 220, 5218, 357, 27932, 62, 51, 6624, 2147, 8, 5633, 2147, 1058, 9335, 62, 51, 764, 855, 657, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 52, 5218, 2147, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 53, 5218, 2147, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 54, 5218, 2147, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1058, 31667, 5218, 2147, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2147, 5218, 2147, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 198, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 4814, 62, 312, 87, 17, 796, 360, 713, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 329, 357, 74, 11, 85, 8, 287, 4814, 62, 312, 87, 16, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4814, 62, 312, 87, 17, 58, 74, 60, 796, 357, 85, 14512, 2147, 8, 5633, 9943, 7241, 12078, 7, 85, 11, 685, 17, 11, 513, 11, 352, 12962, 1058, 2147, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 649, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 5391, 82, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10706, 62, 67, 12078, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10706, 62, 67, 12078, 17, 62, 2536, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1366, 62, 41667, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4814, 62, 312, 87, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4814, 62, 312, 87, 17, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 9701, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 628, 220, 220, 220, 886, 198, 198, 437, 198, 198, 8818, 842, 43015, 0, 7, 198, 220, 220, 220, 288, 83, 220, 220, 220, 220, 220, 220, 7904, 6060, 10962, 11, 198, 220, 220, 220, 4686, 220, 220, 220, 220, 220, 220, 7904, 4479, 90, 13940, 23650, 11, 10903, 5512, 198, 220, 220, 220, 10706, 220, 220, 220, 220, 7904, 38357, 11, 198, 220, 220, 220, 9335, 220, 220, 220, 220, 7904, 4479, 90, 13940, 23650, 11, 10528, 5512, 198, 220, 220, 220, 1366, 220, 220, 220, 220, 7904, 27741, 19182, 90, 51, 5512, 198, 8, 810, 309, 628, 220, 220, 220, 399, 16, 796, 288, 83, 13, 67, 12078, 14692, 45, 16, 8973, 198, 220, 220, 220, 399, 87, 796, 288, 83, 13, 67, 12078, 14692, 45, 87, 8973, 198, 220, 220, 220, 17735, 796, 288, 83, 13, 67, 12078, 14692, 45, 88, 8973, 198, 220, 220, 220, 399, 89, 796, 288, 83, 13, 67, 12078, 14692, 45, 89, 8973, 198, 220, 220, 220, 399, 4464, 16, 796, 288, 83, 13, 67, 12078, 14692, 45, 4464, 16, 8973, 198, 220, 220, 220, 399, 89, 79, 16, 796, 288, 83, 13, 67, 12078, 14692, 45, 89, 79, 16, 8973, 628, 220, 220, 220, 611, 468, 2539, 7, 28664, 13, 7890, 62, 41667, 11, 4686, 8, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 12331, 16922, 7203, 12331, 25, 7885, 4686, 366, 1635, 10903, 7, 312, 8, 1635, 220, 366, 1541, 7160, 526, 4008, 198, 220, 220, 220, 886, 628, 220, 220, 220, 5391, 796, 288, 83, 13, 25928, 62, 67, 12078, 58, 25928, 60, 628, 220, 220, 220, 288, 4906, 796, 1288, 4906, 7, 7890, 8, 198, 220, 220, 220, 611, 5145, 357, 67, 4906, 287, 357, 43879, 2414, 11, 2558, 2414, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 12331, 16922, 7203, 44651, 1366, 2099, 13, 5514, 48436, 2414, 290, 2558, 2414, 389, 6292, 48774, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 309, 29291, 7, 27740, 8, 14512, 2546, 7, 7890, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 3109, 806, 33172, 5391, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 3855, 33172, 2546, 7, 7890, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 12331, 16922, 7203, 15946, 1384, 1366, 857, 407, 423, 3376, 15793, 25, 366, 1635, 4731, 7, 312, 22305, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 288, 4906, 14512, 309, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 12331, 16922, 7203, 67, 4906, 290, 2810, 1366, 857, 407, 2872, 526, 4008, 198, 220, 220, 220, 886, 628, 220, 220, 220, 288, 83, 13, 7890, 62, 41667, 58, 312, 60, 796, 6060, 26453, 7, 198, 220, 220, 220, 220, 220, 220, 220, 288, 83, 11, 198, 220, 220, 220, 220, 220, 220, 220, 4686, 11, 198, 220, 220, 220, 220, 220, 220, 220, 10706, 11, 198, 220, 220, 220, 220, 220, 220, 220, 9335, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1366, 11, 198, 220, 220, 220, 1267, 628, 220, 220, 220, 288, 83, 13, 33152, 58, 312, 60, 796, 657, 198, 437, 198 ]
1.716844
2,066
module CharFuncPricing export DefaultCharFunc, CharFunc abstract type CharFunc{MT,CR} end struct DefaultCharFunc{MT,CR} <: CharFunc{MT,CR} #model type, return type (e.g. Complex or acb) model::MT end @inline model(cf::DefaultCharFunc) = cf.model @inline oneim(cf::CharFunc) = 1im @inline oneim(cf::CharFunc{MT,Complex{T}}) where {MT,T} = 1im @inline oneim(cf::CharFunc{MT,Complex}) where {MT} = 1im @inline Base.zero(cf::CharFunc{MT,Complex}) where {MT} = Base.zero(Float64) @inline Base.zero(cf::CharFunc{MT,Complex{BigFloat}}) where {MT} = Base.zero(BigFloat) @inline const_pi(cf::CharFunc{MT,Complex{T}}) where {MT,T} = T(pi) @inline const_pi(cf::CharFunc{MT,Complex}) where {MT} = Float64(pi) include("lambertw.jl") include("Heston.jl") include("SchobelZhu.jl") include("Cos.jl") include("Flinn.jl") include("Filon.jl") include("NemoCharFunc.jl") include("GaussLobatto.jl") include("AndersenLake.jl") end
[ 21412, 3178, 37, 19524, 47, 1173, 278, 198, 39344, 15161, 12441, 37, 19524, 11, 3178, 37, 19524, 198, 198, 397, 8709, 2099, 3178, 37, 19524, 90, 13752, 11, 9419, 92, 886, 198, 198, 7249, 15161, 12441, 37, 19524, 90, 13752, 11, 9419, 92, 1279, 25, 3178, 37, 19524, 90, 13752, 11, 9419, 92, 1303, 19849, 2099, 11, 1441, 2099, 357, 68, 13, 70, 13, 19157, 393, 936, 65, 8, 198, 220, 220, 220, 2746, 3712, 13752, 198, 437, 198, 198, 31, 45145, 2746, 7, 12993, 3712, 19463, 12441, 37, 19524, 8, 796, 30218, 13, 19849, 198, 31, 45145, 530, 320, 7, 12993, 3712, 12441, 37, 19524, 8, 796, 352, 320, 198, 31, 45145, 530, 320, 7, 12993, 3712, 12441, 37, 19524, 90, 13752, 11, 5377, 11141, 90, 51, 11709, 8, 810, 1391, 13752, 11, 51, 92, 796, 352, 320, 198, 31, 45145, 530, 320, 7, 12993, 3712, 12441, 37, 19524, 90, 13752, 11, 5377, 11141, 30072, 810, 1391, 13752, 92, 796, 352, 320, 198, 31, 45145, 7308, 13, 22570, 7, 12993, 3712, 12441, 37, 19524, 90, 13752, 11, 5377, 11141, 30072, 810, 1391, 13752, 92, 796, 7308, 13, 22570, 7, 43879, 2414, 8, 198, 31, 45145, 7308, 13, 22570, 7, 12993, 3712, 12441, 37, 19524, 90, 13752, 11, 5377, 11141, 90, 12804, 43879, 11709, 8, 810, 1391, 13752, 92, 796, 7308, 13, 22570, 7, 12804, 43879, 8, 198, 31, 45145, 1500, 62, 14415, 7, 12993, 3712, 12441, 37, 19524, 90, 13752, 11, 5377, 11141, 90, 51, 11709, 8, 810, 1391, 13752, 11, 51, 92, 796, 309, 7, 14415, 8, 198, 31, 45145, 1500, 62, 14415, 7, 12993, 3712, 12441, 37, 19524, 90, 13752, 11, 5377, 11141, 30072, 810, 1391, 13752, 92, 796, 48436, 2414, 7, 14415, 8, 628, 198, 198, 17256, 7203, 2543, 527, 4246, 13, 20362, 4943, 198, 17256, 7203, 39, 19115, 13, 20362, 4943, 198, 17256, 7203, 14874, 672, 417, 57, 13415, 13, 20362, 4943, 198, 17256, 7203, 36734, 13, 20362, 4943, 198, 17256, 7203, 37, 2815, 77, 13, 20362, 4943, 198, 17256, 7203, 11928, 261, 13, 20362, 4943, 198, 17256, 7203, 45, 41903, 12441, 37, 19524, 13, 20362, 4943, 198, 17256, 7203, 35389, 1046, 43, 672, 45807, 13, 20362, 4943, 198, 17256, 7203, 1870, 46516, 43035, 13, 20362, 4943, 198, 437, 198 ]
2.450667
375
using GraphPlot using Plots pyplot() using PyPlot pygui(false) include("loadbuild.jl") include("graphing.jl") include("beliefprop.jl") include("Psis.jl") EDGEFILE = "data/save.feather" BIASFILE = "data/bias.csv" plotdir = "results/plots/" figext = "eps" problem_types = ["bias", "fake"] epsilon = 0.44 MAXITER = 2 Plots.PyPlot.rc("lines", lw=10) # Plots.PyPlot.rc("font", family="monospace") # Plots.PyPlot.rc("font", weight="bold") Plots.PyPlot.rc("font", size=22) if EDGEFILE == "data/save.feather" by_domain_flag = true elseif EDGEFILE == "data/save2.feather" by_domain_flag = false end save = loadSave(EDGEFILE) # size(unique(save[:sdom])) #println(size(unique(vcat(save[:rsrc],save[:rdest])))) bias = loadBias(BIASFILE) cats = buildWeb(save, by_domain_flag) #only mutual links for "a" edgeunion = countunion(cats["a"], cats["img"]) @time for x in ["link", "script"] countunion!(edgeunion, cats[x]) end sets = [("union", 1)] #[("union",10)], [("mut", 1000), ("mut", 50), ("mut", 2), ("mut", 1), ("a", 1000), ("a", 500),("a", 100), ("img", 200), ("img", 50)] #s2p = Dict{String, Array}() roc_x = Vector{Float64}() roc_y = Vector{Float64}() k = 3 #number of folds for (sn, set) in enumerate(sets) edgetype = set[1] if edgetype == "union" edgeset = edgeunion else edgeset = cats[set[1]] end # if ~by_domain_flag # domainmap = Dict{String, String}() # for j in edgeset # domainmap[j.first] = split(j.first, '/')[1] # for i in j.second # domainmap[i.first] = split(i.first, '/')[1] # end # end # end G, s2i, i2s = constructGraph(edgeset, minsamp=set[2], giant=false, by_domain=by_domain_flag) #G2, s2i2, i2s2 = constructGraph(edgeset, minsamp=set[2], giant=true, by_domain=by_domain_flag) mindeg = minimum([length([x for x in all_neighbors(G, v) if x != v]) for v in 1:nv(G)]) println("Minimum Degree: $mindeg") maxdeg = maximum(degree(G)) println("Maximum Degree: $maxdeg") # lx, ly = spring_layout(G) #lx2, ly2 = spring_layout(G2) for key in problem_types p = Plots.plot() plot!(p, [0, 1], [0, 1], line=:dash, label="") println(key*string(set)) try mkdir(plotdir*string(set[1])) catch x end try mkdir(plotdir*string(set[1])*"/"*string(set[2])) catch x end mydir = plotdir*string(set[1])*"/"*string(set[2])*"/" # plotGraph(bias, G, s2i, i2s, lx, ly, color=key, # path=mydir*key*"train.png") # ϕ = makeBeliefs(bias, G, s2i, i2s, key) # pr, b, lodds = beliefprop(G, ϕ, Psis(0.44), 1); # plotGraph(bias, G, s2i, i2s, lx, ly, color=b[:,1], # path=mydir*key*"prop.png") # plotGraph(bias, G2, s2i2, i2s2, lx2, ly2, color=key, # path=mydir*key*"train_main.png") # ϕ = makeBeliefs(bias, G2, s2i2, i2s2, key) # pr, b, lodds = beliefprop(G2, ϕ, Psis(0.44), 1); # plotGraph(bias, G2, s2i2, i2s2, lx2, ly2, color=b[:,1], # path=mydir*key*"prop_main.png") folds = makeFolds(G, k) # makeFolds(G, k, i2s, domainmap) aucs = [] for f in 1:k println("Fold " *string(f)) ϕ = makeBeliefs(bias, G, s2i, i2s, key, folds=folds, fold=f) pr, b, lodds = beliefprop(G, ϕ, Psis(epsilon), MAXITER); # for v in 1:nv(G) # if folds[v] == f # site = i2s[v] # if ~haskey(s2p, site) # s2p[site] = ones(1, size(sets, 1)+2)./2.0 # s2p[site][size(sets, 1)+1] = reality(bias, site, "bias") # s2p[site][size(sets, 1)+2] = folds[v] # end # s2p[site][sn] = b[v] # end # end roc_x, roc_y, acc, lvls, cms = getROC(bias, G, s2i, i2s, key, b, folds=folds, fold=f) auc = AUC(roc_x, roc_y) #println("Max "*string(maximum(acc))*" at "*string(lvls[find(x->x==maximum(acc), acc)[1]])) println("AUC : "*string(auc)) best_cutoff = collect(keys(acc))[indmax(collect(values(acc)))] println("best cutoff threshold : "*string(best_cutoff)) println("confusion matrix (best threshold) : ") show(cms[best_cutoff]) println("") println("confusion matrix (0.5 threshold) : ") show(cms[0.5]) println("") #println(typeof(roc_x)) #println(typeof(roc_y)) #println(roc_x) #println(roc_y) plot!(p, roc_x, roc_y,label="Fold $f (AUC=$(@sprintf("%.3f", auc)))") push!(aucs, auc) end avg_auc = sum(aucs)/k title!("Receiver Operating Characteristic (Average AUC=$(@sprintf("%.3f", avg_auc)))") println("Avg AUC : "*string(avg_auc)) figpath = mydir*key*"_ROC_curve.$figext" println("Saving figure to: $figpath") savefig(figpath) open(mydir*"score.txt", "w") do f write(f, string(sum(aucs)/k)) end end end # for site in keys(s2p) # s2p[site][10] = reality(bias, site, "bias") # end # s2p # s2p["cnn.com"] # s2p["bluebirdbanter.com"] # using JSON # open("metadata.json", "w") do f # write(f, JSON.json(s2p)) # end
[ 3500, 29681, 43328, 198, 3500, 1345, 1747, 198, 9078, 29487, 3419, 198, 3500, 9485, 43328, 198, 9078, 48317, 7, 9562, 8, 198, 17256, 7203, 2220, 11249, 13, 20362, 4943, 198, 17256, 7203, 70, 2416, 722, 13, 20362, 4943, 198, 17256, 7203, 6667, 2086, 22930, 13, 20362, 4943, 198, 17256, 7203, 12016, 271, 13, 20362, 4943, 198, 198, 1961, 8264, 25664, 796, 366, 7890, 14, 21928, 13, 5036, 1032, 1, 198, 3483, 1921, 25664, 796, 366, 7890, 14, 65, 4448, 13, 40664, 1, 198, 29487, 15908, 796, 366, 43420, 14, 489, 1747, 30487, 198, 5647, 2302, 796, 366, 25386, 1, 198, 198, 45573, 62, 19199, 796, 14631, 65, 4448, 1600, 366, 30706, 8973, 198, 538, 18217, 261, 796, 657, 13, 2598, 198, 22921, 2043, 1137, 796, 362, 198, 198, 3646, 1747, 13, 20519, 43328, 13, 6015, 7203, 6615, 1600, 300, 86, 28, 940, 8, 198, 2, 1345, 1747, 13, 20519, 43328, 13, 6015, 7203, 10331, 1600, 1641, 2625, 2144, 24912, 4943, 198, 2, 1345, 1747, 13, 20519, 43328, 13, 6015, 7203, 10331, 1600, 3463, 2625, 36575, 4943, 198, 3646, 1747, 13, 20519, 43328, 13, 6015, 7203, 10331, 1600, 2546, 28, 1828, 8, 198, 198, 361, 8392, 8264, 25664, 6624, 366, 7890, 14, 21928, 13, 5036, 1032, 1, 198, 220, 416, 62, 27830, 62, 32109, 796, 2081, 198, 17772, 361, 8392, 8264, 25664, 6624, 366, 7890, 14, 21928, 17, 13, 5036, 1032, 1, 198, 220, 416, 62, 27830, 62, 32109, 796, 3991, 198, 437, 198, 198, 21928, 796, 3440, 16928, 7, 1961, 8264, 25664, 8, 198, 198, 2, 2546, 7, 34642, 7, 21928, 58, 25, 82, 3438, 60, 4008, 198, 198, 2, 35235, 7, 7857, 7, 34642, 7, 85, 9246, 7, 21928, 58, 25, 3808, 6015, 4357, 21928, 58, 25, 4372, 395, 60, 35514, 198, 198, 65, 4448, 796, 3440, 33, 4448, 7, 3483, 1921, 25664, 8, 198, 198, 24619, 796, 1382, 13908, 7, 21928, 11, 416, 62, 27830, 62, 32109, 8, 1303, 8807, 13584, 6117, 329, 366, 64, 1, 198, 198, 14907, 24592, 796, 954, 24592, 7, 24619, 14692, 64, 33116, 11875, 14692, 9600, 8973, 8, 198, 31, 2435, 329, 2124, 287, 14631, 8726, 1600, 366, 12048, 8973, 198, 220, 220, 220, 954, 24592, 0, 7, 14907, 24592, 11, 11875, 58, 87, 12962, 198, 437, 628, 198, 28709, 796, 685, 7203, 24592, 1600, 352, 15437, 1303, 58, 7203, 24592, 1600, 940, 8, 4357, 685, 7203, 21973, 1600, 8576, 828, 5855, 21973, 1600, 2026, 828, 5855, 21973, 1600, 362, 828, 5855, 21973, 1600, 352, 828, 5855, 64, 1600, 8576, 828, 5855, 64, 1600, 5323, 828, 7203, 64, 1600, 1802, 828, 5855, 9600, 1600, 939, 828, 5855, 9600, 1600, 2026, 15437, 198, 198, 2, 82, 17, 79, 796, 360, 713, 90, 10100, 11, 15690, 92, 3419, 198, 198, 12204, 62, 87, 796, 20650, 90, 43879, 2414, 92, 3419, 198, 12204, 62, 88, 796, 20650, 90, 43879, 2414, 92, 3419, 198, 198, 74, 796, 513, 1303, 17618, 286, 38744, 198, 198, 1640, 357, 16184, 11, 900, 8, 287, 27056, 378, 7, 28709, 8, 198, 220, 220, 1225, 1136, 2981, 796, 900, 58, 16, 60, 198, 220, 220, 220, 611, 1225, 1136, 2981, 6624, 366, 24592, 1, 198, 220, 220, 220, 220, 220, 13015, 316, 796, 5743, 24592, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 13015, 316, 796, 11875, 58, 2617, 58, 16, 11907, 198, 220, 220, 220, 886, 628, 198, 220, 220, 220, 1303, 611, 5299, 1525, 62, 27830, 62, 32109, 198, 220, 220, 220, 1303, 220, 220, 7386, 8899, 796, 360, 713, 90, 10100, 11, 10903, 92, 3419, 198, 220, 220, 220, 1303, 220, 220, 329, 474, 287, 13015, 316, 198, 220, 220, 220, 1303, 220, 220, 220, 220, 7386, 8899, 58, 73, 13, 11085, 60, 796, 6626, 7, 73, 13, 11085, 11, 31051, 11537, 58, 16, 60, 198, 220, 220, 220, 1303, 220, 220, 220, 220, 329, 1312, 287, 474, 13, 12227, 198, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 7386, 8899, 58, 72, 13, 11085, 60, 796, 6626, 7, 72, 13, 11085, 11, 31051, 11537, 58, 16, 60, 198, 220, 220, 220, 1303, 220, 220, 220, 220, 886, 198, 220, 220, 220, 1303, 220, 220, 886, 198, 220, 220, 220, 1303, 886, 628, 220, 220, 220, 402, 11, 264, 17, 72, 11, 1312, 17, 82, 796, 5678, 37065, 7, 276, 3212, 316, 11, 23550, 696, 28, 2617, 58, 17, 4357, 6175, 28, 9562, 11, 416, 62, 27830, 28, 1525, 62, 27830, 62, 32109, 8, 198, 220, 220, 220, 1303, 38, 17, 11, 264, 17, 72, 17, 11, 1312, 17, 82, 17, 796, 5678, 37065, 7, 276, 3212, 316, 11, 23550, 696, 28, 2617, 58, 17, 4357, 6175, 28, 7942, 11, 416, 62, 27830, 28, 1525, 62, 27830, 62, 32109, 8, 198, 220, 220, 220, 2000, 1533, 796, 5288, 26933, 13664, 26933, 87, 329, 2124, 287, 477, 62, 710, 394, 32289, 7, 38, 11, 410, 8, 611, 2124, 14512, 410, 12962, 329, 410, 287, 352, 25, 48005, 7, 38, 8, 12962, 198, 220, 220, 220, 44872, 7203, 44046, 34486, 25, 720, 10155, 1533, 4943, 198, 220, 220, 220, 3509, 13500, 796, 5415, 7, 16863, 7, 38, 4008, 198, 220, 220, 220, 44872, 7203, 40541, 34486, 25, 720, 9806, 13500, 4943, 198, 220, 220, 220, 1303, 300, 87, 11, 22404, 796, 6076, 62, 39786, 7, 38, 8, 198, 220, 220, 220, 1303, 75, 87, 17, 11, 22404, 17, 796, 6076, 62, 39786, 7, 38, 17, 8, 628, 220, 220, 220, 329, 1994, 287, 1917, 62, 19199, 198, 220, 220, 220, 220, 220, 220, 220, 279, 796, 1345, 1747, 13, 29487, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 7110, 0, 7, 79, 11, 685, 15, 11, 352, 4357, 685, 15, 11, 352, 4357, 1627, 28, 25, 42460, 11, 6167, 2625, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 2539, 9, 8841, 7, 2617, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 1949, 33480, 15908, 7, 29487, 15908, 9, 8841, 7, 2617, 58, 16, 60, 4008, 4929, 2124, 886, 198, 220, 220, 220, 220, 220, 220, 220, 1949, 33480, 15908, 7, 29487, 15908, 9, 8841, 7, 2617, 58, 16, 12962, 9, 1, 30487, 9, 8841, 7, 2617, 58, 17, 60, 4008, 4929, 2124, 886, 198, 220, 220, 220, 220, 220, 220, 220, 616, 15908, 796, 7110, 15908, 9, 8841, 7, 2617, 58, 16, 12962, 9, 1, 30487, 9, 8841, 7, 2617, 58, 17, 12962, 9, 1, 30487, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 7110, 37065, 7, 65, 4448, 11, 402, 11, 264, 17, 72, 11, 1312, 17, 82, 11, 300, 87, 11, 22404, 11, 3124, 28, 2539, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3108, 28, 1820, 15908, 9, 2539, 9, 1, 27432, 13, 11134, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 18074, 243, 796, 787, 12193, 2086, 82, 7, 65, 4448, 11, 402, 11, 264, 17, 72, 11, 1312, 17, 82, 11, 1994, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 778, 11, 275, 11, 300, 5088, 82, 796, 4901, 22930, 7, 38, 11, 18074, 243, 11, 350, 13429, 7, 15, 13, 2598, 828, 352, 1776, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 7110, 37065, 7, 65, 4448, 11, 402, 11, 264, 17, 72, 11, 1312, 17, 82, 11, 300, 87, 11, 22404, 11, 3124, 28, 65, 58, 45299, 16, 4357, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 3108, 28, 1820, 15908, 9, 2539, 9, 1, 22930, 13, 11134, 4943, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 7110, 37065, 7, 65, 4448, 11, 402, 17, 11, 264, 17, 72, 17, 11, 1312, 17, 82, 17, 11, 300, 87, 17, 11, 22404, 17, 11, 3124, 28, 2539, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3108, 28, 1820, 15908, 9, 2539, 9, 1, 27432, 62, 12417, 13, 11134, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 18074, 243, 796, 787, 12193, 2086, 82, 7, 65, 4448, 11, 402, 17, 11, 264, 17, 72, 17, 11, 1312, 17, 82, 17, 11, 1994, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 778, 11, 275, 11, 300, 5088, 82, 796, 4901, 22930, 7, 38, 17, 11, 18074, 243, 11, 350, 13429, 7, 15, 13, 2598, 828, 352, 1776, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 7110, 37065, 7, 65, 4448, 11, 402, 17, 11, 264, 17, 72, 17, 11, 1312, 17, 82, 17, 11, 300, 87, 17, 11, 22404, 17, 11, 3124, 28, 65, 58, 45299, 16, 4357, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3108, 28, 1820, 15908, 9, 2539, 9, 1, 22930, 62, 12417, 13, 11134, 4943, 628, 220, 220, 220, 220, 220, 220, 220, 38744, 796, 787, 37, 10119, 7, 38, 11, 479, 8, 1303, 787, 37, 10119, 7, 38, 11, 479, 11, 1312, 17, 82, 11, 7386, 8899, 8, 198, 220, 220, 220, 220, 220, 220, 220, 257, 1229, 82, 796, 17635, 198, 220, 220, 220, 220, 220, 220, 220, 329, 277, 287, 352, 25, 74, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 37, 727, 366, 1635, 8841, 7, 69, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 18074, 243, 796, 787, 12193, 2086, 82, 7, 65, 4448, 11, 402, 11, 264, 17, 72, 11, 1312, 17, 82, 11, 1994, 11, 38744, 28, 69, 10119, 11, 5591, 28, 69, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 778, 11, 275, 11, 300, 5088, 82, 796, 4901, 22930, 7, 38, 11, 18074, 243, 11, 350, 13429, 7, 538, 18217, 261, 828, 25882, 2043, 1137, 1776, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 329, 410, 287, 352, 25, 48005, 7, 38, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 611, 38744, 58, 85, 60, 6624, 277, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 2524, 796, 1312, 17, 82, 58, 85, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 611, 5299, 10134, 2539, 7, 82, 17, 79, 11, 2524, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 264, 17, 79, 58, 15654, 60, 796, 3392, 7, 16, 11, 2546, 7, 28709, 11, 352, 47762, 17, 737, 14, 17, 13, 15, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 264, 17, 79, 58, 15654, 7131, 7857, 7, 28709, 11, 352, 47762, 16, 60, 796, 3950, 7, 65, 4448, 11, 2524, 11, 366, 65, 4448, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 264, 17, 79, 58, 15654, 7131, 7857, 7, 28709, 11, 352, 47762, 17, 60, 796, 38744, 58, 85, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 220, 220, 264, 17, 79, 58, 15654, 7131, 16184, 60, 796, 275, 58, 85, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 886, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 686, 66, 62, 87, 11, 686, 66, 62, 88, 11, 697, 11, 300, 85, 7278, 11, 269, 907, 796, 651, 49, 4503, 7, 65, 4448, 11, 402, 11, 264, 17, 72, 11, 1312, 17, 82, 11, 1994, 11, 275, 11, 38744, 28, 69, 10119, 11, 5591, 28, 69, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 257, 1229, 796, 317, 9598, 7, 12204, 62, 87, 11, 686, 66, 62, 88, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 35235, 7203, 11518, 366, 9, 8841, 7, 47033, 7, 4134, 4008, 9, 1, 379, 366, 9, 8841, 7, 6780, 7278, 58, 19796, 7, 87, 3784, 87, 855, 47033, 7, 4134, 828, 697, 38381, 16, 11907, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 32, 9598, 1058, 366, 9, 8841, 7, 14272, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1266, 62, 8968, 2364, 796, 2824, 7, 13083, 7, 4134, 4008, 58, 521, 9806, 7, 33327, 7, 27160, 7, 4134, 4008, 15437, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 13466, 45616, 11387, 1058, 366, 9, 8841, 7, 13466, 62, 8968, 2364, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 10414, 4241, 17593, 357, 13466, 11387, 8, 1058, 366, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 905, 7, 46406, 58, 13466, 62, 8968, 2364, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 10414, 4241, 17593, 357, 15, 13, 20, 11387, 8, 1058, 366, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 905, 7, 46406, 58, 15, 13, 20, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 35235, 7, 4906, 1659, 7, 12204, 62, 87, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 35235, 7, 4906, 1659, 7, 12204, 62, 88, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 35235, 7, 12204, 62, 87, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 35235, 7, 12204, 62, 88, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 7110, 0, 7, 79, 11, 686, 66, 62, 87, 11, 686, 66, 62, 88, 11, 18242, 2625, 37, 727, 720, 69, 357, 32, 9598, 43641, 7, 31, 82, 37435, 7203, 7225, 18, 69, 1600, 257, 1229, 22305, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 559, 6359, 11, 257, 1229, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 42781, 62, 14272, 796, 2160, 7, 559, 6359, 20679, 74, 198, 220, 220, 220, 220, 220, 220, 220, 3670, 0, 7203, 3041, 39729, 24850, 15684, 2569, 357, 26287, 317, 9598, 43641, 7, 31, 82, 37435, 7203, 7225, 18, 69, 1600, 42781, 62, 14272, 22305, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 48997, 317, 9598, 1058, 366, 9, 8841, 7, 615, 70, 62, 14272, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 2336, 6978, 796, 616, 15908, 9, 2539, 9, 1, 62, 49, 4503, 62, 22019, 303, 48082, 5647, 2302, 1, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7203, 50, 2703, 3785, 284, 25, 720, 5647, 6978, 4943, 198, 220, 220, 220, 220, 220, 220, 220, 3613, 5647, 7, 5647, 6978, 8, 628, 220, 220, 220, 220, 220, 220, 220, 1280, 7, 1820, 15908, 9, 1, 26675, 13, 14116, 1600, 366, 86, 4943, 466, 277, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3551, 7, 69, 11, 4731, 7, 16345, 7, 559, 6359, 20679, 74, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2, 329, 2524, 287, 8251, 7, 82, 17, 79, 8, 198, 2, 220, 220, 220, 220, 264, 17, 79, 58, 15654, 7131, 940, 60, 796, 3950, 7, 65, 4448, 11, 2524, 11, 366, 65, 4448, 4943, 198, 2, 886, 198, 198, 2, 264, 17, 79, 198, 198, 2, 264, 17, 79, 14692, 66, 20471, 13, 785, 8973, 198, 2, 264, 17, 79, 14692, 17585, 16944, 3820, 353, 13, 785, 8973, 198, 198, 2, 1262, 19449, 198, 2, 1280, 7203, 38993, 13, 17752, 1600, 366, 86, 4943, 466, 277, 198, 2, 220, 220, 220, 220, 3551, 7, 69, 11, 19449, 13, 17752, 7, 82, 17, 79, 4008, 198, 2, 886, 198 ]
1.912006
2,807
""" struct ElementFEAInfo{dim, T} Kes::AbstractVector{<:AbstractMatrix{T}} fes::AbstractVector{<:AbstractVector{T}} fixedload::AbstractVector{T} cellvolumes::AbstractVector{T} cellvalues::CellValues{dim, T} facevalues::FaceValues{<:Any, T} metadata::Metadata black::AbstractVector white::AbstractVector varind::AbstractVector{Int} cells end An instance of the `ElementFEAInfo` type stores element information such as: - `Kes`: the element stiffness matrices, - `fes`: the element load vectors, - `cellvolumes`: the element volumes, - `cellvalues` and `facevalues`: two `Ferrite` types that facilitate cell and face iteration and queries. - `metadata`: that stores degree of freedom (dof) to node mapping, dof to cell mapping, etc. - `black`: a `BitVector` such that `black[i]` is 1 iff element `i` must be part of any feasible design. - `white`: a `BitVector` such that `white[i]` is 1 iff element `i` must never be part of any feasible design. - `varind`: a vector such that `varind[i]` gives the decision variable index of element `i`. - `cells`: the cell connectivities. """ @params struct ElementFEAInfo{dim,T} Kes::AbstractVector{<:AbstractMatrix{T}} fes::AbstractVector{<:AbstractVector{T}} fixedload::AbstractVector{T} cellvolumes::AbstractVector{T} cellvalues::CellValues{dim,T,<:Any} facevalues::FaceValues{<:Any,T,<:Any} metadata::Metadata black::AbstractVector white::AbstractVector varind::AbstractVector{Int} cells::Any end function Base.show(io::Base.IO, ::MIME"text/plain", efeainfo::ElementFEAInfo) return print( io, "ElementFEAInfo: Kes |$(length(efeainfo.Kes))|, fes |$(length(efeainfo.fes))|, fixedload |$(length(efeainfo.fixedload))|, cells |$(length(efeainfo.cells))|", ) end """ ElementFEAInfo(sp, quad_order=2, ::Type{Val{mat_type}}=Val{:Static}) where {mat_type} Constructs an instance of `ElementFEAInfo` from a stiffness problem `sp` using a Gaussian quadrature order of `quad_order`. The element matrix and vector types will be: 1. `SMatrix` and `SVector` if `mat_type` is `:SMatrix` or `:Static`, the default, 2. `MMatrix` and `MVector` if `mat_type` is `:MMatrix`, or 3. `Matrix` and `Vector` otherwise. The static matrices and vectors are more performant and GPU-compatible therefore they are used by default. """ function ElementFEAInfo( sp, quad_order=2, ::Type{Val{mat_type}}=Val{:Static} ) where {mat_type} Kes, weights, dloads, cellvalues, facevalues = make_Kes_and_fes( sp, quad_order, Val{mat_type} ) element_Kes = convert( Vector{<:ElementMatrix}, Kes; bc_dofs=sp.ch.prescribed_dofs, dof_cells=sp.metadata.dof_cells, ) fixedload = Vector(make_cload(sp)) assemble_f!(fixedload, sp, dloads) cellvolumes = get_cell_volumes(sp, cellvalues) cells = sp.ch.dh.grid.cells return ElementFEAInfo( element_Kes, weights, fixedload, cellvolumes, cellvalues, facevalues, sp.metadata, sp.black, sp.white, sp.varind, cells, ) end """ struct GlobalFEAInfo{T, TK<:AbstractMatrix{T}, Tf<:AbstractVector{T}, Tchol} K::TK f::Tf cholK::Tchol end An instance of `GlobalFEAInfo` hosts the global stiffness matrix `K`, the load vector `f` and the cholesky decomposition of the `K`, `cholK`. """ @params mutable struct GlobalFEAInfo{T} K::AbstractMatrix{T} f::AbstractVector{T} cholK::Any qrK::Any end function Base.show(::IO, ::MIME{Symbol("text/plain")}, ::GlobalFEAInfo) return println("TopOpt global FEA information") end """ GlobalFEAInfo(::Type{T}=Float64) where {T} Constructs an empty instance of `GlobalFEAInfo` where the field `K` is an empty sparse matrix of element type `T` and the field `f` is an empty dense vector of element type `T`. """ GlobalFEAInfo(::Type{T}=Float64) where {T} = GlobalFEAInfo{T}() function GlobalFEAInfo{T}() where {T} return GlobalFEAInfo(sparse(zeros(T, 0, 0)), zeros(T, 0), cholesky(one(T)), qr(one(T))) end """ GlobalFEAInfo(sp::StiffnessTopOptProblem) Constructs an instance of `GlobalFEAInfo` where the field `K` is a sparse matrix with the correct size and sparsity pattern for the problem instance `sp`. The field `f` is a dense vector of the appropriate size. The values in `K` and `f` are meaningless though and require calling the function `assemble!` to update. """ function GlobalFEAInfo(sp::StiffnessTopOptProblem) K = initialize_K(sp) f = initialize_f(sp) return GlobalFEAInfo(K, f) end function GlobalFEAInfo( K::Union{AbstractSparseMatrix,Symmetric{<:Any,<:AbstractSparseMatrix}}, f ) chol = cholesky(spdiagm(0 => ones(size(K, 1)))) qrfact = qr(spdiagm(0 => ones(size(K, 1)))) return GlobalFEAInfo{eltype(K),typeof(K),typeof(f),typeof(chol),typeof(qrfact)}( K, f, chol, qrfact ) end """ GlobalFEAInfo(K, f) Constructs an instance of `GlobalFEAInfo` with global stiffness matrix `K` and load vector `f`. """ function GlobalFEAInfo(K, f) chol = cholesky(Matrix{eltype(K)}(I, size(K)...)) qrfact = qr(Matrix{eltype(K)}(I, size(K)...)) return GlobalFEAInfo(K, f, chol, qrfact) end """ get_cell_volumes(sp::StiffnessTopOptProblem{dim, T}, cellvalues) Calculates an approximation of the element volumes by approximating the volume integral of 1 over each element using Gaussian quadrature. `cellvalues` is a `Ferrite` struct that facilitates the computation of the integral. To initialize `cellvalues` for an element with index `cell`, `Ferrite.reinit!(cellvalues, cell)` can be called. Calling `Ferrite.getdetJdV(cellvalues, q_point)` then computes the value of the determinant of the Jacobian of the geometric basis functions at the point `q_point` in the reference element. The sum of such values for all integration points is the volume approximation. """ function get_cell_volumes(sp::StiffnessTopOptProblem{dim,T}, cellvalues) where {dim,T} dh = sp.ch.dh cellvolumes = zeros(T, getncells(dh.grid)) for (i, cell) in enumerate(CellIterator(dh)) reinit!(cellvalues, cell) cellvolumes[i] = sum( Ferrite.getdetJdV(cellvalues, q_point) for q_point in 1:Ferrite.getnquadpoints(cellvalues) ) end return cellvolumes end
[ 37811, 198, 220, 220, 220, 2878, 11703, 15112, 32, 12360, 90, 27740, 11, 309, 92, 198, 220, 220, 220, 220, 220, 220, 220, 40679, 3712, 23839, 38469, 90, 27, 25, 23839, 46912, 90, 51, 11709, 198, 220, 220, 220, 220, 220, 220, 220, 277, 274, 3712, 23839, 38469, 90, 27, 25, 23839, 38469, 90, 51, 11709, 198, 220, 220, 220, 220, 220, 220, 220, 5969, 2220, 3712, 23839, 38469, 90, 51, 92, 198, 220, 220, 220, 220, 220, 220, 220, 2685, 10396, 8139, 3712, 23839, 38469, 90, 51, 92, 198, 220, 220, 220, 220, 220, 220, 220, 2685, 27160, 3712, 28780, 40161, 90, 27740, 11, 309, 92, 198, 220, 220, 220, 220, 220, 220, 220, 1986, 27160, 3712, 32388, 40161, 90, 27, 25, 7149, 11, 309, 92, 198, 220, 220, 220, 220, 220, 220, 220, 20150, 3712, 9171, 14706, 198, 220, 220, 220, 220, 220, 220, 220, 2042, 3712, 23839, 38469, 198, 220, 220, 220, 220, 220, 220, 220, 2330, 3712, 23839, 38469, 198, 220, 220, 220, 220, 220, 220, 220, 1401, 521, 3712, 23839, 38469, 90, 5317, 92, 198, 220, 220, 220, 220, 220, 220, 220, 4778, 198, 220, 220, 220, 886, 198, 198, 2025, 4554, 286, 262, 4600, 20180, 15112, 32, 12360, 63, 2099, 7000, 5002, 1321, 884, 355, 25, 198, 12, 4600, 42, 274, 63, 25, 262, 5002, 49586, 2603, 45977, 11, 198, 12, 4600, 69, 274, 63, 25, 262, 5002, 3440, 30104, 11, 198, 12, 4600, 3846, 10396, 8139, 63, 25, 262, 5002, 15343, 11, 198, 12, 4600, 3846, 27160, 63, 290, 4600, 2550, 27160, 63, 25, 734, 4600, 43362, 6525, 63, 3858, 326, 15570, 2685, 290, 1986, 24415, 290, 20743, 13, 198, 12, 4600, 38993, 63, 25, 326, 7000, 4922, 286, 4925, 357, 67, 1659, 8, 284, 10139, 16855, 11, 466, 69, 284, 2685, 16855, 11, 3503, 13, 198, 12, 4600, 13424, 63, 25, 257, 4600, 13128, 38469, 63, 884, 326, 4600, 13424, 58, 72, 60, 63, 318, 352, 611, 69, 5002, 4600, 72, 63, 1276, 307, 636, 286, 597, 23498, 1486, 13, 198, 12, 4600, 11186, 63, 25, 257, 4600, 13128, 38469, 63, 884, 326, 4600, 11186, 58, 72, 60, 63, 318, 352, 611, 69, 5002, 4600, 72, 63, 1276, 1239, 307, 636, 286, 597, 23498, 1486, 13, 198, 12, 4600, 7785, 521, 63, 25, 257, 15879, 884, 326, 4600, 7785, 521, 58, 72, 60, 63, 3607, 262, 2551, 7885, 6376, 286, 5002, 4600, 72, 44646, 198, 12, 4600, 46342, 63, 25, 262, 2685, 2018, 28720, 13, 198, 37811, 198, 31, 37266, 2878, 11703, 15112, 32, 12360, 90, 27740, 11, 51, 92, 198, 220, 220, 220, 40679, 3712, 23839, 38469, 90, 27, 25, 23839, 46912, 90, 51, 11709, 198, 220, 220, 220, 277, 274, 3712, 23839, 38469, 90, 27, 25, 23839, 38469, 90, 51, 11709, 198, 220, 220, 220, 5969, 2220, 3712, 23839, 38469, 90, 51, 92, 198, 220, 220, 220, 2685, 10396, 8139, 3712, 23839, 38469, 90, 51, 92, 198, 220, 220, 220, 2685, 27160, 3712, 28780, 40161, 90, 27740, 11, 51, 11, 27, 25, 7149, 92, 198, 220, 220, 220, 1986, 27160, 3712, 32388, 40161, 90, 27, 25, 7149, 11, 51, 11, 27, 25, 7149, 92, 198, 220, 220, 220, 20150, 3712, 9171, 14706, 198, 220, 220, 220, 2042, 3712, 23839, 38469, 198, 220, 220, 220, 2330, 3712, 23839, 38469, 198, 220, 220, 220, 1401, 521, 3712, 23839, 38469, 90, 5317, 92, 198, 220, 220, 220, 4778, 3712, 7149, 198, 437, 198, 198, 8818, 7308, 13, 12860, 7, 952, 3712, 14881, 13, 9399, 11, 7904, 44, 12789, 1, 5239, 14, 25638, 1600, 304, 5036, 391, 6513, 3712, 20180, 15112, 32, 12360, 8, 198, 220, 220, 220, 1441, 3601, 7, 198, 220, 220, 220, 220, 220, 220, 220, 33245, 11, 198, 220, 220, 220, 220, 220, 220, 220, 366, 20180, 15112, 32, 12360, 25, 40679, 930, 3, 7, 13664, 7, 22521, 391, 6513, 13, 42, 274, 4008, 91, 11, 277, 274, 930, 3, 7, 13664, 7, 22521, 391, 6513, 13, 69, 274, 4008, 91, 11, 5969, 2220, 930, 3, 7, 13664, 7, 22521, 391, 6513, 13, 34021, 2220, 4008, 91, 11, 4778, 930, 3, 7, 13664, 7, 22521, 391, 6513, 13, 46342, 4008, 91, 1600, 198, 220, 220, 220, 1267, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 11703, 15112, 32, 12360, 7, 2777, 11, 15094, 62, 2875, 28, 17, 11, 7904, 6030, 90, 7762, 90, 6759, 62, 4906, 11709, 28, 7762, 90, 25, 45442, 30072, 810, 1391, 6759, 62, 4906, 92, 198, 198, 42316, 82, 281, 4554, 286, 4600, 20180, 15112, 32, 12360, 63, 422, 257, 49586, 1917, 4600, 2777, 63, 1262, 257, 12822, 31562, 15094, 81, 1300, 1502, 286, 4600, 47003, 62, 2875, 44646, 383, 5002, 17593, 290, 15879, 3858, 481, 307, 25, 198, 16, 13, 4600, 12310, 265, 8609, 63, 290, 4600, 50, 38469, 63, 611, 4600, 6759, 62, 4906, 63, 318, 4600, 25, 12310, 265, 8609, 63, 393, 4600, 25, 45442, 47671, 262, 4277, 11, 198, 17, 13, 4600, 12038, 265, 8609, 63, 290, 4600, 44, 38469, 63, 611, 4600, 6759, 62, 4906, 63, 318, 4600, 25, 12038, 265, 8609, 47671, 393, 198, 18, 13, 4600, 46912, 63, 290, 4600, 38469, 63, 4306, 13, 198, 198, 464, 9037, 2603, 45977, 290, 30104, 389, 517, 1620, 415, 290, 11362, 12, 38532, 4361, 484, 389, 973, 416, 4277, 13, 198, 37811, 198, 8818, 11703, 15112, 32, 12360, 7, 198, 220, 220, 220, 599, 11, 15094, 62, 2875, 28, 17, 11, 7904, 6030, 90, 7762, 90, 6759, 62, 4906, 11709, 28, 7762, 90, 25, 45442, 92, 198, 8, 810, 1391, 6759, 62, 4906, 92, 198, 220, 220, 220, 40679, 11, 19590, 11, 288, 46030, 11, 2685, 27160, 11, 1986, 27160, 796, 787, 62, 42, 274, 62, 392, 62, 69, 274, 7, 198, 220, 220, 220, 220, 220, 220, 220, 599, 11, 15094, 62, 2875, 11, 3254, 90, 6759, 62, 4906, 92, 198, 220, 220, 220, 1267, 198, 220, 220, 220, 5002, 62, 42, 274, 796, 10385, 7, 198, 220, 220, 220, 220, 220, 220, 220, 20650, 90, 27, 25, 20180, 46912, 5512, 198, 220, 220, 220, 220, 220, 220, 220, 40679, 26, 198, 220, 220, 220, 220, 220, 220, 220, 47125, 62, 67, 1659, 82, 28, 2777, 13, 354, 13, 18302, 32968, 62, 67, 1659, 82, 11, 198, 220, 220, 220, 220, 220, 220, 220, 466, 69, 62, 46342, 28, 2777, 13, 38993, 13, 67, 1659, 62, 46342, 11, 198, 220, 220, 220, 1267, 198, 220, 220, 220, 5969, 2220, 796, 20650, 7, 15883, 62, 565, 1170, 7, 2777, 4008, 198, 220, 220, 220, 25432, 62, 69, 0, 7, 34021, 2220, 11, 599, 11, 288, 46030, 8, 198, 220, 220, 220, 2685, 10396, 8139, 796, 651, 62, 3846, 62, 10396, 8139, 7, 2777, 11, 2685, 27160, 8, 198, 220, 220, 220, 4778, 796, 599, 13, 354, 13, 34985, 13, 25928, 13, 46342, 198, 220, 220, 220, 1441, 11703, 15112, 32, 12360, 7, 198, 220, 220, 220, 220, 220, 220, 220, 5002, 62, 42, 274, 11, 198, 220, 220, 220, 220, 220, 220, 220, 19590, 11, 198, 220, 220, 220, 220, 220, 220, 220, 5969, 2220, 11, 198, 220, 220, 220, 220, 220, 220, 220, 2685, 10396, 8139, 11, 198, 220, 220, 220, 220, 220, 220, 220, 2685, 27160, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1986, 27160, 11, 198, 220, 220, 220, 220, 220, 220, 220, 599, 13, 38993, 11, 198, 220, 220, 220, 220, 220, 220, 220, 599, 13, 13424, 11, 198, 220, 220, 220, 220, 220, 220, 220, 599, 13, 11186, 11, 198, 220, 220, 220, 220, 220, 220, 220, 599, 13, 7785, 521, 11, 198, 220, 220, 220, 220, 220, 220, 220, 4778, 11, 198, 220, 220, 220, 1267, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 2878, 8060, 15112, 32, 12360, 90, 51, 11, 309, 42, 27, 25, 23839, 46912, 90, 51, 5512, 309, 69, 27, 25, 23839, 38469, 90, 51, 5512, 309, 354, 349, 92, 198, 220, 220, 220, 220, 220, 220, 220, 509, 3712, 51, 42, 198, 220, 220, 220, 220, 220, 220, 220, 277, 3712, 51, 69, 198, 220, 220, 220, 220, 220, 220, 220, 442, 349, 42, 3712, 51, 354, 349, 198, 220, 220, 220, 886, 198, 198, 2025, 4554, 286, 4600, 22289, 15112, 32, 12360, 63, 11453, 262, 3298, 49586, 17593, 4600, 42, 47671, 262, 3440, 15879, 4600, 69, 63, 290, 262, 442, 4316, 2584, 26969, 9150, 286, 262, 4600, 42, 47671, 4600, 354, 349, 42, 44646, 198, 37811, 198, 31, 37266, 4517, 540, 2878, 8060, 15112, 32, 12360, 90, 51, 92, 198, 220, 220, 220, 509, 3712, 23839, 46912, 90, 51, 92, 198, 220, 220, 220, 277, 3712, 23839, 38469, 90, 51, 92, 198, 220, 220, 220, 442, 349, 42, 3712, 7149, 198, 220, 220, 220, 10662, 81, 42, 3712, 7149, 198, 437, 198, 8818, 7308, 13, 12860, 7, 3712, 9399, 11, 7904, 44, 12789, 90, 13940, 23650, 7203, 5239, 14, 25638, 4943, 5512, 7904, 22289, 15112, 32, 12360, 8, 198, 220, 220, 220, 1441, 44872, 7203, 9126, 27871, 3298, 376, 16412, 1321, 4943, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 8060, 15112, 32, 12360, 7, 3712, 6030, 90, 51, 92, 28, 43879, 2414, 8, 810, 1391, 51, 92, 198, 198, 42316, 82, 281, 6565, 4554, 286, 4600, 22289, 15112, 32, 12360, 63, 810, 262, 2214, 4600, 42, 63, 318, 281, 6565, 29877, 17593, 286, 5002, 2099, 4600, 51, 63, 290, 262, 2214, 4600, 69, 63, 318, 281, 6565, 15715, 15879, 286, 5002, 2099, 4600, 51, 44646, 198, 37811, 198, 22289, 15112, 32, 12360, 7, 3712, 6030, 90, 51, 92, 28, 43879, 2414, 8, 810, 1391, 51, 92, 796, 8060, 15112, 32, 12360, 90, 51, 92, 3419, 198, 8818, 8060, 15112, 32, 12360, 90, 51, 92, 3419, 810, 1391, 51, 92, 198, 220, 220, 220, 1441, 8060, 15112, 32, 12360, 7, 82, 29572, 7, 9107, 418, 7, 51, 11, 657, 11, 657, 36911, 1976, 27498, 7, 51, 11, 657, 828, 442, 4316, 2584, 7, 505, 7, 51, 36911, 10662, 81, 7, 505, 7, 51, 22305, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 8060, 15112, 32, 12360, 7, 2777, 3712, 1273, 733, 1108, 9126, 27871, 40781, 8, 198, 198, 42316, 82, 281, 4554, 286, 4600, 22289, 15112, 32, 12360, 63, 810, 262, 2214, 4600, 42, 63, 318, 257, 29877, 17593, 351, 262, 3376, 2546, 290, 599, 45826, 3912, 329, 262, 1917, 4554, 4600, 2777, 44646, 383, 2214, 4600, 69, 63, 318, 257, 15715, 15879, 286, 262, 5035, 2546, 13, 383, 3815, 287, 4600, 42, 63, 290, 4600, 69, 63, 389, 24513, 996, 290, 2421, 4585, 262, 2163, 4600, 292, 15140, 0, 63, 284, 4296, 13, 198, 37811, 198, 8818, 8060, 15112, 32, 12360, 7, 2777, 3712, 1273, 733, 1108, 9126, 27871, 40781, 8, 198, 220, 220, 220, 509, 796, 41216, 62, 42, 7, 2777, 8, 198, 220, 220, 220, 277, 796, 41216, 62, 69, 7, 2777, 8, 198, 220, 220, 220, 1441, 8060, 15112, 32, 12360, 7, 42, 11, 277, 8, 198, 437, 198, 8818, 8060, 15112, 32, 12360, 7, 198, 220, 220, 220, 509, 3712, 38176, 90, 23839, 50, 29572, 46912, 11, 13940, 3020, 19482, 90, 27, 25, 7149, 11, 27, 25, 23839, 50, 29572, 46912, 92, 5512, 277, 198, 8, 198, 220, 220, 220, 442, 349, 796, 442, 4316, 2584, 7, 2777, 10989, 363, 76, 7, 15, 5218, 3392, 7, 7857, 7, 42, 11, 352, 35514, 198, 220, 220, 220, 10662, 81, 22584, 796, 10662, 81, 7, 2777, 10989, 363, 76, 7, 15, 5218, 3392, 7, 7857, 7, 42, 11, 352, 35514, 198, 220, 220, 220, 1441, 8060, 15112, 32, 12360, 90, 417, 4906, 7, 42, 828, 4906, 1659, 7, 42, 828, 4906, 1659, 7, 69, 828, 4906, 1659, 7, 354, 349, 828, 4906, 1659, 7, 80, 81, 22584, 38165, 7, 198, 220, 220, 220, 220, 220, 220, 220, 509, 11, 277, 11, 442, 349, 11, 10662, 81, 22584, 198, 220, 220, 220, 1267, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 8060, 15112, 32, 12360, 7, 42, 11, 277, 8, 198, 198, 42316, 82, 281, 4554, 286, 4600, 22289, 15112, 32, 12360, 63, 351, 3298, 49586, 17593, 4600, 42, 63, 290, 3440, 15879, 4600, 69, 44646, 198, 37811, 198, 8818, 8060, 15112, 32, 12360, 7, 42, 11, 277, 8, 198, 220, 220, 220, 442, 349, 796, 442, 4316, 2584, 7, 46912, 90, 417, 4906, 7, 42, 38165, 7, 40, 11, 2546, 7, 42, 26513, 4008, 198, 220, 220, 220, 10662, 81, 22584, 796, 10662, 81, 7, 46912, 90, 417, 4906, 7, 42, 38165, 7, 40, 11, 2546, 7, 42, 26513, 4008, 198, 220, 220, 220, 1441, 8060, 15112, 32, 12360, 7, 42, 11, 277, 11, 442, 349, 11, 10662, 81, 22584, 8, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 651, 62, 3846, 62, 10396, 8139, 7, 2777, 3712, 1273, 733, 1108, 9126, 27871, 40781, 90, 27740, 11, 309, 5512, 2685, 27160, 8, 198, 198, 9771, 3129, 689, 281, 40874, 286, 262, 5002, 15343, 416, 5561, 39204, 262, 6115, 19287, 286, 352, 625, 1123, 5002, 1262, 12822, 31562, 15094, 81, 1300, 13, 4600, 3846, 27160, 63, 318, 257, 4600, 43362, 6525, 63, 2878, 326, 42699, 262, 29964, 286, 262, 19287, 13, 1675, 41216, 4600, 3846, 27160, 63, 329, 281, 5002, 351, 6376, 4600, 3846, 47671, 4600, 43362, 6525, 13, 260, 15003, 0, 7, 3846, 27160, 11, 2685, 8, 63, 460, 307, 1444, 13, 32677, 4600, 43362, 6525, 13, 1136, 15255, 41, 67, 53, 7, 3846, 27160, 11, 10662, 62, 4122, 8, 63, 788, 552, 1769, 262, 1988, 286, 262, 3416, 415, 286, 262, 12806, 666, 286, 262, 38445, 4308, 5499, 379, 262, 966, 4600, 80, 62, 4122, 63, 287, 262, 4941, 5002, 13, 383, 2160, 286, 884, 3815, 329, 477, 11812, 2173, 318, 262, 6115, 40874, 13, 198, 37811, 198, 8818, 651, 62, 3846, 62, 10396, 8139, 7, 2777, 3712, 1273, 733, 1108, 9126, 27871, 40781, 90, 27740, 11, 51, 5512, 2685, 27160, 8, 810, 1391, 27740, 11, 51, 92, 198, 220, 220, 220, 34590, 796, 599, 13, 354, 13, 34985, 198, 220, 220, 220, 2685, 10396, 8139, 796, 1976, 27498, 7, 51, 11, 651, 1198, 297, 82, 7, 34985, 13, 25928, 4008, 198, 220, 220, 220, 329, 357, 72, 11, 2685, 8, 287, 27056, 378, 7, 28780, 37787, 7, 34985, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 6865, 270, 0, 7, 3846, 27160, 11, 2685, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2685, 10396, 8139, 58, 72, 60, 796, 2160, 7, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 12880, 6525, 13, 1136, 15255, 41, 67, 53, 7, 3846, 27160, 11, 10662, 62, 4122, 8, 329, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 10662, 62, 4122, 287, 352, 25, 43362, 6525, 13, 1136, 77, 47003, 13033, 7, 3846, 27160, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 2685, 10396, 8139, 198, 437, 198 ]
2.591771
2,479
# use Julia1 for this using PyPlot # using StatPlots using Statistics using CSV type_list = [Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64,Float64] # table = CSV.read("logs/test_gconvert.csv") # table = CSV.read("logs/net_transition_discount_vary_reference_solver_training.csv",types=type_list,weakrefstrings=false,rows=10) # table = CSV.read("logs/n_vary_reference_solver_training.csv") table = CSV.read("logs/mturk_trusted_condition_1.csv") # table = CSV.read("logs/mturk_candidate_condition_4.csv") # for c in names(table) # println(typeof(table[c])) # end tbl_ary = convert(Array{Float64},table[:,1:22]) println(typeof(tbl_ary)) # normalize all data # for i = 1:size(tbl_ary,2) # tbl_ary[:,i] = tbl_ary[:,i]./maximum(tbl_ary[:,i]) # end col_list = [] # detect nearly identical columns and leave them out # for i = 1:size(tbl_ary,2) # if sum(isequal.(diff(tbl_ary[:,i]),0.0))/length(tbl_ary[:,i]) > 0.40 # # this is an (nearly) identical column # continue # else # push!(col_list,i) # end # end println(col_list) println(size(tbl_ary)) fig,ax = PyPlot.subplots(2,1) fig.set_size_inches(8,8) fsize = 15 # ax[1].scatter(tbl_ary[:,3],tbl_ary[:,21],marker=".",c=:black,label="Monte-Carlo Results") # ax[1].scatter(tbl_ary[:,3],tbl_ary[:,21],c=tbl_ary[:,12]) ax[1].hlines(y=0,xmin=0,xmax=1,colors=:gray,label="rwd=0.0") ax[1].set_title("transition probability vs. reward",size=fsize) ax[1].set_xlabel("transition probability",size=fsize) ax[1].set_ylabel("Reward",size=fsize) ax[1].legend() mean_rwd = [] for u in unique(tbl_ary[:,12]) uniqueN = tbl_ary[:,12].==u append!(mean_rwd,mean(tbl_ary[:,21][uniqueN])) end mean_sort = sortperm(unique(tbl_ary[:,12])) ax[2].scatter(tbl_ary[:,12],tbl_ary[:,21],marker=".",c=:black,label="Monte-Carlo Results") ax[2].plot(unique(tbl_ary[:,12])[mean_sort],mean_rwd[mean_sort],c=:blue,label="Mean Reward") ax[2].hlines(y=0,xmin=16,xmax=43,colors=:gray,label="rwd=0.0") ax[2].set_title("N vs. mean reward",size=fsize) ax[2].set_xlabel("N",size=fsize) ax[2].set_ylabel("Reward",size=fsize) ax[2].legend() fig.tight_layout() savefig("raw_data.pdf",transparent=true,dpi=300) # fig2,ax2 = PyPlot.subplots(1,1) # fig.set_size_inches(5,5) # fsize = 15 # # ax2.scatter(tbl_ary[:,3],tbl_ary[:,12],c=tbl_ary[:,21]) # ax2.set_title("ptrans vs N",size=fsize) # ax2.set_xlabel("ptrans",size=fsize) # ax2.set_ylabel("N",size=fsize) # # fig3,ax3 = PyPlot.subplots(1,1) # fig3.set_size_inches(5,5) # fsize = 15 # # mean_rwd = [] # for u in unique(tbl_ary[:,12]) # uniqueN = tbl_ary[:,12].==u # # append!(mean_rwd,mean(tbl_ary[:,21][uniqueN])) # end # # ax3.scatter(mean_rwd,unique(tbl_ary[:,12])) # ax3.set_title("mean reward vs N",size=fsize) # ax3.set_xlabel("mean reward",size=fsize) # ax3.set_ylabel("N",size=fsize) # # fig4,ax4 = PyPlot.subplots(1,1) # fig4.set_size_inches(5,5) # fsize = 15
[ 2, 779, 22300, 16, 329, 428, 198, 3500, 9485, 43328, 198, 2, 220, 1262, 5133, 3646, 1747, 198, 3500, 14370, 198, 3500, 44189, 198, 198, 4906, 62, 4868, 796, 685, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 11, 43879, 2414, 60, 198, 2, 220, 3084, 796, 44189, 13, 961, 7203, 6404, 82, 14, 9288, 62, 70, 1102, 1851, 13, 40664, 4943, 198, 2, 220, 3084, 796, 44189, 13, 961, 7203, 6404, 82, 14, 3262, 62, 7645, 653, 62, 15410, 608, 62, 85, 560, 62, 35790, 62, 82, 14375, 62, 34409, 13, 40664, 1600, 19199, 28, 4906, 62, 4868, 11, 38695, 5420, 37336, 28, 9562, 11, 8516, 28, 940, 8, 198, 2, 220, 3084, 796, 44189, 13, 961, 7203, 6404, 82, 14, 77, 62, 85, 560, 62, 35790, 62, 82, 14375, 62, 34409, 13, 40664, 4943, 198, 11487, 796, 44189, 13, 961, 7203, 6404, 82, 14, 16762, 333, 74, 62, 2213, 8459, 62, 31448, 62, 16, 13, 40664, 4943, 198, 2, 220, 3084, 796, 44189, 13, 961, 7203, 6404, 82, 14, 16762, 333, 74, 62, 46188, 20540, 62, 31448, 62, 19, 13, 40664, 4943, 198, 2, 220, 329, 269, 287, 3891, 7, 11487, 8, 198, 220, 220, 220, 1303, 220, 44872, 7, 4906, 1659, 7, 11487, 58, 66, 60, 4008, 198, 2, 220, 886, 198, 83, 2436, 62, 560, 796, 10385, 7, 19182, 90, 43879, 2414, 5512, 11487, 58, 45299, 16, 25, 1828, 12962, 198, 35235, 7, 4906, 1659, 7, 83, 2436, 62, 560, 4008, 198, 198, 2, 3487, 1096, 477, 1366, 198, 2, 220, 329, 1312, 796, 352, 25, 7857, 7, 83, 2436, 62, 560, 11, 17, 8, 198, 220, 220, 220, 1303, 220, 256, 2436, 62, 560, 58, 45299, 72, 60, 796, 256, 2436, 62, 560, 58, 45299, 72, 4083, 14, 47033, 7, 83, 2436, 62, 560, 58, 45299, 72, 12962, 198, 2, 220, 886, 198, 198, 4033, 62, 4868, 796, 17635, 198, 198, 2, 4886, 3016, 10411, 15180, 290, 2666, 606, 503, 198, 2, 220, 329, 1312, 796, 352, 25, 7857, 7, 83, 2436, 62, 560, 11, 17, 8, 198, 220, 220, 220, 1303, 220, 611, 2160, 7, 786, 13255, 12195, 26069, 7, 83, 2436, 62, 560, 58, 45299, 72, 46570, 15, 13, 15, 4008, 14, 13664, 7, 83, 2436, 62, 560, 58, 45299, 72, 12962, 1875, 657, 13, 1821, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 1303, 428, 318, 281, 357, 77, 11458, 8, 10411, 5721, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 2555, 198, 220, 220, 220, 1303, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 4574, 0, 7, 4033, 62, 4868, 11, 72, 8, 198, 220, 220, 220, 1303, 220, 886, 198, 2, 220, 886, 198, 198, 35235, 7, 4033, 62, 4868, 8, 198, 35235, 7, 7857, 7, 83, 2436, 62, 560, 4008, 198, 198, 5647, 11, 897, 796, 9485, 43328, 13, 7266, 489, 1747, 7, 17, 11, 16, 8, 198, 5647, 13, 2617, 62, 7857, 62, 45457, 7, 23, 11, 23, 8, 198, 69, 7857, 796, 1315, 198, 2, 198, 897, 58, 16, 4083, 1416, 1436, 7, 83, 2436, 62, 560, 58, 45299, 18, 4357, 83, 2436, 62, 560, 58, 45299, 2481, 4357, 4102, 263, 2625, 33283, 66, 28, 25, 13424, 11, 18242, 2625, 9069, 660, 12, 9914, 5439, 15691, 4943, 198, 2, 220, 7877, 58, 16, 4083, 1416, 1436, 7, 83, 2436, 62, 560, 58, 45299, 18, 4357, 83, 2436, 62, 560, 58, 45299, 2481, 4357, 66, 28, 83, 2436, 62, 560, 58, 45299, 1065, 12962, 198, 897, 58, 16, 4083, 71, 6615, 7, 88, 28, 15, 11, 87, 1084, 28, 15, 11, 87, 9806, 28, 16, 11, 4033, 669, 28, 25, 44605, 11, 18242, 2625, 81, 16993, 28, 15, 13, 15, 4943, 198, 897, 58, 16, 4083, 2617, 62, 7839, 7203, 7645, 653, 12867, 3691, 13, 6721, 1600, 7857, 28, 69, 7857, 8, 198, 897, 58, 16, 4083, 2617, 62, 87, 18242, 7203, 7645, 653, 12867, 1600, 7857, 28, 69, 7857, 8, 198, 897, 58, 16, 4083, 2617, 62, 2645, 9608, 7203, 48123, 1600, 7857, 28, 69, 7857, 8, 198, 897, 58, 16, 4083, 1455, 437, 3419, 198, 198, 32604, 62, 81, 16993, 796, 17635, 198, 1640, 334, 287, 3748, 7, 83, 2436, 62, 560, 58, 45299, 1065, 12962, 198, 220, 220, 220, 3748, 45, 796, 256, 2436, 62, 560, 58, 45299, 1065, 4083, 855, 84, 628, 220, 220, 220, 24443, 0, 7, 32604, 62, 81, 16993, 11, 32604, 7, 83, 2436, 62, 560, 58, 45299, 2481, 7131, 34642, 45, 60, 4008, 198, 437, 198, 198, 32604, 62, 30619, 796, 3297, 16321, 7, 34642, 7, 83, 2436, 62, 560, 58, 45299, 1065, 60, 4008, 198, 198, 897, 58, 17, 4083, 1416, 1436, 7, 83, 2436, 62, 560, 58, 45299, 1065, 4357, 83, 2436, 62, 560, 58, 45299, 2481, 4357, 4102, 263, 2625, 33283, 66, 28, 25, 13424, 11, 18242, 2625, 9069, 660, 12, 9914, 5439, 15691, 4943, 198, 897, 58, 17, 4083, 29487, 7, 34642, 7, 83, 2436, 62, 560, 58, 45299, 1065, 12962, 58, 32604, 62, 30619, 4357, 32604, 62, 81, 16993, 58, 32604, 62, 30619, 4357, 66, 28, 25, 17585, 11, 18242, 2625, 5308, 272, 32307, 4943, 198, 897, 58, 17, 4083, 71, 6615, 7, 88, 28, 15, 11, 87, 1084, 28, 1433, 11, 87, 9806, 28, 3559, 11, 4033, 669, 28, 25, 44605, 11, 18242, 2625, 81, 16993, 28, 15, 13, 15, 4943, 198, 897, 58, 17, 4083, 2617, 62, 7839, 7203, 45, 3691, 13, 1612, 6721, 1600, 7857, 28, 69, 7857, 8, 198, 897, 58, 17, 4083, 2617, 62, 87, 18242, 7203, 45, 1600, 7857, 28, 69, 7857, 8, 198, 897, 58, 17, 4083, 2617, 62, 2645, 9608, 7203, 48123, 1600, 7857, 28, 69, 7857, 8, 198, 897, 58, 17, 4083, 1455, 437, 3419, 198, 198, 5647, 13, 33464, 62, 39786, 3419, 198, 198, 21928, 5647, 7203, 1831, 62, 7890, 13, 12315, 1600, 7645, 8000, 28, 7942, 11, 67, 14415, 28, 6200, 8, 198, 198, 2, 220, 2336, 17, 11, 897, 17, 796, 9485, 43328, 13, 7266, 489, 1747, 7, 16, 11, 16, 8, 198, 2, 220, 2336, 13, 2617, 62, 7857, 62, 45457, 7, 20, 11, 20, 8, 198, 2, 220, 277, 7857, 796, 1315, 198, 2, 198, 2, 220, 7877, 17, 13, 1416, 1436, 7, 83, 2436, 62, 560, 58, 45299, 18, 4357, 83, 2436, 62, 560, 58, 45299, 1065, 4357, 66, 28, 83, 2436, 62, 560, 58, 45299, 2481, 12962, 198, 2, 220, 7877, 17, 13, 2617, 62, 7839, 7203, 20692, 504, 3691, 399, 1600, 7857, 28, 69, 7857, 8, 198, 2, 220, 7877, 17, 13, 2617, 62, 87, 18242, 7203, 20692, 504, 1600, 7857, 28, 69, 7857, 8, 198, 2, 220, 7877, 17, 13, 2617, 62, 2645, 9608, 7203, 45, 1600, 7857, 28, 69, 7857, 8, 198, 2, 198, 2, 220, 2336, 18, 11, 897, 18, 796, 9485, 43328, 13, 7266, 489, 1747, 7, 16, 11, 16, 8, 198, 2, 220, 2336, 18, 13, 2617, 62, 7857, 62, 45457, 7, 20, 11, 20, 8, 198, 2, 220, 277, 7857, 796, 1315, 198, 2, 198, 2, 220, 1612, 62, 81, 16993, 796, 17635, 198, 2, 220, 329, 334, 287, 3748, 7, 83, 2436, 62, 560, 58, 45299, 1065, 12962, 198, 220, 220, 220, 1303, 220, 3748, 45, 796, 256, 2436, 62, 560, 58, 45299, 1065, 4083, 855, 84, 198, 2, 198, 220, 220, 220, 1303, 220, 24443, 0, 7, 32604, 62, 81, 16993, 11, 32604, 7, 83, 2436, 62, 560, 58, 45299, 2481, 7131, 34642, 45, 60, 4008, 198, 2, 220, 886, 198, 2, 198, 2, 220, 7877, 18, 13, 1416, 1436, 7, 32604, 62, 81, 16993, 11, 34642, 7, 83, 2436, 62, 560, 58, 45299, 1065, 60, 4008, 198, 2, 220, 7877, 18, 13, 2617, 62, 7839, 7203, 32604, 6721, 3691, 399, 1600, 7857, 28, 69, 7857, 8, 198, 2, 220, 7877, 18, 13, 2617, 62, 87, 18242, 7203, 32604, 6721, 1600, 7857, 28, 69, 7857, 8, 198, 2, 220, 7877, 18, 13, 2617, 62, 2645, 9608, 7203, 45, 1600, 7857, 28, 69, 7857, 8, 198, 2, 198, 2, 220, 2336, 19, 11, 897, 19, 796, 9485, 43328, 13, 7266, 489, 1747, 7, 16, 11, 16, 8, 198, 2, 220, 2336, 19, 13, 2617, 62, 7857, 62, 45457, 7, 20, 11, 20, 8, 198, 2, 220, 277, 7857, 796, 1315, 198 ]
2.144027
1,465
using Bolt 𝕡 = CosmoParams() bg = Background(𝕡) 𝕣 = Bolt.RECFAST(bg=bg, Yp=𝕡.Y_p, OmegaB=𝕡.Ω_b) # 𝕣 = Bolt.Peebles() ih = IonizationHistory(𝕣, 𝕡, bg) Nz = 1000 dz = 10000/float(Nz) z = (10000 - dz):(-dz):0.0 ## using PyPlot clf() plot(z, ih.Tmat.(z2x.(z)), "-", label=raw"$T_{\mathrm{mat}}$") plot(z, ih.Trad.(z2x.(z)), "--", label=raw"$T_{\mathrm{rad}}$") yscale("log") xscale("log") legend() ylim(1, 2e4) xlim(10, 10000) xlabel("redshift") ylabel("temperature [K]") gcf()
[ 3500, 21764, 198, 47728, 243, 94, 796, 10437, 5908, 10044, 4105, 3419, 198, 35904, 796, 25353, 7, 47728, 243, 94, 8, 198, 47728, 243, 96, 796, 21764, 13, 2200, 22495, 11262, 7, 35904, 28, 35904, 11, 575, 79, 28, 47728, 243, 94, 13, 56, 62, 79, 11, 19839, 33, 28, 47728, 243, 94, 13, 138, 102, 62, 65, 8, 220, 1303, 220, 220, 47728, 243, 96, 796, 21764, 13, 47, 1453, 7689, 3419, 198, 4449, 796, 36404, 1634, 18122, 7, 47728, 243, 96, 11, 220, 47728, 243, 94, 11, 275, 70, 8, 198, 198, 45, 89, 796, 8576, 198, 67, 89, 796, 33028, 14, 22468, 7, 45, 89, 8, 198, 89, 796, 357, 49388, 532, 288, 89, 2599, 32590, 67, 89, 2599, 15, 13, 15, 198, 2235, 198, 198, 3500, 9485, 43328, 198, 565, 69, 3419, 198, 29487, 7, 89, 11, 1312, 71, 13, 51, 6759, 12195, 89, 17, 87, 12195, 89, 36911, 27444, 1600, 6167, 28, 1831, 1, 3, 51, 23330, 59, 11018, 26224, 90, 6759, 11709, 3, 4943, 198, 29487, 7, 89, 11, 1312, 71, 13, 2898, 324, 12195, 89, 17, 87, 12195, 89, 36911, 366, 438, 1600, 6167, 28, 1831, 1, 3, 51, 23330, 59, 11018, 26224, 90, 6335, 11709, 3, 4943, 198, 198, 28349, 1000, 7203, 6404, 4943, 198, 87, 9888, 7203, 6404, 4943, 198, 1455, 437, 3419, 198, 88, 2475, 7, 16, 11, 362, 68, 19, 8, 198, 87, 2475, 7, 940, 11, 33028, 8, 198, 87, 18242, 7203, 445, 30846, 4943, 198, 2645, 9608, 7203, 11498, 21069, 685, 42, 60, 4943, 198, 70, 12993, 3419, 198 ]
1.828244
262
### A Pluto.jl notebook ### # v0.17.2 using Markdown using InteractiveUtils # ╔═╡ 4b348c51-c844-4e64-85e4-a4f7ea952fc9 using Pkg, DrWatson # ╔═╡ 75ce54b9-b801-412a-b70e-ab5222df137f begin using Random using StatsBase using Distributions using StatsPlots using StatsFuns using Logging using CSV using DataFrames using Optim using MCMCChains using Turing using StatisticalRethinking end # ╔═╡ e803d172-2b8a-43b4-b99d-307e64cf29d5 md"# Chapter 9. Markov Chain Monte Carlo." # ╔═╡ 77a70403-fa95-4b13-b886-415d1a91f15a begin default(labels=false) Logging.disable_logging(Logging.Warn); end # ╔═╡ f9ff23ea-fdf2-4d48-bb84-98f40db8603e md"## 9.1 Good King Markov and his island kingdom." # ╔═╡ 821bcd65-4ab5-43e8-837e-8bdf96f24edd md"### Code 9.1" # ╔═╡ 0ccba2cd-c10c-4713-80e1-77e4a3e9c85c begin Random.seed!(1) num_weeks = 10^5 positions = [] current = 10 end; # ╔═╡ b71b59cb-b9ed-4a18-a713-400d8fb48517 for i ∈ 1:num_weeks # record current position push!(positions, current) # flip coin to generate proposal proposal = current + sample([-1, 1]) # handle loops around proposal < 1 && (proposal = 10) proposal > 10 && (proposal = 1) # move? prob_move = proposal / current rand() < prob_move && (current = proposal) end # ╔═╡ 62852231-aebe-43bc-a591-ff3c79651739 md"### Code 9.2" # ╔═╡ 2f603bc2-938d-45b4-a9ed-60daa5847af5 scatter(positions[1:100], xlab="week", ylab="island") # ╔═╡ 3f745e69-690e-4ab9-934f-b05f24f20a98 md"### Code 9.3" # ╔═╡ a88970a9-341c-4e92-891b-6057dbac1e01 histogram(positions, xlab="island", ylab="number of weeks") # ╔═╡ e7569635-07ab-4b69-8014-f26d42955fce md"## 9.2 Metropolis algorithms" # ╔═╡ d4991ad9-4341-47e8-aee4-9c35cbe28e35 md"### Code 9.4" # ╔═╡ 9322d404-9ebd-4dd8-985d-8322f4f77571 begin D = 10 T = 1000 Y = rand(MvNormal(zeros(D), ones(D)), T) Rd = sqrt.(sum.(eachcol(Y.^2))) density(Rd) end # ╔═╡ 7d94a7f1-7ce5-4f6a-ba72-0a8a9cde44e9 md"## 9.3 Hamiltonian Monte Carlo" # ╔═╡ 19d13362-93a0-4a93-b3bb-6e30d3d934a3 md"### Code 9.5" # ╔═╡ 29a1a866-522b-4354-866e-9f121ba378b9 begin Random.seed!(7) x = rand(Normal(), 50) y = rand(Normal(), 50) x = standardize(ZScoreTransform, x) y = standardize(ZScoreTransform, y); end; # ╔═╡ e3cc237b-9997-41b6-8298-1b79e4444662 function U(q::Vector{Float64}; a=0, b=1, k=0, d=1)::Float64 μy, μx = q U = sum(normlogpdf.(μy, 1, y)) + sum(normlogpdf.(μx, 1, x)) U += normlogpdf(a, b, μy) + normlogpdf(k, d, μx) -U end # ╔═╡ cb41155d-43a6-4fef-932f-13cabcdf907a md"### Code 9.6" # ╔═╡ 7d29cbaf-2b27-4b4e-8dee-74a049408fba function ∇U(q::Vector{Float64}; a=0, b=1, k=0, d=1)::Vector{Float64} μy, μx = q G₁ = sum(y .- μy) + (a - μy) / b^2 # ∂U/∂μy G₂ = sum(x .- μx) + (k - μx) / d^2 # ∂U/∂μx [-G₁, -G₂] end # ╔═╡ 9d674865-3fed-48a6-a970-d997ae9d7443 md"### Codes 9.8 - 9.10 (before 9.7 to define HMC2 function)" # ╔═╡ aa9be028-c3dc-4e4a-9405-86be642540ca function HMC2(U, ∇U, ϵ::Float64, L::Int, current_q::Vector{Float64}) q = current_q p = rand(Normal(), length(q)) # random flick - p is momentum current_p = p # make a half step for momentum at the beginning p -= ϵ .* ∇U(q) ./ 2 # initialize bookkeeping - saves trajectory qtraj = [q] ptraj = [p] # Alternate full steps for position and momentum for i ∈ 1:L q += @. ϵ * p # full step for the position # make a full step for the momentum except at the end of trajectory if i != L p -= ϵ * ∇U(q) push!(ptraj, p) end push!(qtraj, q) end # Make a half step for momentum at the end p -= ϵ * ∇U(q) / 2 push!(ptraj, p) # negate momentum at the end of trajectory to make the proposal symmetric p = -p # evaluate potential and kinetic energies at the start and the end of trajectory current_U = U(current_q) current_K = sum(current_p.^2)/2 proposed_U = U(q) proposed_K = sum(p.^2)/2 # accept or reject the state at the end of trajectory, returning either # the position at the end of the trajectory or the initial position accept = (rand() < exp(current_U - proposed_U + current_K - proposed_K)) if accept current_q = q end (q=current_q, traj=qtraj, ptraj=ptraj, accept=accept) end # ╔═╡ e61d81ed-761a-450b-9ea0-1398a9ac8e22 md"### Code 9.7" # ╔═╡ a74b283d-febc-40b1-9654-3d63b7d014b2 begin Random.seed!(1) Q = (q=[-0.1, 0.2],) pr = 0.3 step1 = 0.03 L = 11 n_samples = 4 p = scatter([Q.q[1]], [Q.q[2]], xlab="μx", ylab="μy") for i ∈ 1:n_samples Q = HMC2(U, ∇U, step1, L, Q.q) if n_samples < 10 cx, cy = [], [] for j ∈ 1:L K0 = sum(Q.ptraj[j].^2)/2 plot!( [Q.traj[j][1], Q.traj[j+1][1]], [Q.traj[j][2], Q.traj[j+1][2]], lw=1+2*K0, c=:black, alpha=0.5 ) push!(cx, Q.traj[j+1][1]) push!(cy, Q.traj[j+1][2]) end scatter!(cx, cy, c=:white, ms=3) end scatter!([Q.q[1]], [Q.q[2]], shape=(Q.accept ? :circle : :rect), c=:blue) end p end # ╔═╡ 4dc8aa1b-7544-4a80-9109-a2c9040d9321 md"## 9.4 Easy HMC: ulam" # ╔═╡ e6a3d465-57d2-40aa-b71d-8cca5db234d9 md"### Code 9.11" # ╔═╡ ff957f53-dbc7-4885-9797-61d10b8dac15 begin d = CSV.read(sr_datadir("rugged.csv"), DataFrame) dd = d[completecases(d, :rgdppc_2000),:] dd[:,:log_gdp] = log.(dd.rgdppc_2000); dd[:,:log_gdp_std] = dd.log_gdp / mean(dd.log_gdp) dd[:,:rugged_std] = dd.rugged / maximum(dd.rugged) dd[:,:cid] = @. ifelse(dd.cont_africa == 1, 1, 2); end; # ╔═╡ 06d5c8b7-7a87-4ddb-9c30-d6d623a71814 md"### Code 9.12" # ╔═╡ e29edd1a-890d-4e21-a221-d4311bd845d3 r̄ = mean(dd.rugged_std); # ╔═╡ 200f0e88-b30f-4aac-a733-a25f5a52c5d8 @model function model_m8_3(rugged_std, cid, log_gdp_std) σ ~ Exponential() a ~ MvNormal([1, 1], 0.1) b ~ MvNormal([0, 0], 0.3) μ = @. a[cid] + b[cid] * (rugged_std - r̄) log_gdp_std ~ MvNormal(μ, σ) end # ╔═╡ fbcda425-2e88-4a49-b24b-17894231642e begin m8_3 = optimize(model_m8_3(dd.rugged_std, dd.cid, dd.log_gdp_std), MAP()) m8_3_df = DataFrame(sample(m8_3, 1000)) PRECIS(m8_3_df) end # ╔═╡ f67d530a-e56d-408c-8f21-d4e37e8dab42 md"### Code 9.13" # ╔═╡ 60a185df-0656-4a46-b301-388407073ab6 md"#### For Turing this is not needed" # ╔═╡ 9d6afd05-6570-44e0-8b49-5e4bc7e8a76f begin dat_slim = dd[!,[:log_gdp_std, :rugged_std, :cid]] describe(dat_slim) end # ╔═╡ cfe67e9f-41bb-419f-96ba-282926de31a2 md"### Code 9.14" # ╔═╡ 8409b9f4-7fa5-4f38-9b38-ae34e4c60e83 @model function model_m9_1(rugged_std, cid, log_gdp_std) σ ~ Exponential() a ~ MvNormal([1, 1], 0.1) b ~ MvNormal([0, 0], 0.3) μ = @. a[cid] + b[cid] * (rugged_std - r̄) log_gdp_std ~ MvNormal(μ, σ) end # ╔═╡ 4e94cf59-81eb-4b99-b048-502f54faee15 md"#### One chain will be produced by default" # ╔═╡ 76782d05-9e32-424c-a206-8081e0fdd146 m9_1 = sample(model_m8_3(dd.rugged_std, dd.cid, dd.log_gdp_std), NUTS(), 1000); # ╔═╡ e8dd780e-b94d-413c-9b0b-0476817b2094 md"### Code 9.15" # ╔═╡ b80e5ff3-445a-465c-9665-697f5b0b897e PRECIS(DataFrame(m9_1)) # ╔═╡ b6057787-3948-482c-be7e-69c4231386b6 md"### Code 9.16" # ╔═╡ d438bddd-9138-410e-ab98-40f7c90e780f md"#### For this to use multiple cores, julia has to be started with `--threads 4` parameter, otherwise chains will be sampled sequentially" # ╔═╡ 3f4a3b7c-2db7-4d7b-800a-c14968a02855 m9_1_4 = sample(model_m8_3(dd.rugged_std, dd.cid, dd.log_gdp_std), NUTS(), MCMCThreads(), 1000, 4); # ╔═╡ 2d2aa3ef-8fb7-4c69-8869-42e1939dc950 md"### Code 9.17" # ╔═╡ 61b5e6a8-3baa-4101-9a21-5d49af43bfe7 md"#### This shows combined chains statistics. To get information about individual chains, use `m9_1[:,:,1]`" # ╔═╡ 35f25d1e-234b-481f-9303-3c5973ab1228 m9_1 # ╔═╡ 4e20ad94-3011-4b89-b29e-8a793e733e03 md"### Code 9.18" # ╔═╡ ed026592-6cb3-40a3-9f0a-565e14038114 PRECIS(DataFrame(m9_1[:,:,1])) # ╔═╡ b25c0b7a-4469-4945-be28-bfb2c22103ca md"### Code 9.19" # ╔═╡ 8a0295cc-4f0c-475a-a8c6-ccf2b99ed00f @df DataFrame(m9_1) corrplot(cols(1:5), seriestype=:scatter, ms=0.2, size=(950, 800), bins=30, grid=false) # ╔═╡ 580db5a8-550a-42d1-9aef-c95f4099a3fa md"### Code 9.20" # ╔═╡ 0bd7dbfe-0689-40d4-8fd0-1fd372b2edc2 traceplot(m9_1) # ╔═╡ 534f0c53-da8b-4da5-81d4-c0ab3ceb270b md"### Code 9.21" # ╔═╡ a28ee7bb-d9d7-43ea-833f-6460a2cf7579 histogram(m9_1) # ╔═╡ 4535c71f-be7c-41e8-940b-57289c83e509 md"## 9.5 Care and feeding of your Markov chain." # ╔═╡ f39cd55f-ed8f-487e-885e-f1e16b78d9dd md"### Codes 9.22 - 9.23" # ╔═╡ cd971faa-315a-4cea-a11a-0cb28f3e3997 let # To make it diverting with Turing, it was needed to increase exp() argument. Random.seed!(1) y = [-1., 1.] @model function model_m9_2(y) α ~ Normal(0, 1000) σ ~ Exponential(1/0.0001) y ~ Normal(α, σ) end global m9_2 = sample(model_m9_2(y), NUTS(), 1000) m9_2_df = DataFrame(m9_2) PRECIS(m9_2_df) end # ╔═╡ a9febef3-06d0-4552-8590-2f165ce36547 md"### Code 9.23" # ╔═╡ 7b2588d2-d86d-44fb-9895-d6452875bc47 plot( traceplot(m9_2), histogram(m9_2), size=(900, 500) ) # ╔═╡ cc97f4d9-ad00-4d2c-b520-2071b9cf86f6 md"### Code 9.24" # ╔═╡ 631bb03b-00a5-466a-be0d-36f86a9721aa Random.seed!(2) # ╔═╡ 95dc66d6-660a-4b0c-b89d-487a22dfec82 @model function model_m9_3(y) α ~ Normal(1, 10) σ ~ Exponential(1) y ~ Normal(α, σ) end # ╔═╡ c5570bf1-c04d-41e3-b8ae-6e6dac45cb70 begin m9_3 = sample(model_m9_3(y), NUTS(), 1000) m9_3_df = DataFrame(m9_3) PRECIS(m9_3_df) end # ╔═╡ 8f945f6c-2561-433b-aedb-3448d2c4b419 ess_rhat(m9_3) # ╔═╡ ecd23fa3-fdd2-4ffb-a0e9-ad1feee04d22 md"### Code 9.25 - 9.26" # ╔═╡ f10e310f-165b-4b4b-b3e0-66af6430ba4f let Random.seed!(41) y = rand(Normal(), 100) Random.seed!(384) @model function model_m9_4(y) a1 ~ Normal(0, 1000) a2 ~ Normal(0, 1000) σ ~ Exponential(1) μ = a1 + a2 y ~ Normal(μ, σ) end global m9_4 = sample(model_m9_4(y), NUTS(), 1000) m9_4_df = DataFrame(m9_4) PRECIS(m9_4_df) end # ╔═╡ 4c09eda3-8f4c-4fa2-91ea-99b92cfbb422 ess_rhat(m9_4) # ╔═╡ 1f2c5378-bbcd-4fb7-9130-9c6cebb4c6d4 plot(m9_4) # ╔═╡ 517d31ba-5843-40a7-ad06-96e7a8ea8845 md"### Code 9.27" # ╔═╡ 1cc0a6c1-3fcf-4df3-a8d9-ba3454c0a37b Random.seed!(384) # ╔═╡ 9a76593b-c9a9-45cc-aca5-9877432baffd @model function model_m9_5(y) a1 ~ Normal(0, 10) a2 ~ Normal(0, 10) σ ~ Exponential(1) μ = a1 + a2 y ~ Normal(μ, σ) end # ╔═╡ 6a7ea8be-bea2-41c4-89ab-9a6bbcfba116 begin m9_5 = sample(model_m9_5(y), NUTS(), 1000) m9_5_df = DataFrame(m9_5) PRECIS(m9_5_df) end # ╔═╡ 942e3f19-a5c1-430e-a3be-097c53bc7394 ess_rhat(m9_5) # ╔═╡ 6caa4b75-9ac1-496b-a4b2-38b72b203e59 plot(m9_5) # ╔═╡ 00000000-0000-0000-0000-000000000001 PLUTO_PROJECT_TOML_CONTENTS = """ [deps] CSV = "336ed68f-0bac-5ca0-87d4-7b16caf5d00b" DataFrames = "a93c6f00-e57d-5684-b7b6-d8193f3e46c0" Distributions = "31c24e10-a181-5473-b8eb-7969acd0382f" DrWatson = "634d3b9d-ee7a-5ddf-bec9-22491ea816e1" Logging = "56ddb016-857b-54e1-b83d-db4d58db5568" MCMCChains = "c7f686f2-ff18-58e9-bc7b-31028e88f75d" Optim = "429524aa-4258-5aef-a3af-852621145aeb" Pkg = "44cfe95a-1eb2-52ea-b672-e2afdf69b78f" Random = "9a3f8284-a2c9-5f02-9a11-845980a1fd5c" StatisticalRethinking = "2d09df54-9d0f-5258-8220-54c2a3d4fbee" StatsBase = "2913bbd2-ae8a-5f71-8c99-4fb6c76f3a91" StatsFuns = "4c63d2b9-4356-54db-8cca-17b64c39e42c" StatsPlots = "f3b207a7-027a-5e70-b257-86293d7955fd" Turing = "fce5fe82-541a-59a6-adf8-730c64b5f9a0" [compat] CSV = "~0.9.11" DataFrames = "~1.2.2" Distributions = "~0.25.34" DrWatson = "~2.7.5" MCMCChains = "~5.0.1" Optim = "~1.5.0" StatisticalRethinking = "~4.4.3" StatsBase = "~0.33.13" StatsFuns = "~0.9.14" StatsPlots = "~0.14.29" Turing = "~0.19.0" """ # ╔═╡ 00000000-0000-0000-0000-000000000002 PLUTO_MANIFEST_TOML_CONTENTS = """ # This file is machine-generated - editing it directly is not advised [[ANSIColoredPrinters]] git-tree-sha1 = "574baf8110975760d391c710b6341da1afa48d8c" uuid = "a4c015fc-c6ff-483c-b24f-f7ea428134e9" version = "0.0.1" [[AbstractFFTs]] deps = ["LinearAlgebra"] git-tree-sha1 = "485ee0867925449198280d4af84bdb46a2a404d0" uuid = "621f4979-c628-5d54-868e-fcf4e3e8185c" version = "1.0.1" [[AbstractMCMC]] deps = ["BangBang", "ConsoleProgressMonitor", "Distributed", "Logging", "LoggingExtras", "ProgressLogging", "Random", "StatsBase", "TerminalLoggers", "Transducers"] git-tree-sha1 = "db0a7ff3fbd987055c43b4e12d2fa30aaae8749c" uuid = "80f14c24-f653-4e6a-9b94-39d6b0f70001" version = "3.2.1" [[AbstractPPL]] deps = ["AbstractMCMC"] git-tree-sha1 = "15f34cc635546ac072d03fc2cc10083adb4df680" uuid = "7a57a42e-76ec-4ea3-a279-07e840d6d9cf" version = "0.2.0" [[AbstractTrees]] git-tree-sha1 = "03e0550477d86222521d254b741d470ba17ea0b5" uuid = "1520ce14-60c1-5f80-bbc7-55ef81b5835c" version = "0.3.4" [[Adapt]] deps = ["LinearAlgebra"] git-tree-sha1 = "84918055d15b3114ede17ac6a7182f68870c16f7" uuid = "79e6a3ab-5dfb-504d-930d-738a2a938a0e" version = "3.3.1" [[AdvancedHMC]] deps = ["AbstractMCMC", "ArgCheck", "DocStringExtensions", "InplaceOps", "LinearAlgebra", "ProgressMeter", "Random", "Requires", "Setfield", "Statistics", "StatsBase", "StatsFuns", "UnPack"] git-tree-sha1 = "0a655e9a59ee1c8bafc3af18e96d90f980b08600" uuid = "0bf59076-c3b1-5ca4-86bd-e02cd72cde3d" version = "0.3.2" [[AdvancedMH]] deps = ["AbstractMCMC", "Distributions", "Random", "Requires"] git-tree-sha1 = "8ad8bfddf8bb627d689ecb91599c349cbf15e971" uuid = "5b7e9947-ddc0-4b3f-9b55-0d8042f74170" version = "0.6.6" [[AdvancedPS]] deps = ["AbstractMCMC", "Distributions", "Libtask", "Random", "StatsFuns"] git-tree-sha1 = "06da6c283cf17cf0f97ed2c07c29b6333ee83dc9" uuid = "576499cb-2369-40b2-a588-c64705576edc" version = "0.2.4" [[AdvancedVI]] deps = ["Bijectors", "Distributions", "DistributionsAD", "DocStringExtensions", "ForwardDiff", "LinearAlgebra", "ProgressMeter", "Random", "Requires", "StatsBase", "StatsFuns", "Tracker"] git-tree-sha1 = "130d6b17a3a9d420d9a6b37412cae03ffd6a64ff" uuid = "b5ca4192-6429-45e5-a2d9-87aec30a685c" version = "0.1.3" [[ArgCheck]] git-tree-sha1 = "dedbbb2ddb876f899585c4ec4433265e3017215a" uuid = "dce04be8-c92d-5529-be00-80e4d2c0e197" version = "2.1.0" [[ArgTools]] uuid = "0dad84c5-d112-42e6-8d28-ef12dabb789f" [[Arpack]] deps = ["Arpack_jll", "Libdl", "LinearAlgebra"] git-tree-sha1 = "2ff92b71ba1747c5fdd541f8fc87736d82f40ec9" uuid = "7d9fca2a-8960-54d3-9f78-7d1dccf2cb97" version = "0.4.0" [[Arpack_jll]] deps = ["Libdl", "OpenBLAS_jll", "Pkg"] git-tree-sha1 = "e214a9b9bd1b4e1b4f15b22c0994862b66af7ff7" uuid = "68821587-b530-5797-8361-c406ea357684" version = "3.5.0+3" [[ArrayInterface]] deps = ["Compat", "IfElse", "LinearAlgebra", "Requires", "SparseArrays", "Static"] git-tree-sha1 = "265b06e2b1f6a216e0e8f183d28e4d354eab3220" uuid = "4fba245c-0d91-5ea0-9b3e-6abc04ee57a9" version = "3.2.1" [[Artifacts]] uuid = "56f22d72-fd6d-98f1-02f0-08ddc0907c33" [[AxisAlgorithms]] deps = ["LinearAlgebra", "Random", "SparseArrays", "WoodburyMatrices"] git-tree-sha1 = "66771c8d21c8ff5e3a93379480a2307ac36863f7" uuid = "13072b0f-2c55-5437-9ae7-d433b7a33950" version = "1.0.1" [[AxisArrays]] deps = ["Dates", "IntervalSets", "IterTools", "RangeArrays"] git-tree-sha1 = "d127d5e4d86c7680b20c35d40b503c74b9a39b5e" uuid = "39de3d68-74b9-583c-8d2d-e117c070f3a9" version = "0.4.4" [[AxisKeys]] deps = ["AbstractFFTs", "CovarianceEstimation", "IntervalSets", "InvertedIndices", "LazyStack", "LinearAlgebra", "NamedDims", "OffsetArrays", "Statistics", "StatsBase", "Tables"] git-tree-sha1 = "7bf355be5615178fdac1252a16e247eca6ee166f" uuid = "94b1ba4f-4ee9-5380-92f1-94cde586c3c5" version = "0.1.22" [[BangBang]] deps = ["Compat", "ConstructionBase", "Future", "InitialValues", "LinearAlgebra", "Requires", "Setfield", "Tables", "ZygoteRules"] git-tree-sha1 = "0ad226aa72d8671f20d0316e03028f0ba1624307" uuid = "198e06fe-97b7-11e9-32a5-e1d131e6ad66" version = "0.3.32" [[Base64]] uuid = "2a0f44e3-6c83-55bd-87e4-b1978d98bd5f" [[Baselet]] git-tree-sha1 = "aebf55e6d7795e02ca500a689d326ac979aaf89e" uuid = "9718e550-a3fa-408a-8086-8db961cd8217" version = "0.1.1" [[Bijectors]] deps = ["ArgCheck", "ChainRulesCore", "Compat", "Distributions", "Functors", "IrrationalConstants", "LinearAlgebra", "LogExpFunctions", "MappedArrays", "Random", "Reexport", "Requires", "Roots", "SparseArrays", "Statistics"] git-tree-sha1 = "369af32fcb9be65d496dc43ad0bb713705d4e859" uuid = "76274a88-744f-5084-9051-94815aaf08c4" version = "0.9.11" [[BitTwiddlingConvenienceFunctions]] deps = ["Static"] git-tree-sha1 = "bc1317f71de8dce26ea67fcdf7eccc0d0693b75b" uuid = "62783981-4cbd-42fc-bca8-16325de8dc4b" version = "0.1.1" [[Bzip2_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "19a35467a82e236ff51bc17a3a44b69ef35185a2" uuid = "6e34b625-4abd-537c-b88f-471c36dfa7a0" version = "1.0.8+0" [[CPUSummary]] deps = ["Hwloc", "IfElse", "Static"] git-tree-sha1 = "87b0c9c6ee0124d6c1f4ce8cb035dcaf9f90b803" uuid = "2a0fbf3d-bb9c-48f3-b0a9-814d99fd7ab9" version = "0.1.6" [[CSV]] deps = ["CodecZlib", "Dates", "FilePathsBase", "InlineStrings", "Mmap", "Parsers", "PooledArrays", "SentinelArrays", "Tables", "Unicode", "WeakRefStrings"] git-tree-sha1 = "49f14b6c56a2da47608fe30aed711b5882264d7a" uuid = "336ed68f-0bac-5ca0-87d4-7b16caf5d00b" version = "0.9.11" [[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 = "f2202b55d816427cd385a9a4f3ffb226bee80f99" uuid = "83423d85-b0ee-5818-9007-b63ccbeb887a" version = "1.16.1+0" [[ChainRules]] deps = ["ChainRulesCore", "Compat", "LinearAlgebra", "Random", "RealDot", "Statistics"] git-tree-sha1 = "65a0826ac25869556070076459925d1700316aab" uuid = "082447d4-558c-5d27-93f4-14fc19e9eca2" version = "1.14.0" [[ChainRulesCore]] deps = ["Compat", "LinearAlgebra", "SparseArrays"] git-tree-sha1 = "f885e7e7c124f8c92650d61b9477b9ac2ee607dd" uuid = "d360d2e6-b24c-11e9-a2a3-2a2ae2dbcce4" version = "1.11.1" [[ChangesOfVariables]] deps = ["LinearAlgebra", "Test"] git-tree-sha1 = "9a1d594397670492219635b35a3d830b04730d62" uuid = "9e997f8a-9a97-42d5-a9f1-ce6bfc15e2c0" version = "0.1.1" [[Clustering]] deps = ["Distances", "LinearAlgebra", "NearestNeighbors", "Printf", "SparseArrays", "Statistics", "StatsBase"] git-tree-sha1 = "75479b7df4167267d75294d14b58244695beb2ac" uuid = "aaaa29a8-35af-508c-8bc3-b662a17a0fe5" version = "0.14.2" [[CodecZlib]] deps = ["TranscodingStreams", "Zlib_jll"] git-tree-sha1 = "ded953804d019afa9a3f98981d99b33e3db7b6da" uuid = "944b1d66-785c-5afd-91f1-9de20f533193" version = "0.7.0" [[ColorSchemes]] deps = ["ColorTypes", "Colors", "FixedPointNumbers", "Random"] git-tree-sha1 = "a851fec56cb73cfdf43762999ec72eff5b86882a" uuid = "35d6a980-a343-548e-a6ea-1d62b119f2f4" version = "3.15.0" [[ColorTypes]] deps = ["FixedPointNumbers", "Random"] git-tree-sha1 = "024fe24d83e4a5bf5fc80501a314ce0d1aa35597" uuid = "3da002f7-5984-5a60-b8a6-cbb66c0b333f" version = "0.11.0" [[Colors]] deps = ["ColorTypes", "FixedPointNumbers", "Reexport"] git-tree-sha1 = "417b0ed7b8b838aa6ca0a87aadf1bb9eb111ce40" uuid = "5ae59095-9a9b-59fe-a467-6f913c188581" version = "0.12.8" [[Combinatorics]] git-tree-sha1 = "08c8b6831dc00bfea825826be0bc8336fc369860" uuid = "861a8166-3701-5b0c-9a16-15d98fcdc6aa" version = "1.0.2" [[CommonSolve]] git-tree-sha1 = "68a0743f578349ada8bc911a5cbd5a2ef6ed6d1f" uuid = "38540f10-b2f7-11e9-35d8-d573e4eb0ff2" version = "0.2.0" [[CommonSubexpressions]] deps = ["MacroTools", "Test"] git-tree-sha1 = "7b8a93dba8af7e3b42fecabf646260105ac373f7" uuid = "bbf7d656-a473-5ed7-a52c-81e309532950" version = "0.3.0" [[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 = "dce3e3fea680869eaa0b774b2e8343e9ff442313" uuid = "34da2185-b29b-5c13-b0c7-acf172513d20" version = "3.40.0" [[CompilerSupportLibraries_jll]] deps = ["Artifacts", "Libdl"] uuid = "e66e0078-7015-5450-92f7-15fbd957f2ae" [[CompositionsBase]] git-tree-sha1 = "455419f7e328a1a2493cabc6428d79e951349769" uuid = "a33af91c-f02d-484b-be07-31d278c5ca2b" version = "0.1.1" [[ConsoleProgressMonitor]] deps = ["Logging", "ProgressMeter"] git-tree-sha1 = "3ab7b2136722890b9af903859afcf457fa3059e8" uuid = "88cd18e8-d9cc-4ea6-8889-5259c0d15c8b" version = "0.1.2" [[ConstructionBase]] deps = ["LinearAlgebra"] git-tree-sha1 = "f74e9d5388b8620b4cee35d4c5a618dd4dc547f4" uuid = "187b0558-2788-49d3-abe0-74a17ed4e7c9" version = "1.3.0" [[Contour]] deps = ["StaticArrays"] git-tree-sha1 = "9f02045d934dc030edad45944ea80dbd1f0ebea7" uuid = "d38c429a-6771-53c6-b99e-75d170b6e991" version = "0.5.7" [[CovarianceEstimation]] deps = ["LinearAlgebra", "Statistics", "StatsBase"] git-tree-sha1 = "bc3930158d2be029e90b7c40d1371c4f54fa04db" uuid = "587fd27a-f159-11e8-2dae-1979310e6154" version = "0.2.6" [[Crayons]] git-tree-sha1 = "3f71217b538d7aaee0b69ab47d9b7724ca8afa0d" uuid = "a8cc5b0e-0ffa-5ad4-8c14-923d3ee1735f" version = "4.0.4" [[DataAPI]] git-tree-sha1 = "cc70b17275652eb47bc9e5f81635981f13cea5c8" uuid = "9a962f9c-6df0-11e9-0e5d-c546b8b5ee8a" version = "1.9.0" [[DataFrames]] deps = ["Compat", "DataAPI", "Future", "InvertedIndices", "IteratorInterfaceExtensions", "LinearAlgebra", "Markdown", "Missings", "PooledArrays", "PrettyTables", "Printf", "REPL", "Reexport", "SortingAlgorithms", "Statistics", "TableTraits", "Tables", "Unicode"] git-tree-sha1 = "d785f42445b63fc86caa08bb9a9351008be9b765" uuid = "a93c6f00-e57d-5684-b7b6-d8193f3e46c0" version = "1.2.2" [[DataStructures]] deps = ["Compat", "InteractiveUtils", "OrderedCollections"] git-tree-sha1 = "7d9d316f04214f7efdbb6398d545446e246eff02" uuid = "864edb3b-99cc-5e75-8d2d-829cb0a9cfe8" version = "0.18.10" [[DataValueInterfaces]] git-tree-sha1 = "bfc1187b79289637fa0ef6d4436ebdfe6905cbd6" uuid = "e2d170a0-9d28-54be-80f0-106bbe20a464" version = "1.0.0" [[DataValues]] deps = ["DataValueInterfaces", "Dates"] git-tree-sha1 = "d88a19299eba280a6d062e135a43f00323ae70bf" uuid = "e7dc6d0d-1eca-5fa6-8ad6-5aecde8b7ea5" version = "0.4.13" [[Dates]] deps = ["Printf"] uuid = "ade2ca70-3891-5945-98fb-dc099432e06a" [[DefineSingletons]] git-tree-sha1 = "77b4ca280084423b728662fe040e5ff8819347c5" uuid = "244e2a9f-e319-4986-a169-4d1fe445cd52" version = "0.1.1" [[DelimitedFiles]] deps = ["Mmap"] uuid = "8bb1440f-4735-579b-a4ab-409b98df4dab" [[DensityInterface]] deps = ["InverseFunctions", "Test"] git-tree-sha1 = "80c3e8639e3353e5d2912fb3a1916b8455e2494b" uuid = "b429d917-457f-4dbc-8f4c-0cc954292b1d" version = "0.4.0" [[DiffResults]] deps = ["StaticArrays"] git-tree-sha1 = "c18e98cba888c6c25d1c3b048e4b3380ca956805" uuid = "163ba53b-c6d8-5494-b064-1a9d43ac40c5" version = "1.0.3" [[DiffRules]] deps = ["LogExpFunctions", "NaNMath", "Random", "SpecialFunctions"] git-tree-sha1 = "d8f468c5cd4d94e86816603f7d18ece910b4aaf1" uuid = "b552c78f-8df3-52c6-915a-8e097449b14b" version = "1.5.0" [[Distances]] deps = ["LinearAlgebra", "Statistics", "StatsAPI"] git-tree-sha1 = "837c83e5574582e07662bbbba733964ff7c26b9d" uuid = "b4f34e82-e78d-54a5-968a-f98e89d6e8f7" version = "0.10.6" [[Distributed]] deps = ["Random", "Serialization", "Sockets"] uuid = "8ba89e20-285c-5b6f-9357-94700520ee1b" [[Distributions]] deps = ["ChainRulesCore", "DensityInterface", "FillArrays", "LinearAlgebra", "PDMats", "Printf", "QuadGK", "Random", "SparseArrays", "SpecialFunctions", "Statistics", "StatsBase", "StatsFuns", "Test"] git-tree-sha1 = "7f3bec11f4bcd01bc1f507ebce5eadf1b0a78f47" uuid = "31c24e10-a181-5473-b8eb-7969acd0382f" version = "0.25.34" [[DistributionsAD]] deps = ["Adapt", "ChainRules", "ChainRulesCore", "Compat", "DiffRules", "Distributions", "FillArrays", "LinearAlgebra", "NaNMath", "PDMats", "Random", "Requires", "SpecialFunctions", "StaticArrays", "StatsBase", "StatsFuns", "ZygoteRules"] git-tree-sha1 = "55c82c84759cff92189c9ad07e7bd0a0df63e900" uuid = "ced4e74d-a319-5a8a-b0ac-84af2272839c" version = "0.6.34" [[DocStringExtensions]] deps = ["LibGit2"] git-tree-sha1 = "b19534d1895d702889b219c382a6e18010797f0b" uuid = "ffbed154-4ef7-542d-bbb7-c09d3a79fcae" version = "0.8.6" [[Documenter]] deps = ["ANSIColoredPrinters", "Base64", "Dates", "DocStringExtensions", "IOCapture", "InteractiveUtils", "JSON", "LibGit2", "Logging", "Markdown", "REPL", "Test", "Unicode"] git-tree-sha1 = "f425293f7e0acaf9144de6d731772de156676233" uuid = "e30172f5-a6a5-5a46-863b-614d45cd2de4" version = "0.27.10" [[Downloads]] deps = ["ArgTools", "LibCURL", "NetworkOptions"] uuid = "f43a241f-c20a-4ad4-852c-f6b1247861c6" [[DrWatson]] deps = ["Dates", "FileIO", "JLD2", "LibGit2", "MacroTools", "Pkg", "Random", "Requires", "Scratch", "UnPack"] git-tree-sha1 = "dfc6c06fa560e6a7658245bacd90fc6a3a6c1cce" uuid = "634d3b9d-ee7a-5ddf-bec9-22491ea816e1" version = "2.7.5" [[DynamicPPL]] deps = ["AbstractMCMC", "AbstractPPL", "BangBang", "Bijectors", "ChainRulesCore", "Distributions", "MacroTools", "Random", "ZygoteRules"] git-tree-sha1 = "532397f64ad49472fb60e328369ecd5dedeff02f" uuid = "366bfd00-2699-11ea-058f-f148b4cae6d8" version = "0.15.1" [[EarCut_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "3f3a2501fa7236e9b911e0f7a588c657e822bb6d" uuid = "5ae413db-bbd1-5e63-b57d-d24a61df00f5" version = "2.2.3+0" [[EllipsisNotation]] deps = ["ArrayInterface"] git-tree-sha1 = "3fe985505b4b667e1ae303c9ca64d181f09d5c05" uuid = "da5c29d0-fa7d-589e-88eb-ea29b0a81949" version = "1.1.3" [[EllipticalSliceSampling]] deps = ["AbstractMCMC", "ArrayInterface", "Distributions", "Random", "Statistics"] git-tree-sha1 = "254182080498cce7ae4bc863d23bf27c632688f7" uuid = "cad2338a-1db2-11e9-3401-43bc07c9ede2" version = "0.4.4" [[Expat_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "b3bfd02e98aedfa5cf885665493c5598c350cd2f" uuid = "2e619515-83b5-522b-bb60-26c02a35a201" version = "2.2.10+0" [[FFMPEG]] deps = ["FFMPEG_jll"] git-tree-sha1 = "b57e3acbe22f8484b4b5ff66a7499717fe1a9cc8" uuid = "c87230d0-a227-11e9-1b43-d7ebe4e7570a" version = "0.4.1" [[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" [[FFTW]] deps = ["AbstractFFTs", "FFTW_jll", "LinearAlgebra", "MKL_jll", "Preferences", "Reexport"] git-tree-sha1 = "463cb335fa22c4ebacfd1faba5fde14edb80d96c" uuid = "7a1cc6ca-52ef-59f5-83cd-3a7055c09341" version = "1.4.5" [[FFTW_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "c6033cc3892d0ef5bb9cd29b7f2f0331ea5184ea" uuid = "f5851436-0d7a-5f13-b9de-f02708fd171a" version = "3.3.10+0" [[FileIO]] deps = ["Pkg", "Requires", "UUIDs"] git-tree-sha1 = "2db648b6712831ecb333eae76dbfd1c156ca13bb" uuid = "5789e2e9-d7fb-5bc7-8068-2c6fae9b9549" version = "1.11.2" [[FilePathsBase]] deps = ["Compat", "Dates", "Mmap", "Printf", "Test", "UUIDs"] git-tree-sha1 = "04d13bfa8ef11720c24e4d840c0033d145537df7" uuid = "48062228-2e41-5def-b9a4-89aafe57970f" version = "0.9.17" [[FillArrays]] deps = ["LinearAlgebra", "Random", "SparseArrays", "Statistics"] git-tree-sha1 = "8756f9935b7ccc9064c6eef0bff0ad643df733a3" uuid = "1a297f60-69ca-5386-bcde-b61e274b549b" version = "0.12.7" [[FiniteDiff]] deps = ["ArrayInterface", "LinearAlgebra", "Requires", "SparseArrays", "StaticArrays"] git-tree-sha1 = "8b3c09b56acaf3c0e581c66638b85c8650ee9dca" uuid = "6a86dc24-6348-571c-b903-95158fe2bd41" version = "2.8.1" [[FixedPointNumbers]] deps = ["Statistics"] git-tree-sha1 = "335bfdceacc84c5cdf16aadc768aa5ddfc5383cc" uuid = "53c48c17-4a7d-5ca2-90c5-79b7896eea93" version = "0.8.4" [[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" [[Formatting]] deps = ["Printf"] git-tree-sha1 = "8339d61043228fdd3eb658d86c926cb282ae72a8" uuid = "59287772-0a20-5a39-b81b-1366585eb4c0" version = "0.4.2" [[ForwardDiff]] deps = ["CommonSubexpressions", "DiffResults", "DiffRules", "LinearAlgebra", "LogExpFunctions", "NaNMath", "Preferences", "Printf", "Random", "SpecialFunctions", "StaticArrays"] git-tree-sha1 = "6406b5112809c08b1baa5703ad274e1dded0652f" uuid = "f6369f11-7733-5829-9624-2563aa707210" version = "0.10.23" [[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" [[FriBidi_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "aa31987c2ba8704e23c6c8ba8a4f769d5d7e4f91" uuid = "559328eb-81f9-559d-9380-de523a88c83c" version = "1.0.10+0" [[Functors]] git-tree-sha1 = "e4768c3b7f597d5a352afa09874d16e3c3f6ead2" uuid = "d9f16b24-f501-4c13-a1f2-28368ffc5196" version = "0.2.7" [[Future]] deps = ["Random"] uuid = "9fa8497b-333b-5362-9e8d-4d0656e87820" [[GLFW_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Libglvnd_jll", "Pkg", "Xorg_libXcursor_jll", "Xorg_libXi_jll", "Xorg_libXinerama_jll", "Xorg_libXrandr_jll"] git-tree-sha1 = "0c603255764a1fa0b61752d2bec14cfbd18f7fe8" uuid = "0656b61e-2033-5cc2-a64a-77c0f6c09b89" version = "3.3.5+1" [[GR]] deps = ["Base64", "DelimitedFiles", "GR_jll", "HTTP", "JSON", "Libdl", "LinearAlgebra", "Pkg", "Printf", "Random", "Serialization", "Sockets", "Test", "UUIDs"] git-tree-sha1 = "30f2b340c2fff8410d89bfcdc9c0a6dd661ac5f7" uuid = "28b8d3ca-fb5f-59d9-8090-bfdbd6d07a71" version = "0.62.1" [[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 = "fd75fa3a2080109a2c0ec9864a6e14c60cca3866" uuid = "d2c73de3-f751-5644-a686-071e5b155ba9" version = "0.62.0+0" [[GeometryBasics]] deps = ["EarCut_jll", "IterTools", "LinearAlgebra", "StaticArrays", "StructArrays", "Tables"] git-tree-sha1 = "58bcdf5ebc057b085e58d95c138725628dd7453c" uuid = "5c1252a2-5f33-56bf-86c9-59e7332b4326" version = "0.4.1" [[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" [[Glib_jll]] deps = ["Artifacts", "Gettext_jll", "JLLWrappers", "Libdl", "Libffi_jll", "Libiconv_jll", "Libmount_jll", "PCRE_jll", "Pkg", "Zlib_jll"] git-tree-sha1 = "7bf67e9a481712b3dbe9cb3dac852dc4b1162e02" uuid = "7746bdde-850d-59dc-9ae8-88ece973131d" version = "2.68.3+0" [[Graphite2_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "344bf40dcab1073aca04aa0df4fb092f920e4011" uuid = "3b182d85-2403-5c21-9c21-1e1f0cc25472" version = "1.3.14+0" [[Grisu]] git-tree-sha1 = "53bb909d1151e57e2484c3d1b53e19552b887fb2" uuid = "42e2da0e-8278-4e71-bc24-59509adca0fe" version = "1.0.2" [[HTTP]] deps = ["Base64", "Dates", "IniFile", "Logging", "MbedTLS", "NetworkOptions", "Sockets", "URIs"] git-tree-sha1 = "0fa77022fe4b511826b39c894c90daf5fce3334a" uuid = "cd3eb016-35fb-5094-929b-558a96fad6f3" version = "0.9.17" [[HarfBuzz_jll]] deps = ["Artifacts", "Cairo_jll", "Fontconfig_jll", "FreeType2_jll", "Glib_jll", "Graphite2_jll", "JLLWrappers", "Libdl", "Libffi_jll", "Pkg"] git-tree-sha1 = "8a954fed8ac097d5be04921d595f741115c1b2ad" uuid = "2e76f6c2-a576-52d4-95c1-20adfe4de566" version = "2.8.1+0" [[HostCPUFeatures]] deps = ["BitTwiddlingConvenienceFunctions", "IfElse", "Libdl", "Static"] git-tree-sha1 = "8f0dc80088981ab55702b04bba38097a44a1a3a9" uuid = "3e5b6fbb-0976-4d2c-9146-d79de83f2fb0" version = "0.1.5" [[Hwloc]] deps = ["Hwloc_jll"] git-tree-sha1 = "92d99146066c5c6888d5a3abc871e6a214388b91" uuid = "0e44f5e4-bd66-52a0-8798-143a42290a1d" version = "2.0.0" [[Hwloc_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "3395d4d4aeb3c9d31f5929d32760d8baeee88aaf" uuid = "e33a78d0-f292-5ffc-b300-72abe9b543c8" version = "2.5.0+0" [[IOCapture]] deps = ["Logging", "Random"] git-tree-sha1 = "f7be53659ab06ddc986428d3a9dcc95f6fa6705a" uuid = "b5f81e59-6552-4d32-b1f0-c071b021bf89" version = "0.2.2" [[IfElse]] git-tree-sha1 = "debdd00ffef04665ccbb3e150747a77560e8fad1" uuid = "615f187c-cbe4-4ef1-ba3b-2fcf58d6d173" version = "0.1.1" [[IniFile]] deps = ["Test"] git-tree-sha1 = "098e4d2c533924c921f9f9847274f2ad89e018b8" uuid = "83e8ac13-25f8-5344-8a64-a9f2b223428f" version = "0.5.0" [[InitialValues]] git-tree-sha1 = "7f6a4508b4a6f46db5ccd9799a3fc71ef5cad6e6" uuid = "22cec73e-a1b8-11e9-2c92-598750a2cf9c" version = "0.2.11" [[InlineStrings]] deps = ["Parsers"] git-tree-sha1 = "19cb49649f8c41de7fea32d089d37de917b553da" uuid = "842dd82b-1e85-43dc-bf29-5d0ee9dffc48" version = "1.0.1" [[InplaceOps]] deps = ["LinearAlgebra", "Test"] git-tree-sha1 = "50b41d59e7164ab6fda65e71049fee9d890731ff" uuid = "505f98c9-085e-5b2c-8e89-488be7bf1f34" version = "0.3.0" [[IntelOpenMP_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "d979e54b71da82f3a65b62553da4fc3d18c9004c" uuid = "1d5cc7b8-4909-519e-a0f8-d0f5ad9712d0" version = "2018.0.3+2" [[InteractiveUtils]] deps = ["Markdown"] uuid = "b77e0a4c-d291-57a0-90e8-8db25a27a240" [[Interpolations]] deps = ["AxisAlgorithms", "ChainRulesCore", "LinearAlgebra", "OffsetArrays", "Random", "Ratios", "Requires", "SharedArrays", "SparseArrays", "StaticArrays", "WoodburyMatrices"] git-tree-sha1 = "61aa005707ea2cebf47c8d780da8dc9bc4e0c512" uuid = "a98d9a8b-a2ab-59e6-89dd-64a1c18fca59" version = "0.13.4" [[IntervalSets]] deps = ["Dates", "EllipsisNotation", "Statistics"] git-tree-sha1 = "3cc368af3f110a767ac786560045dceddfc16758" uuid = "8197267c-284f-5f27-9208-e0e47529a953" version = "0.5.3" [[InverseFunctions]] deps = ["Test"] git-tree-sha1 = "a7254c0acd8e62f1ac75ad24d5db43f5f19f3c65" uuid = "3587e190-3f89-42d0-90ee-14403ec27112" version = "0.1.2" [[InvertedIndices]] git-tree-sha1 = "bee5f1ef5bf65df56bdd2e40447590b272a5471f" uuid = "41ab1584-1d38-5bbf-9106-f11c6c58b48f" version = "1.1.0" [[IrrationalConstants]] git-tree-sha1 = "7fd44fd4ff43fc60815f8e764c0f352b83c49151" uuid = "92d709cd-6900-40b7-9082-c6be49f344b6" version = "0.1.1" [[IterTools]] git-tree-sha1 = "05110a2ab1fc5f932622ffea2a003221f4782c18" uuid = "c8e1da08-722c-5040-9ed9-7db0dc04731e" version = "1.3.0" [[IteratorInterfaceExtensions]] git-tree-sha1 = "a3f24677c21f5bbe9d2a714f95dcd58337fb2856" uuid = "82899510-4779-5014-852e-03e436cf321d" version = "1.0.0" [[JLD2]] deps = ["DataStructures", "FileIO", "MacroTools", "Mmap", "Pkg", "Printf", "Reexport", "TranscodingStreams", "UUIDs"] git-tree-sha1 = "46b7834ec8165c541b0b5d1c8ba63ec940723ffb" uuid = "033835bb-8acc-5ee8-8aae-3f567f8a3819" version = "0.4.15" [[JLLWrappers]] deps = ["Preferences"] git-tree-sha1 = "642a199af8b68253517b80bd3bfd17eb4e84df6e" uuid = "692b3bcd-3c85-4b1f-b108-f13ce0eb3210" version = "1.3.0" [[JSON]] deps = ["Dates", "Mmap", "Parsers", "Unicode"] git-tree-sha1 = "8076680b162ada2a031f707ac7b4953e30667a37" uuid = "682c06a0-de6a-54ab-a142-c8b1cf79cde6" version = "0.21.2" [[JpegTurbo_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "d735490ac75c5cb9f1b00d8b5509c11984dc6943" uuid = "aacddb02-875f-59d6-b918-886e6ef4fbf8" version = "2.1.0+0" [[KernelDensity]] deps = ["Distributions", "DocStringExtensions", "FFTW", "Interpolations", "StatsBase"] git-tree-sha1 = "591e8dc09ad18386189610acafb970032c519707" uuid = "5ab0869b-81aa-558d-bb23-cbf5423bbe9b" version = "0.6.3" [[LAME_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "f6250b16881adf048549549fba48b1161acdac8c" uuid = "c1c5ebd0-6772-5130-a774-d5fcae4a789d" version = "3.100.1+0" [[LZO_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "e5b909bcf985c5e2605737d2ce278ed791b89be6" uuid = "dd4b983a-f0e5-5f8d-a1b7-129d4a5fb1ac" version = "2.10.1+0" [[LaTeXStrings]] git-tree-sha1 = "f2355693d6778a178ade15952b7ac47a4ff97996" uuid = "b964fa9f-0449-5b57-a5c2-d3ea65f4040f" version = "1.3.0" [[Latexify]] deps = ["Formatting", "InteractiveUtils", "LaTeXStrings", "MacroTools", "Markdown", "Printf", "Requires"] git-tree-sha1 = "a8f4f279b6fa3c3c4f1adadd78a621b13a506bce" uuid = "23fbe1c1-3f47-55db-b15f-69d7ec21a316" version = "0.15.9" [[LayoutPointers]] deps = ["ArrayInterface", "LinearAlgebra", "ManualMemory", "SIMDTypes", "Static"] git-tree-sha1 = "83b56449c39342a47f3fcdb3bc782bd6d66e1d97" uuid = "10f19ff3-798f-405d-979b-55457f8fc047" version = "0.1.4" [[LazyArtifacts]] deps = ["Artifacts", "Pkg"] uuid = "4af54fe1-eca0-43a8-85a7-787d91b784e3" [[LazyStack]] deps = ["LinearAlgebra", "NamedDims", "OffsetArrays", "Test", "ZygoteRules"] git-tree-sha1 = "a8bf67afad3f1ee59d367267adb7c44ccac7fdee" uuid = "1fad7336-0346-5a1a-a56f-a06ba010965b" version = "0.0.7" [[LeftChildRightSiblingTrees]] deps = ["AbstractTrees"] git-tree-sha1 = "71be1eb5ad19cb4f61fa8c73395c0338fd092ae0" uuid = "1d6d02ad-be62-4b6b-8a6d-2f90e265016e" version = "0.1.2" [[LibCURL]] deps = ["LibCURL_jll", "MozillaCACerts_jll"] uuid = "b27032c2-a3e7-50c8-80cd-2d36dbcbfd21" [[LibCURL_jll]] deps = ["Artifacts", "LibSSH2_jll", "Libdl", "MbedTLS_jll", "Zlib_jll", "nghttp2_jll"] uuid = "deac9b47-8bc7-5906-a0fe-35ac56dc84c0" [[LibGit2]] deps = ["Base64", "NetworkOptions", "Printf", "SHA"] uuid = "76f85450-5226-5b5a-8eaa-529ad045b433" [[LibSSH2_jll]] deps = ["Artifacts", "Libdl", "MbedTLS_jll"] uuid = "29816b5a-b9ab-546f-933c-edad1886dfa8" [[Libdl]] uuid = "8f399da3-3557-5675-b5ff-fb832c97cbdb" [[Libffi_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "0b4a5d71f3e5200a7dff793393e09dfc2d874290" uuid = "e9f186c6-92d2-5b65-8a66-fee21dc1b490" version = "3.2.2+1" [[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" [[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" [[Libgpg_error_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "c333716e46366857753e273ce6a69ee0945a6db9" uuid = "7add5ba3-2f88-524e-9cd5-f83b8a55f7b8" version = "1.42.0+0" [[Libiconv_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "42b62845d70a619f063a7da093d995ec8e15e778" uuid = "94ce4f54-9a6c-5748-9c1c-f9c7231a4531" version = "1.16.1+1" [[Libmount_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "9c30530bf0effd46e15e0fdcf2b8636e78cbbd73" uuid = "4b2f31a3-9ecc-558c-b454-b3730dcb73e9" version = "2.35.0+0" [[Libtask]] deps = ["Libtask_jll", "LinearAlgebra", "Statistics"] git-tree-sha1 = "90c6ed7f9ac449cddacd80d5c1fca59c97d203e7" uuid = "6f1fad26-d15e-5dc8-ae53-837a1d7b8c9f" version = "0.5.3" [[Libtask_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "901fc8752bbc527a6006a951716d661baa9d54e9" uuid = "3ae2931a-708c-5973-9c38-ccf7496fb450" version = "0.4.3+0" [[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" [[Libuuid_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "7f3efec06033682db852f8b3bc3c1d2b0a0ab066" uuid = "38a345b3-de98-5d2b-a5d3-14cd9215e700" version = "2.36.0+0" [[LineSearches]] deps = ["LinearAlgebra", "NLSolversBase", "NaNMath", "Parameters", "Printf"] git-tree-sha1 = "f27132e551e959b3667d8c93eae90973225032dd" uuid = "d3d80556-e9d4-5f37-9878-2ab0fcc64255" version = "7.1.1" [[LinearAlgebra]] deps = ["Libdl"] uuid = "37e2e46d-f89d-539d-b4ee-838fcccc9c8e" [[LogExpFunctions]] deps = ["ChainRulesCore", "ChangesOfVariables", "DocStringExtensions", "InverseFunctions", "IrrationalConstants", "LinearAlgebra"] git-tree-sha1 = "be9eef9f9d78cecb6f262f3c10da151a6c5ab827" uuid = "2ab3a3ac-af41-5b50-aa03-7779005ae688" version = "0.3.5" [[Logging]] uuid = "56ddb016-857b-54e1-b83d-db4d58db5568" [[LoggingExtras]] deps = ["Dates", "Logging"] git-tree-sha1 = "dfeda1c1130990428720de0024d4516b1902ce98" uuid = "e6f89c97-d47a-5376-807f-9c37f3926c36" version = "0.4.7" [[MCMCChains]] deps = ["AbstractMCMC", "AxisArrays", "Compat", "Dates", "Distributions", "Formatting", "IteratorInterfaceExtensions", "KernelDensity", "LinearAlgebra", "MCMCDiagnosticTools", "MLJModelInterface", "NaturalSort", "OrderedCollections", "PrettyTables", "Random", "RecipesBase", "Serialization", "SpecialFunctions", "Statistics", "StatsBase", "StatsFuns", "TableTraits", "Tables"] git-tree-sha1 = "04c3fd6da28ebd305120ffb05f0a3b8f9baced0a" uuid = "c7f686f2-ff18-58e9-bc7b-31028e88f75d" version = "5.0.1" [[MCMCDiagnosticTools]] deps = ["AbstractFFTs", "DataAPI", "Distributions", "LinearAlgebra", "MLJModelInterface", "Random", "SpecialFunctions", "Statistics", "StatsBase", "Tables"] git-tree-sha1 = "6aba85ab1ac0515a1d14330bf347a8634ea5776c" uuid = "be115224-59cd-429b-ad48-344e309966f0" version = "0.1.2" [[MKL_jll]] deps = ["Artifacts", "IntelOpenMP_jll", "JLLWrappers", "LazyArtifacts", "Libdl", "Pkg"] git-tree-sha1 = "5455aef09b40e5020e1520f551fa3135040d4ed0" uuid = "856f044c-d86e-5d09-b602-aeab76dc8ba7" version = "2021.1.1+2" [[MLJModelInterface]] deps = ["Random", "ScientificTypesBase", "StatisticalTraits"] git-tree-sha1 = "0174e9d180b0cae1f8fe7976350ad52f0e70e0d8" uuid = "e80e1ace-859a-464e-9ed9-23947d8ae3ea" version = "1.3.3" [[MacroTools]] deps = ["Markdown", "Random"] git-tree-sha1 = "3d3e902b31198a27340d0bf00d6ac452866021cf" uuid = "1914dd2f-81c6-5fcd-8719-6d5c9610ff09" version = "0.5.9" [[ManualMemory]] git-tree-sha1 = "9cb207b18148b2199db259adfa923b45593fe08e" uuid = "d125e4d3-2237-4719-b19c-fa641b8a4667" version = "0.1.6" [[MappedArrays]] git-tree-sha1 = "e8b359ef06ec72e8c030463fe02efe5527ee5142" uuid = "dbb5928d-eab1-5f90-85c2-b9b0edb7c900" version = "0.4.1" [[Markdown]] deps = ["Base64"] uuid = "d6f4376e-aef5-505a-96c1-9c027394607a" [[MbedTLS]] deps = ["Dates", "MbedTLS_jll", "Random", "Sockets"] git-tree-sha1 = "1c38e51c3d08ef2278062ebceade0e46cefc96fe" uuid = "739be429-bea8-5141-9913-cc70e7f3736d" version = "1.0.3" [[MbedTLS_jll]] deps = ["Artifacts", "Libdl"] uuid = "c8ffd9c3-330d-5841-b78e-0817d7145fa1" [[Measures]] git-tree-sha1 = "e498ddeee6f9fdb4551ce855a46f54dbd900245f" uuid = "442fdcdd-2543-5da2-b0f3-8c86c306513e" version = "0.3.1" [[MicroCollections]] deps = ["BangBang", "Setfield"] git-tree-sha1 = "4f65bdbbe93475f6ff9ea6969b21532f88d359be" uuid = "128add7d-3638-4c79-886c-908ea0c25c34" version = "0.1.1" [[Missings]] deps = ["DataAPI"] git-tree-sha1 = "bf210ce90b6c9eed32d25dbcae1ebc565df2687f" uuid = "e1d29d7a-bbdc-5cf2-9ac0-f12de2c33e28" version = "1.0.2" [[Mmap]] uuid = "a63ad114-7e13-5084-954f-fe012c677804" [[MonteCarloMeasurements]] deps = ["Distributed", "Distributions", "LinearAlgebra", "MacroTools", "Random", "RecipesBase", "Requires", "SLEEFPirates", "StaticArrays", "Statistics", "StatsBase", "Test"] git-tree-sha1 = "d9dc441d5a0393ee80aea49d0fb13281d7cc7c91" uuid = "0987c9cc-fe09-11e8-30f0-b96dd679fdca" version = "1.0.3" [[MozillaCACerts_jll]] uuid = "14a3606d-f60d-562e-9121-12d972cd8159" [[MultivariateStats]] deps = ["Arpack", "LinearAlgebra", "SparseArrays", "Statistics", "StatsBase"] git-tree-sha1 = "8d958ff1854b166003238fe191ec34b9d592860a" uuid = "6f286f6a-111f-5878-ab1e-185364afe411" version = "0.8.0" [[NLSolversBase]] deps = ["DiffResults", "Distributed", "FiniteDiff", "ForwardDiff"] git-tree-sha1 = "50310f934e55e5ca3912fb941dec199b49ca9b68" uuid = "d41bc354-129a-5804-8e4c-c37616107c6c" version = "7.8.2" [[NNlib]] deps = ["Adapt", "ChainRulesCore", "Compat", "LinearAlgebra", "Pkg", "Requires", "Statistics"] git-tree-sha1 = "2eb305b13eaed91d7da14269bf17ce6664bfee3d" uuid = "872c559c-99b0-510c-b3b7-b6c96a88d5cd" version = "0.7.31" [[NaNMath]] git-tree-sha1 = "bfe47e760d60b82b66b61d2d44128b62e3a369fb" uuid = "77ba4419-2d1f-58cd-9bb1-8ffee604a2e3" version = "0.3.5" [[NamedArrays]] deps = ["Combinatorics", "DataStructures", "DelimitedFiles", "InvertedIndices", "LinearAlgebra", "Random", "Requires", "SparseArrays", "Statistics"] git-tree-sha1 = "2fd5787125d1a93fbe30961bd841707b8a80d75b" uuid = "86f7a689-2022-50b4-a561-43c23ac3c673" version = "0.9.6" [[NamedDims]] deps = ["AbstractFFTs", "ChainRulesCore", "CovarianceEstimation", "LinearAlgebra", "Pkg", "Requires", "Statistics"] git-tree-sha1 = "4f34e3ff2fa7f2a1c03fb2c4fdd637380d760bbc" uuid = "356022a1-0364-5f58-8944-0da4b18d706f" version = "0.2.42" [[NamedTupleTools]] git-tree-sha1 = "63831dcea5e11db1c0925efe5ef5fc01d528c522" uuid = "d9ec5142-1e00-5aa0-9d6a-321866360f50" version = "0.13.7" [[NaturalSort]] git-tree-sha1 = "eda490d06b9f7c00752ee81cfa451efe55521e21" uuid = "c020b1a1-e9b0-503a-9c33-f039bfc54a85" version = "1.0.0" [[NearestNeighbors]] deps = ["Distances", "StaticArrays"] git-tree-sha1 = "16baacfdc8758bc374882566c9187e785e85c2f0" uuid = "b8a86587-4115-5ab1-83bc-aa920d37bbce" version = "0.4.9" [[NetworkOptions]] uuid = "ca575930-c2e3-43a9-ace4-1e988b2c1908" [[Observables]] git-tree-sha1 = "fe29afdef3d0c4a8286128d4e45cc50621b1e43d" uuid = "510215fc-4207-5dde-b226-833fc4488ee2" version = "0.4.0" [[OffsetArrays]] deps = ["Adapt"] git-tree-sha1 = "043017e0bdeff61cfbb7afeb558ab29536bbb5ed" uuid = "6fe1bfb0-de20-5000-8ca7-80f57d26f881" version = "1.10.8" [[Ogg_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "7937eda4681660b4d6aeeecc2f7e1c81c8ee4e2f" uuid = "e7412a2a-1a6e-54c0-be00-318e2571c051" version = "1.3.5+0" [[OpenBLAS_jll]] deps = ["Artifacts", "CompilerSupportLibraries_jll", "Libdl"] uuid = "4536629a-c528-5b80-bd46-f80d51c5b363" [[OpenLibm_jll]] deps = ["Artifacts", "Libdl"] uuid = "05823500-19ac-5b8b-9628-191a04bc5112" [[OpenSSL_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "15003dcb7d8db3c6c857fda14891a539a8f2705a" uuid = "458c3c95-2e84-50aa-8efc-19380b2a3a95" version = "1.1.10+0" [[OpenSpecFun_jll]] deps = ["Artifacts", "CompilerSupportLibraries_jll", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "13652491f6856acfd2db29360e1bbcd4565d04f1" uuid = "efe28fd5-8261-553b-a9e1-b2916fc3738e" version = "0.5.5+0" [[Optim]] deps = ["Compat", "FillArrays", "ForwardDiff", "LineSearches", "LinearAlgebra", "NLSolversBase", "NaNMath", "Parameters", "PositiveFactorizations", "Printf", "SparseArrays", "StatsBase"] git-tree-sha1 = "35d435b512fbab1d1a29138b5229279925eba369" uuid = "429524aa-4258-5aef-a3af-852621145aeb" version = "1.5.0" [[Opus_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "51a08fb14ec28da2ec7a927c4337e4332c2a4720" uuid = "91d4177d-7536-5919-b921-800302f37372" version = "1.3.2+0" [[OrderedCollections]] git-tree-sha1 = "85f8e6578bf1f9ee0d11e7bb1b1456435479d47c" uuid = "bac558e1-5e72-5ebc-8fee-abe8a469f55d" version = "1.4.1" [[PCRE_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "b2a7af664e098055a7529ad1a900ded962bca488" uuid = "2f80f16e-611a-54ab-bc61-aa92de5b98fc" version = "8.44.0+0" [[PDMats]] deps = ["LinearAlgebra", "SparseArrays", "SuiteSparse"] git-tree-sha1 = "ee26b350276c51697c9c2d88a072b339f9f03d73" uuid = "90014a1f-27ba-587c-ab20-58faa44d9150" version = "0.11.5" [[Parameters]] deps = ["OrderedCollections", "UnPack"] git-tree-sha1 = "34c0e9ad262e5f7fc75b10a9952ca7692cfc5fbe" uuid = "d96e819e-fc66-5662-9728-84c9c7592b0a" version = "0.12.3" [[ParetoSmooth]] deps = ["AxisKeys", "InteractiveUtils", "LinearAlgebra", "LogExpFunctions", "MCMCDiagnosticTools", "NamedDims", "PrettyTables", "Printf", "Random", "Requires", "Statistics", "StatsBase", "Tullio"] git-tree-sha1 = "c6e1c653d65d9b411f93d173678e82cf086d92e6" uuid = "a68b5a21-f429-434e-8bfa-46b447300aac" version = "0.7.0" [[ParetoSmoothedImportanceSampling]] deps = ["CSV", "DataFrames", "Distributions", "JSON", "Printf", "Random", "StanSample", "Statistics", "StatsFuns", "StatsPlots", "Test"] git-tree-sha1 = "c272a5d52dc5947a84b22b1b6655284d2fb45c8a" uuid = "98f080ec-61e2-11eb-1c7b-31ea1097256f" version = "1.1.0" [[Parsers]] deps = ["Dates"] git-tree-sha1 = "ae4bbcadb2906ccc085cf52ac286dc1377dceccc" uuid = "69de0a69-1ddd-5017-9359-2bf0b02dc9f0" version = "2.1.2" [[Pixman_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "b4f5d02549a10e20780a24fce72bea96b6329e29" uuid = "30392449-352a-5448-841d-b1acce4e97dc" version = "0.40.1+0" [[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" [[PlotThemes]] deps = ["PlotUtils", "Requires", "Statistics"] git-tree-sha1 = "a3a964ce9dc7898193536002a6dd892b1b5a6f1d" uuid = "ccf2f8ad-2431-5c83-bf29-c5338b663b6a" version = "2.0.1" [[PlotUtils]] deps = ["ColorSchemes", "Colors", "Dates", "Printf", "Random", "Reexport", "Statistics"] git-tree-sha1 = "b084324b4af5a438cd63619fd006614b3b20b87b" uuid = "995b91a9-d308-5afd-9ec6-746e21dbc043" version = "1.0.15" [[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"] git-tree-sha1 = "d73736030a094e8d24fdf3629ae980217bf1d59d" uuid = "91a5bcdd-55d7-5caf-9e0b-520d859cae80" version = "1.24.3" [[PooledArrays]] deps = ["DataAPI", "Future"] git-tree-sha1 = "db3a23166af8aebf4db5ef87ac5b00d36eb771e2" uuid = "2dfb63ee-cc39-5dd5-95bd-886bf059d720" version = "1.4.0" [[PositiveFactorizations]] deps = ["LinearAlgebra"] git-tree-sha1 = "17275485f373e6673f7e7f97051f703ed5b15b20" uuid = "85a6dd25-e78a-55b7-8502-1745935b8125" version = "0.2.4" [[Preferences]] deps = ["TOML"] git-tree-sha1 = "00cfd92944ca9c760982747e9a1d0d5d86ab1e5a" uuid = "21216c6a-2e73-6563-6e65-726566657250" version = "1.2.2" [[PrettyTables]] deps = ["Crayons", "Formatting", "Markdown", "Reexport", "Tables"] git-tree-sha1 = "d940010be611ee9d67064fe559edbb305f8cc0eb" uuid = "08abe8d2-0d0c-5749-adfa-8a2ac140af0d" version = "1.2.3" [[Printf]] deps = ["Unicode"] uuid = "de0858da-6303-5e67-8744-51eddeeeb8d7" [[ProgressLogging]] deps = ["Logging", "SHA", "UUIDs"] git-tree-sha1 = "80d919dee55b9c50e8d9e2da5eeafff3fe58b539" uuid = "33c8b6b6-d38a-422a-b730-caa89a2f386c" version = "0.1.4" [[ProgressMeter]] deps = ["Distributed", "Printf"] git-tree-sha1 = "afadeba63d90ff223a6a48d2009434ecee2ec9e8" uuid = "92933f4c-e287-5a05-a399-4b506db050ca" version = "1.7.1" [[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" [[QuadGK]] deps = ["DataStructures", "LinearAlgebra"] git-tree-sha1 = "78aadffb3efd2155af139781b8a8df1ef279ea39" uuid = "1fd47b50-473d-5c70-9696-f719f8f3bcdc" version = "2.4.2" [[REPL]] deps = ["InteractiveUtils", "Markdown", "Sockets", "Unicode"] uuid = "3fa0cd96-eef1-5676-8a61-b3b8758bbffb" [[Random]] deps = ["Serialization"] uuid = "9a3f8284-a2c9-5f02-9a11-845980a1fd5c" [[RangeArrays]] git-tree-sha1 = "b9039e93773ddcfc828f12aadf7115b4b4d225f5" uuid = "b3c3ace0-ae52-54e7-9d0b-2c1406fd6b9d" version = "0.3.2" [[Ratios]] deps = ["Requires"] git-tree-sha1 = "01d341f502250e81f6fec0afe662aa861392a3aa" uuid = "c84ed2f1-dad5-54f0-aa8e-dbefe2724439" version = "0.4.2" [[RealDot]] deps = ["LinearAlgebra"] git-tree-sha1 = "9f0a1b71baaf7650f4fa8a1d168c7fb6ee41f0c9" uuid = "c1ae055f-0cd5-4b69-90a6-9a35b1a98df9" version = "0.1.0" [[RecipesBase]] git-tree-sha1 = "6bf3f380ff52ce0832ddd3a2a7b9538ed1bcca7d" uuid = "3cdcf5f2-1ef4-517c-9805-6587b60abb01" version = "1.2.1" [[RecipesPipeline]] deps = ["Dates", "NaNMath", "PlotUtils", "RecipesBase"] git-tree-sha1 = "7ad0dfa8d03b7bcf8c597f59f5292801730c55b8" uuid = "01d81517-befc-4cb6-b9ec-a95719d0359c" version = "0.4.1" [[RecursiveArrayTools]] deps = ["ArrayInterface", "ChainRulesCore", "DocStringExtensions", "FillArrays", "LinearAlgebra", "RecipesBase", "Requires", "StaticArrays", "Statistics", "ZygoteRules"] git-tree-sha1 = "c944fa4adbb47be43376359811c0a14757bdc8a8" uuid = "731186ca-8d62-57ce-b412-fbd966d074cd" version = "2.20.0" [[Reexport]] git-tree-sha1 = "45e428421666073eab6f2da5c9d310d99bb12f9b" uuid = "189a3867-3050-52da-a836-e630ba90ab69" version = "1.2.2" [[Requires]] deps = ["UUIDs"] git-tree-sha1 = "4036a3bd08ac7e968e27c203d45f5fff15020621" uuid = "ae029012-a4dd-5104-9daa-d747884805df" version = "1.1.3" [[Rmath]] deps = ["Random", "Rmath_jll"] git-tree-sha1 = "bf3188feca147ce108c76ad82c2792c57abe7b1f" uuid = "79098fc4-a85e-5d69-aa6a-4863f24498fa" version = "0.7.0" [[Rmath_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "68db32dff12bb6127bac73c209881191bf0efbb7" uuid = "f50d1b31-88e8-58de-be2c-1cc44531875f" version = "0.3.0+0" [[Roots]] deps = ["CommonSolve", "Printf", "Setfield"] git-tree-sha1 = "51ee572776905ee34c0568f5efe035d44bf59f74" uuid = "f2b01f46-fcfa-551c-844a-d8ac1e96c665" version = "1.3.11" [[SHA]] uuid = "ea8e919c-243c-51af-8825-aaa63cd721ce" [[SIMDTypes]] git-tree-sha1 = "330289636fb8107c5f32088d2741e9fd7a061a5c" uuid = "94e857df-77ce-4151-89e5-788b33177be4" version = "0.1.0" [[SLEEFPirates]] deps = ["IfElse", "Static", "VectorizationBase"] git-tree-sha1 = "1410aad1c6b35862573c01b96cd1f6dbe3979994" uuid = "476501e8-09a2-5ece-8869-fb82de89a1fa" version = "0.6.28" [[SciMLBase]] deps = ["ArrayInterface", "CommonSolve", "ConstructionBase", "Distributed", "DocStringExtensions", "IteratorInterfaceExtensions", "LinearAlgebra", "Logging", "RecipesBase", "RecursiveArrayTools", "StaticArrays", "Statistics", "Tables", "TreeViews"] git-tree-sha1 = "b3d23aa4e5f621b574b3b0d41c62c8624d27192a" uuid = "0bca4576-84f4-4d90-8ffe-ffa030f20462" version = "1.19.5" [[ScientificTypesBase]] git-tree-sha1 = "185e373beaf6b381c1e7151ce2c2a722351d6637" uuid = "30f210dd-8aff-4c5f-94ba-8e64358c1161" version = "2.3.0" [[Scratch]] deps = ["Dates"] git-tree-sha1 = "0b4b7f1393cff97c33891da2a0bf69c6ed241fda" uuid = "6c6a2e73-6563-6170-7368-637461726353" version = "1.1.0" [[SentinelArrays]] deps = ["Dates", "Random"] git-tree-sha1 = "f45b34656397a1f6e729901dc9ef679610bd12b5" uuid = "91c51154-3ec4-41a3-a24f-3f23e20d615c" version = "1.3.8" [[Serialization]] uuid = "9e88b42a-f829-5b0c-bbe9-9e923198166b" [[Setfield]] deps = ["ConstructionBase", "Future", "MacroTools", "Requires"] git-tree-sha1 = "def0718ddbabeb5476e51e5a43609bee889f285d" uuid = "efcf1570-3423-57d1-acb7-fd33fddbac46" version = "0.8.0" [[SharedArrays]] deps = ["Distributed", "Mmap", "Random", "Serialization"] uuid = "1a1011a3-84de-559e-8e89-a11a2f7dc383" [[Showoff]] deps = ["Dates", "Grisu"] git-tree-sha1 = "91eddf657aca81df9ae6ceb20b959ae5653ad1de" uuid = "992d4aef-0814-514b-bc4d-f2e9a6c4116f" version = "1.0.3" [[Sockets]] uuid = "6462fe0b-24de-5631-8697-dd941f90decc" [[SortingAlgorithms]] deps = ["DataStructures"] git-tree-sha1 = "b3363d7460f7d098ca0912c69b082f75625d7508" uuid = "a2af1166-a08f-5f64-846c-94a0d3cef48c" version = "1.0.1" [[SparseArrays]] deps = ["LinearAlgebra", "Random"] uuid = "2f01184e-e22b-5df5-ae63-d93ebab69eaf" [[SpecialFunctions]] deps = ["ChainRulesCore", "IrrationalConstants", "LogExpFunctions", "OpenLibm_jll", "OpenSpecFun_jll"] git-tree-sha1 = "f0bccf98e16759818ffc5d97ac3ebf87eb950150" uuid = "276daf66-3868-5448-9aa4-cd146d93841b" version = "1.8.1" [[SplittablesBase]] deps = ["Setfield", "Test"] git-tree-sha1 = "39c9f91521de844bad65049efd4f9223e7ed43f9" uuid = "171d559e-b47b-412a-8079-5efa626c420e" version = "0.1.14" [[StanBase]] deps = ["CSV", "DataFrames", "DelimitedFiles", "Distributed", "DocStringExtensions", "Documenter", "Parameters", "Random", "StanDump", "Unicode"] git-tree-sha1 = "3d50110ed8c3b5ee768d29600837be594bee7bca" uuid = "d0ee94f6-a23d-54aa-bbe9-7f572d6da7f5" version = "2.6.0" [[StanDump]] deps = ["ArgCheck", "DocStringExtensions"] git-tree-sha1 = "bfaebe19ada44a52a6c797d48473f1bb22fd0853" uuid = "9713c8f3-0168-54b5-986e-22c526958f39" version = "0.2.0" [[StanSample]] deps = ["CSV", "DelimitedFiles", "Distributed", "DocStringExtensions", "MonteCarloMeasurements", "NamedTupleTools", "OrderedCollections", "Random", "Requires", "StanBase", "TableOperations", "Tables", "Unicode"] git-tree-sha1 = "737094d47efd6c3f4f6ac606367dda490d4c0a9c" uuid = "c1514b29-d3a0-5178-b312-660c88baa699" version = "4.4.1" [[Static]] deps = ["IfElse"] git-tree-sha1 = "e7bc80dc93f50857a5d1e3c8121495852f407e6a" uuid = "aedffcd0-7271-4cad-89d0-dc628f76c6d3" version = "0.4.0" [[StaticArrays]] deps = ["LinearAlgebra", "Random", "Statistics"] git-tree-sha1 = "3c76dde64d03699e074ac02eb2e8ba8254d428da" uuid = "90137ffa-7385-5640-81b9-e52037218182" version = "1.2.13" [[StatisticalRethinking]] deps = ["AxisKeys", "CSV", "DataFrames", "Dates", "Distributions", "DocStringExtensions", "Documenter", "Formatting", "KernelDensity", "LinearAlgebra", "MCMCChains", "MonteCarloMeasurements", "NamedArrays", "NamedTupleTools", "Optim", "OrderedCollections", "Parameters", "ParetoSmooth", "ParetoSmoothedImportanceSampling", "PrettyTables", "Random", "Reexport", "Requires", "Statistics", "StatsBase", "StatsFuns", "StructuralCausalModels", "Tables", "Test", "Unicode"] git-tree-sha1 = "89dd34c569b411ee10c81855844893639c73fef5" uuid = "2d09df54-9d0f-5258-8220-54c2a3d4fbee" version = "4.4.3" [[StatisticalTraits]] deps = ["ScientificTypesBase"] git-tree-sha1 = "730732cae4d3135e2f2182bd47f8d8b795ea4439" uuid = "64bff920-2084-43da-a3e6-9bb72801c0c9" version = "2.1.0" [[Statistics]] deps = ["LinearAlgebra", "SparseArrays"] uuid = "10745b16-79ce-11e8-11f9-7d13ad32a3b2" [[StatsAPI]] git-tree-sha1 = "0f2aa8e32d511f758a2ce49208181f7733a0936a" uuid = "82ae8749-77ed-4fe6-ae5f-f523153014b0" version = "1.1.0" [[StatsBase]] deps = ["DataAPI", "DataStructures", "LinearAlgebra", "LogExpFunctions", "Missings", "Printf", "Random", "SortingAlgorithms", "SparseArrays", "Statistics", "StatsAPI"] git-tree-sha1 = "2bb0cb32026a66037360606510fca5984ccc6b75" uuid = "2913bbd2-ae8a-5f71-8c99-4fb6c76f3a91" version = "0.33.13" [[StatsFuns]] deps = ["ChainRulesCore", "InverseFunctions", "IrrationalConstants", "LogExpFunctions", "Reexport", "Rmath", "SpecialFunctions"] git-tree-sha1 = "bedb3e17cc1d94ce0e6e66d3afa47157978ba404" uuid = "4c63d2b9-4356-54db-8cca-17b64c39e42c" version = "0.9.14" [[StatsPlots]] deps = ["Clustering", "DataStructures", "DataValues", "Distributions", "Interpolations", "KernelDensity", "LinearAlgebra", "MultivariateStats", "Observables", "Plots", "RecipesBase", "RecipesPipeline", "Reexport", "StatsBase", "TableOperations", "Tables", "Widgets"] git-tree-sha1 = "d6956cefe3766a8eb5caae9226118bb0ac61c8ac" uuid = "f3b207a7-027a-5e70-b257-86293d7955fd" version = "0.14.29" [[StructArrays]] deps = ["Adapt", "DataAPI", "StaticArrays", "Tables"] git-tree-sha1 = "2ce41e0d042c60ecd131e9fb7154a3bfadbf50d3" uuid = "09ab397b-f2b6-538f-b94a-2f83cf4a842a" version = "0.6.3" [[StructuralCausalModels]] deps = ["CSV", "Combinatorics", "DataFrames", "DataStructures", "Distributions", "DocStringExtensions", "LinearAlgebra", "NamedArrays", "Reexport", "Statistics"] git-tree-sha1 = "2ff1d30658057a17f3fca1ef501d8911ae66566e" uuid = "a41e6734-49ce-4065-8b83-aff084c01dfd" version = "1.1.0" [[SuiteSparse]] deps = ["Libdl", "LinearAlgebra", "Serialization", "SparseArrays"] uuid = "4607b0f0-06f3-5cda-b6b1-a6196a1729e9" [[TOML]] deps = ["Dates"] uuid = "fa267f1f-6049-4f14-aa54-33bafae1ed76" [[TableOperations]] deps = ["SentinelArrays", "Tables", "Test"] git-tree-sha1 = "e383c87cf2a1dc41fa30c093b2a19877c83e1bc1" uuid = "ab02a1b2-a7df-11e8-156e-fb1833f50b87" version = "1.2.0" [[TableTraits]] deps = ["IteratorInterfaceExtensions"] git-tree-sha1 = "c06b2f539df1c6efa794486abfb6ed2022561a39" uuid = "3783bdb8-4a98-5b6b-af9a-565f29a5fe9c" version = "1.0.1" [[Tables]] deps = ["DataAPI", "DataValueInterfaces", "IteratorInterfaceExtensions", "LinearAlgebra", "TableTraits", "Test"] git-tree-sha1 = "fed34d0e71b91734bf0a7e10eb1bb05296ddbcd0" uuid = "bd369af6-aec1-5ad0-b16a-f7cc5008161c" version = "1.6.0" [[Tar]] deps = ["ArgTools", "SHA"] uuid = "a4e569a6-e804-4fa4-b0f3-eef7a1d5b13e" [[TerminalLoggers]] deps = ["LeftChildRightSiblingTrees", "Logging", "Markdown", "Printf", "ProgressLogging", "UUIDs"] git-tree-sha1 = "62846a48a6cd70e63aa29944b8c4ef704360d72f" uuid = "5d786b92-1e48-4d6f-9151-6b4477ca9bed" version = "0.1.5" [[Test]] deps = ["InteractiveUtils", "Logging", "Random", "Serialization"] uuid = "8dfed614-e22c-5e08-85e1-65c5234f0b40" [[Tracker]] deps = ["Adapt", "DiffRules", "ForwardDiff", "LinearAlgebra", "MacroTools", "NNlib", "NaNMath", "Printf", "Random", "Requires", "SpecialFunctions", "Statistics"] git-tree-sha1 = "bf4adf36062afc921f251af4db58f06235504eff" uuid = "9f7883ad-71c0-57eb-9f7f-b5c9e6d3789c" version = "0.2.16" [[TranscodingStreams]] deps = ["Random", "Test"] git-tree-sha1 = "216b95ea110b5972db65aa90f88d8d89dcb8851c" uuid = "3bb67fe8-82b1-5028-8e26-92a6c54297fa" version = "0.9.6" [[Transducers]] deps = ["Adapt", "ArgCheck", "BangBang", "Baselet", "CompositionsBase", "DefineSingletons", "Distributed", "InitialValues", "Logging", "Markdown", "MicroCollections", "Requires", "Setfield", "SplittablesBase", "Tables"] git-tree-sha1 = "bccb153150744d476a6a8d4facf5299325d5a442" uuid = "28d57a85-8fef-5791-bfe6-a80928e7c999" version = "0.4.67" [[TreeViews]] deps = ["Test"] git-tree-sha1 = "8d0d7a3fe2f30d6a7f833a5f19f7c7a5b396eae6" uuid = "a2a6695c-b41b-5b7d-aed9-dbfdeacea5d7" version = "0.3.0" [[Tullio]] deps = ["ChainRulesCore", "DiffRules", "LinearAlgebra", "Requires"] git-tree-sha1 = "0288b7a395fc412952baf756fac94e4f28bfec65" uuid = "bc48ee85-29a4-5162-ae0b-a64e1601d4bc" version = "0.3.2" [[Turing]] deps = ["AbstractMCMC", "AdvancedHMC", "AdvancedMH", "AdvancedPS", "AdvancedVI", "BangBang", "Bijectors", "DataStructures", "Distributions", "DistributionsAD", "DocStringExtensions", "DynamicPPL", "EllipticalSliceSampling", "ForwardDiff", "Libtask", "LinearAlgebra", "MCMCChains", "NamedArrays", "Printf", "Random", "Reexport", "Requires", "SciMLBase", "SpecialFunctions", "Statistics", "StatsBase", "StatsFuns", "Tracker", "ZygoteRules"] git-tree-sha1 = "c40eac01a46b8efc8af9481982a618d6e54b506d" uuid = "fce5fe82-541a-59a6-adf8-730c64b5f9a0" version = "0.19.0" [[URIs]] git-tree-sha1 = "97bbe755a53fe859669cd907f2d96aee8d2c1355" uuid = "5c2747f8-b7ea-4ff2-ba2e-563bfd36b1d4" version = "1.3.0" [[UUIDs]] deps = ["Random", "SHA"] uuid = "cf7118a7-6976-5b1a-9a39-7adc72f591a4" [[UnPack]] git-tree-sha1 = "387c1f73762231e86e0c9c5443ce3b4a0a9a0c2b" uuid = "3a884ed6-31ef-47d7-9d2a-63182c4928ed" version = "1.0.2" [[Unicode]] uuid = "4ec0a83e-493e-50e2-b9ac-8f72acf5a8f5" [[UnicodeFun]] deps = ["REPL"] git-tree-sha1 = "53915e50200959667e78a92a418594b428dffddf" uuid = "1cfade01-22cf-5700-b092-accc4b62d6e1" version = "0.4.1" [[VectorizationBase]] deps = ["ArrayInterface", "CPUSummary", "HostCPUFeatures", "Hwloc", "IfElse", "LayoutPointers", "Libdl", "LinearAlgebra", "SIMDTypes", "Static"] git-tree-sha1 = "17e5847bb36730d90801170ecd0ce4041a3dde86" uuid = "3d5dd08c-fd9d-11e8-17fa-ed2836048c2f" version = "0.21.22" [[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" [[Wayland_protocols_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "66d72dc6fcc86352f01676e8f0f698562e60510f" uuid = "2381bf8a-dfd0-557d-9999-79630e7b1b91" version = "1.23.0+0" [[WeakRefStrings]] deps = ["DataAPI", "InlineStrings", "Parsers"] git-tree-sha1 = "c69f9da3ff2f4f02e811c3323c22e5dfcb584cfa" uuid = "ea10d353-3f73-51f8-a26c-33c1cb351aa5" version = "1.4.1" [[Widgets]] deps = ["Colors", "Dates", "Observables", "OrderedCollections"] git-tree-sha1 = "80661f59d28714632132c73779f8becc19a113f2" uuid = "cc8bc4a8-27d6-5769-a93b-9d913e69aa62" version = "0.6.4" [[WoodburyMatrices]] deps = ["LinearAlgebra", "SparseArrays"] git-tree-sha1 = "de67fa59e33ad156a590055375a30b23c40299d3" uuid = "efce3f68-66dc-5838-9240-27a6d6f5f9b6" version = "0.5.5" [[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" [[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" [[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" [[Xorg_libXau_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "4e490d5c960c314f33885790ed410ff3a94ce67e" uuid = "0c0b7dd1-d40b-584c-a123-a41640f87eec" version = "1.0.9+4" [[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" [[Xorg_libXdmcp_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "4fe47bd2247248125c428978740e18a681372dd4" uuid = "a3789734-cfe1-5b06-b2d0-1dd0d9d62d05" version = "1.1.3+4" [[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" [[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" [[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" [[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" [[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" [[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" [[Xorg_libpthread_stubs_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "6783737e45d3c59a4a4c4091f5f88cdcf0908cbb" uuid = "14d82f49-176c-5ed1-bb49-ad3f5cbd8c74" version = "0.1.0+3" [[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" [[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" [[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" [[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" [[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" [[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" [[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" [[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" [[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" [[Xorg_xtrans_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "79c31e7844f6ecf779705fbc12146eb190b7d845" uuid = "c5fb5394-a638-5e4d-96e5-b29de1b5cf10" version = "1.4.0+3" [[Zlib_jll]] deps = ["Libdl"] uuid = "83775a58-1f1d-513f-b197-d71354ab007a" [[Zstd_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "cc4bf3fdde8b7e3e9fa0351bdeedba1cf3b7f6e6" uuid = "3161d3a3-bdf6-5164-811a-617609db77b4" version = "1.5.0+0" [[ZygoteRules]] deps = ["MacroTools"] git-tree-sha1 = "8c1a8e4dfacb1fd631745552c8db35d0deb09ea0" uuid = "700de1a5-db45-46bc-99cf-38207098b444" version = "0.2.2" [[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" [[libfdk_aac_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "daacc84a041563f965be61859a36e17c4e4fcd55" uuid = "f638f0a6-7fb0-5443-88ba-1cc74229b280" version = "2.0.2+0" [[libpng_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg", "Zlib_jll"] git-tree-sha1 = "94d180a6d2b5e55e447e2d27a29ed04fe79eb30c" uuid = "b53b4c65-9356-5827-b1ea-8c7a1a84506f" version = "1.6.38+0" [[libvorbis_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Ogg_jll", "Pkg"] git-tree-sha1 = "c45f4e40e7aafe9d086379e5578947ec8b95a8fb" uuid = "f27f6e37-5d2b-51aa-960f-b287f2bc3b7a" version = "1.3.7+0" [[nghttp2_jll]] deps = ["Artifacts", "Libdl"] uuid = "8e850ede-7688-5339-a07c-302acd2aaf8d" [[p7zip_jll]] deps = ["Artifacts", "Libdl"] uuid = "3f19e933-33d8-53b3-aaab-bd5110c3b7a0" [[x264_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "4fea590b89e6ec504593146bf8b988b2c00922b2" uuid = "1270edf5-f2f9-52d2-97e9-ab00b5d0237a" version = "2021.5.5+0" [[x265_jll]] deps = ["Artifacts", "JLLWrappers", "Libdl", "Pkg"] git-tree-sha1 = "ee567a171cce03570d77ad3a43e90218e38937a9" uuid = "dfaa095f-4041-5dcd-9319-2fabd8486b76" version = "3.5.0+0" [[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: # ╟─e803d172-2b8a-43b4-b99d-307e64cf29d5 # ╠═4b348c51-c844-4e64-85e4-a4f7ea952fc9 # ╠═75ce54b9-b801-412a-b70e-ab5222df137f # ╠═77a70403-fa95-4b13-b886-415d1a91f15a # ╟─f9ff23ea-fdf2-4d48-bb84-98f40db8603e # ╟─821bcd65-4ab5-43e8-837e-8bdf96f24edd # ╠═0ccba2cd-c10c-4713-80e1-77e4a3e9c85c # ╠═b71b59cb-b9ed-4a18-a713-400d8fb48517 # ╟─62852231-aebe-43bc-a591-ff3c79651739 # ╠═2f603bc2-938d-45b4-a9ed-60daa5847af5 # ╟─3f745e69-690e-4ab9-934f-b05f24f20a98 # ╠═a88970a9-341c-4e92-891b-6057dbac1e01 # ╟─e7569635-07ab-4b69-8014-f26d42955fce # ╟─d4991ad9-4341-47e8-aee4-9c35cbe28e35 # ╠═9322d404-9ebd-4dd8-985d-8322f4f77571 # ╟─7d94a7f1-7ce5-4f6a-ba72-0a8a9cde44e9 # ╟─19d13362-93a0-4a93-b3bb-6e30d3d934a3 # ╠═29a1a866-522b-4354-866e-9f121ba378b9 # ╠═e3cc237b-9997-41b6-8298-1b79e4444662 # ╟─cb41155d-43a6-4fef-932f-13cabcdf907a # ╠═7d29cbaf-2b27-4b4e-8dee-74a049408fba # ╟─9d674865-3fed-48a6-a970-d997ae9d7443 # ╠═aa9be028-c3dc-4e4a-9405-86be642540ca # ╟─e61d81ed-761a-450b-9ea0-1398a9ac8e22 # ╠═a74b283d-febc-40b1-9654-3d63b7d014b2 # ╟─4dc8aa1b-7544-4a80-9109-a2c9040d9321 # ╟─e6a3d465-57d2-40aa-b71d-8cca5db234d9 # ╠═ff957f53-dbc7-4885-9797-61d10b8dac15 # ╟─06d5c8b7-7a87-4ddb-9c30-d6d623a71814 # ╠═e29edd1a-890d-4e21-a221-d4311bd845d3 # ╠═200f0e88-b30f-4aac-a733-a25f5a52c5d8 # ╠═fbcda425-2e88-4a49-b24b-17894231642e # ╟─f67d530a-e56d-408c-8f21-d4e37e8dab42 # ╟─60a185df-0656-4a46-b301-388407073ab6 # ╠═9d6afd05-6570-44e0-8b49-5e4bc7e8a76f # ╟─cfe67e9f-41bb-419f-96ba-282926de31a2 # ╠═8409b9f4-7fa5-4f38-9b38-ae34e4c60e83 # ╟─4e94cf59-81eb-4b99-b048-502f54faee15 # ╠═76782d05-9e32-424c-a206-8081e0fdd146 # ╟─e8dd780e-b94d-413c-9b0b-0476817b2094 # ╠═b80e5ff3-445a-465c-9665-697f5b0b897e # ╟─b6057787-3948-482c-be7e-69c4231386b6 # ╟─d438bddd-9138-410e-ab98-40f7c90e780f # ╠═3f4a3b7c-2db7-4d7b-800a-c14968a02855 # ╟─2d2aa3ef-8fb7-4c69-8869-42e1939dc950 # ╟─61b5e6a8-3baa-4101-9a21-5d49af43bfe7 # ╠═35f25d1e-234b-481f-9303-3c5973ab1228 # ╟─4e20ad94-3011-4b89-b29e-8a793e733e03 # ╠═ed026592-6cb3-40a3-9f0a-565e14038114 # ╟─b25c0b7a-4469-4945-be28-bfb2c22103ca # ╠═8a0295cc-4f0c-475a-a8c6-ccf2b99ed00f # ╟─580db5a8-550a-42d1-9aef-c95f4099a3fa # ╠═0bd7dbfe-0689-40d4-8fd0-1fd372b2edc2 # ╟─534f0c53-da8b-4da5-81d4-c0ab3ceb270b # ╠═a28ee7bb-d9d7-43ea-833f-6460a2cf7579 # ╟─4535c71f-be7c-41e8-940b-57289c83e509 # ╟─f39cd55f-ed8f-487e-885e-f1e16b78d9dd # ╠═cd971faa-315a-4cea-a11a-0cb28f3e3997 # ╟─a9febef3-06d0-4552-8590-2f165ce36547 # ╠═7b2588d2-d86d-44fb-9895-d6452875bc47 # ╟─cc97f4d9-ad00-4d2c-b520-2071b9cf86f6 # ╠═631bb03b-00a5-466a-be0d-36f86a9721aa # ╠═95dc66d6-660a-4b0c-b89d-487a22dfec82 # ╠═c5570bf1-c04d-41e3-b8ae-6e6dac45cb70 # ╠═8f945f6c-2561-433b-aedb-3448d2c4b419 # ╟─ecd23fa3-fdd2-4ffb-a0e9-ad1feee04d22 # ╠═f10e310f-165b-4b4b-b3e0-66af6430ba4f # ╠═4c09eda3-8f4c-4fa2-91ea-99b92cfbb422 # ╠═1f2c5378-bbcd-4fb7-9130-9c6cebb4c6d4 # ╟─517d31ba-5843-40a7-ad06-96e7a8ea8845 # ╠═1cc0a6c1-3fcf-4df3-a8d9-ba3454c0a37b # ╠═9a76593b-c9a9-45cc-aca5-9877432baffd # ╠═6a7ea8be-bea2-41c4-89ab-9a6bbcfba116 # ╠═942e3f19-a5c1-430e-a3be-097c53bc7394 # ╠═6caa4b75-9ac1-496b-a4b2-38b72b203e59 # ╟─00000000-0000-0000-0000-000000000001 # ╟─00000000-0000-0000-0000-000000000002
[ 21017, 317, 32217, 13, 20362, 20922, 44386, 198, 2, 410, 15, 13, 1558, 13, 17, 198, 198, 3500, 2940, 2902, 198, 3500, 21365, 18274, 4487, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 604, 65, 28978, 66, 4349, 12, 66, 23, 2598, 12, 19, 68, 2414, 12, 5332, 68, 19, 12, 64, 19, 69, 22, 18213, 49234, 16072, 24, 198, 3500, 350, 10025, 11, 1583, 54, 13506, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 5441, 344, 4051, 65, 24, 12, 65, 41531, 12, 39226, 64, 12, 65, 2154, 68, 12, 397, 20, 23148, 7568, 19708, 69, 198, 27471, 198, 197, 3500, 14534, 198, 197, 3500, 20595, 14881, 198, 197, 3500, 46567, 507, 198, 197, 3500, 20595, 3646, 1747, 198, 197, 3500, 20595, 37, 13271, 198, 197, 3500, 5972, 2667, 198, 197, 198, 197, 3500, 44189, 198, 197, 3500, 6060, 35439, 198, 197, 3500, 30011, 198, 197, 198, 197, 3500, 13122, 9655, 1925, 1299, 198, 197, 198, 197, 3500, 39141, 198, 197, 3500, 34931, 49, 2788, 8040, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 43564, 67, 23628, 12, 17, 65, 23, 64, 12, 3559, 65, 19, 12, 65, 2079, 67, 12, 22996, 68, 2414, 12993, 1959, 67, 20, 198, 9132, 1, 2, 7006, 860, 13, 2940, 709, 21853, 22489, 40089, 526, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 8541, 64, 2154, 31552, 12, 13331, 3865, 12, 19, 65, 1485, 12, 65, 44980, 12, 35038, 67, 16, 64, 6420, 69, 1314, 64, 198, 27471, 198, 197, 12286, 7, 23912, 1424, 28, 9562, 8, 198, 197, 11187, 2667, 13, 40223, 62, 6404, 2667, 7, 11187, 2667, 13, 54, 1501, 1776, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 277, 24, 487, 1954, 18213, 12, 69, 7568, 17, 12, 19, 67, 2780, 12, 11848, 5705, 12, 4089, 69, 1821, 9945, 23, 35642, 68, 198, 9132, 1, 2235, 860, 13, 16, 4599, 2677, 2940, 709, 290, 465, 7022, 13239, 526, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 807, 2481, 65, 10210, 2996, 12, 19, 397, 20, 12, 3559, 68, 23, 12, 23, 2718, 68, 12, 23, 65, 7568, 4846, 69, 1731, 6048, 198, 9132, 1, 21017, 6127, 860, 13, 16, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 657, 535, 7012, 17, 10210, 12, 66, 940, 66, 12, 2857, 1485, 12, 1795, 68, 16, 12, 3324, 68, 19, 64, 18, 68, 24, 66, 5332, 66, 198, 27471, 198, 197, 29531, 13, 28826, 0, 7, 16, 8, 198, 197, 22510, 62, 732, 2573, 796, 838, 61, 20, 198, 197, 1930, 1756, 796, 17635, 198, 197, 14421, 796, 838, 198, 437, 26, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 275, 4869, 65, 3270, 21101, 12, 65, 24, 276, 12, 19, 64, 1507, 12, 64, 50055, 12, 7029, 67, 23, 21855, 32642, 1558, 198, 1640, 1312, 18872, 230, 352, 25, 22510, 62, 732, 2573, 198, 220, 220, 220, 1303, 1700, 1459, 2292, 198, 220, 220, 220, 4574, 0, 7, 1930, 1756, 11, 1459, 8, 198, 220, 220, 220, 1303, 14283, 10752, 284, 7716, 6961, 198, 220, 220, 220, 6961, 796, 1459, 1343, 6291, 26933, 12, 16, 11, 352, 12962, 198, 220, 220, 220, 1303, 5412, 23607, 1088, 198, 220, 220, 220, 6961, 1279, 352, 11405, 357, 1676, 40007, 796, 838, 8, 198, 220, 220, 220, 6961, 1875, 838, 11405, 357, 1676, 40007, 796, 352, 8, 198, 220, 220, 220, 1303, 1445, 30, 198, 220, 220, 220, 1861, 62, 21084, 796, 6961, 1220, 1459, 198, 220, 220, 220, 43720, 3419, 1279, 1861, 62, 21084, 11405, 357, 14421, 796, 6961, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 718, 26279, 1828, 3132, 12, 3609, 1350, 12, 3559, 15630, 12, 64, 48952, 12, 487, 18, 66, 3720, 2996, 1558, 2670, 198, 9132, 1, 21017, 6127, 860, 13, 17, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 362, 69, 35642, 15630, 17, 12, 24, 2548, 67, 12, 2231, 65, 19, 12, 64, 24, 276, 12, 1899, 6814, 64, 3365, 2857, 1878, 20, 198, 1416, 1436, 7, 1930, 1756, 58, 16, 25, 3064, 4357, 2124, 23912, 2625, 10464, 1600, 331, 23912, 2625, 271, 1044, 4943, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 513, 69, 50150, 68, 3388, 12, 35844, 68, 12, 19, 397, 24, 12, 24, 2682, 69, 12, 65, 2713, 69, 1731, 69, 1238, 64, 4089, 198, 9132, 1, 21017, 6127, 860, 13, 18, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 257, 39121, 2154, 64, 24, 12, 33660, 66, 12, 19, 68, 5892, 12, 4531, 16, 65, 12, 1899, 3553, 9945, 330, 16, 68, 486, 198, 10034, 21857, 7, 1930, 1756, 11, 2124, 23912, 2625, 271, 1044, 1600, 331, 23912, 2625, 17618, 286, 2745, 4943, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 2425, 38205, 2327, 12, 2998, 397, 12, 19, 65, 3388, 12, 23, 28645, 12, 69, 2075, 67, 11785, 2816, 69, 344, 198, 9132, 1, 2235, 860, 13, 17, 3395, 25986, 16113, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 288, 28324, 16, 324, 24, 12, 19, 33660, 12, 2857, 68, 23, 12, 64, 1453, 19, 12, 24, 66, 2327, 66, 1350, 2078, 68, 2327, 198, 9132, 1, 21017, 6127, 860, 13, 19, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 10261, 1828, 67, 26429, 12, 24, 1765, 67, 12, 19, 1860, 23, 12, 42250, 67, 12, 5999, 1828, 69, 19, 69, 34483, 4869, 198, 27471, 198, 197, 35, 796, 838, 198, 197, 51, 796, 8576, 198, 197, 56, 796, 43720, 7, 44, 85, 26447, 7, 9107, 418, 7, 35, 828, 3392, 7, 35, 36911, 309, 8, 198, 197, 49, 67, 796, 19862, 17034, 12195, 16345, 12195, 27379, 4033, 7, 56, 13, 61, 17, 22305, 198, 197, 43337, 7, 49, 67, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 767, 67, 5824, 64, 22, 69, 16, 12, 22, 344, 20, 12, 19, 69, 21, 64, 12, 7012, 4761, 12, 15, 64, 23, 64, 24, 66, 2934, 2598, 68, 24, 198, 9132, 1, 2235, 860, 13, 18, 11582, 666, 22489, 40089, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 678, 67, 1485, 35667, 12, 6052, 64, 15, 12, 19, 64, 6052, 12, 65, 18, 11848, 12, 21, 68, 1270, 67, 18, 67, 24, 2682, 64, 18, 198, 9132, 1, 21017, 6127, 860, 13, 20, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 2808, 64, 16, 64, 42240, 12, 49542, 65, 12, 19, 32182, 12, 42240, 68, 12, 24, 69, 19244, 7012, 30695, 65, 24, 198, 27471, 198, 197, 29531, 13, 28826, 0, 7, 22, 8, 198, 197, 198, 197, 87, 796, 43720, 7, 26447, 22784, 2026, 8, 198, 197, 88, 796, 43720, 7, 26447, 22784, 2026, 8, 198, 197, 87, 796, 3210, 1096, 7, 57, 26595, 41762, 11, 2124, 8, 198, 197, 88, 796, 3210, 1096, 7, 57, 26595, 41762, 11, 331, 1776, 198, 437, 26, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 18, 535, 24693, 65, 12, 2079, 5607, 12, 3901, 65, 21, 12, 23, 27728, 12, 16, 65, 3720, 68, 2598, 2598, 39380, 198, 8818, 471, 7, 80, 3712, 38469, 90, 43879, 2414, 19629, 257, 28, 15, 11, 275, 28, 16, 11, 479, 28, 15, 11, 288, 28, 16, 2599, 25, 43879, 2414, 198, 220, 220, 220, 18919, 88, 11, 18919, 87, 796, 10662, 198, 220, 220, 220, 471, 796, 2160, 7, 27237, 6404, 12315, 12195, 34703, 88, 11, 352, 11, 331, 4008, 1343, 2160, 7, 27237, 6404, 12315, 12195, 34703, 87, 11, 352, 11, 2124, 4008, 220, 198, 220, 220, 220, 471, 15853, 2593, 6404, 12315, 7, 64, 11, 275, 11, 18919, 88, 8, 1343, 2593, 6404, 12315, 7, 74, 11, 288, 11, 18919, 87, 8, 198, 220, 220, 220, 532, 52, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 269, 65, 42224, 2816, 67, 12, 3559, 64, 21, 12, 19, 69, 891, 12, 24, 2624, 69, 12, 1485, 66, 39305, 7568, 24, 2998, 64, 198, 9132, 1, 21017, 6127, 860, 13, 21, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 767, 67, 1959, 21101, 1878, 12, 17, 65, 1983, 12, 19, 65, 19, 68, 12, 23, 67, 1453, 12, 4524, 64, 15, 2920, 26200, 69, 7012, 198, 8818, 18872, 229, 52, 7, 80, 3712, 38469, 90, 43879, 2414, 19629, 257, 28, 15, 11, 275, 28, 16, 11, 479, 28, 15, 11, 288, 28, 16, 2599, 25, 38469, 90, 43879, 2414, 92, 198, 220, 220, 220, 18919, 88, 11, 18919, 87, 796, 10662, 198, 220, 220, 220, 402, 158, 224, 223, 796, 2160, 7, 88, 764, 12, 18919, 88, 8, 1343, 357, 64, 532, 18919, 88, 8, 1220, 275, 61, 17, 220, 1303, 18872, 224, 52, 14, 24861, 224, 34703, 88, 198, 220, 220, 220, 402, 158, 224, 224, 796, 2160, 7, 87, 764, 12, 18919, 87, 8, 1343, 357, 74, 532, 18919, 87, 8, 1220, 288, 61, 17, 220, 1303, 18872, 224, 52, 14, 24861, 224, 34703, 87, 198, 220, 220, 220, 25915, 38, 158, 224, 223, 11, 532, 38, 158, 224, 224, 60, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 860, 67, 3134, 2780, 2996, 12, 18, 19082, 12, 2780, 64, 21, 12, 64, 43587, 12, 67, 39647, 3609, 24, 67, 22, 34938, 198, 9132, 1, 21017, 44380, 860, 13, 23, 532, 860, 13, 940, 357, 19052, 860, 13, 22, 284, 8160, 367, 9655, 17, 2163, 16725, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 257, 64, 24, 1350, 46957, 12, 66, 18, 17896, 12, 19, 68, 19, 64, 12, 24, 26598, 12, 4521, 1350, 2414, 1495, 1821, 6888, 198, 8818, 367, 9655, 17, 7, 52, 11, 18872, 229, 52, 11, 18074, 113, 3712, 43879, 2414, 11, 406, 3712, 5317, 11, 1459, 62, 80, 3712, 38469, 90, 43879, 2414, 30072, 198, 220, 220, 220, 10662, 796, 1459, 62, 80, 198, 220, 220, 220, 279, 796, 43720, 7, 26447, 22784, 4129, 7, 80, 4008, 220, 1303, 4738, 26810, 532, 279, 318, 12858, 198, 220, 220, 220, 1459, 62, 79, 796, 279, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 787, 257, 2063, 2239, 329, 12858, 379, 262, 3726, 198, 220, 220, 220, 279, 48185, 18074, 113, 764, 9, 18872, 229, 52, 7, 80, 8, 24457, 362, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 41216, 1492, 19934, 532, 16031, 22942, 198, 220, 220, 220, 10662, 9535, 73, 796, 685, 80, 60, 198, 220, 220, 220, 279, 9535, 73, 796, 685, 79, 60, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 42400, 1336, 4831, 329, 2292, 290, 12858, 198, 220, 220, 220, 329, 1312, 18872, 230, 352, 25, 43, 198, 220, 220, 220, 220, 220, 220, 220, 10662, 15853, 2488, 13, 18074, 113, 1635, 279, 220, 1303, 1336, 2239, 329, 262, 2292, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 787, 257, 1336, 2239, 329, 262, 12858, 2845, 379, 262, 886, 286, 22942, 198, 220, 220, 220, 220, 220, 220, 220, 611, 1312, 14512, 406, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 279, 48185, 18074, 113, 1635, 18872, 229, 52, 7, 80, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 457, 430, 73, 11, 279, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 80, 9535, 73, 11, 10662, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 6889, 257, 2063, 2239, 329, 12858, 379, 262, 886, 198, 220, 220, 220, 279, 48185, 18074, 113, 1635, 18872, 229, 52, 7, 80, 8, 1220, 362, 198, 220, 220, 220, 4574, 0, 7, 457, 430, 73, 11, 279, 8, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 44328, 12858, 379, 262, 886, 286, 22942, 284, 787, 262, 6961, 23606, 19482, 198, 220, 220, 220, 279, 796, 532, 79, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 13446, 2785, 290, 37892, 27598, 379, 262, 923, 290, 262, 886, 286, 22942, 198, 220, 220, 220, 1459, 62, 52, 796, 471, 7, 14421, 62, 80, 8, 198, 220, 220, 220, 1459, 62, 42, 796, 2160, 7, 14421, 62, 79, 13, 61, 17, 20679, 17, 198, 220, 220, 220, 5150, 62, 52, 796, 471, 7, 80, 8, 198, 220, 220, 220, 5150, 62, 42, 796, 2160, 7, 79, 13, 61, 17, 20679, 17, 198, 220, 220, 220, 220, 198, 220, 220, 220, 1303, 2453, 393, 4968, 262, 1181, 379, 262, 886, 286, 22942, 11, 8024, 2035, 198, 220, 220, 220, 1303, 262, 2292, 379, 262, 886, 286, 262, 22942, 393, 262, 4238, 2292, 198, 220, 220, 220, 2453, 796, 357, 25192, 3419, 1279, 1033, 7, 14421, 62, 52, 532, 5150, 62, 52, 1343, 1459, 62, 42, 532, 5150, 62, 42, 4008, 628, 220, 220, 220, 611, 2453, 198, 220, 220, 220, 220, 220, 220, 220, 1459, 62, 80, 796, 10662, 198, 220, 220, 220, 886, 198, 220, 220, 220, 220, 198, 220, 220, 220, 357, 80, 28, 14421, 62, 80, 11, 1291, 73, 28, 80, 9535, 73, 11, 279, 9535, 73, 28, 457, 430, 73, 11, 2453, 28, 13635, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 5333, 67, 6659, 276, 12, 4304, 16, 64, 12, 17885, 65, 12, 24, 18213, 15, 12, 1485, 4089, 64, 24, 330, 23, 68, 1828, 198, 9132, 1, 21017, 6127, 860, 13, 22, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 257, 4524, 65, 30290, 67, 12, 69, 1765, 66, 12, 1821, 65, 16, 12, 24, 39111, 12, 18, 67, 5066, 65, 22, 67, 28645, 65, 17, 198, 27471, 198, 197, 29531, 13, 28826, 0, 7, 16, 8, 198, 197, 48, 796, 357, 80, 41888, 12, 15, 13, 16, 11, 657, 13, 17, 4357, 8, 198, 197, 1050, 796, 657, 13, 18, 198, 197, 9662, 16, 796, 657, 13, 3070, 198, 197, 43, 796, 1367, 198, 197, 77, 62, 82, 12629, 796, 604, 198, 197, 79, 796, 41058, 26933, 48, 13, 80, 58, 16, 60, 4357, 685, 48, 13, 80, 58, 17, 60, 4357, 2124, 23912, 2625, 34703, 87, 1600, 331, 23912, 2625, 34703, 88, 4943, 628, 198, 197, 1640, 1312, 18872, 230, 352, 25, 77, 62, 82, 12629, 198, 197, 220, 220, 220, 1195, 796, 367, 9655, 17, 7, 52, 11, 18872, 229, 52, 11, 2239, 16, 11, 406, 11, 1195, 13, 80, 8, 198, 197, 220, 220, 220, 611, 299, 62, 82, 12629, 1279, 838, 220, 198, 197, 220, 220, 220, 220, 220, 220, 220, 43213, 11, 3075, 796, 685, 4357, 17635, 198, 197, 220, 220, 220, 220, 220, 220, 220, 329, 474, 18872, 230, 352, 25, 43, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 509, 15, 796, 2160, 7, 48, 13, 457, 430, 73, 58, 73, 4083, 61, 17, 20679, 17, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 7110, 0, 7, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 685, 48, 13, 9535, 73, 58, 73, 7131, 16, 4357, 1195, 13, 9535, 73, 58, 73, 10, 16, 7131, 16, 60, 4357, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 685, 48, 13, 9535, 73, 58, 73, 7131, 17, 4357, 1195, 13, 9535, 73, 58, 73, 10, 16, 7131, 17, 60, 4357, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 300, 86, 28, 16, 10, 17, 9, 42, 15, 11, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 269, 28, 25, 13424, 11, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 17130, 28, 15, 13, 20, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1267, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 66, 87, 11, 1195, 13, 9535, 73, 58, 73, 10, 16, 7131, 16, 12962, 198, 197, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 948, 11, 1195, 13, 9535, 73, 58, 73, 10, 16, 7131, 17, 12962, 198, 197, 220, 220, 220, 220, 220, 220, 220, 886, 198, 197, 220, 220, 220, 220, 220, 220, 220, 41058, 0, 7, 66, 87, 11, 3075, 11, 269, 28, 25, 11186, 11, 13845, 28, 18, 8, 198, 197, 220, 220, 220, 886, 198, 197, 220, 220, 220, 41058, 0, 26933, 48, 13, 80, 58, 16, 60, 4357, 685, 48, 13, 80, 58, 17, 60, 4357, 5485, 16193, 48, 13, 13635, 5633, 1058, 45597, 1058, 1058, 2554, 828, 269, 28, 25, 17585, 8, 198, 197, 437, 198, 197, 79, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 604, 17896, 23, 7252, 16, 65, 12, 2425, 2598, 12, 19, 64, 1795, 12, 24, 14454, 12, 64, 17, 66, 3829, 1821, 67, 6052, 2481, 198, 9132, 1, 2235, 860, 13, 19, 16789, 367, 9655, 25, 334, 2543, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 21, 64, 18, 67, 42018, 12, 3553, 67, 17, 12, 1821, 7252, 12, 65, 4869, 67, 12, 23, 13227, 20, 9945, 24409, 67, 24, 198, 9132, 1, 21017, 6127, 860, 13, 1157, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 31246, 24, 3553, 69, 4310, 12, 9945, 66, 22, 12, 2780, 5332, 12, 24, 44673, 12, 5333, 67, 940, 65, 23, 67, 330, 1314, 198, 27471, 198, 197, 67, 796, 44189, 13, 961, 7, 27891, 62, 19608, 324, 343, 7203, 21901, 13, 40664, 12340, 6060, 19778, 8, 198, 197, 1860, 796, 288, 58, 20751, 33964, 7, 67, 11, 1058, 81, 21287, 381, 66, 62, 11024, 828, 47715, 198, 197, 1860, 58, 45299, 25, 6404, 62, 21287, 79, 60, 796, 2604, 12195, 1860, 13, 81, 21287, 381, 66, 62, 11024, 1776, 198, 197, 1860, 58, 45299, 25, 6404, 62, 21287, 79, 62, 19282, 60, 796, 49427, 13, 6404, 62, 21287, 79, 1220, 1612, 7, 1860, 13, 6404, 62, 21287, 79, 8, 198, 197, 1860, 58, 45299, 25, 21901, 62, 19282, 60, 796, 49427, 13, 21901, 1220, 5415, 7, 1860, 13, 21901, 8, 198, 197, 1860, 58, 45299, 25, 66, 312, 60, 796, 2488, 13, 611, 17772, 7, 1860, 13, 3642, 62, 1878, 30997, 6624, 352, 11, 352, 11, 362, 1776, 198, 437, 26, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 9130, 67, 20, 66, 23, 65, 22, 12, 22, 64, 5774, 12, 19, 1860, 65, 12, 24, 66, 1270, 12, 67, 21, 67, 46872, 64, 45720, 1415, 198, 9132, 1, 21017, 6127, 860, 13, 1065, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 1959, 6048, 16, 64, 12, 23, 3829, 67, 12, 19, 68, 2481, 12, 64, 26115, 12, 67, 3559, 1157, 17457, 23, 2231, 67, 18, 198, 81, 136, 226, 796, 1612, 7, 1860, 13, 21901, 62, 19282, 1776, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 939, 69, 15, 68, 3459, 12, 65, 1270, 69, 12, 19, 64, 330, 12, 64, 49995, 12, 64, 1495, 69, 20, 64, 4309, 66, 20, 67, 23, 198, 31, 19849, 2163, 2746, 62, 76, 23, 62, 18, 7, 21901, 62, 19282, 11, 269, 312, 11, 220, 2604, 62, 21287, 79, 62, 19282, 8, 198, 220, 220, 220, 18074, 225, 5299, 5518, 35470, 3419, 198, 220, 220, 220, 257, 5299, 337, 85, 26447, 26933, 16, 11, 352, 4357, 657, 13, 16, 8, 198, 220, 220, 220, 275, 5299, 337, 85, 26447, 26933, 15, 11, 657, 4357, 657, 13, 18, 8, 198, 220, 220, 220, 18919, 796, 2488, 13, 257, 58, 66, 312, 60, 1343, 275, 58, 66, 312, 60, 1635, 357, 21901, 62, 19282, 532, 374, 136, 226, 8, 198, 220, 220, 220, 2604, 62, 21287, 79, 62, 19282, 5299, 337, 85, 26447, 7, 34703, 11, 18074, 225, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 277, 15630, 6814, 32114, 12, 17, 68, 3459, 12, 19, 64, 2920, 12, 65, 1731, 65, 12, 1558, 4531, 43356, 1433, 3682, 68, 198, 27471, 198, 197, 76, 23, 62, 18, 796, 27183, 7, 19849, 62, 76, 23, 62, 18, 7, 1860, 13, 21901, 62, 19282, 11, 49427, 13, 66, 312, 11, 220, 49427, 13, 6404, 62, 21287, 79, 62, 19282, 828, 34645, 28955, 198, 197, 76, 23, 62, 18, 62, 7568, 796, 6060, 19778, 7, 39873, 7, 76, 23, 62, 18, 11, 8576, 4008, 198, 197, 47, 38827, 1797, 7, 76, 23, 62, 18, 62, 7568, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 277, 3134, 67, 38612, 64, 12, 68, 3980, 67, 12, 26200, 66, 12, 23, 69, 2481, 12, 67, 19, 68, 2718, 68, 23, 67, 397, 3682, 198, 9132, 1, 21017, 6127, 860, 13, 1485, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 3126, 64, 21652, 7568, 12, 15, 37466, 12, 19, 64, 3510, 12, 65, 18938, 12, 30460, 1821, 2154, 4790, 397, 21, 198, 9132, 1, 4242, 1114, 39141, 428, 318, 407, 2622, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 860, 67, 21, 1878, 67, 2713, 12, 2996, 2154, 12, 2598, 68, 15, 12, 23, 65, 2920, 12, 20, 68, 19, 15630, 22, 68, 23, 64, 4304, 69, 198, 27471, 198, 197, 19608, 62, 82, 2475, 796, 49427, 58, 0, 17414, 25, 6404, 62, 21287, 79, 62, 19282, 11, 1058, 21901, 62, 19282, 11, 1058, 66, 312, 11907, 198, 197, 20147, 4892, 7, 19608, 62, 82, 2475, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 269, 5036, 3134, 68, 24, 69, 12, 3901, 11848, 12, 45068, 69, 12, 4846, 7012, 12, 2078, 1959, 2075, 2934, 3132, 64, 17, 198, 9132, 1, 21017, 6127, 860, 13, 1415, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 807, 29416, 65, 24, 69, 19, 12, 22, 13331, 20, 12, 19, 69, 2548, 12, 24, 65, 2548, 12, 3609, 2682, 68, 19, 66, 1899, 68, 5999, 198, 31, 19849, 2163, 2746, 62, 76, 24, 62, 16, 7, 21901, 62, 19282, 11, 269, 312, 11, 220, 2604, 62, 21287, 79, 62, 19282, 8, 198, 220, 220, 220, 18074, 225, 5299, 5518, 35470, 3419, 198, 220, 220, 220, 257, 5299, 337, 85, 26447, 26933, 16, 11, 352, 4357, 657, 13, 16, 8, 198, 220, 220, 220, 275, 5299, 337, 85, 26447, 26933, 15, 11, 657, 4357, 657, 13, 18, 8, 198, 220, 220, 220, 18919, 796, 2488, 13, 257, 58, 66, 312, 60, 1343, 275, 58, 66, 312, 60, 1635, 357, 21901, 62, 19282, 532, 374, 136, 226, 8, 198, 220, 220, 220, 2604, 62, 21287, 79, 62, 19282, 5299, 337, 85, 26447, 7, 34703, 11, 18074, 225, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 604, 68, 5824, 12993, 3270, 12, 6659, 1765, 12, 19, 65, 2079, 12, 65, 47202, 12, 35126, 69, 4051, 13331, 1453, 1314, 198, 9132, 1, 4242, 1881, 6333, 481, 307, 4635, 416, 4277, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 767, 3134, 6469, 67, 2713, 12, 24, 68, 2624, 12, 40090, 66, 12, 64, 22136, 12, 1795, 6659, 68, 15, 69, 1860, 20964, 198, 76, 24, 62, 16, 796, 6291, 7, 19849, 62, 76, 23, 62, 18, 7, 1860, 13, 21901, 62, 19282, 11, 49427, 13, 66, 312, 11, 220, 49427, 13, 6404, 62, 21287, 79, 62, 19282, 828, 399, 3843, 50, 22784, 8576, 1776, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 304, 23, 1860, 40873, 68, 12, 65, 5824, 67, 12, 44103, 66, 12, 24, 65, 15, 65, 12, 48000, 3104, 1558, 65, 1238, 5824, 198, 9132, 1, 21017, 6127, 860, 13, 1314, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 275, 1795, 68, 20, 487, 18, 12, 43489, 64, 12, 42018, 66, 12, 24, 36879, 12, 40035, 69, 20, 65, 15, 65, 4531, 22, 68, 198, 47, 38827, 1797, 7, 6601, 19778, 7, 76, 24, 62, 16, 4008, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 275, 32417, 3324, 5774, 12, 2670, 2780, 12, 40149, 66, 12, 1350, 22, 68, 12, 3388, 66, 43356, 1485, 4521, 65, 21, 198, 9132, 1, 21017, 6127, 860, 13, 1433, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 288, 43704, 65, 1860, 67, 12, 24, 20107, 12, 33289, 68, 12, 397, 4089, 12, 1821, 69, 22, 66, 3829, 68, 40873, 69, 198, 9132, 1, 4242, 1114, 428, 284, 779, 3294, 21758, 11, 474, 43640, 468, 284, 307, 2067, 351, 4600, 438, 16663, 82, 604, 63, 11507, 11, 4306, 14659, 481, 307, 35846, 4726, 3746, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 513, 69, 19, 64, 18, 65, 22, 66, 12, 17, 9945, 22, 12, 19, 67, 22, 65, 12, 7410, 64, 12, 66, 19442, 3104, 64, 46957, 2816, 198, 76, 24, 62, 16, 62, 19, 796, 6291, 7, 19849, 62, 76, 23, 62, 18, 7, 1860, 13, 21901, 62, 19282, 11, 49427, 13, 66, 312, 11, 220, 49427, 13, 6404, 62, 21287, 79, 62, 19282, 828, 399, 3843, 50, 22784, 198, 197, 9655, 9655, 16818, 82, 22784, 8576, 11, 604, 1776, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 362, 67, 17, 7252, 18, 891, 12, 23, 21855, 22, 12, 19, 66, 3388, 12, 3459, 3388, 12, 3682, 68, 1129, 2670, 17896, 31027, 198, 9132, 1, 21017, 6127, 860, 13, 1558, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 8454, 65, 20, 68, 21, 64, 23, 12, 18, 7012, 64, 12, 3901, 486, 12, 24, 64, 2481, 12, 20, 67, 2920, 1878, 3559, 65, 5036, 22, 198, 9132, 1, 4242, 770, 2523, 5929, 14659, 7869, 13, 1675, 651, 1321, 546, 1981, 14659, 11, 779, 4600, 76, 24, 62, 16, 58, 45299, 45299, 16, 60, 63, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 3439, 69, 1495, 67, 16, 68, 12, 24409, 65, 12, 40271, 69, 12, 24, 22572, 12, 18, 66, 3270, 4790, 397, 1065, 2078, 198, 76, 24, 62, 16, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 604, 68, 1238, 324, 5824, 12, 18938, 16, 12, 19, 65, 4531, 12, 65, 1959, 68, 12, 23, 64, 44750, 68, 49995, 68, 3070, 198, 9132, 1, 21017, 6127, 860, 13, 1507, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 1225, 45987, 45839, 12, 21, 21101, 18, 12, 1821, 64, 18, 12, 24, 69, 15, 64, 12, 47372, 68, 15187, 2548, 16562, 198, 47, 38827, 1797, 7, 6601, 19778, 7, 76, 24, 62, 16, 58, 45299, 45299, 16, 60, 4008, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 275, 1495, 66, 15, 65, 22, 64, 12, 2598, 3388, 12, 2920, 2231, 12, 1350, 2078, 12, 19881, 65, 17, 66, 1828, 15197, 6888, 198, 9132, 1, 21017, 6127, 860, 13, 1129, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 807, 64, 15, 25710, 535, 12, 19, 69, 15, 66, 12, 32576, 64, 12, 64, 23, 66, 21, 12, 535, 69, 17, 65, 2079, 276, 405, 69, 198, 31, 7568, 6060, 19778, 7, 76, 24, 62, 16, 8, 1162, 81, 29487, 7, 4033, 82, 7, 16, 25, 20, 828, 1055, 6386, 2981, 28, 25, 1416, 1436, 11, 13845, 28, 15, 13, 17, 11, 2546, 16193, 31027, 11, 10460, 828, 41701, 28, 1270, 11, 10706, 28, 9562, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 41234, 9945, 20, 64, 23, 12, 22730, 64, 12, 3682, 67, 16, 12, 24, 64, 891, 12, 66, 3865, 69, 1821, 2079, 64, 18, 13331, 198, 9132, 1, 21017, 6127, 860, 13, 1238, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 657, 17457, 22, 9945, 5036, 12, 15, 40523, 12, 1821, 67, 19, 12, 23, 16344, 15, 12, 16, 16344, 36720, 65, 17, 276, 66, 17, 198, 40546, 29487, 7, 76, 24, 62, 16, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 642, 2682, 69, 15, 66, 4310, 12, 6814, 23, 65, 12, 19, 6814, 20, 12, 6659, 67, 19, 12, 66, 15, 397, 18, 344, 65, 20233, 65, 198, 9132, 1, 21017, 6127, 860, 13, 2481, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 257, 2078, 1453, 22, 11848, 12, 67, 24, 67, 22, 12, 3559, 18213, 12, 48634, 69, 12, 2414, 1899, 64, 17, 12993, 2425, 3720, 198, 10034, 21857, 7, 76, 24, 62, 16, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 4153, 2327, 66, 4869, 69, 12, 1350, 22, 66, 12, 3901, 68, 23, 12, 46899, 65, 12, 3553, 27693, 66, 5999, 68, 29022, 198, 9132, 1, 2235, 860, 13, 20, 7276, 290, 13017, 286, 534, 2940, 709, 6333, 526, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 277, 2670, 10210, 2816, 69, 12, 276, 23, 69, 12, 35133, 68, 12, 44230, 68, 12, 69, 16, 68, 1433, 65, 3695, 67, 24, 1860, 198, 9132, 1, 21017, 44380, 860, 13, 1828, 532, 860, 13, 1954, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 22927, 24, 4869, 69, 7252, 12, 27936, 64, 12, 19, 344, 64, 12, 64, 1157, 64, 12, 15, 21101, 2078, 69, 18, 68, 28771, 22, 198, 1616, 198, 197, 2, 1675, 787, 340, 12312, 889, 351, 39141, 11, 340, 373, 2622, 284, 2620, 1033, 3419, 4578, 13, 198, 197, 29531, 13, 28826, 0, 7, 16, 8, 198, 197, 88, 796, 25915, 16, 1539, 352, 8183, 628, 197, 31, 19849, 2163, 2746, 62, 76, 24, 62, 17, 7, 88, 8, 198, 197, 220, 220, 220, 26367, 5299, 14435, 7, 15, 11, 8576, 8, 198, 197, 220, 220, 220, 18074, 225, 5299, 5518, 35470, 7, 16, 14, 15, 13, 18005, 8, 198, 197, 220, 220, 220, 331, 5299, 14435, 7, 17394, 11, 18074, 225, 8, 198, 197, 437, 628, 197, 20541, 285, 24, 62, 17, 796, 6291, 7, 19849, 62, 76, 24, 62, 17, 7, 88, 828, 399, 3843, 50, 22784, 8576, 8, 198, 197, 76, 24, 62, 17, 62, 7568, 796, 6060, 19778, 7, 76, 24, 62, 17, 8, 198, 197, 47, 38827, 1797, 7, 76, 24, 62, 17, 62, 7568, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 257, 24, 69, 1765, 891, 18, 12, 3312, 67, 15, 12, 2231, 4309, 12, 23, 36993, 12, 17, 69, 20986, 344, 24760, 2857, 198, 9132, 1, 21017, 6127, 860, 13, 1954, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 767, 65, 1495, 3459, 67, 17, 12, 67, 4521, 67, 12, 2598, 21855, 12, 4089, 3865, 12, 67, 49259, 2078, 2425, 15630, 2857, 198, 29487, 7, 198, 220, 220, 220, 12854, 29487, 7, 76, 24, 62, 17, 828, 198, 220, 220, 220, 1554, 21857, 7, 76, 24, 62, 17, 828, 198, 220, 220, 220, 2546, 16193, 12865, 11, 5323, 8, 198, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 36624, 5607, 69, 19, 67, 24, 12, 324, 405, 12, 19, 67, 17, 66, 12, 65, 31211, 12, 1238, 4869, 65, 24, 12993, 4521, 69, 21, 198, 9132, 1, 21017, 6127, 860, 13, 1731, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 718, 3132, 11848, 3070, 65, 12, 405, 64, 20, 12, 42199, 64, 12, 1350, 15, 67, 12, 2623, 69, 4521, 64, 5607, 2481, 7252, 198, 29531, 13, 28826, 0, 7, 17, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 6957, 17896, 2791, 67, 21, 12, 39885, 64, 12, 19, 65, 15, 66, 12, 65, 4531, 67, 12, 35133, 64, 1828, 7568, 721, 6469, 198, 31, 19849, 2163, 2746, 62, 76, 24, 62, 18, 7, 88, 8, 198, 220, 220, 220, 26367, 5299, 14435, 7, 16, 11, 838, 8, 198, 220, 220, 220, 18074, 225, 5299, 5518, 35470, 7, 16, 8, 198, 220, 220, 220, 331, 5299, 14435, 7, 17394, 11, 18074, 225, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 269, 2816, 2154, 19881, 16, 12, 66, 3023, 67, 12, 3901, 68, 18, 12, 65, 23, 3609, 12, 21, 68, 21, 67, 330, 2231, 21101, 2154, 198, 27471, 198, 197, 76, 24, 62, 18, 796, 6291, 7, 19849, 62, 76, 24, 62, 18, 7, 88, 828, 399, 3843, 50, 22784, 8576, 8, 198, 197, 76, 24, 62, 18, 62, 7568, 796, 6060, 19778, 7, 76, 24, 62, 18, 8, 198, 197, 47, 38827, 1797, 7, 76, 24, 62, 18, 62, 7568, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 807, 69, 24, 2231, 69, 21, 66, 12, 1495, 5333, 12, 42117, 65, 12, 8432, 65, 12, 18, 31115, 67, 17, 66, 19, 65, 45068, 198, 408, 62, 81, 5183, 7, 76, 24, 62, 18, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 9940, 67, 1954, 13331, 18, 12, 69, 1860, 17, 12, 19, 487, 65, 12, 64, 15, 68, 24, 12, 324, 16, 39071, 68, 3023, 67, 1828, 198, 9132, 1, 21017, 6127, 860, 13, 1495, 532, 860, 13, 2075, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 277, 940, 68, 26717, 69, 12, 20986, 65, 12, 19, 65, 19, 65, 12, 65, 18, 68, 15, 12, 2791, 1878, 2414, 1270, 7012, 19, 69, 198, 1616, 198, 197, 29531, 13, 28826, 0, 7, 3901, 8, 198, 197, 88, 796, 43720, 7, 26447, 22784, 1802, 8, 628, 197, 29531, 13, 28826, 0, 7, 22842, 8, 628, 197, 31, 19849, 2163, 2746, 62, 76, 24, 62, 19, 7, 88, 8, 198, 197, 220, 220, 220, 257, 16, 5299, 14435, 7, 15, 11, 8576, 8, 198, 197, 220, 220, 220, 257, 17, 5299, 14435, 7, 15, 11, 8576, 8, 198, 197, 220, 220, 220, 18074, 225, 5299, 5518, 35470, 7, 16, 8, 198, 197, 220, 220, 220, 18919, 796, 257, 16, 1343, 257, 17, 198, 197, 220, 220, 220, 331, 5299, 14435, 7, 34703, 11, 18074, 225, 8, 198, 197, 437, 628, 197, 20541, 285, 24, 62, 19, 796, 6291, 7, 19849, 62, 76, 24, 62, 19, 7, 88, 828, 399, 3843, 50, 22784, 8576, 8, 198, 197, 76, 24, 62, 19, 62, 7568, 796, 6060, 19778, 7, 76, 24, 62, 19, 8, 198, 197, 47, 38827, 1797, 7, 76, 24, 62, 19, 62, 7568, 8, 198, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 604, 66, 2931, 18082, 18, 12, 23, 69, 19, 66, 12, 19, 13331, 17, 12, 6420, 18213, 12, 2079, 65, 5892, 12993, 11848, 44361, 198, 408, 62, 81, 5183, 7, 76, 24, 62, 19, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 352, 69, 17, 66, 20, 30695, 12, 11848, 10210, 12, 19, 21855, 22, 12, 6420, 1270, 12, 24, 66, 21, 344, 11848, 19, 66, 21, 67, 19, 198, 29487, 7, 76, 24, 62, 19, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 642, 1558, 67, 3132, 7012, 12, 3365, 3559, 12, 1821, 64, 22, 12, 324, 3312, 12, 4846, 68, 22, 64, 23, 18213, 3459, 2231, 198, 9132, 1, 21017, 6127, 860, 13, 1983, 1, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 352, 535, 15, 64, 21, 66, 16, 12, 18, 69, 12993, 12, 19, 7568, 18, 12, 64, 23, 67, 24, 12, 7012, 27712, 19, 66, 15, 64, 2718, 65, 198, 29531, 13, 28826, 0, 7, 22842, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 860, 64, 29143, 6052, 65, 12, 66, 24, 64, 24, 12, 2231, 535, 12, 22260, 20, 12, 4089, 3324, 45331, 65, 2001, 67, 198, 31, 19849, 2163, 2746, 62, 76, 24, 62, 20, 7, 88, 8, 198, 220, 220, 220, 257, 16, 5299, 14435, 7, 15, 11, 838, 8, 198, 220, 220, 220, 257, 17, 5299, 14435, 7, 15, 11, 838, 8, 198, 220, 220, 220, 18074, 225, 5299, 5518, 35470, 7, 16, 8, 198, 220, 220, 220, 18919, 796, 257, 16, 1343, 257, 17, 198, 220, 220, 220, 331, 5299, 14435, 7, 34703, 11, 18074, 225, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 718, 64, 22, 18213, 23, 1350, 12, 1350, 64, 17, 12, 3901, 66, 19, 12, 4531, 397, 12, 24, 64, 21, 11848, 12993, 7012, 18298, 198, 27471, 198, 197, 76, 24, 62, 20, 796, 6291, 7, 19849, 62, 76, 24, 62, 20, 7, 88, 828, 399, 3843, 50, 22784, 8576, 8, 198, 197, 76, 24, 62, 20, 62, 7568, 796, 6060, 19778, 7, 76, 24, 62, 20, 8, 198, 197, 47, 38827, 1797, 7, 76, 24, 62, 20, 62, 7568, 8, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 860, 3682, 68, 18, 69, 1129, 12, 64, 20, 66, 16, 12, 31794, 68, 12, 64, 18, 1350, 12, 2931, 22, 66, 4310, 15630, 22, 34626, 198, 408, 62, 81, 5183, 7, 76, 24, 62, 20, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 718, 6888, 64, 19, 65, 2425, 12, 24, 330, 16, 12, 37747, 65, 12, 64, 19, 65, 17, 12, 2548, 65, 4761, 65, 22416, 68, 3270, 198, 29487, 7, 76, 24, 62, 20, 8, 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, 7902, 53, 796, 366, 29211, 276, 3104, 69, 12, 15, 65, 330, 12, 20, 6888, 15, 12, 5774, 67, 19, 12, 22, 65, 1433, 66, 1878, 20, 67, 405, 65, 1, 198, 6601, 35439, 796, 366, 64, 6052, 66, 21, 69, 405, 12, 68, 3553, 67, 12, 20, 41580, 12, 65, 22, 65, 21, 12, 67, 23, 24943, 69, 18, 68, 3510, 66, 15, 1, 198, 20344, 2455, 507, 796, 366, 3132, 66, 1731, 68, 940, 12, 64, 27057, 12, 20, 37804, 12, 65, 23, 1765, 12, 3720, 3388, 330, 67, 15, 36243, 69, 1, 198, 6187, 54, 13506, 796, 366, 21, 2682, 67, 18, 65, 24, 67, 12, 1453, 22, 64, 12, 20, 1860, 69, 12, 9423, 24, 12, 24137, 6420, 18213, 23, 1433, 68, 16, 1, 198, 11187, 2667, 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, 9655, 9655, 1925, 1299, 796, 366, 66, 22, 69, 33808, 69, 17, 12, 487, 1507, 12, 3365, 68, 24, 12, 15630, 22, 65, 12, 26717, 2078, 68, 3459, 69, 2425, 67, 1, 198, 27871, 320, 796, 366, 11785, 48057, 7252, 12, 19, 25600, 12, 20, 64, 891, 12, 64, 18, 1878, 12, 5332, 2075, 21895, 2231, 64, 1765, 1, 198, 47, 10025, 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, 29531, 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, 17126, 19929, 49, 2788, 8040, 796, 366, 17, 67, 2931, 7568, 4051, 12, 24, 67, 15, 69, 12, 20, 25600, 12, 6469, 1238, 12, 4051, 66, 17, 64, 18, 67, 19, 69, 20963, 1, 198, 29668, 14881, 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, 29668, 37, 13271, 796, 366, 19, 66, 5066, 67, 17, 65, 24, 12, 19, 32066, 12, 4051, 9945, 12, 23, 13227, 12, 1558, 65, 2414, 66, 2670, 68, 3682, 66, 1, 198, 29668, 3646, 1747, 796, 366, 69, 18, 65, 22745, 64, 22, 12, 44698, 64, 12, 20, 68, 2154, 12, 65, 28676, 12, 4521, 31675, 67, 3720, 2816, 16344, 1, 198, 51, 870, 796, 366, 69, 344, 20, 5036, 6469, 12, 20, 3901, 64, 12, 3270, 64, 21, 12, 324, 69, 23, 12, 43916, 66, 2414, 65, 20, 69, 24, 64, 15, 1, 198, 198, 58, 5589, 265, 60, 198, 7902, 53, 796, 366, 93, 15, 13, 24, 13, 1157, 1, 198, 6601, 35439, 796, 366, 93, 16, 13, 17, 13, 17, 1, 198, 20344, 2455, 507, 796, 366, 93, 15, 13, 1495, 13, 2682, 1, 198, 6187, 54, 13506, 796, 366, 93, 17, 13, 22, 13, 20, 1, 198, 9655, 9655, 1925, 1299, 796, 366, 93, 20, 13, 15, 13, 16, 1, 198, 27871, 320, 796, 366, 93, 16, 13, 20, 13, 15, 1, 198, 17126, 19929, 49, 2788, 8040, 796, 366, 93, 19, 13, 19, 13, 18, 1, 198, 29668, 14881, 796, 366, 93, 15, 13, 2091, 13, 1485, 1, 198, 29668, 37, 13271, 796, 366, 93, 15, 13, 24, 13, 1415, 1, 198, 29668, 3646, 1747, 796, 366, 93, 15, 13, 1415, 13, 1959, 1, 198, 51, 870, 796, 366, 93, 15, 13, 1129, 13, 15, 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, 30109, 15037, 2149, 349, 1850, 6836, 20193, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 46900, 65, 1878, 6659, 14454, 39251, 1899, 67, 37710, 66, 43147, 65, 21, 33660, 6814, 16, 28485, 2780, 67, 23, 66, 1, 198, 12303, 312, 796, 366, 64, 19, 66, 25150, 16072, 12, 66, 21, 487, 12, 38783, 66, 12, 65, 1731, 69, 12, 69, 22, 18213, 40173, 19880, 68, 24, 1, 198, 9641, 796, 366, 15, 13, 15, 13, 16, 1, 198, 198, 30109, 23839, 5777, 33758, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 32642, 1453, 2919, 37601, 1495, 31911, 30763, 1795, 67, 19, 1878, 5705, 65, 9945, 3510, 64, 17, 64, 26429, 67, 15, 1, 198, 12303, 312, 796, 366, 21, 2481, 69, 2920, 3720, 12, 66, 48200, 12, 20, 67, 4051, 12, 23, 3104, 68, 12, 69, 12993, 19, 68, 18, 68, 23, 21652, 66, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 16, 1, 198, 198, 30109, 23839, 9655, 9655, 11907, 198, 10378, 82, 796, 14631, 43984, 43984, 1600, 366, 47581, 32577, 35479, 1600, 366, 20344, 6169, 1600, 366, 11187, 2667, 1600, 366, 11187, 2667, 11627, 8847, 1600, 366, 32577, 11187, 2667, 1600, 366, 29531, 1600, 366, 29668, 14881, 1600, 366, 44798, 282, 11187, 5355, 1600, 366, 8291, 41213, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 9945, 15, 64, 22, 487, 18, 69, 17457, 4089, 2154, 2816, 66, 3559, 65, 19, 68, 1065, 67, 17, 13331, 1270, 7252, 3609, 5774, 2920, 66, 1, 198, 12303, 312, 796, 366, 1795, 69, 1415, 66, 1731, 12, 69, 46435, 12, 19, 68, 21, 64, 12, 24, 65, 5824, 12, 2670, 67, 21, 65, 15, 69, 9879, 486, 1, 198, 9641, 796, 366, 18, 13, 17, 13, 16, 1, 198, 198, 30109, 23839, 47, 6489, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1314, 69, 2682, 535, 21, 28567, 3510, 330, 2998, 17, 67, 3070, 16072, 17, 535, 3064, 5999, 324, 65, 19, 7568, 37397, 1, 198, 12303, 312, 796, 366, 22, 64, 3553, 64, 3682, 68, 12, 4304, 721, 12, 19, 18213, 18, 12, 64, 26050, 12, 2998, 68, 40675, 67, 21, 67, 24, 12993, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 15, 1, 198, 198, 30109, 23839, 51, 6037, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3070, 68, 2713, 1120, 32883, 67, 4521, 1828, 1495, 2481, 67, 24970, 65, 22, 3901, 67, 27790, 7012, 1558, 18213, 15, 65, 20, 1, 198, 12303, 312, 796, 366, 1314, 1238, 344, 1415, 12, 1899, 66, 16, 12, 20, 69, 1795, 12, 11848, 66, 22, 12, 2816, 891, 6659, 65, 3365, 2327, 66, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 19, 1, 198, 198, 30109, 48003, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 2920, 1507, 47838, 67, 1314, 65, 18, 16562, 18654, 1558, 330, 21, 64, 22, 24294, 69, 34427, 2154, 66, 1433, 69, 22, 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, 16, 1, 198, 198, 30109, 28809, 39, 9655, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 28100, 9787, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 818, 5372, 41472, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 32577, 44, 2357, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 7248, 3245, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 3118, 11869, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 15, 64, 35916, 68, 24, 64, 3270, 1453, 16, 66, 23, 65, 1878, 66, 18, 1878, 1507, 68, 4846, 67, 3829, 69, 40022, 65, 2919, 8054, 1, 198, 12303, 312, 796, 366, 15, 19881, 3270, 2998, 21, 12, 66, 18, 65, 16, 12, 20, 6888, 19, 12, 4521, 17457, 12, 68, 2999, 10210, 4761, 66, 2934, 18, 67, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 17, 1, 198, 198, 30109, 28809, 36208, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 20344, 2455, 507, 1600, 366, 29531, 1600, 366, 39618, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 324, 23, 19881, 1860, 69, 23, 11848, 49856, 67, 40523, 721, 65, 40248, 2079, 66, 27371, 66, 19881, 1314, 68, 24, 4869, 1, 198, 12303, 312, 796, 366, 20, 65, 22, 68, 2079, 2857, 12, 1860, 66, 15, 12, 19, 65, 18, 69, 12, 24, 65, 2816, 12, 15, 67, 1795, 3682, 69, 4524, 17279, 1, 198, 9641, 796, 366, 15, 13, 21, 13, 21, 1, 198, 198, 30109, 28809, 3705, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 20344, 2455, 507, 1600, 366, 25835, 35943, 1600, 366, 29531, 1600, 366, 29668, 37, 13271, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3312, 6814, 21, 66, 30290, 12993, 1558, 12993, 15, 69, 5607, 276, 17, 66, 2998, 66, 1959, 65, 21, 20370, 1453, 5999, 17896, 24, 1, 198, 12303, 312, 796, 366, 3553, 2414, 2079, 21101, 12, 1954, 3388, 12, 1821, 65, 17, 12, 64, 39118, 12, 66, 2414, 2154, 2816, 4304, 276, 66, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 19, 1, 198, 198, 30109, 28809, 12861, 11907, 198, 10378, 82, 796, 14631, 23286, 752, 669, 1600, 366, 20344, 2455, 507, 1600, 366, 20344, 2455, 507, 2885, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 39746, 28813, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 32577, 44, 2357, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 35694, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 12952, 67, 21, 65, 1558, 64, 18, 64, 24, 67, 27211, 67, 24, 64, 21, 65, 31020, 1065, 66, 3609, 3070, 487, 67, 21, 64, 2414, 487, 1, 198, 12303, 312, 796, 366, 65, 20, 6888, 19, 17477, 12, 2414, 1959, 12, 2231, 68, 20, 12, 64, 17, 67, 24, 12, 5774, 64, 721, 1270, 64, 35978, 66, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 18, 1, 198, 198, 30109, 28100, 9787, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 9395, 11848, 65, 17, 1860, 65, 23, 4304, 69, 44093, 38905, 66, 19, 721, 2598, 2091, 22980, 68, 18938, 4761, 1314, 64, 1, 198, 12303, 312, 796, 366, 67, 344, 3023, 1350, 23, 12, 66, 5892, 67, 12, 2816, 1959, 12, 1350, 405, 12, 1795, 68, 19, 67, 17, 66, 15, 68, 24991, 1, 198, 9641, 796, 366, 17, 13, 16, 13, 15, 1, 198, 198, 30109, 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, 3163, 8002, 11907, 198, 10378, 82, 796, 14631, 3163, 8002, 62, 73, 297, 1600, 366, 25835, 25404, 1600, 366, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 17, 487, 5892, 65, 4869, 7012, 1558, 2857, 66, 20, 69, 1860, 20, 3901, 69, 23, 16072, 42802, 2623, 67, 6469, 69, 1821, 721, 24, 1, 198, 12303, 312, 796, 366, 22, 67, 24, 69, 6888, 17, 64, 12, 4531, 1899, 12, 4051, 67, 18, 12, 24, 69, 3695, 12, 22, 67, 16, 67, 535, 69, 17, 21101, 5607, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 15, 1, 198, 198, 30109, 3163, 8002, 62, 73, 297, 11907, 198, 10378, 82, 796, 14631, 25835, 25404, 1600, 366, 11505, 9148, 1921, 62, 73, 297, 1600, 366, 47, 10025, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 68, 22291, 64, 24, 65, 24, 17457, 16, 65, 19, 68, 16, 65, 19, 69, 1314, 65, 1828, 66, 15, 2079, 2780, 5237, 65, 2791, 1878, 22, 487, 22, 1, 198, 12303, 312, 796, 366, 3104, 6469, 1314, 5774, 12, 65, 38612, 12, 3553, 5607, 12, 23, 35195, 12, 66, 29703, 18213, 27277, 41580, 1, 198, 9641, 796, 366, 18, 13, 20, 13, 15, 10, 18, 1, 198, 198, 30109, 19182, 39317, 11907, 198, 10378, 82, 796, 14631, 40073, 1600, 366, 1532, 40674, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 39618, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 45442, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 22980, 65, 3312, 68, 17, 65, 16, 69, 21, 64, 20666, 68, 15, 68, 23, 69, 24839, 67, 2078, 68, 19, 67, 32182, 68, 397, 2624, 1238, 1, 198, 12303, 312, 796, 366, 19, 69, 7012, 22995, 66, 12, 15, 67, 6420, 12, 20, 18213, 15, 12, 24, 65, 18, 68, 12, 21, 39305, 3023, 1453, 3553, 64, 24, 1, 198, 9641, 796, 366, 18, 13, 17, 13, 16, 1, 198, 198, 30109, 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, 31554, 271, 2348, 7727, 907, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 29531, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 22911, 10711, 19044, 45977, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2791, 46761, 66, 23, 67, 2481, 66, 23, 487, 20, 68, 18, 64, 24, 2091, 3720, 22148, 64, 19214, 22, 330, 2623, 4521, 18, 69, 22, 1, 198, 12303, 312, 796, 366, 12952, 4761, 65, 15, 69, 12, 17, 66, 2816, 12, 4051, 2718, 12, 24, 3609, 22, 12, 67, 42117, 65, 22, 64, 29626, 1120, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 16, 1, 198, 198, 30109, 31554, 271, 3163, 20477, 11907, 198, 10378, 82, 796, 14631, 35, 689, 1600, 366, 9492, 2100, 50, 1039, 1600, 366, 29993, 33637, 1600, 366, 17257, 3163, 20477, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 16799, 67, 20, 68, 19, 67, 4521, 66, 4304, 1795, 65, 1238, 66, 2327, 67, 1821, 65, 31938, 66, 4524, 65, 24, 64, 2670, 65, 20, 68, 1, 198, 12303, 312, 796, 366, 2670, 2934, 18, 67, 3104, 12, 4524, 65, 24, 12, 46239, 66, 12, 23, 67, 17, 67, 12, 68, 17657, 66, 43509, 69, 18, 64, 24, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 19, 1, 198, 198, 30109, 31554, 271, 40729, 11907, 198, 10378, 82, 796, 14631, 23839, 5777, 33758, 1600, 366, 34, 709, 2743, 590, 22362, 18991, 1600, 366, 9492, 2100, 50, 1039, 1600, 366, 818, 13658, 5497, 1063, 1600, 366, 43, 12582, 25896, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 45, 2434, 35, 12078, 1600, 366, 34519, 3163, 20477, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 51, 2977, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 22, 19881, 28567, 1350, 3980, 1314, 23188, 16344, 330, 1065, 4309, 64, 1433, 68, 23753, 31047, 21, 1453, 23055, 69, 1, 198, 12303, 312, 796, 366, 5824, 65, 16, 7012, 19, 69, 12, 19, 1453, 24, 12, 4310, 1795, 12, 5892, 69, 16, 12, 5824, 66, 2934, 29796, 66, 18, 66, 20, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 1828, 1, 198, 198, 30109, 43984, 43984, 11907, 198, 10378, 82, 796, 14631, 40073, 1600, 366, 36687, 14881, 1600, 366, 29783, 1600, 366, 24243, 40161, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 39618, 1600, 366, 7248, 3245, 1600, 366, 51, 2977, 1600, 366, 57, 35641, 1258, 37766, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 15, 324, 24909, 7252, 4761, 67, 23, 46250, 69, 1238, 67, 3070, 1433, 68, 39101, 2078, 69, 15, 7012, 1433, 1731, 22996, 1, 198, 12303, 312, 796, 366, 22337, 68, 3312, 5036, 12, 5607, 65, 22, 12, 1157, 68, 24, 12, 2624, 64, 20, 12, 68, 16, 67, 22042, 68, 21, 324, 2791, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 2624, 1, 198, 198, 30109, 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, 14881, 1616, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 64, 1765, 69, 2816, 68, 21, 67, 3324, 3865, 68, 2999, 6888, 4059, 64, 40523, 67, 39195, 330, 24, 3720, 64, 1878, 4531, 68, 1, 198, 12303, 312, 796, 366, 5607, 1507, 68, 22730, 12, 64, 18, 13331, 12, 26200, 64, 12, 1795, 4521, 12, 23, 9945, 4846, 16, 10210, 6469, 1558, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 16, 1, 198, 198, 30109, 23286, 752, 669, 11907, 198, 10378, 82, 796, 14631, 28100, 9787, 1600, 366, 35491, 37766, 14055, 1600, 366, 40073, 1600, 366, 20344, 2455, 507, 1600, 366, 24629, 5217, 1600, 366, 23820, 20310, 34184, 1187, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 11187, 16870, 24629, 2733, 1600, 366, 44, 6320, 3163, 20477, 1600, 366, 29531, 1600, 366, 3041, 39344, 1600, 366, 39618, 1600, 366, 49, 13880, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 30803, 1878, 2624, 16072, 65, 24, 1350, 2996, 67, 37747, 17896, 3559, 324, 15, 11848, 50055, 34801, 67, 19, 68, 23, 3270, 1, 198, 12303, 312, 796, 366, 4304, 28857, 64, 3459, 12, 22, 2598, 69, 12, 1120, 5705, 12, 44928, 16, 12, 24, 2780, 1314, 64, 1878, 2919, 66, 19, 1, 198, 9641, 796, 366, 15, 13, 24, 13, 1157, 1, 198, 198, 30109, 13128, 5080, 41367, 3103, 574, 1240, 24629, 2733, 11907, 198, 10378, 82, 796, 14631, 45442, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 15630, 1485, 1558, 69, 4869, 2934, 23, 67, 344, 2075, 18213, 3134, 16072, 7568, 22, 68, 535, 66, 15, 67, 3312, 6052, 65, 2425, 65, 1, 198, 12303, 312, 796, 366, 21, 25870, 2670, 6659, 12, 19, 66, 17457, 12, 3682, 16072, 12, 65, 6888, 23, 12, 24136, 1495, 2934, 23, 17896, 19, 65, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 16, 1, 198, 198, 30109, 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, 8697, 2937, 388, 6874, 11907, 198, 10378, 82, 796, 14631, 39, 86, 17946, 1600, 366, 1532, 40674, 1600, 366, 45442, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 5774, 65, 15, 66, 24, 66, 21, 1453, 486, 1731, 67, 21, 66, 16, 69, 19, 344, 23, 21101, 44215, 17896, 1878, 24, 69, 3829, 65, 43564, 1, 198, 12303, 312, 796, 366, 17, 64, 15, 69, 19881, 18, 67, 12, 11848, 24, 66, 12, 2780, 69, 18, 12, 65, 15, 64, 24, 12, 23, 1415, 67, 2079, 16344, 22, 397, 24, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 21, 1, 198, 198, 30109, 7902, 53, 11907, 198, 10378, 82, 796, 14631, 43806, 721, 57, 8019, 1600, 366, 35, 689, 1600, 366, 8979, 15235, 82, 14881, 1600, 366, 818, 1370, 13290, 654, 1600, 366, 44, 8899, 1600, 366, 47, 945, 364, 1600, 366, 27201, 276, 3163, 20477, 1600, 366, 31837, 20538, 3163, 20477, 1600, 366, 51, 2977, 1600, 366, 3118, 291, 1098, 1600, 366, 44898, 8134, 13290, 654, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2920, 69, 1415, 65, 21, 66, 3980, 64, 17, 6814, 2857, 28688, 5036, 1270, 8432, 22, 1157, 65, 39118, 1828, 2414, 67, 22, 64, 1, 198, 12303, 312, 796, 366, 29211, 276, 3104, 69, 12, 15, 65, 330, 12, 20, 6888, 15, 12, 5774, 67, 19, 12, 22, 65, 1433, 66, 1878, 20, 67, 405, 65, 1, 198, 9641, 796, 366, 15, 13, 24, 13, 1157, 1, 198, 198, 30109, 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, 69, 17572, 17, 65, 2816, 67, 23, 23237, 1983, 10210, 27203, 64, 24, 64, 19, 69, 18, 487, 65, 24909, 20963, 1795, 69, 2079, 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, 15, 1, 198, 198, 30109, 35491, 37766, 11907, 198, 10378, 82, 796, 14631, 35491, 37766, 14055, 1600, 366, 40073, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 29531, 1600, 366, 15633, 35, 313, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2996, 64, 2919, 2075, 330, 25600, 3388, 2816, 1899, 9879, 4304, 2231, 2079, 1495, 67, 1558, 11245, 1433, 64, 397, 1, 198, 12303, 312, 796, 366, 2919, 1731, 2857, 67, 19, 12, 40486, 66, 12, 20, 67, 1983, 12, 6052, 69, 19, 12, 1415, 16072, 1129, 68, 24, 31047, 17, 1, 198, 9641, 796, 366, 16, 13, 1415, 13, 15, 1, 198, 198, 30109, 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, 44230, 68, 22, 68, 22, 66, 17464, 69, 23, 66, 24, 2075, 1120, 67, 5333, 65, 24, 32883, 65, 24, 330, 17, 1453, 31980, 1860, 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, 1157, 13, 16, 1, 198, 198, 30109, 29238, 5189, 23907, 2977, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 24, 64, 16, 67, 46438, 2670, 4304, 2154, 2920, 1828, 25272, 2327, 65, 2327, 64, 18, 67, 48341, 65, 48000, 1270, 67, 5237, 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, 16, 1, 198, 198, 30109, 2601, 436, 1586, 11907, 198, 10378, 82, 796, 14631, 20344, 1817, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 8199, 12423, 46445, 32289, 1600, 366, 18557, 69, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 48346, 1600, 366, 29668, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2425, 31714, 65, 22, 7568, 19, 21940, 25674, 67, 2425, 27696, 67, 1415, 65, 3365, 25707, 37381, 1350, 65, 17, 330, 1, 198, 12303, 312, 796, 366, 24794, 1959, 64, 23, 12, 2327, 1878, 12, 33042, 66, 12, 23, 15630, 18, 12, 65, 39380, 64, 1558, 64, 15, 5036, 20, 1, 198, 9641, 796, 366, 15, 13, 1415, 13, 17, 1, 198, 198, 30109, 43806, 721, 57, 8019, 11907, 198, 10378, 82, 796, 14631, 8291, 66, 7656, 12124, 82, 1600, 366, 57, 8019, 62, 73, 297, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 9395, 3865, 23734, 19, 67, 30484, 28485, 24, 64, 18, 69, 4089, 4089, 16, 67, 2079, 65, 2091, 68, 18, 9945, 22, 65, 21, 6814, 1, 198, 12303, 312, 796, 366, 24, 2598, 65, 16, 67, 2791, 12, 41172, 66, 12, 20, 1878, 67, 12, 6420, 69, 16, 12, 24, 2934, 1238, 69, 44994, 24943, 1, 198, 9641, 796, 366, 15, 13, 22, 13, 15, 1, 198, 198, 30109, 10258, 27054, 6880, 11907, 198, 10378, 82, 796, 14631, 10258, 31431, 1600, 366, 5216, 669, 1600, 366, 13715, 12727, 49601, 1600, 366, 29531, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 64, 23, 4349, 69, 721, 3980, 21101, 4790, 12993, 7568, 19, 32128, 1959, 2079, 721, 4761, 14822, 20, 65, 23, 3104, 6469, 64, 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, 1314, 13, 15, 1, 198, 198, 30109, 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, 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, 20575, 20900, 873, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2919, 66, 23, 65, 3104, 3132, 17896, 405, 65, 5036, 64, 23, 25600, 2075, 1350, 15, 15630, 23, 29211, 16072, 2623, 4089, 1899, 1, 198, 12303, 312, 796, 366, 4521, 16, 64, 23, 23055, 12, 2718, 486, 12, 20, 65, 15, 66, 12, 24, 64, 1433, 12, 1314, 67, 4089, 69, 10210, 66, 21, 7252, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 17, 1, 198, 198, 30109, 17227, 50, 6442, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3104, 64, 2998, 3559, 69, 38907, 27371, 4763, 23, 15630, 35549, 64, 20, 66, 17457, 20, 64, 17, 891, 21, 276, 21, 67, 16, 69, 1, 198, 12303, 312, 796, 366, 27203, 1821, 69, 940, 12, 65, 17, 69, 22, 12, 1157, 68, 24, 12, 2327, 67, 23, 12, 67, 48638, 68, 19, 1765, 15, 487, 17, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 15, 1, 198, 198, 30109, 17227, 7004, 42712, 507, 11907, 198, 10378, 82, 796, 14631, 14155, 305, 33637, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 22, 65, 23, 64, 6052, 67, 7012, 23, 1878, 22, 68, 18, 65, 3682, 69, 721, 397, 69, 27720, 2075, 486, 2713, 330, 34770, 69, 22, 1, 198, 12303, 312, 796, 366, 11848, 69, 22, 67, 37466, 12, 64, 37804, 12, 20, 276, 22, 12, 64, 4309, 66, 12, 6659, 68, 1270, 3865, 37967, 1120, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 15, 1, 198, 198, 30109, 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, 67, 344, 18, 68, 18, 5036, 64, 21, 28362, 3388, 68, 7252, 15, 65, 47582, 65, 17, 68, 23, 32118, 68, 24, 487, 2598, 1954, 1485, 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, 1821, 13, 15, 1, 198, 198, 30109, 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, 5377, 1930, 1756, 14881, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2231, 4051, 1129, 69, 22, 68, 34256, 64, 16, 64, 1731, 6052, 66, 39305, 2414, 2078, 67, 3720, 68, 3865, 1485, 38073, 3388, 1, 198, 12303, 312, 796, 366, 64, 2091, 1878, 6420, 66, 12, 69, 2999, 67, 12, 34137, 65, 12, 1350, 2998, 12, 3132, 67, 25870, 66, 20, 6888, 17, 65, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 16, 1, 198, 198, 30109, 47581, 32577, 35479, 11907, 198, 10378, 82, 796, 14631, 11187, 2667, 1600, 366, 32577, 44, 2357, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 18, 397, 22, 65, 26427, 3134, 23815, 3829, 65, 24, 1878, 3829, 2548, 3270, 1878, 12993, 33032, 13331, 1270, 3270, 68, 23, 1, 198, 12303, 312, 796, 366, 3459, 10210, 1507, 68, 23, 12, 67, 24, 535, 12, 19, 18213, 21, 12, 3459, 4531, 12, 20, 25191, 66, 15, 67, 1314, 66, 23, 65, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 17, 1, 198, 198, 30109, 36687, 14881, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 69, 4524, 68, 24, 67, 20, 30460, 65, 4521, 1238, 65, 19, 344, 68, 2327, 67, 19, 66, 20, 64, 47448, 1860, 19, 17896, 20, 2857, 69, 19, 1, 198, 12303, 312, 796, 366, 23451, 65, 2713, 3365, 12, 1983, 3459, 12, 2920, 67, 18, 12, 11231, 15, 12, 4524, 64, 1558, 276, 19, 68, 22, 66, 24, 1, 198, 9641, 796, 366, 16, 13, 18, 13, 15, 1, 198, 198, 30109, 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, 34, 709, 2743, 590, 22362, 18991, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 48346, 1600, 366, 29668, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 15630, 2670, 18938, 3365, 67, 17, 1350, 48891, 68, 3829, 65, 22, 66, 1821, 67, 1485, 4869, 66, 19, 69, 4051, 13331, 3023, 9945, 1, 198, 12303, 312, 796, 366, 44617, 16344, 1983, 64, 12, 69, 19707, 12, 1157, 68, 23, 12, 17, 67, 3609, 12, 33581, 26717, 68, 21, 21526, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 21, 1, 198, 198, 30109, 34, 2433, 684, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 18, 69, 49517, 1558, 65, 49561, 67, 22, 7252, 1453, 15, 65, 3388, 397, 2857, 67, 24, 65, 3324, 1731, 6888, 23, 28485, 15, 67, 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, 15, 13, 19, 1, 198, 198, 30109, 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, 6601, 35439, 11907, 198, 10378, 82, 796, 14631, 40073, 1600, 366, 6601, 17614, 1600, 366, 29783, 1600, 366, 818, 13658, 5497, 1063, 1600, 366, 37787, 39317, 11627, 5736, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 9704, 2902, 1600, 366, 17140, 654, 1600, 366, 27201, 276, 3163, 20477, 1600, 366, 35700, 51, 2977, 1600, 366, 18557, 69, 1600, 366, 2200, 6489, 1600, 366, 3041, 39344, 1600, 366, 50, 24707, 2348, 7727, 907, 1600, 366, 48346, 1600, 366, 10962, 15721, 896, 1600, 366, 51, 2977, 1600, 366, 3118, 291, 1098, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 41172, 69, 40090, 2231, 65, 5066, 16072, 4521, 6888, 64, 2919, 11848, 24, 64, 24, 2327, 3064, 23, 1350, 24, 65, 29143, 1, 198, 12303, 312, 796, 366, 64, 6052, 66, 21, 69, 405, 12, 68, 3553, 67, 12, 20, 41580, 12, 65, 22, 65, 21, 12, 67, 23, 24943, 69, 18, 68, 3510, 66, 15, 1, 198, 9641, 796, 366, 16, 13, 17, 13, 17, 1, 198, 198, 30109, 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, 22, 67, 24, 67, 33400, 69, 3023, 22291, 69, 22, 891, 9945, 65, 21, 31952, 67, 45326, 27260, 68, 26912, 14822, 2999, 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, 940, 1, 198, 198, 30109, 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, 6601, 40161, 11907, 198, 10378, 82, 796, 14631, 6601, 11395, 9492, 32186, 1600, 366, 35, 689, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 3459, 64, 1129, 22579, 1765, 64, 21033, 64, 21, 67, 3312, 17, 68, 17059, 64, 3559, 69, 11245, 1954, 3609, 2154, 19881, 1, 198, 12303, 312, 796, 366, 68, 22, 17896, 21, 67, 15, 67, 12, 16, 31047, 12, 20, 13331, 21, 12, 23, 324, 21, 12, 20, 64, 721, 2934, 23, 65, 22, 18213, 20, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 1485, 1, 198, 198, 30109, 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, 7469, 500, 29974, 1616, 684, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3324, 65, 19, 6888, 2078, 25257, 2598, 1954, 65, 48524, 39380, 5036, 36676, 68, 20, 487, 3459, 1129, 30995, 66, 20, 1, 198, 12303, 312, 796, 366, 25707, 68, 17, 64, 24, 69, 12, 68, 35175, 12, 2920, 4521, 12, 64, 22172, 12, 19, 67, 16, 5036, 43489, 10210, 4309, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 16, 1, 198, 198, 30109, 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, 35, 6377, 39317, 11907, 198, 10378, 82, 796, 14631, 818, 4399, 24629, 2733, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1795, 66, 18, 68, 4521, 2670, 68, 2091, 4310, 68, 20, 67, 1959, 1065, 21855, 18, 64, 1129, 1433, 65, 23, 30505, 68, 1731, 5824, 65, 1, 198, 12303, 312, 796, 366, 65, 11785, 67, 24, 1558, 12, 33032, 69, 12, 19, 9945, 66, 12, 23, 69, 19, 66, 12, 15, 535, 3865, 11785, 17, 65, 16, 67, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 15, 1, 198, 198, 30109, 28813, 25468, 11907, 198, 10378, 82, 796, 14631, 45442, 3163, 20477, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 66, 1507, 68, 4089, 66, 7012, 28011, 66, 21, 66, 1495, 67, 16, 66, 18, 65, 47202, 68, 19, 65, 2091, 1795, 6888, 50148, 28256, 1, 198, 12303, 312, 796, 366, 24136, 7012, 4310, 65, 12, 66, 21, 67, 23, 12, 20, 39449, 12, 65, 15, 2414, 12, 16, 64, 24, 67, 3559, 330, 1821, 66, 20, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 18, 1, 198, 198, 30109, 28813, 37766, 11907, 198, 10378, 82, 796, 14631, 11187, 16870, 24629, 2733, 1600, 366, 26705, 32755, 776, 1600, 366, 29531, 1600, 366, 13409, 24629, 2733, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 23, 69, 38472, 66, 20, 10210, 19, 67, 5824, 68, 23, 3104, 1433, 35642, 69, 22, 67, 1507, 68, 344, 43234, 65, 19, 64, 1878, 16, 1, 198, 12303, 312, 796, 366, 65, 40427, 66, 3695, 69, 12, 23, 7568, 18, 12, 4309, 66, 21, 12, 40248, 64, 12, 23, 68, 2931, 22, 31911, 65, 1415, 65, 1, 198, 9641, 796, 366, 16, 13, 20, 13, 15, 1, 198, 198, 30109, 20344, 1817, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 48346, 1600, 366, 29668, 17614, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 2718, 66, 5999, 68, 41948, 2231, 6469, 68, 2998, 39380, 11848, 65, 7012, 22, 29626, 2414, 487, 22, 66, 2075, 65, 24, 67, 1, 198, 12303, 312, 796, 366, 65, 19, 69, 2682, 68, 6469, 12, 68, 3695, 67, 12, 4051, 64, 20, 12, 38956, 64, 12, 69, 4089, 68, 4531, 67, 21, 68, 23, 69, 22, 1, 198, 9641, 796, 366, 15, 13, 940, 13, 21, 1, 198, 198, 30109, 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, 20344, 2455, 507, 11907, 198, 10378, 82, 796, 14631, 35491, 37766, 14055, 1600, 366, 35, 6377, 39317, 1600, 366, 33762, 3163, 20477, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 5760, 44, 1381, 1600, 366, 18557, 69, 1600, 366, 4507, 324, 38, 42, 1600, 366, 29531, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 13409, 24629, 2733, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 22, 69, 18, 9423, 1157, 69, 19, 65, 10210, 486, 15630, 16, 69, 35378, 1765, 344, 20, 1329, 69, 16, 65, 15, 64, 3695, 69, 2857, 1, 198, 12303, 312, 796, 366, 3132, 66, 1731, 68, 940, 12, 64, 27057, 12, 20, 37804, 12, 65, 23, 1765, 12, 3720, 3388, 330, 67, 15, 36243, 69, 1, 198, 9641, 796, 366, 15, 13, 1495, 13, 2682, 1, 198, 198, 30109, 20344, 2455, 507, 2885, 11907, 198, 10378, 82, 796, 14631, 48003, 1600, 366, 35491, 37766, 1600, 366, 35491, 37766, 14055, 1600, 366, 40073, 1600, 366, 28813, 37766, 1600, 366, 20344, 2455, 507, 1600, 366, 33762, 3163, 20477, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 26705, 32755, 776, 1600, 366, 5760, 44, 1381, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 13409, 24629, 2733, 1600, 366, 45442, 3163, 20477, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 57, 35641, 1258, 37766, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2816, 66, 6469, 66, 5705, 38314, 66, 487, 5892, 23362, 66, 24, 324, 2998, 68, 22, 17457, 15, 64, 15, 7568, 5066, 68, 12865, 1, 198, 12303, 312, 796, 366, 771, 19, 68, 4524, 67, 12, 64, 35175, 12, 20, 64, 23, 64, 12, 65, 15, 330, 12, 5705, 1878, 24403, 2078, 2670, 66, 1, 198, 9641, 796, 366, 15, 13, 21, 13, 2682, 1, 198, 198, 30109, 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, 24941, 263, 11907, 198, 10378, 82, 796, 14631, 15037, 2149, 349, 1850, 6836, 20193, 1600, 366, 14881, 2414, 1600, 366, 35, 689, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 40, 4503, 2373, 495, 1600, 366, 9492, 5275, 18274, 4487, 1600, 366, 40386, 1600, 366, 25835, 38, 270, 17, 1600, 366, 11187, 2667, 1600, 366, 9704, 2902, 1600, 366, 2200, 6489, 1600, 366, 14402, 1600, 366, 3118, 291, 1098, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 69, 32114, 31675, 69, 22, 68, 15, 330, 1878, 24, 18444, 2934, 21, 67, 4790, 1558, 4761, 2934, 1314, 2791, 4304, 25429, 1, 198, 12303, 312, 796, 366, 68, 18938, 4761, 69, 20, 12, 64, 21, 64, 20, 12, 20, 64, 3510, 12, 4521, 18, 65, 12, 46841, 67, 2231, 10210, 17, 2934, 19, 1, 198, 9641, 796, 366, 15, 13, 1983, 13, 940, 1, 198, 198, 30109, 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, 6187, 54, 13506, 11907, 198, 10378, 82, 796, 14631, 35, 689, 1600, 366, 8979, 9399, 1600, 366, 41, 11163, 17, 1600, 366, 25835, 38, 270, 17, 1600, 366, 14155, 305, 33637, 1600, 366, 47, 10025, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 3351, 36722, 1600, 366, 3118, 11869, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 7568, 66, 21, 66, 3312, 13331, 34135, 68, 21, 64, 29143, 23, 22995, 65, 330, 67, 3829, 16072, 21, 64, 18, 64, 21, 66, 16, 66, 344, 1, 198, 12303, 312, 796, 366, 21, 2682, 67, 18, 65, 24, 67, 12, 1453, 22, 64, 12, 20, 1860, 69, 12, 9423, 24, 12, 24137, 6420, 18213, 23, 1433, 68, 16, 1, 198, 9641, 796, 366, 17, 13, 22, 13, 20, 1, 198, 198, 30109, 44090, 47, 6489, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 23839, 47, 6489, 1600, 366, 43984, 43984, 1600, 366, 23286, 752, 669, 1600, 366, 35491, 37766, 14055, 1600, 366, 20344, 2455, 507, 1600, 366, 14155, 305, 33637, 1600, 366, 29531, 1600, 366, 57, 35641, 1258, 37766, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 4310, 1954, 5607, 69, 2414, 324, 2920, 37856, 21855, 1899, 68, 34256, 30803, 21142, 20, 9395, 14822, 2999, 69, 1, 198, 12303, 312, 796, 366, 32459, 65, 16344, 405, 12, 2075, 2079, 12, 1157, 18213, 12, 2713, 23, 69, 12, 69, 18294, 65, 19, 66, 3609, 21, 67, 23, 1, 198, 9641, 796, 366, 15, 13, 1314, 13, 16, 1, 198, 198, 30109, 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, 30639, 2419, 271, 3673, 341, 11907, 198, 10378, 82, 796, 14631, 19182, 39317, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 18, 5036, 4089, 22730, 20, 65, 19, 65, 28933, 68, 16, 3609, 22572, 66, 24, 6888, 2414, 67, 27057, 69, 2931, 67, 20, 66, 2713, 1, 198, 12303, 312, 796, 366, 6814, 20, 66, 1959, 67, 15, 12, 13331, 22, 67, 12, 44169, 68, 12, 3459, 1765, 12, 18213, 1959, 65, 15, 64, 23, 1129, 2920, 1, 198, 9641, 796, 366, 16, 13, 16, 13, 18, 1, 198, 198, 30109, 30639, 10257, 605, 11122, 501, 16305, 11347, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 19182, 39317, 1600, 366, 20344, 2455, 507, 1600, 366, 29531, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 24970, 1507, 1238, 1795, 36260, 66, 344, 22, 3609, 19, 15630, 4521, 18, 67, 1954, 19881, 1983, 66, 5066, 2075, 3459, 69, 22, 1, 198, 12303, 312, 796, 366, 66, 324, 1954, 2548, 64, 12, 16, 9945, 17, 12, 1157, 68, 24, 12, 2682, 486, 12, 3559, 15630, 2998, 66, 24, 18654, 17, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 19, 1, 198, 198, 30109, 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, 65, 18, 65, 16344, 2999, 68, 4089, 8432, 13331, 20, 12993, 44230, 36879, 43134, 66, 2816, 4089, 66, 14877, 10210, 17, 69, 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, 17, 13, 940, 10, 15, 1, 198, 198, 30109, 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, 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, 5777, 34551, 11907, 198, 10378, 82, 796, 14631, 23839, 5777, 33758, 1600, 366, 5777, 34551, 62, 73, 297, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 33907, 43, 62, 73, 297, 1600, 366, 36698, 4972, 1600, 366, 3041, 39344, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 38380, 21101, 27326, 13331, 1828, 66, 19, 1765, 330, 16344, 16, 69, 15498, 20, 69, 2934, 1415, 276, 65, 1795, 67, 4846, 66, 1, 198, 12303, 312, 796, 366, 22, 64, 16, 535, 21, 6888, 12, 4309, 891, 12, 3270, 69, 20, 12, 5999, 10210, 12, 18, 64, 2154, 2816, 66, 2931, 33660, 1, 198, 9641, 796, 366, 16, 13, 19, 13, 20, 1, 198, 198, 30109, 5777, 34551, 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, 1899, 2091, 535, 2548, 5892, 67, 15, 891, 20, 11848, 24, 10210, 1959, 65, 22, 69, 17, 69, 15, 31697, 18213, 20, 22883, 18213, 1, 198, 12303, 312, 796, 366, 69, 38905, 1415, 2623, 12, 15, 67, 22, 64, 12, 20, 69, 1485, 12, 65, 24, 2934, 12, 69, 44698, 2919, 16344, 27192, 64, 1, 198, 9641, 796, 366, 18, 13, 18, 13, 940, 10, 15, 1, 198, 198, 30109, 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, 17, 9945, 34287, 65, 3134, 12762, 3132, 721, 65, 20370, 68, 3609, 4304, 9945, 16344, 16, 66, 21599, 6888, 1485, 11848, 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, 1157, 13, 17, 1, 198, 198, 30109, 8979, 15235, 82, 14881, 11907, 198, 10378, 82, 796, 14631, 40073, 1600, 366, 35, 689, 1600, 366, 44, 8899, 1600, 366, 18557, 69, 1600, 366, 14402, 1600, 366, 52, 27586, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3023, 67, 1485, 65, 13331, 23, 891, 17657, 1238, 66, 1731, 68, 19, 67, 40675, 66, 405, 2091, 67, 1415, 2816, 2718, 7568, 22, 1, 198, 12303, 312, 796, 366, 22148, 21, 1828, 2078, 12, 17, 68, 3901, 12, 20, 4299, 12, 65, 24, 64, 19, 12, 4531, 64, 8635, 41734, 2154, 69, 1, 198, 9641, 796, 366, 15, 13, 24, 13, 1558, 1, 198, 198, 30109, 33762, 3163, 20477, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 29531, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 31360, 21, 69, 2079, 2327, 65, 22, 535, 66, 3829, 2414, 66, 21, 68, 891, 15, 65, 487, 15, 324, 41813, 7568, 49995, 64, 18, 1, 198, 12303, 312, 796, 366, 16, 64, 26561, 69, 1899, 12, 3388, 6888, 12, 20, 21734, 12, 15630, 2934, 12, 65, 5333, 68, 28857, 65, 44966, 65, 1, 198, 9641, 796, 366, 15, 13, 1065, 13, 22, 1, 198, 198, 30109, 37, 9504, 28813, 11907, 198, 10378, 82, 796, 14631, 19182, 39317, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 39618, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 45442, 3163, 20477, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 65, 18, 66, 2931, 65, 3980, 330, 1878, 18, 66, 15, 68, 48630, 66, 27310, 2548, 65, 5332, 66, 4521, 1120, 1453, 24, 67, 6888, 1, 198, 12303, 312, 796, 366, 21, 64, 4521, 17896, 1731, 12, 21, 28978, 12, 42875, 66, 12, 65, 24, 3070, 12, 3865, 21273, 5036, 17, 17457, 3901, 1, 198, 9641, 796, 366, 17, 13, 23, 13, 16, 1, 198, 198, 30109, 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, 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, 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, 39746, 28813, 11907, 198, 10378, 82, 796, 14631, 17227, 7004, 42712, 507, 1600, 366, 28813, 25468, 1600, 366, 28813, 37766, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 11187, 16870, 24629, 2733, 1600, 366, 26705, 32755, 776, 1600, 366, 36698, 4972, 1600, 366, 18557, 69, 1600, 366, 29531, 1600, 366, 13409, 24629, 2733, 1600, 366, 45442, 3163, 20477, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 21, 29703, 65, 4349, 1065, 34583, 66, 2919, 65, 16, 7012, 64, 20, 36809, 324, 28857, 68, 16, 1860, 276, 15, 43193, 69, 1, 198, 12303, 312, 796, 366, 69, 21, 30803, 69, 1157, 12, 3324, 2091, 12, 3365, 1959, 12, 4846, 1731, 12, 1495, 5066, 7252, 2154, 4761, 940, 1, 198, 9641, 796, 366, 15, 13, 940, 13, 1954, 1, 198, 198, 30109, 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, 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, 24629, 5217, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 68, 2857, 3104, 66, 18, 65, 22, 69, 43239, 67, 20, 64, 33394, 28485, 2931, 23, 4524, 67, 1433, 68, 18, 66, 18, 69, 21, 1329, 17, 1, 198, 12303, 312, 796, 366, 67, 24, 69, 1433, 65, 1731, 12, 69, 33548, 12, 19, 66, 1485, 12, 64, 16, 69, 17, 12, 2078, 27412, 487, 66, 20, 25272, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 22, 1, 198, 198, 30109, 29783, 11907, 198, 10378, 82, 796, 14631, 29531, 8973, 198, 12303, 312, 796, 366, 24, 13331, 23, 38073, 65, 12, 20370, 65, 12, 20, 35667, 12, 24, 68, 23, 67, 12, 19, 67, 15, 37466, 68, 23, 3695, 1238, 1, 198, 198, 30109, 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, 15, 66, 1899, 26582, 3553, 2414, 64, 16, 13331, 15, 65, 47941, 4309, 67, 17, 9423, 1415, 12993, 17457, 1507, 69, 22, 5036, 23, 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, 20, 10, 16, 1, 198, 198, 30109, 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, 32634, 1634, 1600, 366, 50, 11603, 1600, 366, 14402, 1600, 366, 52, 27586, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1270, 69, 17, 65, 23601, 66, 17, 20972, 5705, 940, 67, 4531, 19881, 10210, 66, 24, 66, 15, 64, 21, 1860, 47159, 330, 20, 69, 22, 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, 5237, 13, 16, 1, 198, 198, 30109, 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, 16344, 2425, 13331, 18, 64, 21315, 486, 2931, 64, 17, 66, 15, 721, 4089, 2414, 64, 21, 68, 1415, 66, 1899, 13227, 2548, 2791, 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, 5237, 13, 15, 10, 15, 1, 198, 198, 30109, 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, 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, 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, 22, 19881, 3134, 68, 24, 64, 2780, 1558, 1065, 65, 18, 67, 1350, 24, 21101, 18, 67, 330, 23, 4309, 17896, 19, 65, 1157, 5237, 68, 2999, 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, 15, 1, 198, 198, 30109, 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, 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, 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, 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, 23, 64, 48372, 19082, 23, 330, 2931, 22, 67, 20, 1350, 15, 2920, 2481, 67, 35124, 69, 4524, 1157, 1314, 66, 16, 65, 17, 324, 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, 15, 1, 198, 198, 30109, 17932, 36037, 23595, 11907, 198, 10378, 82, 796, 14631, 13128, 5080, 41367, 3103, 574, 1240, 24629, 2733, 1600, 366, 1532, 40674, 1600, 366, 25835, 25404, 1600, 366, 45442, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 69, 15, 17896, 7410, 3459, 4089, 16, 397, 2816, 36680, 65, 3023, 65, 7012, 23734, 5607, 64, 2598, 64, 16, 64, 18, 64, 24, 1, 198, 12303, 312, 796, 366, 18, 68, 20, 65, 21, 69, 11848, 12, 2931, 4304, 12, 19, 67, 17, 66, 12, 24, 20964, 12, 67, 3720, 2934, 5999, 69, 17, 21855, 15, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 20, 1, 198, 198, 30109, 39, 86, 17946, 11907, 198, 10378, 82, 796, 14631, 39, 86, 17946, 62, 73, 297, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 5892, 67, 2079, 1415, 1899, 2791, 66, 20, 66, 3104, 3459, 67, 20, 64, 18, 39305, 23, 4869, 68, 21, 64, 22291, 30460, 65, 6420, 1, 198, 12303, 312, 796, 366, 15, 68, 2598, 69, 20, 68, 19, 12, 17457, 2791, 12, 4309, 64, 15, 12, 23, 43240, 12, 21139, 64, 44361, 3829, 64, 16, 67, 1, 198, 9641, 796, 366, 17, 13, 15, 13, 15, 1, 198, 198, 30109, 39, 86, 17946, 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, 2091, 3865, 67, 19, 67, 19, 64, 1765, 18, 66, 24, 67, 3132, 69, 3270, 1959, 67, 34159, 1899, 67, 23, 7012, 1453, 68, 3459, 64, 1878, 1, 198, 12303, 312, 796, 366, 68, 2091, 64, 3695, 67, 15, 12, 69, 32759, 12, 20, 487, 66, 12, 65, 6200, 12, 4761, 11231, 24, 65, 20, 3559, 66, 23, 1, 198, 9641, 796, 366, 17, 13, 20, 13, 15, 10, 15, 1, 198, 198, 30109, 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, 1532, 40674, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 11275, 1860, 405, 487, 891, 3023, 36879, 535, 11848, 18, 68, 8628, 48882, 64, 34483, 1899, 68, 23, 69, 324, 16, 1, 198, 12303, 312, 796, 366, 47007, 69, 23451, 66, 12, 66, 1350, 19, 12, 19, 891, 16, 12, 7012, 18, 65, 12, 17, 69, 12993, 3365, 67, 21, 67, 25399, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 16, 1, 198, 198, 30109, 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, 24243, 40161, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 22, 69, 21, 64, 17885, 23, 65, 19, 64, 21, 69, 3510, 9945, 20, 535, 67, 5607, 2079, 64, 18, 16072, 4869, 891, 20, 66, 324, 21, 68, 21, 1, 198, 12303, 312, 796, 366, 1828, 344, 66, 4790, 68, 12, 64, 16, 65, 23, 12, 1157, 68, 24, 12, 17, 66, 5892, 12, 3270, 5774, 1120, 64, 17, 12993, 24, 66, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 1157, 1, 198, 198, 30109, 818, 1370, 13290, 654, 11907, 198, 10378, 82, 796, 14631, 47, 945, 364, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1129, 21101, 2920, 33300, 69, 23, 66, 3901, 2934, 22, 5036, 64, 2624, 67, 49352, 67, 2718, 2934, 24, 1558, 65, 48096, 6814, 1, 198, 12303, 312, 796, 366, 23, 3682, 1860, 6469, 65, 12, 16, 68, 5332, 12, 3559, 17896, 12, 19881, 1959, 12, 20, 67, 15, 1453, 24, 67, 487, 66, 2780, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 16, 1, 198, 198, 30109, 818, 5372, 41472, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1120, 65, 3901, 67, 3270, 68, 22, 23237, 397, 21, 69, 6814, 2996, 68, 43147, 2920, 39071, 24, 67, 4531, 2998, 3132, 487, 1, 198, 12303, 312, 796, 366, 31654, 69, 4089, 66, 24, 12, 2919, 20, 68, 12, 20, 65, 17, 66, 12, 23, 68, 4531, 12, 33646, 1350, 22, 19881, 16, 69, 2682, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 15, 1, 198, 198, 30109, 24123, 11505, 7378, 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, 67, 24, 3720, 68, 4051, 65, 4869, 6814, 6469, 69, 18, 64, 2996, 65, 26704, 4310, 6814, 19, 16072, 18, 67, 1507, 66, 12865, 19, 66, 1, 198, 12303, 312, 796, 366, 16, 67, 20, 535, 22, 65, 23, 12, 2920, 2931, 12, 47785, 68, 12, 64, 15, 69, 23, 12, 67, 15, 69, 20, 324, 5607, 1065, 67, 15, 1, 198, 9641, 796, 366, 7908, 13, 15, 13, 18, 10, 17, 1, 198, 198, 30109, 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, 9492, 16104, 602, 11907, 198, 10378, 82, 796, 14631, 31554, 271, 2348, 7727, 907, 1600, 366, 35491, 37766, 14055, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 34519, 3163, 20477, 1600, 366, 29531, 1600, 366, 29665, 4267, 1600, 366, 39618, 1600, 366, 2484, 1144, 3163, 20477, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 45442, 3163, 20477, 1600, 366, 22911, 10711, 19044, 45977, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 5333, 7252, 22544, 24038, 18213, 17, 344, 19881, 2857, 66, 23, 67, 40873, 6814, 23, 17896, 24, 15630, 19, 68, 15, 66, 25836, 1, 198, 12303, 312, 796, 366, 64, 4089, 67, 24, 64, 23, 65, 12, 64, 17, 397, 12, 3270, 68, 21, 12, 4531, 1860, 12, 2414, 64, 16, 66, 1507, 69, 6888, 3270, 1, 198, 9641, 796, 366, 15, 13, 1485, 13, 19, 1, 198, 198, 30109, 9492, 2100, 50, 1039, 11907, 198, 10378, 82, 796, 14631, 35, 689, 1600, 366, 30639, 2419, 271, 3673, 341, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 18, 535, 27412, 1878, 18, 69, 11442, 64, 32059, 330, 3695, 2996, 8054, 2231, 67, 771, 7568, 66, 1433, 38569, 1, 198, 12303, 312, 796, 366, 23, 24991, 25674, 66, 12, 30336, 69, 12, 20, 69, 1983, 12, 24, 21315, 12, 68, 15, 68, 32576, 1959, 64, 49649, 1, 198, 9641, 796, 366, 15, 13, 20, 13, 18, 1, 198, 198, 30109, 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, 818, 13658, 5497, 1063, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 20963, 20, 69, 16, 891, 20, 19881, 2996, 7568, 3980, 65, 1860, 17, 68, 1821, 2598, 2425, 3829, 65, 29807, 64, 20, 38339, 69, 1, 198, 12303, 312, 796, 366, 3901, 397, 1314, 5705, 12, 16, 67, 2548, 12, 20, 11848, 69, 12, 24, 15801, 12, 69, 1157, 66, 21, 66, 3365, 65, 2780, 69, 1, 198, 9641, 796, 366, 16, 13, 16, 13, 15, 1, 198, 198, 30109, 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, 29993, 33637, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2713, 11442, 64, 17, 397, 16, 16072, 20, 69, 6052, 2075, 1828, 16658, 64, 17, 64, 11245, 26115, 69, 2857, 6469, 66, 1507, 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, 18, 13, 15, 1, 198, 198, 30109, 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, 41, 11163, 17, 11907, 198, 10378, 82, 796, 14631, 6601, 44909, 942, 1600, 366, 8979, 9399, 1600, 366, 14155, 305, 33637, 1600, 366, 44, 8899, 1600, 366, 47, 10025, 1600, 366, 18557, 69, 1600, 366, 3041, 39344, 1600, 366, 8291, 66, 7656, 12124, 82, 1600, 366, 52, 27586, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3510, 65, 3695, 2682, 721, 23, 20986, 66, 20, 3901, 65, 15, 65, 20, 67, 16, 66, 23, 7012, 5066, 721, 24, 30120, 1954, 487, 65, 1, 198, 12303, 312, 796, 366, 15, 28460, 2327, 11848, 12, 23, 4134, 12, 20, 1453, 23, 12, 23, 64, 3609, 12, 18, 69, 20, 3134, 69, 23, 64, 2548, 1129, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 1314, 1, 198, 198, 30109, 41, 3069, 36918, 11799, 11907, 198, 10378, 82, 796, 14631, 36698, 4972, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 41290, 64, 19104, 1878, 23, 65, 3104, 1495, 2327, 1558, 65, 1795, 17457, 18, 65, 16344, 1558, 1765, 19, 68, 5705, 7568, 21, 68, 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, 18, 13, 15, 1, 198, 198, 30109, 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, 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, 67, 22, 2327, 31503, 330, 2425, 66, 20, 21101, 24, 69, 16, 65, 405, 67, 23, 65, 22730, 24, 66, 16315, 5705, 17896, 3388, 3559, 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, 15, 10, 15, 1, 198, 198, 30109, 42, 7948, 35, 6377, 11907, 198, 10378, 82, 796, 14631, 20344, 2455, 507, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 5777, 34551, 1600, 366, 9492, 16104, 602, 1600, 366, 29668, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 48952, 68, 23, 17896, 2931, 324, 1507, 21734, 1507, 4846, 940, 330, 1878, 65, 5607, 405, 2624, 66, 47785, 24038, 1, 198, 12303, 312, 796, 366, 20, 397, 2919, 3388, 65, 12, 6659, 7252, 12, 40486, 67, 12, 11848, 1954, 12, 66, 19881, 4051, 1954, 65, 1350, 24, 65, 1, 198, 9641, 796, 366, 15, 13, 21, 13, 18, 1, 198, 198, 30109, 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, 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, 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, 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, 32517, 18833, 20193, 11907, 198, 10378, 82, 796, 14631, 19182, 39317, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 5124, 723, 30871, 1600, 366, 48913, 24544, 9497, 1600, 366, 45442, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 5999, 65, 20, 2414, 2920, 66, 2670, 31575, 64, 2857, 69, 18, 16072, 9945, 18, 15630, 46519, 17457, 21, 67, 2791, 68, 16, 67, 5607, 1, 198, 12303, 312, 796, 366, 940, 69, 1129, 487, 18, 12, 43240, 69, 12, 26598, 67, 12, 24, 3720, 65, 12, 2816, 33032, 69, 23, 16072, 48000, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 19, 1, 198, 198, 30109, 43, 12582, 8001, 37199, 11907, 198, 10378, 82, 796, 14631, 8001, 37199, 1600, 366, 47, 10025, 8973, 198, 12303, 312, 796, 366, 19, 1878, 4051, 5036, 16, 12, 31047, 15, 12, 3559, 64, 23, 12, 5332, 64, 22, 12, 41019, 67, 6420, 65, 37688, 68, 18, 1, 198, 198, 30109, 43, 12582, 25896, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 45, 2434, 35, 12078, 1600, 366, 34519, 3163, 20477, 1600, 366, 14402, 1600, 366, 57, 35641, 1258, 37766, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 64, 23, 19881, 3134, 1878, 324, 18, 69, 16, 1453, 3270, 67, 27824, 25674, 324, 65, 22, 66, 2598, 535, 330, 22, 16344, 1453, 1, 198, 12303, 312, 796, 366, 16, 69, 324, 22, 29211, 12, 15, 30557, 12, 20, 64, 16, 64, 12, 64, 3980, 69, 12, 64, 3312, 7012, 486, 2931, 2996, 65, 1, 198, 9641, 796, 366, 15, 13, 15, 13, 22, 1, 198, 198, 30109, 18819, 16424, 11028, 50, 27448, 51, 6037, 11907, 198, 10378, 82, 796, 14631, 23839, 51, 6037, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 4869, 1350, 16, 1765, 20, 324, 1129, 21101, 19, 69, 5333, 13331, 23, 66, 49995, 3865, 66, 15, 28460, 16344, 2931, 17, 3609, 15, 1, 198, 12303, 312, 796, 366, 16, 67, 21, 67, 2999, 324, 12, 1350, 5237, 12, 19, 65, 21, 65, 12, 23, 64, 21, 67, 12, 17, 69, 3829, 68, 22980, 27037, 68, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 17, 1, 198, 198, 30109, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 25835, 35943, 11907, 198, 10378, 82, 796, 14631, 25835, 35943, 62, 73, 297, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3829, 66, 21, 276, 22, 69, 24, 330, 31911, 66, 1860, 330, 67, 1795, 67, 20, 66, 16, 69, 6888, 3270, 66, 5607, 67, 22416, 68, 22, 1, 198, 12303, 312, 796, 366, 21, 69, 16, 69, 324, 2075, 12, 67, 1314, 68, 12, 20, 17896, 23, 12, 3609, 4310, 12, 23, 2718, 64, 16, 67, 22, 65, 23, 66, 24, 69, 1, 198, 9641, 796, 366, 15, 13, 20, 13, 18, 1, 198, 198, 30109, 25835, 35943, 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, 46815, 16072, 31360, 17, 11848, 66, 20, 1983, 64, 8054, 21, 64, 3865, 1558, 1433, 67, 47159, 7012, 64, 24, 67, 4051, 68, 24, 1, 198, 12303, 312, 796, 366, 18, 3609, 1959, 3132, 64, 12, 32583, 66, 12, 3270, 4790, 12, 24, 66, 2548, 12, 535, 69, 22, 37747, 21855, 17885, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 18, 10, 15, 1, 198, 198, 30109, 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, 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, 13949, 50, 451, 2052, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 45, 6561, 349, 690, 14881, 1600, 366, 26705, 32755, 776, 1600, 366, 48944, 1600, 366, 18557, 69, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 69, 1983, 19924, 68, 43697, 68, 24, 3270, 65, 2623, 3134, 67, 23, 66, 6052, 68, 3609, 44675, 4790, 1828, 1120, 2624, 1860, 1, 198, 12303, 312, 796, 366, 67, 18, 67, 1795, 37864, 12, 68, 24, 67, 19, 12, 20, 69, 2718, 12, 4089, 3695, 12, 17, 397, 15, 69, 535, 2414, 13381, 1, 198, 9641, 796, 366, 22, 13, 16, 13, 16, 1, 198, 198, 30109, 14993, 451, 2348, 29230, 11907, 198, 10378, 82, 796, 14631, 25835, 25404, 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, 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, 1350, 24, 68, 891, 24, 69, 24, 67, 3695, 344, 21101, 21, 69, 29119, 69, 18, 66, 940, 6814, 24309, 64, 21, 66, 20, 397, 23, 1983, 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, 20, 1, 198, 198, 30109, 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, 11187, 2667, 11627, 8847, 11907, 198, 10378, 82, 796, 14631, 35, 689, 1600, 366, 11187, 2667, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 7568, 18082, 16, 66, 1157, 1270, 2079, 3023, 2078, 23906, 2934, 405, 1731, 67, 2231, 1433, 65, 1129, 2999, 344, 4089, 1, 198, 12303, 312, 796, 366, 68, 21, 69, 4531, 66, 5607, 12, 67, 2857, 64, 12, 20, 32128, 12, 36928, 69, 12, 24, 66, 2718, 69, 2670, 2075, 66, 2623, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 22, 1, 198, 198, 30109, 9655, 9655, 1925, 1299, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 31554, 271, 3163, 20477, 1600, 366, 40073, 1600, 366, 35, 689, 1600, 366, 20344, 2455, 507, 1600, 366, 26227, 889, 1600, 366, 37787, 39317, 11627, 5736, 1600, 366, 42, 7948, 35, 6377, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 9655, 44, 8610, 72, 4660, 15132, 33637, 1600, 366, 5805, 41, 17633, 39317, 1600, 366, 35364, 42758, 1600, 366, 35422, 1068, 5216, 26448, 1600, 366, 35700, 51, 2977, 1600, 366, 29531, 1600, 366, 6690, 18636, 14881, 1600, 366, 32634, 1634, 1600, 366, 13409, 24629, 2733, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 10962, 15721, 896, 1600, 366, 51, 2977, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3023, 66, 18, 16344, 21, 6814, 2078, 1765, 67, 22515, 10232, 487, 65, 2713, 69, 15, 64, 18, 65, 23, 69, 24, 65, 2286, 15, 64, 1, 198, 12303, 312, 796, 366, 66, 22, 69, 33808, 69, 17, 12, 487, 1507, 12, 3365, 68, 24, 12, 15630, 22, 65, 12, 26717, 2078, 68, 3459, 69, 2425, 67, 1, 198, 9641, 796, 366, 20, 13, 15, 13, 16, 1, 198, 198, 30109, 9655, 44, 8610, 72, 4660, 15132, 33637, 11907, 198, 10378, 82, 796, 14631, 23839, 5777, 33758, 1600, 366, 6601, 17614, 1600, 366, 20344, 2455, 507, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 5805, 41, 17633, 39317, 1600, 366, 29531, 1600, 366, 13409, 24629, 2733, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 51, 2977, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 21, 15498, 5332, 397, 16, 330, 2713, 1314, 64, 16, 67, 21139, 1270, 19881, 30995, 64, 4521, 2682, 18213, 20, 39509, 66, 1, 198, 12303, 312, 796, 366, 1350, 1157, 4309, 1731, 12, 3270, 10210, 12, 11785, 65, 12, 324, 2780, 12, 33535, 68, 1270, 2079, 2791, 69, 15, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 17, 1, 198, 198, 30109, 33907, 43, 62, 73, 297, 11907, 198, 10378, 82, 796, 14631, 8001, 37199, 1600, 366, 24123, 11505, 7378, 62, 73, 297, 1600, 366, 41, 3069, 36918, 11799, 1600, 366, 43, 12582, 8001, 37199, 1600, 366, 25835, 25404, 1600, 366, 47, 10025, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 20, 30505, 64, 891, 2931, 65, 1821, 68, 1120, 1238, 68, 1314, 1238, 69, 43697, 13331, 25838, 1120, 1821, 67, 19, 276, 15, 1, 198, 12303, 312, 796, 366, 23, 3980, 69, 43977, 66, 12, 67, 4521, 68, 12, 20, 67, 2931, 12, 65, 31418, 12, 3609, 397, 4304, 17896, 23, 7012, 22, 1, 198, 9641, 796, 366, 1238, 2481, 13, 16, 13, 16, 10, 17, 1, 198, 198, 30109, 5805, 41, 17633, 39317, 11907, 198, 10378, 82, 796, 14631, 29531, 1600, 366, 23010, 811, 31431, 14881, 1600, 366, 17126, 19929, 15721, 896, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 486, 4524, 68, 24, 67, 15259, 65, 15, 66, 3609, 16, 69, 23, 5036, 3720, 4304, 14877, 324, 4309, 69, 15, 68, 2154, 68, 15, 67, 23, 1, 198, 12303, 312, 796, 366, 68, 1795, 68, 16, 558, 12, 23, 3270, 64, 12, 44578, 68, 12, 24, 276, 24, 12, 23516, 2857, 67, 23, 3609, 18, 18213, 1, 198, 9641, 796, 366, 16, 13, 18, 13, 18, 1, 198, 198, 30109, 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, 5124, 723, 30871, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 24, 21101, 22745, 65, 1507, 18294, 65, 17, 19104, 9945, 25191, 324, 13331, 24, 1954, 65, 2231, 49051, 5036, 2919, 68, 1, 198, 12303, 312, 796, 366, 67, 11623, 68, 19, 67, 18, 12, 1828, 2718, 12, 2857, 1129, 12, 65, 1129, 66, 12, 13331, 42759, 65, 23, 64, 19, 28933, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 21, 1, 198, 198, 30109, 44, 6320, 3163, 20477, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 68, 23, 65, 30743, 891, 3312, 721, 4761, 68, 23, 66, 39101, 38380, 5036, 2999, 22521, 2816, 1983, 1453, 20, 23726, 1, 198, 12303, 312, 796, 366, 9945, 65, 3270, 2078, 67, 12, 68, 397, 16, 12, 20, 69, 3829, 12, 5332, 66, 17, 12, 65, 24, 65, 15, 276, 65, 22, 66, 12865, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 16, 1, 198, 198, 30109, 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, 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, 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, 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, 13031, 5216, 26448, 11907, 198, 10378, 82, 796, 14631, 43984, 43984, 1600, 366, 7248, 3245, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 19, 69, 2996, 65, 9945, 1350, 24, 2682, 2425, 69, 21, 487, 24, 18213, 3388, 3388, 65, 23349, 2624, 69, 3459, 67, 30743, 1350, 1, 198, 12303, 312, 796, 366, 12762, 2860, 22, 67, 12, 2623, 2548, 12, 19, 66, 3720, 12, 44980, 66, 12, 24, 2919, 18213, 15, 66, 1495, 66, 2682, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 16, 1, 198, 198, 30109, 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, 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, 9069, 660, 9914, 5439, 47384, 902, 11907, 198, 10378, 82, 796, 14631, 20344, 6169, 1600, 366, 20344, 2455, 507, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 14155, 305, 33637, 1600, 366, 29531, 1600, 366, 6690, 18636, 14881, 1600, 366, 39618, 1600, 366, 50, 2538, 36, 5837, 343, 689, 1600, 366, 45442, 3163, 20477, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 24, 17896, 39710, 67, 20, 64, 15, 26007, 1453, 1795, 44705, 2920, 67, 15, 21855, 1485, 30368, 67, 22, 535, 22, 66, 6420, 1, 198, 12303, 312, 796, 366, 2931, 5774, 66, 24, 535, 12, 5036, 2931, 12, 1157, 68, 23, 12, 1270, 69, 15, 12, 65, 4846, 1860, 37601, 16344, 6888, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 18, 1, 198, 198, 30109, 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, 15205, 42524, 29668, 11907, 198, 10378, 82, 796, 14631, 3163, 8002, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 48346, 1600, 366, 29668, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 67, 24, 3365, 487, 1507, 4051, 65, 1433, 8054, 18, 23721, 5036, 26492, 721, 2682, 65, 24, 67, 3270, 2078, 1899, 64, 1, 198, 12303, 312, 796, 366, 21, 69, 27033, 69, 21, 64, 12, 16243, 69, 12, 3365, 3695, 12, 397, 16, 68, 12, 1507, 4310, 2414, 8635, 42224, 1, 198, 9641, 796, 366, 15, 13, 23, 13, 15, 1, 198, 198, 30109, 45, 6561, 349, 690, 14881, 11907, 198, 10378, 82, 796, 14631, 28813, 25468, 1600, 366, 20344, 6169, 1600, 366, 37, 9504, 28813, 1600, 366, 39746, 28813, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1120, 26717, 69, 24, 2682, 68, 2816, 68, 20, 6888, 2670, 1065, 21855, 24, 3901, 12501, 19104, 65, 2920, 6888, 24, 65, 3104, 1, 198, 12303, 312, 796, 366, 67, 3901, 15630, 32182, 12, 18741, 64, 12, 20, 36088, 12, 23, 68, 19, 66, 12, 66, 32128, 1433, 15982, 66, 21, 66, 1, 198, 9641, 796, 366, 22, 13, 23, 13, 17, 1, 198, 198, 30109, 6144, 8019, 11907, 198, 10378, 82, 796, 14631, 48003, 1600, 366, 35491, 37766, 14055, 1600, 366, 40073, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 47, 10025, 1600, 366, 39618, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 17, 1765, 22515, 65, 1485, 68, 8432, 6420, 67, 22, 6814, 1415, 26276, 19881, 1558, 344, 2791, 2414, 19881, 1453, 18, 67, 1, 198, 12303, 312, 796, 366, 23, 4761, 66, 38605, 66, 12, 2079, 65, 15, 12, 33690, 66, 12, 65, 18, 65, 22, 12, 65, 21, 66, 4846, 64, 3459, 67, 20, 10210, 1, 198, 9641, 796, 366, 15, 13, 22, 13, 3132, 1, 198, 198, 30109, 26705, 32755, 776, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 65, 5036, 2857, 68, 40761, 67, 1899, 65, 6469, 65, 2791, 65, 5333, 67, 17, 67, 2598, 12762, 65, 5237, 68, 18, 64, 30803, 21855, 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, 20, 1, 198, 198, 30109, 45, 2434, 3163, 20477, 11907, 198, 10378, 82, 796, 14631, 20575, 20900, 873, 1600, 366, 6601, 44909, 942, 1600, 366, 13856, 320, 863, 25876, 1600, 366, 818, 13658, 5497, 1063, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 17, 16344, 3553, 5774, 11623, 67, 16, 64, 6052, 69, 1350, 1270, 4846, 16, 17457, 5705, 1558, 2998, 65, 23, 64, 1795, 67, 2425, 65, 1, 198, 12303, 312, 796, 366, 4521, 69, 22, 64, 40523, 12, 1238, 1828, 12, 1120, 65, 19, 12, 64, 47915, 12, 3559, 66, 1954, 330, 18, 66, 45758, 1, 198, 9641, 796, 366, 15, 13, 24, 13, 21, 1, 198, 198, 30109, 45, 2434, 35, 12078, 11907, 198, 10378, 82, 796, 14631, 23839, 5777, 33758, 1600, 366, 35491, 37766, 14055, 1600, 366, 34, 709, 2743, 590, 22362, 18991, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 47, 10025, 1600, 366, 39618, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 19, 69, 2682, 68, 18, 487, 17, 13331, 22, 69, 17, 64, 16, 66, 3070, 21855, 17, 66, 19, 69, 1860, 21, 2718, 23734, 67, 40761, 11848, 66, 1, 198, 12303, 312, 796, 366, 2327, 1899, 1828, 64, 16, 12, 3070, 2414, 12, 20, 69, 3365, 12, 4531, 2598, 12, 15, 6814, 19, 65, 1507, 67, 35402, 69, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 3682, 1, 198, 198, 30109, 45, 2434, 51, 29291, 33637, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 21, 2548, 3132, 67, 344, 64, 20, 68, 1157, 9945, 16, 66, 2931, 1495, 22521, 20, 891, 20, 16072, 486, 67, 49351, 66, 49542, 1, 198, 12303, 312, 796, 366, 67, 24, 721, 20, 23726, 12, 16, 68, 405, 12, 20, 7252, 15, 12, 24, 67, 21, 64, 12, 2624, 1507, 2791, 15277, 69, 1120, 1, 198, 9641, 796, 366, 15, 13, 1485, 13, 22, 1, 198, 198, 30109, 35364, 42758, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 18082, 31503, 67, 3312, 65, 24, 69, 22, 66, 405, 43665, 1453, 6659, 12993, 64, 36330, 22521, 31046, 2481, 68, 2481, 1, 198, 12303, 312, 796, 366, 66, 33618, 65, 16, 64, 16, 12, 68, 24, 65, 15, 12, 31938, 64, 12, 24, 66, 2091, 12, 69, 15, 2670, 65, 16072, 4051, 64, 5332, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 15, 1, 198, 198, 30109, 8199, 12423, 46445, 32289, 11907, 198, 10378, 82, 796, 14631, 20344, 1817, 1600, 366, 45442, 3163, 20477, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1433, 7012, 330, 16344, 66, 31360, 23, 15630, 2718, 33646, 1495, 2791, 66, 24, 23451, 68, 41172, 68, 5332, 66, 17, 69, 15, 1, 198, 12303, 312, 796, 366, 65, 23, 64, 23, 2996, 5774, 12, 19, 15363, 12, 20, 397, 16, 12, 5999, 15630, 12, 7252, 37128, 67, 2718, 11848, 344, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 24, 1, 198, 198, 30109, 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, 31310, 712, 2977, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 5036, 1959, 1878, 4299, 18, 67, 15, 66, 19, 64, 23, 27033, 12762, 67, 19, 68, 2231, 535, 35638, 2481, 65, 16, 68, 3559, 67, 1, 198, 12303, 312, 796, 366, 20, 15377, 1314, 16072, 12, 19, 22745, 12, 20, 1860, 68, 12, 65, 24909, 12, 48634, 16072, 2598, 3459, 1453, 17, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 15, 1, 198, 198, 30109, 34519, 3163, 20477, 11907, 198, 10378, 82, 796, 14631, 48003, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3023, 18938, 22, 68, 15, 65, 2934, 487, 5333, 12993, 11848, 22, 1878, 1765, 40486, 397, 25710, 2623, 11848, 65, 20, 276, 1, 198, 12303, 312, 796, 366, 21, 5036, 16, 19881, 65, 15, 12, 2934, 1238, 12, 27641, 12, 23, 6888, 22, 12, 1795, 69, 3553, 67, 2075, 69, 3459, 16, 1, 198, 9641, 796, 366, 16, 13, 940, 13, 23, 1, 198, 198, 30109, 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, 3720, 2718, 18082, 38472, 1433, 1899, 65, 19, 67, 21, 64, 1453, 68, 535, 17, 69, 22, 68, 16, 66, 6659, 66, 23, 1453, 19, 68, 17, 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, 15, 1, 198, 198, 30109, 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, 11505, 25835, 76, 62, 73, 297, 11907, 198, 10378, 82, 796, 14631, 8001, 37199, 1600, 366, 25835, 25404, 8973, 198, 12303, 312, 796, 366, 2713, 23, 1954, 4059, 12, 1129, 330, 12, 20, 65, 23, 65, 12, 4846, 2078, 12, 26492, 64, 3023, 15630, 4349, 1065, 1, 198, 198, 30109, 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, 1314, 11245, 17896, 65, 22, 67, 23, 9945, 18, 66, 21, 66, 23, 3553, 69, 6814, 1415, 4531, 16, 64, 20, 2670, 64, 23, 69, 1983, 2713, 64, 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, 940, 10, 15, 1, 198, 198, 30109, 11505, 22882, 24629, 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, 47, 10025, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1485, 2996, 1731, 6420, 69, 3104, 3980, 330, 16344, 17, 9945, 1959, 15277, 68, 16, 11848, 10210, 2231, 2996, 67, 3023, 69, 16, 1, 198, 12303, 312, 796, 366, 22521, 2078, 16344, 20, 12, 23, 30057, 12, 48096, 65, 12, 64, 24, 68, 16, 12, 65, 1959, 1433, 16072, 2718, 2548, 68, 1, 198, 9641, 796, 366, 15, 13, 20, 13, 20, 10, 15, 1, 198, 198, 30109, 27871, 320, 11907, 198, 10378, 82, 796, 14631, 40073, 1600, 366, 33762, 3163, 20477, 1600, 366, 39746, 28813, 1600, 366, 13949, 50, 451, 2052, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 45, 6561, 349, 690, 14881, 1600, 366, 26705, 32755, 776, 1600, 366, 48944, 1600, 366, 21604, 1800, 41384, 4582, 1600, 366, 18557, 69, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 29668, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2327, 67, 40064, 65, 25836, 21855, 397, 16, 67, 16, 64, 1959, 20107, 65, 20, 23539, 1983, 2079, 1495, 1765, 64, 30803, 1, 198, 12303, 312, 796, 366, 11785, 48057, 7252, 12, 19, 25600, 12, 20, 64, 891, 12, 64, 18, 1878, 12, 5332, 2075, 21895, 2231, 64, 1765, 1, 198, 9641, 796, 366, 16, 13, 20, 13, 15, 1, 198, 198, 30109, 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, 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, 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, 5760, 44, 1381, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 50, 29572, 3163, 20477, 1600, 366, 5606, 578, 50, 29572, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1453, 2075, 65, 14877, 27988, 66, 47493, 5607, 66, 24, 66, 17, 67, 3459, 64, 2998, 17, 65, 29626, 69, 24, 69, 3070, 67, 4790, 1, 198, 12303, 312, 796, 366, 12865, 1415, 64, 16, 69, 12, 1983, 7012, 12, 44617, 66, 12, 397, 1238, 12, 3365, 69, 7252, 2598, 67, 6420, 1120, 1, 198, 9641, 796, 366, 15, 13, 1157, 13, 20, 1, 198, 198, 30109, 48944, 11907, 198, 10378, 82, 796, 14631, 35422, 1068, 5216, 26448, 1600, 366, 3118, 11869, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2682, 66, 15, 68, 24, 324, 29119, 68, 20, 69, 22, 16072, 2425, 65, 940, 64, 2079, 4309, 6888, 22, 46589, 12993, 66, 20, 69, 1350, 1, 198, 12303, 312, 796, 366, 67, 4846, 68, 23, 1129, 68, 12, 16072, 2791, 12, 20, 39380, 12, 5607, 2078, 12, 5705, 66, 24, 66, 2425, 5892, 65, 15, 64, 1, 198, 9641, 796, 366, 15, 13, 1065, 13, 18, 1, 198, 198, 30109, 47, 533, 1462, 7556, 5226, 11907, 198, 10378, 82, 796, 14631, 31554, 271, 40729, 1600, 366, 9492, 5275, 18274, 4487, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 11187, 16870, 24629, 2733, 1600, 366, 9655, 44, 8610, 72, 4660, 15132, 33637, 1600, 366, 45, 2434, 35, 12078, 1600, 366, 35700, 51, 2977, 1600, 366, 18557, 69, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 51, 724, 952, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 66, 21, 68, 16, 66, 46435, 67, 2996, 67, 24, 65, 42224, 69, 6052, 67, 1558, 2623, 3695, 68, 6469, 12993, 2919, 21, 67, 5892, 68, 21, 1, 198, 12303, 312, 796, 366, 64, 3104, 65, 20, 64, 2481, 12, 69, 11785, 12, 47101, 68, 12, 23, 65, 13331, 12, 3510, 65, 2598, 4790, 405, 64, 330, 1, 198, 9641, 796, 366, 15, 13, 22, 13, 15, 1, 198, 198, 30109, 47, 533, 1462, 7556, 1025, 704, 20939, 590, 16305, 11347, 11907, 198, 10378, 82, 796, 14631, 7902, 53, 1600, 366, 6601, 35439, 1600, 366, 20344, 2455, 507, 1600, 366, 40386, 1600, 366, 18557, 69, 1600, 366, 29531, 1600, 366, 32140, 36674, 1600, 366, 48346, 1600, 366, 29668, 37, 13271, 1600, 366, 29668, 3646, 1747, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 66, 29807, 64, 20, 67, 4309, 17896, 3270, 2857, 64, 5705, 65, 1828, 65, 16, 65, 2791, 2816, 30336, 67, 17, 21855, 2231, 66, 23, 64, 1, 198, 12303, 312, 796, 366, 4089, 69, 33057, 721, 12, 5333, 68, 17, 12, 1157, 1765, 12, 16, 66, 22, 65, 12, 3132, 18213, 940, 5607, 11645, 69, 1, 198, 9641, 796, 366, 16, 13, 16, 13, 15, 1, 198, 198, 30109, 47, 945, 364, 11907, 198, 10378, 82, 796, 14631, 35, 689, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3609, 19, 11848, 66, 324, 65, 1959, 3312, 535, 66, 2919, 20, 12993, 4309, 330, 27033, 17896, 1485, 3324, 67, 344, 535, 66, 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, 16, 13, 17, 1, 198, 198, 30109, 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, 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, 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, 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, 65, 2919, 3559, 1731, 65, 19, 1878, 20, 64, 43704, 10210, 21, 2623, 1129, 16344, 405, 2791, 1415, 65, 18, 65, 1238, 65, 5774, 65, 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, 15, 13, 1314, 1, 198, 198, 30109, 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, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 22, 2718, 15277, 1270, 64, 2931, 19, 68, 23, 67, 1731, 69, 7568, 2623, 1959, 3609, 40022, 24591, 19881, 16, 67, 3270, 67, 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, 1731, 13, 18, 1, 198, 198, 30109, 27201, 276, 3163, 20477, 11907, 198, 10378, 82, 796, 14631, 6601, 17614, 1600, 366, 29783, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 9945, 18, 64, 1954, 23055, 1878, 23, 64, 1765, 69, 19, 9945, 20, 891, 5774, 330, 20, 65, 405, 67, 2623, 1765, 46761, 68, 17, 1, 198, 12303, 312, 796, 366, 17, 7568, 65, 5066, 1453, 12, 535, 2670, 12, 20, 1860, 20, 12, 3865, 17457, 12, 44980, 19881, 46712, 67, 23906, 1, 198, 9641, 796, 366, 16, 13, 19, 13, 15, 1, 198, 198, 30109, 21604, 1800, 41384, 4582, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1558, 23195, 32642, 69, 34770, 68, 2791, 4790, 69, 22, 68, 22, 69, 43587, 4349, 69, 36809, 276, 20, 65, 1314, 65, 1238, 1, 198, 12303, 312, 796, 366, 5332, 64, 21, 1860, 1495, 12, 68, 3695, 64, 12, 2816, 65, 22, 12, 25764, 17, 12, 1558, 33459, 2327, 65, 23, 11623, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 19, 1, 198, 198, 30109, 36698, 4972, 11907, 198, 10378, 82, 796, 14631, 51, 2662, 43, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 405, 12993, 67, 24, 1959, 2598, 6888, 24, 66, 40761, 4089, 1983, 2857, 68, 24, 64, 16, 67, 15, 67, 20, 67, 4521, 397, 16, 68, 20, 64, 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, 17, 1, 198, 198, 30109, 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, 67, 5824, 37187, 1350, 21, 1157, 1453, 24, 67, 43798, 2414, 5036, 38605, 276, 11848, 22515, 69, 23, 535, 15, 1765, 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, 17, 13, 18, 1, 198, 198, 30109, 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, 32577, 11187, 2667, 11907, 198, 10378, 82, 796, 14631, 11187, 2667, 1600, 366, 37596, 1600, 366, 52, 27586, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1795, 67, 24, 1129, 67, 1453, 2816, 65, 24, 66, 1120, 68, 23, 67, 24, 68, 17, 6814, 20, 1453, 2001, 69, 18, 5036, 3365, 65, 20, 2670, 1, 198, 12303, 312, 796, 366, 2091, 66, 23, 65, 21, 65, 21, 12, 67, 2548, 64, 12, 44361, 64, 12, 65, 43916, 12, 6888, 64, 4531, 64, 17, 69, 21734, 66, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 19, 1, 198, 198, 30109, 32577, 44, 2357, 11907, 198, 10378, 82, 796, 14631, 20344, 6169, 1600, 366, 18557, 69, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1878, 671, 7012, 5066, 67, 3829, 487, 22047, 64, 21, 64, 2780, 67, 2167, 5824, 2682, 68, 344, 68, 17, 721, 24, 68, 23, 1, 198, 12303, 312, 796, 366, 24, 1959, 2091, 69, 19, 66, 12, 68, 27800, 12, 20, 64, 2713, 12, 64, 28771, 12, 19, 65, 35638, 9945, 28669, 6888, 1, 198, 9641, 796, 366, 16, 13, 22, 13, 16, 1, 198, 198, 30109, 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, 4507, 324, 38, 42, 11907, 198, 10378, 82, 796, 14631, 6601, 44909, 942, 1600, 366, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3695, 64, 324, 487, 65, 18, 891, 67, 17, 18742, 1878, 20219, 49703, 65, 23, 64, 23, 7568, 16, 891, 26050, 18213, 2670, 1, 198, 12303, 312, 796, 366, 16, 16344, 2857, 65, 1120, 12, 37804, 67, 12, 20, 66, 2154, 12, 24, 38205, 12, 69, 22, 1129, 69, 23, 69, 18, 65, 10210, 66, 1, 198, 9641, 796, 366, 17, 13, 19, 13, 17, 1, 198, 198, 30109, 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, 29531, 11907, 198, 10378, 82, 796, 14631, 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, 17257, 3163, 20477, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 65, 3829, 2670, 68, 24, 2718, 4790, 1860, 12993, 66, 23, 2078, 69, 1065, 64, 324, 69, 22, 15363, 65, 19, 65, 19, 67, 18182, 69, 20, 1, 198, 12303, 312, 796, 366, 65, 18, 66, 18, 558, 15, 12, 3609, 4309, 12, 4051, 68, 22, 12, 24, 67, 15, 65, 12, 17, 66, 1415, 3312, 16344, 21, 65, 24, 67, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 17, 1, 198, 198, 30109, 29665, 4267, 11907, 198, 10378, 82, 796, 14631, 39618, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 486, 67, 33660, 69, 1120, 1828, 1120, 68, 6659, 69, 21, 69, 721, 15, 8635, 39380, 7252, 4521, 1485, 5892, 64, 18, 7252, 1, 198, 12303, 312, 796, 366, 66, 5705, 276, 17, 69, 16, 12, 47984, 20, 12, 4051, 69, 15, 12, 7252, 23, 68, 12, 9945, 22521, 1983, 25707, 2670, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 17, 1, 198, 198, 30109, 15633, 35, 313, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 24, 69, 15, 64, 16, 65, 4869, 7012, 1878, 4304, 1120, 69, 19, 13331, 23, 64, 16, 67, 14656, 66, 22, 21855, 21, 1453, 3901, 69, 15, 66, 24, 1, 198, 12303, 312, 796, 366, 66, 16, 3609, 47838, 69, 12, 15, 10210, 20, 12, 19, 65, 3388, 12, 3829, 64, 21, 12, 24, 64, 2327, 65, 16, 64, 4089, 7568, 24, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 15, 1, 198, 198, 30109, 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, 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, 22, 324, 15, 7568, 64, 23, 67, 3070, 65, 22, 65, 12993, 23, 66, 43239, 69, 3270, 69, 49721, 2078, 29326, 1270, 66, 2816, 65, 23, 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, 19, 13, 16, 1, 198, 198, 30109, 6690, 30753, 19182, 33637, 11907, 198, 10378, 82, 796, 14631, 19182, 39317, 1600, 366, 35491, 37766, 14055, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 33762, 3163, 20477, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 6690, 18636, 14881, 1600, 366, 39618, 1600, 366, 45442, 3163, 20477, 1600, 366, 48346, 1600, 366, 57, 35641, 1258, 37766, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 66, 24, 2598, 13331, 19, 324, 11848, 2857, 1350, 42117, 4304, 2327, 4089, 1157, 66, 15, 64, 1415, 39251, 17457, 66, 23, 64, 23, 1, 198, 12303, 312, 796, 366, 4790, 1157, 4521, 6888, 12, 23, 67, 5237, 12, 3553, 344, 12, 65, 39226, 12, 69, 17457, 24, 2791, 67, 2998, 19, 10210, 1, 198, 9641, 796, 366, 17, 13, 1238, 13, 15, 1, 198, 198, 30109, 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, 39618, 11907, 198, 10378, 82, 796, 14631, 52, 27586, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1821, 2623, 64, 18, 17457, 2919, 330, 22, 68, 38956, 68, 1983, 66, 22416, 67, 2231, 69, 20, 20972, 8628, 22136, 2481, 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, 16, 13, 18, 1, 198, 198, 30109, 49, 11018, 11907, 198, 10378, 82, 796, 14631, 29531, 1600, 366, 49, 11018, 62, 73, 297, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 19881, 18, 20356, 69, 31047, 20198, 344, 15711, 66, 4304, 324, 6469, 66, 1983, 5892, 66, 3553, 11231, 22, 65, 16, 69, 1, 198, 12303, 312, 796, 366, 3720, 2931, 23, 16072, 19, 12, 64, 5332, 68, 12, 20, 67, 3388, 12, 7252, 21, 64, 12, 2780, 5066, 69, 1731, 36260, 13331, 1, 198, 9641, 796, 366, 15, 13, 22, 13, 15, 1, 198, 198, 30109, 49, 11018, 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, 3104, 9945, 2624, 67, 487, 1065, 11848, 21, 16799, 65, 330, 4790, 66, 22567, 3459, 16315, 16, 19881, 15, 891, 11848, 22, 1, 198, 12303, 312, 796, 366, 69, 1120, 67, 16, 65, 3132, 12, 3459, 68, 23, 12, 3365, 2934, 12, 1350, 17, 66, 12, 16, 535, 43489, 36042, 2425, 69, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 15, 10, 15, 1, 198, 198, 30109, 49, 13880, 11907, 198, 10378, 82, 796, 14631, 17227, 50, 6442, 1600, 366, 18557, 69, 1600, 366, 7248, 3245, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 4349, 1453, 3553, 27019, 3388, 2713, 1453, 2682, 66, 2713, 3104, 69, 20, 22521, 44215, 67, 2598, 19881, 3270, 69, 4524, 1, 198, 12303, 312, 796, 366, 69, 17, 65, 486, 69, 3510, 12, 69, 12993, 64, 12, 43697, 66, 12, 23, 2598, 64, 12, 67, 23, 330, 16, 68, 4846, 66, 36879, 1, 198, 9641, 796, 366, 16, 13, 18, 13, 1157, 1, 198, 198, 30109, 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, 48913, 24544, 9497, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 26073, 2078, 4846, 2623, 21855, 23, 15982, 66, 20, 69, 19504, 3459, 67, 1983, 3901, 68, 24, 16344, 22, 64, 3312, 16, 64, 20, 66, 1, 198, 12303, 312, 796, 366, 5824, 68, 23, 3553, 7568, 12, 3324, 344, 12, 19, 24309, 12, 4531, 68, 20, 12, 22, 3459, 65, 2091, 22413, 1350, 19, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 15, 1, 198, 198, 30109, 50, 2538, 36, 5837, 343, 689, 11907, 198, 10378, 82, 796, 14631, 1532, 40674, 1600, 366, 45442, 1600, 366, 38469, 1634, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1415, 940, 64, 324, 16, 66, 21, 65, 2327, 4521, 1495, 4790, 66, 486, 65, 4846, 10210, 16, 69, 21, 67, 1350, 33372, 2079, 5824, 1, 198, 12303, 312, 796, 366, 2857, 2996, 486, 68, 23, 12, 2931, 64, 17, 12, 20, 68, 344, 12, 3459, 3388, 12, 21855, 6469, 2934, 4531, 64, 16, 13331, 1, 198, 9641, 796, 366, 15, 13, 21, 13, 2078, 1, 198, 198, 30109, 50, 979, 5805, 14881, 11907, 198, 10378, 82, 796, 14631, 19182, 39317, 1600, 366, 17227, 50, 6442, 1600, 366, 36687, 14881, 1600, 366, 20344, 6169, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 37787, 39317, 11627, 5736, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 11187, 2667, 1600, 366, 6690, 18636, 14881, 1600, 366, 6690, 30753, 19182, 33637, 1600, 366, 45442, 3163, 20477, 1600, 366, 48346, 1600, 366, 51, 2977, 1600, 366, 27660, 7680, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 65, 18, 67, 1954, 7252, 19, 68, 20, 69, 21, 2481, 65, 46900, 65, 18, 65, 15, 67, 3901, 66, 5237, 66, 4521, 1731, 67, 1983, 17477, 64, 1, 198, 12303, 312, 796, 366, 15, 65, 6888, 2231, 4304, 12, 5705, 69, 19, 12, 19, 67, 3829, 12, 23, 16658, 12, 487, 64, 39101, 69, 1238, 39997, 1, 198, 9641, 796, 366, 16, 13, 1129, 13, 20, 1, 198, 198, 30109, 23010, 811, 31431, 14881, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 21652, 68, 34770, 1350, 1878, 21, 65, 36626, 66, 16, 68, 22, 24309, 344, 17, 66, 17, 64, 22, 1828, 35273, 67, 2791, 2718, 1, 198, 12303, 312, 796, 366, 1270, 69, 21536, 1860, 12, 23, 2001, 12, 19, 66, 20, 69, 12, 5824, 7012, 12, 23, 68, 2414, 31128, 66, 1157, 5333, 1, 198, 9641, 796, 366, 17, 13, 18, 13, 15, 1, 198, 198, 30109, 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, 31837, 20538, 3163, 20477, 11907, 198, 10378, 82, 796, 14631, 35, 689, 1600, 366, 29531, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 69, 2231, 65, 2682, 37466, 33372, 64, 16, 69, 21, 68, 22, 22579, 486, 17896, 24, 891, 3134, 4846, 940, 17457, 1065, 65, 20, 1, 198, 12303, 312, 796, 366, 6420, 66, 41647, 4051, 12, 18, 721, 19, 12, 3901, 64, 18, 12, 64, 1731, 69, 12, 18, 69, 1954, 68, 1238, 67, 47007, 66, 1, 198, 9641, 796, 366, 16, 13, 18, 13, 23, 1, 198, 198, 30109, 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, 7248, 3245, 11907, 198, 10378, 82, 796, 14631, 36687, 14881, 1600, 366, 29783, 1600, 366, 14155, 305, 33637, 1600, 366, 39618, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 4299, 2998, 1507, 1860, 65, 397, 1765, 20, 35435, 68, 4349, 68, 20, 64, 3559, 31751, 20963, 39121, 69, 26279, 67, 1, 198, 12303, 312, 796, 366, 891, 12993, 1314, 2154, 12, 2682, 1954, 12, 3553, 67, 16, 12, 330, 65, 22, 12, 16344, 2091, 69, 1860, 65, 330, 3510, 1, 198, 9641, 796, 366, 15, 13, 23, 13, 15, 1, 198, 198, 30109, 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, 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, 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, 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, 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, 13409, 24629, 2733, 11907, 198, 10378, 82, 796, 14631, 35491, 37766, 14055, 1600, 366, 23820, 20310, 34184, 1187, 1600, 366, 11187, 16870, 24629, 2733, 1600, 366, 11505, 25835, 76, 62, 73, 297, 1600, 366, 11505, 22882, 24629, 62, 73, 297, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 69, 15, 65, 535, 69, 4089, 68, 1433, 2425, 4089, 1507, 487, 66, 20, 67, 5607, 330, 18, 1765, 69, 5774, 1765, 3865, 486, 1120, 1, 198, 12303, 312, 796, 366, 27988, 67, 1878, 2791, 12, 2548, 3104, 12, 20, 31115, 12, 24, 7252, 19, 12, 10210, 20964, 67, 24, 2548, 3901, 65, 1, 198, 9641, 796, 366, 16, 13, 23, 13, 16, 1, 198, 198, 30109, 26568, 715, 2977, 14881, 11907, 198, 10378, 82, 796, 14631, 7248, 3245, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2670, 66, 24, 69, 40248, 2481, 2934, 23, 2598, 14774, 17544, 2920, 891, 67, 19, 69, 24, 22047, 68, 22, 276, 3559, 69, 24, 1, 198, 12303, 312, 796, 366, 27192, 67, 38605, 68, 12, 65, 2857, 65, 12, 39226, 64, 12, 1795, 3720, 12, 20, 891, 64, 45191, 66, 27211, 68, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 1415, 1, 198, 198, 30109, 32140, 14881, 11907, 198, 10378, 82, 796, 14631, 7902, 53, 1600, 366, 6601, 35439, 1600, 366, 13856, 320, 863, 25876, 1600, 366, 20344, 6169, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 24941, 263, 1600, 366, 48944, 1600, 366, 29531, 1600, 366, 32140, 35, 931, 1600, 366, 3118, 291, 1098, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 18, 67, 33548, 940, 276, 23, 66, 18, 65, 20, 1453, 30610, 67, 1959, 8054, 23, 2718, 1350, 46438, 20963, 22, 65, 6888, 1, 198, 12303, 312, 796, 366, 67, 15, 1453, 5824, 69, 21, 12, 64, 1954, 67, 12, 4051, 7252, 12, 65, 1350, 24, 12, 22, 69, 48724, 67, 21, 6814, 22, 69, 20, 1, 198, 9641, 796, 366, 17, 13, 21, 13, 15, 1, 198, 198, 30109, 32140, 35, 931, 11907, 198, 10378, 82, 796, 14631, 28100, 9787, 1600, 366, 23579, 10100, 11627, 5736, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 19881, 3609, 1350, 1129, 4763, 2598, 64, 4309, 64, 21, 66, 44673, 67, 2780, 37804, 69, 16, 11848, 1828, 16344, 2919, 4310, 1, 198, 12303, 312, 796, 366, 5607, 1485, 66, 23, 69, 18, 12, 486, 3104, 12, 4051, 65, 20, 12, 49087, 68, 12, 1828, 66, 20, 26276, 3365, 69, 2670, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 15, 1, 198, 198, 30109, 32140, 36674, 11907, 198, 10378, 82, 796, 14631, 7902, 53, 1600, 366, 13856, 320, 863, 25876, 1600, 366, 20344, 6169, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 9069, 660, 9914, 5439, 47384, 902, 1600, 366, 45, 2434, 51, 29291, 33637, 1600, 366, 35422, 1068, 5216, 26448, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 32140, 14881, 1600, 366, 10962, 18843, 602, 1600, 366, 51, 2977, 1600, 366, 3118, 291, 1098, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 4790, 2154, 5824, 67, 2857, 891, 67, 21, 66, 18, 69, 19, 69, 21, 330, 33206, 27824, 1860, 64, 31503, 67, 19, 66, 15, 64, 24, 66, 1, 198, 12303, 312, 796, 366, 66, 1314, 1415, 65, 1959, 12, 67, 18, 64, 15, 12, 20, 23188, 12, 65, 27970, 12, 39885, 66, 3459, 7012, 64, 47325, 1, 198, 9641, 796, 366, 19, 13, 19, 13, 16, 1, 198, 198, 30109, 45442, 11907, 198, 10378, 82, 796, 14631, 1532, 40674, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 68, 22, 15630, 1795, 17896, 6052, 69, 33042, 3553, 64, 20, 67, 16, 68, 18, 66, 23, 1065, 19442, 3365, 4309, 69, 30120, 68, 21, 64, 1, 198, 12303, 312, 796, 366, 8432, 487, 10210, 15, 12, 22, 28977, 12, 19, 66, 324, 12, 4531, 67, 15, 12, 17896, 48200, 69, 4304, 66, 21, 67, 18, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 15, 1, 198, 198, 30109, 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, 18, 66, 4304, 1860, 68, 2414, 67, 48597, 2079, 68, 2998, 19, 330, 2999, 1765, 17, 68, 23, 7012, 23, 24970, 67, 40173, 6814, 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, 17, 13, 1485, 1, 198, 198, 30109, 17126, 19929, 49, 2788, 8040, 11907, 198, 10378, 82, 796, 14631, 31554, 271, 40729, 1600, 366, 7902, 53, 1600, 366, 6601, 35439, 1600, 366, 35, 689, 1600, 366, 20344, 2455, 507, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 24941, 263, 1600, 366, 26227, 889, 1600, 366, 42, 7948, 35, 6377, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 9655, 9655, 1925, 1299, 1600, 366, 9069, 660, 9914, 5439, 47384, 902, 1600, 366, 45, 2434, 3163, 20477, 1600, 366, 45, 2434, 51, 29291, 33637, 1600, 366, 27871, 320, 1600, 366, 35422, 1068, 5216, 26448, 1600, 366, 48944, 1600, 366, 47, 533, 1462, 7556, 5226, 1600, 366, 47, 533, 1462, 7556, 1025, 704, 20939, 590, 16305, 11347, 1600, 366, 35700, 51, 2977, 1600, 366, 29531, 1600, 366, 3041, 39344, 1600, 366, 39618, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 44909, 1523, 24334, 6775, 5841, 1424, 1600, 366, 51, 2977, 1600, 366, 14402, 1600, 366, 3118, 291, 1098, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 4531, 1860, 2682, 66, 20, 3388, 65, 42224, 1453, 940, 66, 23, 1507, 40486, 2598, 4531, 2623, 2670, 66, 4790, 69, 891, 20, 1, 198, 12303, 312, 796, 366, 17, 67, 2931, 7568, 4051, 12, 24, 67, 15, 69, 12, 20, 25600, 12, 6469, 1238, 12, 4051, 66, 17, 64, 18, 67, 19, 69, 20963, 1, 198, 9641, 796, 366, 19, 13, 19, 13, 18, 1, 198, 198, 30109, 17126, 19929, 15721, 896, 11907, 198, 10378, 82, 796, 14631, 23010, 811, 31431, 14881, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 22, 22996, 2624, 66, 3609, 19, 67, 18, 17059, 68, 17, 69, 17, 24294, 17457, 2857, 69, 23, 67, 23, 65, 41544, 18213, 2598, 2670, 1, 198, 12303, 312, 796, 366, 2414, 65, 487, 37128, 12, 1238, 5705, 12, 3559, 6814, 12, 64, 18, 68, 21, 12, 24, 11848, 48524, 486, 66, 15, 66, 24, 1, 198, 9641, 796, 366, 17, 13, 16, 13, 15, 1, 198, 198, 30109, 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, 29668, 17614, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 15, 69, 17, 7252, 23, 68, 2624, 67, 41647, 69, 38569, 64, 17, 344, 2920, 21315, 27057, 69, 3324, 2091, 64, 2931, 2623, 64, 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, 16, 13, 15, 1, 198, 198, 30109, 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, 17, 11848, 15, 21101, 19504, 2075, 64, 39885, 2718, 15277, 1899, 2996, 940, 69, 6888, 3270, 5705, 535, 66, 21, 65, 2425, 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, 1485, 1, 198, 198, 30109, 29668, 37, 13271, 11907, 198, 10378, 82, 796, 14631, 35491, 37766, 14055, 1600, 366, 818, 4399, 24629, 2733, 1600, 366, 23820, 20310, 34184, 1187, 1600, 366, 11187, 16870, 24629, 2733, 1600, 366, 3041, 39344, 1600, 366, 49, 11018, 1600, 366, 13409, 24629, 2733, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 3077, 65, 18, 68, 1558, 535, 16, 67, 5824, 344, 15, 68, 21, 68, 2791, 67, 18, 28485, 2857, 1314, 3720, 3695, 7012, 26429, 1, 198, 12303, 312, 796, 366, 19, 66, 5066, 67, 17, 65, 24, 12, 19, 32066, 12, 4051, 9945, 12, 23, 13227, 12, 1558, 65, 2414, 66, 2670, 68, 3682, 66, 1, 198, 9641, 796, 366, 15, 13, 24, 13, 1415, 1, 198, 198, 30109, 29668, 3646, 1747, 11907, 198, 10378, 82, 796, 14631, 2601, 436, 1586, 1600, 366, 6601, 44909, 942, 1600, 366, 6601, 40161, 1600, 366, 20344, 2455, 507, 1600, 366, 9492, 16104, 602, 1600, 366, 42, 7948, 35, 6377, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 15205, 42524, 29668, 1600, 366, 31310, 712, 2977, 1600, 366, 3646, 1747, 1600, 366, 6690, 18636, 14881, 1600, 366, 6690, 18636, 47, 541, 4470, 1600, 366, 3041, 39344, 1600, 366, 29668, 14881, 1600, 366, 10962, 18843, 602, 1600, 366, 51, 2977, 1600, 366, 54, 312, 11407, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 67, 3388, 3980, 344, 5036, 2718, 2791, 64, 23, 1765, 20, 6888, 3609, 24, 24909, 16817, 11848, 15, 330, 5333, 66, 23, 330, 1, 198, 12303, 312, 796, 366, 69, 18, 65, 22745, 64, 22, 12, 44698, 64, 12, 20, 68, 2154, 12, 65, 28676, 12, 4521, 31675, 67, 3720, 2816, 16344, 1, 198, 9641, 796, 366, 15, 13, 1415, 13, 1959, 1, 198, 198, 30109, 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, 17, 344, 3901, 68, 15, 67, 3023, 17, 66, 1899, 21142, 22042, 68, 24, 21855, 22, 21526, 64, 18, 19881, 324, 19881, 1120, 67, 18, 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, 18, 1, 198, 198, 30109, 44909, 1523, 24334, 6775, 5841, 1424, 11907, 198, 10378, 82, 796, 14631, 7902, 53, 1600, 366, 20575, 20900, 873, 1600, 366, 6601, 35439, 1600, 366, 6601, 44909, 942, 1600, 366, 20344, 2455, 507, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 45, 2434, 3163, 20477, 1600, 366, 3041, 39344, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 17, 487, 16, 67, 1270, 2996, 1795, 3553, 64, 1558, 69, 18, 69, 6888, 16, 891, 33548, 67, 4531, 1157, 3609, 36879, 2791, 68, 1, 198, 12303, 312, 796, 366, 64, 3901, 68, 3134, 2682, 12, 2920, 344, 12, 1821, 2996, 12, 23, 65, 5999, 12, 2001, 2919, 19, 66, 486, 7568, 67, 1, 198, 9641, 796, 366, 16, 13, 16, 13, 15, 1, 198, 198, 30109, 5606, 578, 50, 29572, 11907, 198, 10378, 82, 796, 14631, 25835, 25404, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 32634, 1634, 1600, 366, 50, 29572, 3163, 20477, 8973, 198, 12303, 312, 796, 366, 19, 31980, 65, 15, 69, 15, 12, 3312, 69, 18, 12, 20, 66, 6814, 12, 65, 21, 65, 16, 12, 64, 21, 25272, 64, 1558, 1959, 68, 24, 1, 198, 198, 30109, 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, 10962, 18843, 602, 11907, 198, 10378, 82, 796, 14631, 31837, 20538, 3163, 20477, 1600, 366, 51, 2977, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 68, 34741, 66, 5774, 12993, 17, 64, 16, 17896, 3901, 13331, 1270, 66, 2931, 18, 65, 17, 64, 22337, 3324, 66, 5999, 68, 16, 15630, 16, 1, 198, 12303, 312, 796, 366, 397, 2999, 64, 16, 65, 17, 12, 64, 22, 7568, 12, 1157, 68, 23, 12, 21599, 68, 12, 21855, 1507, 2091, 69, 1120, 65, 5774, 1, 198, 9641, 796, 366, 16, 13, 17, 13, 15, 1, 198, 198, 30109, 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, 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, 19082, 2682, 67, 15, 68, 4869, 65, 24, 1558, 2682, 19881, 15, 64, 22, 68, 940, 1765, 16, 11848, 2713, 27137, 1860, 65, 10210, 15, 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, 15, 1, 198, 198, 30109, 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, 44798, 282, 11187, 5355, 11907, 198, 10378, 82, 796, 14631, 18819, 16424, 11028, 50, 27448, 51, 6037, 1600, 366, 11187, 2667, 1600, 366, 9704, 2902, 1600, 366, 18557, 69, 1600, 366, 32577, 11187, 2667, 1600, 366, 52, 27586, 82, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 48200, 3510, 64, 2780, 64, 21, 10210, 2154, 68, 5066, 7252, 22579, 2598, 65, 23, 66, 19, 891, 2154, 3559, 1899, 67, 4761, 69, 1, 198, 12303, 312, 796, 366, 20, 67, 46302, 65, 5892, 12, 16, 68, 2780, 12, 19, 67, 21, 69, 12, 24, 24309, 12, 21, 65, 2598, 3324, 6888, 24, 3077, 1, 198, 9641, 796, 366, 15, 13, 16, 13, 20, 1, 198, 198, 30109, 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, 35694, 11907, 198, 10378, 82, 796, 14631, 48003, 1600, 366, 28813, 37766, 1600, 366, 39746, 28813, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 14155, 305, 33637, 1600, 366, 6144, 8019, 1600, 366, 26705, 32755, 776, 1600, 366, 18557, 69, 1600, 366, 29531, 1600, 366, 39618, 1600, 366, 13409, 24629, 2733, 1600, 366, 48346, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 19881, 19, 324, 69, 15277, 5237, 1878, 66, 24, 2481, 69, 28072, 1878, 19, 9945, 3365, 69, 3312, 22370, 33580, 14822, 1, 198, 12303, 312, 796, 366, 24, 69, 22, 49287, 324, 12, 4869, 66, 15, 12, 3553, 1765, 12, 24, 69, 22, 69, 12, 65, 20, 66, 24, 68, 21, 67, 2718, 4531, 66, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 1433, 1, 198, 198, 30109, 8291, 66, 7656, 12124, 82, 11907, 198, 10378, 82, 796, 14631, 29531, 1600, 366, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 20666, 65, 3865, 18213, 11442, 65, 3270, 4761, 9945, 2996, 7252, 3829, 69, 3459, 67, 23, 67, 4531, 17896, 65, 3459, 4349, 66, 1, 198, 12303, 312, 796, 366, 18, 11848, 3134, 5036, 23, 12, 6469, 65, 16, 12, 1120, 2078, 12, 23, 68, 2075, 12, 5892, 64, 21, 66, 4051, 26561, 13331, 1, 198, 9641, 796, 366, 15, 13, 24, 13, 21, 1, 198, 198, 30109, 8291, 41213, 11907, 198, 10378, 82, 796, 14631, 48003, 1600, 366, 28100, 9787, 1600, 366, 43984, 43984, 1600, 366, 14881, 1616, 1600, 366, 5377, 1930, 1756, 14881, 1600, 366, 7469, 500, 29974, 1616, 684, 1600, 366, 20344, 6169, 1600, 366, 24243, 40161, 1600, 366, 11187, 2667, 1600, 366, 9704, 2902, 1600, 366, 13031, 5216, 26448, 1600, 366, 39618, 1600, 366, 7248, 3245, 1600, 366, 26568, 715, 2977, 14881, 1600, 366, 51, 2977, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 65, 535, 65, 1314, 3132, 35378, 2598, 67, 35435, 64, 21, 64, 23, 67, 19, 38942, 69, 49721, 6052, 1495, 67, 20, 64, 39506, 1, 198, 12303, 312, 796, 366, 2078, 67, 3553, 64, 5332, 12, 23, 69, 891, 12, 3553, 6420, 12, 65, 5036, 21, 12, 64, 34583, 2078, 68, 22, 66, 17032, 1, 198, 9641, 796, 366, 15, 13, 19, 13, 3134, 1, 198, 198, 30109, 27660, 7680, 82, 11907, 198, 10378, 82, 796, 14631, 14402, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 67, 15, 67, 22, 64, 18, 5036, 17, 69, 1270, 67, 21, 64, 22, 69, 48634, 64, 20, 69, 1129, 69, 22, 66, 22, 64, 20, 65, 34107, 68, 3609, 21, 1, 198, 12303, 312, 796, 366, 64, 17, 64, 2791, 3865, 66, 12, 65, 3901, 65, 12, 20, 65, 22, 67, 12, 8432, 24, 12, 9945, 69, 2934, 44977, 20, 67, 22, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 15, 1, 198, 198, 30109, 51, 724, 952, 11907, 198, 10378, 82, 796, 14631, 35491, 37766, 14055, 1600, 366, 28813, 37766, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 39618, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 15, 25270, 65, 22, 64, 31010, 16072, 39226, 49234, 65, 1878, 38219, 38942, 5824, 68, 19, 69, 2078, 19881, 721, 2996, 1, 198, 12303, 312, 796, 366, 15630, 2780, 1453, 5332, 12, 1959, 64, 19, 12, 20, 25061, 12, 3609, 15, 65, 12, 64, 2414, 68, 1433, 486, 67, 19, 15630, 1, 198, 9641, 796, 366, 15, 13, 18, 13, 17, 1, 198, 198, 30109, 51, 870, 11907, 198, 10378, 82, 796, 14631, 23839, 9655, 9655, 1600, 366, 28809, 39, 9655, 1600, 366, 28809, 36208, 1600, 366, 28809, 3705, 1600, 366, 28809, 12861, 1600, 366, 43984, 43984, 1600, 366, 23286, 752, 669, 1600, 366, 6601, 44909, 942, 1600, 366, 20344, 2455, 507, 1600, 366, 20344, 2455, 507, 2885, 1600, 366, 23579, 10100, 11627, 5736, 1600, 366, 44090, 47, 6489, 1600, 366, 30639, 10257, 605, 11122, 501, 16305, 11347, 1600, 366, 39746, 28813, 1600, 366, 25835, 35943, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 9655, 9655, 1925, 1299, 1600, 366, 45, 2434, 3163, 20477, 1600, 366, 18557, 69, 1600, 366, 29531, 1600, 366, 3041, 39344, 1600, 366, 39618, 1600, 366, 50, 979, 5805, 14881, 1600, 366, 13409, 24629, 2733, 1600, 366, 48346, 1600, 366, 29668, 14881, 1600, 366, 29668, 37, 13271, 1600, 366, 35694, 1600, 366, 57, 35641, 1258, 37766, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 66, 1821, 68, 330, 486, 64, 3510, 65, 23, 891, 66, 23, 1878, 24, 2780, 30763, 64, 47448, 67, 21, 68, 4051, 65, 35638, 67, 1, 198, 12303, 312, 796, 366, 69, 344, 20, 5036, 6469, 12, 20, 3901, 64, 12, 3270, 64, 21, 12, 324, 69, 23, 12, 43916, 66, 2414, 65, 20, 69, 24, 64, 15, 1, 198, 9641, 796, 366, 15, 13, 1129, 13, 15, 1, 198, 198, 30109, 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, 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, 3118, 11869, 11907, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 32220, 66, 16, 69, 22, 32128, 1828, 3132, 68, 4521, 68, 15, 66, 24, 66, 20, 34938, 344, 18, 65, 19, 64, 15, 64, 24, 64, 15, 66, 17, 65, 1, 198, 12303, 312, 796, 366, 18, 64, 40353, 276, 21, 12, 3132, 891, 12, 2857, 67, 22, 12, 24, 67, 17, 64, 12, 5066, 24294, 66, 2920, 2078, 276, 1, 198, 9641, 796, 366, 16, 13, 15, 13, 17, 1, 198, 198, 30109, 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, 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, 38469, 1634, 14881, 11907, 198, 10378, 82, 796, 14631, 19182, 39317, 1600, 366, 8697, 2937, 388, 6874, 1600, 366, 17932, 36037, 23595, 1600, 366, 39, 86, 17946, 1600, 366, 1532, 40674, 1600, 366, 32517, 18833, 20193, 1600, 366, 25835, 25404, 1600, 366, 14993, 451, 2348, 29230, 1600, 366, 48913, 24544, 9497, 1600, 366, 45442, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1558, 68, 3365, 2857, 11848, 27824, 1270, 67, 24, 2919, 486, 17279, 21142, 15, 344, 1821, 3901, 64, 18, 1860, 68, 4521, 1, 198, 12303, 312, 796, 366, 18, 67, 20, 1860, 2919, 66, 12, 16344, 24, 67, 12, 1157, 68, 23, 12, 1558, 13331, 12, 276, 2078, 15277, 2780, 66, 17, 69, 1, 198, 9641, 796, 366, 15, 13, 2481, 13, 1828, 1, 198, 198, 30109, 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, 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, 44898, 8134, 13290, 654, 11907, 198, 10378, 82, 796, 14631, 6601, 17614, 1600, 366, 818, 1370, 13290, 654, 1600, 366, 47, 945, 364, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 66, 3388, 69, 24, 6814, 18, 487, 17, 69, 19, 69, 2999, 68, 23, 1157, 66, 2091, 1954, 66, 1828, 68, 20, 7568, 21101, 46352, 12993, 64, 1, 198, 12303, 312, 796, 366, 18213, 940, 67, 33319, 12, 18, 69, 4790, 12, 4349, 69, 23, 12, 64, 2075, 66, 12, 2091, 66, 16, 21101, 35273, 7252, 20, 1, 198, 9641, 796, 366, 16, 13, 19, 13, 16, 1, 198, 198, 30109, 54, 312, 11407, 11907, 198, 10378, 82, 796, 14631, 5216, 669, 1600, 366, 35, 689, 1600, 366, 31310, 712, 2977, 1600, 366, 35422, 1068, 5216, 26448, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 1795, 47159, 69, 3270, 67, 27800, 20964, 2624, 19924, 66, 22, 2718, 3720, 69, 23, 1350, 535, 1129, 64, 16616, 69, 17, 1, 198, 12303, 312, 796, 366, 535, 23, 15630, 19, 64, 23, 12, 1983, 67, 21, 12, 3553, 3388, 12, 64, 6052, 65, 12, 24, 67, 24, 1485, 68, 3388, 7252, 5237, 1, 198, 9641, 796, 366, 15, 13, 21, 13, 19, 1, 198, 198, 30109, 22911, 10711, 19044, 45977, 11907, 198, 10378, 82, 796, 14631, 14993, 451, 2348, 29230, 1600, 366, 50, 29572, 3163, 20477, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 2934, 3134, 13331, 3270, 68, 2091, 324, 21599, 64, 3270, 405, 2816, 22318, 64, 1270, 65, 1954, 66, 1821, 22579, 67, 18, 1, 198, 12303, 312, 796, 366, 891, 344, 18, 69, 3104, 12, 2791, 17896, 12, 3365, 2548, 12, 24, 16102, 12, 1983, 64, 21, 67, 21, 69, 20, 69, 24, 65, 21, 1, 198, 9641, 796, 366, 15, 13, 20, 13, 20, 1, 198, 198, 30109, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 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, 535, 19, 19881, 18, 69, 1860, 68, 23, 65, 22, 68, 18, 68, 24, 13331, 15, 35273, 17457, 2308, 7012, 16, 12993, 18, 65, 22, 69, 21, 68, 21, 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, 15, 10, 15, 1, 198, 198, 30109, 57, 35641, 1258, 37766, 11907, 198, 10378, 82, 796, 14631, 14155, 305, 33637, 8973, 198, 18300, 12, 21048, 12, 26270, 16, 796, 366, 23, 66, 16, 64, 23, 68, 19, 7568, 330, 65, 16, 16344, 5066, 1558, 2231, 40427, 66, 23, 9945, 2327, 67, 15, 11275, 2931, 18213, 15, 1, 198, 12303, 312, 796, 366, 9879, 2934, 16, 64, 20, 12, 9945, 2231, 12, 3510, 15630, 12, 2079, 12993, 12, 2548, 1238, 2154, 4089, 65, 30272, 1, 198, 9641, 796, 366, 15, 13, 17, 13, 17, 1, 198, 198, 30109, 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, 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, 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, 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, 66, 2231, 69, 19, 68, 1821, 68, 22, 64, 8635, 24, 67, 2919, 21, 29088, 68, 2816, 40401, 2857, 721, 23, 65, 3865, 64, 23, 21855, 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, 15, 1, 198, 198, 30109, 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, 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, 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, 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, 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, 68, 43564, 67, 23628, 12, 17, 65, 23, 64, 12, 3559, 65, 19, 12, 65, 2079, 67, 12, 22996, 68, 2414, 12993, 1959, 67, 20, 198, 2, 2343, 243, 254, 28670, 19, 65, 28978, 66, 4349, 12, 66, 23, 2598, 12, 19, 68, 2414, 12, 5332, 68, 19, 12, 64, 19, 69, 22, 18213, 49234, 16072, 24, 198, 2, 2343, 243, 254, 28670, 2425, 344, 4051, 65, 24, 12, 65, 41531, 12, 39226, 64, 12, 65, 2154, 68, 12, 397, 20, 23148, 7568, 19708, 69, 198, 2, 2343, 243, 254, 28670, 3324, 64, 2154, 31552, 12, 13331, 3865, 12, 19, 65, 1485, 12, 65, 44980, 12, 35038, 67, 16, 64, 6420, 69, 1314, 64, 198, 2, 2343, 243, 253, 7280, 69, 24, 487, 1954, 18213, 12, 69, 7568, 17, 12, 19, 67, 2780, 12, 11848, 5705, 12, 4089, 69, 1821, 9945, 23, 35642, 68, 198, 2, 2343, 243, 253, 7280, 23, 2481, 65, 10210, 2996, 12, 19, 397, 20, 12, 3559, 68, 23, 12, 23, 2718, 68, 12, 23, 65, 7568, 4846, 69, 1731, 6048, 198, 2, 2343, 243, 254, 28670, 15, 535, 7012, 17, 10210, 12, 66, 940, 66, 12, 2857, 1485, 12, 1795, 68, 16, 12, 3324, 68, 19, 64, 18, 68, 24, 66, 5332, 66, 198, 2, 2343, 243, 254, 28670, 65, 4869, 65, 3270, 21101, 12, 65, 24, 276, 12, 19, 64, 1507, 12, 64, 50055, 12, 7029, 67, 23, 21855, 32642, 1558, 198, 2, 2343, 243, 253, 7280, 21, 26279, 1828, 3132, 12, 3609, 1350, 12, 3559, 15630, 12, 64, 48952, 12, 487, 18, 66, 3720, 2996, 1558, 2670, 198, 2, 2343, 243, 254, 28670, 17, 69, 35642, 15630, 17, 12, 24, 2548, 67, 12, 2231, 65, 19, 12, 64, 24, 276, 12, 1899, 6814, 64, 3365, 2857, 1878, 20, 198, 2, 2343, 243, 253, 7280, 18, 69, 50150, 68, 3388, 12, 35844, 68, 12, 19, 397, 24, 12, 24, 2682, 69, 12, 65, 2713, 69, 1731, 69, 1238, 64, 4089, 198, 2, 2343, 243, 254, 28670, 64, 39121, 2154, 64, 24, 12, 33660, 66, 12, 19, 68, 5892, 12, 4531, 16, 65, 12, 1899, 3553, 9945, 330, 16, 68, 486, 198, 2, 2343, 243, 253, 7280, 68, 2425, 38205, 2327, 12, 2998, 397, 12, 19, 65, 3388, 12, 23, 28645, 12, 69, 2075, 67, 11785, 2816, 69, 344, 198, 2, 2343, 243, 253, 7280, 67, 28324, 16, 324, 24, 12, 19, 33660, 12, 2857, 68, 23, 12, 64, 1453, 19, 12, 24, 66, 2327, 66, 1350, 2078, 68, 2327, 198, 2, 2343, 243, 254, 28670, 6052, 1828, 67, 26429, 12, 24, 1765, 67, 12, 19, 1860, 23, 12, 42250, 67, 12, 5999, 1828, 69, 19, 69, 34483, 4869, 198, 2, 2343, 243, 253, 7280, 22, 67, 5824, 64, 22, 69, 16, 12, 22, 344, 20, 12, 19, 69, 21, 64, 12, 7012, 4761, 12, 15, 64, 23, 64, 24, 66, 2934, 2598, 68, 24, 198, 2, 2343, 243, 253, 7280, 1129, 67, 1485, 35667, 12, 6052, 64, 15, 12, 19, 64, 6052, 12, 65, 18, 11848, 12, 21, 68, 1270, 67, 18, 67, 24, 2682, 64, 18, 198, 2, 2343, 243, 254, 28670, 1959, 64, 16, 64, 42240, 12, 49542, 65, 12, 19, 32182, 12, 42240, 68, 12, 24, 69, 19244, 7012, 30695, 65, 24, 198, 2, 2343, 243, 254, 28670, 68, 18, 535, 24693, 65, 12, 2079, 5607, 12, 3901, 65, 21, 12, 23, 27728, 12, 16, 65, 3720, 68, 2598, 2598, 39380, 198, 2, 2343, 243, 253, 7280, 21101, 42224, 2816, 67, 12, 3559, 64, 21, 12, 19, 69, 891, 12, 24, 2624, 69, 12, 1485, 66, 39305, 7568, 24, 2998, 64, 198, 2, 2343, 243, 254, 28670, 22, 67, 1959, 21101, 1878, 12, 17, 65, 1983, 12, 19, 65, 19, 68, 12, 23, 67, 1453, 12, 4524, 64, 15, 2920, 26200, 69, 7012, 198, 2, 2343, 243, 253, 7280, 24, 67, 3134, 2780, 2996, 12, 18, 19082, 12, 2780, 64, 21, 12, 64, 43587, 12, 67, 39647, 3609, 24, 67, 22, 34938, 198, 2, 2343, 243, 254, 28670, 7252, 24, 1350, 46957, 12, 66, 18, 17896, 12, 19, 68, 19, 64, 12, 24, 26598, 12, 4521, 1350, 2414, 1495, 1821, 6888, 198, 2, 2343, 243, 253, 7280, 68, 5333, 67, 6659, 276, 12, 4304, 16, 64, 12, 17885, 65, 12, 24, 18213, 15, 12, 1485, 4089, 64, 24, 330, 23, 68, 1828, 198, 2, 2343, 243, 254, 28670, 64, 4524, 65, 30290, 67, 12, 69, 1765, 66, 12, 1821, 65, 16, 12, 24, 39111, 12, 18, 67, 5066, 65, 22, 67, 28645, 65, 17, 198, 2, 2343, 243, 253, 7280, 19, 17896, 23, 7252, 16, 65, 12, 2425, 2598, 12, 19, 64, 1795, 12, 24, 14454, 12, 64, 17, 66, 3829, 1821, 67, 6052, 2481, 198, 2, 2343, 243, 253, 7280, 68, 21, 64, 18, 67, 42018, 12, 3553, 67, 17, 12, 1821, 7252, 12, 65, 4869, 67, 12, 23, 13227, 20, 9945, 24409, 67, 24, 198, 2, 2343, 243, 254, 28670, 487, 24, 3553, 69, 4310, 12, 9945, 66, 22, 12, 2780, 5332, 12, 24, 44673, 12, 5333, 67, 940, 65, 23, 67, 330, 1314, 198, 2, 2343, 243, 253, 7280, 3312, 67, 20, 66, 23, 65, 22, 12, 22, 64, 5774, 12, 19, 1860, 65, 12, 24, 66, 1270, 12, 67, 21, 67, 46872, 64, 45720, 1415, 198, 2, 2343, 243, 254, 28670, 68, 1959, 6048, 16, 64, 12, 23, 3829, 67, 12, 19, 68, 2481, 12, 64, 26115, 12, 67, 3559, 1157, 17457, 23, 2231, 67, 18, 198, 2, 2343, 243, 254, 28670, 2167, 69, 15, 68, 3459, 12, 65, 1270, 69, 12, 19, 64, 330, 12, 64, 49995, 12, 64, 1495, 69, 20, 64, 4309, 66, 20, 67, 23, 198, 2, 2343, 243, 254, 28670, 69, 15630, 6814, 32114, 12, 17, 68, 3459, 12, 19, 64, 2920, 12, 65, 1731, 65, 12, 1558, 4531, 43356, 1433, 3682, 68, 198, 2, 2343, 243, 253, 7280, 69, 3134, 67, 38612, 64, 12, 68, 3980, 67, 12, 26200, 66, 12, 23, 69, 2481, 12, 67, 19, 68, 2718, 68, 23, 67, 397, 3682, 198, 2, 2343, 243, 253, 7280, 1899, 64, 21652, 7568, 12, 15, 37466, 12, 19, 64, 3510, 12, 65, 18938, 12, 30460, 1821, 2154, 4790, 397, 21, 198, 2, 2343, 243, 254, 28670, 24, 67, 21, 1878, 67, 2713, 12, 2996, 2154, 12, 2598, 68, 15, 12, 23, 65, 2920, 12, 20, 68, 19, 15630, 22, 68, 23, 64, 4304, 69, 198, 2, 2343, 243, 253, 7280, 66, 5036, 3134, 68, 24, 69, 12, 3901, 11848, 12, 45068, 69, 12, 4846, 7012, 12, 2078, 1959, 2075, 2934, 3132, 64, 17, 198, 2, 2343, 243, 254, 28670, 23, 29416, 65, 24, 69, 19, 12, 22, 13331, 20, 12, 19, 69, 2548, 12, 24, 65, 2548, 12, 3609, 2682, 68, 19, 66, 1899, 68, 5999, 198, 2, 2343, 243, 253, 7280, 19, 68, 5824, 12993, 3270, 12, 6659, 1765, 12, 19, 65, 2079, 12, 65, 47202, 12, 35126, 69, 4051, 13331, 1453, 1314, 198, 2, 2343, 243, 254, 28670, 32059, 6469, 67, 2713, 12, 24, 68, 2624, 12, 40090, 66, 12, 64, 22136, 12, 1795, 6659, 68, 15, 69, 1860, 20964, 198, 2, 2343, 243, 253, 7280, 68, 23, 1860, 40873, 68, 12, 65, 5824, 67, 12, 44103, 66, 12, 24, 65, 15, 65, 12, 48000, 3104, 1558, 65, 1238, 5824, 198, 2, 2343, 243, 254, 28670, 65, 1795, 68, 20, 487, 18, 12, 43489, 64, 12, 42018, 66, 12, 24, 36879, 12, 40035, 69, 20, 65, 15, 65, 4531, 22, 68, 198, 2, 2343, 243, 253, 7280, 65, 32417, 3324, 5774, 12, 2670, 2780, 12, 40149, 66, 12, 1350, 22, 68, 12, 3388, 66, 43356, 1485, 4521, 65, 21, 198, 2, 2343, 243, 253, 7280, 67, 43704, 65, 1860, 67, 12, 24, 20107, 12, 33289, 68, 12, 397, 4089, 12, 1821, 69, 22, 66, 3829, 68, 40873, 69, 198, 2, 2343, 243, 254, 28670, 18, 69, 19, 64, 18, 65, 22, 66, 12, 17, 9945, 22, 12, 19, 67, 22, 65, 12, 7410, 64, 12, 66, 19442, 3104, 64, 46957, 2816, 198, 2, 2343, 243, 253, 7280, 17, 67, 17, 7252, 18, 891, 12, 23, 21855, 22, 12, 19, 66, 3388, 12, 3459, 3388, 12, 3682, 68, 1129, 2670, 17896, 31027, 198, 2, 2343, 243, 253, 7280, 5333, 65, 20, 68, 21, 64, 23, 12, 18, 7012, 64, 12, 3901, 486, 12, 24, 64, 2481, 12, 20, 67, 2920, 1878, 3559, 65, 5036, 22, 198, 2, 2343, 243, 254, 28670, 2327, 69, 1495, 67, 16, 68, 12, 24409, 65, 12, 40271, 69, 12, 24, 22572, 12, 18, 66, 3270, 4790, 397, 1065, 2078, 198, 2, 2343, 243, 253, 7280, 19, 68, 1238, 324, 5824, 12, 18938, 16, 12, 19, 65, 4531, 12, 65, 1959, 68, 12, 23, 64, 44750, 68, 49995, 68, 3070, 198, 2, 2343, 243, 254, 28670, 276, 45987, 45839, 12, 21, 21101, 18, 12, 1821, 64, 18, 12, 24, 69, 15, 64, 12, 47372, 68, 15187, 2548, 16562, 198, 2, 2343, 243, 253, 7280, 65, 1495, 66, 15, 65, 22, 64, 12, 2598, 3388, 12, 2920, 2231, 12, 1350, 2078, 12, 19881, 65, 17, 66, 1828, 15197, 6888, 198, 2, 2343, 243, 254, 28670, 23, 64, 15, 25710, 535, 12, 19, 69, 15, 66, 12, 32576, 64, 12, 64, 23, 66, 21, 12, 535, 69, 17, 65, 2079, 276, 405, 69, 198, 2, 2343, 243, 253, 7280, 39322, 9945, 20, 64, 23, 12, 22730, 64, 12, 3682, 67, 16, 12, 24, 64, 891, 12, 66, 3865, 69, 1821, 2079, 64, 18, 13331, 198, 2, 2343, 243, 254, 28670, 15, 17457, 22, 9945, 5036, 12, 15, 40523, 12, 1821, 67, 19, 12, 23, 16344, 15, 12, 16, 16344, 36720, 65, 17, 276, 66, 17, 198, 2, 2343, 243, 253, 7280, 20, 2682, 69, 15, 66, 4310, 12, 6814, 23, 65, 12, 19, 6814, 20, 12, 6659, 67, 19, 12, 66, 15, 397, 18, 344, 65, 20233, 65, 198, 2, 2343, 243, 254, 28670, 64, 2078, 1453, 22, 11848, 12, 67, 24, 67, 22, 12, 3559, 18213, 12, 48634, 69, 12, 2414, 1899, 64, 17, 12993, 2425, 3720, 198, 2, 2343, 243, 253, 7280, 2231, 2327, 66, 4869, 69, 12, 1350, 22, 66, 12, 3901, 68, 23, 12, 46899, 65, 12, 3553, 27693, 66, 5999, 68, 29022, 198, 2, 2343, 243, 253, 7280, 69, 2670, 10210, 2816, 69, 12, 276, 23, 69, 12, 35133, 68, 12, 44230, 68, 12, 69, 16, 68, 1433, 65, 3695, 67, 24, 1860, 198, 2, 2343, 243, 254, 28670, 10210, 24, 4869, 69, 7252, 12, 27936, 64, 12, 19, 344, 64, 12, 64, 1157, 64, 12, 15, 21101, 2078, 69, 18, 68, 28771, 22, 198, 2, 2343, 243, 253, 7280, 64, 24, 69, 1765, 891, 18, 12, 3312, 67, 15, 12, 2231, 4309, 12, 23, 36993, 12, 17, 69, 20986, 344, 24760, 2857, 198, 2, 2343, 243, 254, 28670, 22, 65, 1495, 3459, 67, 17, 12, 67, 4521, 67, 12, 2598, 21855, 12, 4089, 3865, 12, 67, 49259, 2078, 2425, 15630, 2857, 198, 2, 2343, 243, 253, 7280, 535, 5607, 69, 19, 67, 24, 12, 324, 405, 12, 19, 67, 17, 66, 12, 65, 31211, 12, 1238, 4869, 65, 24, 12993, 4521, 69, 21, 198, 2, 2343, 243, 254, 28670, 21, 3132, 11848, 3070, 65, 12, 405, 64, 20, 12, 42199, 64, 12, 1350, 15, 67, 12, 2623, 69, 4521, 64, 5607, 2481, 7252, 198, 2, 2343, 243, 254, 28670, 3865, 17896, 2791, 67, 21, 12, 39885, 64, 12, 19, 65, 15, 66, 12, 65, 4531, 67, 12, 35133, 64, 1828, 7568, 721, 6469, 198, 2, 2343, 243, 254, 28670, 66, 2816, 2154, 19881, 16, 12, 66, 3023, 67, 12, 3901, 68, 18, 12, 65, 23, 3609, 12, 21, 68, 21, 67, 330, 2231, 21101, 2154, 198, 2, 2343, 243, 254, 28670, 23, 69, 24, 2231, 69, 21, 66, 12, 1495, 5333, 12, 42117, 65, 12, 8432, 65, 12, 18, 31115, 67, 17, 66, 19, 65, 45068, 198, 2, 2343, 243, 253, 7280, 21142, 1954, 13331, 18, 12, 69, 1860, 17, 12, 19, 487, 65, 12, 64, 15, 68, 24, 12, 324, 16, 39071, 68, 3023, 67, 1828, 198, 2, 2343, 243, 254, 28670, 69, 940, 68, 26717, 69, 12, 20986, 65, 12, 19, 65, 19, 65, 12, 65, 18, 68, 15, 12, 2791, 1878, 2414, 1270, 7012, 19, 69, 198, 2, 2343, 243, 254, 28670, 19, 66, 2931, 18082, 18, 12, 23, 69, 19, 66, 12, 19, 13331, 17, 12, 6420, 18213, 12, 2079, 65, 5892, 12993, 11848, 44361, 198, 2, 2343, 243, 254, 28670, 16, 69, 17, 66, 20, 30695, 12, 11848, 10210, 12, 19, 21855, 22, 12, 6420, 1270, 12, 24, 66, 21, 344, 11848, 19, 66, 21, 67, 19, 198, 2, 2343, 243, 253, 7280, 48170, 67, 3132, 7012, 12, 3365, 3559, 12, 1821, 64, 22, 12, 324, 3312, 12, 4846, 68, 22, 64, 23, 18213, 3459, 2231, 198, 2, 2343, 243, 254, 28670, 16, 535, 15, 64, 21, 66, 16, 12, 18, 69, 12993, 12, 19, 7568, 18, 12, 64, 23, 67, 24, 12, 7012, 27712, 19, 66, 15, 64, 2718, 65, 198, 2, 2343, 243, 254, 28670, 24, 64, 29143, 6052, 65, 12, 66, 24, 64, 24, 12, 2231, 535, 12, 22260, 20, 12, 4089, 3324, 45331, 65, 2001, 67, 198, 2, 2343, 243, 254, 28670, 21, 64, 22, 18213, 23, 1350, 12, 1350, 64, 17, 12, 3901, 66, 19, 12, 4531, 397, 12, 24, 64, 21, 11848, 12993, 7012, 18298, 198, 2, 2343, 243, 254, 28670, 24, 3682, 68, 18, 69, 1129, 12, 64, 20, 66, 16, 12, 31794, 68, 12, 64, 18, 1350, 12, 2931, 22, 66, 4310, 15630, 22, 34626, 198, 2, 2343, 243, 254, 28670, 21, 6888, 64, 19, 65, 2425, 12, 24, 330, 16, 12, 37747, 65, 12, 64, 19, 65, 17, 12, 2548, 65, 4761, 65, 22416, 68, 3270, 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 ]
1.859007
40,846
using CSV, Distributions, HypothesisTests data = CSV.read("../data/machine1.csv", header=false)[:,1] xBar, n = mean(data), length(data) sig = 1.2 alpha = 0.1 z = quantile(Normal(),1-alpha/2) println("Calculating formula: ", (xBar - z*sig/sqrt(n), xBar + z*sig/sqrt(n))) println("Using confint() function: ", confint(OneSampleZTest(xBar,sig,n),alpha))
[ 3500, 44189, 11, 46567, 507, 11, 21209, 313, 8497, 51, 3558, 198, 198, 7890, 796, 44189, 13, 961, 7203, 40720, 7890, 14, 30243, 16, 13, 40664, 1600, 13639, 28, 9562, 38381, 45299, 16, 60, 198, 87, 10374, 11, 299, 796, 1612, 7, 7890, 828, 4129, 7, 7890, 8, 198, 82, 328, 796, 352, 13, 17, 198, 26591, 796, 657, 13, 16, 198, 89, 796, 5554, 576, 7, 26447, 22784, 16, 12, 26591, 14, 17, 8, 198, 198, 35235, 7203, 9771, 3129, 803, 10451, 25, 33172, 357, 87, 10374, 532, 1976, 9, 82, 328, 14, 31166, 17034, 7, 77, 828, 2124, 10374, 1343, 1976, 9, 82, 328, 14, 31166, 17034, 7, 77, 22305, 198, 35235, 7203, 12814, 1013, 600, 3419, 2163, 25, 33172, 1013, 600, 7, 3198, 36674, 57, 14402, 7, 87, 10374, 11, 82, 328, 11, 77, 828, 26591, 4008, 198 ]
2.503546
141
# Automatically generated using Clang.jl wrap_c, version 0.0.0 const SDL_IMAGE_MAJOR_VERSION = 2 const SDL_IMAGE_MINOR_VERSION = 0 const SDL_IMAGE_PATCHLEVEL = 4 # Skipping MacroDefinition: SDL_IMAGE_VERSION ( X ) \ #{ ( X ) -> major = SDL_IMAGE_MAJOR_VERSION ; ( X ) -> minor = SDL_IMAGE_MINOR_VERSION ; ( X ) -> patch = SDL_IMAGE_PATCHLEVEL ; \ #} # Skipping MacroDefinition: SDL_IMAGE_COMPILEDVERSION SDL_VERSIONNUM ( SDL_IMAGE_MAJOR_VERSION , SDL_IMAGE_MINOR_VERSION , SDL_IMAGE_PATCHLEVEL ) # Skipping MacroDefinition: SDL_IMAGE_VERSION_ATLEAST ( X , Y , Z ) ( SDL_IMAGE_COMPILEDVERSION >= SDL_VERSIONNUM ( X , Y , Z ) ) #const IMG_SetError = SDL_SetError #const IMG_GetError = SDL_GetError # begin enum ANONYMOUS_1 const ANONYMOUS_1 = UInt32 const SDL_FALSE = (UInt32)(0) const SDL_TRUE = (UInt32)(1) const SDL_bool = Bool # end enum ANONYMOUS_1 # begin enum ANONYMOUS_49 const ANONYMOUS_49 = UInt32 const IMG_INIT_JPG = (UInt32)(1) const IMG_INIT_PNG = (UInt32)(2) const IMG_INIT_TIF = (UInt32)(4) const IMG_INIT_WEBP = (UInt32)(8) # end enum ANONYMOUS_49 #$(Expr(:typealias, :IMG_InitFlags, :Void))
[ 2, 17406, 4142, 7560, 1262, 1012, 648, 13, 20362, 14441, 62, 66, 11, 2196, 657, 13, 15, 13, 15, 198, 198, 9979, 45417, 62, 3955, 11879, 62, 5673, 41, 1581, 62, 43717, 796, 362, 198, 9979, 45417, 62, 3955, 11879, 62, 23678, 1581, 62, 43717, 796, 657, 198, 9979, 45417, 62, 3955, 11879, 62, 47, 11417, 2538, 18697, 796, 604, 198, 198, 2, 3661, 4501, 42755, 36621, 25, 45417, 62, 3955, 11879, 62, 43717, 357, 1395, 1267, 3467, 198, 2, 90, 357, 1395, 1267, 4613, 1688, 796, 45417, 62, 3955, 11879, 62, 5673, 41, 1581, 62, 43717, 2162, 357, 1395, 1267, 4613, 4159, 796, 45417, 62, 3955, 11879, 62, 23678, 1581, 62, 43717, 2162, 357, 1395, 1267, 4613, 8529, 796, 45417, 62, 3955, 11879, 62, 47, 11417, 2538, 18697, 2162, 3467, 198, 2, 92, 198, 2, 3661, 4501, 42755, 36621, 25, 45417, 62, 3955, 11879, 62, 9858, 47, 4146, 1961, 43717, 45417, 62, 43717, 41359, 357, 45417, 62, 3955, 11879, 62, 5673, 41, 1581, 62, 43717, 837, 45417, 62, 3955, 11879, 62, 23678, 1581, 62, 43717, 837, 45417, 62, 3955, 11879, 62, 47, 11417, 2538, 18697, 1267, 198, 2, 3661, 4501, 42755, 36621, 25, 45417, 62, 3955, 11879, 62, 43717, 62, 1404, 2538, 11262, 357, 1395, 837, 575, 837, 1168, 1267, 357, 45417, 62, 3955, 11879, 62, 9858, 47, 4146, 1961, 43717, 18189, 45417, 62, 43717, 41359, 357, 1395, 837, 575, 837, 1168, 1267, 1267, 198, 198, 2, 9979, 8959, 38, 62, 7248, 12331, 796, 45417, 62, 7248, 12331, 198, 2, 9979, 8959, 38, 62, 3855, 12331, 796, 45417, 62, 3855, 12331, 198, 198, 2, 2221, 33829, 3537, 40508, 44, 20958, 62, 16, 198, 9979, 3537, 40508, 44, 20958, 62, 16, 796, 471, 5317, 2624, 198, 9979, 45417, 62, 37, 23719, 796, 357, 52, 5317, 2624, 5769, 15, 8, 198, 9979, 45417, 62, 5446, 8924, 796, 357, 52, 5317, 2624, 5769, 16, 8, 198, 9979, 45417, 62, 30388, 796, 347, 970, 198, 198, 2, 886, 33829, 3537, 40508, 44, 20958, 62, 16, 198, 198, 2, 2221, 33829, 3537, 40508, 44, 20958, 62, 2920, 198, 9979, 3537, 40508, 44, 20958, 62, 2920, 796, 471, 5317, 2624, 198, 9979, 8959, 38, 62, 1268, 2043, 62, 41, 6968, 796, 357, 52, 5317, 2624, 5769, 16, 8, 198, 9979, 8959, 38, 62, 1268, 2043, 62, 47, 10503, 796, 357, 52, 5317, 2624, 5769, 17, 8, 198, 9979, 8959, 38, 62, 1268, 2043, 62, 51, 5064, 796, 357, 52, 5317, 2624, 5769, 19, 8, 198, 9979, 8959, 38, 62, 1268, 2043, 62, 8845, 20866, 796, 357, 52, 5317, 2624, 5769, 23, 8, 198, 2, 886, 33829, 3537, 40508, 44, 20958, 62, 2920, 198, 198, 29953, 7, 3109, 1050, 7, 25, 4906, 26011, 11, 1058, 3955, 38, 62, 31768, 40053, 11, 1058, 53, 1868, 4008, 198 ]
2.421739
460
# Constructing Gaussian quadrature weights for an # arbitrary weight function and integration bounds. # for numerical stability, we apply the usual Lanczos # Gram–Schmidt procedure to the basis {T₀,T₁,T₂,…} of # Chebyshev polynomials on [-1,1] rather than to the # textbook monomial basis {1,x,x²,…}. # evaluate Chebyshev polynomial p(x) with coefficients a[i] # by a Clenshaw recurrence. function chebeval(x, a) if length(a) ≤ 2 length(a) == 1 && return a[1] + x * zero(a[1]) return a[1]+x*a[2] end bₖ = a[end-1] + 2x*a[end] bₖ₊₁ = oftype(bₖ, a[end]) for j = lastindex(a)-2:-1:2 bⱼ = a[j] + 2x*bₖ - bₖ₊₁ bₖ, bₖ₊₁ = bⱼ, bₖ end return a[1] + x*bₖ - bₖ₊₁ end # if a[i] are coefficients of Chebyshev series, compute the coefficients xa (in-place) # of the series multiplied by x, using recurrence xTₙ = 0.5 (Tₙ₊₁+Tₙ₋₁) for n > 0 function chebx!(xa, a) resize!(xa, length(a)+1) xa .= 0 for n = 2:lastindex(a) c = 0.5*a[n] xa[n-1] += c xa[n+1] += c end if !isempty(a) xa[2] += a[1] end return xa end """ gauss(W, N, a, b; rtol=sqrt(eps), quad=quadgk) Return a pair `(x, w)` of `N` quadrature points `x[i]` and weights `w[i]` to integrate functions on the interval `(a, b)` multiplied by the weight function `W(x)`. That is, `sum(w .* f.(x))` approximates the integral `∫ W(x)f(x)dx` from `a` to `b`. This function performs `2N` numerical integrals of polynomials against `W(x)` using the integration function `quad` (defaults to `quadgk`) with relative tolerance `rtol` (which defaults to half of the precision `eps` of the endpoints). This is followed by an O(N²) calculations. So, using a large order `N` is expensive. If `W` has lots of singularities that make it hard to integrate numerically, you may need to decrease `rtol`. You can also pass in a specialized quadrature routine via the `quad` keyword argument, which should accept arguments `quad(f,a,b,rtol=_,atol=_)` similar to `quadgk`. (This is useful if your weight function has discontinuities, in which case you might want to break up the integration interval at the discontinuities.) """ function gauss(W, N, a::Real,b::Real; rtol::Real=sqrt(eps(typeof(float(b-a)))), quad=quadgk) (isfinite(a) && isfinite(b)) || throw(ArgumentError("a finite interval is required")) return _gauss(W, N, a, b, rtol, quad) end function _gauss(W, N, a, b, rtol, quad) # Uses the Lanczos recurrence described in Trefethen & Bau, # Numerical Linear Algebra, to find the `N`-point Gaussian quadrature # using O(N) integrals and O(N²) operations, applied to Chebyshev basis: xscale = 2.0/(b-a) # scaling from (a,b) to (-1,1) T = typeof(xscale) α = zeros(T, N) β = zeros(T, N) q₀ = sizehint!(T[0], N+1) # 0 polynomial wint = first(quad(W, a, b, rtol=rtol)) (wint isa Real && wint > 0) || throw(ArgumentError("weight W must be real and positive")) atol = rtol*wint q₁ = sizehint!(T[1/sqrt(wint)],N+1) # normalized constant polynomial v = copy(q₀) for n = 1:N chebx!(v, q₁) # v = x * q₁ α[n] = first(quad(a, b, rtol=rtol, atol=atol) do x t = (x-a)*xscale - 1 W(x) * chebeval(t, q₁) * chebeval(t, v) end) n == N && break for j = 1:length(q₀); v[j] -= β[n]*q₀[j]; end for j = 1:length(q₁); v[j] -= α[n]*q₁[j]; end β[n+1] = sqrt(first(quad(a, b, rtol=rtol, atol=atol) do x W(x) * chebeval((x-a)*xscale - 1, v)^2 end)) v .*= inv(β[n+1]) q₀,q₁,v = q₁,v,q₀ end # TODO: handle BigFloat etcetera — requires us to update eignewt() to # support nonzero diagonal entries. E = eigen(SymTridiagonal(α, β[2:N])) w = E.vectors[1,:] w .= wint .* abs2.(w) return ((E.values .+ 1) ./ xscale .+ a, w) end
[ 2, 28407, 278, 12822, 31562, 15094, 81, 1300, 19590, 329, 281, 198, 2, 14977, 3463, 2163, 290, 11812, 22303, 13, 198, 198, 2, 329, 29052, 10159, 11, 356, 4174, 262, 6678, 21534, 37925, 198, 2, 20159, 1906, 14874, 21184, 8771, 284, 262, 4308, 1391, 51, 158, 224, 222, 11, 51, 158, 224, 223, 11, 51, 158, 224, 224, 11, 1399, 92, 286, 198, 2, 2580, 48209, 258, 85, 745, 6213, 296, 8231, 319, 25915, 16, 11, 16, 60, 2138, 621, 284, 262, 198, 2, 28979, 937, 49070, 4308, 1391, 16, 11, 87, 11, 87, 31185, 11, 1399, 27422, 198, 198, 2, 13446, 2580, 48209, 258, 85, 745, 6213, 49070, 279, 7, 87, 8, 351, 44036, 257, 58, 72, 60, 198, 2, 416, 257, 1012, 641, 26615, 664, 33928, 13, 198, 8818, 1125, 1350, 2100, 7, 87, 11, 257, 8, 198, 220, 220, 220, 611, 4129, 7, 64, 8, 41305, 362, 198, 220, 220, 220, 220, 220, 220, 220, 4129, 7, 64, 8, 6624, 352, 11405, 1441, 257, 58, 16, 60, 1343, 2124, 1635, 6632, 7, 64, 58, 16, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 257, 58, 16, 48688, 87, 9, 64, 58, 17, 60, 198, 220, 220, 220, 886, 198, 220, 220, 220, 275, 158, 224, 244, 796, 257, 58, 437, 12, 16, 60, 1343, 362, 87, 9, 64, 58, 437, 60, 198, 220, 220, 220, 275, 158, 224, 244, 158, 224, 232, 158, 224, 223, 796, 286, 4906, 7, 65, 158, 224, 244, 11, 257, 58, 437, 12962, 198, 220, 220, 220, 329, 474, 796, 938, 9630, 7, 64, 13219, 17, 21912, 16, 25, 17, 198, 220, 220, 220, 220, 220, 220, 220, 275, 158, 109, 120, 796, 257, 58, 73, 60, 1343, 362, 87, 9, 65, 158, 224, 244, 532, 275, 158, 224, 244, 158, 224, 232, 158, 224, 223, 198, 220, 220, 220, 220, 220, 220, 220, 275, 158, 224, 244, 11, 275, 158, 224, 244, 158, 224, 232, 158, 224, 223, 796, 275, 158, 109, 120, 11, 275, 158, 224, 244, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 257, 58, 16, 60, 1343, 2124, 9, 65, 158, 224, 244, 532, 275, 158, 224, 244, 158, 224, 232, 158, 224, 223, 198, 437, 198, 198, 2, 611, 257, 58, 72, 60, 389, 44036, 286, 2580, 48209, 258, 85, 2168, 11, 24061, 262, 44036, 2124, 64, 357, 259, 12, 5372, 8, 198, 2, 286, 262, 2168, 33096, 416, 2124, 11, 1262, 664, 33928, 2124, 51, 158, 224, 247, 796, 657, 13, 20, 357, 51, 158, 224, 247, 158, 224, 232, 158, 224, 223, 10, 51, 158, 224, 247, 158, 224, 233, 158, 224, 223, 8, 329, 299, 1875, 657, 198, 8818, 1125, 65, 87, 0, 7, 27865, 11, 257, 8, 198, 220, 220, 220, 47558, 0, 7, 27865, 11, 4129, 7, 64, 47762, 16, 8, 198, 220, 220, 220, 2124, 64, 764, 28, 657, 198, 220, 220, 220, 329, 299, 796, 362, 25, 12957, 9630, 7, 64, 8, 198, 220, 220, 220, 220, 220, 220, 220, 269, 796, 657, 13, 20, 9, 64, 58, 77, 60, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 64, 58, 77, 12, 16, 60, 15853, 269, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 64, 58, 77, 10, 16, 60, 15853, 269, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 5145, 271, 28920, 7, 64, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 64, 58, 17, 60, 15853, 257, 58, 16, 60, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 2124, 64, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 31986, 1046, 7, 54, 11, 399, 11, 257, 11, 275, 26, 374, 83, 349, 28, 31166, 17034, 7, 25386, 828, 15094, 28, 47003, 70, 74, 8, 198, 198, 13615, 257, 5166, 4600, 7, 87, 11, 266, 8, 63, 286, 4600, 45, 63, 15094, 81, 1300, 2173, 4600, 87, 58, 72, 60, 63, 290, 19590, 4600, 86, 58, 72, 60, 63, 284, 198, 18908, 4873, 5499, 319, 262, 16654, 4600, 7, 64, 11, 275, 8, 63, 33096, 416, 262, 3463, 2163, 198, 63, 54, 7, 87, 8, 44646, 220, 1320, 318, 11, 4600, 16345, 7, 86, 764, 9, 277, 12195, 87, 4008, 63, 5561, 26748, 262, 19287, 4600, 24861, 104, 370, 7, 87, 8, 69, 7, 87, 8, 34350, 63, 198, 6738, 4600, 64, 63, 284, 4600, 65, 44646, 198, 198, 1212, 2163, 17706, 4600, 17, 45, 63, 29052, 4132, 30691, 286, 745, 6213, 296, 8231, 1028, 4600, 54, 7, 87, 8, 63, 198, 3500, 262, 11812, 2163, 4600, 47003, 63, 357, 12286, 82, 284, 4600, 47003, 70, 74, 63, 8, 351, 3585, 15621, 4600, 17034, 349, 63, 198, 7, 4758, 26235, 284, 2063, 286, 262, 15440, 4600, 25386, 63, 286, 262, 886, 13033, 737, 198, 1212, 318, 3940, 416, 281, 440, 7, 45, 31185, 8, 16765, 13, 1406, 11, 1262, 257, 1588, 1502, 4600, 45, 63, 318, 5789, 13, 198, 198, 1532, 4600, 54, 63, 468, 6041, 286, 18032, 871, 326, 787, 340, 1327, 284, 19386, 5470, 1146, 11, 198, 5832, 743, 761, 284, 10070, 4600, 17034, 349, 44646, 220, 220, 921, 460, 635, 1208, 287, 257, 16976, 15094, 81, 1300, 8027, 198, 8869, 262, 4600, 47003, 63, 21179, 4578, 11, 543, 815, 2453, 7159, 4600, 47003, 7, 69, 11, 64, 11, 65, 11, 17034, 349, 28, 62, 11, 265, 349, 28, 62, 8, 63, 198, 38610, 284, 4600, 47003, 70, 74, 44646, 220, 357, 1212, 318, 4465, 611, 534, 3463, 2163, 468, 19936, 84, 871, 11, 287, 543, 198, 7442, 345, 1244, 765, 284, 2270, 510, 262, 11812, 16654, 379, 262, 19936, 84, 871, 2014, 198, 37811, 198, 8818, 31986, 1046, 7, 54, 11, 399, 11, 257, 3712, 15633, 11, 65, 3712, 15633, 26, 374, 83, 349, 3712, 15633, 28, 31166, 17034, 7, 25386, 7, 4906, 1659, 7, 22468, 7, 65, 12, 64, 22305, 828, 15094, 28, 47003, 70, 74, 8, 198, 220, 220, 220, 357, 4468, 9504, 7, 64, 8, 11405, 318, 69, 9504, 7, 65, 4008, 8614, 3714, 7, 28100, 1713, 12331, 7203, 64, 27454, 16654, 318, 2672, 48774, 198, 220, 220, 220, 1441, 4808, 4908, 1046, 7, 54, 11, 399, 11, 257, 11, 275, 11, 374, 83, 349, 11, 15094, 8, 198, 437, 198, 198, 8818, 4808, 4908, 1046, 7, 54, 11, 399, 11, 257, 11, 275, 11, 374, 83, 349, 11, 15094, 8, 198, 220, 220, 220, 1303, 36965, 262, 21534, 37925, 664, 33928, 3417, 287, 4700, 34045, 831, 1222, 347, 559, 11, 198, 220, 220, 220, 1303, 399, 6975, 605, 44800, 978, 29230, 11, 284, 1064, 262, 4600, 45, 63, 12, 4122, 12822, 31562, 15094, 81, 1300, 198, 220, 220, 220, 1303, 1262, 440, 7, 45, 8, 4132, 30691, 290, 440, 7, 45, 31185, 8, 4560, 11, 5625, 284, 2580, 48209, 258, 85, 4308, 25, 198, 220, 220, 220, 2124, 9888, 796, 362, 13, 15, 29006, 65, 12, 64, 8, 1303, 20796, 422, 357, 64, 11, 65, 8, 284, 13841, 16, 11, 16, 8, 198, 220, 220, 220, 309, 796, 2099, 1659, 7, 87, 9888, 8, 198, 220, 220, 220, 26367, 796, 1976, 27498, 7, 51, 11, 399, 8, 198, 220, 220, 220, 27169, 796, 1976, 27498, 7, 51, 11, 399, 8, 198, 220, 220, 220, 10662, 158, 224, 222, 796, 2546, 71, 600, 0, 7, 51, 58, 15, 4357, 399, 10, 16, 8, 1303, 657, 745, 6213, 49070, 198, 220, 220, 220, 266, 600, 796, 717, 7, 47003, 7, 54, 11, 257, 11, 275, 11, 374, 83, 349, 28, 17034, 349, 4008, 198, 220, 220, 220, 357, 86, 600, 318, 64, 6416, 11405, 266, 600, 1875, 657, 8, 8614, 198, 220, 220, 220, 220, 220, 220, 220, 3714, 7, 28100, 1713, 12331, 7203, 6551, 370, 1276, 307, 1103, 290, 3967, 48774, 198, 220, 220, 220, 379, 349, 796, 374, 83, 349, 9, 86, 600, 198, 220, 220, 220, 10662, 158, 224, 223, 796, 2546, 71, 600, 0, 7, 51, 58, 16, 14, 31166, 17034, 7, 86, 600, 8, 4357, 45, 10, 16, 8, 1303, 39279, 6937, 745, 6213, 49070, 198, 220, 220, 220, 410, 796, 4866, 7, 80, 158, 224, 222, 8, 198, 220, 220, 220, 329, 299, 796, 352, 25, 45, 198, 220, 220, 220, 220, 220, 220, 220, 1125, 65, 87, 0, 7, 85, 11, 10662, 158, 224, 223, 8, 1303, 410, 796, 2124, 1635, 10662, 158, 224, 223, 198, 220, 220, 220, 220, 220, 220, 220, 26367, 58, 77, 60, 796, 717, 7, 47003, 7, 64, 11, 275, 11, 374, 83, 349, 28, 17034, 349, 11, 379, 349, 28, 265, 349, 8, 466, 2124, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 256, 796, 357, 87, 12, 64, 27493, 87, 9888, 532, 352, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 370, 7, 87, 8, 1635, 1125, 1350, 2100, 7, 83, 11, 10662, 158, 224, 223, 8, 1635, 1125, 1350, 2100, 7, 83, 11, 410, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 8, 198, 220, 220, 220, 220, 220, 220, 220, 299, 6624, 399, 11405, 2270, 198, 220, 220, 220, 220, 220, 220, 220, 329, 474, 796, 352, 25, 13664, 7, 80, 158, 224, 222, 1776, 410, 58, 73, 60, 48185, 27169, 58, 77, 60, 9, 80, 158, 224, 222, 58, 73, 11208, 886, 198, 220, 220, 220, 220, 220, 220, 220, 329, 474, 796, 352, 25, 13664, 7, 80, 158, 224, 223, 1776, 410, 58, 73, 60, 48185, 26367, 58, 77, 60, 9, 80, 158, 224, 223, 58, 73, 11208, 886, 198, 220, 220, 220, 220, 220, 220, 220, 27169, 58, 77, 10, 16, 60, 796, 19862, 17034, 7, 11085, 7, 47003, 7, 64, 11, 275, 11, 374, 83, 349, 28, 17034, 349, 11, 379, 349, 28, 265, 349, 8, 466, 2124, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 370, 7, 87, 8, 1635, 1125, 1350, 2100, 19510, 87, 12, 64, 27493, 87, 9888, 532, 352, 11, 410, 8, 61, 17, 198, 220, 220, 220, 220, 220, 220, 220, 886, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 410, 764, 9, 28, 800, 7, 26638, 58, 77, 10, 16, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 10662, 158, 224, 222, 11, 80, 158, 224, 223, 11, 85, 796, 10662, 158, 224, 223, 11, 85, 11, 80, 158, 224, 222, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1303, 16926, 46, 25, 5412, 4403, 43879, 3503, 2357, 64, 851, 4433, 514, 284, 4296, 304, 570, 413, 83, 3419, 284, 198, 220, 220, 220, 1303, 220, 220, 220, 220, 220, 220, 1104, 1729, 22570, 40039, 12784, 13, 198, 220, 220, 220, 412, 796, 304, 9324, 7, 43094, 2898, 19830, 27923, 7, 17394, 11, 27169, 58, 17, 25, 45, 60, 4008, 628, 220, 220, 220, 266, 796, 412, 13, 303, 5217, 58, 16, 11, 47715, 198, 220, 220, 220, 266, 764, 28, 266, 600, 764, 9, 2352, 17, 12195, 86, 8, 198, 220, 220, 220, 1441, 14808, 36, 13, 27160, 764, 10, 352, 8, 24457, 2124, 9888, 764, 10, 257, 11, 266, 8, 198, 437, 198 ]
2.099567
1,848
import Base.Dates: trunc, DatePeriod, TimePeriod import Base.Dates: firstdayofweek, lastdayofweek, firstdayofmonth, lastdayofmonth, firstdayofyear, lastdayofyear, firstdayofquarter, lastdayofquarter # Truncation # TODO: Just utilize floor code for truncation? function trunc{P<:DatePeriod}(zdt::ZonedDateTime, ::Type{P}) ZonedDateTime(trunc(localtime(zdt), P), timezone(zdt)) end function trunc{P<:TimePeriod}(zdt::ZonedDateTime, ::Type{P}) local_dt = trunc(localtime(zdt), P) utc_dt = local_dt - zdt.zone.offset ZonedDateTime(utc_dt, timezone(zdt); from_utc=true) end trunc(zdt::ZonedDateTime, ::Type{Millisecond}) = zdt # Adjusters for prefix in ("firstdayof", "lastdayof"), suffix in ("week", "month", "year", "quarter") func = Symbol(prefix * suffix) @eval begin $func(dt::ZonedDateTime) = ZonedDateTime($func(localtime(dt)), dt.timezone) end end
[ 11748, 7308, 13, 35, 689, 25, 40122, 11, 7536, 5990, 2101, 11, 3862, 5990, 2101, 198, 11748, 7308, 13, 35, 689, 25, 717, 820, 1659, 10464, 11, 938, 820, 1659, 10464, 11, 717, 820, 1659, 8424, 11, 938, 820, 1659, 8424, 11, 198, 220, 220, 220, 717, 820, 1659, 1941, 11, 938, 820, 1659, 1941, 11, 717, 820, 1659, 24385, 11, 938, 820, 1659, 24385, 628, 198, 2, 833, 19524, 341, 198, 2, 16926, 46, 25, 2329, 17624, 4314, 2438, 329, 40122, 341, 30, 198, 8818, 40122, 90, 47, 27, 25, 10430, 5990, 2101, 92, 7, 89, 28664, 3712, 57, 12004, 10430, 7575, 11, 7904, 6030, 90, 47, 30072, 198, 220, 220, 220, 1168, 12004, 10430, 7575, 7, 2213, 19524, 7, 12001, 2435, 7, 89, 28664, 828, 350, 828, 640, 11340, 7, 89, 28664, 4008, 198, 437, 198, 8818, 40122, 90, 47, 27, 25, 7575, 5990, 2101, 92, 7, 89, 28664, 3712, 57, 12004, 10430, 7575, 11, 7904, 6030, 90, 47, 30072, 198, 220, 220, 220, 1957, 62, 28664, 796, 40122, 7, 12001, 2435, 7, 89, 28664, 828, 350, 8, 198, 220, 220, 220, 3384, 66, 62, 28664, 796, 1957, 62, 28664, 532, 1976, 28664, 13, 11340, 13, 28968, 198, 220, 220, 220, 1168, 12004, 10430, 7575, 7, 315, 66, 62, 28664, 11, 640, 11340, 7, 89, 28664, 1776, 422, 62, 315, 66, 28, 7942, 8, 198, 437, 198, 2213, 19524, 7, 89, 28664, 3712, 57, 12004, 10430, 7575, 11, 7904, 6030, 90, 22603, 27866, 623, 30072, 796, 1976, 28664, 198, 198, 2, 20292, 364, 198, 1640, 21231, 287, 5855, 11085, 820, 1659, 1600, 366, 12957, 820, 1659, 12340, 35488, 287, 5855, 10464, 1600, 366, 8424, 1600, 366, 1941, 1600, 366, 24385, 4943, 198, 220, 220, 220, 25439, 796, 38357, 7, 40290, 1635, 35488, 8, 198, 220, 220, 220, 2488, 18206, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 720, 20786, 7, 28664, 3712, 57, 12004, 10430, 7575, 8, 796, 1168, 12004, 10430, 7575, 16763, 20786, 7, 12001, 2435, 7, 28664, 36911, 288, 83, 13, 2435, 11340, 8, 198, 220, 220, 220, 886, 198, 437, 198 ]
2.576369
347
v0 = [] v1 = [] v2 = [] v3 = [] v4 = [] function d() while length(v0) > 0 side = v0[length(v0)] if side == 0 step = v1[length(v1)] while step > 0 move!(robot, Sud) step -= 1 end pop!(v1) elseif side == 1 step = v2[length(v2)] while step > 0 move!(robot, West) step -= 1 end pop!(v2) elseif side == 2 step = v3[length(v3)] while step > 0 move!(robot, Nord) step -= 1 end pop!(v3) else step = v4[length(v4)] while step > 0 move!(robot, Ost) step -= 1 end pop!(v4) end pop!(v0) end end function f() while !isborder(robot, Nord) || !isborder(robot, West) step = 0 while !isborder(robot, Nord) move!(robot, Nord) step += 1 end push!(v0, 0) push!(v1, step) step = 0 while !isborder(robot, West) move!(robot, West) step += 1 end push!(v0, 3) push!(v4, step) end putmarker!(robot) d() while !isborder(robot, Nord) || !isborder(robot, Ost) step = 0 while !isborder(robot, Nord) move!(robot, Nord) step += 1 end push!(v0, 0) push!(v1, step) step = 0 while !isborder(robot, Ost) move!(robot, Ost) step += 1 end push!(v0, 1) push!(v2, step) end putmarker!(robot) d() while !isborder(robot, Sud) || !isborder(robot, Ost) step = 0 while !isborder(robot, Sud) move!(robot, Sud) step += 1 end push!(v0, 2) push!(v3, step) step = 0 while !isborder(robot, Ost) move!(robot, Ost) step += 1 end push!(v0, 1) push!(v2, step) end putmarker!(robot) d() while !isborder(robot, Sud) || !isborder(robot, West) step = 0 while !isborder(robot, Sud) move!(robot, Sud) step += 1 end push!(v0, 2) push!(v3, step) step = 0 while !isborder(robot, West) move!(robot, West) step += 1 end push!(v0, 3) push!(v4, step) end putmarker!(robot) d() end f()
[ 85, 15, 796, 17635, 201, 198, 85, 16, 796, 17635, 201, 198, 85, 17, 796, 17635, 201, 198, 85, 18, 796, 17635, 201, 198, 85, 19, 796, 17635, 201, 198, 201, 198, 8818, 288, 3419, 201, 198, 220, 220, 220, 981, 4129, 7, 85, 15, 8, 1875, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 1735, 796, 410, 15, 58, 13664, 7, 85, 15, 15437, 201, 198, 220, 220, 220, 220, 220, 220, 220, 611, 1735, 6624, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 410, 16, 58, 13664, 7, 85, 16, 15437, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 981, 2239, 1875, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 14818, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 48185, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1461, 0, 7, 85, 16, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 1735, 6624, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 410, 17, 58, 13664, 7, 85, 17, 15437, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 981, 2239, 1875, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 48185, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1461, 0, 7, 85, 17, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 1735, 6624, 362, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 410, 18, 58, 13664, 7, 85, 18, 15437, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 981, 2239, 1875, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 18687, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 48185, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1461, 0, 7, 85, 18, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 410, 19, 58, 13664, 7, 85, 19, 15437, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 981, 2239, 1875, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 48185, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1461, 0, 7, 85, 19, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 1461, 0, 7, 85, 15, 8, 201, 198, 220, 220, 220, 886, 201, 198, 437, 201, 198, 201, 198, 8818, 277, 3419, 201, 198, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 18687, 8, 8614, 5145, 271, 20192, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 18687, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 18687, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 657, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 16, 11, 2239, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 513, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 19, 11, 2239, 8, 201, 198, 220, 220, 220, 886, 201, 198, 220, 220, 220, 1234, 4102, 263, 0, 7, 305, 13645, 8, 201, 198, 220, 220, 220, 288, 3419, 201, 198, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 18687, 8, 8614, 5145, 271, 20192, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 18687, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 18687, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 657, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 16, 11, 2239, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 352, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 17, 11, 2239, 8, 201, 198, 220, 220, 220, 886, 201, 198, 220, 220, 220, 1234, 4102, 263, 0, 7, 305, 13645, 8, 201, 198, 220, 220, 220, 288, 3419, 201, 198, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 14818, 8, 8614, 5145, 271, 20192, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 14818, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 14818, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 362, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 18, 11, 2239, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 38919, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 352, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 17, 11, 2239, 8, 201, 198, 220, 220, 220, 886, 201, 198, 220, 220, 220, 1234, 4102, 263, 0, 7, 305, 13645, 8, 201, 198, 220, 220, 220, 288, 3419, 201, 198, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 14818, 8, 8614, 5145, 271, 20192, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 14818, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 14818, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 362, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 18, 11, 2239, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 2239, 796, 657, 201, 198, 220, 220, 220, 220, 220, 220, 220, 981, 5145, 271, 20192, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1445, 0, 7, 305, 13645, 11, 2688, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2239, 15853, 352, 201, 198, 220, 220, 220, 220, 220, 220, 220, 886, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 15, 11, 513, 8, 201, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 85, 19, 11, 2239, 8, 201, 198, 220, 220, 220, 886, 201, 198, 220, 220, 220, 1234, 4102, 263, 0, 7, 305, 13645, 8, 201, 198, 220, 220, 220, 288, 3419, 201, 198, 437, 201, 198, 201, 198, 69, 3419 ]
1.548851
1,740
using MPSGE using Test using MPSGE.JuMP.Containers @testset "MPSGE" begin @testset "TWOBYTWO (functional version)" begin m = Model() inputcoeff = add!(m, Parameter(:inputcoeff, value=2.)) endow = add!(m, Parameter(:endow, value=2.)) elascoeff = add!(m, Parameter(:elascoeff, value=2.)) outputmult = add!(m, Parameter(:outputmult, value=2.)) X = add!(m, Sector(:X)) Y = add!(m, Sector(:Y)) U = add!(m, Sector(:U)) PX = add!(m, Commodity(:PX)) PY = add!(m, Commodity(:PY)) PU = add!(m, Commodity(:PU)) PL = add!(m, Commodity(:PL)) PK = add!(m, Commodity(:PK)) RA = add!(m, Consumer(:RA, benchmark=150.)) add!(m, Production(X, 1, [Output(PX, 100)], [Input(PL, :(25 * $inputcoeff)), Input(PK, 50)])) add!(m, Production(Y, :(0.5 * $elascoeff), [Output(PY, 50)], [Input(PL, 20), Input(PK, 30)])) add!(m, Production(U, 1, [Output(PU, :(75 * $outputmult))], [Input(PX, 100), Input(PY, 50)])) add!(m, DemandFunction(RA, [Demand(PU,150)], [Endowment(PL, :(35 * $endow)), Endowment(PK, 80)])) avm = algebraic_version(m) @test typeof(avm) == MPSGE.AlgebraicWrapper solve!(m) @test value(m, :X) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:Y]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:U]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:RA]) ≈ 150. @test MPSGE.Complementarity.result_value(m._jump_model[:PX]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PY]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PU]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PL]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PK]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†X")]) ≈ 50. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†Y")]) ≈ 20. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†X")]) ≈ 50. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†Y")]) ≈ 30. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PX†U")]) ≈ 100. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PY†U")]) ≈ 50. avm2 = algebraic_version(m) @test typeof(avm2) == MPSGE.AlgebraicWrapper # For now just run these functions, we might add tests for the results # at a later point repr(MIME("text/plain"), m) repr(MIME("text/plain"), avm2) repr(MIME("text/latex"), avm2) set_fixed!(PX, true) set_value(endow, 2.2) solve!(m) @test value(m, :X) ≈ 1.04880885 @test MPSGE.Complementarity.result_value(m._jump_model[:Y]) ≈ 1.03886012 @test MPSGE.Complementarity.result_value(m._jump_model[:U]) ≈ 1.04548206 @test MPSGE.Complementarity.result_value(m._jump_model[:RA]) ≈ 157.321327225523 @test MPSGE.Complementarity.result_value(m._jump_model[:PX]) ≈ 1.0000000000 @test MPSGE.Complementarity.result_value(m._jump_model[:PY]) ≈ 1.00957658 @test MPSGE.Complementarity.result_value(m._jump_model[:PU]) ≈ 1.00318206 @test MPSGE.Complementarity.result_value(m._jump_model[:PL]) ≈ 0.95346259 @test MPSGE.Complementarity.result_value(m._jump_model[:PK]) ≈ 1.04880885 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†X")]) ≈ 52.4404424085075 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†Y")]) ≈ 21.1770570584356 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†X")]) ≈ 47.6731294622795 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†Y")]) ≈ 28.877805079685 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PX†U")]) ≈ 100.318205802571 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PY†U")]) ≈ 49.6833066029729 end @testset "TWOBYTWO (macro version)" begin m = Model() inputcoeff = @parameter(m, inputcoeff, 2.) endow = @parameter(m, endow, 2.) elascoeff = @parameter(m, elascoeff, 2.) outputmult = @parameter(m, outputmult, 2.) @sector(m, X) @sector(m, Y) @sector(m, U) @commodity(m, PX) @commodity(m, PY) @commodity(m, PU) @commodity(m, PL) @commodity(m, PK) @consumer(m, RA, benchmark=150.) @production(m, X, 1, [Output(PX, 100)], [Input(PL, :(25 * $inputcoeff)), Input(PK, 50)]) @production(m, Y, :(0.5 * $elascoeff), [Output(PY, 50)], [Input(PL, 20), Input(PK, 30)]) @production(m, U, 1, [Output(PU, :(75 * $outputmult))], [Input(PX, 100), Input(PY, 50)]) @demand(m, RA, [Demand(PU, 150)], [Endowment(PL, :(35 * $endow)), Endowment(PK, 80)]) avm = algebraic_version(m) @test typeof(avm) == MPSGE.AlgebraicWrapper solve!(m) @test value(m, :X) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:Y]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:U]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:RA]) ≈ 150. @test MPSGE.Complementarity.result_value(m._jump_model[:PX]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PY]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PU]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PL]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PK]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†X")]) ≈ 50. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†Y")]) ≈ 20. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†X")]) ≈ 50. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†Y")]) ≈ 30. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PX†U")]) ≈ 100. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PY†U")]) ≈ 50. avm2 = algebraic_version(m) @test typeof(avm2) == MPSGE.AlgebraicWrapper # For now just run these functions, we might add tests for the results # at a later point repr(MIME("text/plain"), m) repr(MIME("text/plain"), avm2) repr(MIME("text/latex"), avm2) set_fixed!(PX, true) set_value(endow, 2.2) solve!(m) @test value(m, :X) ≈ 1.04880885 @test MPSGE.Complementarity.result_value(m._jump_model[:Y]) ≈ 1.03886012 @test MPSGE.Complementarity.result_value(m._jump_model[:U]) ≈ 1.04548206 @test MPSGE.Complementarity.result_value(m._jump_model[:RA]) ≈ 157.321327225523 @test MPSGE.Complementarity.result_value(m._jump_model[:PX]) ≈ 1.0000000000 @test MPSGE.Complementarity.result_value(m._jump_model[:PY]) ≈ 1.00957658 @test MPSGE.Complementarity.result_value(m._jump_model[:PU]) ≈ 1.00318206 @test MPSGE.Complementarity.result_value(m._jump_model[:PL]) ≈ 0.95346259 @test MPSGE.Complementarity.result_value(m._jump_model[:PK]) ≈ 1.04880885 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†X")]) ≈ 52.4404424085075 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PL†Y")]) ≈ 21.1770570584356 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†X")]) ≈ 47.6731294622795 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PK†Y")]) ≈ 28.877805079685 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PX†U")]) ≈ 100.318205802571 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PY†U")]) ≈ 49.6833066029729 end @testset "TWOBYTWO (indexed version)" begin m = Model() goods = [:x, :y] factors = [:l, :k] factor = DenseAxisArray(Float64[50 50; 20 30], goods, factors) supply = DenseAxisArray(Float64[100, 50], goods) @parameter(m, endow, 1.0) Y = add!(m, Sector(:Y, indices=(goods,))) U = add!(m, Sector(:U)) PC = add!(m, Commodity(:PC, indices=(goods,))) PU = add!(m, Commodity(:PU)) PF = add!(m, Commodity(:PF, indices=(factors,))) RA = add!(m, Consumer(:RA, benchmark=150.)) for i in goods @production(m, Y[i], 1, [Output(PC[i], supply[i])], [Input(PF[:l], factor[i,:l]), Input(PF[:k], factor[i,:k])]) end @production(m, U, 1, [Output(PU, 150)], [Input(PC[:x], 100), Input(PC[:y], 50)]) @demand(m, RA, [Demand(PU, 150)], [Endowment(PF[:l], :(70 * $endow)), Endowment(PF[:k], 80.)]) solve!(m, cumulative_iteration_limit=0) @test MPSGE.Complementarity.result_value(m._jump_model[:Y][:x]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:Y][:y]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:U]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:RA]) ≈ 150. @test MPSGE.Complementarity.result_value(m._jump_model[:PC][:x]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PC][:y]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PU]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:l]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:k]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†Y[x]")]) ≈ 50. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†Y[y]")]) ≈ 20. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†Y[x]")]) ≈ 50. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†Y[y]")]) ≈ 30. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PC[x]†U")]) ≈ 100. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PC[y]†U")]) ≈ 50. set_fixed!(PC[:x], true) set_value(endow, 1.1) solve!(m) @test MPSGE.Complementarity.result_value(m._jump_model[:Y][:x]) ≈ 1.04880885 @test MPSGE.Complementarity.result_value(m._jump_model[:Y][:y]) ≈ 1.03886012 @test MPSGE.Complementarity.result_value(m._jump_model[:U]) ≈ 1.04548206 @test MPSGE.Complementarity.result_value(m._jump_model[:RA]) ≈ 157.321327225523 @test MPSGE.Complementarity.result_value(m._jump_model[:PC][:x]) ≈ 1.0000000000 @test MPSGE.Complementarity.result_value(m._jump_model[:PC][:y]) ≈ 1.00957658 @test MPSGE.Complementarity.result_value(m._jump_model[:PU]) ≈ 1.00318206 @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:l]) ≈ 0.95346259 @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:k]) ≈ 1.04880885 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†Y[x]")]) ≈ 52.4404424085075 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†Y[y]")]) ≈ 21.1770570584356 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†Y[x]")]) ≈ 47.6731294622795 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†Y[y]")]) ≈ 28.877805079685 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PC[x]†U")]) ≈ 100.318205802571 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PC[y]†U")]) ≈ 49.6833066029729 end @testset "JPMGE (Joint Production Intermediate Demand)" begin m = Model() goods = [:g1, :g2] factors = [:l, :k] sectors = [:s1, :s2] make0 = DenseAxisArray(Float64[6 2; 2 10], goods, sectors) use0 = DenseAxisArray(Float64[4 2; 2 6], goods, sectors) fd0 = DenseAxisArray(Float64[1 3; 1 1], factors, sectors) c0 = DenseAxisArray(Float64[2, 4], goods) e0 = DenseAxisArray(Float64[sum(fd0[f,:]) for f in factors], factors) @parameter(m, endow, 1.0) X = add!(m, Sector(:X, indices=(sectors,))) P = add!(m, Commodity(:P, indices=(goods,))) PF = add!(m, Commodity(:PF, indices=(factors,))) Y = add!(m, Consumer(:Y, benchmark=sum(fd0))) for j in sectors @production(m, X[j], 1, [Output(P[i], make0[i,j]) for i in goods], [[Input(P[i], use0[i,j]) for i in goods]; [Input(PF[f], fd0[f,j]) for f in factors]]) end @demand(m, Y, [Demand(P[i], c0[i]) for i in goods], [Endowment(PF[:k], e0[:k]), Endowment(PF[:l], :($(endow) * $(e0[:l]))) ]) avm = algebraic_version(m) @test typeof(avm) == MPSGE.AlgebraicWrapper solve!(m) @test MPSGE.Complementarity.result_value(m._jump_model[:X][:s1]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:X][:s2]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:P][:g1]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:P][:g2]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:l]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:k]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[:Y]) ≈ 6. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]‡X[s1]")]) ≈ 6. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]‡X[s1]")]) ≈ 2. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]‡X[s2]")]) ≈ 2. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]‡X[s2]")]) ≈10. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]†X[s1]")]) ≈ 4. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]†X[s1]")]) ≈ 2. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†X[s1]")]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†X[s1]")]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]†X[s2]")]) ≈ 2. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]†X[s2]")]) ≈ 6. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†X[s2]")]) ≈ 3. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†X[s2]")]) ≈ 1. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]ρY")]) ≈ 2. @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]ρY")]) ≈ 4. solve!(m) #Counter-factual set_value(endow, 1.1) set_value(Y, 6.4) set_fixed!(Y, true) solve!(m) @test MPSGE.Complementarity.result_value(m._jump_model[:X][:s1]) ≈ 0.99692562 @test MPSGE.Complementarity.result_value(m._jump_model[:X][:s2]) ≈ 1.09975731 @test MPSGE.Complementarity.result_value(m._jump_model[:P][:g1]) ≈ 1.01306317 @test MPSGE.Complementarity.result_value(m._jump_model[:P][:g2]) ≈ 0.99467892 @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:l]) ≈ 0.97665932 @test MPSGE.Complementarity.result_value(m._jump_model[:PF][:k]) ≈ 1.0513495 @test MPSGE.Complementarity.result_value(m._jump_model[:Y]) ≈ 6.4 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]‡X[s1]")]) ≈ 6.0271570795595 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]‡X[s1]")]) ≈ 1.97259368637181 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]‡X[s2]")]) ≈ 2.03066186698742 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]‡X[s2]")]) ≈ 9.96905522562002 #note - digits after 9.969 added from MPSGE.jl results bc GAMS not showing @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]†X[s1]")]) ≈ 3.98197684247759 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]†X[s1]")]) ≈ 2.02778707866119 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†X[s1]")]) ≈ 1.03260012599366 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†X[s1]")]) ≈ 0.959241925360056 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]†X[s2]")]) ≈ 1.96980110341978 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]†X[s2]")]) ≈ 6.018624497730061 #note - digits after 6.0186 added from MPSGE.jl results bc GAMS not showing @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[l]†X[s2]")]) ≈ 3.06483480444652 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("PF[k]†X[s2]")]) ≈ 0.94903406 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g1]ρY")]) ≈ 2.1058245831306 @test MPSGE.Complementarity.result_value(m._jump_model[Symbol("P[g2]ρY")]) ≈ 4.28949135539776 end end
[ 3500, 337, 3705, 8264, 198, 3500, 6208, 198, 3500, 337, 3705, 8264, 13, 33018, 7378, 13, 4264, 50221, 198, 198, 31, 9288, 2617, 366, 44, 3705, 8264, 1, 2221, 628, 220, 220, 220, 2488, 9288, 2617, 366, 34551, 9864, 56, 34551, 46, 357, 45124, 2196, 16725, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 285, 796, 9104, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 5128, 1073, 14822, 796, 751, 0, 7, 76, 11, 25139, 2357, 7, 25, 15414, 1073, 14822, 11, 1988, 28, 17, 2014, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 322, 796, 751, 0, 7, 76, 11, 25139, 2357, 7, 25, 437, 322, 11, 1988, 28, 17, 2014, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1288, 292, 1073, 14822, 796, 751, 0, 7, 76, 11, 25139, 2357, 7, 25, 417, 292, 1073, 14822, 11, 1988, 28, 17, 2014, 8, 198, 220, 220, 220, 220, 220, 220, 220, 5072, 16680, 796, 751, 0, 7, 76, 11, 25139, 2357, 7, 25, 22915, 16680, 11, 1988, 28, 17, 2014, 8, 628, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 1395, 796, 751, 0, 7, 76, 11, 25892, 7, 25, 55, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 575, 796, 751, 0, 7, 76, 11, 25892, 7, 25, 56, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 471, 796, 751, 0, 7, 76, 11, 25892, 7, 25, 52, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 350, 55, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 47, 55, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 350, 56, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 47, 56, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 24676, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 5105, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 9297, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 6489, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 29673, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 40492, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 17926, 796, 751, 0, 7, 76, 11, 18110, 7, 25, 3861, 11, 18335, 28, 8628, 2014, 8, 628, 220, 220, 220, 220, 220, 220, 220, 751, 0, 7, 76, 11, 19174, 7, 55, 11, 352, 11, 685, 26410, 7, 47, 55, 11, 1802, 8, 4357, 685, 20560, 7, 6489, 11, 36147, 1495, 1635, 720, 15414, 1073, 14822, 36911, 23412, 7, 40492, 11, 2026, 15437, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 751, 0, 7, 76, 11, 19174, 7, 56, 11, 36147, 15, 13, 20, 1635, 720, 417, 292, 1073, 14822, 828, 685, 26410, 7, 47, 56, 11, 2026, 8, 4357, 685, 20560, 7, 6489, 11, 1160, 828, 23412, 7, 40492, 11, 1542, 15437, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 751, 0, 7, 76, 11, 19174, 7, 52, 11, 352, 11, 685, 26410, 7, 5105, 11, 36147, 2425, 1635, 720, 22915, 16680, 4008, 4357, 685, 20560, 7, 47, 55, 11, 1802, 828, 23412, 7, 47, 56, 11, 2026, 15437, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 751, 0, 7, 76, 11, 34479, 22203, 7, 3861, 11, 685, 42782, 7, 5105, 11, 8628, 8, 4357, 685, 12915, 36569, 7, 6489, 11, 36147, 2327, 1635, 720, 437, 322, 36911, 5268, 36569, 7, 40492, 11, 4019, 15437, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 1196, 76, 796, 37139, 291, 62, 9641, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 2099, 1659, 7, 615, 76, 8, 6624, 337, 3705, 8264, 13, 2348, 29230, 291, 36918, 2848, 628, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 1988, 7, 76, 11, 1058, 55, 8, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 52, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 3861, 12962, 15139, 230, 6640, 13, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 55, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 56, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5105, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 6489, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 40492, 12962, 15139, 230, 352, 13, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 55, 4943, 12962, 15139, 230, 2026, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 56, 4943, 12962, 15139, 230, 1160, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 55, 4943, 12962, 15139, 230, 2026, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 56, 4943, 12962, 15139, 230, 1542, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 55, 33912, 52, 4943, 12962, 15139, 230, 1802, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 56, 33912, 52, 4943, 12962, 15139, 230, 2026, 13, 628, 220, 220, 220, 220, 220, 220, 220, 1196, 76, 17, 796, 37139, 291, 62, 9641, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 2099, 1659, 7, 615, 76, 17, 8, 6624, 337, 3705, 8264, 13, 2348, 29230, 291, 36918, 2848, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 1114, 783, 655, 1057, 777, 5499, 11, 356, 1244, 751, 5254, 329, 262, 2482, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 379, 257, 1568, 966, 198, 220, 220, 220, 220, 220, 220, 220, 41575, 7, 44, 12789, 7203, 5239, 14, 25638, 12340, 285, 8, 198, 220, 220, 220, 220, 220, 220, 220, 41575, 7, 44, 12789, 7203, 5239, 14, 25638, 12340, 1196, 76, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 41575, 7, 44, 12789, 7203, 5239, 14, 17660, 87, 12340, 1196, 76, 17, 8, 628, 220, 220, 220, 220, 220, 220, 220, 900, 62, 34021, 0, 7, 47, 55, 11, 2081, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 8367, 7, 437, 322, 11, 362, 13, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 1988, 7, 76, 11, 1058, 55, 8, 15139, 230, 352, 13, 47202, 1795, 44230, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 12962, 15139, 230, 352, 13, 15, 2548, 4521, 30206, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 52, 12962, 15139, 230, 352, 13, 40350, 2780, 22136, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 3861, 12962, 15139, 230, 23313, 13, 2624, 1485, 29807, 13381, 1954, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 55, 12962, 15139, 230, 352, 13, 8269, 405, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 56, 12962, 15139, 230, 352, 13, 28694, 3553, 38431, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5105, 12962, 15139, 230, 352, 13, 11245, 1507, 22136, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 6489, 12962, 15139, 230, 657, 13, 3865, 30557, 25191, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 40492, 12962, 15139, 230, 352, 13, 47202, 1795, 44230, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 55, 4943, 12962, 15139, 230, 6740, 13, 25644, 2598, 1731, 2919, 1120, 2425, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 56, 4943, 12962, 15139, 230, 2310, 13, 1558, 34801, 2154, 46352, 32066, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 55, 4943, 12962, 15139, 230, 6298, 13, 45758, 18741, 3510, 1828, 41544, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 56, 4943, 12962, 15139, 230, 2579, 13, 42802, 1795, 1120, 3720, 35978, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 55, 33912, 52, 4943, 12962, 15139, 230, 1802, 13, 36042, 21261, 1795, 1495, 4869, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 56, 33912, 52, 4943, 12962, 15139, 230, 5125, 13, 47521, 20548, 1899, 26561, 1959, 198, 220, 220, 220, 886, 628, 220, 220, 220, 2488, 9288, 2617, 366, 34551, 9864, 56, 34551, 46, 357, 20285, 305, 2196, 16725, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 285, 796, 9104, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 5128, 1073, 14822, 796, 2488, 17143, 2357, 7, 76, 11, 5128, 1073, 14822, 11, 362, 2014, 198, 220, 220, 220, 220, 220, 220, 220, 886, 322, 796, 2488, 17143, 2357, 7, 76, 11, 886, 322, 11, 362, 2014, 198, 220, 220, 220, 220, 220, 220, 220, 1288, 292, 1073, 14822, 796, 2488, 17143, 2357, 7, 76, 11, 1288, 292, 1073, 14822, 11, 362, 2014, 198, 220, 220, 220, 220, 220, 220, 220, 5072, 16680, 796, 2488, 17143, 2357, 7, 76, 11, 5072, 16680, 11, 362, 2014, 628, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 34914, 7, 76, 11, 1395, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 34914, 7, 76, 11, 575, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 34914, 7, 76, 11, 471, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 785, 4666, 414, 7, 76, 11, 350, 55, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 785, 4666, 414, 7, 76, 11, 350, 56, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 785, 4666, 414, 7, 76, 11, 24676, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 785, 4666, 414, 7, 76, 11, 9297, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 785, 4666, 414, 7, 76, 11, 29673, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 49827, 7, 76, 11, 17926, 11, 18335, 28, 8628, 2014, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 25493, 7, 76, 11, 1395, 11, 352, 11, 685, 26410, 7, 47, 55, 11, 1802, 8, 4357, 685, 20560, 7, 6489, 11, 36147, 1495, 1635, 720, 15414, 1073, 14822, 36911, 23412, 7, 40492, 11, 2026, 8, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 25493, 7, 76, 11, 575, 11, 36147, 15, 13, 20, 1635, 720, 417, 292, 1073, 14822, 828, 685, 26410, 7, 47, 56, 11, 2026, 8, 4357, 685, 20560, 7, 6489, 11, 1160, 828, 23412, 7, 40492, 11, 1542, 8, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 25493, 7, 76, 11, 471, 11, 352, 11, 685, 26410, 7, 5105, 11, 36147, 2425, 1635, 720, 22915, 16680, 4008, 4357, 685, 20560, 7, 47, 55, 11, 1802, 828, 23412, 7, 47, 56, 11, 2026, 8, 12962, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 28550, 7, 76, 11, 17926, 11, 685, 42782, 7, 5105, 11, 6640, 8, 4357, 685, 12915, 36569, 7, 6489, 11, 36147, 2327, 1635, 720, 437, 322, 36911, 5268, 36569, 7, 40492, 11, 4019, 8, 12962, 628, 220, 220, 220, 220, 220, 220, 220, 1196, 76, 796, 37139, 291, 62, 9641, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 2099, 1659, 7, 615, 76, 8, 6624, 337, 3705, 8264, 13, 2348, 29230, 291, 36918, 2848, 628, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 1988, 7, 76, 11, 1058, 55, 8, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 52, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 3861, 12962, 15139, 230, 6640, 13, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 55, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 56, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5105, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 6489, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 40492, 12962, 15139, 230, 352, 13, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 55, 4943, 12962, 15139, 230, 2026, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 56, 4943, 12962, 15139, 230, 1160, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 55, 4943, 12962, 15139, 230, 2026, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 56, 4943, 12962, 15139, 230, 1542, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 55, 33912, 52, 4943, 12962, 15139, 230, 1802, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 56, 33912, 52, 4943, 12962, 15139, 230, 2026, 13, 628, 220, 220, 220, 220, 220, 220, 220, 1196, 76, 17, 796, 37139, 291, 62, 9641, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 2099, 1659, 7, 615, 76, 17, 8, 6624, 337, 3705, 8264, 13, 2348, 29230, 291, 36918, 2848, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 1114, 783, 655, 1057, 777, 5499, 11, 356, 1244, 751, 5254, 329, 262, 2482, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 379, 257, 1568, 966, 198, 220, 220, 220, 220, 220, 220, 220, 41575, 7, 44, 12789, 7203, 5239, 14, 25638, 12340, 285, 8, 198, 220, 220, 220, 220, 220, 220, 220, 41575, 7, 44, 12789, 7203, 5239, 14, 25638, 12340, 1196, 76, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 41575, 7, 44, 12789, 7203, 5239, 14, 17660, 87, 12340, 1196, 76, 17, 8, 628, 220, 220, 220, 220, 220, 220, 220, 900, 62, 34021, 0, 7, 47, 55, 11, 2081, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 8367, 7, 437, 322, 11, 362, 13, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 1988, 7, 76, 11, 1058, 55, 8, 15139, 230, 352, 13, 47202, 1795, 44230, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 12962, 15139, 230, 352, 13, 15, 2548, 4521, 30206, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 52, 12962, 15139, 230, 352, 13, 40350, 2780, 22136, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 3861, 12962, 15139, 230, 23313, 13, 2624, 1485, 29807, 13381, 1954, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 55, 12962, 15139, 230, 352, 13, 8269, 405, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 56, 12962, 15139, 230, 352, 13, 28694, 3553, 38431, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5105, 12962, 15139, 230, 352, 13, 11245, 1507, 22136, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 6489, 12962, 15139, 230, 657, 13, 3865, 30557, 25191, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 40492, 12962, 15139, 230, 352, 13, 47202, 1795, 44230, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 55, 4943, 12962, 15139, 230, 6740, 13, 25644, 2598, 1731, 2919, 1120, 2425, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 6489, 33912, 56, 4943, 12962, 15139, 230, 2310, 13, 1558, 34801, 2154, 46352, 32066, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 55, 4943, 12962, 15139, 230, 6298, 13, 45758, 18741, 3510, 1828, 41544, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 40492, 33912, 56, 4943, 12962, 15139, 230, 2579, 13, 42802, 1795, 1120, 3720, 35978, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 55, 33912, 52, 4943, 12962, 15139, 230, 1802, 13, 36042, 21261, 1795, 1495, 4869, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 56, 33912, 52, 4943, 12962, 15139, 230, 5125, 13, 47521, 20548, 1899, 26561, 1959, 198, 220, 220, 220, 886, 198, 220, 220, 220, 220, 198, 220, 220, 220, 2488, 9288, 2617, 366, 34551, 9864, 56, 34551, 46, 357, 9630, 276, 2196, 16725, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 285, 796, 9104, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 7017, 796, 685, 25, 87, 11, 1058, 88, 60, 198, 220, 220, 220, 220, 220, 220, 220, 5087, 796, 685, 25, 75, 11, 1058, 74, 60, 198, 220, 220, 220, 220, 220, 220, 220, 5766, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 1120, 2026, 26, 1160, 1542, 4357, 7017, 11, 5087, 8, 198, 220, 220, 220, 220, 220, 220, 220, 5127, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 3064, 11, 2026, 4357, 7017, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 17143, 2357, 7, 76, 11, 886, 322, 11, 352, 13, 15, 8, 198, 220, 220, 220, 220, 220, 220, 220, 575, 796, 751, 0, 7, 76, 11, 25892, 7, 25, 56, 11, 36525, 16193, 11274, 82, 11, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 471, 796, 751, 0, 7, 76, 11, 25892, 7, 25, 52, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 4217, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 5662, 11, 36525, 16193, 11274, 82, 11, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 24676, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 5105, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 28223, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 42668, 11, 36525, 16193, 22584, 669, 11, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 17926, 796, 751, 0, 7, 76, 11, 18110, 7, 25, 3861, 11, 18335, 28, 8628, 2014, 8, 628, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 287, 7017, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 25493, 7, 76, 11, 575, 58, 72, 4357, 352, 11, 685, 26410, 7, 5662, 58, 72, 4357, 5127, 58, 72, 12962, 4357, 685, 20560, 7, 42668, 58, 25, 75, 4357, 5766, 58, 72, 11, 25, 75, 46570, 23412, 7, 42668, 58, 25, 74, 4357, 5766, 58, 72, 11, 25, 74, 12962, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 25493, 7, 76, 11, 471, 11, 352, 11, 685, 26410, 7, 5105, 11, 6640, 8, 4357, 685, 20560, 7, 5662, 58, 25, 87, 4357, 1802, 828, 23412, 7, 5662, 58, 25, 88, 4357, 2026, 8, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 28550, 7, 76, 11, 17926, 11, 685, 42782, 7, 5105, 11, 6640, 8, 4357, 685, 12915, 36569, 7, 42668, 58, 25, 75, 4357, 36147, 2154, 1635, 720, 437, 322, 36911, 5268, 36569, 7, 42668, 58, 25, 74, 4357, 4019, 2014, 12962, 628, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 11, 23818, 62, 2676, 341, 62, 32374, 28, 15, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 7131, 25, 87, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 7131, 25, 88, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 52, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 3861, 12962, 15139, 230, 6640, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5662, 7131, 25, 87, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5662, 7131, 25, 88, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5105, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 75, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 74, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 56, 58, 87, 60, 4943, 12962, 15139, 230, 2026, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 56, 58, 88, 60, 4943, 12962, 15139, 230, 1160, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 56, 58, 87, 60, 4943, 12962, 15139, 230, 2026, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 56, 58, 88, 60, 4943, 12962, 15139, 230, 1542, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 5662, 58, 87, 60, 33912, 52, 4943, 12962, 15139, 230, 1802, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 5662, 58, 88, 60, 33912, 52, 4943, 12962, 15139, 230, 2026, 13, 628, 220, 220, 220, 220, 220, 220, 220, 900, 62, 34021, 0, 7, 5662, 58, 25, 87, 4357, 2081, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 8367, 7, 437, 322, 11, 352, 13, 16, 8, 628, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 7131, 25, 87, 12962, 15139, 230, 352, 13, 47202, 1795, 44230, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 7131, 25, 88, 12962, 15139, 230, 352, 13, 15, 2548, 4521, 30206, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 52, 12962, 15139, 230, 352, 13, 40350, 2780, 22136, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 3861, 12962, 15139, 230, 23313, 13, 2624, 1485, 29807, 13381, 1954, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5662, 7131, 25, 87, 12962, 15139, 230, 352, 13, 8269, 405, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5662, 7131, 25, 88, 12962, 15139, 230, 352, 13, 28694, 3553, 38431, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 5105, 12962, 15139, 230, 352, 13, 11245, 1507, 22136, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 75, 12962, 15139, 230, 657, 13, 3865, 30557, 25191, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 74, 12962, 15139, 230, 352, 13, 47202, 1795, 44230, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 56, 58, 87, 60, 4943, 12962, 15139, 230, 6740, 13, 25644, 2598, 1731, 2919, 1120, 2425, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 56, 58, 88, 60, 4943, 12962, 15139, 230, 2310, 13, 1558, 34801, 2154, 46352, 32066, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 56, 58, 87, 60, 4943, 12962, 15139, 230, 6298, 13, 45758, 18741, 3510, 1828, 41544, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 56, 58, 88, 60, 4943, 12962, 15139, 230, 2579, 13, 42802, 1795, 1120, 3720, 35978, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 5662, 58, 87, 60, 33912, 52, 4943, 12962, 15139, 230, 1802, 13, 36042, 21261, 1795, 1495, 4869, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 5662, 58, 88, 60, 33912, 52, 4943, 12962, 15139, 230, 5125, 13, 47521, 20548, 1899, 26561, 1959, 198, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 886, 198, 220, 220, 220, 2488, 9288, 2617, 366, 41, 5868, 8264, 357, 41, 1563, 19174, 42540, 34479, 16725, 2221, 628, 220, 220, 220, 220, 220, 220, 220, 285, 796, 9104, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 7017, 796, 685, 25, 70, 16, 11, 1058, 70, 17, 60, 198, 220, 220, 220, 220, 220, 220, 220, 5087, 796, 685, 25, 75, 11, 1058, 74, 60, 198, 220, 220, 220, 220, 220, 220, 220, 16020, 796, 685, 25, 82, 16, 11, 1058, 82, 17, 60, 198, 220, 220, 220, 220, 220, 220, 220, 787, 15, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 21, 362, 26, 362, 838, 4357, 7017, 11, 16020, 8, 198, 220, 220, 220, 220, 220, 220, 220, 779, 15, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 19, 362, 26, 362, 718, 4357, 7017, 11, 16020, 8, 198, 220, 220, 220, 220, 220, 220, 220, 277, 67, 15, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 16, 513, 26, 352, 352, 4357, 5087, 11, 16020, 8, 198, 220, 220, 220, 220, 220, 220, 220, 269, 15, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 17, 11, 604, 4357, 7017, 8, 198, 220, 220, 220, 220, 220, 220, 220, 304, 15, 796, 360, 1072, 31554, 271, 19182, 7, 43879, 2414, 58, 16345, 7, 16344, 15, 58, 69, 11, 25, 12962, 329, 277, 287, 5087, 4357, 5087, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 17143, 2357, 7, 76, 11, 886, 322, 11, 352, 13, 15, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1395, 796, 751, 0, 7, 76, 11, 25892, 7, 25, 55, 11, 36525, 16193, 325, 5217, 11, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 350, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 47, 11, 36525, 16193, 11274, 82, 11, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 28223, 796, 751, 0, 7, 76, 11, 1520, 375, 414, 7, 25, 42668, 11, 36525, 16193, 22584, 669, 11, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 575, 796, 751, 0, 7, 76, 11, 18110, 7, 25, 56, 11, 18335, 28, 16345, 7, 16344, 15, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 329, 474, 287, 16020, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 25493, 7, 76, 11, 1395, 58, 73, 4357, 352, 11, 685, 26410, 7, 47, 58, 72, 4357, 787, 15, 58, 72, 11, 73, 12962, 329, 1312, 287, 7017, 4357, 16410, 20560, 7, 47, 58, 72, 4357, 779, 15, 58, 72, 11, 73, 12962, 329, 1312, 287, 7017, 11208, 685, 20560, 7, 42668, 58, 69, 4357, 277, 67, 15, 58, 69, 11, 73, 12962, 329, 277, 287, 5087, 11907, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 28550, 7, 76, 11, 575, 11, 685, 42782, 7, 47, 58, 72, 4357, 269, 15, 58, 72, 12962, 329, 1312, 287, 7017, 4357, 685, 12915, 36569, 7, 42668, 58, 25, 74, 4357, 304, 15, 58, 25, 74, 46570, 5268, 36569, 7, 42668, 58, 25, 75, 4357, 1058, 16763, 7, 437, 322, 8, 1635, 29568, 68, 15, 58, 25, 75, 60, 22305, 33761, 628, 220, 220, 220, 220, 220, 220, 220, 1196, 76, 796, 37139, 291, 62, 9641, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 2099, 1659, 7, 615, 76, 8, 6624, 337, 3705, 8264, 13, 2348, 29230, 291, 36918, 2848, 628, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 628, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 55, 7131, 25, 82, 16, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 55, 7131, 25, 82, 17, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 7131, 25, 70, 16, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 7131, 25, 70, 17, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 75, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 74, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 12962, 15139, 230, 718, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 447, 94, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 718, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 447, 94, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 362, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 447, 94, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 362, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 447, 94, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 940, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 604, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 362, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 362, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 718, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 513, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 352, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 33643, 56, 4943, 12962, 15139, 230, 362, 13, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 33643, 56, 4943, 12962, 15139, 230, 604, 13, 198, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 220, 220, 220, 220, 220, 220, 220, 220, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 31694, 12, 22584, 723, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 8367, 7, 437, 322, 11, 352, 13, 16, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 8367, 7, 56, 11, 718, 13, 19, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 62, 34021, 0, 7, 56, 11, 2081, 8, 628, 220, 220, 220, 220, 220, 220, 220, 8494, 0, 7, 76, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 55, 7131, 25, 82, 16, 12962, 15139, 230, 657, 13, 2079, 3388, 1495, 5237, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 55, 7131, 25, 82, 17, 12962, 15139, 230, 352, 13, 15, 2079, 39251, 3132, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 7131, 25, 70, 16, 12962, 15139, 230, 352, 13, 486, 1270, 5066, 1558, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 47, 7131, 25, 70, 17, 12962, 15139, 230, 657, 13, 2079, 24669, 4531, 17, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 75, 12962, 15139, 230, 657, 13, 5607, 2791, 3270, 2624, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 42668, 7131, 25, 74, 12962, 15139, 230, 352, 13, 2713, 1485, 33781, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 25, 56, 12962, 15139, 230, 718, 13, 19, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 447, 94, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 718, 13, 44698, 1314, 2154, 3720, 2816, 3865, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 447, 94, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 352, 13, 5607, 25191, 2623, 4521, 2718, 27057, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 447, 94, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 362, 13, 39101, 2791, 1507, 2791, 44183, 3682, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 447, 94, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 860, 13, 38819, 2713, 4309, 11645, 16942, 1303, 11295, 532, 19561, 706, 860, 13, 38819, 2087, 422, 337, 3705, 8264, 13, 20362, 2482, 47125, 402, 40834, 407, 4478, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 513, 13, 4089, 24991, 41580, 23753, 38314, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 362, 13, 44698, 3695, 2154, 3695, 2791, 16315, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 352, 13, 3070, 2075, 405, 11623, 2079, 32459, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 55, 58, 82, 16, 60, 4943, 12962, 15139, 230, 657, 13, 24, 3270, 1731, 1129, 1495, 2623, 405, 3980, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 352, 13, 38819, 41531, 940, 2682, 37950, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 718, 13, 486, 4521, 1731, 2920, 3324, 6200, 5333, 1303, 11295, 532, 19561, 706, 718, 13, 486, 4521, 2087, 422, 337, 3705, 8264, 13, 20362, 2482, 47125, 402, 40834, 407, 4478, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 75, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 513, 13, 15, 34287, 2682, 1795, 30272, 43193, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 42668, 58, 74, 60, 33912, 55, 58, 82, 17, 60, 4943, 12962, 15139, 230, 657, 13, 48581, 3070, 29703, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 16, 60, 33643, 56, 4943, 12962, 15139, 230, 362, 13, 940, 3365, 1731, 3365, 3132, 20548, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 9288, 337, 3705, 8264, 13, 5377, 26908, 6806, 13, 20274, 62, 8367, 7, 76, 13557, 43327, 62, 19849, 58, 13940, 23650, 7203, 47, 58, 70, 17, 60, 33643, 56, 4943, 12962, 15139, 230, 604, 13, 27693, 2920, 1485, 2816, 2670, 39509, 628, 220, 220, 220, 886, 198, 437 ]
2.020152
8,436
@testset "Curve struct" begin @testset "Uniformly distributed values" begin n = 20 data = rand(Uniform(0,10), n) curve = CalculatedABC.ABCcurve(data) @test curve.effort == 0:0.05:1.0 expected_yield = [0, 0.10223370412290836, 0.19630374973228518, 0.2798337861487627, 0.35309289814499817, 0.4251124119444249, 0.49223359866263033, 0.5559340313195282, 0.6192318028485928, 0.6706485917196718, 0.7210686469145637, 0.7696104643520768, 0.812596101423477, 0.8466456273448749, 0.8777009051387628, 0.9076823618805581, 0.9368834040175215, 0.9647084964342312, 0.9824989229044542, 0.994333140487581, 1.0000000000000002] @test isapprox(curve.yield, expected_yield) end @testset "Exponentially distributed values" begin n = 20 data = rand(Exponential(1), n) curve = CalculatedABC.ABCcurve(data) @test curve.effort == 0:0.05:1.0 expected_yield = [0.0, 0.1559704817922999, 0.259107787045309, 0.36017085915674457, 0.4567531613173713, 0.530483819367366, 0.5905820392527759, 0.6503414525690904, 0.6912925133668514, 0.7318440937106174, 0.7704643555492486, 0.8031964684921609, 0.8353247928350085, 0.8670259991394021, 0.8976554662905372, 0.9212877248856802, 0.9431001183934831, 0.964704167187443, 0.9810003669812493, 0.9911110632975999, 1.0] @test isapprox(curve.yield, expected_yield) end @testset "SwissInhabitants data" begin data = readdlm("swissinhabitants")[:,1] curve = CalculatedABC.ABCcurve(data) @test curve.effort == 0:0.0003453038674033149:1.0 expected_yield = readdlm("expected_yield")[:,1] @test isapprox(curve.yield, expected_yield) end end
[ 31, 9288, 2617, 366, 26628, 303, 2878, 1, 2221, 198, 31, 9288, 2617, 366, 3118, 6933, 306, 9387, 3815, 1, 2221, 198, 220, 220, 220, 299, 796, 1160, 198, 220, 220, 220, 1366, 796, 43720, 7, 3118, 6933, 7, 15, 11, 940, 828, 299, 8, 198, 220, 220, 220, 12133, 796, 27131, 515, 24694, 13, 24694, 22019, 303, 7, 7890, 8, 198, 220, 220, 220, 2488, 9288, 12133, 13, 14822, 419, 6624, 657, 25, 15, 13, 2713, 25, 16, 13, 15, 198, 220, 220, 220, 2938, 62, 88, 1164, 796, 685, 15, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 940, 1828, 2091, 32869, 1065, 1959, 2919, 2623, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 25272, 1270, 2718, 2920, 4790, 1828, 5332, 1507, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 1983, 4089, 2091, 46302, 18294, 4304, 1983, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 2327, 26895, 2078, 4089, 18444, 34808, 1558, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 32114, 14686, 3901, 1129, 30272, 21626, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 2920, 1828, 2091, 41292, 2791, 2075, 1270, 2091, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 2816, 3270, 23601, 25838, 22186, 32568, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 21, 1129, 1954, 15259, 2078, 2780, 3270, 2078, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 43798, 34287, 3270, 1558, 42830, 1507, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4761, 940, 3104, 2414, 3388, 1415, 3980, 2718, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 22, 38205, 13464, 2414, 2327, 22745, 3104, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 23, 1065, 3270, 5333, 28645, 1954, 32883, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 5705, 2791, 29228, 27367, 2598, 5774, 2920, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 42802, 9879, 44928, 20107, 4304, 2078, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 24, 2998, 3104, 24940, 1507, 1795, 2816, 6659, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 24, 2623, 3459, 23601, 21844, 2425, 23349, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 24, 2414, 32583, 2920, 2414, 2682, 1954, 1065, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4089, 1731, 42520, 23539, 3023, 2231, 3682, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 42691, 20370, 15187, 2780, 2425, 6659, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 352, 13, 8269, 24598, 17, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 22019, 303, 13, 88, 1164, 11, 2938, 62, 88, 1164, 8, 198, 437, 198, 198, 31, 9288, 2617, 366, 16870, 3471, 1927, 9387, 3815, 1, 2221, 198, 220, 220, 220, 299, 796, 1160, 198, 220, 220, 220, 1366, 796, 43720, 7, 16870, 35470, 7, 16, 828, 299, 8, 198, 220, 220, 220, 12133, 796, 27131, 515, 24694, 13, 24694, 22019, 303, 7, 7890, 8, 198, 220, 220, 220, 2488, 9288, 12133, 13, 14822, 419, 6624, 657, 25, 15, 13, 2713, 25, 16, 13, 15, 198, 220, 220, 220, 2938, 62, 88, 1164, 796, 685, 15, 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, 657, 13, 1314, 3270, 2154, 2780, 21738, 1828, 17032, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 25191, 940, 39761, 2154, 2231, 26895, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 2623, 486, 32583, 3270, 1314, 45385, 33032, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 29228, 2425, 33400, 1485, 1558, 2718, 1485, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 38612, 2780, 2548, 1129, 27824, 32459, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 3270, 2713, 41739, 2670, 1495, 1983, 38314, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 17544, 2682, 18781, 1495, 3388, 2931, 3023, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 3388, 18741, 1495, 1485, 2623, 35978, 1415, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4790, 22883, 29416, 2718, 15801, 22985, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 22, 32869, 2414, 2327, 2816, 2920, 1731, 4521, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 1795, 35175, 2414, 3104, 2920, 20666, 2931, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 23, 33319, 1731, 3720, 2078, 2327, 405, 5332, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4521, 2154, 1495, 17032, 20219, 1821, 2481, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4531, 4304, 2816, 42199, 1959, 2713, 36720, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 5892, 12762, 3324, 1731, 3459, 3980, 30863, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 24, 3559, 3064, 16817, 2670, 28978, 3132, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 24, 2414, 32869, 21940, 23451, 34938, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 4089, 12825, 2623, 39357, 1065, 43134, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 657, 13, 2079, 1157, 11442, 5066, 1959, 2425, 17032, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 352, 13, 15, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 22019, 303, 13, 88, 1164, 11, 2938, 62, 88, 1164, 8, 198, 437, 198, 198, 31, 9288, 2617, 366, 10462, 747, 818, 5976, 270, 1187, 1366, 1, 2221, 198, 220, 220, 220, 1366, 796, 1100, 25404, 76, 7203, 2032, 747, 259, 5976, 270, 1187, 4943, 58, 45299, 16, 60, 198, 220, 220, 220, 12133, 796, 27131, 515, 24694, 13, 24694, 22019, 303, 7, 7890, 8, 198, 220, 220, 220, 2488, 9288, 12133, 13, 14822, 419, 6624, 657, 25, 15, 13, 830, 27712, 1270, 2548, 3134, 1821, 2091, 19442, 25, 16, 13, 15, 198, 220, 220, 220, 2938, 62, 88, 1164, 796, 1100, 25404, 76, 7203, 40319, 62, 88, 1164, 4943, 58, 45299, 16, 60, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 22019, 303, 13, 88, 1164, 11, 2938, 62, 88, 1164, 8, 198, 437, 198, 437, 198 ]
1.532099
1,620
module GenieCMS greet() = print("Hello World!") using Genie function install(dest::String; force = false) src = abspath(normpath(joinpath(@__DIR__, "..", Genie.Plugins.FILES_FOLDER))) for f in readdir(src) isdir(f) || continue Genie.Plugins.install(joinpath(src, f), dest, force = force) end end end # module
[ 21412, 49405, 34, 5653, 198, 198, 70, 2871, 3419, 796, 3601, 7203, 15496, 2159, 2474, 8, 198, 198, 3500, 49405, 198, 198, 8818, 2721, 7, 16520, 3712, 10100, 26, 2700, 796, 3991, 8, 198, 220, 12351, 796, 2352, 6978, 7, 27237, 6978, 7, 22179, 6978, 7, 31, 834, 34720, 834, 11, 366, 492, 1600, 49405, 13, 23257, 1040, 13, 46700, 1546, 62, 37, 3535, 14418, 22305, 628, 220, 329, 277, 287, 1100, 15908, 7, 10677, 8, 198, 220, 220, 220, 318, 15908, 7, 69, 8, 8614, 2555, 198, 220, 220, 220, 49405, 13, 23257, 1040, 13, 17350, 7, 22179, 6978, 7, 10677, 11, 277, 828, 2244, 11, 2700, 796, 2700, 8, 198, 220, 886, 198, 437, 198, 198, 437, 1303, 8265 ]
2.702479
121
abstract type AbstractHyperedgeCutModel end @inline (mdl::AbstractHyperedgeCutModel)(n_vertices, n_pins, n_self_nets, n_cut_nets, k) = mdl(n_vertices, n_pins, n_self_nets, n_cut_nets) struct AffineHyperedgeCutModel{Tv} <: AbstractHyperedgeCutModel α::Tv β_vertex::Tv β_pin::Tv β_self_net::Tv β_cut_net::Tv end function AffineHyperedgeCutModel(; α = false, β_vertex = false, β_pin = false, β_self_net = false, β_cut_net = false) AffineHyperedgeCutModel(promote(α, β_vertex, β_pin, β_self_net, β_cut_net)...) end @inline cost_type(::Type{AffineHyperedgeCutModel{Tv}}) where {Tv} = Tv (mdl::AffineHyperedgeCutModel)(n_vertices, n_pins, n_self_nets, n_cut_nets) = mdl.α + n_vertices * mdl.β_vertex + n_pins * mdl.β_pin + n_self_nets * mdl.β_self_net + n_cut_nets * mdl.β_cut_net struct HyperedgeCutOracle{Ti, Net, SelfNet, Mdl} <: AbstractOracleCost{Mdl} pos::Vector{Ti} net::Net selfnet::SelfNet mdl::Mdl end oracle_model(ocl::HyperedgeCutOracle) = ocl.mdl function oracle_stripe(hint::AbstractHint, mdl::AbstractHyperedgeCutModel, A::SparseMatrixCSC{Tv, Ti}; net=nothing, adj_A=nothing, kwargs...) where {Tv, Ti} @inbounds begin m, n = size(A) pos = A.colptr if net === nothing net = netcount(hint, A; kwargs...) end selfnet = selfnetcount(hint, A; kwargs...) return HyperedgeCutOracle(pos, net, selfnet, mdl) end end @inline function (cst::HyperedgeCutOracle{Ti, Mdl})(j, j′, k...) where {Ti, Mdl} @inbounds begin w = cst.pos[j′] - cst.pos[j] d = cst.net[j, j′] l = cst.selfnet[j, j′] return cst.mdl(j′ - j, w, l, d - l, k...) end end @inline function (stp::Step{Ocl})(_j, _j′, _k...) where {Ti, Mdl, Ocl <: HyperedgeCutOracle{Ti, Mdl}} @inbounds begin cst = stp.ocl j = destep(_j) j′ = destep(_j′) k = maptuple(destep, _k...) w = cst.pos[j′] - cst.pos[j] d = Step(cst.net)(_j, _j′) l = Step(cst.selfnet)(_j, _j′) return cst.mdl(j′ - j, w, l, d - l, k...) end end
[ 397, 8709, 2099, 27741, 39, 2981, 445, 469, 26254, 17633, 886, 198, 198, 31, 45145, 357, 9132, 75, 3712, 23839, 39, 2981, 445, 469, 26254, 17633, 5769, 77, 62, 1851, 1063, 11, 299, 62, 49556, 11, 299, 62, 944, 62, 45938, 11, 299, 62, 8968, 62, 45938, 11, 479, 8, 796, 285, 25404, 7, 77, 62, 1851, 1063, 11, 299, 62, 49556, 11, 299, 62, 944, 62, 45938, 11, 299, 62, 8968, 62, 45938, 8, 628, 198, 198, 7249, 6708, 500, 39, 2981, 445, 469, 26254, 17633, 90, 51, 85, 92, 1279, 25, 27741, 39, 2981, 445, 469, 26254, 17633, 198, 220, 220, 220, 26367, 3712, 51, 85, 198, 220, 220, 220, 27169, 62, 332, 16886, 3712, 51, 85, 198, 220, 220, 220, 27169, 62, 11635, 3712, 51, 85, 198, 220, 220, 220, 27169, 62, 944, 62, 3262, 3712, 51, 85, 198, 220, 220, 220, 27169, 62, 8968, 62, 3262, 3712, 51, 85, 198, 437, 198, 198, 8818, 6708, 500, 39, 2981, 445, 469, 26254, 17633, 7, 26, 26367, 796, 3991, 11, 27169, 62, 332, 16886, 796, 3991, 11, 27169, 62, 11635, 796, 3991, 11, 27169, 62, 944, 62, 3262, 796, 3991, 11, 27169, 62, 8968, 62, 3262, 796, 3991, 8, 198, 220, 220, 220, 6708, 500, 39, 2981, 445, 469, 26254, 17633, 7, 16963, 1258, 7, 17394, 11, 27169, 62, 332, 16886, 11, 27169, 62, 11635, 11, 27169, 62, 944, 62, 3262, 11, 27169, 62, 8968, 62, 3262, 8, 23029, 198, 437, 198, 198, 31, 45145, 1575, 62, 4906, 7, 3712, 6030, 90, 35191, 500, 39, 2981, 445, 469, 26254, 17633, 90, 51, 85, 11709, 8, 810, 1391, 51, 85, 92, 796, 309, 85, 198, 198, 7, 9132, 75, 3712, 35191, 500, 39, 2981, 445, 469, 26254, 17633, 5769, 77, 62, 1851, 1063, 11, 299, 62, 49556, 11, 299, 62, 944, 62, 45938, 11, 299, 62, 8968, 62, 45938, 8, 796, 285, 25404, 13, 17394, 1343, 299, 62, 1851, 1063, 1635, 285, 25404, 13, 26638, 62, 332, 16886, 1343, 299, 62, 49556, 1635, 285, 25404, 13, 26638, 62, 11635, 1343, 299, 62, 944, 62, 45938, 1635, 285, 25404, 13, 26638, 62, 944, 62, 3262, 1343, 299, 62, 8968, 62, 45938, 1635, 285, 25404, 13, 26638, 62, 8968, 62, 3262, 198, 198, 7249, 367, 2981, 445, 469, 26254, 48625, 90, 40533, 11, 3433, 11, 12189, 7934, 11, 337, 25404, 92, 1279, 25, 27741, 48625, 13729, 90, 44, 25404, 92, 198, 220, 220, 220, 1426, 3712, 38469, 90, 40533, 92, 198, 220, 220, 220, 2010, 3712, 7934, 198, 220, 220, 220, 2116, 3262, 3712, 24704, 7934, 198, 220, 220, 220, 285, 25404, 3712, 44, 25404, 198, 437, 198, 198, 273, 6008, 62, 19849, 7, 38679, 3712, 39, 2981, 445, 469, 26254, 48625, 8, 796, 267, 565, 13, 9132, 75, 198, 198, 8818, 393, 6008, 62, 33565, 431, 7, 71, 600, 3712, 23839, 39, 600, 11, 285, 25404, 3712, 23839, 39, 2981, 445, 469, 26254, 17633, 11, 317, 3712, 50, 29572, 46912, 34, 6173, 90, 51, 85, 11, 16953, 19629, 2010, 28, 22366, 11, 9224, 62, 32, 28, 22366, 11, 479, 86, 22046, 23029, 810, 1391, 51, 85, 11, 16953, 92, 198, 220, 220, 220, 2488, 259, 65, 3733, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 285, 11, 299, 796, 2546, 7, 32, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1426, 796, 317, 13, 4033, 20692, 198, 220, 220, 220, 220, 220, 220, 220, 611, 2010, 24844, 2147, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2010, 796, 2010, 9127, 7, 71, 600, 11, 317, 26, 479, 86, 22046, 23029, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2116, 3262, 796, 2116, 3262, 9127, 7, 71, 600, 11, 317, 26, 479, 86, 22046, 23029, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 367, 2981, 445, 469, 26254, 48625, 7, 1930, 11, 2010, 11, 2116, 3262, 11, 285, 25404, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 31, 45145, 2163, 357, 66, 301, 3712, 39, 2981, 445, 469, 26254, 48625, 90, 40533, 11, 337, 25404, 92, 5769, 73, 11, 474, 17478, 11, 479, 23029, 810, 1391, 40533, 11, 337, 25404, 92, 198, 220, 220, 220, 2488, 259, 65, 3733, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 266, 796, 269, 301, 13, 1930, 58, 73, 17478, 60, 532, 269, 301, 13, 1930, 58, 73, 60, 198, 220, 220, 220, 220, 220, 220, 220, 288, 796, 269, 301, 13, 3262, 58, 73, 11, 474, 17478, 60, 198, 220, 220, 220, 220, 220, 220, 220, 300, 796, 269, 301, 13, 944, 3262, 58, 73, 11, 474, 17478, 60, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 269, 301, 13, 9132, 75, 7, 73, 17478, 532, 474, 11, 266, 11, 300, 11, 288, 532, 300, 11, 479, 23029, 198, 220, 220, 220, 886, 198, 437, 198, 198, 31, 45145, 2163, 357, 301, 79, 3712, 8600, 90, 46, 565, 92, 5769, 62, 73, 11, 4808, 73, 17478, 11, 4808, 74, 23029, 810, 1391, 40533, 11, 337, 25404, 11, 440, 565, 1279, 25, 367, 2981, 445, 469, 26254, 48625, 90, 40533, 11, 337, 25404, 11709, 198, 220, 220, 220, 2488, 259, 65, 3733, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 269, 301, 796, 336, 79, 13, 38679, 198, 220, 220, 220, 220, 220, 220, 220, 474, 796, 2244, 538, 28264, 73, 8, 198, 220, 220, 220, 220, 220, 220, 220, 474, 17478, 796, 2244, 538, 28264, 73, 17478, 8, 198, 220, 220, 220, 220, 220, 220, 220, 479, 796, 285, 2373, 29291, 7, 16520, 538, 11, 4808, 74, 23029, 198, 220, 220, 220, 220, 220, 220, 220, 266, 796, 269, 301, 13, 1930, 58, 73, 17478, 60, 532, 269, 301, 13, 1930, 58, 73, 60, 198, 220, 220, 220, 220, 220, 220, 220, 288, 796, 5012, 7, 66, 301, 13, 3262, 5769, 62, 73, 11, 4808, 73, 17478, 8, 198, 220, 220, 220, 220, 220, 220, 220, 300, 796, 5012, 7, 66, 301, 13, 944, 3262, 5769, 62, 73, 11, 4808, 73, 17478, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 269, 301, 13, 9132, 75, 7, 73, 17478, 532, 474, 11, 266, 11, 300, 11, 288, 532, 300, 11, 479, 23029, 198, 220, 220, 220, 886, 198, 437 ]
2
1,047
using LinearAlgebraicRepresentation Lar = LinearAlgebraicRepresentation using ViewerGL GL = ViewerGL # data input (V, FV, EV) = ([1.01181 0.215639 0.91979 0.123616 1.02252 0.226347 0.930498 0.134324 0.0458309 -0.301827 0.348275 0.0006172 0.579367 0.23171 0.881811 0.534154 -0.0521776 0.627953 -0.190635 0.489496 -0.0233884 0.656742 -0.161846 0.518285 0.27652 -0.0875132 0.52527 0.161237 0.509324 0.145291 0.758074 0.394041 0.27631 0.564484 0.0058279 0.294002 1.01221 1.30039 0.741732 1.02991; 0.160033 0.0680099 0.956278 0.864255 0.160649 0.0686266 0.956895 0.864872 -0.200245 0.102199 0.417839 0.720283 -0.35354 -0.0510965 0.264543 0.566987 0.682359 0.543901 0.0592036 -0.0792537 0.956374 0.817917 0.333219 0.194762 -0.102028 0.146722 0.324834 0.573584 -0.16916 0.0795901 0.257702 0.506452 0.452356 0.181874 1.15396 0.883481 0.816151 0.545669 1.51776 1.24728; 0.196256 0.206963 0.196872 0.20758 0.997729 1.00844 0.998346 1.00905 0.0677451 0.601282 -0.0855504 0.447986 0.502301 1.03584 0.349005 0.882542 0.159301 0.18809 0.433316 0.462105 0.797002 0.825792 1.07102 1.09981 0.1446 0.377404 0.0774682 0.310272 0.580364 0.813168 0.513232 0.746036 0.403805 1.13971 0.767599 1.5035 0.249344 0.985248 0.613139 1.34904], Array{Int64,1}[[1,2,3,4],[5,6,7,8],[1,2,5,6],[3,4,7,8],[1,3,5,7],[2,4,6,8],[9,10,11,12],[13,14,15,16],[9,10,13,14],[11,12,15,16],[9,11,13,15],[10,12,14,16],[17,18,19,20],[21,22,23,24],[17,18,21,22],[19,20,23,24],[17,19,21,23],[18,20,22,24],[25,26,27,28],[29,30,31,32],[25,26,29,30],[27,28,31,32],[25,27,29,31],[26,28,30,32],[33,34,35,36],[37,38,39,40],[33,34,37,38],[35,36,39,40],[33,35,37,39],[34,36,38,40]],Array{Int64,1}[[1,2],[3,4],[5,6],[7,8],[1,3],[2,4],[5,7],[6,8],[1,5],[2,6],[3,7],[4,8],[9,10],[11,12],[13,14],[15,16],[9,11],[10,12],[13,15],[14,16],[9,13],[10,14],[11,15],[12,16],[17,18],[19,20],[21,22],[23,24],[17,19],[18,20],[21,23],[22,24],[17,21],[18,22],[19,23],[20,24],[25,26],[27,28],[29,30],[31,32],[25,27],[26,28],[29,31],[30,32],[25,29],[26,30],[27,31],[28,32],[33,34],[35,36],[37,38],[39,40],[33,35],[34,36],[37,39],[38,40],[33,37],[34,38],[35,39],[36,40]]) cop_EV = Lar.coboundary_0(EV::Lar.Cells); cop_EW = convert(Lar.ChainOp, cop_EV); cop_FE = Lar.coboundary_1(V, FV::Lar.Cells, EV::Lar.Cells); W = convert(Lar.Points, V'); V, copEV, copFE, copCF = Lar.space_arrangement( W::Lar.Points, cop_EW::Lar.ChainOp, cop_FE::Lar.ChainOp) cc = [copEV, copFE, copCF] LarModelString = Lar.lar2obj(V::Lar.Points, cc::Lar.ChainComplex) f = open("../test/out3d.obj", "w") print(f, LarModelString); close(f) V,EVs,FVs = Lar.obj2lar("../test/out3d.obj") GL.VIEW([ GL.GLPolyhedron(V, FVs[1]) GL.GLFrame ]); V,CVs,FVs,EVs = Lar.pols2tria(V, copEV, copFE, copCF); # whole assembly GL.VIEW(GL.GLExplode(V,FVs,1.2,1.2,1.2,99,1)); GL.VIEW(GL.GLExplode(V,EVs,1.5,1.5,1.5,99,1)); GL.VIEW(GL.GLExplode(V,CVs[2:end],5,5,5,99,0.2)); GL.VIEW(GL.GLExplode(V,[CVs[1]],1,1,1,99,0.5));
[ 3500, 44800, 2348, 29230, 291, 40171, 341, 198, 43, 283, 796, 44800, 2348, 29230, 291, 40171, 341, 198, 3500, 3582, 263, 8763, 198, 8763, 796, 3582, 263, 8763, 198, 198, 2, 1366, 5128, 198, 7, 53, 11, 376, 53, 11, 8696, 8, 796, 29565, 16, 13, 486, 27057, 657, 13, 17, 21599, 2670, 657, 13, 24, 33581, 657, 13, 1065, 2623, 1433, 352, 13, 2999, 22800, 657, 13, 24909, 30995, 657, 13, 45418, 36260, 657, 13, 1485, 3559, 1731, 657, 13, 15, 29334, 26895, 532, 15, 13, 18938, 23, 1983, 657, 13, 28978, 23195, 657, 13, 830, 21, 23628, 657, 13, 41734, 27824, 657, 13, 1954, 27192, 657, 13, 3459, 1507, 1157, 657, 13, 20, 2682, 21526, 532, 15, 13, 2713, 24591, 4304, 657, 13, 49856, 49649, 532, 15, 13, 1129, 3312, 2327, 657, 13, 35890, 37747, 532, 15, 13, 45310, 2548, 5705, 657, 13, 2996, 3134, 3682, 532, 15, 13, 1433, 1507, 3510, 657, 13, 44085, 26279, 657, 13, 1983, 43193, 532, 15, 13, 2919, 2425, 19924, 657, 13, 39088, 1983, 657, 13, 1433, 1065, 2718, 657, 13, 1120, 6052, 1731, 657, 13, 18781, 33551, 657, 13, 2425, 1795, 4524, 657, 13, 2670, 1821, 3901, 657, 13, 27988, 3132, 657, 13, 20, 2414, 34137, 657, 13, 405, 3365, 26050, 657, 13, 1959, 7029, 17, 352, 13, 486, 26115, 352, 13, 6200, 2670, 657, 13, 4524, 1558, 2624, 352, 13, 48891, 6420, 26, 657, 13, 36150, 2091, 657, 13, 15, 3104, 405, 2079, 657, 13, 50148, 25870, 657, 13, 39570, 13381, 657, 13, 14198, 33300, 657, 13, 15, 33808, 25540, 657, 13, 3865, 3104, 3865, 657, 13, 23, 34287, 4761, 532, 15, 13, 2167, 22995, 657, 13, 15377, 19104, 657, 13, 19, 23188, 2670, 657, 13, 23906, 30290, 532, 15, 13, 2327, 32182, 532, 15, 13, 2713, 14454, 2996, 657, 13, 2075, 2231, 3559, 657, 13, 20, 2791, 44183, 657, 13, 3104, 1954, 3270, 657, 13, 4051, 2670, 486, 657, 13, 2713, 37128, 2623, 532, 15, 13, 2998, 46351, 2718, 657, 13, 50148, 31020, 657, 13, 23, 21738, 1558, 657, 13, 2091, 2624, 1129, 657, 13, 1129, 2857, 5237, 532, 15, 13, 940, 1238, 2078, 657, 13, 1415, 3134, 1828, 657, 13, 18, 23045, 2682, 657, 13, 3553, 2327, 5705, 532, 15, 13, 22172, 1433, 657, 13, 2998, 24, 3270, 486, 657, 13, 28676, 36680, 657, 13, 35638, 37730, 657, 13, 2231, 1954, 3980, 657, 13, 1507, 1507, 4524, 352, 13, 1314, 34107, 657, 13, 3459, 2682, 6659, 657, 13, 23, 1433, 24309, 657, 13, 45326, 36657, 352, 13, 48170, 4304, 352, 13, 23753, 2078, 26, 657, 13, 25272, 11645, 657, 13, 1238, 3388, 5066, 657, 13, 42246, 4761, 657, 13, 1238, 38569, 657, 13, 2079, 3324, 1959, 352, 13, 25257, 2598, 657, 13, 34808, 30557, 352, 13, 28694, 2713, 657, 13, 15, 40179, 36330, 657, 13, 41706, 32568, 532, 15, 13, 2919, 2816, 33580, 657, 13, 2598, 3720, 4521, 657, 13, 1120, 1954, 486, 352, 13, 44215, 5705, 657, 13, 2682, 12865, 20, 657, 13, 3459, 1495, 3682, 657, 13, 1314, 6052, 486, 657, 13, 1507, 34583, 657, 13, 19, 20370, 1433, 657, 13, 39997, 13348, 657, 13, 3720, 9879, 17, 657, 13, 47338, 48156, 352, 13, 2998, 15377, 352, 13, 15, 2079, 6659, 657, 13, 1415, 3510, 657, 13, 26514, 26429, 657, 13, 2998, 4524, 43950, 657, 13, 26717, 29807, 657, 13, 39322, 26780, 657, 13, 23, 1485, 14656, 657, 13, 48645, 24339, 657, 13, 4524, 1899, 2623, 657, 13, 1821, 23734, 20, 352, 13, 20219, 4869, 657, 13, 4304, 2425, 2079, 352, 13, 1120, 2327, 657, 13, 1731, 6052, 2598, 657, 13, 42250, 23045, 657, 13, 47512, 20219, 352, 13, 27371, 3023, 4357, 15690, 90, 5317, 2414, 11, 16, 92, 30109, 16, 11, 17, 11, 18, 11, 19, 38430, 20, 11, 21, 11, 22, 11, 23, 38430, 16, 11, 17, 11, 20, 11, 21, 38430, 18, 11, 19, 11, 22, 11, 23, 38430, 16, 11, 18, 11, 20, 11, 22, 38430, 17, 11, 19, 11, 21, 11, 23, 38430, 24, 11, 940, 11, 1157, 11, 1065, 38430, 1485, 11, 1415, 11, 1314, 11, 1433, 38430, 24, 11, 940, 11, 1485, 11, 1415, 38430, 1157, 11, 1065, 11, 1314, 11, 1433, 38430, 24, 11, 1157, 11, 1485, 11, 1314, 38430, 940, 11, 1065, 11, 1415, 11, 1433, 38430, 1558, 11, 1507, 11, 1129, 11, 1238, 38430, 2481, 11, 1828, 11, 1954, 11, 1731, 38430, 1558, 11, 1507, 11, 2481, 11, 1828, 38430, 1129, 11, 1238, 11, 1954, 11, 1731, 38430, 1558, 11, 1129, 11, 2481, 11, 1954, 38430, 1507, 11, 1238, 11, 1828, 11, 1731, 38430, 1495, 11, 2075, 11, 1983, 11, 2078, 38430, 1959, 11, 1270, 11, 3132, 11, 2624, 38430, 1495, 11, 2075, 11, 1959, 11, 1270, 38430, 1983, 11, 2078, 11, 3132, 11, 2624, 38430, 1495, 11, 1983, 11, 1959, 11, 3132, 38430, 2075, 11, 2078, 11, 1270, 11, 2624, 38430, 2091, 11, 2682, 11, 2327, 11, 2623, 38430, 2718, 11, 2548, 11, 2670, 11, 1821, 38430, 2091, 11, 2682, 11, 2718, 11, 2548, 38430, 2327, 11, 2623, 11, 2670, 11, 1821, 38430, 2091, 11, 2327, 11, 2718, 11, 2670, 38430, 2682, 11, 2623, 11, 2548, 11, 1821, 60, 4357, 19182, 90, 5317, 2414, 11, 16, 92, 30109, 16, 11, 17, 38430, 18, 11, 19, 38430, 20, 11, 21, 38430, 22, 11, 23, 38430, 16, 11, 18, 38430, 17, 11, 19, 38430, 20, 11, 22, 38430, 21, 11, 23, 38430, 16, 11, 20, 38430, 17, 11, 21, 38430, 18, 11, 22, 38430, 19, 11, 23, 38430, 24, 11, 940, 38430, 1157, 11, 1065, 38430, 1485, 11, 1415, 38430, 1314, 11, 1433, 38430, 24, 11, 1157, 38430, 940, 11, 1065, 38430, 1485, 11, 1314, 38430, 1415, 11, 1433, 38430, 24, 11, 1485, 38430, 940, 11, 1415, 38430, 1157, 11, 1314, 38430, 1065, 11, 1433, 38430, 1558, 11, 1507, 38430, 1129, 11, 1238, 38430, 2481, 11, 1828, 38430, 1954, 11, 1731, 38430, 1558, 11, 1129, 38430, 1507, 11, 1238, 38430, 2481, 11, 1954, 38430, 1828, 11, 1731, 38430, 1558, 11, 2481, 38430, 1507, 11, 1828, 38430, 1129, 11, 1954, 38430, 1238, 11, 1731, 38430, 1495, 11, 2075, 38430, 1983, 11, 2078, 38430, 1959, 11, 1270, 38430, 3132, 11, 2624, 38430, 1495, 11, 1983, 38430, 2075, 11, 2078, 38430, 1959, 11, 3132, 38430, 1270, 11, 2624, 38430, 1495, 11, 1959, 38430, 2075, 11, 1270, 38430, 1983, 11, 3132, 38430, 2078, 11, 2624, 38430, 2091, 11, 2682, 38430, 2327, 11, 2623, 38430, 2718, 11, 2548, 38430, 2670, 11, 1821, 38430, 2091, 11, 2327, 38430, 2682, 11, 2623, 38430, 2718, 11, 2670, 38430, 2548, 11, 1821, 38430, 2091, 11, 2718, 38430, 2682, 11, 2548, 38430, 2327, 11, 2670, 38430, 2623, 11, 1821, 11907, 8, 198, 198, 22163, 62, 20114, 796, 25577, 13, 66, 672, 633, 560, 62, 15, 7, 20114, 3712, 43, 283, 13, 34, 19187, 1776, 198, 22163, 62, 6217, 796, 10385, 7, 43, 283, 13, 35491, 18257, 11, 2243, 62, 20114, 1776, 198, 22163, 62, 15112, 796, 25577, 13, 66, 672, 633, 560, 62, 16, 7, 53, 11, 376, 53, 3712, 43, 283, 13, 34, 19187, 11, 8696, 3712, 43, 283, 13, 34, 19187, 1776, 198, 54, 796, 10385, 7, 43, 283, 13, 40710, 11, 569, 24036, 198, 198, 53, 11, 2243, 20114, 11, 2243, 15112, 11, 2243, 22495, 796, 25577, 13, 13200, 62, 3258, 648, 972, 7, 198, 197, 54, 3712, 43, 283, 13, 40710, 11, 2243, 62, 6217, 3712, 43, 283, 13, 35491, 18257, 11, 2243, 62, 15112, 3712, 43, 283, 13, 35491, 18257, 8, 198, 198, 535, 796, 685, 22163, 20114, 11, 2243, 15112, 11, 2243, 22495, 60, 198, 43, 283, 17633, 10100, 796, 25577, 13, 21681, 17, 26801, 7, 53, 3712, 43, 283, 13, 40710, 11, 36624, 3712, 43, 283, 13, 35491, 5377, 11141, 8, 198, 69, 796, 1280, 7203, 40720, 9288, 14, 448, 18, 67, 13, 26801, 1600, 366, 86, 4943, 198, 4798, 7, 69, 11, 25577, 17633, 10100, 1776, 1969, 7, 69, 8, 198, 53, 11, 20114, 82, 11, 37, 23266, 796, 25577, 13, 26801, 17, 21681, 7203, 40720, 9288, 14, 448, 18, 67, 13, 26801, 4943, 198, 198, 8763, 13, 28206, 26933, 198, 220, 220, 220, 220, 220, 10188, 13, 8763, 34220, 704, 1313, 7, 53, 11, 376, 23266, 58, 16, 12962, 198, 220, 220, 220, 220, 220, 10188, 13, 8763, 19778, 198, 36563, 198, 198, 53, 11, 34, 23266, 11, 37, 23266, 11, 20114, 82, 796, 25577, 13, 79, 10220, 17, 83, 7496, 7, 53, 11, 2243, 20114, 11, 2243, 15112, 11, 2243, 22495, 1776, 1303, 2187, 10474, 198, 8763, 13, 28206, 7, 8763, 13, 38, 2538, 87, 489, 1098, 7, 53, 11, 37, 23266, 11, 16, 13, 17, 11, 16, 13, 17, 11, 16, 13, 17, 11, 2079, 11, 16, 18125, 198, 8763, 13, 28206, 7, 8763, 13, 38, 2538, 87, 489, 1098, 7, 53, 11, 20114, 82, 11, 16, 13, 20, 11, 16, 13, 20, 11, 16, 13, 20, 11, 2079, 11, 16, 18125, 198, 8763, 13, 28206, 7, 8763, 13, 38, 2538, 87, 489, 1098, 7, 53, 11, 34, 23266, 58, 17, 25, 437, 4357, 20, 11, 20, 11, 20, 11, 2079, 11, 15, 13, 17, 18125, 198, 8763, 13, 28206, 7, 8763, 13, 38, 2538, 87, 489, 1098, 7, 53, 17414, 34, 23266, 58, 16, 60, 4357, 16, 11, 16, 11, 16, 11, 2079, 11, 15, 13, 20, 18125, 198 ]
1.885363
1,544
# dependencies using LFAToolkit using LinearAlgebra using Plots # setup p = 2 dimension = 1 mesh = Mesh1D(1.0) # operator diffusion = GalleryOperator("diffusion", p+1, p+1, mesh) # NoPreco smoother noPreco = NoPreco(diffusion) # full operator symbols numbersteps = 250 maxeigenvalue = 0 θ_min = -π/2 θ_max = 3π/2 θ_step = 2π/(numbersteps-1) θ_range = θ_min:θ_step:θ_max # compute and plot smoothing factor # setup ω = [1.00] eigenvalues = zeros(numbersteps, p) # compute for i in 1:numbersteps θ = [θ_range[i]] if abs(θ[1]) > π/512 A = computesymbols(noPreco, ω, θ) currenteigenvalues = [real(val) for val in eigvals(I-A)] eigenvalues[i, :] = currenteigenvalues end end # plot xrange = θ_range/π plot( xrange, xlabel="θ/π", xtickfont=font(12, "Courier"), eigenvalues, ytickfont=font(12, "Courier"), ylabel="λ", linewidth=3, legend=:none, title="Spectrum of NoPreco Symbol", palette=palette(:tab10) ) ylims!(min(0.0, eigenvalues...) * 1.1, max(eigenvalues...) * 1.1) savefig("noPreco_spectrum_2") ## p = 4 # setup p = 4 dimension = 1 mesh = Mesh1D(1.0) # operator diffusion = GalleryOperator("diffusion", p+1, p+1, mesh) # NoPreco smoother noPreco = NoPreco(diffusion) # full operator symbols numbersteps = 250 maxeigenvalue = 0 θ_min = -π/2 θ_max = 3π/2 θ_step = 2π/(numbersteps-1) θ_range = θ_min:θ_step:θ_max # compute and plot smoothing factor # setup ω = [1.00] eigenvalues = zeros(numbersteps, p) # compute for i in 1:numbersteps θ = [θ_range[i]] if abs(θ[1]) > π/512 A = computesymbols(noPreco, ω, θ) currenteigenvalues = [real(val) for val in eigvals(I-A)] eigenvalues[i, :] = currenteigenvalues end end # plot xrange = θ_range/π plot( xrange, xlabel="θ/π", xtickfont=font(12, "Courier"), eigenvalues, ytickfont=font(12, "Courier"), ylabel="λ", linewidth=3, legend=:none, title="Spectrum of NoPreco Symbol", palette=palette(:tab10) ) ylims!(min(0.0, eigenvalues...) * 1.1, max(eigenvalues...) * 1.1) savefig("noPreco_spectrum_4") ## p = 7 # setup p = 7 dimension = 1 mesh = Mesh1D(1.0) # operator diffusion = GalleryOperator("diffusion", p+1, p+1, mesh) # NoPreco smoother noPreco = NoPreco(diffusion) # full operator symbols numbersteps = 250 maxeigenvalue = 0 θ_min = -π/2 θ_max = 3π/2 θ_step = 2π/(numbersteps-1) θ_range = θ_min:θ_step:θ_max # compute and plot smoothing factor # setup ω = [1.00] eigenvalues = zeros(numbersteps, p) # compute for i in 1:numbersteps θ = [θ_range[i]] if abs(θ[1]) > π/512 A = computesymbols(noPreco, ω, θ) currenteigenvalues = [real(val) for val in eigvals(I-A)] eigenvalues[i, :] = currenteigenvalues end end # plot xrange = θ_range/π plot( xrange, xlabel="θ/π", xtickfont=font(12, "Courier"), eigenvalues, ytickfont=font(12, "Courier"), ylabel="λ", linewidth=3, legend=:none, title="Spectrum of NoPreco Symbol", palette=palette(:tab10) ) ylims!(min(0.0, eigenvalues...) * 1.1, max(eigenvalues...) * 1.1) savefig("noPreco_spectrum_7")
[ 2, 20086, 198, 3500, 47629, 1404, 970, 15813, 198, 3500, 44800, 2348, 29230, 198, 3500, 1345, 1747, 198, 2, 9058, 198, 79, 796, 362, 198, 46156, 796, 352, 198, 76, 5069, 796, 47529, 16, 35, 7, 16, 13, 15, 8, 198, 198, 2, 10088, 198, 26069, 4241, 796, 12917, 18843, 1352, 7203, 26069, 4241, 1600, 279, 10, 16, 11, 279, 10, 16, 11, 19609, 8, 198, 198, 2, 1400, 6719, 1073, 32686, 198, 3919, 6719, 1073, 796, 1400, 6719, 1073, 7, 26069, 4241, 8, 198, 2, 1336, 10088, 14354, 198, 17618, 20214, 796, 8646, 198, 9806, 68, 9324, 8367, 796, 657, 198, 138, 116, 62, 1084, 796, 532, 46582, 14, 17, 198, 138, 116, 62, 9806, 796, 513, 46582, 14, 17, 198, 138, 116, 62, 9662, 796, 362, 46582, 29006, 17618, 20214, 12, 16, 8, 198, 138, 116, 62, 9521, 796, 7377, 116, 62, 1084, 25, 138, 116, 62, 9662, 25, 138, 116, 62, 9806, 198, 198, 2, 24061, 290, 7110, 32746, 722, 5766, 198, 2, 9058, 198, 49535, 796, 685, 16, 13, 405, 60, 198, 68, 9324, 27160, 796, 1976, 27498, 7, 17618, 20214, 11, 279, 8, 198, 198, 2, 24061, 198, 1640, 1312, 287, 352, 25, 17618, 20214, 198, 220, 220, 220, 7377, 116, 796, 685, 138, 116, 62, 9521, 58, 72, 11907, 198, 220, 220, 220, 611, 2352, 7, 138, 116, 58, 16, 12962, 1875, 220, 18074, 222, 14, 25836, 198, 220, 220, 220, 220, 220, 220, 220, 317, 796, 552, 1769, 88, 2022, 10220, 7, 3919, 6719, 1073, 11, 18074, 231, 11, 7377, 116, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1459, 68, 9324, 27160, 796, 685, 5305, 7, 2100, 8, 329, 1188, 287, 304, 328, 12786, 7, 40, 12, 32, 15437, 198, 220, 220, 220, 220, 220, 220, 220, 304, 9324, 27160, 58, 72, 11, 1058, 60, 796, 1459, 68, 9324, 27160, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2, 7110, 198, 87, 9521, 796, 7377, 116, 62, 9521, 14, 46582, 198, 29487, 7, 198, 220, 220, 220, 2124, 9521, 11, 198, 220, 220, 220, 2124, 18242, 2625, 138, 116, 14, 46582, 1600, 198, 220, 220, 220, 220, 742, 624, 10331, 28, 10331, 7, 1065, 11, 366, 34, 280, 5277, 12340, 198, 220, 220, 220, 304, 9324, 27160, 11, 198, 220, 220, 220, 331, 42298, 10331, 28, 10331, 7, 1065, 11, 366, 34, 280, 5277, 12340, 198, 220, 220, 220, 331, 18242, 2625, 39377, 1600, 198, 220, 220, 220, 9493, 413, 5649, 28, 18, 11, 198, 220, 220, 220, 8177, 28, 25, 23108, 11, 198, 220, 220, 220, 3670, 2625, 49738, 6582, 286, 1400, 6719, 1073, 38357, 1600, 198, 220, 220, 220, 27043, 28, 18596, 5857, 7, 25, 8658, 940, 8, 198, 8, 198, 88, 2475, 82, 0, 7, 1084, 7, 15, 13, 15, 11, 304, 9324, 27160, 23029, 1635, 352, 13, 16, 11, 3509, 7, 68, 9324, 27160, 23029, 1635, 352, 13, 16, 8, 198, 21928, 5647, 7203, 3919, 6719, 1073, 62, 4443, 6582, 62, 17, 4943, 198, 198, 2235, 279, 796, 604, 198, 198, 2, 9058, 198, 79, 796, 604, 198, 46156, 796, 352, 198, 76, 5069, 796, 47529, 16, 35, 7, 16, 13, 15, 8, 198, 198, 2, 10088, 198, 26069, 4241, 796, 12917, 18843, 1352, 7203, 26069, 4241, 1600, 279, 10, 16, 11, 279, 10, 16, 11, 19609, 8, 198, 198, 2, 1400, 6719, 1073, 32686, 198, 3919, 6719, 1073, 796, 1400, 6719, 1073, 7, 26069, 4241, 8, 198, 2, 1336, 10088, 14354, 198, 17618, 20214, 796, 8646, 198, 9806, 68, 9324, 8367, 796, 657, 198, 138, 116, 62, 1084, 796, 532, 46582, 14, 17, 198, 138, 116, 62, 9806, 796, 513, 46582, 14, 17, 198, 138, 116, 62, 9662, 796, 362, 46582, 29006, 17618, 20214, 12, 16, 8, 198, 138, 116, 62, 9521, 796, 7377, 116, 62, 1084, 25, 138, 116, 62, 9662, 25, 138, 116, 62, 9806, 198, 198, 2, 24061, 290, 7110, 32746, 722, 5766, 198, 2, 9058, 198, 49535, 796, 685, 16, 13, 405, 60, 198, 68, 9324, 27160, 796, 1976, 27498, 7, 17618, 20214, 11, 279, 8, 198, 198, 2, 24061, 198, 1640, 1312, 287, 352, 25, 17618, 20214, 198, 220, 220, 220, 7377, 116, 796, 685, 138, 116, 62, 9521, 58, 72, 11907, 198, 220, 220, 220, 611, 2352, 7, 138, 116, 58, 16, 12962, 1875, 220, 18074, 222, 14, 25836, 198, 220, 220, 220, 220, 220, 220, 220, 317, 796, 552, 1769, 88, 2022, 10220, 7, 3919, 6719, 1073, 11, 18074, 231, 11, 7377, 116, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1459, 68, 9324, 27160, 796, 685, 5305, 7, 2100, 8, 329, 1188, 287, 304, 328, 12786, 7, 40, 12, 32, 15437, 198, 220, 220, 220, 220, 220, 220, 220, 304, 9324, 27160, 58, 72, 11, 1058, 60, 796, 1459, 68, 9324, 27160, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2, 7110, 198, 87, 9521, 796, 7377, 116, 62, 9521, 14, 46582, 198, 29487, 7, 198, 220, 220, 220, 2124, 9521, 11, 198, 220, 220, 220, 2124, 18242, 2625, 138, 116, 14, 46582, 1600, 198, 220, 220, 220, 220, 742, 624, 10331, 28, 10331, 7, 1065, 11, 366, 34, 280, 5277, 12340, 198, 220, 220, 220, 304, 9324, 27160, 11, 198, 220, 220, 220, 331, 42298, 10331, 28, 10331, 7, 1065, 11, 366, 34, 280, 5277, 12340, 198, 220, 220, 220, 331, 18242, 2625, 39377, 1600, 198, 220, 220, 220, 9493, 413, 5649, 28, 18, 11, 198, 220, 220, 220, 8177, 28, 25, 23108, 11, 198, 220, 220, 220, 3670, 2625, 49738, 6582, 286, 1400, 6719, 1073, 38357, 1600, 198, 220, 220, 220, 27043, 28, 18596, 5857, 7, 25, 8658, 940, 8, 198, 8, 198, 88, 2475, 82, 0, 7, 1084, 7, 15, 13, 15, 11, 304, 9324, 27160, 23029, 1635, 352, 13, 16, 11, 3509, 7, 68, 9324, 27160, 23029, 1635, 352, 13, 16, 8, 198, 21928, 5647, 7203, 3919, 6719, 1073, 62, 4443, 6582, 62, 19, 4943, 198, 198, 2235, 279, 796, 767, 198, 198, 2, 9058, 198, 79, 796, 767, 198, 46156, 796, 352, 198, 76, 5069, 796, 47529, 16, 35, 7, 16, 13, 15, 8, 198, 198, 2, 10088, 198, 26069, 4241, 796, 12917, 18843, 1352, 7203, 26069, 4241, 1600, 279, 10, 16, 11, 279, 10, 16, 11, 19609, 8, 198, 198, 2, 1400, 6719, 1073, 32686, 198, 3919, 6719, 1073, 796, 1400, 6719, 1073, 7, 26069, 4241, 8, 198, 2, 1336, 10088, 14354, 198, 17618, 20214, 796, 8646, 198, 9806, 68, 9324, 8367, 796, 657, 198, 138, 116, 62, 1084, 796, 532, 46582, 14, 17, 198, 138, 116, 62, 9806, 796, 513, 46582, 14, 17, 198, 138, 116, 62, 9662, 796, 362, 46582, 29006, 17618, 20214, 12, 16, 8, 198, 138, 116, 62, 9521, 796, 7377, 116, 62, 1084, 25, 138, 116, 62, 9662, 25, 138, 116, 62, 9806, 198, 198, 2, 24061, 290, 7110, 32746, 722, 5766, 198, 2, 9058, 198, 49535, 796, 685, 16, 13, 405, 60, 198, 68, 9324, 27160, 796, 1976, 27498, 7, 17618, 20214, 11, 279, 8, 198, 198, 2, 24061, 198, 1640, 1312, 287, 352, 25, 17618, 20214, 198, 220, 220, 220, 7377, 116, 796, 685, 138, 116, 62, 9521, 58, 72, 11907, 198, 220, 220, 220, 611, 2352, 7, 138, 116, 58, 16, 12962, 1875, 220, 18074, 222, 14, 25836, 198, 220, 220, 220, 220, 220, 220, 220, 317, 796, 552, 1769, 88, 2022, 10220, 7, 3919, 6719, 1073, 11, 18074, 231, 11, 7377, 116, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1459, 68, 9324, 27160, 796, 685, 5305, 7, 2100, 8, 329, 1188, 287, 304, 328, 12786, 7, 40, 12, 32, 15437, 198, 220, 220, 220, 220, 220, 220, 220, 304, 9324, 27160, 58, 72, 11, 1058, 60, 796, 1459, 68, 9324, 27160, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2, 7110, 198, 87, 9521, 796, 7377, 116, 62, 9521, 14, 46582, 198, 29487, 7, 198, 220, 220, 220, 2124, 9521, 11, 198, 220, 220, 220, 2124, 18242, 2625, 138, 116, 14, 46582, 1600, 198, 220, 220, 220, 220, 742, 624, 10331, 28, 10331, 7, 1065, 11, 366, 34, 280, 5277, 12340, 198, 220, 220, 220, 304, 9324, 27160, 11, 198, 220, 220, 220, 331, 42298, 10331, 28, 10331, 7, 1065, 11, 366, 34, 280, 5277, 12340, 198, 220, 220, 220, 331, 18242, 2625, 39377, 1600, 198, 220, 220, 220, 9493, 413, 5649, 28, 18, 11, 198, 220, 220, 220, 8177, 28, 25, 23108, 11, 198, 220, 220, 220, 3670, 2625, 49738, 6582, 286, 1400, 6719, 1073, 38357, 1600, 198, 220, 220, 220, 27043, 28, 18596, 5857, 7, 25, 8658, 940, 8, 198, 8, 198, 88, 2475, 82, 0, 7, 1084, 7, 15, 13, 15, 11, 304, 9324, 27160, 23029, 1635, 352, 13, 16, 11, 3509, 7, 68, 9324, 27160, 23029, 1635, 352, 13, 16, 8, 198, 21928, 5647, 7203, 3919, 6719, 1073, 62, 4443, 6582, 62, 22, 4943 ]
2.125765
1,471
struct ECE{B<:AbstractBinningAlgorithm,D} <: CalibrationErrorEstimator """Binning algorithm.""" binning::B """Distance function.""" distance::D end """ ECE(binning[, distance = TotalVariation()]) Estimator of the expected calibration error (ECE) for a classification model with respect to the given `distance` function using the `binning` algorithm. For classification models, the predictions ``P_{X_i}`` and targets ``Y_i`` are identified with vectors in the probability simplex. The estimator of the ECE is defined as ```math \\frac{1}{B} \\sum_{i=1}^B d\\big(\\overline{P}_i, \\overline{Y}_i\\big), ``` where ``B`` is the number of non-empty bins, ``d`` is the distance function, and ``\\overline{P}_i`` and ``\\overline{Y}_i`` are the average vector of the predictions and the average vector of targets in the ``i``th bin. By default, the total variation distance is used. The `distance` has to be a function of the form ```julia distance(pbar::Vector{<:Real}, ybar::Vector{<:Real}). ``` In particular, distance measures of the package [Distances.jl](https://github.com/JuliaStats/Distances.jl) are supported. """ ECE(binning::AbstractBinningAlgorithm) = ECE(binning, TotalVariation()) # estimate ECE function (ece::ECE)( predictions::AbstractVector{<:AbstractVector{<:Real}}, targets::AbstractVector{<:Integer}, ) @unpack binning, distance = ece # check number of samples nsamples = check_nsamples(predictions, targets) # bin predictions and labels bins = perform(binning, predictions, targets) nbins = length(bins) nbins > 0 || error("there must exist at least one bin") # compute the weighted mean of the distances in each bin # use West's algorithm for numerical stability # evaluate the distance in the first bin @inbounds begin bin = bins[1] x = distance(bin.mean_predictions, bin.proportions_targets) # initialize the estimate estimate = x / 1 # for all other bins n = bin.nsamples for i in 2:nbins # evaluate the distance bin = bins[i] x = distance(bin.mean_predictions, bin.proportions_targets) # update the estimate m = bin.nsamples n += m estimate += (m / n) * (x - estimate) end end return estimate end
[ 7249, 412, 5222, 90, 33, 27, 25, 23839, 33, 23062, 2348, 42289, 11, 35, 92, 1279, 25, 2199, 571, 1358, 12331, 22362, 320, 1352, 198, 220, 220, 220, 37227, 33, 23062, 11862, 526, 15931, 198, 220, 220, 220, 9874, 768, 3712, 33, 198, 220, 220, 220, 37227, 45767, 2163, 526, 15931, 198, 220, 220, 220, 5253, 3712, 35, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 412, 5222, 7, 8800, 768, 58, 11, 5253, 796, 7472, 23907, 341, 3419, 12962, 198, 198, 22362, 320, 1352, 286, 262, 2938, 36537, 4049, 357, 2943, 36, 8, 329, 257, 17923, 2746, 351, 198, 15008, 284, 262, 1813, 4600, 30246, 63, 2163, 1262, 262, 4600, 8800, 768, 63, 11862, 13, 198, 198, 1890, 17923, 4981, 11, 262, 16277, 7559, 47, 23330, 55, 62, 72, 92, 15506, 290, 6670, 7559, 56, 62, 72, 15506, 389, 5174, 198, 4480, 30104, 287, 262, 12867, 2829, 87, 13, 383, 3959, 1352, 286, 262, 412, 5222, 318, 5447, 355, 198, 15506, 63, 11018, 198, 6852, 31944, 90, 16, 18477, 33, 92, 26867, 16345, 23330, 72, 28, 16, 92, 61, 33, 288, 6852, 14261, 7, 6852, 2502, 1370, 90, 47, 92, 62, 72, 11, 26867, 2502, 1370, 90, 56, 92, 62, 72, 6852, 14261, 828, 198, 15506, 63, 198, 3003, 7559, 33, 15506, 318, 262, 1271, 286, 1729, 12, 28920, 41701, 11, 7559, 67, 15506, 318, 262, 5253, 2163, 11, 290, 198, 15506, 6852, 2502, 1370, 90, 47, 92, 62, 72, 15506, 290, 7559, 6852, 2502, 1370, 90, 56, 92, 62, 72, 15506, 389, 262, 2811, 15879, 286, 262, 16277, 290, 198, 1169, 2811, 15879, 286, 6670, 287, 262, 7559, 72, 15506, 400, 9874, 13, 2750, 4277, 11, 262, 2472, 12291, 5253, 198, 271, 973, 13, 198, 198, 464, 4600, 30246, 63, 468, 284, 307, 257, 2163, 286, 262, 1296, 198, 15506, 63, 73, 43640, 198, 30246, 7, 79, 5657, 3712, 38469, 90, 27, 25, 15633, 5512, 331, 5657, 3712, 38469, 90, 27, 25, 15633, 92, 737, 198, 15506, 63, 198, 818, 1948, 11, 5253, 5260, 286, 262, 5301, 198, 58, 20344, 1817, 13, 20362, 16151, 5450, 1378, 12567, 13, 785, 14, 16980, 544, 29668, 14, 20344, 1817, 13, 20362, 8, 389, 4855, 13, 198, 37811, 198, 2943, 36, 7, 8800, 768, 3712, 23839, 33, 23062, 2348, 42289, 8, 796, 412, 5222, 7, 8800, 768, 11, 7472, 23907, 341, 28955, 198, 198, 2, 8636, 412, 5222, 198, 8818, 357, 68, 344, 3712, 2943, 36, 5769, 198, 220, 220, 220, 16277, 3712, 23839, 38469, 90, 27, 25, 23839, 38469, 90, 27, 25, 15633, 92, 5512, 198, 220, 220, 220, 6670, 3712, 23839, 38469, 90, 27, 25, 46541, 5512, 198, 8, 198, 220, 220, 220, 2488, 403, 8002, 9874, 768, 11, 5253, 796, 304, 344, 628, 220, 220, 220, 1303, 2198, 1271, 286, 8405, 198, 220, 220, 220, 36545, 12629, 796, 2198, 62, 5907, 12629, 7, 28764, 9278, 11, 6670, 8, 628, 220, 220, 220, 1303, 9874, 16277, 290, 14722, 198, 220, 220, 220, 41701, 796, 1620, 7, 8800, 768, 11, 16277, 11, 6670, 8, 198, 220, 220, 220, 299, 65, 1040, 796, 4129, 7, 65, 1040, 8, 198, 220, 220, 220, 299, 65, 1040, 1875, 657, 8614, 4049, 7203, 8117, 1276, 2152, 379, 1551, 530, 9874, 4943, 628, 220, 220, 220, 1303, 24061, 262, 26356, 1612, 286, 262, 18868, 287, 1123, 9874, 198, 220, 220, 220, 1303, 779, 2688, 338, 11862, 329, 29052, 10159, 628, 220, 220, 220, 1303, 13446, 262, 5253, 287, 262, 717, 9874, 198, 220, 220, 220, 2488, 259, 65, 3733, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 9874, 796, 41701, 58, 16, 60, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 796, 5253, 7, 8800, 13, 32604, 62, 28764, 9278, 11, 9874, 13, 1676, 634, 507, 62, 83, 853, 1039, 8, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 41216, 262, 8636, 198, 220, 220, 220, 220, 220, 220, 220, 8636, 796, 2124, 1220, 352, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 329, 477, 584, 41701, 198, 220, 220, 220, 220, 220, 220, 220, 299, 796, 9874, 13, 5907, 12629, 198, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 287, 362, 25, 46803, 1040, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 13446, 262, 5253, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 9874, 796, 41701, 58, 72, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2124, 796, 5253, 7, 8800, 13, 32604, 62, 28764, 9278, 11, 9874, 13, 1676, 634, 507, 62, 83, 853, 1039, 8, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 4296, 262, 8636, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 285, 796, 9874, 13, 5907, 12629, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 15853, 285, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 8636, 15853, 357, 76, 1220, 299, 8, 1635, 357, 87, 532, 8636, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1441, 8636, 198, 437, 198 ]
2.747381
859
# module Octo # SQLElement abstract type SQLElement end const Structured = Array # Union{<:SQLElement, Any} struct FromItem <: SQLElement __octo_model::Type __octo_alias::Union{Symbol, Nothing} end struct SubQuery <: SQLElement __octo_query::Structured __octo_alias::Union{Symbol, Nothing} end struct SQLFunction <: SQLElement name::Symbol fields::Tuple end struct SQLFunctionName <: SQLElement name::Symbol end (f::SQLFunctionName)(args...) = SQLFunction(f.name, args) struct Field <: SQLElement clause::Union{FromItem, SubQuery, Nothing} name::Symbol end struct SQLKeyword <: SQLElement name::Symbol end """ Octo.PlaceHolder """ struct PlaceHolder <: SQLElement body::String end const PredicateValueTypes = Union{Bool, Number, String, Symbol, Day, <:SQLElement, Type{PlaceHolder}} struct Predicate <: SQLElement func::Function left::PredicateValueTypes right::PredicateValueTypes end struct SQLAlias <: SQLElement field::Union{Field, SQLFunction, Predicate} alias::Symbol end struct SQLExtract <: SQLElement field::Union{SQLKeyword, Type{DP}, Type{TP}} where DP <: DatePeriod where TP <: TimePeriod from::Union{DateTime, DP, TP, CompoundPeriod} where DP <: DatePeriod where TP <: TimePeriod end """ Octo.Raw """ struct Raw <: SQLElement string::String end struct Enclosed <: SQLElement values::Vector end struct VectorOfTuples <: SQLElement values::Vector{<:Tuple} end struct KeywordAllKeyword <: SQLElement left::SQLKeyword right::SQLKeyword end # module Octo
[ 2, 8265, 2556, 78, 198, 198, 2, 49747, 2538, 1732, 198, 397, 8709, 2099, 49747, 2538, 1732, 886, 198, 198, 9979, 32112, 1522, 796, 15690, 1303, 4479, 90, 27, 25, 50, 48, 2538, 1732, 11, 4377, 92, 198, 198, 7249, 3574, 7449, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 11593, 38441, 78, 62, 19849, 3712, 6030, 198, 220, 220, 220, 11593, 38441, 78, 62, 26011, 3712, 38176, 90, 13940, 23650, 11, 10528, 92, 198, 437, 198, 198, 7249, 3834, 20746, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 11593, 38441, 78, 62, 22766, 3712, 44909, 1522, 198, 220, 220, 220, 11593, 38441, 78, 62, 26011, 3712, 38176, 90, 13940, 23650, 11, 10528, 92, 198, 437, 198, 198, 7249, 16363, 22203, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 1438, 3712, 13940, 23650, 198, 220, 220, 220, 7032, 3712, 51, 29291, 198, 437, 198, 198, 7249, 16363, 22203, 5376, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 1438, 3712, 13940, 23650, 198, 437, 198, 7, 69, 3712, 17861, 22203, 5376, 5769, 22046, 23029, 796, 16363, 22203, 7, 69, 13, 3672, 11, 26498, 8, 198, 198, 7249, 7663, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 13444, 3712, 38176, 90, 4863, 7449, 11, 3834, 20746, 11, 10528, 92, 198, 220, 220, 220, 1438, 3712, 13940, 23650, 198, 437, 198, 198, 7249, 16363, 9218, 4775, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 1438, 3712, 13940, 23650, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 2556, 78, 13, 27271, 39, 19892, 198, 37811, 198, 7249, 8474, 39, 19892, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 1767, 3712, 10100, 198, 437, 198, 198, 9979, 14322, 5344, 11395, 31431, 796, 4479, 90, 33, 970, 11, 7913, 11, 10903, 11, 38357, 11, 3596, 11, 1279, 25, 50, 48, 2538, 1732, 11, 5994, 90, 27271, 39, 19892, 11709, 198, 198, 7249, 14322, 5344, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 25439, 3712, 22203, 198, 220, 220, 220, 1364, 3712, 39156, 5344, 11395, 31431, 198, 220, 220, 220, 826, 3712, 39156, 5344, 11395, 31431, 198, 437, 198, 198, 7249, 16363, 40489, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 2214, 3712, 38176, 90, 15878, 11, 16363, 22203, 11, 14322, 5344, 92, 198, 220, 220, 220, 16144, 3712, 13940, 23650, 198, 437, 198, 198, 7249, 49747, 2538, 742, 974, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 2214, 3712, 38176, 90, 17861, 9218, 4775, 11, 5994, 90, 6322, 5512, 5994, 90, 7250, 11709, 220, 220, 220, 220, 810, 27704, 1279, 25, 7536, 5990, 2101, 810, 24525, 1279, 25, 3862, 5990, 2101, 198, 220, 220, 220, 422, 3712, 38176, 90, 10430, 7575, 11, 27704, 11, 24525, 11, 3082, 633, 5990, 2101, 92, 810, 27704, 1279, 25, 7536, 5990, 2101, 810, 24525, 1279, 25, 3862, 5990, 2101, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 2556, 78, 13, 27369, 198, 37811, 198, 7249, 16089, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 4731, 3712, 10100, 198, 437, 198, 198, 7249, 2039, 20225, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 3815, 3712, 38469, 198, 437, 198, 198, 7249, 20650, 5189, 47247, 2374, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 3815, 3712, 38469, 90, 27, 25, 51, 29291, 92, 198, 437, 198, 198, 7249, 7383, 4775, 3237, 9218, 4775, 1279, 25, 49747, 2538, 1732, 198, 220, 220, 220, 1364, 3712, 17861, 9218, 4775, 198, 220, 220, 220, 826, 3712, 17861, 9218, 4775, 198, 437, 198, 198, 2, 8265, 2556, 78, 198 ]
2.695578
588
#bld_parametric_sin_initial.jl: Parametric sin(): Initial observations #------------------------------------------------------------------------------- using CMDimData using CMDimData.EasyPlot #==Constants ===============================================================================# LBL_AXIS_TIME = "Time [s]" LBL_AXIS_POSITION = "Position [m]" LBL_AXIS_NORMPOSITION = "Normalized Pos [m/m]" LBL_AXIS_SPEED = "Speed [m/s]" lstylesweep = cons(:a, line = set(style=:solid, width=2)) #Default is a bit thin dfltglyph = cons(:a, glyph = set(shape=:o, size=1.5)) function fnbuild(data) plot = cons(:plot, nstrips = 3, ystrip1 = set(axislabel=LBL_AXIS_POSITION, striplabel="Sinusoidal response"), ystrip2 = set(axislabel=LBL_AXIS_NORMPOSITION, striplabel="Normalized response (All peaks should be ±1)"), ystrip3 = set(axislabel=LBL_AXIS_SPEED, striplabel="Rate of change (should be larger for higher frequencies)"), xaxis = set(label=LBL_AXIS_TIME) ) push!(plot, cons(:wfrm, data.signal, lstylesweep, label="", strip=1), cons(:wfrm, data.signal_norm, lstylesweep, label="", strip=2), cons(:wfrm, data.rate, lstylesweep, label="", strip=3), ) pcoll = push!(cons(:plotcoll, title="Parametric sin() - Initial Observations"), plot) return pcoll end #Return EasyPlotBuilder object: EasyPlot.EasyPlotBuilder(fnbuild)
[ 2, 65, 335, 62, 17143, 19482, 62, 31369, 62, 36733, 13, 20362, 25, 25139, 19482, 7813, 33529, 20768, 13050, 198, 2, 10097, 24305, 198, 3500, 327, 12740, 320, 6601, 198, 3500, 327, 12740, 320, 6601, 13, 28406, 43328, 628, 198, 2, 855, 34184, 1187, 198, 23926, 25609, 18604, 2, 198, 43, 9148, 62, 25922, 1797, 62, 34694, 796, 366, 7575, 685, 82, 30866, 198, 43, 9148, 62, 25922, 1797, 62, 37997, 17941, 796, 366, 26545, 685, 76, 30866, 198, 43, 9148, 62, 25922, 1797, 62, 35510, 7378, 2640, 17941, 796, 366, 26447, 1143, 18574, 685, 76, 14, 76, 30866, 198, 43, 9148, 62, 25922, 1797, 62, 4303, 41841, 796, 366, 22785, 685, 76, 14, 82, 30866, 198, 75, 47720, 732, 538, 796, 762, 7, 25, 64, 11, 1627, 796, 900, 7, 7635, 28, 25, 39390, 11, 9647, 28, 17, 4008, 1303, 19463, 318, 257, 1643, 7888, 198, 7568, 2528, 10853, 746, 796, 762, 7, 25, 64, 11, 25874, 796, 900, 7, 43358, 28, 25, 78, 11, 2546, 28, 16, 13, 20, 4008, 198, 198, 8818, 24714, 11249, 7, 7890, 8, 198, 197, 29487, 796, 762, 7, 25, 29487, 11, 299, 33565, 862, 796, 513, 11, 198, 197, 197, 88, 36311, 16, 796, 900, 7, 897, 3044, 9608, 28, 43, 9148, 62, 25922, 1797, 62, 37997, 17941, 11, 2338, 489, 9608, 2625, 50, 35237, 47502, 2882, 12340, 198, 197, 197, 88, 36311, 17, 796, 900, 7, 897, 3044, 9608, 28, 43, 9148, 62, 25922, 1797, 62, 35510, 7378, 2640, 17941, 11, 2338, 489, 9608, 2625, 26447, 1143, 2882, 357, 3237, 25740, 815, 307, 6354, 16, 8, 12340, 198, 197, 197, 88, 36311, 18, 796, 900, 7, 897, 3044, 9608, 28, 43, 9148, 62, 25922, 1797, 62, 4303, 41841, 11, 2338, 489, 9608, 2625, 32184, 286, 1487, 357, 21754, 307, 4025, 329, 2440, 19998, 8, 12340, 198, 197, 197, 87, 22704, 796, 900, 7, 18242, 28, 43, 9148, 62, 25922, 1797, 62, 34694, 8, 198, 197, 8, 198, 197, 14689, 0, 7, 29487, 11, 198, 197, 197, 5936, 7, 25, 86, 8310, 76, 11, 1366, 13, 12683, 282, 11, 300, 47720, 732, 538, 11, 6167, 2625, 1600, 10283, 28, 16, 828, 198, 197, 197, 5936, 7, 25, 86, 8310, 76, 11, 1366, 13, 12683, 282, 62, 27237, 11, 300, 47720, 732, 538, 11, 6167, 2625, 1600, 10283, 28, 17, 828, 198, 197, 197, 5936, 7, 25, 86, 8310, 76, 11, 1366, 13, 4873, 11, 300, 47720, 732, 538, 11, 6167, 2625, 1600, 10283, 28, 18, 828, 198, 197, 8, 198, 197, 14751, 692, 796, 4574, 0, 7, 5936, 7, 25, 29487, 26000, 11, 3670, 2625, 22973, 19482, 7813, 3419, 532, 20768, 19243, 602, 12340, 7110, 8, 198, 197, 7783, 279, 26000, 198, 437, 198, 198, 2, 13615, 16789, 43328, 32875, 2134, 25, 198, 28406, 43328, 13, 28406, 43328, 32875, 7, 22184, 11249, 8, 198 ]
2.824153
472
export genplots, getexamples, runplotgen """ results = runplotgen() Run full generation of the plots needed for the tests in ControlSystems.jl """ function runplotgen() funcs, refs, eps = getexamples() genplots(funcs, refs, eps=eps) end """ results = genplots(funcs, refs; eps, kwargs...) Generate the plots needed for the tests in ControlSystems.jl """ function genplots(funcs, refs; eps=0.01*ones(length(refs)), kwargs...) ENV["MPLBACKEND"] = "Agg" results = Array{VisualRegressionTests.VisualTestResult,1}(undef, length(refs)) #Run/generate tests for (i,ref) in enumerate(refs) testf(fn) = png(funcs[i](), fn) results[i] = test_images(VisualTest(testf, ref); tol=eps[i], kwargs...) end results end """funcs, refs, eps = getexamples() Get the example functions and locations of reference plots needed for the tests in ControlSystems.jl """ function getexamples() tf1 = tf([1],[1,1]) tf2 = tf([1/5,2],[1,1,1]) sys = [tf1 tf2] sysss = ss([-1 2; 0 1], [1 0; 1 1], [1 0; 0 1], [0.1 0; 0 -0.2]) ws = 10.0 .^range(-2,stop=2,length=200) ts = 0:0.01:5 bodegen() = begin setPlotScale("dB") bodeplot(sys,ws) end nyquistgen() = nyquistplot(sysss,ws) sigmagen() = sigmaplot(sysss,ws) #Only siso for now nicholsgen() = nicholsplot(tf1,ws) stepgen() = stepplot(sys, ts[end], ts[2]-ts[1], l=(:dash, 4)) impulsegen() = impulseplot(sys, ts[end], ts[2]-ts[1], l=:blue) L = lqr(sysss.A, sysss.B, [1 0; 0 1], [1 0; 0 1]) lsimgen() = lsimplot(sysss, (x,i)->-L*x, ts, [1;2]) margingen() = marginplot([tf1, tf2], ws) gangoffourgen() = begin setPlotScale("log10"); gangoffourplot(tf1, [tf(1), tf(5)]) end pzmapgen() = pzmap(tf2, xlims=(-15,5)) rlocusgen() = rlocusplot(tf2) plotsdir = joinpath(dirname(pathof(ControlExamplePlots)), "..", "src", "figures") refs = ["bode.png", "nyquist.png", "sigma.png", "nichols.png", "step.png", "impulse.png", "lsim.png", "margin.png", "gangoffour.png", "pzmap.png", "rlocus.png"] funcs = [bodegen, nyquistgen, sigmagen, nicholsgen, stepgen, impulsegen, lsimgen, margingen, gangoffourgen, pzmapgen, rlocusgen] eps = 0.001*ones(length(refs)); funcs, map(s -> joinpath(plotsdir,s), refs), eps end
[ 39344, 2429, 489, 1747, 11, 651, 1069, 12629, 11, 1057, 29487, 5235, 198, 198, 37811, 2482, 796, 1057, 29487, 5235, 3419, 198, 10987, 1336, 5270, 286, 262, 21528, 2622, 329, 262, 5254, 287, 6779, 11964, 82, 13, 20362, 198, 37811, 198, 8818, 1057, 29487, 5235, 3419, 198, 220, 1257, 6359, 11, 1006, 82, 11, 304, 862, 796, 651, 1069, 12629, 3419, 198, 220, 2429, 489, 1747, 7, 12543, 6359, 11, 1006, 82, 11, 304, 862, 28, 25386, 8, 198, 437, 198, 198, 37811, 2482, 796, 2429, 489, 1747, 7, 12543, 6359, 11, 1006, 82, 26, 304, 862, 11, 479, 86, 22046, 23029, 198, 8645, 378, 262, 21528, 2622, 329, 262, 5254, 287, 6779, 11964, 82, 13, 20362, 198, 37811, 198, 8818, 2429, 489, 1747, 7, 12543, 6359, 11, 1006, 82, 26, 304, 862, 28, 15, 13, 486, 9, 1952, 7, 13664, 7, 5420, 82, 36911, 479, 86, 22046, 23029, 198, 220, 220, 220, 12964, 53, 14692, 44, 6489, 31098, 10619, 8973, 796, 366, 46384, 1, 198, 220, 220, 220, 2482, 796, 15690, 90, 36259, 8081, 2234, 51, 3558, 13, 36259, 14402, 23004, 11, 16, 92, 7, 917, 891, 11, 4129, 7, 5420, 82, 4008, 198, 220, 220, 220, 1303, 10987, 14, 8612, 378, 5254, 198, 220, 220, 220, 329, 357, 72, 11, 5420, 8, 287, 27056, 378, 7, 5420, 82, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1332, 69, 7, 22184, 8, 796, 279, 782, 7, 12543, 6359, 58, 72, 16151, 828, 24714, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2482, 58, 72, 60, 796, 1332, 62, 17566, 7, 36259, 14402, 7, 9288, 69, 11, 1006, 1776, 284, 75, 28, 25386, 58, 72, 4357, 479, 86, 22046, 23029, 198, 220, 220, 220, 886, 198, 220, 220, 220, 2482, 198, 437, 198, 198, 37811, 12543, 6359, 11, 1006, 82, 11, 304, 862, 796, 651, 1069, 12629, 3419, 198, 3855, 262, 1672, 5499, 290, 7064, 286, 4941, 21528, 2622, 329, 262, 5254, 287, 6779, 11964, 82, 13, 20362, 198, 37811, 198, 8818, 651, 1069, 12629, 3419, 198, 220, 220, 220, 48700, 16, 796, 48700, 26933, 16, 38430, 16, 11, 16, 12962, 198, 220, 220, 220, 48700, 17, 796, 48700, 26933, 16, 14, 20, 11, 17, 38430, 16, 11, 16, 11, 16, 12962, 198, 220, 220, 220, 25064, 796, 685, 27110, 16, 48700, 17, 60, 198, 220, 220, 220, 827, 824, 82, 796, 37786, 26933, 12, 16, 362, 26, 657, 352, 4357, 685, 16, 657, 26, 352, 352, 4357, 685, 16, 657, 26, 657, 352, 4357, 685, 15, 13, 16, 657, 26, 657, 532, 15, 13, 17, 12962, 628, 220, 220, 220, 266, 82, 796, 838, 13, 15, 764, 61, 9521, 32590, 17, 11, 11338, 28, 17, 11, 13664, 28, 2167, 8, 198, 220, 220, 220, 40379, 796, 657, 25, 15, 13, 486, 25, 20, 198, 220, 220, 220, 275, 1098, 5235, 3419, 796, 2221, 198, 220, 220, 220, 220, 220, 900, 43328, 29990, 7203, 36077, 4943, 198, 220, 220, 220, 220, 220, 275, 1098, 29487, 7, 17597, 11, 18504, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 299, 88, 30062, 5235, 3419, 796, 299, 88, 30062, 29487, 7, 1837, 824, 82, 11, 18504, 8, 198, 220, 220, 220, 264, 17225, 11286, 3419, 796, 264, 13495, 29487, 7, 1837, 824, 82, 11, 18504, 8, 198, 220, 220, 220, 1303, 10049, 264, 26786, 329, 783, 198, 220, 220, 220, 299, 488, 10220, 5235, 3419, 796, 299, 488, 10220, 29487, 7, 27110, 16, 11, 18504, 8, 628, 220, 220, 220, 2239, 5235, 3419, 796, 2876, 381, 26487, 7, 17597, 11, 40379, 58, 437, 4357, 40379, 58, 17, 45297, 912, 58, 16, 4357, 300, 16193, 25, 42460, 11, 604, 4008, 198, 220, 220, 220, 25278, 5235, 3419, 796, 25278, 29487, 7, 17597, 11, 40379, 58, 437, 4357, 40379, 58, 17, 45297, 912, 58, 16, 4357, 300, 28, 25, 17585, 8, 198, 220, 220, 220, 406, 796, 300, 80, 81, 7, 1837, 824, 82, 13, 32, 11, 827, 824, 82, 13, 33, 11, 685, 16, 657, 26, 657, 352, 4357, 685, 16, 657, 26, 657, 352, 12962, 198, 220, 220, 220, 300, 14323, 5235, 3419, 796, 300, 14323, 29487, 7, 1837, 824, 82, 11, 357, 87, 11, 72, 8, 3784, 12, 43, 9, 87, 11, 40379, 11, 685, 16, 26, 17, 12962, 628, 220, 220, 220, 6145, 36795, 3419, 796, 10330, 29487, 26933, 27110, 16, 11, 48700, 17, 4357, 266, 82, 8, 198, 220, 220, 220, 7706, 2364, 454, 5235, 3419, 796, 2221, 198, 220, 220, 220, 220, 220, 900, 43328, 29990, 7203, 6404, 940, 15341, 198, 220, 220, 220, 220, 220, 7706, 2364, 454, 29487, 7, 27110, 16, 11, 685, 27110, 7, 16, 828, 48700, 7, 20, 8, 12962, 198, 220, 220, 220, 886, 198, 220, 220, 220, 279, 89, 8899, 5235, 3419, 796, 279, 89, 8899, 7, 27110, 17, 11, 2124, 2475, 82, 16193, 12, 1314, 11, 20, 4008, 198, 220, 220, 220, 374, 75, 10901, 5235, 3419, 796, 374, 75, 10901, 29487, 7, 27110, 17, 8, 628, 220, 220, 220, 21528, 15908, 796, 4654, 6978, 7, 15908, 3672, 7, 6978, 1659, 7, 15988, 16281, 3646, 1747, 36911, 366, 492, 1600, 366, 10677, 1600, 366, 5647, 942, 4943, 198, 220, 220, 220, 1006, 82, 796, 14631, 65, 1098, 13, 11134, 1600, 366, 3281, 30062, 13, 11134, 1600, 366, 82, 13495, 13, 11134, 1600, 366, 77, 488, 10220, 13, 11134, 1600, 366, 9662, 13, 11134, 1600, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 366, 11011, 9615, 13, 11134, 1600, 366, 7278, 320, 13, 11134, 1600, 366, 36153, 13, 11134, 1600, 366, 28284, 2364, 454, 13, 11134, 1600, 366, 79, 89, 8899, 13, 11134, 1600, 366, 45895, 10901, 13, 11134, 8973, 198, 220, 220, 220, 1257, 6359, 796, 685, 65, 1098, 5235, 11, 299, 88, 30062, 5235, 11, 264, 17225, 11286, 11, 299, 488, 10220, 5235, 11, 2239, 5235, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 25278, 5235, 11, 300, 14323, 5235, 11, 6145, 36795, 11, 7706, 2364, 454, 5235, 11, 279, 89, 8899, 5235, 11, 374, 75, 10901, 5235, 60, 198, 220, 220, 220, 304, 862, 796, 657, 13, 8298, 9, 1952, 7, 13664, 7, 5420, 82, 18125, 198, 220, 220, 220, 1257, 6359, 11, 3975, 7, 82, 4613, 4654, 6978, 7, 489, 1747, 15908, 11, 82, 828, 1006, 82, 828, 304, 862, 198, 437, 198 ]
2.1862
1,058
###### ###### `inv` ###### function frule((_, Δx), ::typeof(inv), x::AbstractArray) Ω = inv(x) return Ω, -Ω * Δx * Ω end function rrule(::typeof(inv), x::AbstractArray) Ω = inv(x) function inv_pullback(ΔΩ) return NO_FIELDS, -Ω' * ΔΩ * Ω' end return Ω, inv_pullback end ##### ##### `*` ##### function rrule(::typeof(*), A::AbstractMatrix{<:Real}, B::AbstractMatrix{<:Real}) function times_pullback(Ȳ) return (NO_FIELDS, @thunk(Ȳ * B'), @thunk(A' * Ȳ)) end return A * B, times_pullback end function rrule(::typeof(*), A::Real, B::AbstractArray{<:Real}) function times_pullback(Ȳ) return (NO_FIELDS, @thunk(dot(Ȳ, B)), @thunk(A * Ȳ)) end return A * B, times_pullback end function rrule(::typeof(*), B::AbstractArray{<:Real}, A::Real) function times_pullback(Ȳ) return (NO_FIELDS, @thunk(A * Ȳ), @thunk(dot(Ȳ, B))) end return A * B, times_pullback end ##### ##### `/` ##### function rrule(::typeof(/), A::AbstractVecOrMat{<:Real}, B::AbstractVecOrMat{<:Real}) Aᵀ, dA_pb = rrule(adjoint, A) Bᵀ, dB_pb = rrule(adjoint, B) Cᵀ, dS_pb = rrule(\, Bᵀ, Aᵀ) C, dC_pb = rrule(adjoint, Cᵀ) function slash_pullback(Ȳ) # Optimization note: dAᵀ, dBᵀ, dC are calculated no matter which partial you want _, dC = dC_pb(Ȳ) _, dBᵀ, dAᵀ = dS_pb(unthunk(dC)) ∂A = last(dA_pb(unthunk(dAᵀ))) ∂B = last(dA_pb(unthunk(dBᵀ))) (NO_FIELDS, ∂A, ∂B) end return C, slash_pullback end ##### ##### `\` ##### function rrule(::typeof(\), A::AbstractVecOrMat{<:Real}, B::AbstractVecOrMat{<:Real}) Y = A \ B function backslash_pullback(Ȳ) ∂A = @thunk begin B̄ = A' \ Ȳ Ā = -B̄ * Y' Ā = add!!(Ā, (B - A * Y) * B̄' / A') Ā = add!!(Ā, A' \ Y * (Ȳ' - B̄'A)) Ā end ∂B = @thunk A' \ Ȳ return NO_FIELDS, ∂A, ∂B end return Y, backslash_pullback end ##### ##### `\`, `/` matrix-scalar_rule ##### function rrule(::typeof(/), A::AbstractArray{<:Real}, b::Real) Y = A/b function slash_pullback(Ȳ) return (NO_FIELDS, @thunk(Ȳ/b), @thunk(-dot(Ȳ, Y)/b)) end return Y, slash_pullback end function rrule(::typeof(\), b::Real, A::AbstractArray{<:Real}) Y = b\A function backslash_pullback(Ȳ) return (NO_FIELDS, @thunk(-dot(Ȳ, Y)/b), @thunk(Ȳ/b)) end return Y, backslash_pullback end
[ 4242, 2235, 198, 4242, 2235, 4600, 16340, 63, 198, 4242, 2235, 198, 198, 8818, 12658, 293, 19510, 62, 11, 37455, 87, 828, 7904, 4906, 1659, 7, 16340, 828, 2124, 3712, 23839, 19182, 8, 198, 220, 220, 220, 7377, 102, 796, 800, 7, 87, 8, 198, 220, 220, 220, 1441, 7377, 102, 11, 532, 138, 102, 1635, 37455, 87, 1635, 7377, 102, 198, 437, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 7, 16340, 828, 2124, 3712, 23839, 19182, 8, 198, 220, 220, 220, 7377, 102, 796, 800, 7, 87, 8, 198, 220, 220, 220, 2163, 800, 62, 31216, 1891, 7, 138, 242, 138, 102, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 8005, 62, 11674, 3698, 5258, 11, 532, 138, 102, 6, 1635, 37455, 138, 102, 1635, 7377, 102, 6, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 7377, 102, 11, 800, 62, 31216, 1891, 198, 437, 198, 198, 4242, 2, 198, 4242, 2, 4600, 9, 63, 198, 4242, 2, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 46491, 828, 317, 3712, 23839, 46912, 90, 27, 25, 15633, 5512, 347, 3712, 23839, 46912, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 2163, 1661, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 15285, 62, 11674, 3698, 5258, 11, 2488, 400, 2954, 7, 56, 136, 226, 1635, 347, 33809, 2488, 400, 2954, 7, 32, 6, 1635, 575, 136, 226, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 317, 1635, 347, 11, 1661, 62, 31216, 1891, 198, 437, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 46491, 828, 317, 3712, 15633, 11, 347, 3712, 23839, 19182, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 2163, 1661, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 15285, 62, 11674, 3698, 5258, 11, 2488, 400, 2954, 7, 26518, 7, 56, 136, 226, 11, 347, 36911, 2488, 400, 2954, 7, 32, 1635, 575, 136, 226, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 317, 1635, 347, 11, 1661, 62, 31216, 1891, 198, 437, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 46491, 828, 347, 3712, 23839, 19182, 90, 27, 25, 15633, 5512, 317, 3712, 15633, 8, 198, 220, 220, 220, 2163, 1661, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 15285, 62, 11674, 3698, 5258, 11, 2488, 400, 2954, 7, 32, 1635, 575, 136, 226, 828, 2488, 400, 2954, 7, 26518, 7, 56, 136, 226, 11, 347, 22305, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 317, 1635, 347, 11, 1661, 62, 31216, 1891, 198, 437, 628, 198, 198, 4242, 2, 198, 4242, 2, 4600, 14, 63, 198, 4242, 2, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 7, 14, 828, 317, 3712, 23839, 53, 721, 5574, 19044, 90, 27, 25, 15633, 5512, 347, 3712, 23839, 53, 721, 5574, 19044, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 317, 39611, 222, 11, 288, 32, 62, 40842, 796, 374, 25135, 7, 41255, 1563, 11, 317, 8, 198, 220, 220, 220, 347, 39611, 222, 11, 30221, 62, 40842, 796, 374, 25135, 7, 41255, 1563, 11, 347, 8, 198, 220, 220, 220, 327, 39611, 222, 11, 288, 50, 62, 40842, 796, 374, 25135, 38016, 11, 347, 39611, 222, 11, 317, 39611, 222, 8, 198, 220, 220, 220, 327, 11, 288, 34, 62, 40842, 796, 374, 25135, 7, 41255, 1563, 11, 327, 39611, 222, 8, 198, 220, 220, 220, 2163, 24632, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 30011, 1634, 3465, 25, 288, 32, 39611, 222, 11, 30221, 39611, 222, 11, 288, 34, 389, 10488, 645, 2300, 543, 13027, 345, 765, 198, 220, 220, 220, 220, 220, 220, 220, 4808, 11, 288, 34, 796, 288, 34, 62, 40842, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 4808, 11, 30221, 39611, 222, 11, 288, 32, 39611, 222, 796, 288, 50, 62, 40842, 7, 403, 400, 2954, 7, 67, 34, 4008, 628, 220, 220, 220, 220, 220, 220, 220, 18872, 224, 32, 796, 938, 7, 67, 32, 62, 40842, 7, 403, 400, 2954, 7, 67, 32, 39611, 222, 22305, 198, 220, 220, 220, 220, 220, 220, 220, 18872, 224, 33, 796, 938, 7, 67, 32, 62, 40842, 7, 403, 400, 2954, 7, 36077, 39611, 222, 22305, 628, 220, 220, 220, 220, 220, 220, 220, 357, 15285, 62, 11674, 3698, 5258, 11, 18872, 224, 32, 11, 18872, 224, 33, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 327, 11, 24632, 62, 31216, 1891, 198, 437, 198, 198, 4242, 2, 198, 4242, 2, 4600, 59, 63, 198, 4242, 2, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 38016, 828, 317, 3712, 23839, 53, 721, 5574, 19044, 90, 27, 25, 15633, 5512, 347, 3712, 23839, 53, 721, 5574, 19044, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 575, 796, 317, 3467, 347, 198, 220, 220, 220, 2163, 736, 6649, 1077, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 18872, 224, 32, 796, 2488, 400, 2954, 2221, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 347, 136, 226, 796, 317, 6, 3467, 575, 136, 226, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 317, 136, 226, 796, 532, 33, 136, 226, 1635, 575, 6, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 317, 136, 226, 796, 751, 3228, 7, 32, 136, 226, 11, 357, 33, 532, 317, 1635, 575, 8, 1635, 347, 136, 226, 6, 1220, 317, 11537, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 317, 136, 226, 796, 751, 3228, 7, 32, 136, 226, 11, 317, 6, 3467, 575, 1635, 357, 56, 136, 226, 6, 532, 347, 136, 226, 6, 32, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 317, 136, 226, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 18872, 224, 33, 796, 2488, 400, 2954, 317, 6, 3467, 575, 136, 226, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 8005, 62, 11674, 3698, 5258, 11, 18872, 224, 32, 11, 18872, 224, 33, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 575, 11, 736, 6649, 1077, 62, 31216, 1891, 198, 198, 437, 198, 198, 4242, 2, 198, 4242, 2, 4600, 59, 47671, 4600, 14, 63, 17593, 12, 1416, 282, 283, 62, 25135, 198, 4242, 2, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 7, 14, 828, 317, 3712, 23839, 19182, 90, 27, 25, 15633, 5512, 275, 3712, 15633, 8, 198, 220, 220, 220, 575, 796, 317, 14, 65, 198, 220, 220, 220, 2163, 24632, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 15285, 62, 11674, 3698, 5258, 11, 2488, 400, 2954, 7, 56, 136, 226, 14, 65, 828, 2488, 400, 2954, 32590, 26518, 7, 56, 136, 226, 11, 575, 20679, 65, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 575, 11, 24632, 62, 31216, 1891, 198, 437, 198, 198, 8818, 374, 25135, 7, 3712, 4906, 1659, 38016, 828, 275, 3712, 15633, 11, 317, 3712, 23839, 19182, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 575, 796, 275, 59, 32, 198, 220, 220, 220, 2163, 736, 6649, 1077, 62, 31216, 1891, 7, 56, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 15285, 62, 11674, 3698, 5258, 11, 2488, 400, 2954, 32590, 26518, 7, 56, 136, 226, 11, 575, 20679, 65, 828, 2488, 400, 2954, 7, 56, 136, 226, 14, 65, 4008, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 575, 11, 736, 6649, 1077, 62, 31216, 1891, 198, 437, 198 ]
1.877259
1,328
function getIndexes(i,j,d) if i == j return [i] elseif i > j && i > 2 return 0 else niz1 = [] niz2 = collect(i:j-1) for k in 1:d if !(k in niz2) push!(niz1,k) end end return length(niz1) == 0 ? 0 : niz1 end end function getSelectedColumns(selectedColumns,X) localX = [] if selectedColumns != 0 for i in selectedColumns push!(localX,X[:,i]) end return localX else return 0 end end X = [1 2 3 4 5; 1 2 3 4 5; 1 2 3 4 5; 1 2 3 4 5] d = 10 for i in 1:d-1 for j in 1:d temp = getIndexes(i,j,d) println(temp == 0 ? "" : temp) end end
[ 198, 198, 8818, 651, 15732, 274, 7, 72, 11, 73, 11, 67, 8, 198, 220, 220, 220, 611, 1312, 6624, 474, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 685, 72, 60, 198, 220, 220, 220, 2073, 361, 1312, 1875, 474, 11405, 1312, 1875, 362, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 657, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 299, 528, 16, 796, 17635, 198, 220, 220, 220, 220, 220, 220, 220, 299, 528, 17, 796, 2824, 7, 72, 25, 73, 12, 16, 8, 198, 220, 220, 220, 220, 220, 220, 220, 329, 479, 287, 352, 25, 67, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 5145, 7, 74, 287, 299, 528, 17, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 77, 528, 16, 11, 74, 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, 220, 220, 220, 220, 1441, 4129, 7, 77, 528, 16, 8, 6624, 657, 5633, 657, 1058, 299, 528, 16, 198, 220, 220, 220, 886, 198, 437, 628, 628, 198, 8818, 651, 4653, 12609, 39470, 82, 7, 34213, 39470, 82, 11, 55, 8, 198, 220, 220, 220, 1957, 55, 796, 17635, 198, 220, 220, 220, 611, 6163, 39470, 82, 14512, 657, 198, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 287, 6163, 39470, 82, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 12001, 55, 11, 55, 58, 45299, 72, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 1957, 55, 198, 220, 220, 220, 2073, 220, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 657, 198, 220, 220, 220, 886, 198, 437, 628, 198, 55, 796, 685, 16, 362, 513, 604, 642, 26, 198, 220, 220, 220, 220, 352, 362, 513, 604, 642, 26, 198, 220, 220, 220, 220, 352, 362, 513, 604, 642, 26, 198, 220, 220, 220, 220, 352, 362, 513, 604, 642, 60, 628, 198, 67, 796, 838, 198, 198, 1640, 1312, 287, 352, 25, 67, 12, 16, 198, 220, 220, 220, 329, 474, 287, 352, 25, 67, 198, 220, 220, 220, 220, 220, 220, 220, 20218, 796, 651, 15732, 274, 7, 72, 11, 73, 11, 67, 8, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 29510, 6624, 657, 5633, 13538, 1058, 20218, 8, 198, 220, 220, 220, 886, 198, 437 ]
1.728111
434
function obtain_raw_data(base_dir::String, sha::String) data_path = joinpath(base_dir,"raw_input_data") ispath(data_path) && rm(data_path, recursive = true) mkpath(data_path) if Sys.iswindows() POWERSYSTEMSTESTDATA_URL = "https://github.com/GridMod/RTS-GMLC/archive/$(sha).zip" else POWERSYSTEMSTESTDATA_URL = "https://github.com/GridMod/RTS-GMLC/archive/$(sha).tar.gz" end tempfilename= Base.download(POWERSYSTEMSTESTDATA_URL) Sys.iswindows() && unzip_windows(tempfilename, base_dir) Sys.islinux() && unzip_unix(tempfilename, base_dir) Sys.isapple() && unzip_unix(tempfilename, base_dir) mv(joinpath(base_dir, "RTS-GMLC-$(sha)"), data_path, force=true) return data_path end function unzip_unix(filename, directory) @assert success(`tar -xvf $filename -C $directory`) "Unable to extract $filename to $directory" end function unzip_windows(filename, directory) home = (Base.VERSION < v"0.7-") ? JULIA_HOME : Sys.BINDIR @assert success(`$home/7z x $filename -y -o$directory`) "Unable to extract $filename to $directory" end
[ 8818, 7330, 62, 1831, 62, 7890, 7, 8692, 62, 15908, 3712, 10100, 11, 427, 64, 3712, 10100, 8, 198, 220, 220, 220, 1366, 62, 6978, 796, 4654, 6978, 7, 8692, 62, 15908, 553, 1831, 62, 15414, 62, 7890, 4943, 198, 220, 220, 220, 318, 6978, 7, 7890, 62, 6978, 8, 11405, 42721, 7, 7890, 62, 6978, 11, 45115, 796, 2081, 8, 198, 220, 220, 220, 33480, 6978, 7, 7890, 62, 6978, 8, 628, 220, 220, 220, 611, 311, 893, 13, 271, 28457, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 24148, 4877, 56, 25361, 2257, 6465, 26947, 62, 21886, 796, 366, 5450, 1378, 12567, 13, 785, 14, 41339, 5841, 14, 49, 4694, 12, 15548, 5639, 14, 17474, 32624, 7, 26270, 737, 13344, 1, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 24148, 4877, 56, 25361, 2257, 6465, 26947, 62, 21886, 796, 366, 5450, 1378, 12567, 13, 785, 14, 41339, 5841, 14, 49, 4694, 12, 15548, 5639, 14, 17474, 32624, 7, 26270, 737, 18870, 13, 34586, 1, 198, 220, 220, 220, 886, 628, 220, 220, 220, 20218, 34345, 28, 7308, 13, 15002, 7, 47, 3913, 4877, 56, 25361, 2257, 6465, 26947, 62, 21886, 8, 198, 220, 220, 220, 311, 893, 13, 271, 28457, 3419, 11405, 555, 13344, 62, 28457, 7, 29510, 34345, 11, 2779, 62, 15908, 8, 198, 220, 220, 220, 311, 893, 13, 271, 23289, 3419, 11405, 555, 13344, 62, 403, 844, 7, 29510, 34345, 11, 2779, 62, 15908, 8, 198, 220, 220, 220, 311, 893, 13, 271, 18040, 3419, 11405, 555, 13344, 62, 403, 844, 7, 29510, 34345, 11, 2779, 62, 15908, 8, 628, 220, 220, 220, 285, 85, 7, 22179, 6978, 7, 8692, 62, 15908, 11, 366, 49, 4694, 12, 15548, 5639, 22799, 7, 26270, 8, 12340, 1366, 62, 6978, 11, 2700, 28, 7942, 8, 628, 220, 220, 220, 1441, 1366, 62, 6978, 198, 198, 437, 198, 198, 8818, 555, 13344, 62, 403, 844, 7, 34345, 11, 8619, 8, 198, 220, 220, 220, 2488, 30493, 1943, 7, 63, 18870, 532, 87, 85, 69, 720, 34345, 532, 34, 720, 34945, 63, 8, 366, 3118, 540, 284, 7925, 720, 34345, 284, 720, 34945, 1, 198, 437, 198, 198, 8818, 555, 13344, 62, 28457, 7, 34345, 11, 8619, 8, 198, 220, 220, 220, 1363, 796, 357, 14881, 13, 43717, 1279, 410, 1, 15, 13, 22, 12, 4943, 5633, 49349, 3539, 62, 39069, 1058, 311, 893, 13, 33, 12115, 4663, 198, 220, 220, 220, 2488, 30493, 1943, 7, 63, 3, 11195, 14, 22, 89, 2124, 720, 34345, 532, 88, 532, 78, 3, 34945, 63, 8, 366, 3118, 540, 284, 7925, 720, 34345, 284, 720, 34945, 1, 198, 437, 198 ]
2.494357
443
using FromFile @from "../types.jl" import MyInt @from "ops.jl" import Square int_unwrap(x::MyInt)::Int = x.value int_square_unwrap(x::MyInt)::Int = int_unwrap(Square.int_square(x))
[ 3500, 3574, 8979, 198, 31, 6738, 366, 40720, 19199, 13, 20362, 1, 1330, 2011, 5317, 198, 31, 6738, 366, 2840, 13, 20362, 1, 1330, 9276, 198, 198, 600, 62, 403, 37150, 7, 87, 3712, 3666, 5317, 2599, 25, 5317, 796, 2124, 13, 8367, 198, 600, 62, 23415, 62, 403, 37150, 7, 87, 3712, 3666, 5317, 2599, 25, 5317, 796, 493, 62, 403, 37150, 7, 48011, 13, 600, 62, 23415, 7, 87, 4008 ]
2.513889
72
# This file compares approaching multi-agent models in two ways: # 1) using different Types to represent different agents. This leads to type # stability within `step!`. # 2) using a single type with some extra property `type` or `kind`, and then do # an `if`-based branching on this type to dispatch to different functions. # The result is that (2) is much faster. ################### DEFINITION 1 ############### using Agents, Random, BenchmarkTools mutable struct GridAgentOne <: AbstractAgent id::Int pos::Dims{2} one::Float64 two::Bool end mutable struct GridAgentTwo <: AbstractAgent id::Int pos::Dims{2} one::Float64 two::Bool end mutable struct GridAgentThree <: AbstractAgent id::Int pos::Dims{2} one::Float64 two::Bool end mutable struct GridAgentFour <: AbstractAgent id::Int pos::Dims{2} one::Float64 two::Bool end mutable struct GridAgentFive <: AbstractAgent id::Int pos::Dims{2} one::Float64 two::Bool end model1 = ABM( Union{GridAgentOne,GridAgentTwo,GridAgentThree,GridAgentFour,GridAgentFive}, GridSpace((15, 15)); warn = false, rng = MersenneTwister(42), scheduler = schedule_randomly, ) for _ in 1:50 a = GridAgentOne(nextid(model1), (1,1), rand(model1.rng), rand(model1.rng, Bool)) add_agent!(a, model1) a = GridAgentTwo(nextid(model1), (1,1), rand(model1.rng), rand(model1.rng, Bool)) add_agent!(a, model1) a = GridAgentThree(nextid(model1), (1,1), rand(model1.rng), rand(model1.rng, Bool)) add_agent!(a, model1) a = GridAgentFour(nextid(model1), (1,1), rand(model1.rng), rand(model1.rng, Bool)) add_agent!(a, model1) a = GridAgentFive(nextid(model1), (1,1), rand(model1.rng), rand(model1.rng, Bool)) add_agent!(a, model1) end agent_step!(agent::GridAgentOne, model1) = walk!(agent, rand, model1) function agent_step!(agent::GridAgentTwo, model1) agent.one += rand(model1.rng) agent.two = rand(model1.rng, Bool) end function agent_step!(agent::GridAgentThree, model1) if any(a-> a isa GridAgentTwo, nearby_agents(agent, model1)) agent.two = true walk!(agent, rand, model1) end end function agent_step!(agent::GridAgentFour, model1) agent.one += sum(a.one for a in nearby_agents(agent, model1)) end function agent_step!(agent::GridAgentFive, model1) targets = filter!(a->a.one > 0.8, collect(nearby_agents(agent, model1, 3))) idx = argmax(map(t->edistance(agent, t, model1), targets)) farthest = targets[idx] walk!(agent, sign.(farthest.pos .- agent.pos), model1) end ################### DEFINITION 2 ############### mutable struct GridAgentAll <: AbstractAgent id::Int pos::Dims{2} one::Float64 two::Bool type::Symbol end model2 = ABM( GridAgentAll, GridSpace((15, 15)); rng = MersenneTwister(42), scheduler = schedule_randomly, ) for _ in 1:50 a = GridAgentAll(nextid(model2), (1,1), rand(model2.rng), rand(model2.rng, Bool), :one) add_agent!(a, model2) a = GridAgentAll(nextid(model2), (1,1), rand(model2.rng), rand(model2.rng, Bool), :two) add_agent!(a, model2) a = GridAgentAll(nextid(model2), (1,1), rand(model2.rng), rand(model2.rng, Bool), :three) add_agent!(a, model2) a = GridAgentAll(nextid(model2), (1,1), rand(model2.rng), rand(model2.rng, Bool), :four) add_agent!(a, model2) a = GridAgentAll(nextid(model2), (1,1), rand(model2.rng), rand(model2.rng, Bool), :five) add_agent!(a, model2) end function agent_step!(agent::GridAgentAll, model2) if agent.type == :one agent_step_one!(agent, model2) elseif agent.type == :two agent_step_two!(agent, model2) elseif agent.type == :three agent_step_three!(agent, model2) elseif agent.type == :four agent_step_four!(agent, model2) else agent_step_five!(agent, model2) end end agent_step_one!(agent, model2) = walk!(agent, rand, model2) function agent_step_two!(agent, model2) agent.one += rand(model2.rng) agent.two = rand(model2.rng, Bool) end function agent_step_three!(agent, model2) if any(a-> a.type == :two, nearby_agents(agent, model2)) agent.two = true walk!(agent, rand, model2) end end function agent_step_four!(agent, model2) agent.one += sum(a.one for a in nearby_agents(agent, model2)) end function agent_step_five!(agent, model2) targets = filter!(a->a.one > 1.0, collect(nearby_agents(agent, model2, 3))) if !isempty(targets) idx = argmax(map(t->edistance(agent, t, model2), targets)) farthest = targets[idx] walk!(agent, sign.(farthest.pos .- agent.pos), model2) end end ################### Benchmarks ############### @btime step!($model1, agent_step!, dummystep, 500) @btime step!($model2, agent_step!, dummystep, 500) # Results: # 718.589 ms (11581560 allocations: 704.26 MiB) # 141.673 ms (2292318 allocations: 149.54 MiB)
[ 2, 770, 2393, 23008, 13885, 5021, 12, 25781, 4981, 287, 734, 2842, 25, 198, 2, 352, 8, 1262, 1180, 24897, 284, 2380, 1180, 6554, 13, 770, 5983, 284, 2099, 198, 2, 10159, 1626, 4600, 9662, 0, 44646, 198, 2, 362, 8, 1262, 257, 2060, 2099, 351, 617, 3131, 3119, 4600, 4906, 63, 393, 4600, 11031, 47671, 290, 788, 466, 198, 2, 281, 4600, 361, 63, 12, 3106, 49526, 319, 428, 2099, 284, 27965, 284, 1180, 5499, 13, 198, 198, 2, 383, 1255, 318, 326, 357, 17, 8, 318, 881, 5443, 13, 198, 198, 14468, 21017, 5550, 20032, 17941, 352, 1303, 7804, 4242, 2235, 198, 3500, 28295, 11, 14534, 11, 25187, 4102, 33637, 198, 198, 76, 18187, 2878, 24846, 36772, 3198, 1279, 25, 27741, 36772, 198, 220, 220, 220, 4686, 3712, 5317, 198, 220, 220, 220, 1426, 3712, 35, 12078, 90, 17, 92, 198, 220, 220, 220, 530, 3712, 43879, 2414, 198, 220, 220, 220, 734, 3712, 33, 970, 198, 437, 198, 198, 76, 18187, 2878, 24846, 36772, 7571, 1279, 25, 27741, 36772, 198, 220, 220, 220, 4686, 3712, 5317, 198, 220, 220, 220, 1426, 3712, 35, 12078, 90, 17, 92, 198, 220, 220, 220, 530, 3712, 43879, 2414, 198, 220, 220, 220, 734, 3712, 33, 970, 198, 437, 198, 198, 76, 18187, 2878, 24846, 36772, 12510, 1279, 25, 27741, 36772, 198, 220, 220, 220, 4686, 3712, 5317, 198, 220, 220, 220, 1426, 3712, 35, 12078, 90, 17, 92, 198, 220, 220, 220, 530, 3712, 43879, 2414, 198, 220, 220, 220, 734, 3712, 33, 970, 198, 437, 198, 198, 76, 18187, 2878, 24846, 36772, 15137, 1279, 25, 27741, 36772, 198, 220, 220, 220, 4686, 3712, 5317, 198, 220, 220, 220, 1426, 3712, 35, 12078, 90, 17, 92, 198, 220, 220, 220, 530, 3712, 43879, 2414, 198, 220, 220, 220, 734, 3712, 33, 970, 198, 437, 198, 198, 76, 18187, 2878, 24846, 36772, 20029, 1279, 25, 27741, 36772, 198, 220, 220, 220, 4686, 3712, 5317, 198, 220, 220, 220, 1426, 3712, 35, 12078, 90, 17, 92, 198, 220, 220, 220, 530, 3712, 43879, 2414, 198, 220, 220, 220, 734, 3712, 33, 970, 198, 437, 198, 198, 19849, 16, 796, 9564, 44, 7, 198, 220, 220, 220, 4479, 90, 41339, 36772, 3198, 11, 41339, 36772, 7571, 11, 41339, 36772, 12510, 11, 41339, 36772, 15137, 11, 41339, 36772, 20029, 5512, 198, 220, 220, 220, 24846, 14106, 19510, 1314, 11, 1315, 18125, 198, 220, 220, 220, 9828, 796, 3991, 11, 198, 220, 220, 220, 374, 782, 796, 337, 364, 29727, 5080, 1694, 7, 3682, 828, 198, 220, 220, 220, 6038, 18173, 796, 7269, 62, 25120, 306, 11, 198, 8, 198, 198, 1640, 4808, 287, 352, 25, 1120, 198, 220, 220, 220, 257, 796, 24846, 36772, 3198, 7, 19545, 312, 7, 19849, 16, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 16, 13, 81, 782, 828, 43720, 7, 19849, 16, 13, 81, 782, 11, 347, 970, 4008, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 16, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 7571, 7, 19545, 312, 7, 19849, 16, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 16, 13, 81, 782, 828, 43720, 7, 19849, 16, 13, 81, 782, 11, 347, 970, 4008, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 16, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 12510, 7, 19545, 312, 7, 19849, 16, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 16, 13, 81, 782, 828, 43720, 7, 19849, 16, 13, 81, 782, 11, 347, 970, 4008, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 16, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 15137, 7, 19545, 312, 7, 19849, 16, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 16, 13, 81, 782, 828, 43720, 7, 19849, 16, 13, 81, 782, 11, 347, 970, 4008, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 16, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 20029, 7, 19545, 312, 7, 19849, 16, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 16, 13, 81, 782, 828, 43720, 7, 19849, 16, 13, 81, 782, 11, 347, 970, 4008, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 16, 8, 198, 437, 198, 198, 25781, 62, 9662, 0, 7, 25781, 3712, 41339, 36772, 3198, 11, 2746, 16, 8, 796, 2513, 0, 7, 25781, 11, 43720, 11, 2746, 16, 8, 198, 8818, 5797, 62, 9662, 0, 7, 25781, 3712, 41339, 36772, 7571, 11, 2746, 16, 8, 198, 220, 220, 220, 5797, 13, 505, 15853, 43720, 7, 19849, 16, 13, 81, 782, 8, 198, 220, 220, 220, 5797, 13, 11545, 796, 43720, 7, 19849, 16, 13, 81, 782, 11, 347, 970, 8, 198, 437, 198, 8818, 5797, 62, 9662, 0, 7, 25781, 3712, 41339, 36772, 12510, 11, 2746, 16, 8, 198, 220, 220, 220, 611, 597, 7, 64, 3784, 257, 318, 64, 24846, 36772, 7571, 11, 6716, 62, 49638, 7, 25781, 11, 2746, 16, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 13, 11545, 796, 2081, 198, 220, 220, 220, 220, 220, 220, 220, 2513, 0, 7, 25781, 11, 43720, 11, 2746, 16, 8, 198, 220, 220, 220, 886, 198, 437, 198, 8818, 5797, 62, 9662, 0, 7, 25781, 3712, 41339, 36772, 15137, 11, 2746, 16, 8, 198, 220, 220, 220, 5797, 13, 505, 15853, 2160, 7, 64, 13, 505, 329, 257, 287, 6716, 62, 49638, 7, 25781, 11, 2746, 16, 4008, 198, 437, 198, 8818, 5797, 62, 9662, 0, 7, 25781, 3712, 41339, 36772, 20029, 11, 2746, 16, 8, 198, 220, 220, 220, 6670, 796, 8106, 0, 7, 64, 3784, 64, 13, 505, 1875, 657, 13, 23, 11, 2824, 7, 40093, 1525, 62, 49638, 7, 25781, 11, 2746, 16, 11, 513, 22305, 198, 220, 220, 220, 4686, 87, 796, 1822, 9806, 7, 8899, 7, 83, 3784, 276, 9311, 7, 25781, 11, 256, 11, 2746, 16, 828, 6670, 4008, 198, 220, 220, 220, 15189, 3634, 796, 6670, 58, 312, 87, 60, 198, 220, 220, 220, 2513, 0, 7, 25781, 11, 1051, 12195, 69, 433, 3634, 13, 1930, 764, 12, 5797, 13, 1930, 828, 2746, 16, 8, 198, 437, 198, 198, 14468, 21017, 5550, 20032, 17941, 362, 1303, 7804, 4242, 2235, 198, 198, 76, 18187, 2878, 24846, 36772, 3237, 1279, 25, 27741, 36772, 198, 220, 220, 220, 4686, 3712, 5317, 198, 220, 220, 220, 1426, 3712, 35, 12078, 90, 17, 92, 198, 220, 220, 220, 530, 3712, 43879, 2414, 198, 220, 220, 220, 734, 3712, 33, 970, 198, 220, 220, 220, 2099, 3712, 13940, 23650, 198, 437, 198, 198, 19849, 17, 796, 9564, 44, 7, 198, 220, 220, 220, 24846, 36772, 3237, 11, 198, 220, 220, 220, 24846, 14106, 19510, 1314, 11, 1315, 18125, 198, 220, 220, 220, 374, 782, 796, 337, 364, 29727, 5080, 1694, 7, 3682, 828, 198, 220, 220, 220, 6038, 18173, 796, 7269, 62, 25120, 306, 11, 198, 8, 198, 198, 1640, 4808, 287, 352, 25, 1120, 198, 220, 220, 220, 257, 796, 24846, 36772, 3237, 7, 19545, 312, 7, 19849, 17, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 17, 13, 81, 782, 828, 43720, 7, 19849, 17, 13, 81, 782, 11, 347, 970, 828, 1058, 505, 8, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 17, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 3237, 7, 19545, 312, 7, 19849, 17, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 17, 13, 81, 782, 828, 43720, 7, 19849, 17, 13, 81, 782, 11, 347, 970, 828, 1058, 11545, 8, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 17, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 3237, 7, 19545, 312, 7, 19849, 17, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 17, 13, 81, 782, 828, 43720, 7, 19849, 17, 13, 81, 782, 11, 347, 970, 828, 1058, 15542, 8, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 17, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 3237, 7, 19545, 312, 7, 19849, 17, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 17, 13, 81, 782, 828, 43720, 7, 19849, 17, 13, 81, 782, 11, 347, 970, 828, 1058, 14337, 8, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 17, 8, 198, 220, 220, 220, 257, 796, 24846, 36772, 3237, 7, 19545, 312, 7, 19849, 17, 828, 357, 16, 11, 16, 828, 43720, 7, 19849, 17, 13, 81, 782, 828, 43720, 7, 19849, 17, 13, 81, 782, 11, 347, 970, 828, 1058, 13261, 8, 198, 220, 220, 220, 751, 62, 25781, 0, 7, 64, 11, 2746, 17, 8, 198, 437, 198, 198, 8818, 5797, 62, 9662, 0, 7, 25781, 3712, 41339, 36772, 3237, 11, 2746, 17, 8, 198, 220, 220, 220, 611, 5797, 13, 4906, 6624, 1058, 505, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 62, 9662, 62, 505, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 2073, 361, 5797, 13, 4906, 6624, 1058, 11545, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 62, 9662, 62, 11545, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 2073, 361, 5797, 13, 4906, 6624, 1058, 15542, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 62, 9662, 62, 15542, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 2073, 361, 5797, 13, 4906, 6624, 1058, 14337, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 62, 9662, 62, 14337, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 62, 9662, 62, 13261, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 886, 198, 437, 198, 25781, 62, 9662, 62, 505, 0, 7, 25781, 11, 2746, 17, 8, 796, 2513, 0, 7, 25781, 11, 43720, 11, 2746, 17, 8, 198, 8818, 5797, 62, 9662, 62, 11545, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 5797, 13, 505, 15853, 43720, 7, 19849, 17, 13, 81, 782, 8, 198, 220, 220, 220, 5797, 13, 11545, 796, 43720, 7, 19849, 17, 13, 81, 782, 11, 347, 970, 8, 198, 437, 198, 8818, 5797, 62, 9662, 62, 15542, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 611, 597, 7, 64, 3784, 257, 13, 4906, 6624, 1058, 11545, 11, 6716, 62, 49638, 7, 25781, 11, 2746, 17, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 5797, 13, 11545, 796, 2081, 198, 220, 220, 220, 220, 220, 220, 220, 2513, 0, 7, 25781, 11, 43720, 11, 2746, 17, 8, 198, 220, 220, 220, 886, 198, 437, 198, 8818, 5797, 62, 9662, 62, 14337, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 5797, 13, 505, 15853, 2160, 7, 64, 13, 505, 329, 257, 287, 6716, 62, 49638, 7, 25781, 11, 2746, 17, 4008, 198, 437, 198, 8818, 5797, 62, 9662, 62, 13261, 0, 7, 25781, 11, 2746, 17, 8, 198, 220, 220, 220, 6670, 796, 8106, 0, 7, 64, 3784, 64, 13, 505, 1875, 352, 13, 15, 11, 2824, 7, 40093, 1525, 62, 49638, 7, 25781, 11, 2746, 17, 11, 513, 22305, 198, 220, 220, 220, 611, 5145, 271, 28920, 7, 83, 853, 1039, 8, 198, 220, 220, 220, 220, 220, 220, 220, 4686, 87, 796, 1822, 9806, 7, 8899, 7, 83, 3784, 276, 9311, 7, 25781, 11, 256, 11, 2746, 17, 828, 6670, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 15189, 3634, 796, 6670, 58, 312, 87, 60, 198, 220, 220, 220, 220, 220, 220, 220, 2513, 0, 7, 25781, 11, 1051, 12195, 69, 433, 3634, 13, 1930, 764, 12, 5797, 13, 1930, 828, 2746, 17, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 14468, 21017, 25187, 14306, 1303, 7804, 4242, 2235, 198, 198, 31, 65, 2435, 2239, 0, 16763, 19849, 16, 11, 5797, 62, 9662, 28265, 31548, 9662, 11, 5323, 8, 198, 31, 65, 2435, 2239, 0, 16763, 19849, 17, 11, 5797, 62, 9662, 28265, 31548, 9662, 11, 5323, 8, 198, 198, 2, 15691, 25, 198, 2, 767, 1507, 13, 44169, 13845, 357, 1157, 3365, 1314, 1899, 49157, 25, 767, 3023, 13, 2075, 13756, 33, 8, 198, 2, 25500, 13, 45758, 13845, 357, 23539, 1954, 1507, 220, 49157, 25, 24041, 13, 4051, 13756, 33, 8, 198 ]
2.403406
2,055
""" find_global_maximum_bfs(graph::Dict{Int64,Array{Int64,1}}) Find the total global maximum based on a comparsion between the intial vertex (`global_maximum = 0`), the current dictionary key, and the accesible vertexes from the array-list (value). # Arguments - `graph::Dict{Int64,Array{Int64,1}}`: Graph of the connected nodes """ function find_global_maximum_bfs(graph::Dict{Int64,Array{Int64,1}}) global_maximum = 0 # Going through the dictionary for (key, value) in graph # Check the keys as new global maximum if key > global_maximum global_maximum = key end # Check the values as new local maximum local_maximum = maximum(value) # Check if new local maximum becomes global maximum if local_maximum > global_maximum global_maximum = local_maximum end end return global_maximum end """ breadth_first_search(graph::Dict{Int64,Array{Int64,1}}, start::Int64) The breadth-first search (BFS) is an algorithm dedicated to traversing or searching for tree or graph data structures. It starts at a specified tree root (start) for exploring all connected neighbor nodes. The important feature is that the BFS automatically leaves the present depth and passes on to the next nodes at a deeper level. BFS is queue-based. For more information see: [https://en.wikipedia.org/wiki/Breadth-first_search](https://en.wikipedia.org/wiki/Breadth-first_search) # Arguments - `graph::Dict{Int64,Array{Int64,1}}`: Graph of the connected nodes - `start::Int64`: Startpoint (first selected vertex) of the graph-traveling process # Examples ```julia-repl julia> import ClassicAlgorithmsCollections julia> graph = Dict(1=> [2, 3], 2=> [3], 3=> [1, 4], 4=> [4]) julia> ClassicAlgorithmsCollections.breadth_first_search(graph, 3) [3, 1, 4, 2] ``` """ function breadth_first_search(graph::Dict{Int64,Array{Int64,1}}, start::Int64) # Mark all the vertices as not visited n = find_global_maximum_bfs(graph) visited = zeros(Bool, n) # Create a queue for BFS queue = zeros(Int64, false) # Create array-list for the searching solution solution = zeros(Int64, false) # Mark the source node as visited and enqueue it visited[start] = true append!(queue, start) while !isempty(queue) # Dequeue a vertex from # queue and print it start = popat!(queue, 1) append!(solution, start) # Get all adjacent vertices of the dequeued vertex s. If a adjacent # has not been visited, then mark it visited and enqueue it for i in graph[start] # Check if vertex has already been visited if visited[i] == false append!(queue, i) visited[i] = true end end end return solution end
[ 37811, 198, 220, 220, 220, 1064, 62, 20541, 62, 47033, 62, 65, 9501, 7, 34960, 3712, 35, 713, 90, 5317, 2414, 11, 19182, 90, 5317, 2414, 11, 16, 11709, 8, 198, 198, 16742, 262, 2472, 3298, 5415, 1912, 319, 257, 552, 945, 295, 1022, 262, 493, 498, 37423, 198, 7, 63, 20541, 62, 47033, 796, 657, 63, 828, 262, 1459, 22155, 1994, 11, 290, 262, 697, 274, 856, 37423, 274, 422, 198, 1169, 7177, 12, 4868, 357, 8367, 737, 628, 198, 2, 20559, 2886, 198, 12, 4600, 34960, 3712, 35, 713, 90, 5317, 2414, 11, 19182, 90, 5317, 2414, 11, 16, 11709, 63, 25, 29681, 286, 262, 5884, 13760, 198, 37811, 198, 8818, 1064, 62, 20541, 62, 47033, 62, 65, 9501, 7, 34960, 3712, 35, 713, 90, 5317, 2414, 11, 19182, 90, 5317, 2414, 11, 16, 11709, 8, 198, 220, 220, 220, 3298, 62, 47033, 796, 657, 198, 220, 220, 220, 1303, 19219, 832, 262, 22155, 198, 220, 220, 220, 329, 357, 2539, 11, 1988, 8, 287, 4823, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 6822, 262, 8251, 355, 649, 3298, 5415, 198, 220, 220, 220, 220, 220, 220, 220, 611, 1994, 1875, 3298, 62, 47033, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3298, 62, 47033, 796, 1994, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 6822, 262, 3815, 355, 649, 1957, 5415, 198, 220, 220, 220, 220, 220, 220, 220, 1957, 62, 47033, 796, 5415, 7, 8367, 8, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 6822, 611, 649, 1957, 5415, 4329, 3298, 5415, 198, 220, 220, 220, 220, 220, 220, 220, 611, 1957, 62, 47033, 1875, 3298, 62, 47033, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 3298, 62, 47033, 796, 1957, 62, 47033, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 3298, 62, 47033, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 32483, 62, 11085, 62, 12947, 7, 34960, 3712, 35, 713, 90, 5317, 2414, 11, 19182, 90, 5317, 2414, 11, 16, 92, 5512, 923, 3712, 5317, 2414, 8, 198, 198, 464, 32483, 12, 11085, 2989, 357, 33, 10652, 8, 318, 281, 11862, 7256, 284, 33038, 278, 393, 10342, 329, 198, 21048, 393, 4823, 1366, 8573, 13, 632, 4940, 379, 257, 7368, 5509, 6808, 357, 9688, 8, 329, 13504, 198, 439, 5884, 4780, 13760, 13, 383, 1593, 3895, 318, 326, 262, 347, 10652, 6338, 5667, 198, 1169, 1944, 6795, 290, 8318, 319, 284, 262, 1306, 13760, 379, 257, 9211, 1241, 13, 347, 10652, 318, 16834, 12, 3106, 13, 198, 1890, 517, 1321, 766, 25, 685, 5450, 1378, 268, 13, 31266, 13, 2398, 14, 15466, 14, 33, 961, 400, 12, 11085, 62, 12947, 16151, 5450, 1378, 268, 13, 31266, 13, 2398, 14, 15466, 14, 33, 961, 400, 12, 11085, 62, 12947, 8, 628, 198, 2, 20559, 2886, 198, 12, 4600, 34960, 3712, 35, 713, 90, 5317, 2414, 11, 19182, 90, 5317, 2414, 11, 16, 11709, 63, 25, 29681, 286, 262, 5884, 13760, 198, 12, 4600, 9688, 3712, 5317, 2414, 63, 25, 7253, 4122, 357, 11085, 6163, 37423, 8, 286, 262, 4823, 12, 35927, 278, 1429, 628, 198, 2, 21066, 198, 15506, 63, 73, 43640, 12, 35666, 198, 73, 43640, 29, 1330, 13449, 2348, 7727, 907, 5216, 26448, 198, 73, 43640, 29, 4823, 796, 360, 713, 7, 16, 14804, 685, 17, 11, 513, 4357, 362, 14804, 685, 18, 4357, 513, 14804, 685, 16, 11, 604, 4357, 604, 14804, 685, 19, 12962, 198, 73, 43640, 29, 13449, 2348, 7727, 907, 5216, 26448, 13, 29573, 400, 62, 11085, 62, 12947, 7, 34960, 11, 513, 8, 198, 58, 18, 11, 352, 11, 604, 11, 362, 60, 198, 15506, 63, 198, 37811, 198, 8818, 32483, 62, 11085, 62, 12947, 7, 34960, 3712, 35, 713, 90, 5317, 2414, 11, 19182, 90, 5317, 2414, 11, 16, 92, 5512, 923, 3712, 5317, 2414, 8, 628, 220, 220, 220, 1303, 2940, 477, 262, 9421, 1063, 355, 407, 8672, 198, 220, 220, 220, 299, 796, 1064, 62, 20541, 62, 47033, 62, 65, 9501, 7, 34960, 8, 198, 220, 220, 220, 8672, 796, 1976, 27498, 7, 33, 970, 11, 299, 8, 628, 220, 220, 220, 1303, 13610, 257, 16834, 329, 347, 10652, 198, 220, 220, 220, 16834, 796, 1976, 27498, 7, 5317, 2414, 11, 3991, 8, 628, 220, 220, 220, 1303, 13610, 7177, 12, 4868, 329, 262, 10342, 4610, 198, 220, 220, 220, 4610, 796, 1976, 27498, 7, 5317, 2414, 11, 3991, 8, 628, 220, 220, 220, 1303, 2940, 262, 2723, 10139, 355, 8672, 290, 551, 36560, 340, 198, 220, 220, 220, 8672, 58, 9688, 60, 796, 2081, 198, 220, 220, 220, 24443, 0, 7, 36560, 11, 923, 8, 628, 220, 220, 220, 981, 5145, 271, 28920, 7, 36560, 8, 628, 220, 220, 220, 220, 220, 220, 220, 1303, 1024, 36560, 257, 37423, 422, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 16834, 290, 3601, 340, 198, 220, 220, 220, 220, 220, 220, 220, 923, 796, 1461, 265, 0, 7, 36560, 11, 352, 8, 198, 220, 220, 220, 220, 220, 220, 220, 24443, 0, 7, 82, 2122, 11, 923, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 3497, 477, 15909, 9421, 1063, 286, 262, 390, 4188, 1739, 37423, 264, 13, 1002, 257, 15909, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 468, 407, 587, 8672, 11, 788, 1317, 340, 8672, 290, 551, 36560, 340, 198, 220, 220, 220, 220, 220, 220, 220, 329, 1312, 287, 4823, 58, 9688, 60, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 6822, 611, 37423, 468, 1541, 587, 8672, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 8672, 58, 72, 60, 6624, 3991, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 24443, 0, 7, 36560, 11, 1312, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 8672, 58, 72, 60, 796, 2081, 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, 4610, 198, 437, 198 ]
2.717557
1,048
# # Copyright (c) 2021 Tobias Thummerer, Lars Mikelsons # Licensed under the MIT license. See LICENSE file in the project root for details. # using DifferentialEquations, DiffEqCallbacks using ChainRulesCore import ForwardDiff, Zygote # helper to collect variable IdSet function indiciesForValueReferences(fmu::FMU2, refs::Array{fmi2ValueReference}) array = fmi2ValueReference[] for i in 1:length(fmu.modelDescription.valueReferences) if fmu.modelDescription.valueReferences[i] in refs push!(array, i) end end array end """ Performs something similar to `fmiDoStep` for ME-FMUs (note, that fmiDoStep is for CS-FMUs only). Event handling (state- and time-events) is supported. If you don't want events to be handled, you can disable event-handling for the NeuralFMU `nfmu` with the attribute `eventHandling = false`. Optional, additional FMU-values can be set via keyword arguments `setValueReferences` and `setValues`. Optional, additional FMU-values can be retrieved by keyword argument `getValueReferences`. Function takes the current system state array ("x") and returns an array with state derivatives ("x dot") and optionally the FMU-values for `getValueReferences`. Setting the FMU time via argument `t` is optional, if not set, the current time of the ODE solver around the NeuralFMU is used. """ function fmi2EvaluateME(comp::FMU2Component, x::Array{<:Real}, t = -1.0,#::Real, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) _fmi2EvaluateME(comp, x, t, setValueReferences, setValues, getValueReferences) end function fmi2EvaluateME(comp::FMU2Component, x::Array{<:ForwardDiff.Dual{Tx, Vx, Nx}}, t = -1.0,#::Real, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0) ) where {Tx, Vx, Nx} _fmi2EvaluateME_fd((Tx, Vx, Nx), (Tx, Vx, Nx), comp, x, t, setValueReferences, setValues, getValueReferences) end function fmi2EvaluateME(comp::FMU2Component, x::Array{<:ForwardDiff.Dual{Tx, Vx, Nx}}, t,#::Real, setValueReferences::Array{fmi2ValueReference}, setValues::Array{<:ForwardDiff.Dual{Tu, Vu, Nu}}, getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0) ) where {Tx, Vx, Nx, Tu, Vu, Nu} _fmi2EvaluateME_fd((Tx, Vx, Nx), (Tu, Vu, Nu), comp, x, t, setValueReferences, setValues, getValueReferences) end # ForwardDiff backend using the existing ChainRulesCore.frule # adapted from: https://discourse.julialang.org/t/chainrulescore-and-forwarddiff/61705/8 function _fmi2EvaluateME_fd(TVNx, TVNu, comp, x, t, setValueReferences, setValues, getValueReferences) #where {T, V, N} #where {T} # <:ForwardDiff.Dual} Tx, Vx, Nx = TVNx Tu, Vu, Nu = TVNu ȧrgs = [NoTangent(), NoTangent(), collect(ForwardDiff.partials(e) for e in x), ForwardDiff.partials(t), NoTangent(), collect(ForwardDiff.partials(e) for e in setValues), NoTangent()] args = [fmi2EvaluateME, comp, collect(ForwardDiff.value(e) for e in x), ForwardDiff.value(t), setValueReferences, collect(ForwardDiff.value(e) for e in setValues), getValueReferences] # ToDo: Find a good fix! #Zygote.@ignore @debug "From $(typeof(args[6]))" if typeof(args[6]) == Vector{Any} args[6] = convert(Vector{Float64}, args[6]) #Zygote.@ignore @debug "To $(typeof(args[6]))" end ȧrgs = (ȧrgs...,) args = (args...,) @assert (typeof(args[3]) == Vector{Float64}) || (typeof(args[3]) == Vector{Float32}) "After conversion, `x` is still an invalid type `$(typeof(args[3]))`." y, _, dx, _, _, du, _ = ChainRulesCore.frule(ȧrgs, args...) if Vx != Float64 Vx = Float64 end if Vu != Float64 Vu = Float64 end # original function returns [dx_1, ..., dx_n, y_1, ..., y_m] # ToDo: Add sensitivities (partials) from du -> (dx, y) [collect( ForwardDiff.Dual{Tx, Vx, Nx}(y[i], dx[i]) for i in 1:length(dx) )...] end function _fmi2EvaluateME(comp::FMU2Component, x::Array{<:Real}, t::Real, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) @assert fmi2IsModelExchange(comp.fmu) ["fmi2EvaluateME(...): As in the name, this function only supports ME-FMUs."] setter = (length(setValueReferences) > 0) getter = (length(getValueReferences) > 0) if setter @assert length(setValueReferences) == length(setValues) ["fmi2EvaluateME(...): `setValueReferences` and `setValues` need to be the same length!"] end if t >= 0.0 fmi2SetTime(comp, t) end if setter fmi2SetReal(comp, setValueReferences, setValues) end fmi2SetContinuousStates(comp, x) y = [] if getter y = fmi2GetReal(comp, getValueReferences) end dx = fmi2GetDerivatives(comp) [dx..., y...] end function ChainRulesCore.rrule(::typeof(fmi2EvaluateME), comp::FMU2Component, x::Array{<:Real}, t::Real = -1.0, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) y = fmi2EvaluateME(comp, x, t, setValueReferences, setValues, getValueReferences) function fmi2EvaluateME_pullback(ȳ) setter = (length(setValueReferences) > 0) getter = (length(getValueReferences) > 0) if setter @assert length(setValueReferences) == length(setValues) ["ChainRulesCore.rrule(fmi2EvaluateME, ...): `setValueReferences` and `setValues` need to be the same length!"] end if t >= 0.0 fmi2SetTime(comp, t) end fmi2SetContinuousStates(comp, x) rdx = vcat(comp.fmu.modelDescription.derivativeValueReferences, getValueReferences) rx = comp.fmu.modelDescription.stateValueReferences ru = setValueReferences n_dx_x = NoTangent() n_dx_u = NoTangent() if comp.senseFunc == :full || comp.senseFunc == :directionalDerivatives || comp.senseFunc == :auto # OPTIMIZATION: compute new jacobians only if system state or time changed, otherwise return the cached one if comp.jac_x != x || comp.jac_t != t if size(comp.jac_dxy_x) != (length(rdx), length(rx)) comp.jac_dxy_x = zeros(length(rdx), length(rx)) end comp.jacobianFct(comp.jac_dxy_x, comp, rdx, rx) if size(comp.jac_dxy_u) != (length(rdx), length(ru)) comp.jac_dxy_u = zeros(length(rdx), length(ru)) end comp.jacobianFct(comp.jac_dxy_u, comp, rdx, ru) comp.jac_x = x comp.jac_t = t end n_dx_x = @thunk(comp.jac_dxy_x' * ȳ) if setter n_dx_u = @thunk(comp.jac_dxy_u' * ȳ) end elseif comp.senseFunc == :adjointDerivatives @assert false "Adjoint Derivatives not supported by FMI2." else @assert false "`senseFunc=$(comp.senseFunc)` unknown value for `senseFunc`." end f̄ = NoTangent() c̄omp = ZeroTangent() x̄ = n_dx_x t̄ = ZeroTangent() s̄etValueReferences = ZeroTangent() s̄etValues = n_dx_u ḡetValueReferences = ZeroTangent() return f̄, c̄omp, x̄, t̄, s̄etValueReferences, s̄etValues, ḡetValueReferences end return y, fmi2EvaluateME_pullback end function ChainRulesCore.frule((Δself, Δcomp, Δx, Δt, ΔsetValueReferences, ΔsetValues, ΔgetValueReferences), ::typeof(fmi2EvaluateME), comp, #::FMU2Component, x,#::Array{<:Real}, t,#::Real = -1.0, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) y = fmi2EvaluateME(comp, x, t, setValueReferences, setValues, getValueReferences) function fmi2EvaluateME_pullforward(Δx, ΔsetValues) setter = (length(setValueReferences) > 0) getter = (length(getValueReferences) > 0) if setter @assert length(setValueReferences) == length(setValues) ["ChainRulesCore.frule(fmi2EvaluateME, ...): `setValueReferences` and `setValues` need to be the same length!"] end if t >= 0.0 fmi2SetTime(comp, t) end if all(isa.(x, ForwardDiff.Dual)) xf = collect(ForwardDiff.value(e) for e in x) fmi2SetContinuousStates(comp, xf) else fmi2SetContinuousStates(comp, x) end rdx = vcat(comp.fmu.modelDescription.derivativeValueReferences, getValueReferences) rx = comp.fmu.modelDescription.stateValueReferences ru = setValueReferences n_dx_x = NoTangent() n_dx_u = NoTangent() if comp.senseFunc == :auto || comp.senseFunc == :full # OPTIMIZATION: compute new jacobians only if system state or time changed, otherwise return the cached one # ToDo: Optimize for getDirectionalDerivatives with seed vector Δx if comp.jac_x != x || comp.jac_t != t if size(comp.jac_dxy_x) != (length(rdx), length(rx)) comp.jac_dxy_x = zeros(length(rdx), length(rx)) end comp.jacobianFct(comp.jac_dxy_x, comp, rdx, rx) if size(comp.jac_dxy_u) != (length(rdx), length(ru)) comp.jac_dxy_u = zeros(length(rdx), length(ru)) end comp.jacobianFct(comp.jac_dxy_u, comp, rdx, ru) comp.jac_x = x comp.jac_t = t end n_dx_x = comp.jac_dxy_x * Δx if setter n_dx_u = comp.jac_dxy_u * ΔsetValues end elseif comp.senseFunc == :directionalDerivatives n_dx_x = fmi2GetDirectionalDerivative(comp, rdx, rx, Δx) if setter n_dx_u = fmi2GetDirectionalDerivative(comp, rdx, ru, ΔsetValues) end elseif comp.senseFunc == :adjointDerivatives @assert false "Adjoint Derivatives not supported by FMI2." else @assert false "`senseFunc=$(comp.senseFunc)` unknown value for `senseFunc`." end c̄omp = ZeroTangent() x̄ = n_dx_x t̄ = ZeroTangent() s̄etValueReferences = ZeroTangent() s̄etValues = n_dx_u ḡetValueReferences = ZeroTangent() return (c̄omp, x̄, t̄, s̄etValueReferences, s̄etValues, ḡetValueReferences) end return (y, fmi2EvaluateME_pullforward(Δx, ΔsetValues)...) end """ Performs a fmiDoStep for CS-FMUs (note, that fmiDoStep is for CS-FMUs only). Optional, FMU-values can be set via keyword arguments `setValueReferences` and `setValues`. Optional, FMU-values can be retrieved by keyword argument `getValueReferences`. Function returns the FMU-values for the optional keyword argument `getValueReferences`. The CS-FMU performs one macro step with step size `dt`. Dependent on the integrated numerical solver, the FMU may perform multiple (internal) micro steps if needed to meet solver requirements (stability/accuracy). These micro steps are hidden by FMI2. """ function fmi2DoStepCS(comp::FMU2Component, dt::Real, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) _fmi2DoStepCS(comp, dt, setValueReferences, setValues, getValueReferences) end function fmi2DoStepCS(comp::FMU2Component, dt,#::Real, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:ForwardDiff.Dual{Tu, Vu, Nu}} = Array{ForwardDiff.Dual{Tu, Vu, Nu}}(), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0) ) where {Tu, Vu, Nu} _fmi2DoStepCS_fd((Td, Vd, Nd), comp, dt, setValueReferences, setValues, getValueReferences) end # Helper because keyword arguments are (currently) not supported by Zygote. function _fmi2DoStepCS(comp::FMU2Component, dt::Real, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) @assert fmi2IsCoSimulation(comp.fmu) ["fmi2DoStepCS(...): As in the name, this function only supports CS-FMUs."] @assert length(setValueReferences) == length(setValues) ["fmi2DoStepCS(...): `setValueReferences` ($(length(setValueReferences))) and `setValues` ($(length(setValues))) need to be the same length!"] if length(setValueReferences) > 0 fmi2SetReal(comp, setValueReferences, setValues) end fmi2DoStep(comp, dt) y = zeros(Float64, 0) if length(getValueReferences) > 0 y = fmi2GetReal(comp, getValueReferences) end y end # ForwardDiff backend using the existing ChainRulesCore.frule # adapted from: https://discourse.julialang.org/t/chainrulescore-and-forwarddiff/61705/8 function _fmi2DoStepCS_fd(TVNu, comp, dt, setValueReferences, setValues, getValueReferences) Tu, Vu, Nu = TVNu ȧrgs = [NoTangent(), NoTangent(), ForwardDiff.partials(dt), NoTangent(), collect(ForwardDiff.partials(e) for e in setValues), NoTangent()] args = [fmi2DoStepCS, comp, ForwardDiff.value(dt), setValueReferences, collect(ForwardDiff.value(e) for e in setValues), getValueReferences] # ToDo: Find a good fix! if typeof(args[5]) == Vector{Any} args[5] = convert(Vector{Float64}, args[5]) end ȧrgs = (ȧrgs...,) args = (args...,) y, _, _, _, du, _ = ChainRulesCore.frule(ȧrgs, args...) if Vu != Float64 Vu = Float64 end # original function returns [y_1, ..., y_m] [collect( ForwardDiff.Dual{Tu, Vu, Nu}(y[i], du[i]) for i in 1:length(du) )...] end function ChainRulesCore.rrule(::typeof(fmi2DoStepCS), comp::FMU2Component, dt::Real = -1.0, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) y = fmi2DoStepCS(comp, dt, setValueReferences, setValues, getValueReferences) function fmi2DoStepCS_pullback(ȳ) setter = (length(setValueReferences) > 0) getter = (length(getValueReferences) > 0) if setter @assert length(setValueReferences) == length(setValues) ["ChainRulesCore.rrule(fmi2DoStepCS, ...): `setValueReferences` and `setValues` need to be the same length!"] end rdx = getValueReferences rx = setValueReferences n_dx_u = ZeroTangent() if getter mat = zeros(length(rdx), length(rx)) comp.jacobianFct(mat, comp, rdx, rx) n_dx_u = @thunk(mat' * ȳ) end f̄ = NoTangent() f̄mu = ZeroTangent() d̄t = ZeroTangent() s̄etValueReferences = ZeroTangent() s̄etValues = n_dx_u ḡetValueReferences = ZeroTangent() return (f̄, f̄mu, d̄t, s̄etValueReferences, s̄etValues, ḡetValueReferences) end return y, fmi2DoStepCS_pullback end function ChainRulesCore.frule((Δself, Δcomp, Δdt, ΔsetValueReferences, ΔsetValues, ΔgetValueReferences), ::typeof(fmi2DoStepCS), comp, #::FMU2, dt,#::Real = -1.0, setValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0), setValues::Array{<:Real} = zeros(Real, 0), getValueReferences::Array{fmi2ValueReference} = zeros(fmi2ValueReference, 0)) y = fmi2DoStepCS(comp, dt, setValueReferences, setValues, getValueReferences) function fmi2DoStepCS_pullforward(ΔsetValues) setter = (length(setValueReferences) > 0) getter = (length(getValueReferences) > 0) if setter @assert length(setValueReferences) == length(setValues) ["ChainRulesCore.frule(fmi2DoStepCS, ...): `setValueReferences` and `setValues` need to be the same length!"] end rdx = getValueReferences rx = setValueReferences n_dx_u = ZeroTangent() if getter mat = zeros(length(rdx), length(rx)) comp.jacobianFct(mat, comp, rdx, rx) n_dx_u = mat * ΔsetValues end f̄mu = ZeroTangent() d̄t = ZeroTangent() s̄etValueReferences = ZeroTangent() s̄etValues = n_dx_u ḡetValueReferences = ZeroTangent() return (f̄mu, d̄t, s̄etValueReferences, s̄etValues, ḡetValueReferences) end return (y, fmi2DoStepCS_pullforward(ΔsetValues)...) end """ fmi2InputDoStepCSOutput(comp::FMU2Component, dt::Real, u::Array{<:Real}) Sets all FMU inputs to `u`, performs a ´´´fmi2DoStep´´´ and returns all FMU outputs. """ function fmi2InputDoStepCSOutput(comp::FMU2Component, dt::Real, u::Array{<:Real}) @assert fmi2IsCoSimulation(comp.fmu) ["fmi2InputDoStepCSOutput(...): As in the name, this function only supports CS-FMUs."] fmi2DoStepCS(comp, dt, comp.fmu.modelDescription.inputValueReferences, u, comp.fmu.modelDescription.outputValueReferences) end # FMU wrappers function fmi2EvaluateME(fmu::FMU2, args...; kwargs...) fmi2EvaluateME(fmu.components[end], args...; kwargs...) end function fmi2DoStepCS(fmu::FMU2, args...; kwargs...) fmi2DoStepCS(fmu.components[end], args...; kwargs...) end function fmi2InputDoStepCSOutput(fmu::FMU2, args...; kwargs...) fmi2InputDoStepCSOutput(fmu.components[end], args...; kwargs...) end
[ 2, 198, 2, 15069, 357, 66, 8, 33448, 46675, 536, 13929, 11882, 11, 31239, 4995, 7278, 684, 198, 2, 49962, 739, 262, 17168, 5964, 13, 4091, 38559, 24290, 2393, 287, 262, 1628, 6808, 329, 3307, 13, 198, 2, 198, 198, 3500, 20615, 498, 23588, 602, 11, 10631, 36, 80, 14134, 10146, 198, 198, 3500, 21853, 37766, 14055, 198, 11748, 19530, 28813, 11, 1168, 35641, 1258, 198, 198, 2, 31904, 284, 2824, 7885, 5121, 7248, 198, 8818, 2699, 444, 1890, 11395, 19927, 7, 69, 30300, 3712, 23264, 52, 17, 11, 220, 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, 1006, 82, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 30072, 198, 220, 220, 220, 7177, 796, 277, 11632, 17, 11395, 26687, 21737, 198, 220, 220, 220, 329, 1312, 287, 352, 25, 13664, 7, 69, 30300, 13, 19849, 11828, 13, 8367, 19927, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 277, 30300, 13, 19849, 11828, 13, 8367, 19927, 58, 72, 60, 287, 1006, 82, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 18747, 11, 1312, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 220, 220, 220, 7177, 198, 437, 220, 198, 198, 37811, 198, 5990, 23914, 1223, 2092, 284, 4600, 69, 11632, 5211, 8600, 63, 329, 11948, 12, 23264, 5842, 357, 11295, 11, 326, 277, 11632, 5211, 8600, 318, 329, 9429, 12, 23264, 5842, 691, 737, 198, 9237, 9041, 357, 5219, 12, 290, 640, 12, 31534, 8, 318, 4855, 13, 1002, 345, 836, 470, 765, 2995, 284, 307, 12118, 11, 345, 460, 15560, 1785, 12, 4993, 1359, 329, 262, 47986, 23264, 52, 4600, 77, 69, 30300, 63, 351, 262, 11688, 4600, 15596, 12885, 1359, 796, 3991, 44646, 198, 198, 30719, 11, 3224, 18695, 52, 12, 27160, 460, 307, 900, 2884, 21179, 7159, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 44646, 198, 30719, 11, 3224, 18695, 52, 12, 27160, 460, 307, 29517, 416, 21179, 4578, 4600, 1136, 11395, 19927, 44646, 198, 198, 22203, 2753, 262, 1459, 1080, 1181, 7177, 5855, 87, 4943, 290, 5860, 281, 7177, 351, 1181, 28486, 5855, 87, 16605, 4943, 290, 42976, 262, 18695, 52, 12, 27160, 329, 4600, 1136, 11395, 19927, 44646, 198, 34149, 262, 18695, 52, 640, 2884, 4578, 4600, 83, 63, 318, 11902, 11, 611, 407, 900, 11, 262, 1459, 640, 286, 262, 440, 7206, 1540, 332, 1088, 262, 47986, 23264, 52, 318, 973, 13, 198, 37811, 198, 8818, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 3712, 19182, 90, 27, 25, 15633, 5512, 198, 220, 220, 220, 220, 220, 220, 220, 256, 796, 532, 16, 13, 15, 11, 2, 3712, 15633, 11, 198, 220, 220, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 828, 220, 198, 220, 220, 220, 220, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 220, 628, 220, 220, 220, 4808, 69, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 11, 2124, 11, 256, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 437, 198, 8818, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 198, 220, 220, 220, 2124, 3712, 19182, 90, 27, 25, 39746, 28813, 13, 36248, 90, 46047, 11, 569, 87, 11, 399, 87, 92, 5512, 198, 220, 220, 220, 256, 796, 532, 16, 13, 15, 11, 2, 3712, 15633, 11, 198, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 828, 198, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 828, 198, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 8, 1267, 810, 1391, 46047, 11, 569, 87, 11, 399, 87, 92, 628, 220, 220, 220, 4808, 69, 11632, 17, 36, 2100, 4985, 11682, 62, 16344, 19510, 46047, 11, 569, 87, 11, 399, 87, 828, 357, 46047, 11, 569, 87, 11, 399, 87, 828, 552, 11, 2124, 11, 256, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 437, 198, 8818, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 198, 220, 220, 220, 2124, 3712, 19182, 90, 27, 25, 39746, 28813, 13, 36248, 90, 46047, 11, 569, 87, 11, 399, 87, 92, 5512, 198, 220, 220, 220, 256, 11, 2, 3712, 15633, 11, 198, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 5512, 198, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 39746, 28813, 13, 36248, 90, 47247, 11, 35816, 11, 21733, 92, 5512, 198, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 8, 1267, 810, 1391, 46047, 11, 569, 87, 11, 399, 87, 11, 16749, 11, 35816, 11, 21733, 92, 628, 220, 220, 220, 4808, 69, 11632, 17, 36, 2100, 4985, 11682, 62, 16344, 19510, 46047, 11, 569, 87, 11, 399, 87, 828, 357, 47247, 11, 35816, 11, 21733, 828, 552, 11, 2124, 11, 256, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 437, 198, 198, 2, 19530, 28813, 30203, 1262, 262, 4683, 21853, 37766, 14055, 13, 69, 25135, 198, 2, 16573, 422, 25, 3740, 1378, 15410, 9047, 13, 73, 377, 498, 648, 13, 2398, 14, 83, 14, 7983, 81, 377, 3798, 382, 12, 392, 12, 11813, 26069, 14, 47941, 2713, 14, 23, 198, 8818, 4808, 69, 11632, 17, 36, 2100, 4985, 11682, 62, 16344, 7, 6849, 45, 87, 11, 3195, 45, 84, 11, 552, 11, 2124, 11, 256, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 1303, 3003, 1391, 51, 11, 569, 11, 399, 92, 1303, 3003, 1391, 51, 92, 1303, 1279, 25, 39746, 28813, 13, 36248, 92, 198, 220, 220, 198, 220, 220, 220, 309, 87, 11, 569, 87, 11, 399, 87, 796, 3195, 45, 87, 198, 220, 220, 220, 16749, 11, 35816, 11, 21733, 796, 3195, 45, 84, 628, 220, 220, 220, 257, 136, 229, 81, 14542, 796, 685, 2949, 43909, 298, 22784, 1400, 43909, 298, 22784, 2824, 7, 39746, 28813, 13, 3911, 8231, 7, 68, 8, 329, 304, 287, 2124, 828, 19530, 28813, 13, 3911, 8231, 7, 83, 828, 1400, 43909, 298, 22784, 2824, 7, 39746, 28813, 13, 3911, 8231, 7, 68, 8, 329, 304, 287, 900, 40161, 828, 1400, 43909, 298, 3419, 60, 198, 220, 220, 220, 26498, 796, 685, 69, 11632, 17, 36, 2100, 4985, 11682, 11, 552, 11, 2824, 7, 39746, 28813, 13, 8367, 7, 68, 8, 329, 304, 287, 2124, 828, 19530, 28813, 13, 8367, 7, 83, 828, 900, 11395, 19927, 11, 2824, 7, 39746, 28813, 13, 8367, 7, 68, 8, 329, 304, 287, 900, 40161, 828, 651, 11395, 19927, 60, 628, 220, 220, 220, 1303, 1675, 5211, 25, 9938, 257, 922, 4259, 0, 198, 220, 220, 220, 1303, 57, 35641, 1258, 13, 31, 46430, 2488, 24442, 366, 4863, 29568, 4906, 1659, 7, 22046, 58, 21, 60, 4008, 1, 198, 220, 220, 220, 611, 2099, 1659, 7, 22046, 58, 21, 12962, 6624, 20650, 90, 7149, 92, 198, 220, 220, 220, 220, 220, 220, 220, 26498, 58, 21, 60, 796, 10385, 7, 38469, 90, 43879, 2414, 5512, 26498, 58, 21, 12962, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 57, 35641, 1258, 13, 31, 46430, 2488, 24442, 366, 2514, 29568, 4906, 1659, 7, 22046, 58, 21, 60, 4008, 1, 198, 220, 220, 220, 886, 220, 628, 220, 220, 220, 257, 136, 229, 81, 14542, 796, 357, 64, 136, 229, 81, 14542, 986, 35751, 198, 220, 220, 220, 26498, 796, 357, 22046, 986, 35751, 628, 220, 220, 220, 2488, 30493, 357, 4906, 1659, 7, 22046, 58, 18, 12962, 6624, 20650, 90, 43879, 2414, 30072, 8614, 357, 4906, 1659, 7, 22046, 58, 18, 12962, 6624, 20650, 90, 43879, 2624, 30072, 366, 3260, 11315, 11, 4600, 87, 63, 318, 991, 281, 12515, 2099, 4600, 3, 7, 4906, 1659, 7, 22046, 58, 18, 60, 4008, 63, 526, 198, 220, 220, 220, 220, 220, 198, 220, 220, 220, 331, 11, 4808, 11, 44332, 11, 4808, 11, 4808, 11, 7043, 11, 4808, 796, 21853, 37766, 14055, 13, 69, 25135, 7, 64, 136, 229, 81, 14542, 11, 26498, 23029, 628, 220, 220, 220, 611, 569, 87, 14512, 48436, 2414, 198, 220, 220, 220, 220, 220, 220, 220, 569, 87, 796, 48436, 2414, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 35816, 14512, 48436, 2414, 198, 220, 220, 220, 220, 220, 220, 220, 35816, 796, 48436, 2414, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1303, 2656, 2163, 5860, 685, 34350, 62, 16, 11, 2644, 11, 44332, 62, 77, 11, 331, 62, 16, 11, 2644, 11, 331, 62, 76, 60, 198, 220, 220, 220, 1303, 1675, 5211, 25, 3060, 44752, 28720, 357, 3911, 8231, 8, 422, 7043, 4613, 357, 34350, 11, 331, 8, 198, 220, 220, 220, 685, 33327, 7, 19530, 28813, 13, 36248, 90, 46047, 11, 569, 87, 11, 399, 87, 92, 7, 88, 58, 72, 4357, 44332, 58, 72, 12962, 329, 1312, 287, 352, 25, 13664, 7, 34350, 8, 1267, 22345, 198, 437, 198, 198, 8818, 4808, 69, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2124, 3712, 19182, 90, 27, 25, 15633, 5512, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 256, 3712, 15633, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 198, 220, 220, 220, 220, 198, 220, 220, 220, 2488, 30493, 277, 11632, 17, 3792, 17633, 3109, 3803, 7, 5589, 13, 69, 30300, 8, 14631, 69, 11632, 17, 36, 2100, 4985, 11682, 7, 986, 2599, 1081, 287, 262, 1438, 11, 428, 2163, 691, 6971, 11948, 12, 23264, 5842, 526, 60, 628, 220, 220, 220, 900, 353, 796, 357, 13664, 7, 2617, 11395, 19927, 8, 1875, 657, 8, 198, 220, 220, 220, 651, 353, 796, 357, 13664, 7, 1136, 11395, 19927, 8, 1875, 657, 8, 628, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 4129, 7, 2617, 11395, 19927, 8, 6624, 4129, 7, 2617, 40161, 8, 14631, 69, 11632, 17, 36, 2100, 4985, 11682, 7, 986, 2599, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 63, 761, 284, 307, 262, 976, 4129, 2474, 60, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 256, 18189, 657, 13, 15, 220, 198, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 7575, 7, 5589, 11, 256, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 15633, 7, 5589, 11, 900, 11395, 19927, 11, 900, 40161, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 277, 11632, 17, 7248, 17875, 5623, 42237, 7, 5589, 11, 2124, 8, 198, 220, 220, 220, 220, 198, 220, 220, 220, 331, 796, 17635, 198, 220, 220, 220, 611, 651, 353, 198, 220, 220, 220, 220, 220, 220, 220, 331, 796, 277, 11632, 17, 3855, 15633, 7, 5589, 11, 651, 11395, 19927, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 44332, 796, 277, 11632, 17, 3855, 28532, 452, 2929, 7, 5589, 8, 628, 220, 220, 220, 685, 34350, 986, 11, 331, 22345, 220, 198, 437, 198, 198, 8818, 21853, 37766, 14055, 13, 81, 25135, 7, 3712, 4906, 1659, 7, 69, 11632, 17, 36, 2100, 4985, 11682, 828, 220, 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, 552, 3712, 23264, 52, 17, 21950, 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, 2124, 3712, 19182, 90, 27, 25, 15633, 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, 220, 220, 220, 220, 220, 220, 256, 3712, 15633, 796, 532, 16, 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, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 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, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 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, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 628, 220, 220, 220, 331, 796, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 11, 2124, 11, 256, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 220, 220, 220, 2163, 277, 11632, 17, 36, 2100, 4985, 11682, 62, 31216, 1891, 7, 88, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 353, 796, 357, 13664, 7, 2617, 11395, 19927, 8, 1875, 657, 8, 198, 220, 220, 220, 220, 220, 220, 220, 651, 353, 796, 357, 13664, 7, 1136, 11395, 19927, 8, 1875, 657, 8, 628, 220, 220, 220, 220, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 4129, 7, 2617, 11395, 19927, 8, 6624, 4129, 7, 2617, 40161, 8, 14631, 35491, 37766, 14055, 13, 81, 25135, 7, 69, 11632, 17, 36, 2100, 4985, 11682, 11, 2644, 2599, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 63, 761, 284, 307, 262, 976, 4129, 2474, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 611, 256, 18189, 657, 13, 15, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 7575, 7, 5589, 11, 256, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 17875, 5623, 42237, 7, 5589, 11, 2124, 8, 628, 220, 220, 220, 220, 220, 220, 220, 374, 34350, 796, 410, 9246, 7, 5589, 13, 69, 30300, 13, 19849, 11828, 13, 1082, 452, 876, 11395, 19927, 11, 651, 11395, 19927, 8, 220, 198, 220, 220, 220, 220, 220, 220, 220, 374, 87, 796, 552, 13, 69, 30300, 13, 19849, 11828, 13, 5219, 11395, 19927, 198, 220, 220, 220, 220, 220, 220, 220, 7422, 796, 900, 11395, 19927, 628, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 87, 796, 1400, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 1400, 43909, 298, 3419, 628, 220, 220, 220, 220, 220, 220, 220, 611, 552, 13, 33819, 37, 19524, 6624, 1058, 12853, 8614, 552, 13, 33819, 37, 19524, 6624, 1058, 37295, 282, 28532, 452, 2929, 8614, 552, 13, 33819, 37, 19524, 6624, 1058, 23736, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 39852, 3955, 14887, 6234, 25, 24061, 649, 474, 330, 672, 1547, 691, 611, 1080, 1181, 393, 640, 3421, 11, 4306, 1441, 262, 39986, 530, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 552, 13, 30482, 62, 87, 14512, 2124, 8614, 552, 13, 30482, 62, 83, 14512, 256, 220, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 2546, 7, 5589, 13, 30482, 62, 67, 5431, 62, 87, 8, 14512, 357, 13664, 7, 4372, 87, 828, 4129, 7, 40914, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 67, 5431, 62, 87, 796, 1976, 27498, 7, 13664, 7, 4372, 87, 828, 4129, 7, 40914, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 672, 666, 37, 310, 7, 5589, 13, 30482, 62, 67, 5431, 62, 87, 11, 552, 11, 374, 34350, 11, 374, 87, 8, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 2546, 7, 5589, 13, 30482, 62, 67, 5431, 62, 84, 8, 14512, 357, 13664, 7, 4372, 87, 828, 4129, 7, 622, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 67, 5431, 62, 84, 796, 1976, 27498, 7, 13664, 7, 4372, 87, 828, 4129, 7, 622, 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, 220, 220, 220, 220, 552, 13, 30482, 672, 666, 37, 310, 7, 5589, 13, 30482, 62, 67, 5431, 62, 84, 11, 552, 11, 374, 34350, 11, 7422, 8, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 87, 796, 2124, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 83, 796, 256, 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, 299, 62, 34350, 62, 87, 796, 2488, 400, 2954, 7, 5589, 13, 30482, 62, 67, 5431, 62, 87, 6, 1635, 331, 136, 226, 8, 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, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 2488, 400, 2954, 7, 5589, 13, 30482, 62, 67, 5431, 62, 84, 6, 1635, 331, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 552, 13, 33819, 37, 19524, 6624, 1058, 41255, 1563, 28532, 452, 2929, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 3991, 366, 2782, 73, 1563, 9626, 452, 2929, 407, 4855, 416, 376, 8895, 17, 526, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 3991, 366, 63, 33819, 37, 19524, 43641, 7, 5589, 13, 33819, 37, 19524, 8, 63, 6439, 1988, 329, 4600, 33819, 37, 19524, 63, 526, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 277, 136, 226, 796, 1400, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 269, 136, 226, 3361, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 136, 226, 796, 299, 62, 34350, 62, 87, 198, 220, 220, 220, 220, 220, 220, 220, 256, 136, 226, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 220, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 40161, 796, 299, 62, 34350, 62, 84, 198, 220, 220, 220, 220, 220, 220, 220, 308, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 277, 136, 226, 11, 269, 136, 226, 3361, 11, 2124, 136, 226, 11, 256, 136, 226, 11, 264, 136, 226, 316, 11395, 19927, 11, 264, 136, 226, 316, 40161, 11, 308, 136, 226, 316, 11395, 19927, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 331, 11, 277, 11632, 17, 36, 2100, 4985, 11682, 62, 31216, 1891, 198, 437, 198, 198, 8818, 21853, 37766, 14055, 13, 69, 25135, 19510, 138, 242, 944, 11, 37455, 5589, 11, 37455, 87, 11, 37455, 83, 11, 37455, 2617, 11395, 19927, 11, 37455, 2617, 40161, 11, 37455, 1136, 11395, 19927, 828, 220, 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, 7904, 4906, 1659, 7, 69, 11632, 17, 36, 2100, 4985, 11682, 828, 220, 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, 552, 11, 1303, 3712, 23264, 52, 17, 21950, 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, 2124, 11, 2, 3712, 19182, 90, 27, 25, 15633, 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, 220, 220, 220, 220, 220, 220, 256, 11, 2, 3712, 15633, 796, 532, 16, 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, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 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, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 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, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 628, 220, 220, 220, 331, 796, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 5589, 11, 2124, 11, 256, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 220, 220, 220, 2163, 277, 11632, 17, 36, 2100, 4985, 11682, 62, 31216, 11813, 7, 138, 242, 87, 11, 37455, 2617, 40161, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 353, 796, 357, 13664, 7, 2617, 11395, 19927, 8, 1875, 657, 8, 198, 220, 220, 220, 220, 220, 220, 220, 651, 353, 796, 357, 13664, 7, 1136, 11395, 19927, 8, 1875, 657, 8, 628, 220, 220, 220, 220, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 4129, 7, 2617, 11395, 19927, 8, 6624, 4129, 7, 2617, 40161, 8, 14631, 35491, 37766, 14055, 13, 69, 25135, 7, 69, 11632, 17, 36, 2100, 4985, 11682, 11, 2644, 2599, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 63, 761, 284, 307, 262, 976, 4129, 2474, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 611, 256, 18189, 657, 13, 15, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 7575, 7, 5589, 11, 256, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 611, 477, 7, 9160, 12195, 87, 11, 19530, 28813, 13, 36248, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2124, 69, 796, 2824, 7, 39746, 28813, 13, 8367, 7, 68, 8, 329, 304, 287, 2124, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 17875, 5623, 42237, 7, 5589, 11, 2124, 69, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 17875, 5623, 42237, 7, 5589, 11, 2124, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 374, 34350, 796, 410, 9246, 7, 5589, 13, 69, 30300, 13, 19849, 11828, 13, 1082, 452, 876, 11395, 19927, 11, 651, 11395, 19927, 8, 220, 198, 220, 220, 220, 220, 220, 220, 220, 374, 87, 796, 552, 13, 69, 30300, 13, 19849, 11828, 13, 5219, 11395, 19927, 198, 220, 220, 220, 220, 220, 220, 220, 7422, 796, 900, 11395, 19927, 628, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 87, 796, 1400, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 1400, 43909, 298, 3419, 628, 220, 220, 220, 220, 220, 220, 220, 611, 552, 13, 33819, 37, 19524, 6624, 1058, 23736, 8614, 552, 13, 33819, 37, 19524, 6624, 1058, 12853, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 39852, 3955, 14887, 6234, 25, 24061, 649, 474, 330, 672, 1547, 691, 611, 1080, 1181, 393, 640, 3421, 11, 4306, 1441, 262, 39986, 530, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 1675, 5211, 25, 30011, 1096, 329, 651, 35, 4154, 282, 28532, 452, 2929, 351, 9403, 15879, 37455, 87, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 552, 13, 30482, 62, 87, 14512, 2124, 8614, 552, 13, 30482, 62, 83, 14512, 256, 220, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 2546, 7, 5589, 13, 30482, 62, 67, 5431, 62, 87, 8, 14512, 357, 13664, 7, 4372, 87, 828, 4129, 7, 40914, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 67, 5431, 62, 87, 796, 1976, 27498, 7, 13664, 7, 4372, 87, 828, 4129, 7, 40914, 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, 220, 220, 220, 220, 552, 13, 30482, 672, 666, 37, 310, 7, 5589, 13, 30482, 62, 67, 5431, 62, 87, 11, 552, 11, 374, 34350, 11, 374, 87, 8, 628, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 2546, 7, 5589, 13, 30482, 62, 67, 5431, 62, 84, 8, 14512, 357, 13664, 7, 4372, 87, 828, 4129, 7, 622, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 67, 5431, 62, 84, 796, 1976, 27498, 7, 13664, 7, 4372, 87, 828, 4129, 7, 622, 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, 220, 220, 220, 220, 552, 13, 30482, 672, 666, 37, 310, 7, 5589, 13, 30482, 62, 67, 5431, 62, 84, 11, 552, 11, 374, 34350, 11, 7422, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 87, 796, 2124, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 62, 83, 796, 256, 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, 299, 62, 34350, 62, 87, 796, 552, 13, 30482, 62, 67, 5431, 62, 87, 1635, 37455, 87, 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, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 552, 13, 30482, 62, 67, 5431, 62, 84, 1635, 37455, 2617, 40161, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 552, 13, 33819, 37, 19524, 6624, 1058, 37295, 282, 28532, 452, 2929, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 87, 796, 277, 11632, 17, 3855, 35, 4154, 282, 28532, 452, 876, 7, 5589, 11, 374, 34350, 11, 374, 87, 11, 37455, 87, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 277, 11632, 17, 3855, 35, 4154, 282, 28532, 452, 876, 7, 5589, 11, 374, 34350, 11, 7422, 11, 37455, 2617, 40161, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 361, 552, 13, 33819, 37, 19524, 6624, 1058, 41255, 1563, 28532, 452, 2929, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 3991, 366, 2782, 73, 1563, 9626, 452, 2929, 407, 4855, 416, 376, 8895, 17, 526, 198, 220, 220, 220, 220, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 3991, 366, 63, 33819, 37, 19524, 43641, 7, 5589, 13, 33819, 37, 19524, 8, 63, 6439, 1988, 329, 4600, 33819, 37, 19524, 63, 526, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 269, 136, 226, 3361, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 2124, 136, 226, 796, 299, 62, 34350, 62, 87, 220, 198, 220, 220, 220, 220, 220, 220, 220, 256, 136, 226, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 40161, 796, 299, 62, 34350, 62, 84, 198, 220, 220, 220, 220, 220, 220, 220, 308, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 66, 136, 226, 3361, 11, 2124, 136, 226, 11, 256, 136, 226, 11, 264, 136, 226, 316, 11395, 19927, 11, 264, 136, 226, 316, 40161, 11, 308, 136, 226, 316, 11395, 19927, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 357, 88, 11, 277, 11632, 17, 36, 2100, 4985, 11682, 62, 31216, 11813, 7, 138, 242, 87, 11, 37455, 2617, 40161, 8, 23029, 198, 437, 198, 198, 37811, 198, 5990, 23914, 257, 277, 11632, 5211, 8600, 329, 9429, 12, 23264, 5842, 357, 11295, 11, 326, 277, 11632, 5211, 8600, 318, 329, 9429, 12, 23264, 5842, 691, 737, 198, 198, 30719, 11, 18695, 52, 12, 27160, 460, 307, 900, 2884, 21179, 7159, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 44646, 198, 30719, 11, 18695, 52, 12, 27160, 460, 307, 29517, 416, 21179, 4578, 4600, 1136, 11395, 19927, 44646, 198, 198, 22203, 5860, 262, 18695, 52, 12, 27160, 329, 262, 11902, 21179, 4578, 4600, 1136, 11395, 19927, 44646, 198, 464, 9429, 12, 23264, 52, 17706, 530, 15021, 2239, 351, 2239, 2546, 4600, 28664, 44646, 37947, 298, 319, 262, 11521, 29052, 1540, 332, 11, 262, 18695, 52, 743, 1620, 3294, 357, 32538, 8, 4580, 4831, 611, 2622, 284, 1826, 1540, 332, 5359, 357, 301, 1799, 14, 4134, 23843, 737, 2312, 4580, 4831, 389, 7104, 416, 376, 8895, 17, 13, 198, 37811, 198, 8818, 277, 11632, 17, 5211, 8600, 7902, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 288, 83, 3712, 15633, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 198, 220, 220, 220, 4808, 69, 11632, 17, 5211, 8600, 7902, 7, 5589, 11, 288, 83, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 437, 198, 8818, 277, 11632, 17, 5211, 8600, 7902, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 198, 220, 220, 220, 288, 83, 11, 2, 3712, 15633, 11, 198, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 828, 198, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 39746, 28813, 13, 36248, 90, 47247, 11, 35816, 11, 21733, 11709, 796, 15690, 90, 39746, 28813, 13, 36248, 90, 47247, 11, 35816, 11, 21733, 11709, 22784, 198, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 8, 1267, 810, 1391, 47247, 11, 35816, 11, 21733, 92, 628, 220, 220, 220, 4808, 69, 11632, 17, 5211, 8600, 7902, 62, 16344, 19510, 51, 67, 11, 569, 67, 11, 399, 67, 828, 552, 11, 288, 83, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 437, 198, 198, 2, 5053, 525, 780, 21179, 7159, 389, 357, 41745, 8, 407, 4855, 416, 1168, 35641, 1258, 13, 198, 8818, 4808, 69, 11632, 17, 5211, 8600, 7902, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 288, 83, 3712, 15633, 11, 220, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 828, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 198, 220, 220, 220, 220, 198, 220, 220, 220, 2488, 30493, 277, 11632, 17, 3792, 7222, 8890, 1741, 7, 5589, 13, 69, 30300, 8, 14631, 69, 11632, 17, 5211, 8600, 7902, 7, 986, 2599, 1081, 287, 262, 1438, 11, 428, 2163, 691, 6971, 9429, 12, 23264, 5842, 526, 60, 198, 220, 220, 220, 2488, 30493, 4129, 7, 2617, 11395, 19927, 8, 6624, 4129, 7, 2617, 40161, 8, 14631, 69, 11632, 17, 5211, 8600, 7902, 7, 986, 2599, 4600, 2617, 11395, 19927, 63, 7198, 7, 13664, 7, 2617, 11395, 19927, 22305, 290, 4600, 2617, 40161, 63, 7198, 7, 13664, 7, 2617, 40161, 22305, 761, 284, 307, 262, 976, 4129, 2474, 60, 628, 220, 220, 220, 611, 4129, 7, 2617, 11395, 19927, 8, 1875, 657, 198, 220, 220, 220, 220, 220, 220, 220, 277, 11632, 17, 7248, 15633, 7, 5589, 11, 900, 11395, 19927, 11, 900, 40161, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 277, 11632, 17, 5211, 8600, 7, 5589, 11, 288, 83, 8, 628, 220, 220, 220, 331, 796, 1976, 27498, 7, 43879, 2414, 11, 657, 8, 628, 220, 220, 220, 611, 4129, 7, 1136, 11395, 19927, 8, 1875, 657, 198, 220, 220, 220, 220, 220, 220, 220, 331, 796, 277, 11632, 17, 3855, 15633, 7, 5589, 11, 651, 11395, 19927, 8, 198, 220, 220, 220, 886, 628, 220, 220, 220, 331, 198, 437, 198, 198, 2, 19530, 28813, 30203, 1262, 262, 4683, 21853, 37766, 14055, 13, 69, 25135, 198, 2, 16573, 422, 25, 3740, 1378, 15410, 9047, 13, 73, 377, 498, 648, 13, 2398, 14, 83, 14, 7983, 81, 377, 3798, 382, 12, 392, 12, 11813, 26069, 14, 47941, 2713, 14, 23, 198, 8818, 4808, 69, 11632, 17, 5211, 8600, 7902, 62, 16344, 7, 6849, 45, 84, 11, 220, 198, 220, 220, 220, 552, 11, 220, 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, 288, 83, 11, 220, 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, 900, 11395, 19927, 11, 220, 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, 900, 40161, 11, 220, 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, 651, 11395, 19927, 8, 220, 198, 220, 220, 198, 220, 220, 220, 16749, 11, 35816, 11, 21733, 796, 3195, 45, 84, 628, 220, 220, 220, 257, 136, 229, 81, 14542, 796, 685, 2949, 43909, 298, 22784, 1400, 43909, 298, 22784, 19530, 28813, 13, 3911, 8231, 7, 28664, 828, 1400, 43909, 298, 22784, 2824, 7, 39746, 28813, 13, 3911, 8231, 7, 68, 8, 329, 304, 287, 900, 40161, 828, 1400, 43909, 298, 3419, 60, 198, 220, 220, 220, 26498, 796, 685, 69, 11632, 17, 5211, 8600, 7902, 11, 552, 11, 19530, 28813, 13, 8367, 7, 28664, 828, 900, 11395, 19927, 11, 2824, 7, 39746, 28813, 13, 8367, 7, 68, 8, 329, 304, 287, 900, 40161, 828, 651, 11395, 19927, 60, 628, 220, 220, 220, 1303, 1675, 5211, 25, 9938, 257, 922, 4259, 0, 198, 220, 220, 220, 611, 2099, 1659, 7, 22046, 58, 20, 12962, 6624, 20650, 90, 7149, 92, 198, 220, 220, 220, 220, 220, 220, 220, 26498, 58, 20, 60, 796, 10385, 7, 38469, 90, 43879, 2414, 5512, 26498, 58, 20, 12962, 198, 220, 220, 220, 886, 220, 628, 220, 220, 220, 257, 136, 229, 81, 14542, 796, 357, 64, 136, 229, 81, 14542, 986, 35751, 198, 220, 220, 220, 26498, 796, 357, 22046, 986, 35751, 198, 220, 220, 220, 220, 220, 198, 220, 220, 220, 331, 11, 4808, 11, 4808, 11, 4808, 11, 7043, 11, 4808, 796, 21853, 37766, 14055, 13, 69, 25135, 7, 64, 136, 229, 81, 14542, 11, 26498, 23029, 628, 220, 220, 220, 611, 35816, 14512, 48436, 2414, 198, 220, 220, 220, 220, 220, 220, 220, 35816, 796, 48436, 2414, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1303, 2656, 2163, 5860, 685, 88, 62, 16, 11, 2644, 11, 331, 62, 76, 60, 198, 220, 220, 220, 685, 33327, 7, 19530, 28813, 13, 36248, 90, 47247, 11, 35816, 11, 21733, 92, 7, 88, 58, 72, 4357, 7043, 58, 72, 12962, 329, 1312, 287, 352, 25, 13664, 7, 646, 8, 1267, 22345, 198, 437, 198, 198, 8818, 21853, 37766, 14055, 13, 81, 25135, 7, 3712, 4906, 1659, 7, 69, 11632, 17, 5211, 8600, 7902, 828, 220, 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, 552, 3712, 23264, 52, 17, 21950, 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, 288, 83, 3712, 15633, 796, 532, 16, 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, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 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, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 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, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 628, 220, 220, 220, 331, 796, 277, 11632, 17, 5211, 8600, 7902, 7, 5589, 11, 288, 83, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 220, 220, 220, 2163, 277, 11632, 17, 5211, 8600, 7902, 62, 31216, 1891, 7, 88, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 353, 796, 357, 13664, 7, 2617, 11395, 19927, 8, 1875, 657, 8, 198, 220, 220, 220, 220, 220, 220, 220, 651, 353, 796, 357, 13664, 7, 1136, 11395, 19927, 8, 1875, 657, 8, 628, 220, 220, 220, 220, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 4129, 7, 2617, 11395, 19927, 8, 6624, 4129, 7, 2617, 40161, 8, 14631, 35491, 37766, 14055, 13, 81, 25135, 7, 69, 11632, 17, 5211, 8600, 7902, 11, 2644, 2599, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 63, 761, 284, 307, 262, 976, 4129, 2474, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 374, 34350, 796, 651, 11395, 19927, 198, 220, 220, 220, 220, 220, 220, 220, 374, 87, 796, 900, 11395, 19927, 628, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 12169, 43909, 298, 3419, 628, 220, 220, 220, 220, 220, 220, 220, 611, 651, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2603, 796, 1976, 27498, 7, 13664, 7, 4372, 87, 828, 4129, 7, 40914, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 672, 666, 37, 310, 7, 6759, 11, 552, 11, 374, 34350, 11, 374, 87, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 2488, 400, 2954, 7, 6759, 6, 1635, 331, 136, 226, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 277, 136, 226, 796, 1400, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 277, 136, 226, 30300, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 288, 136, 226, 83, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 40161, 796, 299, 62, 34350, 62, 84, 198, 220, 220, 220, 220, 220, 220, 220, 308, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 628, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 69, 136, 226, 11, 277, 136, 226, 30300, 11, 288, 136, 226, 83, 11, 264, 136, 226, 316, 11395, 19927, 11, 264, 136, 226, 316, 40161, 11, 308, 136, 226, 316, 11395, 19927, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 331, 11, 277, 11632, 17, 5211, 8600, 7902, 62, 31216, 1891, 198, 437, 198, 198, 8818, 21853, 37766, 14055, 13, 69, 25135, 19510, 138, 242, 944, 11, 37455, 5589, 11, 37455, 28664, 11, 37455, 2617, 11395, 19927, 11, 37455, 2617, 40161, 11, 37455, 1136, 11395, 19927, 828, 220, 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, 7904, 4906, 1659, 7, 69, 11632, 17, 5211, 8600, 7902, 828, 220, 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, 552, 11, 1303, 3712, 23264, 52, 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, 288, 83, 11, 2, 3712, 15633, 796, 532, 16, 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, 220, 220, 220, 220, 220, 900, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 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, 220, 220, 900, 40161, 3712, 19182, 90, 27, 25, 15633, 92, 796, 1976, 27498, 7, 15633, 11, 657, 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, 220, 220, 651, 11395, 19927, 3712, 19182, 90, 69, 11632, 17, 11395, 26687, 92, 796, 1976, 27498, 7, 69, 11632, 17, 11395, 26687, 11, 657, 4008, 628, 220, 220, 220, 331, 796, 277, 11632, 17, 5211, 8600, 7902, 7, 5589, 11, 288, 83, 11, 900, 11395, 19927, 11, 900, 40161, 11, 651, 11395, 19927, 8, 198, 220, 220, 220, 2163, 277, 11632, 17, 5211, 8600, 7902, 62, 31216, 11813, 7, 138, 242, 2617, 40161, 8, 198, 220, 220, 220, 220, 220, 220, 220, 900, 353, 796, 357, 13664, 7, 2617, 11395, 19927, 8, 1875, 657, 8, 198, 220, 220, 220, 220, 220, 220, 220, 651, 353, 796, 357, 13664, 7, 1136, 11395, 19927, 8, 1875, 657, 8, 628, 220, 220, 220, 220, 220, 220, 220, 611, 900, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 4129, 7, 2617, 11395, 19927, 8, 6624, 4129, 7, 2617, 40161, 8, 14631, 35491, 37766, 14055, 13, 69, 25135, 7, 69, 11632, 17, 5211, 8600, 7902, 11, 2644, 2599, 4600, 2617, 11395, 19927, 63, 290, 4600, 2617, 40161, 63, 761, 284, 307, 262, 976, 4129, 2474, 60, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 374, 34350, 796, 651, 11395, 19927, 198, 220, 220, 220, 220, 220, 220, 220, 374, 87, 796, 900, 11395, 19927, 628, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 12169, 43909, 298, 3419, 628, 220, 220, 220, 220, 220, 220, 220, 611, 651, 353, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2603, 796, 1976, 27498, 7, 13664, 7, 4372, 87, 828, 4129, 7, 40914, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 30482, 672, 666, 37, 310, 7, 6759, 11, 552, 11, 374, 34350, 11, 374, 87, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 299, 62, 34350, 62, 84, 796, 2603, 1635, 37455, 2617, 40161, 198, 220, 220, 220, 220, 220, 220, 220, 886, 628, 220, 220, 220, 220, 220, 220, 220, 277, 136, 226, 30300, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 288, 136, 226, 83, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 264, 136, 226, 316, 40161, 796, 299, 62, 34350, 62, 84, 198, 220, 220, 220, 220, 220, 220, 220, 308, 136, 226, 316, 11395, 19927, 796, 12169, 43909, 298, 3419, 628, 220, 220, 220, 220, 220, 220, 220, 1441, 357, 69, 136, 226, 30300, 11, 288, 136, 226, 83, 11, 264, 136, 226, 316, 11395, 19927, 11, 264, 136, 226, 316, 40161, 11, 308, 136, 226, 316, 11395, 19927, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 1441, 357, 88, 11, 277, 11632, 17, 5211, 8600, 7902, 62, 31216, 11813, 7, 138, 242, 2617, 40161, 8, 23029, 198, 437, 198, 198, 37811, 198, 220, 220, 220, 277, 11632, 17, 20560, 5211, 8600, 7902, 26410, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 220, 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, 83, 3712, 15633, 11, 220, 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, 334, 3712, 19182, 90, 27, 25, 15633, 30072, 198, 198, 50, 1039, 477, 18695, 52, 17311, 284, 4600, 84, 47671, 17706, 257, 1587, 112, 18265, 18265, 69, 11632, 17, 5211, 8600, 18265, 18265, 18265, 290, 5860, 477, 18695, 52, 23862, 13, 198, 37811, 198, 8818, 277, 11632, 17, 20560, 5211, 8600, 7902, 26410, 7, 5589, 3712, 23264, 52, 17, 21950, 11, 220, 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, 288, 83, 3712, 15633, 11, 220, 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, 334, 3712, 19182, 90, 27, 25, 15633, 30072, 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, 198, 220, 220, 220, 2488, 30493, 277, 11632, 17, 3792, 7222, 8890, 1741, 7, 5589, 13, 69, 30300, 8, 14631, 69, 11632, 17, 20560, 5211, 8600, 7902, 26410, 7, 986, 2599, 1081, 287, 262, 1438, 11, 428, 2163, 691, 6971, 9429, 12, 23264, 5842, 526, 60, 628, 220, 220, 220, 277, 11632, 17, 5211, 8600, 7902, 7, 5589, 11, 288, 83, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 69, 30300, 13, 19849, 11828, 13, 15414, 11395, 19927, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 334, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 552, 13, 69, 30300, 13, 19849, 11828, 13, 22915, 11395, 19927, 8, 198, 437, 198, 198, 2, 18695, 52, 7917, 11799, 198, 198, 8818, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 69, 30300, 3712, 23264, 52, 17, 11, 26498, 986, 26, 479, 86, 22046, 23029, 198, 220, 220, 220, 277, 11632, 17, 36, 2100, 4985, 11682, 7, 69, 30300, 13, 5589, 3906, 58, 437, 4357, 26498, 986, 26, 479, 86, 22046, 23029, 198, 437, 198, 198, 8818, 277, 11632, 17, 5211, 8600, 7902, 7, 69, 30300, 3712, 23264, 52, 17, 11, 26498, 986, 26, 479, 86, 22046, 23029, 198, 220, 220, 220, 277, 11632, 17, 5211, 8600, 7902, 7, 69, 30300, 13, 5589, 3906, 58, 437, 4357, 26498, 986, 26, 479, 86, 22046, 23029, 198, 437, 198, 198, 8818, 277, 11632, 17, 20560, 5211, 8600, 7902, 26410, 7, 69, 30300, 3712, 23264, 52, 17, 11, 26498, 986, 26, 479, 86, 22046, 23029, 198, 220, 220, 220, 277, 11632, 17, 20560, 5211, 8600, 7902, 26410, 7, 69, 30300, 13, 5589, 3906, 58, 437, 4357, 26498, 986, 26, 479, 86, 22046, 23029, 198, 437 ]
2.136129
9,087
using GmshParser using Test @testset "GmshParser.jl" begin # Write your tests here. end
[ 3500, 402, 907, 71, 46677, 198, 3500, 6208, 198, 198, 31, 9288, 2617, 366, 38, 907, 71, 46677, 13, 20362, 1, 2221, 198, 220, 220, 220, 1303, 19430, 534, 5254, 994, 13, 198, 437, 198 ]
2.657143
35
""" Stacked layer is a abstract type and defines common behavior for containers layers that enables to access them as arrays. """ abstract type StackedLayer <: Layer end add(model::StackedLayer, layers...) = push!(model.layers, layers...) """ Sequential layer allows to chain together a number of other layers. # Usage ```julia model = Sequential(Conv2D(100),MaxPool(),Dense(10)) ``` """ struct Sequential <:StackedLayer layers::Vector Sequential(blocks...) = new([blocks...]) end function call(model::Sequential, X::Tensor) for layer in model.layers X = layer(X) end return X end """ Concurrrent layer allows for stacking a number of other layers in parallel and combining their results before returning it. This layer will stack on the second last dimension. So with 2D and 3D convolution this will be the channel layer (WxHxCxN). As a result other dimensions have to the same. """ struct Concurrent <:StackedLayer layers::Vector Concurrent(blocks...) = new([blocks...]) end function call(model::Concurrent, X::Tensor) out = [] for layer in model.layers push!(out, layer(X)) end cat(out..., dims=ndims(out[1])-1) end """ Residual Layer works like a Sequential layer, however before returning the result it will be combined with the orginal input (residual). This is a popular techique in modern neural networds since it allows for better backpropagation. This will stack on the second last dimension. So with 2D and 3D convolution this will be the channel layer (WxHxCxN) """ struct Residual <:StackedLayer layers::Vector Residual(blocks...) = new([blocks...]) end function call(model::Residual, X::Tensor) res = X for layer in model.layers X = layer(X) end cat(res, X, dims=ndims(res[1])-1) end @debug "Loaded Container modules"
[ 198, 37811, 198, 1273, 6021, 7679, 318, 257, 12531, 2099, 290, 15738, 2219, 4069, 329, 16472, 198, 75, 6962, 326, 13536, 284, 1895, 606, 355, 26515, 13, 198, 37811, 198, 397, 8709, 2099, 520, 6021, 49925, 1279, 25, 34398, 886, 198, 198, 2860, 7, 19849, 3712, 1273, 6021, 49925, 11, 11685, 23029, 796, 4574, 0, 7, 19849, 13, 75, 6962, 11, 11685, 23029, 628, 198, 198, 37811, 198, 44015, 1843, 7679, 3578, 284, 6333, 1978, 257, 1271, 286, 584, 11685, 13, 198, 198, 2, 29566, 198, 198, 15506, 63, 73, 43640, 198, 19849, 796, 24604, 1843, 7, 3103, 85, 17, 35, 7, 3064, 828, 11518, 27201, 22784, 35, 1072, 7, 940, 4008, 198, 15506, 63, 198, 198, 37811, 198, 7249, 24604, 1843, 1279, 25, 1273, 6021, 49925, 198, 220, 220, 220, 11685, 3712, 38469, 628, 197, 44015, 1843, 7, 27372, 23029, 796, 649, 26933, 27372, 986, 12962, 198, 437, 198, 198, 8818, 869, 7, 19849, 3712, 44015, 1843, 11, 1395, 3712, 51, 22854, 8, 198, 197, 1640, 7679, 287, 2746, 13, 75, 6962, 198, 197, 197, 55, 796, 7679, 7, 55, 8, 198, 197, 437, 198, 197, 7783, 1395, 198, 437, 628, 198, 37811, 198, 3103, 22019, 81, 1156, 7679, 3578, 329, 41228, 257, 1271, 286, 584, 11685, 287, 10730, 290, 198, 24011, 3191, 511, 2482, 878, 8024, 340, 13, 198, 198, 1212, 7679, 481, 8931, 319, 262, 1218, 938, 15793, 13, 198, 2396, 351, 362, 35, 290, 513, 35, 3063, 2122, 428, 481, 307, 262, 6518, 7679, 357, 54, 87, 39, 87, 34, 87, 45, 737, 1081, 257, 1255, 198, 847, 15225, 423, 284, 262, 976, 13, 198, 37811, 198, 7249, 13223, 6657, 1279, 25, 1273, 6021, 49925, 198, 220, 220, 220, 11685, 3712, 38469, 628, 197, 3103, 14421, 7, 27372, 23029, 796, 649, 26933, 27372, 986, 12962, 198, 437, 198, 198, 8818, 869, 7, 19849, 3712, 3103, 14421, 11, 1395, 3712, 51, 22854, 8, 198, 197, 448, 796, 17635, 198, 197, 1640, 7679, 287, 2746, 13, 75, 6962, 198, 197, 197, 14689, 0, 7, 448, 11, 7679, 7, 55, 4008, 198, 197, 437, 198, 197, 9246, 7, 448, 986, 11, 5391, 82, 28, 358, 12078, 7, 448, 58, 16, 12962, 12, 16, 8, 198, 437, 628, 198, 37811, 198, 4965, 312, 723, 34398, 2499, 588, 257, 24604, 1843, 7679, 11, 2158, 878, 8024, 262, 1255, 198, 270, 481, 307, 5929, 351, 262, 8745, 1292, 5128, 357, 411, 312, 723, 737, 770, 318, 257, 2968, 7261, 2350, 198, 259, 3660, 17019, 2010, 10879, 1201, 340, 3578, 329, 1365, 736, 22930, 363, 341, 13, 198, 198, 1212, 481, 8931, 319, 262, 1218, 938, 15793, 13, 198, 2396, 351, 362, 35, 290, 513, 35, 3063, 2122, 428, 481, 307, 262, 6518, 7679, 357, 54, 87, 39, 87, 34, 87, 45, 8, 198, 37811, 198, 7249, 1874, 312, 723, 1279, 25, 1273, 6021, 49925, 198, 220, 220, 220, 11685, 3712, 38469, 628, 197, 4965, 312, 723, 7, 27372, 23029, 796, 649, 26933, 27372, 986, 12962, 198, 437, 198, 198, 8818, 869, 7, 19849, 3712, 4965, 312, 723, 11, 1395, 3712, 51, 22854, 8, 198, 197, 411, 796, 1395, 198, 197, 1640, 7679, 287, 2746, 13, 75, 6962, 198, 197, 197, 55, 796, 7679, 7, 55, 8, 198, 197, 437, 198, 197, 9246, 7, 411, 11, 1395, 11, 5391, 82, 28, 358, 12078, 7, 411, 58, 16, 12962, 12, 16, 8, 198, 437, 198, 198, 31, 24442, 366, 8912, 276, 43101, 13103, 1, 198 ]
3.126095
571
# Add our own pairwise function to be able to apply it on vectors function pairwise(d::PreMetric, X::AbstractVector, Y::AbstractVector) return broadcast(d, X, permutedims(Y)) end pairwise(d::PreMetric, X::AbstractVector) = pairwise(d, X, X) function pairwise!(out::AbstractMatrix, d::PreMetric, X::AbstractVector, Y::AbstractVector) return broadcast!(d, out, X, permutedims(Y)) end pairwise!(out::AbstractMatrix, d::PreMetric, X::AbstractVector) = pairwise!(out, d, X, X) function pairwise(d::PreMetric, x::AbstractVector{<:Real}) return Distances_pairwise(d, reshape(x, :, 1); dims=1) end function pairwise(d::PreMetric, x::AbstractVector{<:Real}, y::AbstractVector{<:Real}) return Distances_pairwise(d, reshape(x, :, 1), reshape(y, :, 1); dims=1) end function pairwise!(out::AbstractMatrix, d::PreMetric, x::AbstractVector{<:Real}) return Distances.pairwise!(out, d, reshape(x, :, 1); dims=1) end function pairwise!( out::AbstractMatrix, d::PreMetric, x::AbstractVector{<:Real}, y::AbstractVector{<:Real} ) return Distances.pairwise!(out, d, reshape(x, :, 1), reshape(y, :, 1); dims=1) end # Also defines the colwise method for abstractvectors function colwise(d::PreMetric, x::AbstractVector) return zeros(Distances.result_type(d, x, x), length(x)) # Valid since d(x,x) == 0 by definition end function colwise(d::PreMetric, x::ColVecs) return zeros(Distances.result_type(d, x.X, x.X), length(x)) # Valid since d(x,x) == 0 by definition end function colwise(d::PreMetric, x::RowVecs) return zeros(Distances.result_type(d, x.X, x.X), length(x)) # Valid since d(x,x) == 0 by definition end ## The following is a hack for DotProduct and Delta to still work function colwise(d::Distances.UnionPreMetric, x::ColVecs) return Distances.colwise(d, x.X, x.X) end function colwise(d::Distances.UnionPreMetric, x::RowVecs) return Distances.colwise(d, x.X', x.X') end function colwise(d::Distances.UnionPreMetric, x::AbstractVector) return map(d, x, x) end function colwise(d::PreMetric, x::ColVecs, y::ColVecs) return Distances.colwise(d, x.X, y.X) end function colwise(d::PreMetric, x::RowVecs, y::RowVecs) return Distances.colwise(d, x.X', y.X') end function colwise(d::PreMetric, x::AbstractVector, y::AbstractVector) return map(d, x, y) end
[ 2, 3060, 674, 898, 5166, 3083, 2163, 284, 307, 1498, 284, 4174, 340, 319, 30104, 198, 198, 8818, 5166, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 1395, 3712, 23839, 38469, 11, 575, 3712, 23839, 38469, 8, 198, 220, 220, 220, 1441, 7025, 7, 67, 11, 1395, 11, 9943, 7241, 12078, 7, 56, 4008, 198, 437, 198, 198, 24874, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 1395, 3712, 23839, 38469, 8, 796, 5166, 3083, 7, 67, 11, 1395, 11, 1395, 8, 198, 198, 8818, 5166, 3083, 0, 7, 448, 3712, 23839, 46912, 11, 288, 3712, 6719, 9171, 1173, 11, 1395, 3712, 23839, 38469, 11, 575, 3712, 23839, 38469, 8, 198, 220, 220, 220, 1441, 7025, 0, 7, 67, 11, 503, 11, 1395, 11, 9943, 7241, 12078, 7, 56, 4008, 198, 437, 198, 198, 24874, 3083, 0, 7, 448, 3712, 23839, 46912, 11, 288, 3712, 6719, 9171, 1173, 11, 1395, 3712, 23839, 38469, 8, 796, 5166, 3083, 0, 7, 448, 11, 288, 11, 1395, 11, 1395, 8, 198, 198, 8818, 5166, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 1441, 4307, 1817, 62, 24874, 3083, 7, 67, 11, 27179, 1758, 7, 87, 11, 1058, 11, 352, 1776, 5391, 82, 28, 16, 8, 198, 437, 198, 198, 8818, 5166, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 90, 27, 25, 15633, 5512, 331, 3712, 23839, 38469, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 1441, 4307, 1817, 62, 24874, 3083, 7, 67, 11, 27179, 1758, 7, 87, 11, 1058, 11, 352, 828, 27179, 1758, 7, 88, 11, 1058, 11, 352, 1776, 5391, 82, 28, 16, 8, 198, 437, 198, 198, 8818, 5166, 3083, 0, 7, 448, 3712, 23839, 46912, 11, 288, 3712, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 90, 27, 25, 15633, 30072, 198, 220, 220, 220, 1441, 4307, 1817, 13, 24874, 3083, 0, 7, 448, 11, 288, 11, 27179, 1758, 7, 87, 11, 1058, 11, 352, 1776, 5391, 82, 28, 16, 8, 198, 437, 198, 198, 8818, 5166, 3083, 0, 7, 198, 220, 220, 220, 503, 3712, 23839, 46912, 11, 288, 3712, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 90, 27, 25, 15633, 5512, 331, 3712, 23839, 38469, 90, 27, 25, 15633, 92, 198, 8, 198, 220, 220, 220, 1441, 4307, 1817, 13, 24874, 3083, 0, 7, 448, 11, 288, 11, 27179, 1758, 7, 87, 11, 1058, 11, 352, 828, 27179, 1758, 7, 88, 11, 1058, 11, 352, 1776, 5391, 82, 28, 16, 8, 198, 437, 198, 198, 2, 4418, 15738, 262, 951, 3083, 2446, 329, 12531, 303, 5217, 198, 198, 8818, 951, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 8, 198, 220, 220, 220, 1441, 1976, 27498, 7, 20344, 1817, 13, 20274, 62, 4906, 7, 67, 11, 2124, 11, 2124, 828, 4129, 7, 87, 4008, 1303, 48951, 1201, 288, 7, 87, 11, 87, 8, 6624, 657, 416, 6770, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 5216, 53, 721, 82, 8, 198, 220, 220, 220, 1441, 1976, 27498, 7, 20344, 1817, 13, 20274, 62, 4906, 7, 67, 11, 2124, 13, 55, 11, 2124, 13, 55, 828, 4129, 7, 87, 4008, 1303, 48951, 1201, 288, 7, 87, 11, 87, 8, 6624, 657, 416, 6770, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 25166, 53, 721, 82, 8, 198, 220, 220, 220, 1441, 1976, 27498, 7, 20344, 1817, 13, 20274, 62, 4906, 7, 67, 11, 2124, 13, 55, 11, 2124, 13, 55, 828, 4129, 7, 87, 4008, 1303, 48951, 1201, 288, 7, 87, 11, 87, 8, 6624, 657, 416, 6770, 198, 437, 198, 198, 2235, 383, 1708, 318, 257, 8156, 329, 22875, 15667, 290, 16978, 284, 991, 670, 198, 8818, 951, 3083, 7, 67, 3712, 20344, 1817, 13, 38176, 6719, 9171, 1173, 11, 2124, 3712, 5216, 53, 721, 82, 8, 198, 220, 220, 220, 1441, 4307, 1817, 13, 4033, 3083, 7, 67, 11, 2124, 13, 55, 11, 2124, 13, 55, 8, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 20344, 1817, 13, 38176, 6719, 9171, 1173, 11, 2124, 3712, 25166, 53, 721, 82, 8, 198, 220, 220, 220, 1441, 4307, 1817, 13, 4033, 3083, 7, 67, 11, 2124, 13, 55, 3256, 2124, 13, 55, 11537, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 20344, 1817, 13, 38176, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 8, 198, 220, 220, 220, 1441, 3975, 7, 67, 11, 2124, 11, 2124, 8, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 5216, 53, 721, 82, 11, 331, 3712, 5216, 53, 721, 82, 8, 198, 220, 220, 220, 1441, 4307, 1817, 13, 4033, 3083, 7, 67, 11, 2124, 13, 55, 11, 331, 13, 55, 8, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 25166, 53, 721, 82, 11, 331, 3712, 25166, 53, 721, 82, 8, 198, 220, 220, 220, 1441, 4307, 1817, 13, 4033, 3083, 7, 67, 11, 2124, 13, 55, 3256, 331, 13, 55, 11537, 198, 437, 198, 198, 8818, 951, 3083, 7, 67, 3712, 6719, 9171, 1173, 11, 2124, 3712, 23839, 38469, 11, 331, 3712, 23839, 38469, 8, 198, 220, 220, 220, 1441, 3975, 7, 67, 11, 2124, 11, 331, 8, 198, 437, 198 ]
2.569845
902
function listFunctions(_module::Module) _names = names(_module; all=true) _functions = Function[] for _name in _names _function = getfield(_module, _name) if ( typeof(_function) <: Function && !occursin("#",string(_name)) && !(string(_function) in ["eval","include"]) ) push!(_functions, _function) end end _functions end function listMethods(_module::Module) _functions = listFunctions(_module) _methods = Method[] for _f in _functions _methodList = methods(_f) push!(_methods,_methodList.ms...) end _methods end function createDefaultArguments(method) @info "Create default arguments for method[$(method.name)]" sig = try collect(method.sig.types) catch e @warn e return nothing end popfirst!(sig) argsAsVector = [] for _type in sig arg = try createDefaultObject(getNonMissingTypeOfUnionType(_type)) catch e @warn e return nothing end push!(argsAsVector, arg) end argsAsVector end function createDefaultObject(_type::DataType) if _type <: Number return _type(0) end if _type <: String return "lorem ipsum" end if _type <: Date return today() end if _type <: Enum return first(instances(_type)) end return _type() end function createDefaultObject(::Type{Dict}) return Dict() end function invokeMethod(_function::Function, args::Vector, procID::Int64) argsTypesForPrinting = join(string.(typeof.(args)),", ") @info "# Invoke $(_function)($argsTypesForPrinting) on procID[$procID]" try future = @spawnat procID _function(args...) catch e # try-catch on the @spawnat is not enough because Exceptions on remote # computations are captured and rethrown locally. Therefore the calling # method needs to try-catch the call to this function. # see https://docs.julialang.org/en/v1/stdlib/Distributed/index.html#Distributed.RemoteException error(e) end end function invokeMethod(_method::Method, args::Vector, procID::Int64) fct = getfield(_method.module, _method.name) invokeMethod(fct, args, procID) end function invokeMethodOnAllProcs(_method::Method) args = createDefaultArguments(_method) if isnothing(args) @warn "Unable to create default arugments => Skip method[$(_method)]" return end for procID in 1:nprocs() try invokeMethod(_method, args, procID) # try-catch on the @spawnat is not enough because Exceptions on remote # computations are captured and rethrown locally # see https://docs.julialang.org/en/v1/stdlib/Distributed/index.html#Distributed.RemoteException catch e @debug "RemoteException was caught so that we can carry on." end end end function invokeMethodsOfModule(_module::Module ;excludeMethods::Vector{Symbol} = Symbol[]) methods = listMethods(_module) filter!(x-> !(x.name in excludeMethods),methods) for m in methods invokeMethodOnAllProcs(m) end end # This method exists so that we can call it even without having to test if the # argument is a Union function getNonMissingTypeOfUnionType(arg::Any) return arg end # NOTE: We cannot say that this method returns a DataType (::DataType) because # arrays are not datatypes function getNonMissingTypeOfUnionType(arg::Union) if arg.a != Missing return arg.a else return arg.b end end
[ 8818, 1351, 24629, 2733, 28264, 21412, 3712, 26796, 8, 198, 220, 220, 220, 4808, 14933, 796, 3891, 28264, 21412, 26, 477, 28, 7942, 8, 628, 220, 220, 220, 4808, 12543, 2733, 796, 15553, 21737, 198, 220, 220, 220, 329, 4808, 3672, 287, 4808, 14933, 198, 220, 220, 220, 220, 220, 220, 220, 4808, 8818, 796, 651, 3245, 28264, 21412, 11, 4808, 3672, 8, 198, 220, 220, 220, 220, 220, 220, 220, 611, 357, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2099, 1659, 28264, 8818, 8, 1279, 25, 15553, 198, 220, 220, 220, 220, 220, 220, 220, 220, 11405, 5145, 13966, 1834, 259, 7203, 2, 1600, 8841, 28264, 3672, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 220, 11405, 5145, 7, 8841, 28264, 8818, 8, 287, 14631, 18206, 2430, 17256, 8973, 8, 198, 220, 220, 220, 220, 220, 220, 220, 220, 1267, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 28264, 12543, 2733, 11, 4808, 8818, 8, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 628, 220, 220, 220, 4808, 12543, 2733, 198, 437, 628, 198, 198, 8818, 1351, 46202, 28264, 21412, 3712, 26796, 8, 198, 220, 220, 220, 4808, 12543, 2733, 796, 1351, 24629, 2733, 28264, 21412, 8, 198, 220, 220, 220, 4808, 24396, 82, 796, 11789, 21737, 198, 220, 220, 220, 329, 4808, 69, 287, 4808, 12543, 2733, 198, 220, 220, 220, 220, 220, 220, 220, 4808, 24396, 8053, 796, 5050, 28264, 69, 8, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 28264, 24396, 82, 11, 62, 24396, 8053, 13, 907, 23029, 198, 220, 220, 220, 886, 198, 220, 220, 220, 4808, 24396, 82, 198, 437, 198, 198, 8818, 2251, 19463, 28100, 2886, 7, 24396, 8, 198, 220, 220, 220, 2488, 10951, 366, 16447, 4277, 7159, 329, 2446, 58, 3, 7, 24396, 13, 3672, 15437, 1, 198, 220, 220, 220, 43237, 796, 1949, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2824, 7, 24396, 13, 82, 328, 13, 19199, 8, 198, 220, 220, 220, 220, 220, 220, 220, 4929, 304, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 40539, 304, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 2147, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 1461, 11085, 0, 7, 82, 328, 8, 628, 220, 220, 220, 26498, 1722, 38469, 796, 17635, 198, 220, 220, 220, 329, 4808, 4906, 287, 43237, 198, 220, 220, 220, 220, 220, 220, 220, 1822, 796, 1949, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2251, 19463, 10267, 7, 1136, 15419, 43730, 6030, 5189, 38176, 6030, 28264, 4906, 4008, 198, 220, 220, 220, 220, 220, 220, 220, 4929, 304, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 40539, 304, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1441, 2147, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 22046, 1722, 38469, 11, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1822, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 26498, 1722, 38469, 198, 437, 198, 198, 8818, 2251, 19463, 10267, 28264, 4906, 3712, 6601, 6030, 8, 628, 220, 220, 220, 611, 4808, 4906, 1279, 25, 7913, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 4808, 4906, 7, 15, 8, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 4808, 4906, 1279, 25, 10903, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 366, 75, 29625, 220, 2419, 388, 1, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 4808, 4906, 1279, 25, 7536, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 1909, 3419, 198, 220, 220, 220, 886, 198, 220, 220, 220, 611, 4808, 4906, 1279, 25, 2039, 388, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 717, 7, 8625, 1817, 28264, 4906, 4008, 198, 220, 220, 220, 886, 628, 220, 220, 220, 1441, 4808, 4906, 3419, 198, 437, 198, 198, 8818, 2251, 19463, 10267, 7, 3712, 6030, 90, 35, 713, 30072, 198, 220, 220, 220, 1441, 360, 713, 3419, 198, 437, 198, 198, 8818, 26342, 17410, 28264, 8818, 3712, 22203, 11, 26498, 3712, 38469, 11, 13834, 2389, 3712, 5317, 2414, 8, 628, 220, 220, 220, 26498, 31431, 1890, 18557, 278, 796, 4654, 7, 8841, 12195, 4906, 1659, 12195, 22046, 4008, 553, 11, 366, 8, 198, 220, 220, 220, 2488, 10951, 25113, 10001, 2088, 720, 28264, 8818, 5769, 3, 22046, 31431, 1890, 18557, 278, 8, 319, 13834, 2389, 58, 3, 36942, 2389, 30866, 628, 220, 220, 220, 1949, 198, 220, 220, 220, 220, 220, 220, 220, 2003, 796, 2488, 48183, 265, 13834, 2389, 4808, 8818, 7, 22046, 23029, 198, 220, 220, 220, 4929, 304, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 1949, 12, 40198, 319, 262, 2488, 48183, 265, 318, 407, 1576, 780, 1475, 11755, 319, 6569, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 2653, 602, 389, 7907, 290, 302, 400, 2053, 15726, 13, 8447, 262, 4585, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 2446, 2476, 284, 1949, 12, 40198, 262, 869, 284, 428, 2163, 13, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 766, 3740, 1378, 31628, 13, 73, 377, 498, 648, 13, 2398, 14, 268, 14, 85, 16, 14, 19282, 8019, 14, 20344, 6169, 14, 9630, 13, 6494, 2, 20344, 6169, 13, 36510, 16922, 198, 220, 220, 220, 220, 220, 220, 220, 4049, 7, 68, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 26342, 17410, 28264, 24396, 3712, 17410, 11, 26498, 3712, 38469, 11, 13834, 2389, 3712, 5317, 2414, 8, 198, 220, 220, 220, 277, 310, 796, 651, 3245, 28264, 24396, 13, 21412, 11, 4808, 24396, 13, 3672, 8, 198, 220, 220, 220, 26342, 17410, 7, 69, 310, 11, 26498, 11, 13834, 2389, 8, 198, 437, 198, 198, 8818, 26342, 17410, 2202, 3237, 2964, 6359, 28264, 24396, 3712, 17410, 8, 198, 220, 220, 220, 26498, 796, 2251, 19463, 28100, 2886, 28264, 24396, 8, 198, 220, 220, 220, 611, 318, 22366, 7, 22046, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 40539, 366, 3118, 540, 284, 2251, 4277, 610, 1018, 902, 5218, 32214, 2446, 58, 3, 28264, 24396, 15437, 1, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 198, 220, 220, 220, 886, 198, 220, 220, 220, 329, 13834, 2389, 287, 352, 25, 77, 1676, 6359, 3419, 198, 220, 220, 220, 220, 220, 220, 220, 1949, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 26342, 17410, 28264, 24396, 11, 26498, 11, 13834, 2389, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 1949, 12, 40198, 319, 262, 2488, 48183, 265, 318, 407, 1576, 780, 1475, 11755, 319, 6569, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 220, 220, 2653, 602, 389, 7907, 290, 302, 400, 2053, 15726, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 766, 3740, 1378, 31628, 13, 73, 377, 498, 648, 13, 2398, 14, 268, 14, 85, 16, 14, 19282, 8019, 14, 20344, 6169, 14, 9630, 13, 6494, 2, 20344, 6169, 13, 36510, 16922, 198, 220, 220, 220, 220, 220, 220, 220, 4929, 304, 198, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2488, 24442, 366, 36510, 16922, 373, 4978, 523, 326, 356, 460, 3283, 319, 526, 198, 220, 220, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 26342, 46202, 5189, 26796, 28264, 21412, 3712, 26796, 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, 2162, 1069, 9152, 46202, 3712, 38469, 90, 13940, 23650, 92, 796, 38357, 58, 12962, 628, 220, 220, 220, 5050, 796, 1351, 46202, 28264, 21412, 8, 198, 220, 220, 220, 8106, 0, 7, 87, 3784, 5145, 7, 87, 13, 3672, 287, 19607, 46202, 828, 24396, 82, 8, 628, 220, 220, 220, 329, 285, 287, 5050, 198, 220, 220, 220, 220, 220, 220, 220, 26342, 17410, 2202, 3237, 2964, 6359, 7, 76, 8, 198, 220, 220, 220, 886, 198, 437, 628, 198, 2, 770, 2446, 7160, 523, 326, 356, 460, 869, 340, 772, 1231, 1719, 284, 1332, 611, 262, 198, 2, 220, 220, 4578, 318, 257, 4479, 198, 8818, 651, 15419, 43730, 6030, 5189, 38176, 6030, 7, 853, 3712, 7149, 8, 198, 220, 220, 220, 1441, 1822, 198, 437, 198, 198, 2, 24550, 25, 775, 2314, 910, 326, 428, 2446, 5860, 257, 6060, 6030, 357, 3712, 6601, 6030, 8, 780, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 26515, 389, 407, 4818, 265, 9497, 198, 8818, 651, 15419, 43730, 6030, 5189, 38176, 6030, 7, 853, 3712, 38176, 8, 198, 220, 220, 220, 611, 1822, 13, 64, 14512, 25639, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 1822, 13, 64, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 1441, 1822, 13, 65, 198, 220, 220, 220, 886, 198, 437, 198 ]
2.429504
1,532
struct IPSReactionIR pairwise :: Bool input1 :: Int # center input2 :: Int # adjacent output1 :: Int # center output2 :: Int # adjacent label :: Int # reaction index p_index :: Int # parameter index end function Base.show(io::IO, x::IPSReactionIR) i1, i2 = x.input1, x.input2 o1, o2 = x.output1, x.output2 if x.pairwise str = "$(i1) + $(i2) --> $(o1) + $(o2)" else str = "$(i1) --> $(o1)" end print(io, str) end ##### helper functions ##### function clean_expression(input_ex) ex = Expr(input_ex.head) for line in input_ex.args if line isa Expr && line.head == :tuple && length(line.args) == 2 # change 0 to :∅ to make it its own "type" clean_line = postwalk(x -> x isa Integer && x == 0 ? :∅ : x, line) # add the new line push!(ex.args, clean_line) end end # add checks to make sure each formula is well-formed return ex end # catch-all for symbols and constants function add_tokens!(tokens, sym) push!(tokens, sym) end # search through an Expr function add_tokens!(tokens, ex::Expr) for token in ex.args if isa(token, Symbol) push!(tokens, token) end end return tokens end # build a Dictionary that maps a particle type to an index function build_species_dict(ex) open_site = :∅ tokens = Symbol[] for line in ex.args formula = line.args[1] input = formula.args[1] output = formula.args[2] add_tokens!(tokens, input) add_tokens!(tokens, output) end tokens = unique(tokens) filter!(x -> (x != :+), tokens) filter!(x -> (x != :*), tokens) filter!(x -> (x != open_site), tokens) sort!(tokens) tokens = [open_site; tokens] return OrderedDict{Symbol,Int}(tokens[i] => i for i in eachindex(tokens)) end # catch-all for non-pairwise events function get_species_types(sym, dict) x = dict[sym] y = 0 return x, y end # for pairwise events function get_species_types(ex::Expr, dict) x_sym = ex.args[2] y_sym = ex.args[3] x = dict[x_sym] y = dict[y_sym] return x, y end # build a Dictionary that maps a parameter symbol to an index function build_parameters_dict(p) parameters = OrderedDict{Symbol,Int}() p_count = 0 for parameter in p if !haskey(parameters,parameter) p_count += 1 parameters[parameter] = p_count end end return parameters end # build a list of internal IPSReactionIR objects from input function encode_reaction_struct(ex::Expr, species_dict, params_dict) reactions = IPSReactionIR[] for j in eachindex(ex.args) line = ex.args[j] formula = line.args[1] parameter = line.args[2] input = formula.args[1] output = formula.args[2] is_pairwise = isa(input, Expr) # if not, then the argument is a symbol or constant type1, type2 = get_species_types(input, species_dict) type3, type4 = get_species_types(output, species_dict) reaction = IPSReactionIR(is_pairwise, type1, type2, type3, type4, j, params_dict[parameter]) push!(reactions, reaction) end return reactions end ## define a reaction set from user input macro def_reactions(inputex::Expr, p...) __def_reactions(inputex, p) end ## define a reaction set from a programatically generated list macro def_reactions(inputex::Symbol, p...) escex = esc(inputex) quote __def_reactions($escex, $p) end end # implements the body of the @def_reactions macro function __def_reactions(inputex, p) # sweep through the user's code block to clean it up # e.g. strip away the annoying line numbers that get folded in ex = clean_expression(inputex) # sweep through the user's code block to pick up # all the unique species and map them to an index species_dict = build_species_dict(ex) params_dict = build_parameters_dict(p) # translate the user's model to some intermediate representation reactions = encode_reaction_struct(ex, species_dict, params_dict) # the macro needs to return an expression # which builds a IPSReactionIR array return :($reactions) end ## enumerate the full reaction list using a given spatial structure # macro enumerate_with_nclass(r, n, d, p) # escr = esc(r) # escn = esc(n) # escd = esc(d) # escp = esc(p) # quote # __reactions_nclass($escr, $escn, $escd, $escp) # end # end # implements the body of @enumerate_with_nclass # function __reactions_nclass(initial, nbhood, d, params) # nbhood ∉ NBTYPES && error("unsupported neighborhood structure") # d > 3 && error("do you really need $(d) dimensions?") # # # determine number of particle types # L = 0 # # for reaction in initial # L = max(L, reaction.input1, reaction.input2, reaction.output1, reaction.output2) # end # # # determine maximum number of neighbors # nbmax = capacity(nbhood, d) # # # compositions = collect(multiexponents(L + 1, 2 * d)) # compositions = collect(multiexponents(L, nbmax)) # number_compositions = length(compositions) # # reactions = IPSReactionStruct[] # # for reaction in initial # for class in 1:number_compositions # # class is the integer corresponding to each composition # composition = compositions[class] # # # check for pairwise reaction # if reaction.pairwise == true # # get the number of reactants in the composition # number_reactants = composition[reaction.input2] # # # ignore this class-reaction pair if there are no suitable # # reactants in the given configuration # if number_reactants != 0 # rate = params[reaction.p_index] # # push!(reactions, IPSReactionStruct( # reaction.pairwise, # reaction.input1, # reaction.input2, # reaction.output1, # reaction.output2, # class, # neighborhood class # number_reactants * rate # local rate # ) ) # end # else # rate = params[reaction.p_index] # # push!(reactions, IPSReactionStruct( # reaction.pairwise, # reaction.input1, # reaction.input2, # reaction.output1, # reaction.output2, # class, # neighborhood class # rate / number_compositions # scaled local rate # ) ) # end # end # end # # return reactions # end ## enumerate the full reaction list using a given spatial structure macro enumerate_with_sclass(r, n, d, p) escr = esc(r) escn = esc(n) escd = esc(d) escp = esc(p) quote __reactions_sclass($escr, $escn, $escd, $escp) end end # implements the body of the @enumerate_with_sclass macro function __reactions_sclass(initial, nbhood, d, params) nbhood ∉ NBTYPES && error("unsupported neighborhood structure") d > 3 && error("do you really need $(d) dimensions?") # determine number of particle types number_types = 0 for rxn in initial number_types = max( number_types, rxn.input1, rxn.input2, rxn.output1, rxn.output2 ) end number_types -= 1 # determine maximum number of neighbors number_neighbors = capacity(nbhood, d) pairs = build_reactant_pairs(initial) isactive = build_active_set(pairs, number_types) reactant_to_class = map_reactant_to_class(pairs, number_neighbors) reactions = IPSReactionStruct[] for reaction in initial reactant_pair = (reaction.input1, reaction.input2) sampleidx = reactant_to_class[reactant_pair] if reaction.pairwise == true # iterate over the possible number of adjacent reactants for number_reactants in 1:number_neighbors rate = params[reaction.p_index] push!(reactions, IPSReactionStruct( reaction.pairwise, reaction.input1, reaction.input2, reaction.output1, reaction.output2, # need to shift index based on dimension sampleidx + number_reactants - 1, # total rate at which a particle in this class undergoes this reaction number_reactants * rate) ) end else # don't care about neighborhood composition here for the rate or the class, so we explicitly ignore it # meaning we don't need to change anything about the reaction vector rate = params[reaction.p_index] push!(reactions, IPSReactionStruct( reaction.pairwise, reaction.input1, reaction.input2, reaction.output1, reaction.output2, sampleidx, rate # total rate at which a particle in this class undergoes this reaction ) ) end end # enumerate the possible neighborhood compositions composition = collect(Vector{Int}, multiexponents(number_types + 1, number_neighbors)) # build a mapping from (l,k) to sample classes s pair_to_classes = map_pair_to_classes(composition, reactant_to_class, isactive, number_types) # group everything from our sample class enumeration enumeration = SampleClassEnumeration{d,typeof(nbhood)}(composition, pairs, reactant_to_class, pair_to_classes, isactive) return InteractingParticleSystem(reactions, isactive, enumeration) end
[ 7249, 37632, 3041, 2673, 4663, 198, 220, 5166, 3083, 220, 220, 7904, 347, 970, 198, 220, 5128, 16, 220, 220, 220, 220, 7904, 2558, 1303, 3641, 198, 220, 5128, 17, 220, 220, 220, 220, 7904, 2558, 1303, 15909, 198, 220, 5072, 16, 220, 220, 220, 7904, 2558, 1303, 3641, 198, 220, 5072, 17, 220, 220, 220, 7904, 2558, 1303, 15909, 198, 220, 6167, 220, 220, 220, 220, 220, 7904, 2558, 1303, 6317, 6376, 198, 220, 279, 62, 9630, 220, 220, 220, 7904, 2558, 1303, 11507, 6376, 198, 437, 198, 198, 8818, 7308, 13, 12860, 7, 952, 3712, 9399, 11, 2124, 3712, 47643, 3041, 2673, 4663, 8, 198, 220, 1312, 16, 11, 1312, 17, 796, 2124, 13, 15414, 16, 11, 2124, 13, 15414, 17, 198, 220, 267, 16, 11, 267, 17, 796, 2124, 13, 22915, 16, 11, 2124, 13, 22915, 17, 628, 220, 611, 2124, 13, 24874, 3083, 198, 220, 220, 220, 965, 796, 17971, 7, 72, 16, 8, 1343, 29568, 72, 17, 8, 14610, 29568, 78, 16, 8, 1343, 29568, 78, 17, 16725, 198, 220, 2073, 198, 220, 220, 220, 965, 796, 17971, 7, 72, 16, 8, 14610, 29568, 78, 16, 16725, 198, 220, 886, 628, 220, 3601, 7, 952, 11, 965, 8, 198, 437, 198, 198, 4242, 2, 31904, 5499, 46424, 198, 8818, 3424, 62, 38011, 7, 15414, 62, 1069, 8, 198, 220, 409, 796, 1475, 1050, 7, 15414, 62, 1069, 13, 2256, 8, 628, 220, 329, 1627, 287, 5128, 62, 1069, 13, 22046, 198, 220, 220, 220, 611, 1627, 318, 64, 1475, 1050, 11405, 1627, 13, 2256, 6624, 1058, 83, 29291, 11405, 4129, 7, 1370, 13, 22046, 8, 6624, 362, 198, 220, 220, 220, 220, 220, 1303, 1487, 657, 284, 1058, 24861, 227, 284, 787, 340, 663, 898, 366, 4906, 1, 198, 220, 220, 220, 220, 220, 3424, 62, 1370, 796, 1281, 11152, 7, 87, 4613, 2124, 318, 64, 34142, 11405, 2124, 6624, 657, 5633, 1058, 24861, 227, 1058, 2124, 11, 1627, 8, 628, 220, 220, 220, 220, 220, 1303, 751, 262, 649, 1627, 198, 220, 220, 220, 220, 220, 4574, 0, 7, 1069, 13, 22046, 11, 3424, 62, 1370, 8, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 1303, 751, 8794, 284, 787, 1654, 1123, 10451, 318, 880, 12, 12214, 628, 220, 1441, 409, 198, 437, 198, 198, 2, 4929, 12, 439, 329, 14354, 290, 38491, 198, 8818, 751, 62, 83, 482, 641, 0, 7, 83, 482, 641, 11, 5659, 8, 198, 220, 4574, 0, 7, 83, 482, 641, 11, 5659, 8, 198, 437, 198, 198, 2, 2989, 832, 281, 1475, 1050, 198, 8818, 751, 62, 83, 482, 641, 0, 7, 83, 482, 641, 11, 409, 3712, 3109, 1050, 8, 198, 220, 329, 11241, 287, 409, 13, 22046, 198, 220, 220, 220, 611, 318, 64, 7, 30001, 11, 38357, 8, 198, 220, 220, 220, 220, 220, 4574, 0, 7, 83, 482, 641, 11, 11241, 8, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 1441, 16326, 198, 437, 198, 198, 2, 1382, 257, 28261, 326, 8739, 257, 18758, 2099, 284, 281, 6376, 198, 8818, 1382, 62, 35448, 62, 11600, 7, 1069, 8, 198, 220, 1280, 62, 15654, 796, 1058, 24861, 227, 198, 220, 16326, 796, 38357, 21737, 628, 220, 329, 1627, 287, 409, 13, 22046, 198, 220, 220, 220, 10451, 796, 1627, 13, 22046, 58, 16, 60, 628, 220, 220, 220, 5128, 220, 796, 10451, 13, 22046, 58, 16, 60, 198, 220, 220, 220, 5072, 796, 10451, 13, 22046, 58, 17, 60, 628, 220, 220, 220, 751, 62, 83, 482, 641, 0, 7, 83, 482, 641, 11, 5128, 8, 198, 220, 220, 220, 751, 62, 83, 482, 641, 0, 7, 83, 482, 641, 11, 5072, 8, 198, 220, 886, 628, 220, 16326, 796, 3748, 7, 83, 482, 641, 8, 628, 220, 8106, 0, 7, 87, 4613, 357, 87, 14512, 1058, 10, 828, 16326, 8, 198, 220, 8106, 0, 7, 87, 4613, 357, 87, 14512, 1058, 9, 828, 16326, 8, 198, 220, 8106, 0, 7, 87, 4613, 357, 87, 14512, 1280, 62, 15654, 828, 16326, 8, 628, 220, 3297, 0, 7, 83, 482, 641, 8, 198, 220, 16326, 796, 685, 9654, 62, 15654, 26, 16326, 60, 628, 220, 1441, 14230, 1068, 35, 713, 90, 13940, 23650, 11, 5317, 92, 7, 83, 482, 641, 58, 72, 60, 5218, 1312, 329, 1312, 287, 1123, 9630, 7, 83, 482, 641, 4008, 198, 437, 198, 198, 2, 4929, 12, 439, 329, 1729, 12, 24874, 3083, 2995, 198, 8818, 651, 62, 35448, 62, 19199, 7, 37047, 11, 8633, 8, 198, 220, 2124, 796, 8633, 58, 37047, 60, 198, 220, 331, 796, 657, 628, 220, 1441, 2124, 11, 331, 198, 437, 198, 198, 2, 329, 5166, 3083, 2995, 198, 8818, 651, 62, 35448, 62, 19199, 7, 1069, 3712, 3109, 1050, 11, 8633, 8, 198, 220, 2124, 62, 37047, 796, 409, 13, 22046, 58, 17, 60, 198, 220, 331, 62, 37047, 796, 409, 13, 22046, 58, 18, 60, 628, 220, 2124, 796, 8633, 58, 87, 62, 37047, 60, 198, 220, 331, 796, 8633, 58, 88, 62, 37047, 60, 628, 220, 1441, 2124, 11, 331, 198, 437, 198, 198, 2, 1382, 257, 28261, 326, 8739, 257, 11507, 6194, 284, 281, 6376, 198, 8818, 1382, 62, 17143, 7307, 62, 11600, 7, 79, 8, 198, 220, 10007, 796, 14230, 1068, 35, 713, 90, 13940, 23650, 11, 5317, 92, 3419, 198, 220, 279, 62, 9127, 796, 657, 198, 220, 329, 11507, 287, 279, 198, 220, 220, 220, 220, 220, 611, 5145, 10134, 2539, 7, 17143, 7307, 11, 17143, 2357, 8, 198, 220, 220, 220, 220, 220, 220, 220, 279, 62, 9127, 15853, 352, 198, 220, 220, 220, 220, 220, 220, 220, 10007, 58, 17143, 2357, 60, 796, 279, 62, 9127, 198, 220, 220, 220, 220, 220, 886, 198, 220, 886, 628, 220, 1441, 10007, 198, 437, 198, 198, 2, 1382, 257, 1351, 286, 5387, 37632, 3041, 2673, 4663, 5563, 422, 5128, 198, 8818, 37773, 62, 260, 2673, 62, 7249, 7, 1069, 3712, 3109, 1050, 11, 4693, 62, 11600, 11, 42287, 62, 11600, 8, 198, 220, 12737, 796, 37632, 3041, 2673, 4663, 21737, 628, 220, 329, 474, 287, 1123, 9630, 7, 1069, 13, 22046, 8, 198, 220, 220, 220, 1627, 796, 409, 13, 22046, 58, 73, 60, 628, 220, 220, 220, 10451, 220, 220, 796, 1627, 13, 22046, 58, 16, 60, 198, 220, 220, 220, 11507, 796, 1627, 13, 22046, 58, 17, 60, 628, 220, 220, 220, 5128, 220, 796, 10451, 13, 22046, 58, 16, 60, 198, 220, 220, 220, 5072, 796, 10451, 13, 22046, 58, 17, 60, 628, 220, 220, 220, 318, 62, 24874, 3083, 796, 318, 64, 7, 15414, 11, 1475, 1050, 8, 1303, 611, 407, 11, 788, 262, 4578, 318, 257, 6194, 393, 6937, 628, 220, 220, 220, 2099, 16, 11, 2099, 17, 796, 651, 62, 35448, 62, 19199, 7, 15414, 11, 4693, 62, 11600, 8, 198, 220, 220, 220, 2099, 18, 11, 2099, 19, 796, 651, 62, 35448, 62, 19199, 7, 22915, 11, 4693, 62, 11600, 8, 628, 220, 220, 220, 6317, 796, 37632, 3041, 2673, 4663, 7, 271, 62, 24874, 3083, 11, 2099, 16, 11, 2099, 17, 11, 2099, 18, 11, 2099, 19, 11, 474, 11, 42287, 62, 11600, 58, 17143, 2357, 12962, 628, 220, 220, 220, 4574, 0, 7, 260, 4658, 11, 6317, 8, 198, 220, 886, 628, 220, 1441, 12737, 198, 437, 198, 198, 2235, 8160, 257, 6317, 900, 422, 2836, 5128, 198, 20285, 305, 825, 62, 260, 4658, 7, 15414, 1069, 3712, 3109, 1050, 11, 279, 23029, 198, 220, 11593, 4299, 62, 260, 4658, 7, 15414, 1069, 11, 279, 8, 198, 437, 198, 198, 2235, 8160, 257, 6317, 900, 422, 257, 1430, 4142, 7560, 1351, 198, 20285, 305, 825, 62, 260, 4658, 7, 15414, 1069, 3712, 13940, 23650, 11, 279, 23029, 198, 220, 1658, 344, 87, 796, 3671, 7, 15414, 1069, 8, 628, 220, 9577, 198, 220, 220, 220, 11593, 4299, 62, 260, 4658, 16763, 274, 344, 87, 11, 720, 79, 8, 198, 220, 886, 198, 437, 198, 198, 2, 23986, 262, 1767, 286, 262, 2488, 4299, 62, 260, 4658, 15021, 198, 8818, 11593, 4299, 62, 260, 4658, 7, 15414, 1069, 11, 279, 8, 198, 220, 1303, 16085, 832, 262, 2836, 338, 2438, 2512, 284, 3424, 340, 510, 198, 220, 1303, 304, 13, 70, 13, 10283, 1497, 262, 15774, 1627, 3146, 326, 651, 24650, 287, 198, 220, 409, 796, 3424, 62, 38011, 7, 15414, 1069, 8, 628, 220, 1303, 16085, 832, 262, 2836, 338, 2438, 2512, 284, 2298, 510, 198, 220, 1303, 477, 262, 3748, 4693, 290, 3975, 606, 284, 281, 6376, 198, 220, 4693, 62, 11600, 796, 1382, 62, 35448, 62, 11600, 7, 1069, 8, 198, 220, 42287, 62, 11600, 220, 796, 1382, 62, 17143, 7307, 62, 11600, 7, 79, 8, 628, 220, 1303, 15772, 262, 2836, 338, 2746, 284, 617, 19898, 10552, 198, 220, 12737, 796, 37773, 62, 260, 2673, 62, 7249, 7, 1069, 11, 4693, 62, 11600, 11, 42287, 62, 11600, 8, 628, 220, 1303, 262, 15021, 2476, 284, 1441, 281, 5408, 198, 220, 1303, 543, 12188, 257, 37632, 3041, 2673, 4663, 7177, 198, 220, 1441, 1058, 16763, 260, 4658, 8, 198, 437, 198, 198, 2235, 27056, 378, 262, 1336, 6317, 1351, 1262, 257, 1813, 21739, 4645, 198, 2, 15021, 27056, 378, 62, 4480, 62, 77, 4871, 7, 81, 11, 299, 11, 288, 11, 279, 8, 198, 2, 220, 220, 3671, 81, 796, 3671, 7, 81, 8, 198, 2, 220, 220, 3671, 77, 796, 3671, 7, 77, 8, 198, 2, 220, 220, 3671, 67, 796, 3671, 7, 67, 8, 198, 2, 220, 220, 3671, 79, 796, 3671, 7, 79, 8, 198, 2, 220, 220, 9577, 198, 2, 220, 220, 220, 220, 11593, 260, 4658, 62, 77, 4871, 16763, 3798, 81, 11, 720, 3798, 77, 11, 720, 3798, 67, 11, 720, 3798, 79, 8, 198, 2, 220, 220, 886, 198, 2, 886, 198, 198, 2, 23986, 262, 1767, 286, 2488, 268, 6975, 378, 62, 4480, 62, 77, 4871, 198, 2, 2163, 11593, 260, 4658, 62, 77, 4871, 7, 36733, 11, 299, 65, 2894, 11, 288, 11, 42287, 8, 198, 2, 220, 220, 299, 65, 2894, 18872, 231, 41354, 9936, 47, 1546, 11405, 4049, 7203, 403, 15999, 6232, 4645, 4943, 198, 2, 220, 220, 288, 1875, 513, 11405, 4049, 7203, 4598, 345, 1107, 761, 29568, 67, 8, 15225, 1701, 8, 198, 2, 198, 2, 220, 220, 1303, 5004, 1271, 286, 18758, 3858, 198, 2, 220, 220, 406, 796, 657, 198, 2, 198, 2, 220, 220, 329, 6317, 287, 4238, 198, 2, 220, 220, 220, 220, 406, 796, 3509, 7, 43, 11, 6317, 13, 15414, 16, 11, 6317, 13, 15414, 17, 11, 6317, 13, 22915, 16, 11, 6317, 13, 22915, 17, 8, 198, 2, 220, 220, 886, 198, 2, 198, 2, 220, 220, 1303, 5004, 5415, 1271, 286, 12020, 198, 2, 220, 220, 299, 65, 9806, 796, 5339, 7, 46803, 2894, 11, 288, 8, 198, 2, 198, 2, 220, 220, 1303, 33543, 796, 2824, 7, 16680, 494, 42372, 3906, 7, 43, 1343, 352, 11, 362, 1635, 288, 4008, 198, 2, 220, 220, 33543, 796, 2824, 7, 16680, 494, 42372, 3906, 7, 43, 11, 299, 65, 9806, 4008, 198, 2, 220, 220, 1271, 62, 785, 1930, 1756, 796, 4129, 7, 785, 1930, 1756, 8, 198, 2, 198, 2, 220, 220, 12737, 796, 37632, 3041, 2673, 44909, 21737, 198, 2, 198, 2, 220, 220, 329, 6317, 287, 4238, 198, 2, 220, 220, 220, 220, 329, 1398, 287, 352, 25, 17618, 62, 785, 1930, 1756, 198, 2, 220, 220, 220, 220, 220, 220, 1303, 1398, 318, 262, 18253, 11188, 284, 1123, 11742, 198, 2, 220, 220, 220, 220, 220, 220, 11742, 796, 33543, 58, 4871, 60, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 1303, 2198, 329, 5166, 3083, 6317, 198, 2, 220, 220, 220, 220, 220, 220, 611, 6317, 13, 24874, 3083, 6624, 2081, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 651, 262, 1271, 286, 6324, 1187, 287, 262, 11742, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1271, 62, 45018, 1187, 796, 11742, 58, 260, 2673, 13, 15414, 17, 60, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 8856, 428, 1398, 12, 260, 2673, 5166, 611, 612, 389, 645, 11080, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 6324, 1187, 287, 262, 1813, 8398, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 611, 1271, 62, 45018, 1187, 14512, 657, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2494, 796, 42287, 58, 260, 2673, 13, 79, 62, 9630, 60, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 260, 4658, 11, 37632, 3041, 2673, 44909, 7, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 24874, 3083, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 16, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 17, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 16, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 17, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1398, 11, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 6232, 1398, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1271, 62, 45018, 1187, 1635, 2494, 1303, 1957, 2494, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1267, 1267, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 886, 198, 2, 220, 220, 220, 220, 220, 220, 2073, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 2494, 796, 42287, 58, 260, 2673, 13, 79, 62, 9630, 60, 198, 2, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 260, 4658, 11, 37632, 3041, 2673, 44909, 7, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 24874, 3083, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 16, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 17, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 16, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 17, 11, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1398, 11, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 1303, 6232, 1398, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 220, 220, 2494, 1220, 1271, 62, 785, 1930, 1756, 1303, 27464, 1957, 2494, 198, 2, 220, 220, 220, 220, 220, 220, 220, 220, 1267, 1267, 198, 2, 220, 220, 220, 220, 220, 220, 886, 198, 2, 220, 220, 220, 220, 886, 198, 2, 220, 220, 886, 198, 2, 198, 2, 220, 220, 1441, 12737, 198, 2, 886, 198, 198, 2235, 27056, 378, 262, 1336, 6317, 1351, 1262, 257, 1813, 21739, 4645, 198, 20285, 305, 27056, 378, 62, 4480, 62, 82, 4871, 7, 81, 11, 299, 11, 288, 11, 279, 8, 198, 220, 3671, 81, 796, 3671, 7, 81, 8, 198, 220, 3671, 77, 796, 3671, 7, 77, 8, 198, 220, 3671, 67, 796, 3671, 7, 67, 8, 198, 220, 3671, 79, 796, 3671, 7, 79, 8, 198, 220, 9577, 198, 220, 220, 220, 11593, 260, 4658, 62, 82, 4871, 16763, 3798, 81, 11, 720, 3798, 77, 11, 720, 3798, 67, 11, 720, 3798, 79, 8, 198, 220, 886, 198, 437, 198, 198, 2, 23986, 262, 1767, 286, 262, 2488, 268, 6975, 378, 62, 4480, 62, 82, 4871, 15021, 198, 8818, 11593, 260, 4658, 62, 82, 4871, 7, 36733, 11, 299, 65, 2894, 11, 288, 11, 42287, 8, 198, 220, 299, 65, 2894, 18872, 231, 41354, 9936, 47, 1546, 11405, 4049, 7203, 403, 15999, 6232, 4645, 4943, 198, 220, 288, 1875, 513, 11405, 4049, 7203, 4598, 345, 1107, 761, 29568, 67, 8, 15225, 1701, 8, 628, 220, 1303, 5004, 1271, 286, 18758, 3858, 198, 220, 1271, 62, 19199, 796, 657, 628, 220, 329, 374, 87, 77, 287, 4238, 198, 220, 220, 220, 1271, 62, 19199, 796, 3509, 7, 198, 220, 220, 220, 220, 220, 1271, 62, 19199, 11, 198, 220, 220, 220, 220, 220, 374, 87, 77, 13, 15414, 16, 11, 198, 220, 220, 220, 220, 220, 374, 87, 77, 13, 15414, 17, 11, 198, 220, 220, 220, 220, 220, 374, 87, 77, 13, 22915, 16, 11, 198, 220, 220, 220, 220, 220, 374, 87, 77, 13, 22915, 17, 198, 220, 220, 220, 1267, 198, 220, 886, 628, 220, 1271, 62, 19199, 48185, 352, 628, 220, 1303, 5004, 5415, 1271, 286, 12020, 198, 220, 1271, 62, 710, 394, 32289, 796, 5339, 7, 46803, 2894, 11, 288, 8, 628, 220, 14729, 796, 1382, 62, 45018, 415, 62, 79, 3468, 7, 36733, 8, 198, 220, 318, 5275, 796, 1382, 62, 5275, 62, 2617, 7, 79, 3468, 11, 1271, 62, 19199, 8, 198, 220, 6324, 415, 62, 1462, 62, 4871, 796, 3975, 62, 45018, 415, 62, 1462, 62, 4871, 7, 79, 3468, 11, 1271, 62, 710, 394, 32289, 8, 628, 220, 12737, 796, 37632, 3041, 2673, 44909, 21737, 628, 220, 329, 6317, 287, 4238, 198, 220, 220, 220, 6324, 415, 62, 24874, 796, 357, 260, 2673, 13, 15414, 16, 11, 6317, 13, 15414, 17, 8, 198, 220, 220, 220, 6291, 312, 87, 796, 6324, 415, 62, 1462, 62, 4871, 58, 45018, 415, 62, 24874, 60, 628, 220, 220, 220, 611, 6317, 13, 24874, 3083, 6624, 2081, 628, 220, 220, 220, 220, 220, 1303, 11629, 378, 625, 262, 1744, 1271, 286, 15909, 6324, 1187, 198, 220, 220, 220, 220, 220, 329, 1271, 62, 45018, 1187, 287, 352, 25, 17618, 62, 710, 394, 32289, 198, 220, 220, 220, 220, 220, 220, 220, 2494, 796, 42287, 58, 260, 2673, 13, 79, 62, 9630, 60, 628, 220, 220, 220, 220, 220, 220, 220, 4574, 0, 7, 260, 4658, 11, 37632, 3041, 2673, 44909, 7, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 24874, 3083, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 17, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 17, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 761, 284, 6482, 6376, 1912, 319, 15793, 198, 220, 220, 220, 220, 220, 220, 220, 6291, 312, 87, 1343, 1271, 62, 45018, 1187, 532, 352, 11, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 2472, 2494, 379, 543, 257, 18758, 287, 428, 1398, 17777, 274, 428, 6317, 198, 220, 220, 220, 220, 220, 220, 220, 1271, 62, 45018, 1187, 1635, 2494, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1267, 198, 220, 220, 220, 220, 220, 886, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 1303, 836, 470, 1337, 546, 6232, 11742, 994, 329, 262, 2494, 393, 262, 1398, 11, 523, 356, 11777, 8856, 340, 198, 220, 220, 220, 220, 220, 1303, 3616, 356, 836, 470, 761, 284, 1487, 1997, 546, 262, 6317, 15879, 198, 220, 220, 220, 220, 220, 2494, 796, 42287, 58, 260, 2673, 13, 79, 62, 9630, 60, 628, 220, 220, 220, 220, 220, 4574, 0, 7, 260, 4658, 11, 37632, 3041, 2673, 44909, 7, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 24874, 3083, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 15414, 17, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 16, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6317, 13, 22915, 17, 11, 198, 220, 220, 220, 220, 220, 220, 220, 6291, 312, 87, 11, 198, 220, 220, 220, 220, 220, 220, 220, 2494, 1303, 2472, 2494, 379, 543, 257, 18758, 287, 428, 1398, 17777, 274, 428, 6317, 198, 220, 220, 220, 220, 220, 1267, 1267, 198, 220, 220, 220, 886, 198, 220, 886, 628, 220, 1303, 27056, 378, 262, 1744, 6232, 33543, 198, 220, 11742, 796, 2824, 7, 38469, 90, 5317, 5512, 1963, 494, 42372, 3906, 7, 17618, 62, 19199, 1343, 352, 11, 1271, 62, 710, 394, 32289, 4008, 628, 220, 1303, 1382, 257, 16855, 422, 357, 75, 11, 74, 8, 284, 6291, 6097, 264, 198, 220, 5166, 62, 1462, 62, 37724, 796, 3975, 62, 24874, 62, 1462, 62, 37724, 7, 785, 9150, 11, 6324, 415, 62, 1462, 62, 4871, 11, 318, 5275, 11, 1271, 62, 19199, 8, 628, 220, 1303, 1448, 2279, 422, 674, 6291, 1398, 27056, 341, 198, 220, 27056, 341, 796, 27565, 9487, 4834, 6975, 341, 90, 67, 11, 4906, 1659, 7, 46803, 2894, 38165, 7, 785, 9150, 11, 14729, 11, 6324, 415, 62, 1462, 62, 4871, 11, 5166, 62, 1462, 62, 37724, 11, 318, 5275, 8, 628, 220, 1441, 4225, 27362, 7841, 1548, 11964, 7, 260, 4658, 11, 318, 5275, 11, 27056, 341, 8, 198, 437, 198 ]
2.576988
3,546
""" Atomic solution for an PODE. ### Fields * `t`: time of current time step * `t̅`: time of previous time step * `q`: current solution of q * `q̅`: previous solution of q * `q̃`: compensated summation error of q * `p`: current solution of p * `p̅`: previous solution of p * `p̃`: compensated summation error of p * `v`: vector field of q * `v̅`: vector field of q̅ * `f`: vector field of p * `f̅`: vector field of p̅ """ mutable struct AtomicSolutionPODE{DT,TT} <: AtomicSolution{DT,TT} t::TT t̅::TT q::Vector{DT} q̅::Vector{DT} q̃::Vector{DT} p::Vector{DT} p̅::Vector{DT} p̃::Vector{DT} v::Vector{DT} v̅::Vector{DT} f::Vector{DT} f̅::Vector{DT} function AtomicSolutionPODE{DT, TT}(nd) where {DT <: Number, TT <: Real} new(zero(TT), zero(TT), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd), zeros(DT, nd)) end end AtomicSolutionPODE(DT, TT, nd) = AtomicSolutionPODE{DT, TT}(nd) function set_solution!(asol::AtomicSolutionPODE, sol) t, q, p = sol asol.t = t asol.q .= q asol.p .= p asol.v .= 0 asol.f .= 0 end function get_solution(asol::AtomicSolutionPODE) (asol.t, asol.q, asol.p) end function CommonFunctions.reset!(asol::AtomicSolutionPODE, Δt) asol.t̅ = asol.t asol.q̅ .= asol.q asol.p̅ .= asol.p asol.v̅ .= asol.v asol.f̅ .= asol.f asol.t += Δt end function update!(asol::AtomicSolutionPODE{DT}, y::Vector{DT}, z::Vector{DT}) where {DT} for k in eachindex(y,z) update!(asol, y[k], z[k], k) end end function update!(asol::AtomicSolutionPODE{DT}, y::DT, z::DT, k::Int) where {DT} asol.q[k], asol.q̃[k] = compensated_summation(y, asol.q[k], asol.q̃[k]) asol.p[k], asol.p̃[k] = compensated_summation(z, asol.p[k], asol.p̃[k]) end
[ 37811, 198, 2953, 10179, 4610, 329, 281, 350, 16820, 13, 198, 198, 21017, 23948, 198, 198, 9, 4600, 83, 63, 25, 640, 286, 1459, 640, 2239, 198, 9, 4600, 83, 136, 227, 63, 25, 640, 286, 2180, 640, 2239, 198, 9, 4600, 80, 63, 25, 1459, 4610, 286, 10662, 198, 9, 4600, 80, 136, 227, 63, 25, 2180, 4610, 286, 10662, 198, 9, 4600, 80, 136, 225, 63, 25, 34304, 30114, 341, 4049, 286, 10662, 198, 9, 4600, 79, 63, 25, 1459, 4610, 286, 279, 198, 9, 4600, 79, 136, 227, 63, 25, 2180, 4610, 286, 279, 198, 9, 4600, 79, 136, 225, 63, 25, 34304, 30114, 341, 4049, 286, 279, 198, 9, 4600, 85, 63, 25, 15879, 2214, 286, 10662, 198, 9, 4600, 85, 136, 227, 63, 25, 15879, 2214, 286, 10662, 136, 227, 198, 9, 4600, 69, 63, 25, 15879, 2214, 286, 279, 198, 9, 4600, 69, 136, 227, 63, 25, 15879, 2214, 286, 279, 136, 227, 198, 37811, 198, 76, 18187, 2878, 28976, 46344, 47, 16820, 90, 24544, 11, 15751, 92, 1279, 25, 28976, 46344, 90, 24544, 11, 15751, 92, 198, 220, 220, 220, 256, 3712, 15751, 198, 220, 220, 220, 256, 136, 227, 3712, 15751, 628, 220, 220, 220, 10662, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 10662, 136, 227, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 10662, 136, 225, 3712, 38469, 90, 24544, 92, 628, 220, 220, 220, 279, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 279, 136, 227, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 279, 136, 225, 3712, 38469, 90, 24544, 92, 628, 220, 220, 220, 410, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 410, 136, 227, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 277, 3712, 38469, 90, 24544, 92, 198, 220, 220, 220, 277, 136, 227, 3712, 38469, 90, 24544, 92, 628, 220, 220, 220, 2163, 28976, 46344, 47, 16820, 90, 24544, 11, 26653, 92, 7, 358, 8, 810, 1391, 24544, 1279, 25, 7913, 11, 26653, 1279, 25, 6416, 92, 198, 220, 220, 220, 220, 220, 220, 220, 649, 7, 22570, 7, 15751, 828, 6632, 7, 15751, 828, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 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, 220, 220, 220, 220, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 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, 220, 220, 220, 220, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 828, 1976, 27498, 7, 24544, 11, 299, 67, 4008, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2953, 10179, 46344, 47, 16820, 7, 24544, 11, 26653, 11, 299, 67, 8, 796, 28976, 46344, 47, 16820, 90, 24544, 11, 26653, 92, 7, 358, 8, 198, 198, 8818, 900, 62, 82, 2122, 0, 7, 292, 349, 3712, 2953, 10179, 46344, 47, 16820, 11, 1540, 8, 198, 220, 220, 220, 256, 11, 10662, 11, 279, 796, 1540, 198, 220, 220, 220, 355, 349, 13, 83, 220, 796, 256, 198, 220, 220, 220, 355, 349, 13, 80, 764, 28, 10662, 198, 220, 220, 220, 355, 349, 13, 79, 764, 28, 279, 198, 220, 220, 220, 355, 349, 13, 85, 764, 28, 657, 198, 220, 220, 220, 355, 349, 13, 69, 764, 28, 657, 198, 437, 198, 198, 8818, 651, 62, 82, 2122, 7, 292, 349, 3712, 2953, 10179, 46344, 47, 16820, 8, 198, 220, 220, 220, 357, 292, 349, 13, 83, 11, 355, 349, 13, 80, 11, 355, 349, 13, 79, 8, 198, 437, 198, 198, 8818, 8070, 24629, 2733, 13, 42503, 0, 7, 292, 349, 3712, 2953, 10179, 46344, 47, 16820, 11, 37455, 83, 8, 198, 220, 220, 220, 355, 349, 13, 83, 136, 227, 220, 796, 355, 349, 13, 83, 198, 220, 220, 220, 355, 349, 13, 80, 136, 227, 764, 28, 355, 349, 13, 80, 198, 220, 220, 220, 355, 349, 13, 79, 136, 227, 764, 28, 355, 349, 13, 79, 198, 220, 220, 220, 355, 349, 13, 85, 136, 227, 764, 28, 355, 349, 13, 85, 198, 220, 220, 220, 355, 349, 13, 69, 136, 227, 764, 28, 355, 349, 13, 69, 198, 220, 220, 220, 355, 349, 13, 83, 15853, 37455, 83, 198, 437, 198, 198, 8818, 4296, 0, 7, 292, 349, 3712, 2953, 10179, 46344, 47, 16820, 90, 24544, 5512, 331, 3712, 38469, 90, 24544, 5512, 1976, 3712, 38469, 90, 24544, 30072, 810, 1391, 24544, 92, 198, 220, 220, 220, 329, 479, 287, 1123, 9630, 7, 88, 11, 89, 8, 198, 220, 220, 220, 220, 220, 220, 220, 4296, 0, 7, 292, 349, 11, 331, 58, 74, 4357, 1976, 58, 74, 4357, 479, 8, 198, 220, 220, 220, 886, 198, 437, 198, 198, 8818, 4296, 0, 7, 292, 349, 3712, 2953, 10179, 46344, 47, 16820, 90, 24544, 5512, 331, 3712, 24544, 11, 1976, 3712, 24544, 11, 479, 3712, 5317, 8, 810, 1391, 24544, 92, 198, 220, 220, 220, 355, 349, 13, 80, 58, 74, 4357, 355, 349, 13, 80, 136, 225, 58, 74, 60, 796, 34304, 62, 82, 13929, 341, 7, 88, 11, 355, 349, 13, 80, 58, 74, 4357, 355, 349, 13, 80, 136, 225, 58, 74, 12962, 198, 220, 220, 220, 355, 349, 13, 79, 58, 74, 4357, 355, 349, 13, 79, 136, 225, 58, 74, 60, 796, 34304, 62, 82, 13929, 341, 7, 89, 11, 355, 349, 13, 79, 58, 74, 4357, 355, 349, 13, 79, 136, 225, 58, 74, 12962, 198, 437, 198 ]
1.970498
983
function trimolecular_1path_diff!(du,u,p,t,dens,cons) # unpack rates and constants nᵣ,nᵣₓ,n₃ = u kₓ,k₋ₓ,k₃,k₋₃ = p k₁,k₋₁ = cons mᵣ,mₗ,mₓ,A = dens # model du[1] = dnᵣ = A*k₁*mᵣ*mₗ - k₋₁*nᵣ - A*kₓ*mₓ*nᵣ + k₋ₓ*nᵣₓ du[2] = dnᵣₓ = A*kₓ*mₓ*nᵣ - k₋ₓ*nᵣₓ - k₃*nᵣₓ + k₋₃*n₃ du[3] = dn₃ = k₃*nᵣₓ - k₋₃*n₃ end
[ 201, 198, 8818, 15797, 2305, 10440, 62, 16, 6978, 62, 26069, 0, 7, 646, 11, 84, 11, 79, 11, 83, 11, 67, 641, 11, 5936, 8, 201, 198, 220, 220, 220, 1303, 555, 8002, 3965, 290, 38491, 201, 198, 220, 220, 220, 299, 39611, 96, 11, 77, 39611, 96, 158, 224, 241, 11, 77, 158, 224, 225, 796, 334, 201, 198, 220, 220, 220, 479, 158, 224, 241, 11, 74, 158, 224, 233, 158, 224, 241, 11, 74, 158, 224, 225, 11, 74, 158, 224, 233, 158, 224, 225, 796, 279, 201, 198, 220, 220, 220, 479, 158, 224, 223, 11, 74, 158, 224, 233, 158, 224, 223, 796, 762, 201, 198, 220, 220, 220, 285, 39611, 96, 11, 76, 158, 224, 245, 11, 76, 158, 224, 241, 11, 32, 796, 29509, 201, 198, 201, 198, 220, 220, 220, 1303, 2746, 201, 198, 220, 220, 220, 7043, 58, 16, 60, 796, 288, 77, 39611, 96, 220, 796, 317, 9, 74, 158, 224, 223, 9, 76, 39611, 96, 9, 76, 158, 224, 245, 532, 479, 158, 224, 233, 158, 224, 223, 9, 77, 39611, 96, 532, 317, 9, 74, 158, 224, 241, 9, 76, 158, 224, 241, 9, 77, 39611, 96, 1343, 479, 158, 224, 233, 158, 224, 241, 9, 77, 39611, 96, 158, 224, 241, 201, 198, 220, 220, 220, 7043, 58, 17, 60, 796, 288, 77, 39611, 96, 158, 224, 241, 796, 317, 9, 74, 158, 224, 241, 9, 76, 158, 224, 241, 9, 77, 39611, 96, 532, 479, 158, 224, 233, 158, 224, 241, 9, 77, 39611, 96, 158, 224, 241, 532, 479, 158, 224, 225, 9, 77, 39611, 96, 158, 224, 241, 1343, 479, 158, 224, 233, 158, 224, 225, 9, 77, 158, 224, 225, 201, 198, 220, 220, 220, 7043, 58, 18, 60, 796, 288, 77, 158, 224, 225, 220, 796, 479, 158, 224, 225, 9, 77, 39611, 96, 158, 224, 241, 532, 479, 158, 224, 233, 158, 224, 225, 9, 77, 158, 224, 225, 201, 198, 201, 198, 437, 201, 198 ]
1.056548
336
### A Pluto.jl notebook ### # v0.12.18 using Markdown using InteractiveUtils # ╔═╡ 92081fb8-5d90-11eb-2078-ddbf87421051 begin using ReinforcementLearning using Flux using Statistics using Plots using Distributions end # ╔═╡ 3254385c-5d90-11eb-2c99-07a3a40ae467 md""" Again, we'll describe the car rental problem with a distributional model. """ # ╔═╡ a1a5176c-5d90-11eb-2ad6-2f108e1531e2 begin const PoissonUpperBound = 10 const MaxCars= 20 const MaxMoves = 5 const CostPerMove = 2 const CarRentalCartesianIndices = CartesianIndices((0:MaxCars,0:MaxCars)) const CarRentalLinearIndices = LinearIndices((0:MaxCars,0:MaxCars)) const Actions = -MaxMoves:MaxMoves const RequestDist_1 = Poisson(3) const RequestDist_2 = Poisson(4) const ReturnDist_1 = Poisson(3) const ReturnDist_2 = Poisson(2) decode_state(s::Int) = Tuple(CarRentalCartesianIndices[s]) encode_state(s1::Int, s2::Int) = CarRentalLinearIndices[CartesianIndex(s1+1, s2+1)] decode_action(a::Int) = a - MaxMoves - 1 encode_action(a::Int) = a + MaxMoves + 1 function merge_prob(dist) merged = Dict() for (s′, r, p) in dist if haskey(merged, (s′, r)) merged[(s′, r)] += p else merged[(s′, r)] = p end end [(r, false, s′) => p for ((s′, r), p) in merged] end function nextstep(state::Int, action::Int) (s1, s2), a = decode_state(state), decode_action(action) move = a > 0 ? min(a, s1) : max(a, -s2) reward = -CostPerMove*abs(move) s1′, s2′ = min(s1 - move, MaxCars), min(s2 + move, MaxCars) merge_prob( ( encode_state( min(max(s1′-req_1, 0)+ret_1, MaxCars), min(max(s2′-req_2, 0)+ret_2, MaxCars) ), reward + (min(s1′, req_1) + min(s2′, req_2)) * 10, ( pdf(RequestDist_1, req_1) * pdf(RequestDist_2, req_2) * pdf(ReturnDist_1, ret_1) * pdf(ReturnDist_2, ret_2) ) ) for req_1 in 0:PoissonUpperBound, req_2 in 0:PoissonUpperBound, ret_1 in 0:PoissonUpperBound, ret_2 in 0:PoissonUpperBound ) end struct CarRentalEnvModel <: AbstractEnvironmentModel dist end function CarRentalEnvModel() CarRentalEnvModel( Dict( (s,a) => nextstep(s,a) for s in 1:(MaxCars+1)^2 for a in 1:length(Actions) ) ) end (m::CarRentalEnvModel)(s, a) = m.dist[(s, a)] RLBase.state_space(m::CarRentalEnvModel) = Base.OneTo((MaxCars+1)^2) RLBase.action_space(m::CarRentalEnvModel) = Base.OneTo(length(Actions)) end # ╔═╡ 20e3c8d6-5d92-11eb-1591-9911e62805bd model = CarRentalEnvModel() # ╔═╡ 0c099578-5d92-11eb-2a8b-2f4889026185 V = TabularVApproximator(n_state=length(state_space(model)), opt=Descent(1.0)) # ╔═╡ dda27350-5d94-11eb-1a82-c302513da719 p = TabularPolicy(;table=Dict(s=>1 for s in state_space(model)), n_action=length(action_space(model))) # ╔═╡ 021f9b90-5d95-11eb-303a-ed2fb3de3d08 policy_iteration!(;V=V, π=p, model=model, γ=0.9, max_iter=300) # ╔═╡ 8bbe08e6-5d98-11eb-0c02-4712c4659830 heatmap(0:MaxCars, 0:MaxCars, reshape([decode_action(p(x)) for x in state_space(model)], 1+MaxCars,1+MaxCars)) # ╔═╡ 91d90bf6-5d98-11eb-23a5-4dfc2839a707 heatmap(0:MaxCars, 0:MaxCars, reshape(V.table, 1+MaxCars,1+MaxCars)) # ╔═╡ Cell order: # ╟─3254385c-5d90-11eb-2c99-07a3a40ae467 # ╠═92081fb8-5d90-11eb-2078-ddbf87421051 # ╠═a1a5176c-5d90-11eb-2ad6-2f108e1531e2 # ╠═20e3c8d6-5d92-11eb-1591-9911e62805bd # ╠═0c099578-5d92-11eb-2a8b-2f4889026185 # ╠═dda27350-5d94-11eb-1a82-c302513da719 # ╠═021f9b90-5d95-11eb-303a-ed2fb3de3d08 # ╠═8bbe08e6-5d98-11eb-0c02-4712c4659830 # ╠═91d90bf6-5d98-11eb-23a5-4dfc2839a707
[ 21017, 317, 32217, 13, 20362, 20922, 44386, 198, 2, 410, 15, 13, 1065, 13, 1507, 198, 198, 3500, 2940, 2902, 198, 3500, 21365, 18274, 4487, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 47679, 6659, 21855, 23, 12, 20, 67, 3829, 12, 1157, 1765, 12, 1238, 3695, 12, 1860, 19881, 5774, 3682, 940, 4349, 198, 27471, 198, 197, 3500, 22299, 13442, 41730, 198, 197, 3500, 1610, 2821, 198, 197, 3500, 14370, 198, 197, 3500, 1345, 1747, 198, 197, 3500, 46567, 507, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 513, 24970, 27203, 66, 12, 20, 67, 3829, 12, 1157, 1765, 12, 17, 66, 2079, 12, 2998, 64, 18, 64, 1821, 3609, 24669, 198, 9132, 37811, 198, 15316, 11, 356, 1183, 6901, 262, 1097, 14447, 1917, 351, 257, 6082, 282, 2746, 13, 198, 37811, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 257, 16, 64, 20, 24096, 66, 12, 20, 67, 3829, 12, 1157, 1765, 12, 17, 324, 21, 12, 17, 69, 15711, 68, 1314, 3132, 68, 17, 198, 27471, 198, 197, 9979, 7695, 30927, 52, 2848, 49646, 796, 838, 198, 197, 9979, 5436, 34, 945, 28, 1160, 198, 197, 9979, 5436, 44, 5241, 796, 642, 198, 197, 9979, 6446, 5990, 21774, 796, 362, 198, 197, 9979, 1879, 49, 2470, 43476, 35610, 5497, 1063, 796, 13690, 35610, 5497, 1063, 19510, 15, 25, 11518, 34, 945, 11, 15, 25, 11518, 34, 945, 4008, 198, 197, 9979, 1879, 49, 2470, 14993, 451, 5497, 1063, 796, 44800, 5497, 1063, 19510, 15, 25, 11518, 34, 945, 11, 15, 25, 11518, 34, 945, 4008, 198, 197, 9979, 24439, 796, 532, 11518, 44, 5241, 25, 11518, 44, 5241, 198, 197, 9979, 19390, 20344, 62, 16, 796, 7695, 30927, 7, 18, 8, 198, 197, 9979, 19390, 20344, 62, 17, 796, 7695, 30927, 7, 19, 8, 198, 197, 9979, 8229, 20344, 62, 16, 796, 7695, 30927, 7, 18, 8, 198, 197, 9979, 8229, 20344, 62, 17, 796, 7695, 30927, 7, 17, 8, 628, 197, 12501, 1098, 62, 5219, 7, 82, 3712, 5317, 8, 796, 309, 29291, 7, 9914, 49, 2470, 43476, 35610, 5497, 1063, 58, 82, 12962, 198, 197, 268, 8189, 62, 5219, 7, 82, 16, 3712, 5317, 11, 264, 17, 3712, 5317, 8, 796, 1879, 49, 2470, 14993, 451, 5497, 1063, 58, 43476, 35610, 15732, 7, 82, 16, 10, 16, 11, 264, 17, 10, 16, 15437, 198, 197, 12501, 1098, 62, 2673, 7, 64, 3712, 5317, 8, 796, 257, 532, 5436, 44, 5241, 532, 352, 198, 197, 268, 8189, 62, 2673, 7, 64, 3712, 5317, 8, 796, 257, 1343, 5436, 44, 5241, 1343, 352, 628, 197, 8818, 20121, 62, 1676, 65, 7, 17080, 8, 198, 197, 197, 647, 2004, 796, 360, 713, 3419, 198, 197, 197, 1640, 357, 82, 17478, 11, 374, 11, 279, 8, 287, 1233, 198, 197, 197, 197, 361, 468, 2539, 7, 647, 2004, 11, 357, 82, 17478, 11, 374, 4008, 198, 197, 197, 197, 197, 647, 2004, 58, 7, 82, 17478, 11, 374, 15437, 15853, 279, 198, 197, 197, 197, 17772, 198, 197, 197, 197, 197, 647, 2004, 58, 7, 82, 17478, 11, 374, 15437, 796, 279, 198, 197, 197, 197, 437, 198, 197, 197, 437, 198, 197, 197, 58, 7, 81, 11, 3991, 11, 264, 17478, 8, 5218, 279, 329, 14808, 82, 17478, 11, 374, 828, 279, 8, 287, 23791, 60, 198, 197, 437, 628, 197, 8818, 1306, 9662, 7, 5219, 3712, 5317, 11, 2223, 3712, 5317, 8, 198, 197, 197, 7, 82, 16, 11, 264, 17, 828, 257, 796, 36899, 62, 5219, 7, 5219, 828, 36899, 62, 2673, 7, 2673, 8, 198, 197, 197, 21084, 796, 257, 1875, 657, 5633, 949, 7, 64, 11, 264, 16, 8, 1058, 3509, 7, 64, 11, 532, 82, 17, 8, 198, 197, 197, 260, 904, 796, 532, 13729, 5990, 21774, 9, 8937, 7, 21084, 8, 198, 197, 197, 82, 16, 17478, 11, 264, 17, 17478, 796, 949, 7, 82, 16, 532, 1445, 11, 5436, 34, 945, 828, 949, 7, 82, 17, 1343, 1445, 11, 5436, 34, 945, 8, 198, 197, 197, 647, 469, 62, 1676, 65, 7, 198, 197, 197, 197, 7, 198, 197, 197, 197, 197, 268, 8189, 62, 5219, 7, 198, 197, 197, 197, 197, 197, 1084, 7, 9806, 7, 82, 16, 17478, 12, 42180, 62, 16, 11, 657, 47762, 1186, 62, 16, 11, 5436, 34, 945, 828, 198, 197, 197, 197, 197, 197, 1084, 7, 9806, 7, 82, 17, 17478, 12, 42180, 62, 17, 11, 657, 47762, 1186, 62, 17, 11, 5436, 34, 945, 8, 198, 197, 197, 197, 197, 197, 828, 220, 198, 197, 197, 197, 197, 260, 904, 1343, 357, 1084, 7, 82, 16, 17478, 11, 43089, 62, 16, 8, 1343, 949, 7, 82, 17, 17478, 11, 43089, 62, 17, 4008, 1635, 838, 11, 198, 197, 197, 197, 197, 7, 198, 197, 197, 197, 197, 197, 12315, 7, 18453, 20344, 62, 16, 11, 43089, 62, 16, 8, 1635, 220, 198, 197, 197, 197, 197, 197, 12315, 7, 18453, 20344, 62, 17, 11, 43089, 62, 17, 8, 1635, 220, 198, 197, 197, 197, 197, 197, 12315, 7, 13615, 20344, 62, 16, 11, 1005, 62, 16, 8, 1635, 198, 197, 197, 197, 197, 197, 12315, 7, 13615, 20344, 62, 17, 11, 1005, 62, 17, 8, 198, 197, 197, 197, 197, 8, 198, 197, 197, 197, 8, 198, 197, 197, 197, 1640, 43089, 62, 16, 287, 657, 25, 18833, 30927, 52, 2848, 49646, 11, 198, 197, 197, 197, 197, 42180, 62, 17, 287, 657, 25, 18833, 30927, 52, 2848, 49646, 11, 220, 198, 197, 197, 197, 197, 1186, 62, 16, 287, 657, 25, 18833, 30927, 52, 2848, 49646, 11, 198, 197, 197, 197, 197, 1186, 62, 17, 287, 657, 25, 18833, 30927, 52, 2848, 49646, 198, 197, 197, 8, 198, 197, 437, 628, 197, 7249, 1879, 49, 2470, 4834, 85, 17633, 1279, 25, 27741, 31441, 17633, 198, 197, 197, 17080, 198, 197, 437, 628, 197, 8818, 1879, 49, 2470, 4834, 85, 17633, 3419, 198, 197, 197, 9914, 49, 2470, 4834, 85, 17633, 7, 198, 197, 197, 197, 35, 713, 7, 198, 197, 197, 197, 197, 7, 82, 11, 64, 8, 5218, 1306, 9662, 7, 82, 11, 64, 8, 198, 197, 197, 197, 197, 1640, 264, 287, 352, 37498, 11518, 34, 945, 10, 16, 8, 61, 17, 329, 257, 287, 352, 25, 13664, 7, 32, 2733, 8, 198, 197, 197, 197, 8, 198, 197, 197, 8, 198, 197, 437, 628, 197, 7, 76, 3712, 9914, 49, 2470, 4834, 85, 17633, 5769, 82, 11, 257, 8, 796, 285, 13, 17080, 58, 7, 82, 11, 257, 15437, 628, 197, 7836, 14881, 13, 5219, 62, 13200, 7, 76, 3712, 9914, 49, 2470, 4834, 85, 17633, 8, 796, 7308, 13, 3198, 2514, 19510, 11518, 34, 945, 10, 16, 8, 61, 17, 8, 198, 197, 7836, 14881, 13, 2673, 62, 13200, 7, 76, 3712, 9914, 49, 2470, 4834, 85, 17633, 8, 796, 7308, 13, 3198, 2514, 7, 13664, 7, 32, 2733, 4008, 198, 437, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 1160, 68, 18, 66, 23, 67, 21, 12, 20, 67, 5892, 12, 1157, 1765, 12, 1314, 6420, 12, 2079, 1157, 68, 5237, 28256, 17457, 198, 19849, 796, 1879, 49, 2470, 4834, 85, 17633, 3419, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 657, 66, 15, 2079, 38907, 12, 20, 67, 5892, 12, 1157, 1765, 12, 17, 64, 23, 65, 12, 17, 69, 33646, 3829, 2075, 21652, 198, 53, 796, 16904, 934, 53, 4677, 13907, 320, 1352, 7, 77, 62, 5219, 28, 13664, 7, 5219, 62, 13200, 7, 19849, 36911, 2172, 28, 5960, 1087, 7, 16, 13, 15, 4008, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 288, 6814, 1983, 14877, 12, 20, 67, 5824, 12, 1157, 1765, 12, 16, 64, 6469, 12, 66, 1270, 1495, 1485, 6814, 22, 1129, 198, 79, 796, 16904, 934, 36727, 7, 26, 11487, 28, 35, 713, 7, 82, 14804, 16, 329, 264, 287, 1181, 62, 13200, 7, 19849, 36911, 299, 62, 2673, 28, 13664, 7, 2673, 62, 13200, 7, 19849, 22305, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 657, 2481, 69, 24, 65, 3829, 12, 20, 67, 3865, 12, 1157, 1765, 12, 22572, 64, 12, 276, 17, 21855, 18, 2934, 18, 67, 2919, 198, 30586, 62, 2676, 341, 0, 7, 26, 53, 28, 53, 11, 18074, 222, 28, 79, 11, 2746, 28, 19849, 11, 7377, 111, 28, 15, 13, 24, 11, 3509, 62, 2676, 28, 6200, 8, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 807, 65, 1350, 2919, 68, 21, 12, 20, 67, 4089, 12, 1157, 1765, 12, 15, 66, 2999, 12, 2857, 1065, 66, 42018, 4089, 1270, 198, 25080, 8899, 7, 15, 25, 11518, 34, 945, 11, 657, 25, 11518, 34, 945, 11, 27179, 1758, 26933, 12501, 1098, 62, 2673, 7, 79, 7, 87, 4008, 329, 2124, 287, 1181, 62, 13200, 7, 19849, 8, 4357, 352, 10, 11518, 34, 945, 11, 16, 10, 11518, 34, 945, 4008, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 10495, 67, 3829, 19881, 21, 12, 20, 67, 4089, 12, 1157, 1765, 12, 1954, 64, 20, 12, 19, 7568, 66, 2078, 2670, 64, 24038, 198, 25080, 8899, 7, 15, 25, 11518, 34, 945, 11, 657, 25, 11518, 34, 945, 11, 27179, 1758, 7, 53, 13, 11487, 11, 352, 10, 11518, 34, 945, 11, 16, 10, 11518, 34, 945, 4008, 198, 198, 2, 2343, 243, 242, 28670, 22880, 94, 12440, 1502, 25, 198, 2, 2343, 243, 253, 7280, 18, 24970, 27203, 66, 12, 20, 67, 3829, 12, 1157, 1765, 12, 17, 66, 2079, 12, 2998, 64, 18, 64, 1821, 3609, 24669, 198, 2, 2343, 243, 254, 28670, 37128, 6659, 21855, 23, 12, 20, 67, 3829, 12, 1157, 1765, 12, 1238, 3695, 12, 1860, 19881, 5774, 3682, 940, 4349, 198, 2, 2343, 243, 254, 28670, 64, 16, 64, 20, 24096, 66, 12, 20, 67, 3829, 12, 1157, 1765, 12, 17, 324, 21, 12, 17, 69, 15711, 68, 1314, 3132, 68, 17, 198, 2, 2343, 243, 254, 28670, 1238, 68, 18, 66, 23, 67, 21, 12, 20, 67, 5892, 12, 1157, 1765, 12, 1314, 6420, 12, 2079, 1157, 68, 5237, 28256, 17457, 198, 2, 2343, 243, 254, 28670, 15, 66, 15, 2079, 38907, 12, 20, 67, 5892, 12, 1157, 1765, 12, 17, 64, 23, 65, 12, 17, 69, 33646, 3829, 2075, 21652, 198, 2, 2343, 243, 254, 28670, 1860, 64, 1983, 14877, 12, 20, 67, 5824, 12, 1157, 1765, 12, 16, 64, 6469, 12, 66, 1270, 1495, 1485, 6814, 22, 1129, 198, 2, 2343, 243, 254, 28670, 46821, 69, 24, 65, 3829, 12, 20, 67, 3865, 12, 1157, 1765, 12, 22572, 64, 12, 276, 17, 21855, 18, 2934, 18, 67, 2919, 198, 2, 2343, 243, 254, 28670, 23, 65, 1350, 2919, 68, 21, 12, 20, 67, 4089, 12, 1157, 1765, 12, 15, 66, 2999, 12, 2857, 1065, 66, 42018, 4089, 1270, 198, 2, 2343, 243, 254, 28670, 6420, 67, 3829, 19881, 21, 12, 20, 67, 4089, 12, 1157, 1765, 12, 1954, 64, 20, 12, 19, 7568, 66, 2078, 2670, 64, 24038, 198 ]
1.927123
1,825
const _fact_tab64 = SafeInt64.(Base._fact_table64) const _fact_tab128 = SafeUInt128.(Base._fact_table128) function factorial_lookup(n::S, table, lim) where {S<:Union{SafeSigned, SafeUnsigned}} n < 0 && throw(DomainError(n, "`n` must not be negative.")) n > lim && throw(OverflowError(string(n, "! is too large to fit in a $S"))) n == 0 && return one(n) @inbounds f = table[n] return oftype(n, f) end Base.factorial(n::SafeInt128) = factorial_lookup(n, _fact_tab128, 33) Base.factorial(n::SafeUInt128) = factorial_lookup(n, _fact_tab128, 34) Base.factorial(n::Union{SafeInt64,SafeUInt64}) = factorial_lookup(n, _fact_tab64, 20) if Int === Int32 Base.factorial(n::Union{SafeInt8,SafeUInt8,SafeInt16,SafeUInt16}) = factorial(SafeInt32(n)) Base.factorial(n::Union{SafeInt32,SafeUInt32}) = factorial_lookup(n, _fact_tab64, 12) else Base.factorial(n::Union{SafeInt8,SafeUInt8,SafeInt16,SafeUInt16,SafeInt32,SafeUInt32}) = factorial(SafeInt64(n)) end
[ 9979, 4808, 22584, 62, 8658, 2414, 796, 19978, 5317, 2414, 12195, 14881, 13557, 22584, 62, 11487, 2414, 8, 198, 9979, 4808, 22584, 62, 8658, 12762, 796, 19978, 52, 5317, 12762, 12195, 14881, 13557, 22584, 62, 11487, 12762, 8, 198, 198, 8818, 1109, 5132, 62, 5460, 929, 7, 77, 3712, 50, 11, 3084, 11, 1761, 8, 810, 1391, 50, 27, 25, 38176, 90, 31511, 50, 3916, 11, 19978, 3118, 32696, 11709, 198, 220, 220, 220, 299, 1279, 657, 11405, 3714, 7, 43961, 12331, 7, 77, 11, 366, 63, 77, 63, 1276, 407, 307, 4633, 526, 4008, 198, 220, 220, 220, 299, 1875, 1761, 11405, 3714, 7, 5886, 11125, 12331, 7, 8841, 7, 77, 11, 366, 0, 318, 1165, 1588, 284, 4197, 287, 257, 720, 50, 1, 22305, 198, 220, 220, 220, 299, 6624, 657, 11405, 1441, 530, 7, 77, 8, 198, 220, 220, 220, 2488, 259, 65, 3733, 277, 796, 3084, 58, 77, 60, 198, 220, 220, 220, 1441, 286, 4906, 7, 77, 11, 277, 8, 198, 437, 198, 198, 14881, 13, 22584, 5132, 7, 77, 3712, 31511, 5317, 12762, 8, 796, 1109, 5132, 62, 5460, 929, 7, 77, 11, 4808, 22584, 62, 8658, 12762, 11, 4747, 8, 198, 14881, 13, 22584, 5132, 7, 77, 3712, 31511, 52, 5317, 12762, 8, 796, 1109, 5132, 62, 5460, 929, 7, 77, 11, 4808, 22584, 62, 8658, 12762, 11, 4974, 8, 198, 14881, 13, 22584, 5132, 7, 77, 3712, 38176, 90, 31511, 5317, 2414, 11, 31511, 52, 5317, 2414, 30072, 796, 1109, 5132, 62, 5460, 929, 7, 77, 11, 4808, 22584, 62, 8658, 2414, 11, 1160, 8, 628, 198, 361, 2558, 24844, 2558, 2624, 198, 220, 220, 220, 7308, 13, 22584, 5132, 7, 77, 3712, 38176, 90, 31511, 5317, 23, 11, 31511, 52, 5317, 23, 11, 31511, 5317, 1433, 11, 31511, 52, 5317, 1433, 30072, 796, 1109, 5132, 7, 31511, 5317, 2624, 7, 77, 4008, 198, 220, 220, 220, 7308, 13, 22584, 5132, 7, 77, 3712, 38176, 90, 31511, 5317, 2624, 11, 31511, 52, 5317, 2624, 30072, 796, 1109, 5132, 62, 5460, 929, 7, 77, 11, 4808, 22584, 62, 8658, 2414, 11, 1105, 8, 198, 17772, 198, 220, 220, 220, 7308, 13, 22584, 5132, 7, 77, 3712, 38176, 90, 31511, 5317, 23, 11, 31511, 52, 5317, 23, 11, 31511, 5317, 1433, 11, 31511, 52, 5317, 1433, 11, 31511, 5317, 2624, 11, 31511, 52, 5317, 2624, 30072, 796, 1109, 5132, 7, 31511, 5317, 2414, 7, 77, 4008, 198, 437, 628 ]
2.422222
405
#! /usr/bin/env julia using Benchmark using PolygonClipping using DataFrames function intersection1() polya = Polygon() push!(polya, Vertex(0.38717397323666614,0.9175286859623484)) push!(polya, Vertex(0.22863911382759805,0.97369797312849)) push!(polya, Vertex(0.411735284885411,0.67925592862104)) push!(polya, Vertex(0.4760881945244875,0.6150149154240558)) push!(polya, Vertex(0.05897662471214904,0.8393947489758318)) push!(polya, Vertex(0.1138425905192968,0.4935408034874309)) push!(polya, Vertex(0.5369414505688628,0.20213738997953312)) push!(polya, Vertex(0.8894594154609499,0.9924712388095045)) push!(polya, Vertex(0.9256610367848219,0.9190955722799556)) push!(polya, Vertex(0.6895872059237731,0.43384802891551)) push!(polya, Vertex(0.9087449635347744,0.47063971708226404)) push!(polya, Vertex(0.9757793404848136,0.7322250783012572)) push!(polya, Vertex(0.12339214488107642,0.11118441062092432)) push!(polya, Vertex(0.6140766278925023,0.7892323008875815)) push!(polya, Vertex(0.9080611442010653,0.8482511305518234)) push!(polya, Vertex(0.10274769769723902,0.38869064624120186)) push!(polya, Vertex(0.6082870387345407,0.9944088302986258)) push!(polya, Vertex(0.3641405100568089,0.6359528425953462)) push!(polya, Vertex(0.6835875991611398,0.6110124950747555)) push!(polya, Vertex(0.7131748261757693,0.8537241667688524)) push!(polya, Vertex(0.47313568651228555,0.84090661977734)) push!(polya, Vertex(0.6122874995061984,0.4397916059818694)) push!(polya, Vertex(0.9378622844157258,0.6928400362996152)) push!(polya, Vertex(0.37988141528846486,0.3924066347636528)) push!(polya, Vertex(0.37612785711290586,0.1262573371450586)) push!(polya, Vertex(0.2855066522487957,0.34807448520950257)) push!(polya, Vertex(0.3226665347220963,0.7530552496358307)) push!(polya, Vertex(0.6260310508679137,0.9624257683012829)) push!(polya, Vertex(0.5090596161323337,0.6293681446635448)) push!(polya, Vertex(0.15373073711802787,0.699604530492266)) push!(polya, Vertex(0.5916127221754168,0.5134368361443975)) push!(polya, Vertex(0.5476501761702322,0.12025320226897085)) push!(polya, Vertex(0.7364982683875068,0.6573742771739695)) push!(polya, Vertex(0.3564770108133659,0.6190436269899608)) push!(polya, Vertex(0.1942877121254134,0.7460859067795749)) push!(polya, Vertex(0.48141346512614325,0.33226336281429103)) push!(polya, Vertex(0.029892986776481,0.2174442631248703)) push!(polya, Vertex(0.6110877370822994,0.6597597834785822)) push!(polya, Vertex(0.6492858228562519,0.6866871593335842)) push!(polya, Vertex(0.7810487364244136,0.6630376297746976)) push!(polya, Vertex(0.7517037010056422,0.5481097354087443)) push!(polya, Vertex(0.32595306165531923,0.827698654052716)) push!(polya, Vertex(0.0946562934579609,0.06511398366340826)) push!(polya, Vertex(0.4016822086257372,0.2633273020831326)) push!(polya, Vertex(0.14840039175150355,0.26329155785679026)) push!(polya, Vertex(0.660892803459532,0.14824001535942988)) push!(polya, Vertex(0.7270462350880156,0.9616603642178803)) push!(polya, Vertex(0.20565290637531142,0.45438554764185524)) push!(polya, Vertex(0.01226767618359137,0.4346542090688914)) push!(polya, Vertex(0.8443656165997122,0.6218309213080848)) push!(polya, Vertex(0.36543895623038214,0.575693893269152)) push!(polya, Vertex(0.2057450566974688,0.41382632848748657)) push!(polya, Vertex(0.6578438918849019,0.018731630167831304)) push!(polya, Vertex(0.9251751209532304,0.27030612773533713)) push!(polya, Vertex(0.3698114785252209,0.08714925463572976)) push!(polya, Vertex(0.8310050243916558,0.19245735232136196)) push!(polya, Vertex(0.09311535434229778,0.5708872306538855)) push!(polya, Vertex(0.2275489167423912,0.10333866005215286)) push!(polya, Vertex(0.5691689464441063,0.07917751066510315)) push!(polya, Vertex(0.9441999955891076,0.08863956272995877)) push!(polya, Vertex(0.06944908047821619,0.9580858557547942)) push!(polya, Vertex(0.13317769494718235,0.30579396918400126)) push!(polya, Vertex(0.8916959800005415,0.49287891827534636)) push!(polya, Vertex(0.05313909148370777,0.568467861010775)) push!(polya, Vertex(0.8839793776888005,0.3922614940305833)) push!(polya, Vertex(0.29947054407245455,0.13067176985025442)) push!(polya, Vertex(0.6412436143042177,0.05964508351161513)) push!(polya, Vertex(0.9907882336943714,0.18490674849468958)) push!(polya, Vertex(0.3164116203917908,0.6915262366567434)) push!(polya, Vertex(0.670340857966748,0.2494086348537079)) push!(polya, Vertex(0.9516002726498964,0.5877410895223771)) push!(polya, Vertex(0.37859268972845683,0.5498068716998208)) push!(polya, Vertex(0.4585342971405306,0.009925253379711174)) push!(polya, Vertex(0.825358328321574,0.02436860679566233)) push!(polya, Vertex(0.2944481729419708,0.35565821826071664)) push!(polya, Vertex(0.9479518990808133,0.022876736181673296)) push!(polya, Vertex(0.32890511871298855,0.5903117675591205)) push!(polya, Vertex(0.13434078534002403,0.8043761349960912)) push!(polya, Vertex(0.36305742044837475,0.8074864926312384)) push!(polya, Vertex(0.37006152533035075,0.810010072925335)) push!(polya, Vertex(0.30245125983035126,0.531982907605898)) push!(polya, Vertex(0.6061475382439927,0.3591482019894219)) push!(polya, Vertex(0.4318224796352559,0.6906958337163789)) push!(polya, Vertex(0.5484989647598377,0.5979198296052988)) push!(polya, Vertex(0.3283124258298571,0.550335718203822)) push!(polya, Vertex(0.731217871868109,0.694746265475011)) push!(polya, Vertex(0.33503956272666824,0.7135843285873211)) push!(polya, Vertex(0.4458879602562089,0.8271969180995566)) push!(polya, Vertex(0.7868344276375905,0.9746067374413514)) push!(polya, Vertex(0.12173043080454882,0.8576124078521512)) push!(polya, Vertex(0.5907417299265332,0.6830068306826631)) push!(polya, Vertex(0.2927496535507432,0.9373149390911051)) push!(polya, Vertex(0.8550155012852447,0.9303058527010857)) push!(polya, Vertex(0.30123570126170174,0.5735420574883527)) push!(polya, Vertex(0.8967395912778122,0.018901254929095)) push!(polya, Vertex(0.6950306441092162,0.32167381094779923)) push!(polya, Vertex(0.8612213482620878,0.8954192932054237)) push!(polya, Vertex(0.755007334348081,0.6441892302099188)) push!(polya, Vertex(0.5129282217003186,0.6163889826956628)) push!(polya, Vertex(0.5956877205258515,0.207078358084255)) polyb = Polygon() push!(polyb, Vertex(0.45922312991074965,0.8634708765893035)) push!(polyb, Vertex(0.3432506505322517,0.7610444169585342)) push!(polyb, Vertex(0.7745733205429546,0.6432459662157686)) push!(polyb, Vertex(0.6626248852675782,0.3756202023478652)) push!(polyb, Vertex(0.11391157584189071,0.1175951719793249)) push!(polyb, Vertex(0.47290352518324696,0.2521388807609466)) push!(polyb, Vertex(0.975042508309663,0.31523396145745664)) push!(polyb, Vertex(0.6645972006883816,0.39747175992018424)) push!(polyb, Vertex(0.4033012612046003,0.6697684324194775)) push!(polyb, Vertex(0.7478015750621811,0.26064185515728866)) push!(polyb, Vertex(0.5408637693590228,0.6848821125508033)) push!(polyb, Vertex(0.20715997569592037,0.6570627238206466)) push!(polyb, Vertex(0.23093726175916385,0.8287208212251969)) push!(polyb, Vertex(0.6024572633721841,0.8204147304496012)) push!(polyb, Vertex(0.7025482053945702,0.6316840227377571)) push!(polyb, Vertex(0.15103563731064762,0.5804190220758261)) push!(polyb, Vertex(0.9887757894210867,0.9772711166739021)) push!(polyb, Vertex(0.6251517614575921,0.38220971314131513)) push!(polyb, Vertex(0.23163449016202686,0.7955298748003772)) push!(polyb, Vertex(0.008749232698707532,0.7038966642300737)) push!(polyb, Vertex(0.36552065983260706,0.007266458811545862)) push!(polyb, Vertex(0.8431274574795424,0.975174390993478)) push!(polyb, Vertex(0.9674040599289924,0.7546437140411728)) push!(polyb, Vertex(0.6299023469869027,0.5941113636172484)) push!(polyb, Vertex(0.3651692839350955,0.9412811548927036)) push!(polyb, Vertex(0.46700978293718576,0.6372087264115178)) push!(polyb, Vertex(0.09441852929672212,0.712398255967287)) push!(polyb, Vertex(0.6594117537641844,0.8556959981933909)) push!(polyb, Vertex(0.41749612512996004,0.7726528031089717)) push!(polyb, Vertex(0.8230135867808732,0.9270969466572365)) push!(polyb, Vertex(0.04389833237303109,0.5609640399741183)) push!(polyb, Vertex(0.4125116220480387,0.5160396701522856)) push!(polyb, Vertex(0.8836833851491399,0.7590081568215858)) push!(polyb, Vertex(0.5428845419686217,0.5433520734475961)) push!(polyb, Vertex(0.5473279623543394,0.48707911841886875)) push!(polyb, Vertex(0.504975646406884,0.6269770507544459)) push!(polyb, Vertex(0.6692031351652192,0.8269983773582317)) push!(polyb, Vertex(0.5665824658182701,0.28971587253261544)) push!(polyb, Vertex(0.6979596641936274,0.6963299758066004)) push!(polyb, Vertex(0.41393013487701724,0.02515192656365972)) push!(polyb, Vertex(0.4146094682050434,0.7760774006253788)) push!(polyb, Vertex(0.916841516397837,0.3812664317124159)) push!(polyb, Vertex(0.5694746452391368,0.021859026116122227)) push!(polyb, Vertex(0.5811595135265466,0.2757689306043134)) push!(polyb, Vertex(0.4894054388068505,0.35643214512810095)) push!(polyb, Vertex(0.5595554636066462,0.5848619132982462)) push!(polyb, Vertex(0.055595115965147324,0.08067075687112912)) push!(polyb, Vertex(0.8201820592938383,0.5690753436287503)) push!(polyb, Vertex(0.1630668008610887,0.21593074025144188)) push!(polyb, Vertex(0.3818523211281113,0.49892970559056926)) push!(polyb, Vertex(0.5879509816156174,0.7091657227073489)) push!(polyb, Vertex(0.7906807122153934,0.2210363105879154)) push!(polyb, Vertex(0.5593694790678512,0.4640752428580712)) push!(polyb, Vertex(0.6012166172350997,0.31394337995190624)) push!(polyb, Vertex(0.5626052673349125,0.8689869237375565)) push!(polyb, Vertex(0.9062078706328689,0.5926285281119317)) push!(polyb, Vertex(0.2116818069931432,0.7097461450894131)) push!(polyb, Vertex(0.23462798149426778,0.6347647741466378)) push!(polyb, Vertex(0.8333332026965838,0.4044637675513083)) push!(polyb, Vertex(0.38151281356770417,0.5842041828199334)) push!(polyb, Vertex(0.15019329095984024,0.4211489213025983)) push!(polyb, Vertex(0.8360328648037809,0.023292893005907978)) push!(polyb, Vertex(0.31874416444804177,0.11721397482037488)) push!(polyb, Vertex(0.39155608346680637,0.0016294336268325438)) push!(polyb, Vertex(0.49241666713123067,0.827810647049537)) push!(polyb, Vertex(0.28852655549271455,0.5134511690270223)) push!(polyb, Vertex(0.6320220046603813,0.8851410292212929)) push!(polyb, Vertex(0.9740042546342045,0.18256471264167917)) push!(polyb, Vertex(0.5780722916281602,0.20879214268020507)) push!(polyb, Vertex(0.6201054810476829,0.09914904930053448)) push!(polyb, Vertex(0.6219009431337508,0.1516866613709651)) push!(polyb, Vertex(0.34716243679494574,0.006595091110359164)) push!(polyb, Vertex(0.6890583759094768,0.3440450342993846)) push!(polyb, Vertex(0.9778512374676402,0.5744641432773667)) push!(polyb, Vertex(0.0033568324875912214,0.6148369261343873)) push!(polyb, Vertex(0.34832869925563625,0.40428761834628935)) push!(polyb, Vertex(0.2907179321707041,0.5340135773079302)) push!(polyb, Vertex(0.12479109273224198,0.8885089407774147)) push!(polyb, Vertex(0.9876184891473105,0.5950350229751693)) push!(polyb, Vertex(0.2006836897721096,0.44523290012385375)) push!(polyb, Vertex(0.24482339423302024,0.11468063465242362)) push!(polyb, Vertex(0.28181652810828073,0.2035021093756293)) push!(polyb, Vertex(0.06733186631795296,0.45001635767596593)) push!(polyb, Vertex(0.21527661471388138,0.3520300299617407)) push!(polyb, Vertex(0.5927741449744783,0.8525914294328816)) push!(polyb, Vertex(0.6258613640600956,0.43656539966226804)) push!(polyb, Vertex(0.5910220014222105,0.3521522088352207)) push!(polyb, Vertex(0.6106632086832191,0.5346375695717998)) push!(polyb, Vertex(0.34566121714575027,0.5845480914914436)) push!(polyb, Vertex(0.8691587357382462,0.32313446735351126)) push!(polyb, Vertex(0.3861919843487014,0.12972240893508835)) push!(polyb, Vertex(0.37769973424020375,0.051694328774281484)) push!(polyb, Vertex(0.4552128830552533,0.16435305304622982)) push!(polyb, Vertex(0.16131619574158784,0.3971212509168853)) push!(polyb, Vertex(0.24572158657159515,0.8610180990083223)) push!(polyb, Vertex(0.7284331633547654,0.7187589226042599)) push!(polyb, Vertex(0.03504548735067359,0.6029694383465394)) push!(polyb, Vertex(0.9995434477131571,0.3499686099551058)) push!(polyb, Vertex(0.8042033719306321,0.17999362049770196)) push!(polyb, Vertex(0.7467041955244049,0.3309946873417935)) results = intersection(polya, polyb) end outfile = Pkg.dir("PolygonClipping")*"/perf/intersection1_benchmarks.csv" out = benchmark(intersection1, "Clipping", "Intersection 1", 10) if isfile(outfile) previous = readtable(outfile) out = vcat(previous, out) end writetable(outfile, out)
[ 2, 0, 1220, 14629, 14, 8800, 14, 24330, 474, 43640, 198, 198, 3500, 25187, 4102, 198, 3500, 12280, 14520, 2601, 4501, 198, 3500, 6060, 35439, 198, 198, 8818, 16246, 16, 3419, 198, 220, 220, 220, 7514, 64, 796, 12280, 14520, 3419, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 32220, 1558, 2670, 4790, 1954, 19060, 1415, 11, 15, 13, 24, 17430, 2078, 3104, 45734, 1954, 34137, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1828, 4521, 2670, 1157, 2548, 1983, 3270, 28256, 11, 15, 13, 5607, 30803, 3720, 4790, 12762, 2920, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 19, 17657, 2327, 2078, 33646, 4051, 1157, 11, 15, 13, 37601, 1495, 3270, 2078, 5237, 13464, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2857, 1899, 3459, 41931, 1731, 2780, 2425, 11, 15, 13, 47007, 486, 2920, 21526, 1731, 2713, 3365, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2713, 4531, 22, 2791, 23753, 1065, 19442, 3023, 11, 15, 13, 23, 2670, 2670, 2857, 35890, 2425, 5999, 1507, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1157, 22842, 25191, 2713, 1129, 1959, 3104, 11, 15, 13, 2920, 2327, 1821, 1795, 28978, 4524, 26895, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 44468, 5824, 1415, 31654, 3104, 4521, 2078, 11, 15, 13, 19004, 19708, 2548, 2079, 41544, 2091, 1065, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 39121, 2231, 5824, 21526, 1899, 5824, 2079, 11, 15, 13, 2079, 23753, 1065, 2548, 1795, 31027, 2231, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 46351, 2791, 940, 2623, 3695, 2780, 28896, 11, 15, 13, 24, 1129, 2931, 41948, 24403, 2079, 37864, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 40523, 3365, 23906, 3270, 1954, 3324, 3132, 11, 15, 13, 42117, 5705, 1795, 27693, 1314, 4349, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 24, 2919, 22, 2598, 4846, 2327, 2682, 3324, 2598, 11, 15, 13, 27790, 21, 33372, 1558, 2919, 24909, 26429, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 42716, 3324, 6052, 1821, 2780, 2780, 20809, 11, 15, 13, 4790, 1828, 9031, 3695, 18938, 1495, 4761, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1065, 2091, 5892, 1415, 33646, 15982, 41290, 11, 15, 13, 1157, 16817, 2598, 15801, 22567, 1731, 2624, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 46841, 2998, 2791, 1983, 4531, 9031, 1954, 11, 15, 13, 40401, 1954, 1954, 405, 3459, 38569, 1314, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3829, 37988, 1157, 2598, 10333, 46435, 11, 15, 13, 23, 2780, 1495, 1157, 1270, 2816, 1507, 24409, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 40403, 2857, 40035, 40035, 23516, 2999, 11, 15, 13, 30460, 35844, 27720, 1731, 1065, 486, 4521, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 28688, 2078, 2154, 2548, 4790, 2231, 30120, 11, 15, 13, 2079, 25644, 3459, 1270, 1959, 4521, 25600, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 26780, 1415, 2713, 3064, 3980, 1795, 4531, 11, 15, 13, 48250, 3865, 30336, 1495, 3865, 2682, 5237, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3104, 31128, 2425, 2079, 1433, 1157, 31952, 11, 15, 13, 21, 1157, 486, 21626, 1120, 4524, 2425, 2816, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 50055, 1558, 2780, 2075, 1558, 3553, 48528, 11, 15, 13, 5332, 2718, 1731, 1433, 3134, 3104, 5332, 1731, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 37804, 17059, 3104, 2996, 1065, 2078, 31046, 11, 15, 13, 40675, 3829, 2791, 1129, 29331, 2682, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 43610, 2078, 4524, 2079, 35638, 28296, 11, 15, 13, 47106, 3720, 1433, 2713, 4089, 1507, 45214, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 24, 2718, 4521, 23815, 2598, 18458, 25600, 11, 15, 13, 3388, 2078, 7029, 2623, 1959, 4846, 17827, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 29088, 3459, 1415, 1314, 2078, 5705, 2414, 4521, 11, 15, 13, 2670, 16102, 2791, 2682, 4304, 24760, 2078, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 32128, 1065, 3695, 3553, 14686, 44928, 4521, 11, 15, 13, 19420, 28676, 31496, 1415, 1120, 29796, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2078, 22730, 2791, 4309, 23045, 3720, 3553, 11, 15, 13, 2682, 36928, 2598, 5332, 22567, 1120, 28676, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 37283, 2791, 2996, 2682, 4761, 1238, 4846, 18, 11, 15, 13, 2425, 1270, 2816, 1731, 4846, 31128, 22996, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 5237, 1899, 26717, 33042, 37601, 19708, 11, 15, 13, 4846, 1731, 28676, 3104, 18938, 2078, 1959, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 29022, 2713, 4846, 1433, 1485, 1954, 31496, 11, 15, 13, 48602, 27412, 18444, 2791, 2327, 31115, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1314, 2718, 22996, 2718, 1157, 1795, 1983, 5774, 11, 15, 13, 47325, 1899, 2231, 1270, 2920, 1828, 2791, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3270, 1433, 16799, 1828, 1558, 4051, 14656, 11, 15, 13, 20, 19880, 27412, 2623, 18444, 2670, 2425, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 20, 2857, 2996, 486, 4304, 17279, 1954, 1828, 11, 15, 13, 10232, 1495, 19504, 1828, 40523, 2154, 5332, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 4790, 2414, 4089, 25022, 2548, 15426, 3104, 11, 15, 13, 37680, 31020, 27019, 1558, 2670, 37381, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2327, 2414, 3324, 486, 2919, 1485, 2623, 3270, 11, 15, 13, 21, 1129, 3023, 2623, 2075, 4089, 2079, 28688, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 22913, 2078, 3324, 1065, 1065, 4051, 19880, 11, 15, 13, 4524, 28688, 36993, 3134, 3720, 3553, 2920, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2780, 1415, 19880, 2996, 19420, 21139, 1495, 11, 15, 13, 2091, 24909, 29211, 2078, 1415, 1959, 15197, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 48891, 4531, 27728, 40179, 2414, 6659, 11, 15, 13, 24591, 30272, 2075, 27970, 2780, 36809, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 5333, 15711, 3324, 20167, 23, 1828, 42691, 11, 15, 13, 36445, 2425, 32196, 2682, 3695, 3365, 1828, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 33300, 2078, 3365, 23815, 3980, 1495, 1129, 11, 15, 13, 3104, 2791, 5774, 19707, 2091, 31128, 3682, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3695, 940, 2780, 4790, 2414, 25707, 20809, 11, 15, 13, 2791, 1270, 32128, 1959, 3324, 42947, 4304, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2425, 17279, 2718, 486, 22544, 2414, 1828, 11, 15, 13, 49934, 940, 5607, 2327, 1821, 5774, 34938, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 26582, 3865, 20548, 1433, 2816, 35175, 1954, 11, 15, 13, 23, 1983, 39357, 2996, 26598, 1983, 1433, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2931, 19, 37466, 1959, 27712, 3720, 31751, 11, 15, 13, 15, 2996, 1157, 31952, 2623, 5066, 26200, 2075, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 21844, 3104, 17572, 4521, 28676, 36720, 11, 15, 13, 2075, 2091, 1983, 1270, 1238, 5999, 1485, 2075, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1415, 5705, 405, 2670, 1558, 4349, 1120, 28567, 11, 15, 13, 29558, 1959, 1314, 3553, 5332, 3134, 3829, 2075, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 39885, 4531, 21033, 27712, 3865, 2624, 11, 15, 13, 18294, 1731, 405, 1314, 2327, 5824, 1959, 3459, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 47760, 45438, 1954, 1120, 3459, 486, 3980, 11, 15, 13, 4846, 1433, 1899, 26780, 17, 23188, 43564, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 21261, 2996, 1959, 3312, 22318, 36244, 3682, 11, 15, 13, 34229, 2548, 2816, 2857, 2414, 1507, 2816, 1731, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 486, 1828, 3134, 42548, 1507, 30743, 19708, 11, 15, 13, 47101, 2996, 27211, 3829, 3104, 4531, 1415, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 23, 2598, 2623, 3980, 20986, 39647, 18376, 11, 15, 13, 5237, 1507, 26895, 2481, 1270, 28362, 2780, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2623, 4051, 2548, 3865, 5237, 1270, 2548, 22291, 11, 15, 13, 36189, 3388, 2548, 6052, 26276, 17827, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1238, 3553, 17885, 20, 36657, 4524, 34427, 11, 15, 13, 19, 20107, 29558, 2078, 35133, 2780, 37680, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2996, 37688, 29769, 20356, 2920, 30484, 11, 15, 13, 29159, 4790, 1433, 18938, 30924, 3132, 21288, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 46351, 17430, 1065, 2931, 20, 2624, 21288, 11, 15, 13, 20233, 20548, 1065, 3324, 2327, 31496, 1485, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2623, 4089, 1157, 2857, 5332, 1495, 17572, 24, 11, 15, 13, 2919, 22, 19442, 1495, 3510, 27277, 1959, 4304, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 5999, 3064, 1120, 1731, 2670, 1433, 40486, 11, 15, 13, 1129, 1731, 3553, 2327, 24339, 20809, 25272, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2931, 18, 15363, 32182, 2682, 23539, 39761, 11, 15, 13, 39254, 3459, 4761, 1270, 2996, 30460, 2816, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1828, 2425, 35890, 1433, 4524, 23516, 1065, 11, 15, 13, 940, 2091, 2548, 2791, 405, 4309, 1314, 27033, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 20, 3388, 1433, 4531, 44578, 2598, 940, 5066, 11, 15, 13, 2998, 24, 1558, 2425, 940, 36879, 15197, 1314, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 24, 2598, 1129, 17032, 2816, 4531, 940, 4304, 11, 15, 13, 2919, 4521, 2670, 3980, 1983, 22579, 3365, 3324, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3312, 24, 2598, 3829, 1795, 2857, 6469, 1433, 1129, 11, 15, 13, 3865, 28362, 3365, 2816, 2425, 31714, 3682, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 16945, 22413, 3388, 2920, 2857, 1507, 22370, 11, 15, 13, 1270, 41734, 2670, 3388, 1507, 7029, 19420, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 4531, 22172, 41292, 2388, 4051, 1314, 11, 15, 13, 2920, 2078, 40401, 1507, 23195, 30557, 2623, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2713, 18, 20219, 2931, 1415, 5999, 2154, 29331, 11, 15, 13, 49211, 24669, 4521, 8784, 2998, 2425, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3459, 2670, 3720, 26514, 3104, 3459, 22544, 11, 15, 13, 2670, 24909, 19442, 1821, 1270, 3365, 2091, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1959, 5824, 2154, 4051, 30120, 22995, 30505, 11, 15, 13, 12952, 3134, 1558, 3388, 25764, 1495, 39506, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2414, 17464, 2623, 1415, 1270, 3682, 22413, 11, 15, 13, 46712, 2414, 33042, 2327, 18298, 1314, 1485, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2079, 2998, 3459, 1954, 2623, 5824, 2718, 1415, 11, 15, 13, 1507, 31503, 3134, 2780, 2920, 38472, 24, 3365, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 18, 23237, 18298, 1238, 2670, 21738, 2919, 11, 15, 13, 3388, 1314, 2075, 1954, 36879, 45385, 2682, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 43798, 23601, 23, 41734, 28933, 2780, 11, 15, 13, 21626, 1821, 4521, 28978, 4310, 2154, 3720, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3865, 36150, 1983, 2075, 2920, 4531, 2414, 11, 15, 13, 3365, 47582, 15711, 3865, 1828, 2718, 4869, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 30695, 3270, 2075, 4531, 48524, 2231, 47521, 11, 15, 13, 44966, 1795, 39925, 1433, 34808, 21315, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2231, 5332, 2682, 26561, 1415, 2713, 20548, 11, 15, 13, 405, 2079, 1495, 1495, 2091, 44673, 1157, 22985, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 47338, 2327, 5999, 2078, 2624, 1314, 4524, 11, 15, 13, 40839, 27412, 1899, 3134, 3865, 2791, 25429, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1959, 2598, 2780, 1558, 27696, 30986, 23, 11, 15, 13, 28567, 2996, 6469, 1507, 21719, 22, 1433, 2414, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 24, 2857, 3865, 1507, 34155, 28362, 16945, 11, 15, 13, 44087, 5774, 3134, 2623, 1507, 1433, 4790, 27137, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 18, 27693, 2713, 1157, 5774, 18741, 3459, 2816, 11, 15, 13, 3270, 3070, 1157, 4304, 2425, 3270, 1065, 2713, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1485, 3559, 1821, 41172, 2682, 405, 1731, 3070, 11, 15, 13, 36088, 32128, 19880, 2079, 31751, 1065, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2623, 1270, 3553, 27211, 31115, 31020, 2425, 11, 15, 13, 36928, 2780, 33300, 2075, 27970, 22842, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2718, 28041, 1314, 1495, 26073, 14877, 2425, 11, 15, 13, 23, 3064, 44318, 1959, 1495, 27326, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1270, 22995, 1065, 41292, 1270, 2327, 19420, 11, 15, 13, 4310, 22337, 1959, 2998, 1899, 3365, 4089, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 33206, 1415, 2425, 2548, 26660, 2079, 1983, 11, 15, 13, 30743, 18294, 1264, 42520, 3682, 1129, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3559, 1507, 24137, 41060, 2327, 1495, 3270, 11, 15, 13, 3388, 3312, 24, 3365, 31496, 1433, 2718, 4531, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 49934, 2920, 4531, 2414, 2425, 4089, 26514, 11, 15, 13, 3270, 3720, 22337, 1959, 32417, 1959, 3459, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 18, 30290, 17464, 25600, 27728, 42875, 11, 15, 13, 22730, 2091, 3553, 1507, 1238, 2548, 1828, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 4790, 1065, 1558, 5774, 1507, 3104, 14454, 11, 15, 13, 3388, 2857, 3510, 2075, 4051, 2425, 28555, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2091, 1120, 2670, 3980, 1983, 2075, 35809, 1731, 11, 15, 13, 50055, 3365, 3559, 2078, 44617, 2624, 1157, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 43489, 3459, 3720, 1899, 11645, 1238, 4531, 11, 15, 13, 23, 1983, 38391, 15259, 2079, 2816, 2791, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3695, 3104, 33535, 1983, 5066, 38314, 2713, 11, 15, 13, 24, 4524, 1899, 3134, 2718, 2598, 17059, 1415, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1065, 1558, 21288, 1270, 1795, 2231, 2780, 6469, 11, 15, 13, 23, 37452, 1065, 1821, 3695, 4309, 1314, 1065, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3270, 2998, 38547, 22579, 22980, 32148, 11, 15, 13, 3104, 6200, 3104, 1270, 3104, 25540, 3132, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 1959, 1983, 2920, 2996, 2327, 1120, 4524, 2624, 11, 15, 13, 24, 34770, 19442, 2670, 2931, 11442, 4349, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 45432, 486, 2816, 486, 26279, 1731, 2857, 11, 15, 13, 45418, 1270, 38905, 1983, 486, 2919, 3553, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 18938, 1954, 3553, 486, 2075, 1558, 486, 4524, 11, 15, 13, 3553, 2327, 27211, 3553, 33646, 2327, 1983, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 4531, 3134, 2670, 3270, 1065, 39761, 18376, 11, 15, 13, 486, 4531, 486, 1495, 2920, 1959, 2931, 20, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 3388, 1120, 1270, 29173, 940, 5892, 25061, 11, 15, 13, 2624, 21940, 2548, 14454, 32883, 2079, 1954, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 4521, 18376, 1485, 2780, 2075, 21315, 3695, 11, 15, 13, 23, 3865, 45068, 1959, 19504, 4051, 24693, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 2425, 4059, 22, 31380, 2682, 1795, 6659, 11, 15, 13, 29173, 1507, 5892, 1270, 1238, 2079, 20356, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 20, 18741, 2078, 1828, 1558, 11245, 25096, 11, 15, 13, 44214, 30460, 4089, 2075, 3865, 2791, 2078, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 64, 11, 4643, 16886, 7, 15, 13, 35124, 3104, 3324, 21261, 1495, 5332, 1314, 11, 15, 13, 1238, 2154, 3695, 2327, 1795, 5705, 13381, 4008, 628, 198, 220, 220, 220, 7514, 65, 796, 12280, 14520, 3419, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 33459, 22047, 1065, 2079, 15982, 2920, 2996, 11, 15, 13, 4521, 2682, 2154, 5774, 2996, 4531, 1270, 2327, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2682, 2624, 1120, 17544, 20, 2624, 1495, 1558, 11, 15, 13, 4304, 940, 30272, 22172, 38905, 31575, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3324, 33032, 2091, 1238, 4051, 25710, 3510, 11, 15, 13, 2414, 33916, 3270, 39380, 18458, 33808, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2791, 2075, 1731, 44230, 2075, 2425, 46519, 11, 15, 13, 22318, 38850, 1238, 1954, 29059, 43193, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1157, 2670, 15363, 2425, 5705, 23362, 2998, 16, 11, 15, 13, 1157, 2425, 3865, 1558, 33581, 18, 21626, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2857, 24369, 2327, 1495, 24839, 1731, 38205, 11, 15, 13, 22800, 1485, 3459, 36928, 1899, 5824, 2791, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 5607, 1120, 3682, 33042, 26895, 45791, 11, 15, 13, 27936, 1954, 34107, 1415, 3553, 29228, 2414, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2791, 2231, 5607, 2167, 34427, 2548, 1433, 11, 15, 13, 33372, 2857, 17430, 2079, 1264, 5705, 1731, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1821, 2091, 486, 2075, 1065, 3023, 8054, 18, 11, 15, 13, 2791, 5607, 3104, 3559, 1731, 1129, 2857, 2425, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 22, 29059, 486, 3553, 1120, 5237, 1507, 1157, 11, 15, 13, 21719, 2414, 1507, 2816, 18458, 25270, 2791, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 35005, 4521, 2718, 3388, 2327, 3829, 23815, 11, 15, 13, 3104, 33646, 2481, 11623, 1120, 1795, 2091, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 22745, 1314, 2079, 2425, 3388, 3270, 1238, 2718, 11, 15, 13, 2996, 35402, 1983, 23721, 1238, 2414, 2791, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 19214, 24, 2718, 2075, 1558, 3270, 1433, 27203, 11, 15, 13, 23, 2078, 23906, 6469, 1065, 1495, 38391, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1899, 1731, 3553, 2075, 2091, 4761, 1507, 3901, 11, 15, 13, 23, 18638, 20198, 1270, 2598, 4846, 30206, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2154, 1495, 2780, 21261, 2670, 2231, 36680, 11, 15, 13, 5066, 14656, 1821, 24403, 2718, 2425, 4869, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1314, 940, 32066, 2718, 26717, 2414, 48194, 11, 15, 13, 20, 36088, 1129, 2999, 1238, 38569, 30057, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24, 3459, 34483, 40401, 3682, 15711, 3134, 11, 15, 13, 24, 3324, 1983, 1157, 1433, 3134, 25964, 2481, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 26704, 1314, 24096, 18781, 38314, 2481, 11, 15, 13, 2548, 17572, 5607, 1485, 1415, 1485, 1314, 1485, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1954, 24136, 31911, 27037, 1238, 2075, 4521, 11, 15, 13, 3720, 2816, 1959, 5774, 2780, 405, 2718, 4761, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 405, 5774, 2920, 1954, 2075, 4089, 2154, 2425, 2624, 11, 15, 13, 2154, 29769, 2791, 2414, 1954, 25816, 2718, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2623, 2816, 1238, 2996, 4089, 2624, 1899, 35402, 11, 15, 13, 25816, 25540, 2231, 3459, 15363, 2231, 4521, 17, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 23, 3559, 16799, 33032, 2857, 3865, 40090, 11, 15, 13, 42716, 22985, 25964, 2079, 2682, 3695, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24, 3134, 1821, 26598, 2079, 2078, 2079, 1731, 11, 15, 13, 41874, 2414, 2718, 1415, 3023, 17657, 2078, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 48602, 3829, 24409, 39357, 35844, 1983, 11, 15, 13, 3270, 42224, 20809, 2623, 1558, 1731, 5705, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24760, 22172, 2078, 2670, 14877, 24, 2816, 11, 15, 13, 5824, 12762, 15363, 35890, 20233, 2623, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24669, 28694, 3695, 1959, 2718, 1507, 37452, 11, 15, 13, 21, 2718, 1238, 5774, 18897, 15363, 23188, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2931, 2598, 21652, 1959, 1959, 3134, 1828, 1065, 11, 15, 13, 49517, 31952, 1495, 3270, 3134, 27800, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2996, 5824, 1157, 2425, 2718, 2414, 1507, 2598, 11, 15, 13, 45432, 37381, 34808, 1129, 29626, 2931, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 38547, 37747, 11623, 1065, 2079, 8054, 19, 11, 15, 13, 3324, 2075, 4309, 1795, 26717, 4531, 22, 1558, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 23, 1954, 486, 31128, 3134, 1795, 5774, 2624, 11, 15, 13, 24, 1983, 2931, 3388, 42199, 3553, 1954, 2996, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3023, 2548, 4089, 2091, 24693, 22572, 14454, 11, 15, 13, 34135, 4846, 1821, 28771, 4524, 1157, 5999, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 19, 11623, 1157, 5237, 18638, 1795, 32220, 11, 15, 13, 20, 14198, 2670, 3134, 25150, 23815, 3980, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3459, 27412, 2091, 5332, 19442, 1485, 2079, 11, 15, 13, 2425, 12865, 49503, 43950, 21273, 3365, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 4051, 25270, 34229, 42246, 5237, 1558, 11, 15, 13, 4051, 27326, 1238, 4790, 2598, 2425, 4846, 16, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 20, 2857, 34159, 4846, 1954, 4051, 2091, 5824, 11, 15, 13, 2780, 2154, 3720, 1157, 5705, 20356, 3104, 2425, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1120, 2920, 2425, 27720, 1821, 3104, 5705, 11, 15, 13, 45191, 5607, 2154, 1120, 2425, 2598, 33459, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 36657, 22416, 17059, 1433, 4309, 17477, 11, 15, 13, 23, 2075, 34808, 26514, 31128, 1954, 1558, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 20, 2791, 3365, 1731, 38431, 1507, 1983, 486, 11, 15, 13, 2078, 5607, 1314, 5774, 28592, 2075, 1314, 2598, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3388, 3720, 45734, 2414, 1129, 2623, 28857, 11, 15, 13, 3388, 5066, 22579, 2425, 1795, 2791, 22914, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 44103, 6052, 486, 28978, 3324, 29326, 1731, 11, 15, 13, 36629, 1314, 1129, 2075, 3980, 2623, 3270, 4761, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 37309, 1899, 5824, 3104, 1238, 33580, 2682, 11, 15, 13, 3324, 1899, 3324, 7029, 26704, 2718, 3459, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 48894, 5705, 1314, 1433, 2670, 3695, 2718, 11, 15, 13, 2548, 19420, 2414, 34125, 17464, 19707, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 20, 3388, 2857, 3510, 2231, 23516, 1485, 3104, 11, 15, 13, 2999, 1507, 36993, 2075, 18298, 1065, 1828, 1983, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3365, 1157, 35124, 17059, 2075, 4051, 2791, 11, 15, 13, 1983, 3553, 40523, 1270, 1899, 3559, 19880, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 35890, 1821, 4051, 2548, 1795, 3104, 31654, 11, 15, 13, 2327, 2414, 2624, 18781, 12762, 3064, 3865, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 38605, 31046, 3510, 15277, 21, 2414, 5237, 11, 15, 13, 3365, 34251, 1129, 1485, 27728, 1731, 5237, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2713, 2816, 3865, 1157, 3270, 2996, 1415, 4790, 1731, 11, 15, 13, 33057, 43798, 2425, 3104, 4869, 18741, 1065, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 23, 7908, 1238, 3270, 1959, 2548, 34741, 11, 15, 13, 20, 35844, 2425, 2682, 2623, 2078, 15426, 18, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1433, 1270, 2791, 7410, 4521, 940, 46660, 11, 15, 13, 17, 19707, 22996, 1821, 1495, 18444, 20356, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2548, 21652, 1954, 2481, 12762, 1157, 1485, 11, 15, 13, 2920, 4531, 1959, 2154, 38605, 2713, 3388, 2075, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3365, 3720, 1120, 4089, 1433, 21599, 22985, 11, 15, 13, 31495, 1433, 3553, 1828, 24038, 2682, 4531, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3720, 3312, 36928, 18376, 1314, 2670, 2682, 11, 15, 13, 1828, 940, 2623, 26717, 3365, 3720, 21526, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 38605, 30803, 2857, 3829, 3134, 5332, 1065, 11, 15, 13, 3510, 1821, 2425, 1731, 26279, 36928, 1065, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 41706, 20666, 47941, 1954, 1120, 39647, 11, 15, 13, 25838, 5824, 31496, 33438, 1129, 3312, 1731, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3980, 21719, 20, 25674, 2091, 2920, 11623, 11, 15, 13, 23, 3104, 4089, 3388, 1954, 4790, 38172, 2996, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24, 3312, 1238, 3695, 2154, 5066, 2078, 40523, 11, 15, 13, 3270, 2075, 26279, 2078, 1157, 24943, 1558, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 21895, 3104, 1507, 3312, 2079, 33638, 2624, 11, 15, 13, 2154, 5607, 3510, 1415, 1120, 4531, 19, 22042, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1954, 3510, 1983, 4089, 1415, 5824, 2075, 39761, 11, 15, 13, 21, 30995, 2414, 3324, 37309, 2791, 30695, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 23, 24840, 19504, 26276, 38431, 2548, 11, 15, 13, 1821, 27260, 32128, 2425, 4349, 1270, 5999, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2548, 1314, 12762, 17059, 3134, 32869, 1558, 11, 15, 13, 46352, 18638, 1507, 2078, 19104, 31380, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1314, 486, 6052, 1959, 2931, 3270, 40675, 1731, 11, 15, 13, 3682, 1157, 35890, 2481, 1270, 1495, 4089, 18, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 5999, 1899, 34256, 2414, 1795, 2718, 34583, 11, 15, 13, 45310, 1959, 2078, 6052, 405, 3270, 2998, 32196, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 18, 23451, 2598, 1433, 2598, 22148, 19, 22413, 11, 15, 13, 1157, 4761, 1485, 5607, 2780, 1238, 2718, 33646, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2670, 18742, 28688, 2682, 2791, 37988, 2718, 11, 15, 13, 405, 1433, 27696, 29211, 2075, 5999, 24970, 2548, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2920, 1731, 1433, 28933, 1485, 1065, 1270, 3134, 11, 15, 13, 23, 25870, 940, 2414, 2154, 33781, 2718, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2078, 5332, 2075, 31046, 2920, 1983, 1415, 2816, 11, 15, 13, 48645, 2231, 1157, 35844, 20233, 22047, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 5066, 1238, 34294, 3510, 1899, 2548, 1485, 11, 15, 13, 44230, 1415, 940, 1959, 1828, 18741, 1959, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24, 4524, 22914, 1495, 3510, 2682, 1238, 2231, 11, 15, 13, 1507, 1495, 33981, 1065, 2414, 1433, 3720, 1558, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3553, 36928, 23539, 1433, 2078, 1433, 2999, 11, 15, 13, 21315, 3720, 22291, 2075, 1795, 1238, 35378, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 21, 1264, 2713, 2780, 940, 2857, 3104, 1959, 11, 15, 13, 15, 2079, 1415, 3829, 2920, 6200, 4310, 31115, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 5237, 1129, 28694, 3559, 1485, 2718, 33042, 11, 15, 13, 1314, 14656, 27310, 1485, 31495, 40639, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 30995, 1433, 1731, 2623, 3720, 2920, 2231, 4524, 11, 15, 13, 405, 36445, 29022, 1157, 940, 30743, 23237, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 40523, 2713, 5999, 38314, 2931, 2857, 3104, 11, 15, 13, 2682, 1821, 17885, 2682, 22579, 2548, 3510, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 24, 3324, 5332, 1065, 2718, 24669, 31102, 17, 11, 15, 13, 3553, 2598, 2414, 21139, 27019, 2623, 3134, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 405, 27326, 47521, 23045, 38314, 18376, 1415, 11, 15, 13, 21, 18294, 30803, 2075, 19880, 2548, 4790, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2682, 5999, 27033, 2079, 1495, 3980, 2623, 1495, 11, 15, 13, 26429, 2078, 4304, 1507, 30557, 27693, 2327, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1959, 2998, 21738, 2624, 17279, 2154, 3901, 11, 15, 13, 20, 2682, 486, 2327, 3324, 1270, 3720, 22709, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1065, 31714, 14454, 1983, 2624, 1731, 22337, 11, 15, 13, 3459, 25764, 4531, 1821, 3324, 4524, 20198, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 4089, 4304, 1507, 35890, 1415, 4790, 13348, 11, 15, 13, 3270, 1120, 14877, 23539, 2425, 1433, 6052, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2167, 3104, 2623, 4531, 3324, 21536, 4846, 11, 15, 13, 43489, 1954, 1959, 405, 1065, 2548, 4310, 2425, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1731, 2780, 1954, 34626, 1954, 1270, 1238, 1731, 11, 15, 13, 1157, 3510, 37988, 2682, 2996, 1731, 1954, 5237, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2078, 1507, 20986, 2078, 940, 6469, 1795, 4790, 11, 15, 13, 1238, 14877, 21536, 6052, 38219, 31675, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 15, 3134, 2091, 1507, 2791, 34125, 3865, 27137, 11, 15, 13, 2231, 405, 1433, 2327, 4304, 38314, 2996, 6052, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 23349, 1983, 2791, 20198, 1485, 3459, 20107, 11, 15, 13, 2327, 1238, 6200, 1959, 4846, 1558, 30120, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3270, 1983, 4524, 1415, 38073, 2598, 50165, 11, 15, 13, 5332, 25191, 1415, 1959, 3559, 25270, 1433, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 26704, 4521, 20809, 1821, 8054, 50148, 11, 15, 13, 19, 24760, 2996, 28771, 2791, 24909, 36088, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3270, 940, 34294, 1415, 23148, 13348, 11, 15, 13, 2327, 23349, 17572, 3459, 2327, 17572, 22, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 39132, 2791, 19504, 23, 3104, 2624, 26492, 11, 15, 13, 20, 2682, 5066, 2425, 3388, 3553, 1558, 34808, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 27712, 2791, 1065, 1558, 1415, 3553, 1120, 1983, 11, 15, 13, 3365, 2231, 22148, 24, 19442, 18444, 2623, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 23, 3388, 1314, 5774, 27277, 2548, 1731, 5237, 11, 15, 13, 32637, 1485, 2598, 3134, 2327, 2327, 14686, 21, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 21734, 1129, 28296, 2682, 5774, 28645, 11, 15, 13, 18741, 4761, 1731, 2919, 6052, 1120, 3459, 2327, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2718, 4304, 39647, 2682, 16102, 1238, 22318, 11, 15, 13, 2713, 22172, 3559, 2078, 3324, 40173, 1415, 5705, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2231, 4309, 1065, 3459, 1270, 2816, 1495, 2091, 11, 15, 13, 23237, 2327, 22515, 1270, 3510, 1828, 4089, 17, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1433, 1485, 1433, 1129, 46900, 21273, 37688, 11, 15, 13, 33372, 1065, 1065, 29022, 1433, 3459, 4310, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1731, 48724, 21273, 37680, 1314, 3865, 1314, 11, 15, 13, 4521, 8784, 1795, 2079, 405, 5999, 22047, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 22, 30336, 2091, 1433, 27326, 2857, 39111, 11, 15, 13, 45720, 2425, 4531, 1828, 31916, 1495, 2079, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 3070, 1120, 2231, 2780, 4790, 1120, 3134, 30743, 11, 15, 13, 1899, 1959, 3388, 43704, 2682, 2996, 34626, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 2079, 3865, 3559, 2598, 3324, 1485, 1314, 4869, 11, 15, 13, 2682, 2079, 3104, 1899, 2079, 2816, 940, 3365, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 1795, 27211, 31496, 1129, 1270, 5066, 2481, 11, 15, 13, 1558, 17032, 2623, 1238, 2920, 3324, 486, 4846, 4008, 198, 220, 220, 220, 4574, 0, 7, 35428, 65, 11, 4643, 16886, 7, 15, 13, 22, 3510, 32869, 1129, 2816, 1731, 1821, 2920, 11, 15, 13, 26073, 2079, 38472, 22, 2682, 21738, 2327, 4008, 628, 220, 220, 220, 2482, 796, 16246, 7, 35428, 64, 11, 7514, 65, 8, 198, 437, 198, 198, 448, 7753, 796, 350, 10025, 13, 15908, 7203, 34220, 14520, 2601, 4501, 4943, 9, 1, 14, 525, 69, 14, 3849, 5458, 16, 62, 26968, 14306, 13, 40664, 1, 198, 198, 448, 796, 18335, 7, 3849, 5458, 16, 11, 366, 2601, 4501, 1600, 366, 9492, 5458, 352, 1600, 838, 8, 198, 198, 361, 318, 7753, 7, 448, 7753, 8, 198, 220, 220, 220, 2180, 796, 1100, 11487, 7, 448, 7753, 8, 198, 220, 220, 220, 503, 796, 410, 9246, 7, 3866, 1442, 11, 503, 8, 198, 437, 198, 8933, 316, 540, 7, 448, 7753, 11, 503, 8, 628 ]
1.953781
6,837
function _is_within_range(query_start, query_length, target_start, target_length) target_start <= query_start <= query_start - 1 + query_length <= target_start - 1 + target_length end abstract type Overlap end struct ExactMatch <: Overlap end struct LeftNeighbor <: Overlap end struct RightNeighbor <: Overlap end struct Disjunct <: Overlap end struct Within <: Overlap end struct WithinFromStart <: Overlap end struct WithinToEnd <: Overlap end struct CompleteOverlap <: Overlap end struct LeftOverlap <: Overlap end struct RightOverlap <: Overlap end function _determine_overlap(query_start, query_length, target_start, target_length) query_end = query_start - 1 + query_length target_end = target_start - 1 + target_length if query_start == target_start && query_length == target_length ExactMatch() elseif query_end == target_start - 1 LeftNeighbor() elseif query_start == target_end + 1 RightNeighbor() elseif query_end < target_start || target_end < query_start Disjunct() elseif target_start == query_start <= query_end < target_end WithinFromStart() elseif target_start < query_start <= query_end == target_end WithinToEnd() elseif target_start < query_start <= query_end < target_end Within() elseif query_start < target_start <= query_end <= target_end LeftOverlap() elseif target_start <= query_start <= target_end < query_end RightOverlap() elseif query_start < target_start <= target_end < query_end CompleteOverlap() else println(query_start, " ", query_length, " ", target_start, " ", target_length) @assert false end end
[ 8818, 4808, 271, 62, 33479, 62, 9521, 7, 22766, 62, 9688, 11, 12405, 62, 13664, 11, 2496, 62, 9688, 11, 2496, 62, 13664, 8, 198, 220, 220, 220, 2496, 62, 9688, 19841, 12405, 62, 9688, 19841, 12405, 62, 9688, 532, 352, 1343, 12405, 62, 13664, 19841, 2496, 62, 9688, 532, 352, 1343, 2496, 62, 13664, 198, 437, 198, 198, 397, 8709, 2099, 3827, 37796, 886, 198, 7249, 1475, 529, 23850, 1279, 25, 3827, 37796, 886, 198, 7249, 9578, 46445, 2865, 1279, 25, 3827, 37796, 886, 198, 7249, 6498, 46445, 2865, 1279, 25, 3827, 37796, 886, 198, 7249, 3167, 73, 16260, 1279, 25, 3827, 37796, 886, 198, 7249, 12511, 1279, 25, 3827, 37796, 886, 198, 7249, 12511, 4863, 10434, 1279, 25, 3827, 37796, 886, 198, 7249, 12511, 2514, 12915, 1279, 25, 3827, 37796, 886, 198, 7249, 13248, 5886, 37796, 1279, 25, 3827, 37796, 886, 198, 7249, 9578, 5886, 37796, 1279, 25, 3827, 37796, 886, 198, 7249, 6498, 5886, 37796, 1279, 25, 3827, 37796, 886, 198, 198, 8818, 4808, 67, 2357, 3810, 62, 2502, 37796, 7, 22766, 62, 9688, 11, 12405, 62, 13664, 11, 2496, 62, 9688, 11, 2496, 62, 13664, 8, 198, 220, 220, 220, 12405, 62, 437, 796, 12405, 62, 9688, 532, 352, 1343, 12405, 62, 13664, 198, 220, 220, 220, 2496, 62, 437, 796, 2496, 62, 9688, 532, 352, 1343, 2496, 62, 13664, 628, 220, 220, 220, 611, 12405, 62, 9688, 6624, 2496, 62, 9688, 11405, 12405, 62, 13664, 6624, 2496, 62, 13664, 198, 220, 220, 220, 220, 220, 220, 220, 1475, 529, 23850, 3419, 198, 220, 220, 220, 2073, 361, 12405, 62, 437, 6624, 2496, 62, 9688, 532, 352, 198, 220, 220, 220, 220, 220, 220, 220, 9578, 46445, 2865, 3419, 198, 220, 220, 220, 2073, 361, 12405, 62, 9688, 6624, 2496, 62, 437, 1343, 352, 198, 220, 220, 220, 220, 220, 220, 220, 6498, 46445, 2865, 3419, 198, 220, 220, 220, 2073, 361, 12405, 62, 437, 1279, 2496, 62, 9688, 8614, 2496, 62, 437, 1279, 12405, 62, 9688, 198, 220, 220, 220, 220, 220, 220, 220, 3167, 73, 16260, 3419, 198, 220, 220, 220, 2073, 361, 2496, 62, 9688, 6624, 12405, 62, 9688, 19841, 12405, 62, 437, 1279, 2496, 62, 437, 198, 220, 220, 220, 220, 220, 220, 220, 12511, 4863, 10434, 3419, 198, 220, 220, 220, 2073, 361, 2496, 62, 9688, 1279, 12405, 62, 9688, 19841, 12405, 62, 437, 6624, 2496, 62, 437, 198, 220, 220, 220, 220, 220, 220, 220, 12511, 2514, 12915, 3419, 198, 220, 220, 220, 2073, 361, 2496, 62, 9688, 1279, 12405, 62, 9688, 19841, 12405, 62, 437, 220, 1279, 2496, 62, 437, 198, 220, 220, 220, 220, 220, 220, 220, 12511, 3419, 198, 220, 220, 220, 2073, 361, 12405, 62, 9688, 1279, 2496, 62, 9688, 19841, 12405, 62, 437, 19841, 2496, 62, 437, 198, 220, 220, 220, 220, 220, 220, 220, 9578, 5886, 37796, 3419, 198, 220, 220, 220, 2073, 361, 2496, 62, 9688, 19841, 12405, 62, 9688, 19841, 2496, 62, 437, 1279, 12405, 62, 437, 198, 220, 220, 220, 220, 220, 220, 220, 6498, 5886, 37796, 3419, 198, 220, 220, 220, 2073, 361, 12405, 62, 9688, 1279, 2496, 62, 9688, 19841, 2496, 62, 437, 220, 1279, 12405, 62, 437, 198, 220, 220, 220, 220, 220, 220, 220, 13248, 5886, 37796, 3419, 198, 220, 220, 220, 2073, 198, 220, 220, 220, 220, 220, 220, 220, 44872, 7, 22766, 62, 9688, 11, 366, 33172, 12405, 62, 13664, 11, 366, 33172, 2496, 62, 9688, 11, 366, 33172, 2496, 62, 13664, 8, 198, 220, 220, 220, 220, 220, 220, 220, 2488, 30493, 3991, 198, 220, 220, 220, 886, 198, 437 ]
2.847315
596
""" simpledown Compute the mesh topology structures that correspond to just the downward adjacency between the tetrahedra and the vertices. Memory is used only to store the incidence relation and the locations of the vertices. """ module simpledown using StaticArrays using MeshCore: nvertices, nshapes, manifdim, attribute using MeshCore: ir_skeleton, ir_bbyfacets, ir_transpose using MeshSteward: vtkwrite, T4block using BenchmarkTools using Test include("usedbytes.jl") function test() n = 3 membytes = 0; summembytes = 0 @info "Initial (3, 0)" @time connectivity = T4block(1.0, 2.0, 3.0, n*7, n*9, n*10, :a; intbytes = 4) ir30 = connectivity @show "($(manifdim(ir30.left)), $(manifdim(ir30.right)))" @show (nshapes(ir30.left), nshapes(ir30.right)) @show membytes = usedbytes(ir30._v) summembytes += membytes geom = attribute(ir30.right, "geom") @show membytes = usedbytes(geom.v) summembytes += membytes # Print the total number of megabytes used to store the database @show summembytes/2^20 # vtkwrite("speedtest1", connectivity) true end end using .simpledown # using BenchmarkTools # @btime simpledown.test() simpledown.test()
[ 37811, 198, 220, 220, 220, 7106, 276, 593, 198, 198, 7293, 1133, 262, 19609, 1353, 1435, 8573, 326, 6053, 284, 655, 262, 20841, 198, 324, 30482, 1387, 1022, 262, 28408, 430, 704, 430, 290, 262, 9421, 1063, 13, 198, 30871, 318, 973, 691, 284, 3650, 262, 18349, 8695, 290, 262, 7064, 286, 262, 198, 1851, 1063, 13, 198, 37811, 198, 21412, 7106, 276, 593, 198, 3500, 36125, 3163, 20477, 198, 3500, 47529, 14055, 25, 299, 1851, 1063, 11, 299, 1477, 7916, 11, 19871, 27740, 11, 11688, 198, 3500, 47529, 14055, 25, 4173, 62, 82, 38800, 11, 4173, 62, 65, 1525, 38942, 1039, 11, 4173, 62, 7645, 3455, 198, 3500, 47529, 49328, 446, 25, 410, 30488, 13564, 11, 309, 19, 9967, 198, 3500, 25187, 4102, 33637, 198, 3500, 6208, 198, 198, 17256, 7203, 1484, 33661, 13, 20362, 4943, 198, 198, 8818, 1332, 3419, 198, 220, 220, 220, 299, 796, 513, 198, 220, 220, 220, 1066, 33661, 796, 657, 26, 2160, 11883, 33661, 796, 657, 198, 220, 220, 220, 2488, 10951, 366, 24243, 357, 18, 11, 657, 16725, 198, 220, 220, 220, 2488, 2435, 19843, 796, 309, 19, 9967, 7, 16, 13, 15, 11, 362, 13, 15, 11, 513, 13, 15, 11, 299, 9, 22, 11, 299, 9, 24, 11, 299, 9, 940, 11, 1058, 64, 26, 493, 33661, 796, 604, 8, 198, 220, 220, 220, 4173, 1270, 796, 19843, 198, 220, 220, 220, 2488, 12860, 366, 16763, 7, 805, 361, 27740, 7, 343, 1270, 13, 9464, 36911, 29568, 805, 361, 27740, 7, 343, 1270, 13, 3506, 4008, 16725, 198, 220, 220, 220, 2488, 12860, 357, 77, 1477, 7916, 7, 343, 1270, 13, 9464, 828, 299, 1477, 7916, 7, 343, 1270, 13, 3506, 4008, 198, 220, 220, 220, 2488, 12860, 1066, 33661, 796, 973, 33661, 7, 343, 1270, 13557, 85, 8, 198, 220, 220, 220, 2160, 11883, 33661, 15853, 1066, 33661, 198, 220, 220, 220, 4903, 296, 796, 11688, 7, 343, 1270, 13, 3506, 11, 366, 469, 296, 4943, 198, 220, 220, 220, 2488, 12860, 1066, 33661, 796, 973, 33661, 7, 469, 296, 13, 85, 8, 198, 220, 220, 220, 2160, 11883, 33661, 15853, 1066, 33661, 628, 220, 220, 220, 1303, 12578, 262, 2472, 1271, 286, 17243, 38346, 973, 284, 3650, 262, 6831, 198, 220, 220, 220, 2488, 12860, 2160, 11883, 33661, 14, 17, 61, 1238, 628, 220, 220, 220, 1303, 410, 30488, 13564, 7203, 12287, 9288, 16, 1600, 19843, 8, 198, 220, 220, 220, 2081, 198, 437, 198, 437, 198, 3500, 764, 14323, 10137, 593, 198, 2, 1262, 25187, 4102, 33637, 198, 2, 2488, 65, 2435, 7106, 276, 593, 13, 9288, 3419, 198, 14323, 10137, 593, 13, 9288, 3419, 198 ]
2.749431
439
function hello() # println("Hello, World!") return "Hello, World!" end
[ 8818, 23748, 3419, 198, 220, 220, 220, 1303, 44872, 7203, 15496, 11, 2159, 2474, 8, 198, 220, 220, 220, 1441, 366, 15496, 11, 2159, 2474, 198, 437, 198 ]
2.821429
28
using CharFuncPricing, TaylorSeries @testset "CumulantsJoshi" begin κ = 4.0 θ = 0.25 σ = 1.0 ρ = -0.5 v0 = 0.01 τ = 0.01 params = HestonParams{Float64}(v0, κ, θ, ρ, σ) cf = DefaultCharFunc{HestonParams{Float64},Taylor1{Complex}}(params) t = Taylor1(Float64, 4) cft = CharFuncPricing.evaluateLogCharFuncCui(cf, t, τ) c1, c2, c4 = computeCumulants(params, τ) println(c1, " ", c2 / 2, " ", c4 / (2 * 3 * 4), " ", cft) @test isapprox(imag(cft.coeffs[2]), c1, atol = 1e-12) @test isapprox(-real(cft.coeffs[3]) * 2, c2, atol = 1e-12) @test isapprox(cft.coeffs[5] * 2 * 3 * 4, c4, atol = 1e-16) end @testset "CumulantsAlan" begin κ = 4.0 θ = 0.25 σ = 1.0 ρ = -0.5 v0 = 0.04 τ = 1.0 params = HestonParams{Float64}(v0, κ, θ, ρ, σ) cf = DefaultCharFunc{HestonParams{Float64},Taylor1{Complex}}(params) t = Taylor1(Float64, 4) cft = CharFuncPricing.evaluateLogCharFuncCui(cf, t, τ) c1, c2, c4 = computeCumulants(params, τ) println(c1, " ", c2 / 2, " ", c4 / (2 * 3 * 4), " ", cft) @test isapprox(imag(cft.coeffs[2]), c1, atol = 1e-12) @test isapprox(-real(cft.coeffs[3]) * 2, c2, atol = 1e-12) @test isapprox(cft.coeffs[5] * 2 * 3 * 4, c4, atol = 1e-15) end @testset "CumulantsNearZeroKappa" begin #Low accuracy with small kappa due to powers of kappa in the denominator. κ = 0.02 θ = 0.25 σ = 1.0 ρ = -0.5 v0 = 0.04 τ = 1.0 params = HestonParams{Float64}(v0, κ, θ, ρ, σ) cf = DefaultCharFunc{HestonParams{Float64},Taylor1{Complex}}(params) t = Taylor1(Float64, 4) cft = CharFuncPricing.evaluateLogCharFuncCui(cf, t, τ) c1, c2, c4 = computeCumulants(params, τ) println(c1, " ", c2 / 2, " ", c4 / (2 * 3 * 4), " ", cft) @test isapprox(imag(cft.coeffs[2]), c1, atol = 1e-12) @test isapprox(-real(cft.coeffs[3]) * 2, c2, atol = 1e-3) @test isapprox(cft.coeffs[5] * 2 * 3 * 4, c4, atol = 1e-3) end
[ 3500, 3178, 37, 19524, 47, 1173, 278, 11, 8121, 27996, 198, 198, 31, 9288, 2617, 366, 34, 388, 377, 1187, 41, 13704, 1, 2221, 198, 220, 220, 220, 7377, 118, 796, 604, 13, 15, 198, 220, 220, 220, 7377, 116, 796, 657, 13, 1495, 198, 220, 220, 220, 18074, 225, 796, 352, 13, 15, 198, 220, 220, 220, 18074, 223, 796, 532, 15, 13, 20, 198, 220, 220, 220, 410, 15, 796, 657, 13, 486, 198, 220, 220, 220, 46651, 796, 657, 13, 486, 198, 220, 220, 220, 42287, 796, 367, 19115, 10044, 4105, 90, 43879, 2414, 92, 7, 85, 15, 11, 7377, 118, 11, 7377, 116, 11, 18074, 223, 11, 18074, 225, 8, 198, 220, 220, 220, 30218, 796, 15161, 12441, 37, 19524, 90, 39, 19115, 10044, 4105, 90, 43879, 2414, 5512, 29907, 16, 90, 5377, 11141, 11709, 7, 37266, 8, 198, 220, 220, 220, 256, 796, 8121, 16, 7, 43879, 2414, 11, 604, 8, 198, 220, 220, 220, 269, 701, 796, 3178, 37, 19524, 47, 1173, 278, 13, 49786, 11187, 12441, 37, 19524, 34, 9019, 7, 12993, 11, 256, 11, 46651, 8, 198, 220, 220, 220, 269, 16, 11, 269, 17, 11, 269, 19, 796, 24061, 34, 388, 377, 1187, 7, 37266, 11, 46651, 8, 198, 220, 220, 220, 44872, 7, 66, 16, 11, 366, 33172, 269, 17, 1220, 362, 11, 366, 33172, 269, 19, 1220, 357, 17, 1635, 513, 1635, 604, 828, 366, 33172, 269, 701, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 48466, 7, 66, 701, 13, 1073, 14822, 82, 58, 17, 46570, 269, 16, 11, 379, 349, 796, 352, 68, 12, 1065, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 32590, 5305, 7, 66, 701, 13, 1073, 14822, 82, 58, 18, 12962, 1635, 362, 11, 269, 17, 11, 379, 349, 796, 352, 68, 12, 1065, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 66, 701, 13, 1073, 14822, 82, 58, 20, 60, 1635, 362, 1635, 513, 1635, 604, 11, 269, 19, 11, 379, 349, 796, 352, 68, 12, 1433, 8, 198, 437, 198, 31, 9288, 2617, 366, 34, 388, 377, 1187, 36235, 1, 2221, 198, 220, 220, 220, 7377, 118, 796, 604, 13, 15, 198, 220, 220, 220, 7377, 116, 796, 657, 13, 1495, 198, 220, 220, 220, 18074, 225, 796, 352, 13, 15, 198, 220, 220, 220, 18074, 223, 796, 532, 15, 13, 20, 198, 220, 220, 220, 410, 15, 796, 657, 13, 3023, 198, 220, 220, 220, 46651, 796, 352, 13, 15, 198, 220, 220, 220, 42287, 796, 367, 19115, 10044, 4105, 90, 43879, 2414, 92, 7, 85, 15, 11, 7377, 118, 11, 7377, 116, 11, 18074, 223, 11, 18074, 225, 8, 198, 220, 220, 220, 30218, 796, 15161, 12441, 37, 19524, 90, 39, 19115, 10044, 4105, 90, 43879, 2414, 5512, 29907, 16, 90, 5377, 11141, 11709, 7, 37266, 8, 198, 220, 220, 220, 256, 796, 8121, 16, 7, 43879, 2414, 11, 604, 8, 198, 220, 220, 220, 269, 701, 796, 3178, 37, 19524, 47, 1173, 278, 13, 49786, 11187, 12441, 37, 19524, 34, 9019, 7, 12993, 11, 256, 11, 46651, 8, 198, 220, 220, 220, 269, 16, 11, 269, 17, 11, 269, 19, 796, 24061, 34, 388, 377, 1187, 7, 37266, 11, 46651, 8, 198, 220, 220, 220, 44872, 7, 66, 16, 11, 366, 33172, 269, 17, 1220, 362, 11, 366, 33172, 269, 19, 1220, 357, 17, 1635, 513, 1635, 604, 828, 366, 33172, 269, 701, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 48466, 7, 66, 701, 13, 1073, 14822, 82, 58, 17, 46570, 269, 16, 11, 379, 349, 796, 352, 68, 12, 1065, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 32590, 5305, 7, 66, 701, 13, 1073, 14822, 82, 58, 18, 12962, 1635, 362, 11, 269, 17, 11, 379, 349, 796, 352, 68, 12, 1065, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 66, 701, 13, 1073, 14822, 82, 58, 20, 60, 1635, 362, 1635, 513, 1635, 604, 11, 269, 19, 11, 379, 349, 796, 352, 68, 12, 1314, 8, 198, 437, 198, 31, 9288, 2617, 366, 34, 388, 377, 1187, 40640, 28667, 42, 20975, 1, 2221, 198, 220, 220, 220, 1303, 20535, 9922, 351, 1402, 479, 20975, 2233, 284, 5635, 286, 479, 20975, 287, 262, 31457, 1352, 13, 198, 220, 220, 220, 7377, 118, 796, 657, 13, 2999, 198, 220, 220, 220, 7377, 116, 796, 657, 13, 1495, 198, 220, 220, 220, 18074, 225, 796, 352, 13, 15, 198, 220, 220, 220, 18074, 223, 796, 532, 15, 13, 20, 198, 220, 220, 220, 410, 15, 796, 657, 13, 3023, 198, 220, 220, 220, 46651, 796, 352, 13, 15, 198, 220, 220, 220, 42287, 796, 367, 19115, 10044, 4105, 90, 43879, 2414, 92, 7, 85, 15, 11, 7377, 118, 11, 7377, 116, 11, 18074, 223, 11, 18074, 225, 8, 198, 220, 220, 220, 30218, 796, 15161, 12441, 37, 19524, 90, 39, 19115, 10044, 4105, 90, 43879, 2414, 5512, 29907, 16, 90, 5377, 11141, 11709, 7, 37266, 8, 198, 220, 220, 220, 256, 796, 8121, 16, 7, 43879, 2414, 11, 604, 8, 198, 220, 220, 220, 269, 701, 796, 3178, 37, 19524, 47, 1173, 278, 13, 49786, 11187, 12441, 37, 19524, 34, 9019, 7, 12993, 11, 256, 11, 46651, 8, 198, 220, 220, 220, 269, 16, 11, 269, 17, 11, 269, 19, 796, 24061, 34, 388, 377, 1187, 7, 37266, 11, 46651, 8, 198, 220, 220, 220, 44872, 7, 66, 16, 11, 366, 33172, 269, 17, 1220, 362, 11, 366, 33172, 269, 19, 1220, 357, 17, 1635, 513, 1635, 604, 828, 366, 33172, 269, 701, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 48466, 7, 66, 701, 13, 1073, 14822, 82, 58, 17, 46570, 269, 16, 11, 379, 349, 796, 352, 68, 12, 1065, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 32590, 5305, 7, 66, 701, 13, 1073, 14822, 82, 58, 18, 12962, 1635, 362, 11, 269, 17, 11, 379, 349, 796, 352, 68, 12, 18, 8, 198, 220, 220, 220, 2488, 9288, 318, 1324, 13907, 7, 66, 701, 13, 1073, 14822, 82, 58, 20, 60, 1635, 362, 1635, 513, 1635, 604, 11, 269, 19, 11, 379, 349, 796, 352, 68, 12, 18, 8, 198, 437, 198 ]
1.891346
1,040
using DrWatson @quickactivate "NonlinearDynamicsTextbook" include(srcdir("colorscheme.jl")) using InteractiveDynamics, DynamicalSystems import GLMakie xmax = 1.0 xmin = -1.0 ymin = -1.0 ymax = 1.0 d = 50 const a = 1.4 const b = 0.3 ics = [ SVector(x, y) for x in range(xmin, xmax; length = d) for y in range(ymin, ymax; length = d) ] f1(u) = SVector(u[1], 1 - a*u[1]^2 + u[2]) f2(u) = SVector(b*u[1], u[2]) f3(u) = SVector(u[2], u[1]) function three_phases(ics) p1 = f1.(ics) p2 = f2.(p1) p3 = f3.(p2) return p1, p2, p3 end function linear_transition!(o, p1, p2, steps, io) for i in 1:steps # assumes we start with o[] = p1 o[] = p1 .+ (p2 .- p1) .* i/steps GLMakie.recordframe!(io) # sleep(0.01) # change to record frame end end iterations = 10 steps = 20 fig = GLMakie.Figure(); display(fig) ax = GLMakie.Axis(fig[1,1]) o = GLMakie.Observable(ics) GLMakie.scatter!(ax, o; color = COLORS[1], strokewidth = 0.5, strokecolor = :black, markersize = 5 ) ax.limits = ((-2.5,2.5),(-1.5,1.5)) GLMakie.record(fig, string(@__FILE__)[1:end-2]*"mp4"; framerate = 30) do io for j in 1:iterations p1, p2, p3 = three_phases(ics) linear_transition!(o, ics, p1, steps, io) GLMakie.recordframe!(io) linear_transition!(o, p1, p2, steps, io) GLMakie.recordframe!(io) linear_transition!(o, p2, p3, steps, io) GLMakie.recordframe!(io) global ics = p3 GLMakie.recordframe!(io) end end
[ 3500, 1583, 54, 13506, 198, 31, 24209, 39022, 366, 15419, 29127, 35, 4989, 873, 8206, 2070, 1, 198, 17256, 7, 10677, 15908, 7203, 4033, 26164, 1326, 13, 20362, 48774, 198, 3500, 21365, 35, 4989, 873, 11, 14970, 605, 11964, 82, 198, 11748, 10188, 44, 461, 494, 198, 198, 87, 9806, 796, 352, 13, 15, 198, 87, 1084, 796, 532, 16, 13, 15, 198, 88, 1084, 796, 532, 16, 13, 15, 198, 4948, 897, 796, 352, 13, 15, 198, 67, 796, 2026, 198, 9979, 257, 796, 352, 13, 19, 198, 9979, 275, 796, 657, 13, 18, 198, 198, 873, 796, 685, 198, 220, 220, 220, 20546, 9250, 7, 87, 11, 331, 8, 329, 2124, 287, 2837, 7, 87, 1084, 11, 2124, 9806, 26, 4129, 796, 288, 8, 329, 331, 287, 2837, 7, 88, 1084, 11, 331, 9806, 26, 4129, 796, 288, 8, 198, 60, 198, 198, 69, 16, 7, 84, 8, 796, 20546, 9250, 7, 84, 58, 16, 4357, 352, 532, 257, 9, 84, 58, 16, 60, 61, 17, 1343, 334, 58, 17, 12962, 198, 69, 17, 7, 84, 8, 796, 20546, 9250, 7, 65, 9, 84, 58, 16, 4357, 334, 58, 17, 12962, 198, 69, 18, 7, 84, 8, 796, 20546, 9250, 7, 84, 58, 17, 4357, 334, 58, 16, 12962, 198, 8818, 1115, 62, 746, 1386, 7, 873, 8, 198, 220, 220, 220, 279, 16, 796, 277, 16, 12195, 873, 8, 198, 220, 220, 220, 279, 17, 796, 277, 17, 12195, 79, 16, 8, 198, 220, 220, 220, 279, 18, 796, 277, 18, 12195, 79, 17, 8, 198, 220, 220, 220, 1441, 279, 16, 11, 279, 17, 11, 279, 18, 198, 437, 198, 198, 8818, 14174, 62, 7645, 653, 0, 7, 78, 11, 279, 16, 11, 279, 17, 11, 4831, 11, 33245, 8, 198, 220, 220, 220, 329, 1312, 287, 352, 25, 20214, 1303, 18533, 356, 923, 351, 267, 21737, 796, 279, 16, 198, 220, 220, 220, 220, 220, 220, 220, 267, 21737, 796, 279, 16, 764, 10, 357, 79, 17, 764, 12, 279, 16, 8, 764, 9, 1312, 14, 20214, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 44, 461, 494, 13, 22105, 14535, 0, 7, 952, 8, 198, 220, 220, 220, 220, 220, 220, 220, 1303, 3993, 7, 15, 13, 486, 8, 1303, 1487, 284, 1700, 5739, 198, 220, 220, 220, 886, 198, 437, 198, 198, 2676, 602, 796, 838, 198, 20214, 796, 1160, 198, 198, 5647, 796, 10188, 44, 461, 494, 13, 11337, 9783, 3359, 7, 5647, 8, 198, 897, 796, 10188, 44, 461, 494, 13, 31554, 271, 7, 5647, 58, 16, 11, 16, 12962, 198, 78, 796, 10188, 44, 461, 494, 13, 31310, 712, 540, 7, 873, 8, 198, 8763, 44, 461, 494, 13, 1416, 1436, 0, 7, 897, 11, 267, 26, 220, 198, 220, 220, 220, 3124, 796, 20444, 20673, 58, 16, 4357, 14000, 10394, 796, 657, 13, 20, 11, 14000, 8043, 796, 1058, 13424, 11, 19736, 1096, 796, 642, 198, 8, 198, 897, 13, 49196, 796, 14808, 12, 17, 13, 20, 11, 17, 13, 20, 828, 32590, 16, 13, 20, 11, 16, 13, 20, 4008, 198, 198, 8763, 44, 461, 494, 13, 22105, 7, 5647, 11, 4731, 7, 31, 834, 25664, 834, 38381, 16, 25, 437, 12, 17, 60, 9, 1, 3149, 19, 8172, 5346, 21620, 796, 1542, 8, 466, 33245, 198, 220, 220, 220, 329, 474, 287, 352, 25, 2676, 602, 198, 220, 220, 220, 220, 220, 220, 220, 279, 16, 11, 279, 17, 11, 279, 18, 796, 1115, 62, 746, 1386, 7, 873, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14174, 62, 7645, 653, 0, 7, 78, 11, 220, 873, 11, 279, 16, 11, 4831, 11, 33245, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 44, 461, 494, 13, 22105, 14535, 0, 7, 952, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14174, 62, 7645, 653, 0, 7, 78, 11, 279, 16, 11, 279, 17, 11, 4831, 11, 33245, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 44, 461, 494, 13, 22105, 14535, 0, 7, 952, 8, 198, 220, 220, 220, 220, 220, 220, 220, 14174, 62, 7645, 653, 0, 7, 78, 11, 279, 17, 11, 279, 18, 11, 4831, 11, 33245, 8, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 44, 461, 494, 13, 22105, 14535, 0, 7, 952, 8, 198, 220, 220, 220, 220, 220, 220, 220, 3298, 220, 873, 796, 279, 18, 198, 220, 220, 220, 220, 220, 220, 220, 10188, 44, 461, 494, 13, 22105, 14535, 0, 7, 952, 8, 198, 220, 220, 220, 886, 198, 437, 198 ]
1.984211
760