diff options
Diffstat (limited to 'hw7')
-rw-r--r-- | hw7/.DS_Store | bin | 0 -> 8196 bytes | |||
-rw-r--r-- | hw7/5.6-face.png | bin | 0 -> 76602 bytes | |||
-rw-r--r-- | hw7/5.6-fx.png | bin | 0 -> 38040 bytes | |||
-rw-r--r-- | hw7/5.6-fy.png | bin | 0 -> 64046 bytes | |||
-rw-r--r-- | hw7/5.6-phi-field.png | bin | 0 -> 25715 bytes | |||
-rw-r--r-- | hw7/5.6-phi.png | bin | 0 -> 54394 bytes | |||
-rw-r--r-- | hw7/5.6-test.png | bin | 0 -> 26702 bytes | |||
-rw-r--r-- | hw7/5.6.jl | 192 | ||||
-rw-r--r-- | hw7/5.6.png | bin | 0 -> 86224 bytes | |||
-rw-r--r-- | hw7/8-12.jl | 191 | ||||
-rw-r--r-- | hw7/8-15-d.png | bin | 0 -> 30807 bytes | |||
-rw-r--r-- | hw7/8-15-scales-d.png | bin | 0 -> 28596 bytes | |||
-rw-r--r-- | hw7/8-15-scales.png | bin | 0 -> 31626 bytes | |||
-rw-r--r-- | hw7/8-15.jl | 274 | ||||
-rw-r--r-- | hw7/8-15.png | bin | 0 -> 31061 bytes | |||
-rw-r--r-- | hw7/BoundStates.jl | 73 | ||||
-rw-r--r-- | hw7/Laplacians.jl | 145 | ||||
-rw-r--r-- | hw7/RadialBoundStates.jl | 59 | ||||
-rw-r--r-- | hw7/mvsb.svg | 55 | ||||
-rw-r--r-- | hw7/mvsb2.svg | 46 | ||||
-rw-r--r-- | hw7/tightbinding (1).jl | 24 |
21 files changed, 1059 insertions, 0 deletions
diff --git a/hw7/.DS_Store b/hw7/.DS_Store Binary files differnew file mode 100644 index 0000000..9b9f923 --- /dev/null +++ b/hw7/.DS_Store diff --git a/hw7/5.6-face.png b/hw7/5.6-face.png Binary files differnew file mode 100644 index 0000000..b02d8f9 --- /dev/null +++ b/hw7/5.6-face.png diff --git a/hw7/5.6-fx.png b/hw7/5.6-fx.png Binary files differnew file mode 100644 index 0000000..a445d09 --- /dev/null +++ b/hw7/5.6-fx.png diff --git a/hw7/5.6-fy.png b/hw7/5.6-fy.png Binary files differnew file mode 100644 index 0000000..56c38f5 --- /dev/null +++ b/hw7/5.6-fy.png diff --git a/hw7/5.6-phi-field.png b/hw7/5.6-phi-field.png Binary files differnew file mode 100644 index 0000000..3556e4b --- /dev/null +++ b/hw7/5.6-phi-field.png diff --git a/hw7/5.6-phi.png b/hw7/5.6-phi.png Binary files differnew file mode 100644 index 0000000..93b9775 --- /dev/null +++ b/hw7/5.6-phi.png diff --git a/hw7/5.6-test.png b/hw7/5.6-test.png Binary files differnew file mode 100644 index 0000000..58328e6 --- /dev/null +++ b/hw7/5.6-test.png diff --git a/hw7/5.6.jl b/hw7/5.6.jl new file mode 100644 index 0000000..e6f6c8a --- /dev/null +++ b/hw7/5.6.jl @@ -0,0 +1,192 @@ +using Pkg +Pkg.add("Plots") +using Plots + +function del2_5(a::Matrix{Float64}, dx = 1.0) + #= + Returns a finite-difference approximation of the laplacian of the array a, + with lattice spacing dx, using the five-point stencil: + + 0 1 0 + 1 -4 1 + 0 1 0 + =# + + del2 = zeros(size(a)) + del2[2:end-1, 2:end-1] .= (a[2:end-1, 3:end] + a[2:end-1, 1:end-2] + + a[3:end, 2:end-1] + a[1:end-2, 2:end-1] - + 4.0 * a[2:end-1, 2:end-1]) ./ (dx^2) + return del2 +end + +function del2_9(a::Matrix{Float64}, dx = 1.0) + #= + Returns a finite-difference approximation of the laplacian of the array a, + with lattice spacing dx, using the nine-point stencil: + + 1/6 2/3 1/6 + 2/3 -10/3 2/3 + 1/6 2/3 1/6 + =# + + del2 = zeros(size(a)) + del2[2:end-1, 2:end-1] .= (4.0 * (a[2:end-1, 3:end] + a[2:end-1, 1:end-2] + + a[3:end, 2:end-1] + a[1:end-2, 2:end-1]) + + (a[1:end-2, 1:end-2] + a[1:end-2, 3:end] + + a[3:end, 1:end-2] + a[3:end, 3:end]) - + 20.0 * a[2:end-1, 2:end-1]) ./ (6.0 * dx^2) + return del2 +end + +function invDel2_5(b::Matrix{Float64}, dx = 1.0, N = 10000) + #= + Relaxes over N steps to a discrete approximation of the inverse laplacian + of the source term b, each step is a weighted average over the four neighboring + points and the source. This is the Jacobi algorithm. + =# + + invDel2 = zeros(size(b)) + newInvDel2 = zeros(size(b)) + + for m in 1:N + newInvDel2[2:end-1, 2:end-1] .= 0.25 * (invDel2[2:end-1, 3:end] + + invDel2[2:end-1, 1:end-2] + + invDel2[3:end, 2:end-1] + + invDel2[1:end-2, 2:end-1] - + (dx^2) * b[2:end-1, 2:end-1]) + invDel2 .= newInvDel2 + end + + diff = del2_5(invDel2, dx) - b + diffSq = diff .* diff + error = sqrt(sum(diffSq)) + + println("\nerror = ", error) + + return invDel2 +end + + +# # Define variables +# L = 10 +# dx = 1.0 + +# # Parabola of revolution has constant Laplacian +# phi = zeros((L, L)) +# for i ∈ 1:L +# x = (i + 0.5 - 0.5 * L) * dx +# for j ∈ 1:L +# y = (j + 0.5 - 0.5 * L) * dx +# phi[i, j] = x^2 + y^2 +# end +# end + +# println(size(phi)) + +# println(del2_5(phi, dx)) + +# println("\n\n") + +# println(del2_9(phi, dx)) + +# Electrostatics example: uniformly charged cylinder (rho = 1) of radius R +L = 100 +dx = 1.0 +R = 1.0 +R2 = R^2 + +# Charge distribution +rho = zeros((L, L)) +for i ∈ 1:L + y = (i - 1 + 0.5 - 0.5 * L) * dx + println("y = ", y) + for j ∈ 1:L + x = (j - 1 + 0.5 - 0.5 * L) * dx + # this is the rod here + if y < 0 && abs(x) < R + rho[i, j] = 1.0 # high voltage + elseif y > 0 && abs(x) < R + rho[i, j] = -1.0 # conducting plane + else + rho[i, j] = 0.0 + end + end +end + +rhoPlot = plot(rho[Int(L / 2), :]) + +# Exact (analytical) electric potential +# phi = zeros((L, L)) +# for i ∈ 1:L +# x = (i + 0.5 - 0.5 * L) * dx +# for j ∈ 1:L +# y = (j + 0.5 - 0.5 * L) * dx +# r2 = x^2 + y^2 +# if r2 < R2 +# phi[i, j] = -π * r2 +# else +# phi[i, j] = -π * (R2 + R2 * log(r2 / R2)) +# end +# end +# end + +# phiPlot = plot(phi[Int(L / 2), :]) + +# Charge density obtained from exact potential +# rho = -1.0 / (4.0 * π) * del2_5(phi, dx) +# rhoPlotLattice = plot(rho[Int(L / 2), :]) + +function calc_field(phi::Matrix{Float64}, dx = 1.0) + E_x = zeros(size(phi)) + E_y = zeros(size(phi)) + + E_x[2:end-1, 2:end-1] .= -(phi[3:end, 2:end-1] - phi[1:end-2, 2:end-1]) / (2 * dx) + E_y[2:end-1, 2:end-1] .= -(phi[2:end-1, 3:end] - phi[2:end-1, 1:end-2]) / (2 * dx) + + # for i ∈ 2:size(phi, 1)-1 + # for j ∈ 2:size(phi, 2)-1 + # E_x[i, j] = -(phi[i+1, j] - phi[i-1, j]) / (2 * dx) + # E_y[i, j] = -(phi[i, j+1] - phi[i, j-1]) / (2 * dx) + # end + # end + + return E_x, E_y +end + +phi = invDel2_5(-4.0 * π * rho, dx, 1000) +# phi = invDelSOR(-4.0 * π * rho, dx, 500) +phi .-= phi[Int(L / 2), Int(L / 2)] + +phiPlotInvDel = plot(phi[Int(L / 2), :]) + +# phi_contour = contourf(phi, title = "Electric Potential", color = :viridis, aspect_ratio = :equal, colorbar_title = "V") +# savefig(phi_contour, "hw7/5.6-phi.png") + +# plot the arrows of the magnatic field on the contour plot +xxs = [x for x in 1:L for y in 1:L] +xxy = [y for x in 1:L for y in 1:L] +d_x, d_y = calc_field(phi, dx) + +function df(i, j) + norm = d_x[Int64(i)] * d_x[Int64(i)] + d_y[Int64(j)] * d_y[Int64(j)] + if norm == 0 + return (0, 0) + end + return (d_x[Int64(i)] / norm, d_y[Int64(j)] / norm) +end + +quiver(xxs, xxy, quiver = df, aspect_ratio = :equal, legend = false) +savefig("hw7/5.6-test.png") + + +# d_x, d_y = calc_field(phi, dx) +# field_y = contourf(d_y, title = "Electric Field (y)", color = :viridis, aspect_ratio = :equal, colorbar_title = "V/m") + +# field_x = contourf(d_x, title = "Electric Field (x)", color = :viridis, aspect_ratio = :equal, colorbar_title = "V/m") + + +# savefig(field_y, "hw7/5.6-fy.png") +# savefig(field_x, "hw7/5.6-fx.png") + +#plot(rhoPlot, rhoPlotLattice) +#plot(phiPlot, phiPlotInvDel) diff --git a/hw7/5.6.png b/hw7/5.6.png Binary files differnew file mode 100644 index 0000000..f17824a --- /dev/null +++ b/hw7/5.6.png diff --git a/hw7/8-12.jl b/hw7/8-12.jl new file mode 100644 index 0000000..29e18ec --- /dev/null +++ b/hw7/8-12.jl @@ -0,0 +1,191 @@ +#!/Applications/Julia-1.7.app/Contents/Resources/julia/bin/julia + +using Statistics +using Plots + +function wrap_index(i::Int, l::Int)::Int + wrap = (i - 1) % l + 1 + return (wrap <= 0) ? l + wrap : wrap +end + +mutable struct Ising2D + l::Int + n::Int + temperature::Float64 + w::Vector{Float64} # Boltzmann weights + state::Matrix + energy::Float64 + magnetization::Int + mc_steps::Int + accepted_moves::Int + energy_array::Vector{Float64} + magnetization_array::Vector{Int} + H::Float64 +end + +Ising2D(l::Int, temperature::Float64, H=1.0) = begin + n = l^2 + w = zeros(9) + w[9] = exp(-8.0 / temperature) + w[5] = exp(-4.0 / temperature) + state = ones(Int, l, l) # initially all spins up + energy = Float64(-2 * n + 2 * H * n) + magnetization = n + return Ising2D(l, n, temperature, w, state, energy, magnetization, 0, 0, + Int[], Int[], H) +end + +function reset!(ising::Ising2D) + ising.mc_steps = 0 + ising.accepted_moves = 0 + ising.energy_array = Int[] + ising.magnetization_array = Int[] +end + +function mc_step!(ising::Ising2D) + l::Int = ising.l + n::Int = ising.n + w = ising.w + + state = ising.state + accepted_moves = ising.accepted_moves + energy = ising.energy + magnetization = ising.magnetization + + random_positions = l * rand(2 * n) + random_array = rand(n) + + for k in 1:n + i = trunc(Int, random_positions[2 * k - 1]) + 1 + j = trunc(Int, random_positions[2 * k]) + 1 + + changed_spins = state[i, j] * (state[i % l + 1, j] + + state[wrap_index(i - 1, l), j] + state[i, j % l + 1] + + state[i, wrap_index(j - 1, l)]) + de = 2 * changed_spins + 2 * ising.H * state[i, j] + + if de <= 0 || rand() < exp(-de / ising.temperature) + accepted_moves += 1 + new_spin = - state[i, j] # flip spin + state[i, j] = new_spin + + # add the effects of the new spin + energy += de + magnetization += 2 * new_spin + end + + end + + ising.state = state + ising.accepted_moves = accepted_moves + ising.energy = energy + ising.magnetization = magnetization + + append!(ising.energy_array, ising.energy) + append!(ising.magnetization_array, ising.magnetization) + ising.mc_steps = ising.mc_steps + 1 +end + +function steps!(ising::Ising2D, num::Int=100) + for i in 1:num + mc_step!(ising) + end +end + +function mean_energy(ising::Ising2D) + return mean(ising.energy_array) / ising.n +end + +function specific_heat(ising::Ising2D) + return (std(ising.energy_array) / ising.temperature) ^ 2 / ising.n +end + +function mean_magnetization(ising::Ising2D) + return mean(ising.magnetization_array) / ising.n +end + +function susceptibility(ising::Ising2D) + return (std(ising.magnetization_array)) ^ 2 / (ising.temperature * ising.n) +end + +function observables(ising::Ising2D) + printstyled("Temperature\t\t", bold=true) + print(ising.temperature); print("\n") + + printstyled("Mean Energy\t\t", bold=true) + print(mean_energy(ising)); print("\n") + + printstyled("Mean Magnetiz.\t\t", bold=true) + print(mean_magnetization(ising)); print("\n") + + printstyled("Specific Heat\t\t", bold=true) + print(specific_heat(ising)); print("\n") + + printstyled("Susceptibility\t\t", bold=true) + print(susceptibility(ising)); print("\n") + + printstyled("MC Steps\t\t", bold=true) + print(ising.mc_steps); print("\n") + printstyled("Accepted Moves\t\t", bold=true) + print(ising.accepted_moves); print("\n") +end + + +function plot_ising(state::Matrix{Int}) + pos = Tuple.(findall(>(0), state)) + neg = Tuple.(findall(<(0), state)) + scatter(pos, markersize=5) + scatter!(neg, markersize=5) +end + +function find_m(H::Float64, l::Int, num::Int, T::Float64) + m = Ising2D(l, T, H) + steps!(m, num) + print("T = $T\n") + print("H = $H\n") + print("Mean Energy: $(mean_energy(m))\n") + print("Mean Magnetization: $(mean_magnetization(m))\n\n") + return mean_magnetization(m) +end + +function map_h_to_m(H_range::Vector{Float64}, l::Int, num::Int, T::Float64) + m = [] + for H in H_range + push!(m, find_m(H, l, num, T)) + end + return m +end + +function do_linear_regression(x::Vector{Float64}, y::Vector{Float64}) + n = length(x) + x̄ = mean(x) + ȳ = mean(y) + Σxy = sum((x .- x̄) .* (y .- ȳ)) + Σx² = sum((x .- x̄) .^ 2) + b = Σxy / Σx² + a = ȳ - b * x̄ + return a, b +end + +function plot_log_of_m_and_h(H_range::Vector{Float64}, l::Int, num::Int, T=2.27) + m = map_h_to_m(H_range, l, num, T) + p = scatter(H_range, m, label="M vs H", xlabel="H", ylabel="M", title="Magnetization (M) vs Field (B) for Ising Model at T_c", scale=:ln) + + # get the linear regression of the log + log_h = log.(H_range) + log_m = log.(m) + a, b = do_linear_regression(log_h, log_m) + println("a: $a, b: $b") + # plot the linear regression + plot!(p, H_range, exp.(a) .* H_range .^ b, label="linear regression = $(round(a, digits=3)) + $(round(b, digits=3))x", line=:dash, color=:red) + + return p +end + +# textbook rec +h_range = .02:.02:.2 +h_range = collect(h_range) +T = 2.27 # T_c for this system +side = 64 +steps = 5000 +plot_log_of_m_and_h(h_range, side, steps)
\ No newline at end of file diff --git a/hw7/8-15-d.png b/hw7/8-15-d.png Binary files differnew file mode 100644 index 0000000..eb64f61 --- /dev/null +++ b/hw7/8-15-d.png diff --git a/hw7/8-15-scales-d.png b/hw7/8-15-scales-d.png Binary files differnew file mode 100644 index 0000000..5e4f2e4 --- /dev/null +++ b/hw7/8-15-scales-d.png diff --git a/hw7/8-15-scales.png b/hw7/8-15-scales.png Binary files differnew file mode 100644 index 0000000..2256167 --- /dev/null +++ b/hw7/8-15-scales.png diff --git a/hw7/8-15.jl b/hw7/8-15.jl new file mode 100644 index 0000000..5c833be --- /dev/null +++ b/hw7/8-15.jl @@ -0,0 +1,274 @@ +#!/Applications/Julia-1.7.app/Contents/Resources/julia/bin/julia + +using Statistics +using Plots + +function wrap_index(i::Int, l::Int)::Int + wrap = (i - 1) % l + 1 + return (wrap <= 0) ? l + wrap : wrap +end + +mutable struct Ising2D + l::Int + n::Int + temperature::Float64 + w::Vector{Float64} # Boltzmann weights + state::Matrix + energy::Float64 + magnetization::Int + mc_steps::Int + accepted_moves::Int + energy_array::Vector{Float64} + magnetization_array::Vector{Int} + H::Float64 +end + +Ising2D(l::Int, temperature::Float64, H = 1.0) = begin + n = l^2 + w = zeros(9) + w[9] = exp(-8.0 / temperature) + w[5] = exp(-4.0 / temperature) + state = ones(Int, l, l) # initially all spins up + energy = Float64(-2 * n + 2 * H * n) + magnetization = n + return Ising2D(l, n, temperature, w, state, energy, magnetization, 0, 0, + Int[], Int[], H) +end + +function reset!(ising::Ising2D) + ising.mc_steps = 0 + ising.accepted_moves = 0 + ising.energy_array = Int[] + ising.magnetization_array = Int[] +end + +function mc_step!(ising::Ising2D) + l::Int = ising.l + n::Int = ising.n + w = ising.w + + state = ising.state + accepted_moves = ising.accepted_moves + energy = ising.energy + magnetization = ising.magnetization + + random_positions = l * rand(2 * n) + random_array = rand(n) + + for k in 1:n + i = trunc(Int, random_positions[2*k-1]) + 1 + j = trunc(Int, random_positions[2*k]) + 1 + + changed_spins = state[i, j] * (state[i%l+1, j] + + state[wrap_index(i - 1, l), j] + state[i, j%l+1] + + state[i, wrap_index(j - 1, l)]) + de = 2 * changed_spins + 2 * ising.H * state[i, j] + + if de <= 0 || rand() < exp(-de / ising.temperature) + accepted_moves += 1 + new_spin = -state[i, j] # flip spin + state[i, j] = new_spin + + # add the effects of the new spin + energy += de + magnetization += 2 * new_spin + end + + end + + ising.state = state + ising.accepted_moves = accepted_moves + ising.energy = energy + ising.magnetization = magnetization + + append!(ising.energy_array, ising.energy) + append!(ising.magnetization_array, ising.magnetization) + ising.mc_steps = ising.mc_steps + 1 +end + +function steps!(ising::Ising2D, num::Int = 100) + for i in 1:num + mc_step!(ising) + end +end + +function mean_energy(ising::Ising2D) + return mean(ising.energy_array) / ising.n +end + +function specific_heat(ising::Ising2D) + return (std(ising.energy_array) / ising.temperature)^2 / ising.n +end + +function mean_magnetization(ising::Ising2D) + return mean(ising.magnetization_array) / ising.n +end + +function susceptibility(ising::Ising2D) + return (std(ising.magnetization_array))^2 / (ising.temperature * ising.n) +end + +function observables(ising::Ising2D) + printstyled("Temperature\t\t", bold = true) + print(ising.temperature) + print("\n") + + printstyled("Mean Energy\t\t", bold = true) + print(mean_energy(ising)) + print("\n") + + printstyled("Mean Magnetiz.\t\t", bold = true) + print(mean_magnetization(ising)) + print("\n") + + printstyled("Specific Heat\t\t", bold = true) + print(specific_heat(ising)) + print("\n") + + printstyled("Susceptibility\t\t", bold = true) + print(susceptibility(ising)) + print("\n") + + printstyled("MC Steps\t\t", bold = true) + print(ising.mc_steps) + print("\n") + printstyled("Accepted Moves\t\t", bold = true) + print(ising.accepted_moves) + print("\n") +end + + +function plot_ising(state::Matrix{Int}) + pos = Tuple.(findall(>(0), state)) + neg = Tuple.(findall(<(0), state)) + scatter(pos, markersize = 5) + scatter!(neg, markersize = 5) +end + +function h_to_m(H::Float64, l::Int, num::Int, T::Float64) + m = Ising2D(l, T, H) + steps!(m, num) + print("T = $T\n") + print("H = $H\n") + print("Mean Energy: $(mean_energy(m))\n") + print("Mean Magnetization: $(mean_magnetization(m))\n\n") + return mean_magnetization(m) +end + +function map_h_to_m(H_range::Vector{Float64}, l::Int, num::Int, T::Float64) + m = [] + for H in H_range + push!(m, h_to_m(H, l, num, T)) + end + return m +end + +function do_linear_regression(x::Vector{Float64}, y::Vector{Float64}) + n = length(x) + x̄ = mean(x) + ȳ = mean(y) + Σxy = sum((x .- x̄) .* (y .- ȳ)) + Σx² = sum((x .- x̄) .^ 2) + b = Σxy / Σx² + a = ȳ - b * x̄ + return a, b +end + +function plot_log_of_m_and_h(H_range::Vector{Float64}, l::Int, num::Int, T = 2.27) + m = map_h_to_m(H_range, l, num, T) + p = scatter(H_range, m, label = "M vs H", xlabel = "H", ylabel = "M", title = "Magnetization (M) vs Field (B) for Ising Model at T_c", scale = :ln) + + # get the linear regression of the log + log_h = log.(H_range) + log_m = log.(m) + a, b = do_linear_regression(log_h, log_m) + println("a: $a, b: $b") + # plot the linear regression + plot!(p, H_range, exp.(a) .* H_range .^ b, label = "linear regression = $(round(a, digits=3)) + $(round(b, digits=3))x", line = :dash, color = :red) + + return p +end + +function t_to_m(T::Float64, l::Int, num::Int, H::Float64) + m = Ising2D(l, T, H) + steps!(m, num) + print("T = $T\n") + print("H = $H\n") + print("Mean Energy: $(mean_energy(m))\n") + print("Mean Sus: $(mean_magnetization(m))\n\n") + return susceptibility(m) +end + +function plot_m_over_t(plt, T_range::Vector{Float64}, l::Int, num::Int, H = 0.0) + m = [] + for T in T_range + push!(m, t_to_m(T, l, num, H)) + end + p = scatter!(plt, T_range, m, label = "H = $H", xlabel = "T", ylabel = "X", title = "Susceptibility (X) vs Temperature (T) on Ising Model") + + return p, m +end + +function plot_m_over_t_and_h(T_range::Vector{Float64}, l::Int, num::Int, H_range::Vector{Float64}) + plt = Plots.scatter() + h = [] + for H in H_range + p, m = plot_m_over_t(plt, T_range, l, num, H) + push!(h, m) + end + + # plot the critical temp as a vertical line + plot!(plt, [2.27, 2.27], [-0.01, 30], label = "T_c = 2.27", line = :dash, color = :red) + + return plt, h +end + +function plot_scales(data, t_range, h_range) + x1 = [] + y1 = [] + x2 = [] + y2 = [] + for i in 1:length(h_range) + h = h_range[i] + for j in 1:length(t_range) + t = t_range[j] + + m = data[i][j] + + scaled_t = abs((t - 2.27) / 2.27) + scaled_m = m * (scaled_t^(7.0 / 4.0)) + scaled_h = h / (scaled_t^(15.0 / 8.0)) + if scaled_h > 30 + continue # dont add if too large + end + + if t > 2.27 + push!(x1, scaled_h) + push!(y1, scaled_m) + else + push!(x2, scaled_h) + push!(y2, scaled_m) + end + end + end + + tmp = scatter(x1, y1, label = "T > T_c", xlabel = "h / abs(t)^(15/8)", ylabel = "X * abs(t)^(7/4)", title = "Susceptibility (X) vs Field (H) for Ising Model") + scatter!(tmp, x2, y2, label = "T < T_c", xlabel = "h / abs(t)^(15/8)", ylabel = "X * abs(t)^(7/4)", title = "Susceptibility (X) vs Field (H) for Ising Model") + return tmp +end + +h_range = 0.01:0.01:0.05 +h_range = collect(h_range) +t_range = 1.5:0.1:3.0 +t_range = collect(t_range) +println("t_range: $t_range") +side = 20 +steps = 3000 +plt, data = plot_m_over_t_and_h(t_range, side, steps, h_range) + +savefig(plt, "hw7/8-15.png") + +p = plot_scales(data, t_range, h_range) +savefig(p, "hw7/8-15-scales.png") + + diff --git a/hw7/8-15.png b/hw7/8-15.png Binary files differnew file mode 100644 index 0000000..a5a4b28 --- /dev/null +++ b/hw7/8-15.png diff --git a/hw7/BoundStates.jl b/hw7/BoundStates.jl new file mode 100644 index 0000000..386a5da --- /dev/null +++ b/hw7/BoundStates.jl @@ -0,0 +1,73 @@ +#!/usr/bin/env julia + +"""Find eigenstates and eigenenergies of 1-D quantum problems""" + +using LinearAlgebra +using Plots + +N = 1000 # number of lattice points +L = 20.0 # x runs from -L/2 to L/2 +dx = L / N + +D = zeros(N, N) # discrete laplacian operator +V = zeros(N, N) # potential + +for i in 1:N + D[i, i] = -2.0 +end + +for i in 1:N-1 + D[i, i+1] = 1.0 + D[i+1, i] = 1.0 +end + +#println("\nLattice Laplacian operator") +#println(D) + +function potential(x) + """ The potential energy""" + #return 0.0 # particle in a box + #return 0.5 * x^2 # SHO with the spring constant k = 1 + #return -6.0 * x^2 + 8.0 * x^6 # potential with zero ground state energy + #return 0.1 * x^4 - 2.0 * x^2 + 0.0 * x # double-well potential + return 8*x^6 - 8*x^4 - 4*x^2 + 1 # another double-well potential +end + +for i in 1:N + x = (i + 0.5) * dx - 0.5*L # coordinates of lattice points + V[i, i] = potential(x) +end + +H = -0.5 * dx^(-2.0) * D + V # Hamiltonian. Here m = hbar = 1 + +#println("\nMatrix elements of Hamiltonian = ") +#println(H) + +e, v = eigen(H) # diagonalize Hamiltonian + +println("\nGround state energy = ", e[1]) +println("\n1st excited state energy = ", e[2]) +println("\n2nd excited state energy = ", e[3]) +println("\n3rd excited state energy = ", e[4]) +println("\n4th excited state energy = ", e[5]) + + +gs(x) = exp(-0.5*x^2) # Gaussian that is exact ground state of SHO + + +plot(potential) + + +plot(v[:,1]) +#plot(v[:,2]) +#plot(gs) + +#= +eList = zeros(0) +for i in 1:20 + push!(eList, e[i]) +end + + +bar(eList, orientation = :horizontal) +=# diff --git a/hw7/Laplacians.jl b/hw7/Laplacians.jl new file mode 100644 index 0000000..10f0d48 --- /dev/null +++ b/hw7/Laplacians.jl @@ -0,0 +1,145 @@ +using Pkg +Pkg.add("Plots") +using Plots + +function del2_5(a::Matrix{Float64}, dx=1.0) + #= + Returns a finite-difference approximation of the laplacian of the array a, + with lattice spacing dx, using the five-point stencil: + + 0 1 0 + 1 -4 1 + 0 1 0 + =# + + del2 = zeros(size(a)) + del2[2:end-1, 2:end-1] .= (a[2:end-1, 3:end] + a[2:end-1, 1:end-2] + + a[3:end, 2:end-1] + a[1:end-2, 2:end-1] - + 4.0 * a[2:end-1, 2:end-1]) ./ (dx^2) + return del2 +end + +function del2_9(a::Matrix{Float64}, dx=1.0) + #= + Returns a finite-difference approximation of the laplacian of the array a, + with lattice spacing dx, using the nine-point stencil: + + 1/6 2/3 1/6 + 2/3 -10/3 2/3 + 1/6 2/3 1/6 + =# + + del2 = zeros(size(a)) + del2[2:end-1, 2:end-1] .= (4.0 * (a[2:end-1, 3:end] + a[2:end-1, 1:end-2] + + a[3:end, 2:end-1] + a[1:end-2, 2:end-1]) + + (a[1:end-2, 1:end-2] + a[1:end-2, 3:end] + + a[3:end, 1:end-2] + a[3:end, 3:end]) - + 20.0 * a[2:end-1, 2:end-1]) ./ (6.0 * dx^2) + return del2 +end + +function invDel2_5(b::Matrix{Float64}, dx=1.0, N=10000) + #= + Relaxes over N steps to a discrete approximation of the inverse laplacian + of the source term b, each step is a weighted average over the four neighboring + points and the source. This is the Jacobi algorithm. + =# + + invDel2 = zeros(size(b)) + newInvDel2 = zeros(size(b)) + + for m in 1:N + newInvDel2[2:end-1, 2:end-1] .= 0.25 * (invDel2[2:end-1, 3:end] + + invDel2[2:end-1, 1:end-2] + + invDel2[3:end, 2:end-1] + + invDel2[1:end-2, 2:end-1] - + (dx^2) * b[2:end-1, 2:end-1]) + invDel2 .= newInvDel2 + end + + diff = del2_5(invDel2, dx) - b + diffSq = diff .* diff + error = sqrt(sum(diffSq)) + + println("\nerror = ", error) + + return invDel2 +end + + +# Define variables +L = 10 +dx = 1.0 + +# Parabola of revolution has constant Laplacian +phi = zeros((L, L)) +for i = 1:L + x = (i + 0.5 - 0.5 * L) * dx + for j = 1:L + y = (j + 0.5 - 0.5 * L) * dx + phi[i, j] = x^2 + y^2 + end +end + +println(size(phi)) + +println(del2_5(phi, dx)) + +println("\n\n") + +println(del2_9(phi, dx)) + +# Electrostatics example: uniformly charged cylinder (rho = 1) of radius R +L = 100 +dx = 1.0 +R = 20.0 +R2 = R^2 + +# Charge distribution +rho = zeros((L, L)) +for i = 1:L + x = (i + 0.5 - 0.5 * L) * dx + for j = 1:L + y = (j + 0.5 - 0.5 * L) * dx + r2 = x^2 + y^2 + if r2 < R2 + rho[i, j] = 1.0 + else + rho[i, j] = 0.0 + end + end +end + +rhoPlot = plot(rho[Int(L/2), :]) + +# Exact (analytical) electric potential +phi = zeros((L, L)) +for i = 1:L + x = (i + 0.5 - 0.5 * L) * dx + for j = 1:L + y = (j + 0.5 - 0.5 * L) * dx + r2 = x^2 + y^2 + if r2 < R2 + phi[i, j] = -π * r2 + else + phi[i, j] = -π * (R2 + R2*log(r2/R2)) + end + end +end + +phiPlot = plot(phi[Int(L/2), :]) + +# Charge density obtained from exact potential +rho = -1.0/(4.0 * π) * del2_5(phi, dx) +rhoPlotLattice = plot(rho[Int(L/2), :]) + +phi = invDel2_5(-4.0 * π * rho, dx, 20000) +#phi = invDelSOR(-4.0 * π * rho, dx, 500) +phi .-= phi[Int(L/2), Int(L/2)] + +phiPlotInvDel = plot(phi[Int(L/2), :]) + +contourf(phi) + +#plot(rhoPlot, rhoPlotLattice) +#plot(phiPlot, phiPlotInvDel) diff --git a/hw7/RadialBoundStates.jl b/hw7/RadialBoundStates.jl new file mode 100644 index 0000000..afb91b0 --- /dev/null +++ b/hw7/RadialBoundStates.jl @@ -0,0 +1,59 @@ +#!/usr/bin/env julia + +"""Find eigenstates and eigenenergies of central potential problems""" + +using LinearAlgebra +using Plots + +N = 5000 # number of lattice points +L = 20.0 # r runs from 0 to L +dr = L / N + +D = zeros(N, N) # discrete radial 2nd derivative operator +V = zeros(N, N) # potential + +for i in 1:N + D[i, i] = -2.0 +end + +for i in 1:N-1 + D[i, i+1] = 1.0 + D[i+1, i] = 1.0 +end + +#println("\nLattice Laplacian operator") +#println(D) + +function potential(r, ℓ = 0) + """ The potential energy""" + #return 0.5 * ell * (ℓ+1.0) * pow(r, -2.0) # V=0: Free particle in spherical coordinates + + return -1.0/r + 0.5 * ℓ * (ℓ+1.0) * r^(-2.0) # Hydrogen atom + + #return -r^(-1.1) + 0.5 * ℓ * (ℓ+1.0) * r^(-2.0) # modified Coulomb potential +end + +for i in 1:N + r = (i + 0.5) * dr # radial coordinates of lattice points + V[i, i] = potential(r, 0) +end + +H = -0.5 * dr^(-2.0) * D + V # Hamiltonian. Here m = hbar = 1 + +#println("\nMatrix elements of Hamiltonian = ") +#println(H) + +e, v = eigen(H) # diagonalize Hamiltonian + +println("\nGround state energy = ", e[1]) +println("\n1st excited state energy = ", e[2]) +println("\n2nd excited state energy = ", e[3]) +println("\n3rd excited state energy = ", e[4]) +println("\n4th excited state energy = ", e[5]) + + +plot(potential) + + +plot(v[:,1]) +#plot(v[:,2]) diff --git a/hw7/mvsb.svg b/hw7/mvsb.svg new file mode 100644 index 0000000..9e4afbb --- /dev/null +++ b/hw7/mvsb.svg @@ -0,0 +1,55 @@ +<svg xmlns="http://www.w3.org/2000/svg" xmlns:xlink="http://www.w3.org/1999/xlink" width="600" height="400" viewBox="0 0 2400 1600"> +<defs> + <clipPath id="clip250"> + <rect x="0" y="0" width="2400" height="1600"></rect> + </clipPath> +</defs> +<path clip-path="url(#clip250)" d="M0 1600 L2400 1600 L2400 8.88178e-14 L0 8.88178e-14 Z" fill="#ffffff" fill-rule="evenodd" fill-opacity="1"></path> +<defs> + <clipPath id="clip251"> + <rect x="480" y="0" width="1681" height="1600"></rect> + </clipPath> +</defs> +<path clip-path="url(#clip250)" d="M597.179 1423.18 L2352.76 1423.18 L2352.76 123.472 L597.179 123.472 Z" fill="#ffffff" fill-rule="evenodd" fill-opacity="1"></path> +<defs> + <clipPath id="clip252"> + <rect x="597" y="123" width="1757" height="1301"></rect> + </clipPath> +</defs> +<polyline clip-path="url(#clip252)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="1302.87,1423.18 1302.87,123.472 "></polyline> +<polyline clip-path="url(#clip252)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="2022.15,1423.18 2022.15,123.472 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,1423.18 2352.76,1423.18 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="1302.87,1423.18 1302.87,1404.28 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="2022.15,1423.18 2022.15,1404.28 "></polyline> +<path clip-path="url(#clip250)" d="M1231.62 1471.55 L1231.62 1473.64 L1212.03 1473.64 Q1212.31 1478.03 1214.67 1480.35 Q1217.06 1482.64 1221.29 1482.64 Q1223.75 1482.64 1226.04 1482.04 Q1228.35 1481.44 1230.62 1480.23 L1230.62 1484.26 Q1228.33 1485.23 1225.92 1485.74 Q1223.51 1486.25 1221.04 1486.25 Q1214.83 1486.25 1211.2 1482.64 Q1207.59 1479.03 1207.59 1472.87 Q1207.59 1466.51 1211.01 1462.78 Q1214.46 1459.03 1220.3 1459.03 Q1225.53 1459.03 1228.56 1462.41 Q1231.62 1465.77 1231.62 1471.55 M1227.36 1470.3 Q1227.31 1466.81 1225.39 1464.72 Q1223.49 1462.64 1220.34 1462.64 Q1216.78 1462.64 1214.63 1464.65 Q1212.5 1466.67 1212.17 1470.33 L1227.36 1470.3 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1256.27 1451.02 L1268.84 1463.91 L1264.19 1463.91 L1254 1454.77 L1243.81 1463.91 L1239.16 1463.91 L1251.73 1451.02 L1256.27 1451.02 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1298.1 1489.98 L1298.1 1493.31 L1296.66 1493.31 Q1290.9 1493.31 1288.93 1491.6 Q1286.99 1489.89 1286.99 1484.77 L1286.99 1479.24 Q1286.99 1475.74 1285.74 1474.4 Q1284.49 1473.06 1281.2 1473.06 L1279.79 1473.06 L1279.79 1469.75 L1281.2 1469.75 Q1284.51 1469.75 1285.74 1468.43 Q1286.99 1467.08 1286.99 1463.64 L1286.99 1458.08 Q1286.99 1452.96 1288.93 1451.27 Q1290.9 1449.56 1296.66 1449.56 L1298.1 1449.56 L1298.1 1452.87 L1296.52 1452.87 Q1293.26 1452.87 1292.26 1453.89 Q1291.27 1454.91 1291.27 1458.17 L1291.27 1463.91 Q1291.27 1467.55 1290.2 1469.19 Q1289.16 1470.83 1286.62 1471.41 Q1289.19 1472.04 1290.23 1473.68 Q1291.27 1475.33 1291.27 1478.94 L1291.27 1484.68 Q1291.27 1487.94 1292.26 1488.96 Q1293.26 1489.98 1296.52 1489.98 L1298.1 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1309.05 1468.75 L1338.72 1468.75 L1338.72 1472.69 L1309.05 1472.69 L1309.05 1468.75 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1362.98 1466.95 Q1366.34 1467.66 1368.21 1469.93 Q1370.11 1472.2 1370.11 1475.53 Q1370.11 1480.65 1366.59 1483.45 Q1363.07 1486.25 1356.59 1486.25 Q1354.42 1486.25 1352.1 1485.81 Q1349.81 1485.39 1347.36 1484.54 L1347.36 1480.02 Q1349.3 1481.16 1351.62 1481.74 Q1353.93 1482.32 1356.45 1482.32 Q1360.85 1482.32 1363.14 1480.58 Q1365.46 1478.84 1365.46 1475.53 Q1365.46 1472.48 1363.31 1470.77 Q1361.18 1469.03 1357.36 1469.03 L1353.33 1469.03 L1353.33 1465.19 L1357.54 1465.19 Q1360.99 1465.19 1362.82 1463.82 Q1364.65 1462.43 1364.65 1459.84 Q1364.65 1457.18 1362.75 1455.77 Q1360.87 1454.33 1357.36 1454.33 Q1355.43 1454.33 1353.24 1454.75 Q1351.04 1455.16 1348.4 1456.04 L1348.4 1451.88 Q1351.06 1451.14 1353.37 1450.77 Q1355.71 1450.39 1357.77 1450.39 Q1363.1 1450.39 1366.2 1452.83 Q1369.3 1455.23 1369.3 1459.35 Q1369.3 1462.22 1367.66 1464.21 Q1366.01 1466.18 1362.98 1466.95 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1379.83 1489.98 L1381.45 1489.98 Q1384.69 1489.98 1385.67 1488.98 Q1386.66 1487.99 1386.66 1484.68 L1386.66 1478.94 Q1386.66 1475.33 1387.7 1473.68 Q1388.74 1472.04 1391.31 1471.41 Q1388.74 1470.83 1387.7 1469.19 Q1386.66 1467.55 1386.66 1463.91 L1386.66 1458.17 Q1386.66 1454.89 1385.67 1453.89 Q1384.69 1452.87 1381.45 1452.87 L1379.83 1452.87 L1379.83 1449.56 L1381.29 1449.56 Q1387.05 1449.56 1388.98 1451.27 Q1390.92 1452.96 1390.92 1458.08 L1390.92 1463.64 Q1390.92 1467.08 1392.17 1468.43 Q1393.42 1469.75 1396.71 1469.75 L1398.14 1469.75 L1398.14 1473.06 L1396.71 1473.06 Q1393.42 1473.06 1392.17 1474.4 Q1390.92 1475.74 1390.92 1479.24 L1390.92 1484.77 Q1390.92 1489.89 1388.98 1491.6 Q1387.05 1493.31 1381.29 1493.31 L1379.83 1493.31 L1379.83 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1950.9 1471.55 L1950.9 1473.64 L1931.31 1473.64 Q1931.59 1478.03 1933.95 1480.35 Q1936.34 1482.64 1940.57 1482.64 Q1943.03 1482.64 1945.32 1482.04 Q1947.63 1481.44 1949.9 1480.23 L1949.9 1484.26 Q1947.61 1485.23 1945.2 1485.74 Q1942.79 1486.25 1940.32 1486.25 Q1934.11 1486.25 1930.48 1482.64 Q1926.87 1479.03 1926.87 1472.87 Q1926.87 1466.51 1930.29 1462.78 Q1933.74 1459.03 1939.58 1459.03 Q1944.81 1459.03 1947.84 1462.41 Q1950.9 1465.77 1950.9 1471.55 M1946.64 1470.3 Q1946.59 1466.81 1944.67 1464.72 Q1942.77 1462.64 1939.62 1462.64 Q1936.06 1462.64 1933.91 1464.65 Q1931.78 1466.67 1931.45 1470.33 L1946.64 1470.3 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1975.55 1451.02 L1988.12 1463.91 L1983.47 1463.91 L1973.28 1454.77 L1963.1 1463.91 L1958.44 1463.91 L1971.01 1451.02 L1975.55 1451.02 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2017.38 1489.98 L2017.38 1493.31 L2015.94 1493.31 Q2010.18 1493.31 2008.21 1491.6 Q2006.27 1489.89 2006.27 1484.77 L2006.27 1479.24 Q2006.27 1475.74 2005.02 1474.4 Q2003.77 1473.06 2000.48 1473.06 L1999.07 1473.06 L1999.07 1469.75 L2000.48 1469.75 Q2003.79 1469.75 2005.02 1468.43 Q2006.27 1467.08 2006.27 1463.64 L2006.27 1458.08 Q2006.27 1452.96 2008.21 1451.27 Q2010.18 1449.56 2015.94 1449.56 L2017.38 1449.56 L2017.38 1452.87 L2015.8 1452.87 Q2012.54 1452.87 2011.54 1453.89 Q2010.55 1454.91 2010.55 1458.17 L2010.55 1463.91 Q2010.55 1467.55 2009.48 1469.19 Q2008.44 1470.83 2005.9 1471.41 Q2008.47 1472.04 2009.51 1473.68 Q2010.55 1475.33 2010.55 1478.94 L2010.55 1484.68 Q2010.55 1487.94 2011.54 1488.96 Q2012.54 1489.98 2015.8 1489.98 L2017.38 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2028.33 1468.75 L2058 1468.75 L2058 1472.69 L2028.33 1472.69 L2028.33 1468.75 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2072.12 1481.64 L2088.44 1481.64 L2088.44 1485.58 L2066.5 1485.58 L2066.5 1481.64 Q2069.16 1478.89 2073.74 1474.26 Q2078.35 1469.61 2079.53 1468.27 Q2081.78 1465.74 2082.66 1464.01 Q2083.56 1462.25 2083.56 1460.56 Q2083.56 1457.8 2081.61 1456.07 Q2079.69 1454.33 2076.59 1454.33 Q2074.39 1454.33 2071.94 1455.09 Q2069.51 1455.86 2066.73 1457.41 L2066.73 1452.69 Q2069.55 1451.55 2072.01 1450.97 Q2074.46 1450.39 2076.5 1450.39 Q2081.87 1450.39 2085.06 1453.08 Q2088.26 1455.77 2088.26 1460.26 Q2088.26 1462.39 2087.45 1464.31 Q2086.66 1466.2 2084.55 1468.8 Q2083.97 1469.47 2080.87 1472.69 Q2077.77 1475.88 2072.12 1481.64 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2099.11 1489.98 L2100.73 1489.98 Q2103.97 1489.98 2104.95 1488.98 Q2105.94 1487.99 2105.94 1484.68 L2105.94 1478.94 Q2105.94 1475.33 2106.98 1473.68 Q2108.03 1472.04 2110.59 1471.41 Q2108.03 1470.83 2106.98 1469.19 Q2105.94 1467.55 2105.94 1463.91 L2105.94 1458.17 Q2105.94 1454.89 2104.95 1453.89 Q2103.97 1452.87 2100.73 1452.87 L2099.11 1452.87 L2099.11 1449.56 L2100.57 1449.56 Q2106.34 1449.56 2108.26 1451.27 Q2110.2 1452.96 2110.2 1458.08 L2110.2 1463.64 Q2110.2 1467.08 2111.45 1468.43 Q2112.7 1469.75 2115.99 1469.75 L2117.42 1469.75 L2117.42 1473.06 L2115.99 1473.06 Q2112.7 1473.06 2111.45 1474.4 Q2110.2 1475.74 2110.2 1479.24 L2110.2 1484.77 Q2110.2 1489.89 2108.26 1491.6 Q2106.34 1493.31 2100.57 1493.31 L2099.11 1493.31 L2099.11 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1456.86 1520.52 L1463.29 1520.52 L1463.29 1540 L1486.65 1540 L1486.65 1520.52 L1493.08 1520.52 L1493.08 1568.04 L1486.65 1568.04 L1486.65 1545.41 L1463.29 1545.41 L1463.29 1568.04 L1456.86 1568.04 L1456.86 1520.52 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><polyline clip-path="url(#clip252)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="597.179,1095.08 2352.76,1095.08 "></polyline> +<polyline clip-path="url(#clip252)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="597.179,729.771 2352.76,729.771 "></polyline> +<polyline clip-path="url(#clip252)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="597.179,364.464 2352.76,364.464 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,1423.18 597.179,123.472 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,1095.08 616.077,1095.08 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,729.771 616.077,729.771 "></polyline> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,364.464 616.077,364.464 "></polyline> +<path clip-path="url(#clip250)" d="M138.288 1098.33 L138.288 1100.41 L118.705 1100.41 Q118.982 1104.81 121.343 1107.13 Q123.728 1109.42 127.964 1109.42 Q130.417 1109.42 132.709 1108.82 Q135.024 1108.21 137.292 1107.01 L137.292 1111.04 Q135.001 1112.01 132.593 1112.52 Q130.186 1113.03 127.709 1113.03 Q121.505 1113.03 117.871 1109.42 Q114.26 1105.81 114.26 1099.65 Q114.26 1093.28 117.686 1089.56 Q121.135 1085.81 126.968 1085.81 Q132.2 1085.81 135.232 1089.19 Q138.288 1092.54 138.288 1098.33 M134.029 1097.08 Q133.982 1093.58 132.061 1091.5 Q130.163 1089.42 127.015 1089.42 Q123.45 1089.42 121.297 1091.43 Q119.168 1093.45 118.843 1097.1 L134.029 1097.08 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M162.94 1077.8 L175.51 1090.69 L170.857 1090.69 L160.672 1081.55 L150.487 1090.69 L145.834 1090.69 L158.403 1077.8 L162.94 1077.8 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M204.769 1116.76 L204.769 1120.09 L203.334 1120.09 Q197.57 1120.09 195.602 1118.38 Q193.658 1116.66 193.658 1111.55 L193.658 1106.02 Q193.658 1102.52 192.408 1101.18 Q191.158 1099.83 187.871 1099.83 L186.459 1099.83 L186.459 1096.52 L187.871 1096.52 Q191.181 1096.52 192.408 1095.21 Q193.658 1093.86 193.658 1090.41 L193.658 1084.86 Q193.658 1079.74 195.602 1078.05 Q197.57 1076.34 203.334 1076.34 L204.769 1076.34 L204.769 1079.65 L203.195 1079.65 Q199.931 1079.65 198.936 1080.67 Q197.94 1081.69 197.94 1084.95 L197.94 1090.69 Q197.94 1094.33 196.875 1095.97 Q195.834 1097.61 193.288 1098.19 Q195.857 1098.82 196.899 1100.46 Q197.94 1102.1 197.94 1105.71 L197.94 1111.46 Q197.94 1114.72 198.936 1115.74 Q199.931 1116.76 203.195 1116.76 L204.769 1116.76 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M215.718 1095.53 L245.394 1095.53 L245.394 1099.46 L215.718 1099.46 L215.718 1095.53 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M265.486 1080.88 Q261.875 1080.88 260.046 1084.44 Q258.241 1087.98 258.241 1095.11 Q258.241 1102.22 260.046 1105.78 Q261.875 1109.33 265.486 1109.33 Q269.12 1109.33 270.926 1105.78 Q272.755 1102.22 272.755 1095.11 Q272.755 1087.98 270.926 1084.44 Q269.12 1080.88 265.486 1080.88 M265.486 1077.17 Q271.296 1077.17 274.352 1081.78 Q277.431 1086.36 277.431 1095.11 Q277.431 1103.84 274.352 1108.45 Q271.296 1113.03 265.486 1113.03 Q259.676 1113.03 256.597 1108.45 Q253.542 1103.84 253.542 1095.11 Q253.542 1086.36 256.597 1081.78 Q259.676 1077.17 265.486 1077.17 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M285.648 1106.48 L290.532 1106.48 L290.532 1112.36 L285.648 1112.36 L285.648 1106.48 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M304.745 1108.42 L321.065 1108.42 L321.065 1112.36 L299.12 1112.36 L299.12 1108.42 Q301.782 1105.67 306.366 1101.04 Q310.972 1096.39 312.153 1095.04 Q314.398 1092.52 315.278 1090.78 Q316.18 1089.02 316.18 1087.33 Q316.18 1084.58 314.236 1082.84 Q312.315 1081.11 309.213 1081.11 Q307.014 1081.11 304.56 1081.87 Q302.13 1082.64 299.352 1084.19 L299.352 1079.46 Q302.176 1078.33 304.63 1077.75 Q307.083 1077.17 309.12 1077.17 Q314.491 1077.17 317.685 1079.86 Q320.879 1082.54 320.879 1087.03 Q320.879 1089.16 320.069 1091.08 Q319.282 1092.98 317.176 1095.58 Q316.597 1096.25 313.495 1099.46 Q310.393 1102.66 304.745 1108.42 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M334.907 1108.42 L351.226 1108.42 L351.226 1112.36 L329.282 1112.36 L329.282 1108.42 Q331.944 1105.67 336.527 1101.04 Q341.134 1096.39 342.314 1095.04 Q344.56 1092.52 345.439 1090.78 Q346.342 1089.02 346.342 1087.33 Q346.342 1084.58 344.398 1082.84 Q342.477 1081.11 339.375 1081.11 Q337.176 1081.11 334.722 1081.87 Q332.291 1082.64 329.514 1084.19 L329.514 1079.46 Q332.338 1078.33 334.791 1077.75 Q337.245 1077.17 339.282 1077.17 Q344.652 1077.17 347.847 1079.86 Q351.041 1082.54 351.041 1087.03 Q351.041 1089.16 350.231 1091.08 Q349.444 1092.98 347.338 1095.58 Q346.759 1096.25 343.657 1099.46 Q340.555 1102.66 334.907 1108.42 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M371.041 1095.95 Q367.708 1095.95 365.787 1097.73 Q363.888 1099.51 363.888 1102.64 Q363.888 1105.76 365.787 1107.54 Q367.708 1109.33 371.041 1109.33 Q374.375 1109.33 376.296 1107.54 Q378.217 1105.74 378.217 1102.64 Q378.217 1099.51 376.296 1097.73 Q374.398 1095.95 371.041 1095.95 M366.365 1093.96 Q363.356 1093.21 361.666 1091.15 Q360 1089.09 360 1086.13 Q360 1081.99 362.939 1079.58 Q365.902 1077.17 371.041 1077.17 Q376.203 1077.17 379.143 1079.58 Q382.083 1081.99 382.083 1086.13 Q382.083 1089.09 380.393 1091.15 Q378.726 1093.21 375.74 1093.96 Q379.12 1094.74 380.995 1097.03 Q382.893 1099.33 382.893 1102.64 Q382.893 1107.66 379.814 1110.34 Q376.759 1113.03 371.041 1113.03 Q365.324 1113.03 362.245 1110.34 Q359.189 1107.66 359.189 1102.64 Q359.189 1099.33 361.088 1097.03 Q362.986 1094.74 366.365 1093.96 M364.652 1086.57 Q364.652 1089.26 366.319 1090.76 Q368.009 1092.27 371.041 1092.27 Q374.05 1092.27 375.74 1090.76 Q377.453 1089.26 377.453 1086.57 Q377.453 1083.89 375.74 1082.38 Q374.05 1080.88 371.041 1080.88 Q368.009 1080.88 366.319 1082.38 Q364.652 1083.89 364.652 1086.57 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M391.342 1111.64 L391.342 1107.38 Q393.101 1108.21 394.907 1108.65 Q396.712 1109.09 398.448 1109.09 Q403.078 1109.09 405.509 1105.99 Q407.962 1102.87 408.31 1096.52 Q406.967 1098.52 404.907 1099.58 Q402.847 1100.65 400.347 1100.65 Q395.161 1100.65 392.129 1097.52 Q389.12 1094.37 389.12 1088.93 Q389.12 1083.61 392.268 1080.39 Q395.416 1077.17 400.648 1077.17 Q406.643 1077.17 409.791 1081.78 Q412.962 1086.36 412.962 1095.11 Q412.962 1103.28 409.073 1108.17 Q405.208 1113.03 398.657 1113.03 Q396.898 1113.03 395.092 1112.68 Q393.286 1112.33 391.342 1111.64 M400.648 1096.99 Q403.796 1096.99 405.624 1094.83 Q407.476 1092.68 407.476 1088.93 Q407.476 1085.21 405.624 1083.05 Q403.796 1080.88 400.648 1080.88 Q397.499 1080.88 395.648 1083.05 Q393.819 1085.21 393.819 1088.93 Q393.819 1092.68 395.648 1094.83 Q397.499 1096.99 400.648 1096.99 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M434.212 1081.87 L422.407 1100.32 L434.212 1100.32 L434.212 1081.87 M432.985 1077.8 L438.865 1077.8 L438.865 1100.32 L443.795 1100.32 L443.795 1104.21 L438.865 1104.21 L438.865 1112.36 L434.212 1112.36 L434.212 1104.21 L418.61 1104.21 L418.61 1099.7 L432.985 1077.8 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M451.573 1077.8 L469.93 1077.8 L469.93 1081.73 L455.856 1081.73 L455.856 1090.21 Q456.874 1089.86 457.893 1089.7 Q458.911 1089.51 459.93 1089.51 Q465.717 1089.51 469.096 1092.68 Q472.476 1095.85 472.476 1101.27 Q472.476 1106.85 469.004 1109.95 Q465.531 1113.03 459.212 1113.03 Q457.036 1113.03 454.768 1112.66 Q452.522 1112.29 450.115 1111.55 L450.115 1106.85 Q452.198 1107.98 454.42 1108.54 Q456.643 1109.09 459.119 1109.09 Q463.124 1109.09 465.462 1106.99 Q467.8 1104.88 467.8 1101.27 Q467.8 1097.66 465.462 1095.55 Q463.124 1093.45 459.119 1093.45 Q457.244 1093.45 455.369 1093.86 Q453.518 1094.28 451.573 1095.16 L451.573 1077.8 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M494.536 1081.87 L482.73 1100.32 L494.536 1100.32 L494.536 1081.87 M493.309 1077.8 L499.189 1077.8 L499.189 1100.32 L504.119 1100.32 L504.119 1104.21 L499.189 1104.21 L499.189 1112.36 L494.536 1112.36 L494.536 1104.21 L478.934 1104.21 L478.934 1099.7 L493.309 1077.8 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M511.99 1111.64 L511.99 1107.38 Q513.749 1108.21 515.554 1108.65 Q517.36 1109.09 519.096 1109.09 Q523.726 1109.09 526.156 1105.99 Q528.61 1102.87 528.957 1096.52 Q527.614 1098.52 525.554 1099.58 Q523.494 1100.65 520.994 1100.65 Q515.809 1100.65 512.777 1097.52 Q509.767 1094.37 509.767 1088.93 Q509.767 1083.61 512.915 1080.39 Q516.064 1077.17 521.295 1077.17 Q527.29 1077.17 530.438 1081.78 Q533.61 1086.36 533.61 1095.11 Q533.61 1103.28 529.721 1108.17 Q525.855 1113.03 519.304 1113.03 Q517.545 1113.03 515.739 1112.68 Q513.934 1112.33 511.99 1111.64 M521.295 1096.99 Q524.443 1096.99 526.272 1094.83 Q528.124 1092.68 528.124 1088.93 Q528.124 1085.21 526.272 1083.05 Q524.443 1080.88 521.295 1080.88 Q518.147 1080.88 516.295 1083.05 Q514.466 1085.21 514.466 1088.93 Q514.466 1092.68 516.295 1094.83 Q518.147 1096.99 521.295 1096.99 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M542.869 1116.76 L544.489 1116.76 Q547.73 1116.76 548.702 1115.76 Q549.698 1114.77 549.698 1111.46 L549.698 1105.71 Q549.698 1102.1 550.739 1100.46 Q551.781 1098.82 554.35 1098.19 Q551.781 1097.61 550.739 1095.97 Q549.698 1094.33 549.698 1090.69 L549.698 1084.95 Q549.698 1081.66 548.702 1080.67 Q547.73 1079.65 544.489 1079.65 L542.869 1079.65 L542.869 1076.34 L544.327 1076.34 Q550.091 1076.34 552.012 1078.05 Q553.957 1079.74 553.957 1084.86 L553.957 1090.41 Q553.957 1093.86 555.207 1095.21 Q556.457 1096.52 559.744 1096.52 L561.179 1096.52 L561.179 1099.83 L559.744 1099.83 Q556.457 1099.83 555.207 1101.18 Q553.957 1102.52 553.957 1106.02 L553.957 1111.55 Q553.957 1116.66 552.012 1118.38 Q550.091 1120.09 544.327 1120.09 L542.869 1120.09 L542.869 1116.76 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M138.288 733.023 L138.288 735.106 L118.705 735.106 Q118.982 739.505 121.343 741.819 Q123.728 744.111 127.964 744.111 Q130.417 744.111 132.709 743.509 Q135.024 742.907 137.292 741.704 L137.292 745.731 Q135.001 746.704 132.593 747.213 Q130.186 747.722 127.709 747.722 Q121.505 747.722 117.871 744.111 Q114.26 740.5 114.26 734.343 Q114.26 727.977 117.686 724.25 Q121.135 720.5 126.968 720.5 Q132.2 720.5 135.232 723.88 Q138.288 727.236 138.288 733.023 M134.029 731.773 Q133.982 728.278 132.061 726.194 Q130.163 724.111 127.015 724.111 Q123.45 724.111 121.297 726.125 Q119.168 728.139 118.843 731.796 L134.029 731.773 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M162.94 712.491 L175.51 725.384 L170.857 725.384 L160.672 716.241 L150.487 725.384 L145.834 725.384 L158.403 712.491 L162.94 712.491 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M204.769 751.449 L204.769 754.782 L203.334 754.782 Q197.57 754.782 195.602 753.069 Q193.658 751.356 193.658 746.241 L193.658 740.708 Q193.658 737.213 192.408 735.87 Q191.158 734.528 187.871 734.528 L186.459 734.528 L186.459 731.218 L187.871 731.218 Q191.181 731.218 192.408 729.898 Q193.658 728.556 193.658 725.106 L193.658 719.551 Q193.658 714.435 195.602 712.745 Q197.57 711.032 203.334 711.032 L204.769 711.032 L204.769 714.343 L203.195 714.343 Q199.931 714.343 198.936 715.361 Q197.94 716.38 197.94 719.644 L197.94 725.384 Q197.94 729.018 196.875 730.662 Q195.834 732.305 193.288 732.884 Q195.857 733.509 196.899 735.153 Q197.94 736.796 197.94 740.407 L197.94 746.148 Q197.94 749.412 198.936 750.43 Q199.931 751.449 203.195 751.449 L204.769 751.449 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M215.718 730.222 L245.394 730.222 L245.394 734.157 L215.718 734.157 L215.718 730.222 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M265.486 715.569 Q261.875 715.569 260.046 719.134 Q258.241 722.676 258.241 729.805 Q258.241 736.912 260.046 740.477 Q261.875 744.018 265.486 744.018 Q269.12 744.018 270.926 740.477 Q272.755 736.912 272.755 729.805 Q272.755 722.676 270.926 719.134 Q269.12 715.569 265.486 715.569 M265.486 711.866 Q271.296 711.866 274.352 716.472 Q277.431 721.056 277.431 729.805 Q277.431 738.532 274.352 743.139 Q271.296 747.722 265.486 747.722 Q259.676 747.722 256.597 743.139 Q253.542 738.532 253.542 729.805 Q253.542 721.056 256.597 716.472 Q259.676 711.866 265.486 711.866 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M285.648 741.171 L290.532 741.171 L290.532 747.051 L285.648 747.051 L285.648 741.171 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M301.528 743.116 L309.167 743.116 L309.167 716.75 L300.856 718.417 L300.856 714.157 L309.12 712.491 L313.796 712.491 L313.796 743.116 L321.435 743.116 L321.435 747.051 L301.528 747.051 L301.528 743.116 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M340.879 730.639 Q337.546 730.639 335.625 732.421 Q333.727 734.204 333.727 737.329 Q333.727 740.454 335.625 742.236 Q337.546 744.018 340.879 744.018 Q344.213 744.018 346.134 742.236 Q348.055 740.43 348.055 737.329 Q348.055 734.204 346.134 732.421 Q344.236 730.639 340.879 730.639 M336.203 728.648 Q333.194 727.907 331.504 725.847 Q329.838 723.787 329.838 720.824 Q329.838 716.681 332.778 714.273 Q335.74 711.866 340.879 711.866 Q346.041 711.866 348.981 714.273 Q351.921 716.681 351.921 720.824 Q351.921 723.787 350.231 725.847 Q348.564 727.907 345.578 728.648 Q348.958 729.435 350.833 731.727 Q352.731 734.018 352.731 737.329 Q352.731 742.352 349.652 745.037 Q346.597 747.722 340.879 747.722 Q335.162 747.722 332.083 745.037 Q329.028 742.352 329.028 737.329 Q329.028 734.018 330.926 731.727 Q332.824 729.435 336.203 728.648 M334.49 721.264 Q334.49 723.949 336.157 725.454 Q337.847 726.958 340.879 726.958 Q343.889 726.958 345.578 725.454 Q347.291 723.949 347.291 721.264 Q347.291 718.579 345.578 717.074 Q343.889 715.569 340.879 715.569 Q337.847 715.569 336.157 717.074 Q334.49 718.579 334.49 721.264 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M375.208 728.417 Q378.564 729.134 380.439 731.403 Q382.337 733.671 382.337 737.005 Q382.337 742.12 378.819 744.921 Q375.3 747.722 368.819 747.722 Q366.643 747.722 364.328 747.282 Q362.037 746.866 359.583 746.009 L359.583 741.495 Q361.527 742.63 363.842 743.208 Q366.157 743.787 368.68 743.787 Q373.078 743.787 375.37 742.051 Q377.685 740.315 377.685 737.005 Q377.685 733.949 375.532 732.236 Q373.402 730.5 369.583 730.5 L365.555 730.5 L365.555 726.657 L369.768 726.657 Q373.217 726.657 375.046 725.292 Q376.874 723.903 376.874 721.31 Q376.874 718.648 374.976 717.236 Q373.101 715.801 369.583 715.801 Q367.662 715.801 365.463 716.218 Q363.263 716.634 360.625 717.514 L360.625 713.347 Q363.287 712.607 365.601 712.236 Q367.939 711.866 370 711.866 Q375.324 711.866 378.425 714.296 Q381.527 716.704 381.527 720.824 Q381.527 723.694 379.884 725.685 Q378.24 727.653 375.208 728.417 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M392.013 743.116 L399.652 743.116 L399.652 716.75 L391.342 718.417 L391.342 714.157 L399.606 712.491 L404.282 712.491 L404.282 743.116 L411.921 743.116 L411.921 747.051 L392.013 747.051 L392.013 743.116 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M421.411 712.491 L439.768 712.491 L439.768 716.426 L425.694 716.426 L425.694 724.898 Q426.712 724.551 427.731 724.389 Q428.749 724.204 429.768 724.204 Q435.555 724.204 438.934 727.375 Q442.314 730.546 442.314 735.963 Q442.314 741.542 438.842 744.643 Q435.37 747.722 429.05 747.722 Q426.874 747.722 424.606 747.352 Q422.36 746.981 419.953 746.241 L419.953 741.542 Q422.036 742.676 424.258 743.231 Q426.481 743.787 428.958 743.787 Q432.962 743.787 435.3 741.68 Q437.638 739.574 437.638 735.963 Q437.638 732.352 435.3 730.245 Q432.962 728.139 428.958 728.139 Q427.083 728.139 425.208 728.556 Q423.356 728.972 421.411 729.852 L421.411 712.491 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M462.106 727.907 Q458.957 727.907 457.106 730.06 Q455.277 732.213 455.277 735.963 Q455.277 739.69 457.106 741.866 Q458.957 744.018 462.106 744.018 Q465.254 744.018 467.082 741.866 Q468.934 739.69 468.934 735.963 Q468.934 732.213 467.082 730.06 Q465.254 727.907 462.106 727.907 M471.388 713.255 L471.388 717.514 Q469.629 716.681 467.823 716.241 Q466.041 715.801 464.281 715.801 Q459.652 715.801 457.198 718.926 Q454.768 722.051 454.42 728.37 Q455.786 726.356 457.846 725.292 Q459.906 724.204 462.383 724.204 Q467.592 724.204 470.601 727.375 Q473.633 730.523 473.633 735.963 Q473.633 741.287 470.485 744.504 Q467.337 747.722 462.106 747.722 Q456.11 747.722 452.939 743.139 Q449.768 738.532 449.768 729.805 Q449.768 721.611 453.656 716.75 Q457.545 711.866 464.096 711.866 Q465.855 711.866 467.638 712.213 Q469.443 712.56 471.388 713.255 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M495.855 728.417 Q499.212 729.134 501.087 731.403 Q502.985 733.671 502.985 737.005 Q502.985 742.12 499.466 744.921 Q495.948 747.722 489.466 747.722 Q487.291 747.722 484.976 747.282 Q482.684 746.866 480.23 746.009 L480.23 741.495 Q482.175 742.63 484.49 743.208 Q486.804 743.787 489.328 743.787 Q493.726 743.787 496.017 742.051 Q498.332 740.315 498.332 737.005 Q498.332 733.949 496.179 732.236 Q494.05 730.5 490.23 730.5 L486.203 730.5 L486.203 726.657 L490.416 726.657 Q493.865 726.657 495.693 725.292 Q497.522 723.903 497.522 721.31 Q497.522 718.648 495.624 717.236 Q493.749 715.801 490.23 715.801 Q488.309 715.801 486.11 716.218 Q483.911 716.634 481.272 717.514 L481.272 713.347 Q483.934 712.607 486.249 712.236 Q488.587 711.866 490.647 711.866 Q495.971 711.866 499.073 714.296 Q502.175 716.704 502.175 720.824 Q502.175 723.694 500.531 725.685 Q498.888 727.653 495.855 728.417 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M511.99 746.333 L511.99 742.074 Q513.749 742.907 515.554 743.347 Q517.36 743.787 519.096 743.787 Q523.726 743.787 526.156 740.685 Q528.61 737.56 528.957 731.218 Q527.614 733.208 525.554 734.273 Q523.494 735.338 520.994 735.338 Q515.809 735.338 512.777 732.213 Q509.767 729.065 509.767 723.625 Q509.767 718.301 512.915 715.083 Q516.064 711.866 521.295 711.866 Q527.29 711.866 530.438 716.472 Q533.61 721.056 533.61 729.805 Q533.61 737.977 529.721 742.861 Q525.855 747.722 519.304 747.722 Q517.545 747.722 515.739 747.375 Q513.934 747.028 511.99 746.333 M521.295 731.68 Q524.443 731.68 526.272 729.528 Q528.124 727.375 528.124 723.625 Q528.124 719.898 526.272 717.745 Q524.443 715.569 521.295 715.569 Q518.147 715.569 516.295 717.745 Q514.466 719.898 514.466 723.625 Q514.466 727.375 516.295 729.528 Q518.147 731.68 521.295 731.68 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M542.869 751.449 L544.489 751.449 Q547.73 751.449 548.702 750.454 Q549.698 749.458 549.698 746.148 L549.698 740.407 Q549.698 736.796 550.739 735.153 Q551.781 733.509 554.35 732.884 Q551.781 732.305 550.739 730.662 Q549.698 729.018 549.698 725.384 L549.698 719.644 Q549.698 716.356 548.702 715.361 Q547.73 714.343 544.489 714.343 L542.869 714.343 L542.869 711.032 L544.327 711.032 Q550.091 711.032 552.012 712.745 Q553.957 714.435 553.957 719.551 L553.957 725.106 Q553.957 728.556 555.207 729.898 Q556.457 731.218 559.744 731.218 L561.179 731.218 L561.179 734.528 L559.744 734.528 Q556.457 734.528 555.207 735.87 Q553.957 737.213 553.957 740.708 L553.957 746.241 Q553.957 751.356 552.012 753.069 Q550.091 754.782 544.327 754.782 L542.869 754.782 L542.869 751.449 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M138.288 367.716 L138.288 369.799 L118.705 369.799 Q118.982 374.197 121.343 376.512 Q123.728 378.804 127.964 378.804 Q130.417 378.804 132.709 378.202 Q135.024 377.6 137.292 376.396 L137.292 380.424 Q135.001 381.396 132.593 381.906 Q130.186 382.415 127.709 382.415 Q121.505 382.415 117.871 378.804 Q114.26 375.193 114.26 369.035 Q114.26 362.67 117.686 358.943 Q121.135 355.193 126.968 355.193 Q132.2 355.193 135.232 358.572 Q138.288 361.929 138.288 367.716 M134.029 366.466 Q133.982 362.971 132.061 360.887 Q130.163 358.804 127.015 358.804 Q123.45 358.804 121.297 360.818 Q119.168 362.832 118.843 366.489 L134.029 366.466 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M162.94 347.184 L175.51 360.077 L170.857 360.077 L160.672 350.934 L150.487 360.077 L145.834 360.077 L158.403 347.184 L162.94 347.184 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M204.769 386.142 L204.769 389.475 L203.334 389.475 Q197.57 389.475 195.602 387.762 Q193.658 386.049 193.658 380.933 L193.658 375.401 Q193.658 371.906 192.408 370.563 Q191.158 369.221 187.871 369.221 L186.459 369.221 L186.459 365.91 L187.871 365.91 Q191.181 365.91 192.408 364.591 Q193.658 363.248 193.658 359.799 L193.658 354.244 Q193.658 349.128 195.602 347.438 Q197.57 345.725 203.334 345.725 L204.769 345.725 L204.769 349.035 L203.195 349.035 Q199.931 349.035 198.936 350.054 Q197.94 351.072 197.94 354.336 L197.94 360.077 Q197.94 363.711 196.875 365.355 Q195.834 366.998 193.288 367.577 Q195.857 368.202 196.899 369.846 Q197.94 371.489 197.94 375.1 L197.94 380.841 Q197.94 384.105 198.936 385.123 Q199.931 386.142 203.195 386.142 L204.769 386.142 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M215.718 364.915 L245.394 364.915 L245.394 368.85 L215.718 368.85 L215.718 364.915 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M265.486 350.262 Q261.875 350.262 260.046 353.827 Q258.241 357.369 258.241 364.498 Q258.241 371.605 260.046 375.17 Q261.875 378.711 265.486 378.711 Q269.12 378.711 270.926 375.17 Q272.755 371.605 272.755 364.498 Q272.755 357.369 270.926 353.827 Q269.12 350.262 265.486 350.262 M265.486 346.559 Q271.296 346.559 274.352 351.165 Q277.431 355.748 277.431 364.498 Q277.431 373.225 274.352 377.832 Q271.296 382.415 265.486 382.415 Q259.676 382.415 256.597 377.832 Q253.542 373.225 253.542 364.498 Q253.542 355.748 256.597 351.165 Q259.676 346.559 265.486 346.559 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M285.648 375.864 L290.532 375.864 L290.532 381.744 L285.648 381.744 L285.648 375.864 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M301.528 377.808 L309.167 377.808 L309.167 351.443 L300.856 353.109 L300.856 348.85 L309.12 347.184 L313.796 347.184 L313.796 377.808 L321.435 377.808 L321.435 381.744 L301.528 381.744 L301.528 377.808 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M345.046 363.109 Q348.402 363.827 350.277 366.096 Q352.176 368.364 352.176 371.697 Q352.176 376.813 348.657 379.614 Q345.139 382.415 338.657 382.415 Q336.481 382.415 334.166 381.975 Q331.875 381.558 329.421 380.702 L329.421 376.188 Q331.365 377.322 333.68 377.901 Q335.995 378.48 338.518 378.48 Q342.916 378.48 345.208 376.744 Q347.523 375.008 347.523 371.697 Q347.523 368.642 345.37 366.929 Q343.24 365.193 339.421 365.193 L335.393 365.193 L335.393 361.35 L339.606 361.35 Q343.055 361.35 344.884 359.984 Q346.713 358.596 346.713 356.003 Q346.713 353.341 344.814 351.929 Q342.939 350.494 339.421 350.494 Q337.5 350.494 335.301 350.91 Q333.102 351.327 330.463 352.207 L330.463 348.04 Q333.125 347.299 335.44 346.929 Q337.777 346.559 339.838 346.559 Q345.162 346.559 348.264 348.989 Q351.365 351.397 351.365 355.517 Q351.365 358.387 349.722 360.378 Q348.078 362.346 345.046 363.109 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M359.861 347.184 L382.083 347.184 L382.083 349.174 L369.537 381.744 L364.652 381.744 L376.458 351.119 L359.861 351.119 L359.861 347.184 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M405.37 363.109 Q408.726 363.827 410.601 366.096 Q412.499 368.364 412.499 371.697 Q412.499 376.813 408.981 379.614 Q405.462 382.415 398.981 382.415 Q396.805 382.415 394.49 381.975 Q392.198 381.558 389.745 380.702 L389.745 376.188 Q391.689 377.322 394.004 377.901 Q396.319 378.48 398.842 378.48 Q403.24 378.48 405.532 376.744 Q407.847 375.008 407.847 371.697 Q407.847 368.642 405.694 366.929 Q403.564 365.193 399.745 365.193 L395.717 365.193 L395.717 361.35 L399.93 361.35 Q403.379 361.35 405.208 359.984 Q407.036 358.596 407.036 356.003 Q407.036 353.341 405.138 351.929 Q403.263 350.494 399.745 350.494 Q397.823 350.494 395.624 350.91 Q393.425 351.327 390.786 352.207 L390.786 348.04 Q393.448 347.299 395.763 346.929 Q398.101 346.559 400.161 346.559 Q405.485 346.559 408.587 348.989 Q411.689 351.397 411.689 355.517 Q411.689 358.387 410.046 360.378 Q408.402 362.346 405.37 363.109 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M431.944 362.6 Q428.796 362.6 426.944 364.753 Q425.115 366.906 425.115 370.656 Q425.115 374.383 426.944 376.558 Q428.796 378.711 431.944 378.711 Q435.092 378.711 436.92 376.558 Q438.772 374.383 438.772 370.656 Q438.772 366.906 436.92 364.753 Q435.092 362.6 431.944 362.6 M441.226 347.947 L441.226 352.207 Q439.467 351.373 437.661 350.934 Q435.879 350.494 434.12 350.494 Q429.49 350.494 427.036 353.619 Q424.606 356.744 424.258 363.063 Q425.624 361.049 427.684 359.984 Q429.745 358.897 432.221 358.897 Q437.43 358.897 440.439 362.068 Q443.471 365.216 443.471 370.656 Q443.471 375.98 440.323 379.197 Q437.175 382.415 431.944 382.415 Q425.948 382.415 422.777 377.832 Q419.606 373.225 419.606 364.498 Q419.606 356.304 423.495 351.443 Q427.383 346.559 433.934 346.559 Q435.694 346.559 437.476 346.906 Q439.282 347.253 441.226 347.947 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M450.346 347.184 L472.568 347.184 L472.568 349.174 L460.022 381.744 L455.138 381.744 L466.943 351.119 L450.346 351.119 L450.346 347.184 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M485.717 377.808 L502.036 377.808 L502.036 381.744 L480.092 381.744 L480.092 377.808 Q482.754 375.054 487.337 370.424 Q491.943 365.771 493.124 364.429 Q495.369 361.906 496.249 360.17 Q497.152 358.41 497.152 356.721 Q497.152 353.966 495.207 352.23 Q493.286 350.494 490.184 350.494 Q487.985 350.494 485.531 351.258 Q483.101 352.022 480.323 353.572 L480.323 348.85 Q483.147 347.716 485.601 347.137 Q488.054 346.559 490.091 346.559 Q495.462 346.559 498.656 349.244 Q501.851 351.929 501.851 356.42 Q501.851 358.549 501.04 360.471 Q500.253 362.369 498.147 364.961 Q497.568 365.633 494.466 368.85 Q491.365 372.045 485.717 377.808 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M511.99 381.026 L511.99 376.767 Q513.749 377.6 515.554 378.04 Q517.36 378.48 519.096 378.48 Q523.726 378.48 526.156 375.378 Q528.61 372.253 528.957 365.91 Q527.614 367.901 525.554 368.966 Q523.494 370.031 520.994 370.031 Q515.809 370.031 512.777 366.906 Q509.767 363.758 509.767 358.318 Q509.767 352.994 512.915 349.776 Q516.064 346.559 521.295 346.559 Q527.29 346.559 530.438 351.165 Q533.61 355.748 533.61 364.498 Q533.61 372.67 529.721 377.554 Q525.855 382.415 519.304 382.415 Q517.545 382.415 515.739 382.068 Q513.934 381.72 511.99 381.026 M521.295 366.373 Q524.443 366.373 526.272 364.221 Q528.124 362.068 528.124 358.318 Q528.124 354.591 526.272 352.438 Q524.443 350.262 521.295 350.262 Q518.147 350.262 516.295 352.438 Q514.466 354.591 514.466 358.318 Q514.466 362.068 516.295 364.221 Q518.147 366.373 521.295 366.373 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M542.869 386.142 L544.489 386.142 Q547.73 386.142 548.702 385.146 Q549.698 384.151 549.698 380.841 L549.698 375.1 Q549.698 371.489 550.739 369.846 Q551.781 368.202 554.35 367.577 Q551.781 366.998 550.739 365.355 Q549.698 363.711 549.698 360.077 L549.698 354.336 Q549.698 351.049 548.702 350.054 Q547.73 349.035 544.489 349.035 L542.869 349.035 L542.869 345.725 L544.327 345.725 Q550.091 345.725 552.012 347.438 Q553.957 349.128 553.957 354.244 L553.957 359.799 Q553.957 363.248 555.207 364.591 Q556.457 365.91 559.744 365.91 L561.179 365.91 L561.179 369.221 L559.744 369.221 Q556.457 369.221 555.207 370.563 Q553.957 371.906 553.957 375.401 L553.957 380.933 Q553.957 386.049 552.012 387.762 Q550.091 389.475 544.327 389.475 L542.869 389.475 L542.869 386.142 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M16.4842 795.065 L16.4842 785.484 L48.8219 773.358 L16.4842 761.167 L16.4842 751.587 L64.0042 751.587 L64.0042 757.857 L22.277 757.857 L54.8694 770.111 L54.8694 776.572 L22.277 788.826 L64.0042 788.826 L64.0042 795.065 L16.4842 795.065 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M408.121 12.096 L420.315 12.096 L435.749 53.2532 L451.263 12.096 L463.457 12.096 L463.457 72.576 L455.476 72.576 L455.476 19.4686 L439.88 60.9499 L431.657 60.9499 L416.061 19.4686 L416.061 72.576 L408.121 72.576 L408.121 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M499.996 49.7694 Q490.962 49.7694 487.479 51.8354 Q483.995 53.9013 483.995 58.8839 Q483.995 62.8538 486.587 65.2034 Q489.22 67.5124 493.717 67.5124 Q499.915 67.5124 503.642 63.1374 Q507.409 58.7219 507.409 51.4303 L507.409 49.7694 L499.996 49.7694 M514.863 46.6907 L514.863 72.576 L507.409 72.576 L507.409 65.6895 Q504.857 69.8214 501.049 71.8063 Q497.241 73.7508 491.732 73.7508 Q484.764 73.7508 480.633 69.8619 Q476.541 65.9325 476.541 59.3701 Q476.541 51.7138 481.645 47.825 Q486.79 43.9361 496.958 43.9361 L507.409 43.9361 L507.409 43.2069 Q507.409 38.0623 504.006 35.2672 Q500.644 32.4315 494.527 32.4315 Q490.638 32.4315 486.952 33.3632 Q483.266 34.295 479.863 36.1584 L479.863 29.2718 Q483.954 27.692 487.803 26.9223 Q491.651 26.1121 495.297 26.1121 Q505.141 26.1121 510.002 31.2163 Q514.863 36.3204 514.863 46.6907 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M560.071 49.3643 Q560.071 41.2625 556.709 36.8065 Q553.387 32.3505 547.351 32.3505 Q541.356 32.3505 537.993 36.8065 Q534.672 41.2625 534.672 49.3643 Q534.672 57.4256 537.993 61.8816 Q541.356 66.3376 547.351 66.3376 Q553.387 66.3376 556.709 61.8816 Q560.071 57.4256 560.071 49.3643 M567.524 66.9452 Q567.524 78.5308 562.38 84.1616 Q557.235 89.8329 546.622 89.8329 Q542.692 89.8329 539.209 89.2252 Q535.725 88.6581 532.444 87.4428 L532.444 80.1917 Q535.725 81.9741 538.925 82.8248 Q542.125 83.6755 545.447 83.6755 Q552.779 83.6755 556.425 79.8271 Q560.071 76.0193 560.071 68.282 L560.071 64.5957 Q557.762 68.6061 554.156 70.5911 Q550.551 72.576 545.528 72.576 Q537.183 72.576 532.079 66.2161 Q526.975 59.8562 526.975 49.3643 Q526.975 38.832 532.079 32.472 Q537.183 26.1121 545.528 26.1121 Q550.551 26.1121 554.156 28.0971 Q557.762 30.082 560.071 34.0924 L560.071 27.2059 L567.524 27.2059 L567.524 66.9452 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M620.591 45.1919 L620.591 72.576 L613.138 72.576 L613.138 45.4349 Q613.138 38.994 610.626 35.7938 Q608.114 32.5936 603.091 32.5936 Q597.056 32.5936 593.572 36.4419 Q590.088 40.2903 590.088 46.9338 L590.088 72.576 L582.594 72.576 L582.594 27.2059 L590.088 27.2059 L590.088 34.2544 Q592.762 30.163 596.367 28.1376 Q600.013 26.1121 604.752 26.1121 Q612.57 26.1121 616.581 30.9732 Q620.591 35.7938 620.591 45.1919 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M674.266 48.0275 L674.266 51.6733 L639.995 51.6733 Q640.481 59.3701 644.613 63.421 Q648.786 67.4314 656.199 67.4314 Q660.493 67.4314 664.503 66.3781 Q668.554 65.3249 672.524 63.2184 L672.524 70.267 Q668.513 71.9684 664.301 72.8596 Q660.088 73.7508 655.753 73.7508 Q644.897 73.7508 638.537 67.4314 Q632.217 61.1119 632.217 50.3365 Q632.217 39.1965 638.213 32.6746 Q644.249 26.1121 654.457 26.1121 Q663.612 26.1121 668.919 32.0264 Q674.266 37.9003 674.266 48.0275 M666.812 45.84 Q666.731 39.7232 663.369 36.0774 Q660.047 32.4315 654.538 32.4315 Q648.299 32.4315 644.532 35.9558 Q640.805 39.4801 640.238 45.8805 L666.812 45.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M693.872 14.324 L693.872 27.2059 L709.225 27.2059 L709.225 32.9987 L693.872 32.9987 L693.872 57.6282 Q693.872 63.1779 695.371 64.7578 Q696.91 66.3376 701.569 66.3376 L709.225 66.3376 L709.225 72.576 L701.569 72.576 Q692.94 72.576 689.659 69.3758 Q686.378 66.1351 686.378 57.6282 L686.378 32.9987 L680.909 32.9987 L680.909 27.2059 L686.378 27.2059 L686.378 14.324 L693.872 14.324 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M719.028 27.2059 L726.482 27.2059 L726.482 72.576 L719.028 72.576 L719.028 27.2059 M719.028 9.54393 L726.482 9.54393 L726.482 18.9825 L719.028 18.9825 L719.028 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M738.837 27.2059 L774.242 27.2059 L774.242 34.0114 L746.21 66.6212 L774.242 66.6212 L774.242 72.576 L737.824 72.576 L737.824 65.7705 L765.857 33.1607 L738.837 33.1607 L738.837 27.2059 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M806.244 49.7694 Q797.211 49.7694 793.727 51.8354 Q790.243 53.9013 790.243 58.8839 Q790.243 62.8538 792.836 65.2034 Q795.469 67.5124 799.965 67.5124 Q806.163 67.5124 809.89 63.1374 Q813.657 58.7219 813.657 51.4303 L813.657 49.7694 L806.244 49.7694 M821.111 46.6907 L821.111 72.576 L813.657 72.576 L813.657 65.6895 Q811.105 69.8214 807.297 71.8063 Q803.49 73.7508 797.98 73.7508 Q791.013 73.7508 786.881 69.8619 Q782.789 65.9325 782.789 59.3701 Q782.789 51.7138 787.894 47.825 Q793.038 43.9361 803.206 43.9361 L813.657 43.9361 L813.657 43.2069 Q813.657 38.0623 810.255 35.2672 Q806.892 32.4315 800.775 32.4315 Q796.887 32.4315 793.2 33.3632 Q789.514 34.295 786.111 36.1584 L786.111 29.2718 Q790.203 27.692 794.051 26.9223 Q797.899 26.1121 801.545 26.1121 Q811.389 26.1121 816.25 31.2163 Q821.111 36.3204 821.111 46.6907 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M843.837 14.324 L843.837 27.2059 L859.19 27.2059 L859.19 32.9987 L843.837 32.9987 L843.837 57.6282 Q843.837 63.1779 845.335 64.7578 Q846.875 66.3376 851.533 66.3376 L859.19 66.3376 L859.19 72.576 L851.533 72.576 Q842.905 72.576 839.624 69.3758 Q836.342 66.1351 836.342 57.6282 L836.342 32.9987 L830.874 32.9987 L830.874 27.2059 L836.342 27.2059 L836.342 14.324 L843.837 14.324 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M868.993 27.2059 L876.446 27.2059 L876.446 72.576 L868.993 72.576 L868.993 27.2059 M868.993 9.54393 L876.446 9.54393 L876.446 18.9825 L868.993 18.9825 L868.993 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M909.623 32.4315 Q903.628 32.4315 900.144 37.1306 Q896.66 41.7891 896.66 49.9314 Q896.66 58.0738 900.104 62.7728 Q903.587 67.4314 909.623 67.4314 Q915.578 67.4314 919.062 62.7323 Q922.546 58.0333 922.546 49.9314 Q922.546 41.8701 919.062 37.1711 Q915.578 32.4315 909.623 32.4315 M909.623 26.1121 Q919.345 26.1121 924.895 32.4315 Q930.445 38.7509 930.445 49.9314 Q930.445 61.0714 924.895 67.4314 Q919.345 73.7508 909.623 73.7508 Q899.861 73.7508 894.311 67.4314 Q888.802 61.0714 888.802 49.9314 Q888.802 38.7509 894.311 32.4315 Q899.861 26.1121 909.623 26.1121 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M980.514 45.1919 L980.514 72.576 L973.06 72.576 L973.06 45.4349 Q973.06 38.994 970.549 35.7938 Q968.037 32.5936 963.014 32.5936 Q956.978 32.5936 953.495 36.4419 Q950.011 40.2903 950.011 46.9338 L950.011 72.576 L942.517 72.576 L942.517 27.2059 L950.011 27.2059 L950.011 34.2544 Q952.684 30.163 956.29 28.1376 Q959.936 26.1121 964.675 26.1121 Q972.493 26.1121 976.504 30.9732 Q980.514 35.7938 980.514 45.1919 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1039.66 9.62495 Q1034.23 18.942 1031.6 28.0566 Q1028.96 37.1711 1028.96 46.5287 Q1028.96 55.8863 1031.6 65.0818 Q1034.27 74.2369 1039.66 83.5134 L1033.18 83.5134 Q1027.1 73.9938 1024.06 64.7983 Q1021.06 55.6027 1021.06 46.5287 Q1021.06 37.4952 1024.06 28.3401 Q1027.06 19.1851 1033.18 9.62495 L1039.66 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1054.44 12.096 L1066.64 12.096 L1082.07 53.2532 L1097.59 12.096 L1109.78 12.096 L1109.78 72.576 L1101.8 72.576 L1101.8 19.4686 L1086.2 60.9499 L1077.98 60.9499 L1062.38 19.4686 L1062.38 72.576 L1054.44 72.576 L1054.44 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1124.52 9.62495 L1131.01 9.62495 Q1137.08 19.1851 1140.08 28.3401 Q1143.12 37.4952 1143.12 46.5287 Q1143.12 55.6027 1140.08 64.7983 Q1137.08 73.9938 1131.01 83.5134 L1124.52 83.5134 Q1129.91 74.2369 1132.54 65.0818 Q1135.22 55.8863 1135.22 46.5287 Q1135.22 37.1711 1132.54 28.0566 Q1129.91 18.942 1124.52 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1179.09 27.2059 L1186.99 27.2059 L1201.17 65.2844 L1215.35 27.2059 L1223.24 27.2059 L1206.23 72.576 L1196.1 72.576 L1179.09 27.2059 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1262.46 28.5427 L1262.46 35.5912 Q1259.3 33.9709 1255.89 33.1607 Q1252.49 32.3505 1248.85 32.3505 Q1243.3 32.3505 1240.5 34.0519 Q1237.75 35.7533 1237.75 39.156 Q1237.75 41.7486 1239.73 43.2475 Q1241.72 44.7058 1247.71 46.0426 L1250.26 46.6097 Q1258.2 48.3111 1261.53 51.4303 Q1264.89 54.509 1264.89 60.0587 Q1264.89 66.3781 1259.86 70.0644 Q1254.88 73.7508 1246.13 73.7508 Q1242.49 73.7508 1238.52 73.0216 Q1234.59 72.3329 1230.21 70.9151 L1230.21 63.2184 Q1234.34 65.3654 1238.35 66.4591 Q1242.36 67.5124 1246.29 67.5124 Q1251.56 67.5124 1254.4 65.73 Q1257.23 63.9071 1257.23 60.6258 Q1257.23 57.5877 1255.17 55.9673 Q1253.14 54.3469 1246.21 52.8481 L1243.62 52.2405 Q1236.69 50.7821 1233.61 47.7845 Q1230.54 44.7463 1230.54 39.4801 Q1230.54 33.0797 1235.07 29.5959 Q1239.61 26.1121 1247.95 26.1121 Q1252.09 26.1121 1255.73 26.7198 Q1259.38 27.3274 1262.46 28.5427 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1303.45 12.096 L1338.21 12.096 L1338.21 18.9825 L1311.64 18.9825 L1311.64 36.8065 L1335.62 36.8065 L1335.62 43.6931 L1311.64 43.6931 L1311.64 72.576 L1303.45 72.576 L1303.45 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1344.81 27.2059 L1352.27 27.2059 L1352.27 72.576 L1344.81 72.576 L1344.81 27.2059 M1344.81 9.54393 L1352.27 9.54393 L1352.27 18.9825 L1344.81 18.9825 L1344.81 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1406.67 48.0275 L1406.67 51.6733 L1372.4 51.6733 Q1372.88 59.3701 1377.02 63.421 Q1381.19 67.4314 1388.6 67.4314 Q1392.9 67.4314 1396.91 66.3781 Q1400.96 65.3249 1404.93 63.2184 L1404.93 70.267 Q1400.92 71.9684 1396.7 72.8596 Q1392.49 73.7508 1388.16 73.7508 Q1377.3 73.7508 1370.94 67.4314 Q1364.62 61.1119 1364.62 50.3365 Q1364.62 39.1965 1370.62 32.6746 Q1376.65 26.1121 1386.86 26.1121 Q1396.02 26.1121 1401.32 32.0264 Q1406.67 37.9003 1406.67 48.0275 M1399.22 45.84 Q1399.13 39.7232 1395.77 36.0774 Q1392.45 32.4315 1386.94 32.4315 Q1380.7 32.4315 1376.94 35.9558 Q1373.21 39.4801 1372.64 45.8805 L1399.22 45.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1418.9 9.54393 L1426.36 9.54393 L1426.36 72.576 L1418.9 72.576 L1418.9 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1471.81 34.0924 L1471.81 9.54393 L1479.26 9.54393 L1479.26 72.576 L1471.81 72.576 L1471.81 65.7705 Q1469.46 69.8214 1465.85 71.8063 Q1462.29 73.7508 1457.27 73.7508 Q1449.04 73.7508 1443.86 67.1883 Q1438.71 60.6258 1438.71 49.9314 Q1438.71 39.2371 1443.86 32.6746 Q1449.04 26.1121 1457.27 26.1121 Q1462.29 26.1121 1465.85 28.0971 Q1469.46 30.0415 1471.81 34.0924 M1446.41 49.9314 Q1446.41 58.1548 1449.77 62.8538 Q1453.17 67.5124 1459.09 67.5124 Q1465 67.5124 1468.41 62.8538 Q1471.81 58.1548 1471.81 49.9314 Q1471.81 41.7081 1468.41 37.0496 Q1465 32.3505 1459.09 32.3505 Q1453.17 32.3505 1449.77 37.0496 Q1446.41 41.7081 1446.41 49.9314 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1538.89 9.62495 Q1533.46 18.942 1530.83 28.0566 Q1528.2 37.1711 1528.2 46.5287 Q1528.2 55.8863 1530.83 65.0818 Q1533.5 74.2369 1538.89 83.5134 L1532.41 83.5134 Q1526.33 73.9938 1523.29 64.7983 Q1520.3 55.6027 1520.3 46.5287 Q1520.3 37.4952 1523.29 28.3401 Q1526.29 19.1851 1532.41 9.62495 L1538.89 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1561.86 43.6931 L1561.86 65.8515 L1574.98 65.8515 Q1581.59 65.8515 1584.75 63.1374 Q1587.95 60.3828 1587.95 54.752 Q1587.95 49.0808 1584.75 46.4072 Q1581.59 43.6931 1574.98 43.6931 L1561.86 43.6931 M1561.86 18.8205 L1561.86 37.0496 L1573.97 37.0496 Q1579.97 37.0496 1582.88 34.8216 Q1585.84 32.5531 1585.84 27.935 Q1585.84 23.3575 1582.88 21.089 Q1579.97 18.8205 1573.97 18.8205 L1561.86 18.8205 M1553.68 12.096 L1574.58 12.096 Q1583.94 12.096 1589 15.9849 Q1594.06 19.8737 1594.06 27.0438 Q1594.06 32.5936 1591.47 35.8748 Q1588.88 39.156 1583.86 39.9662 Q1589.89 41.2625 1593.21 45.3944 Q1596.58 49.4858 1596.58 55.6432 Q1596.58 63.745 1591.07 68.1605 Q1585.56 72.576 1575.39 72.576 L1553.68 72.576 L1553.68 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1609.09 9.62495 L1615.57 9.62495 Q1621.65 19.1851 1624.65 28.3401 Q1627.69 37.4952 1627.69 46.5287 Q1627.69 55.6027 1624.65 64.7983 Q1621.65 73.9938 1615.57 83.5134 L1609.09 83.5134 Q1614.48 74.2369 1617.11 65.0818 Q1619.79 55.8863 1619.79 46.5287 Q1619.79 37.1711 1617.11 28.0566 Q1614.48 18.942 1609.09 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1691.97 9.54393 L1691.97 15.7418 L1684.84 15.7418 Q1680.83 15.7418 1679.25 17.3622 Q1677.72 18.9825 1677.72 23.1955 L1677.72 27.2059 L1689.99 27.2059 L1689.99 32.9987 L1677.72 32.9987 L1677.72 72.576 L1670.22 72.576 L1670.22 32.9987 L1663.09 32.9987 L1663.09 27.2059 L1670.22 27.2059 L1670.22 24.0462 Q1670.22 16.471 1673.75 13.0277 Q1677.27 9.54393 1684.93 9.54393 L1691.97 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1715.79 32.4315 Q1709.8 32.4315 1706.31 37.1306 Q1702.83 41.7891 1702.83 49.9314 Q1702.83 58.0738 1706.27 62.7728 Q1709.76 67.4314 1715.79 67.4314 Q1721.75 67.4314 1725.23 62.7323 Q1728.72 58.0333 1728.72 49.9314 Q1728.72 41.8701 1725.23 37.1711 Q1721.75 32.4315 1715.79 32.4315 M1715.79 26.1121 Q1725.52 26.1121 1731.07 32.4315 Q1736.62 38.7509 1736.62 49.9314 Q1736.62 61.0714 1731.07 67.4314 Q1725.52 73.7508 1715.79 73.7508 Q1706.03 73.7508 1700.48 67.4314 Q1694.97 61.0714 1694.97 49.9314 Q1694.97 38.7509 1700.48 32.4315 Q1706.03 26.1121 1715.79 26.1121 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1775.26 34.1734 Q1774.01 33.4443 1772.51 33.1202 Q1771.05 32.7556 1769.27 32.7556 Q1762.95 32.7556 1759.54 36.8875 Q1756.18 40.9789 1756.18 48.6757 L1756.18 72.576 L1748.69 72.576 L1748.69 27.2059 L1756.18 27.2059 L1756.18 34.2544 Q1758.53 30.1225 1762.3 28.1376 Q1766.07 26.1121 1771.45 26.1121 Q1772.22 26.1121 1773.15 26.2337 Q1774.09 26.3147 1775.22 26.5172 L1775.26 34.1734 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1809.77 12.096 L1817.96 12.096 L1817.96 72.576 L1809.77 72.576 L1809.77 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1862.84 28.5427 L1862.84 35.5912 Q1859.68 33.9709 1856.28 33.1607 Q1852.88 32.3505 1849.23 32.3505 Q1843.68 32.3505 1840.89 34.0519 Q1838.13 35.7533 1838.13 39.156 Q1838.13 41.7486 1840.12 43.2475 Q1842.1 44.7058 1848.1 46.0426 L1850.65 46.6097 Q1858.59 48.3111 1861.91 51.4303 Q1865.27 54.509 1865.27 60.0587 Q1865.27 66.3781 1860.25 70.0644 Q1855.27 73.7508 1846.52 73.7508 Q1842.87 73.7508 1838.9 73.0216 Q1834.97 72.3329 1830.6 70.9151 L1830.6 63.2184 Q1834.73 65.3654 1838.74 66.4591 Q1842.75 67.5124 1846.68 67.5124 Q1851.94 67.5124 1854.78 65.73 Q1857.62 63.9071 1857.62 60.6258 Q1857.62 57.5877 1855.55 55.9673 Q1853.52 54.3469 1846.6 52.8481 L1844 52.2405 Q1837.08 50.7821 1834 47.7845 Q1830.92 44.7463 1830.92 39.4801 Q1830.92 33.0797 1835.46 29.5959 Q1839.99 26.1121 1848.34 26.1121 Q1852.47 26.1121 1856.12 26.7198 Q1859.76 27.3274 1862.84 28.5427 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1877.14 27.2059 L1884.59 27.2059 L1884.59 72.576 L1877.14 72.576 L1877.14 27.2059 M1877.14 9.54393 L1884.59 9.54393 L1884.59 18.9825 L1877.14 18.9825 L1877.14 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1937.9 45.1919 L1937.9 72.576 L1930.45 72.576 L1930.45 45.4349 Q1930.45 38.994 1927.94 35.7938 Q1925.43 32.5936 1920.4 32.5936 Q1914.37 32.5936 1910.89 36.4419 Q1907.4 40.2903 1907.4 46.9338 L1907.4 72.576 L1899.91 72.576 L1899.91 27.2059 L1907.4 27.2059 L1907.4 34.2544 Q1910.08 30.163 1913.68 28.1376 Q1917.33 26.1121 1922.07 26.1121 Q1929.88 26.1121 1933.89 30.9732 Q1937.9 35.7938 1937.9 45.1919 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1982.63 49.3643 Q1982.63 41.2625 1979.26 36.8065 Q1975.94 32.3505 1969.91 32.3505 Q1963.91 32.3505 1960.55 36.8065 Q1957.23 41.2625 1957.23 49.3643 Q1957.23 57.4256 1960.55 61.8816 Q1963.91 66.3376 1969.91 66.3376 Q1975.94 66.3376 1979.26 61.8816 Q1982.63 57.4256 1982.63 49.3643 M1990.08 66.9452 Q1990.08 78.5308 1984.94 84.1616 Q1979.79 89.8329 1969.18 89.8329 Q1965.25 89.8329 1961.76 89.2252 Q1958.28 88.6581 1955 87.4428 L1955 80.1917 Q1958.28 81.9741 1961.48 82.8248 Q1964.68 83.6755 1968 83.6755 Q1975.34 83.6755 1978.98 79.8271 Q1982.63 76.0193 1982.63 68.282 L1982.63 64.5957 Q1980.32 68.6061 1976.71 70.5911 Q1973.11 72.576 1968.08 72.576 Q1959.74 72.576 1954.64 66.2161 Q1949.53 59.8562 1949.53 49.3643 Q1949.53 38.832 1954.64 32.472 Q1959.74 26.1121 1968.08 26.1121 Q1973.11 26.1121 1976.71 28.0971 Q1980.32 30.082 1982.63 34.0924 L1982.63 27.2059 L1990.08 27.2059 L1990.08 66.9452 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2032.13 12.096 L2044.32 12.096 L2059.76 53.2532 L2075.27 12.096 L2087.46 12.096 L2087.46 72.576 L2079.48 72.576 L2079.48 19.4686 L2063.89 60.9499 L2055.66 60.9499 L2040.07 19.4686 L2040.07 72.576 L2032.13 72.576 L2032.13 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2120.97 32.4315 Q2114.97 32.4315 2111.49 37.1306 Q2108 41.7891 2108 49.9314 Q2108 58.0738 2111.45 62.7728 Q2114.93 67.4314 2120.97 67.4314 Q2126.92 67.4314 2130.4 62.7323 Q2133.89 58.0333 2133.89 49.9314 Q2133.89 41.8701 2130.4 37.1711 Q2126.92 32.4315 2120.97 32.4315 M2120.97 26.1121 Q2130.69 26.1121 2136.24 32.4315 Q2141.79 38.7509 2141.79 49.9314 Q2141.79 61.0714 2136.24 67.4314 Q2130.69 73.7508 2120.97 73.7508 Q2111.2 73.7508 2105.65 67.4314 Q2100.14 61.0714 2100.14 49.9314 Q2100.14 38.7509 2105.65 32.4315 Q2111.2 26.1121 2120.97 26.1121 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2184 34.0924 L2184 9.54393 L2191.45 9.54393 L2191.45 72.576 L2184 72.576 L2184 65.7705 Q2181.65 69.8214 2178.04 71.8063 Q2174.48 73.7508 2169.45 73.7508 Q2161.23 73.7508 2156.05 67.1883 Q2150.9 60.6258 2150.9 49.9314 Q2150.9 39.2371 2156.05 32.6746 Q2161.23 26.1121 2169.45 26.1121 Q2174.48 26.1121 2178.04 28.0971 Q2181.65 30.0415 2184 34.0924 M2158.6 49.9314 Q2158.6 58.1548 2161.96 62.8538 Q2165.36 67.5124 2171.28 67.5124 Q2177.19 67.5124 2180.59 62.8538 Q2184 58.1548 2184 49.9314 Q2184 41.7081 2180.59 37.0496 Q2177.19 32.3505 2171.28 32.3505 Q2165.36 32.3505 2161.96 37.0496 Q2158.6 41.7081 2158.6 49.9314 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2245.61 48.0275 L2245.61 51.6733 L2211.34 51.6733 Q2211.83 59.3701 2215.96 63.421 Q2220.13 67.4314 2227.54 67.4314 Q2231.84 67.4314 2235.85 66.3781 Q2239.9 65.3249 2243.87 63.2184 L2243.87 70.267 Q2239.86 71.9684 2235.65 72.8596 Q2231.43 73.7508 2227.1 73.7508 Q2216.24 73.7508 2209.88 67.4314 Q2203.56 61.1119 2203.56 50.3365 Q2203.56 39.1965 2209.56 32.6746 Q2215.59 26.1121 2225.8 26.1121 Q2234.96 26.1121 2240.26 32.0264 Q2245.61 37.9003 2245.61 48.0275 M2238.16 45.84 Q2238.08 39.7232 2234.71 36.0774 Q2231.39 32.4315 2225.88 32.4315 Q2219.65 32.4315 2215.88 35.9558 Q2212.15 39.4801 2211.58 45.8805 L2238.16 45.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2257.85 9.54393 L2265.3 9.54393 L2265.3 72.576 L2257.85 72.576 L2257.85 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2327.89 49.7694 Q2318.85 49.7694 2315.37 51.8354 Q2311.88 53.9013 2311.88 58.8839 Q2311.88 62.8538 2314.48 65.2034 Q2317.11 67.5124 2321.61 67.5124 Q2327.8 67.5124 2331.53 63.1374 Q2335.3 58.7219 2335.3 51.4303 L2335.3 49.7694 L2327.89 49.7694 M2342.75 46.6907 L2342.75 72.576 L2335.3 72.576 L2335.3 65.6895 Q2332.75 69.8214 2328.94 71.8063 Q2325.13 73.7508 2319.62 73.7508 Q2312.65 73.7508 2308.52 69.8619 Q2304.43 65.9325 2304.43 59.3701 Q2304.43 51.7138 2309.53 47.825 Q2314.68 43.9361 2324.85 43.9361 L2335.3 43.9361 L2335.3 43.2069 Q2335.3 38.0623 2331.9 35.2672 Q2328.53 32.4315 2322.42 32.4315 Q2318.53 32.4315 2314.84 33.3632 Q2311.16 34.295 2307.75 36.1584 L2307.75 29.2718 Q2311.84 27.692 2315.69 26.9223 Q2319.54 26.1121 2323.19 26.1121 Q2333.03 26.1121 2337.89 31.2163 Q2342.75 36.3204 2342.75 46.6907 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2365.48 14.324 L2365.48 27.2059 L2380.83 27.2059 L2380.83 32.9987 L2365.48 32.9987 L2365.48 57.6282 Q2365.48 63.1779 2366.98 64.7578 Q2368.52 66.3376 2373.17 66.3376 L2380.83 66.3376 L2380.83 72.576 L2373.17 72.576 Q2364.55 72.576 2361.26 69.3758 Q2357.98 66.1351 2357.98 57.6282 L2357.98 32.9987 L2352.51 32.9987 L2352.51 27.2059 L2357.98 27.2059 L2357.98 14.324 L2365.48 14.324 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2408.94 12.096 L2460.11 12.096 L2460.11 18.9825 L2438.64 18.9825 L2438.64 72.576 L2430.41 72.576 L2430.41 18.9825 L2408.94 18.9825 L2408.94 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2502.16 86.3491 L2502.16 92.1419 L2459.05 92.1419 L2459.05 86.3491 L2502.16 86.3491 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M2541.81 28.9478 L2541.81 35.9153 Q2538.65 34.1734 2535.45 33.3227 Q2532.29 32.4315 2529.05 32.4315 Q2521.8 32.4315 2517.79 37.0496 Q2513.78 41.6271 2513.78 49.9314 Q2513.78 58.2358 2517.79 62.8538 Q2521.8 67.4314 2529.05 67.4314 Q2532.29 67.4314 2535.45 66.5807 Q2538.65 65.6895 2541.81 63.9476 L2541.81 70.8341 Q2538.69 72.2924 2535.33 73.0216 Q2532.01 73.7508 2528.24 73.7508 Q2517.99 73.7508 2511.96 67.3098 Q2505.92 60.8689 2505.92 49.9314 Q2505.92 38.832 2512 32.472 Q2518.12 26.1121 2528.73 26.1121 Q2532.17 26.1121 2535.45 26.8413 Q2538.73 27.5299 2541.81 28.9478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><circle clip-path="url(#clip252)" cx="646.865" cy="1386.4" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="938.508" cy="1167.63" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1145.43" cy="947.597" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1305.94" cy="854.723" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1437.08" cy="781.257" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1547.95" cy="706.575" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1644" cy="633.642" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1728.72" cy="572.613" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1804.5" cy="504.173" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1873.06" cy="455.641" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1935.64" cy="425.429" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="1993.22" cy="385.345" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2046.52" cy="327.076" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2096.15" cy="316.825" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2142.57" cy="281.627" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2186.17" cy="254.435" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2227.29" cy="222.965" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2266.18" cy="201.549" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip252)" cx="2303.07" cy="170.461" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<polyline clip-path="url(#clip252)" style="stroke:#ff0000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" stroke-dasharray="16, 10" points="646.865,1352.51 938.508,1142.57 1145.43,993.608 1305.94,878.066 1437.08,783.662 1547.95,703.844 1644,634.703 1728.72,573.716 1804.5,519.161 1873.06,469.811 1935.64,424.757 1993.22,383.312 2046.52,344.939 2096.15,309.215 2142.57,275.798 2186.17,244.407 2227.29,214.811 2266.18,186.815 2303.07,160.256 "></polyline> +<path clip-path="url(#clip250)" d="M655.698 322.316 L1677.66 322.316 L1677.66 166.796 L655.698 166.796 Z" fill="#ffffff" fill-rule="evenodd" fill-opacity="1"></path> +<polyline clip-path="url(#clip250)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="655.698,322.316 1677.66,322.316 1677.66,166.796 655.698,166.796 655.698,322.316 "></polyline> +<circle clip-path="url(#clip250)" cx="733.724" cy="218.636" r="20.48" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="4.55111"></circle> +<path clip-path="url(#clip250)" d="M811.75 201.356 L818.717 201.356 L827.537 224.874 L836.402 201.356 L843.37 201.356 L843.37 235.916 L838.81 235.916 L838.81 205.569 L829.898 229.272 L825.199 229.272 L816.287 205.569 L816.287 235.916 L811.75 235.916 L811.75 201.356 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M864.481 209.99 L868.995 209.99 L877.096 231.749 L885.198 209.99 L889.712 209.99 L879.99 235.916 L874.203 235.916 L864.481 209.99 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M912.119 210.754 L912.119 214.782 Q910.314 213.856 908.369 213.393 Q906.425 212.93 904.342 212.93 Q901.17 212.93 899.573 213.902 Q897.999 214.874 897.999 216.819 Q897.999 218.3 899.133 219.157 Q900.268 219.99 903.694 220.754 L905.152 221.078 Q909.689 222.05 911.587 223.832 Q913.508 225.592 913.508 228.763 Q913.508 232.374 910.638 234.481 Q907.791 236.587 902.791 236.587 Q900.707 236.587 898.439 236.17 Q896.194 235.777 893.694 234.967 L893.694 230.569 Q896.055 231.795 898.346 232.42 Q900.638 233.022 902.883 233.022 Q905.893 233.022 907.513 232.004 Q909.133 230.962 909.133 229.087 Q909.133 227.351 907.953 226.425 Q906.795 225.499 902.837 224.643 L901.356 224.295 Q897.397 223.462 895.638 221.749 Q893.879 220.013 893.879 217.004 Q893.879 213.346 896.471 211.356 Q899.064 209.365 903.832 209.365 Q906.194 209.365 908.277 209.712 Q910.36 210.059 912.119 210.754 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M935.545 201.356 L940.221 201.356 L940.221 215.522 L957.212 215.522 L957.212 201.356 L961.888 201.356 L961.888 235.916 L957.212 235.916 L957.212 219.457 L940.221 219.457 L940.221 235.916 L935.545 235.916 L935.545 201.356 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><polyline clip-path="url(#clip250)" style="stroke:#ff0000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" stroke-dasharray="16, 10" points="675.205,270.476 792.243,270.476 "></polyline> +<path clip-path="url(#clip250)" d="M811.75 251.737 L816.009 251.737 L816.009 287.756 L811.75 287.756 L811.75 251.737 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M824.921 261.83 L829.18 261.83 L829.18 287.756 L824.921 287.756 L824.921 261.83 M824.921 251.737 L829.18 251.737 L829.18 257.131 L824.921 257.131 L824.921 251.737 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M859.643 272.108 L859.643 287.756 L855.384 287.756 L855.384 272.247 Q855.384 268.566 853.948 266.737 Q852.513 264.909 849.643 264.909 Q846.194 264.909 844.203 267.108 Q842.212 269.307 842.212 273.103 L842.212 287.756 L837.93 287.756 L837.93 261.83 L842.212 261.83 L842.212 265.858 Q843.74 263.52 845.8 262.362 Q847.884 261.205 850.592 261.205 Q855.06 261.205 857.351 263.983 Q859.643 266.737 859.643 272.108 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M890.314 273.728 L890.314 275.811 L870.731 275.811 Q871.009 280.209 873.37 282.524 Q875.754 284.816 879.99 284.816 Q882.444 284.816 884.735 284.214 Q887.05 283.612 889.319 282.409 L889.319 286.436 Q887.027 287.408 884.62 287.918 Q882.212 288.427 879.735 288.427 Q873.532 288.427 869.897 284.816 Q866.286 281.205 866.286 275.047 Q866.286 268.682 869.712 264.955 Q873.161 261.205 878.995 261.205 Q884.226 261.205 887.258 264.585 Q890.314 267.941 890.314 273.728 M886.055 272.478 Q886.008 268.983 884.087 266.899 Q882.189 264.816 879.041 264.816 Q875.476 264.816 873.323 266.83 Q871.194 268.844 870.87 272.501 L886.055 272.478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M909.087 274.723 Q903.925 274.723 901.934 275.904 Q899.944 277.084 899.944 279.932 Q899.944 282.2 901.425 283.543 Q902.93 284.862 905.499 284.862 Q909.041 284.862 911.17 282.362 Q913.323 279.839 913.323 275.672 L913.323 274.723 L909.087 274.723 M917.582 272.964 L917.582 287.756 L913.323 287.756 L913.323 283.821 Q911.865 286.182 909.689 287.316 Q907.513 288.427 904.365 288.427 Q900.383 288.427 898.022 286.205 Q895.684 283.959 895.684 280.209 Q895.684 275.834 898.601 273.612 Q901.541 271.39 907.351 271.39 L913.323 271.39 L913.323 270.973 Q913.323 268.034 911.379 266.436 Q909.457 264.816 905.962 264.816 Q903.74 264.816 901.633 265.348 Q899.527 265.881 897.582 266.946 L897.582 263.01 Q899.92 262.108 902.119 261.668 Q904.319 261.205 906.402 261.205 Q912.027 261.205 914.805 264.122 Q917.582 267.038 917.582 272.964 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M941.378 265.811 Q940.661 265.395 939.804 265.21 Q938.971 265.001 937.953 265.001 Q934.341 265.001 932.397 267.362 Q930.476 269.7 930.476 274.098 L930.476 287.756 L926.193 287.756 L926.193 261.83 L930.476 261.83 L930.476 265.858 Q931.818 263.497 933.971 262.362 Q936.124 261.205 939.203 261.205 Q939.642 261.205 940.175 261.274 Q940.707 261.321 941.355 261.436 L941.378 265.811 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M975.938 265.811 Q975.221 265.395 974.364 265.21 Q973.531 265.001 972.513 265.001 Q968.901 265.001 966.957 267.362 Q965.036 269.7 965.036 274.098 L965.036 287.756 L960.753 287.756 L960.753 261.83 L965.036 261.83 L965.036 265.858 Q966.378 263.497 968.531 262.362 Q970.684 261.205 973.763 261.205 Q974.202 261.205 974.735 261.274 Q975.267 261.321 975.915 261.436 L975.938 265.811 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1001.54 273.728 L1001.54 275.811 L981.957 275.811 Q982.235 280.209 984.596 282.524 Q986.98 284.816 991.216 284.816 Q993.67 284.816 995.962 284.214 Q998.276 283.612 1000.54 282.409 L1000.54 286.436 Q998.253 287.408 995.846 287.918 Q993.438 288.427 990.962 288.427 Q984.758 288.427 981.124 284.816 Q977.513 281.205 977.513 275.047 Q977.513 268.682 980.938 264.955 Q984.388 261.205 990.221 261.205 Q995.452 261.205 998.485 264.585 Q1001.54 267.941 1001.54 273.728 M997.281 272.478 Q997.235 268.983 995.313 266.899 Q993.415 264.816 990.267 264.816 Q986.702 264.816 984.55 266.83 Q982.42 268.844 982.096 272.501 L997.281 272.478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1025.59 274.492 Q1025.59 269.862 1023.67 267.316 Q1021.77 264.77 1018.32 264.77 Q1014.9 264.77 1012.98 267.316 Q1011.08 269.862 1011.08 274.492 Q1011.08 279.098 1012.98 281.645 Q1014.9 284.191 1018.32 284.191 Q1021.77 284.191 1023.67 281.645 Q1025.59 279.098 1025.59 274.492 M1029.85 284.538 Q1029.85 291.158 1026.91 294.376 Q1023.97 297.617 1017.91 297.617 Q1015.66 297.617 1013.67 297.27 Q1011.68 296.945 1009.8 296.251 L1009.8 292.108 Q1011.68 293.126 1013.51 293.612 Q1015.34 294.098 1017.23 294.098 Q1021.42 294.098 1023.51 291.899 Q1025.59 289.723 1025.59 285.302 L1025.59 283.196 Q1024.27 285.487 1022.21 286.621 Q1020.15 287.756 1017.28 287.756 Q1012.51 287.756 1009.6 284.121 Q1006.68 280.487 1006.68 274.492 Q1006.68 268.473 1009.6 264.839 Q1012.51 261.205 1017.28 261.205 Q1020.15 261.205 1022.21 262.339 Q1024.27 263.473 1025.59 265.765 L1025.59 261.83 L1029.85 261.83 L1029.85 284.538 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1053.65 265.811 Q1052.93 265.395 1052.07 265.21 Q1051.24 265.001 1050.22 265.001 Q1046.61 265.001 1044.66 267.362 Q1042.74 269.7 1042.74 274.098 L1042.74 287.756 L1038.46 287.756 L1038.46 261.83 L1042.74 261.83 L1042.74 265.858 Q1044.09 263.497 1046.24 262.362 Q1048.39 261.205 1051.47 261.205 Q1051.91 261.205 1052.44 261.274 Q1052.98 261.321 1053.62 261.436 L1053.65 265.811 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1079.25 273.728 L1079.25 275.811 L1059.66 275.811 Q1059.94 280.209 1062.3 282.524 Q1064.69 284.816 1068.92 284.816 Q1071.38 284.816 1073.67 284.214 Q1075.98 283.612 1078.25 282.409 L1078.25 286.436 Q1075.96 287.408 1073.55 287.918 Q1071.15 288.427 1068.67 288.427 Q1062.47 288.427 1058.83 284.816 Q1055.22 281.205 1055.22 275.047 Q1055.22 268.682 1058.65 264.955 Q1062.1 261.205 1067.93 261.205 Q1073.16 261.205 1076.19 264.585 Q1079.25 267.941 1079.25 273.728 M1074.99 272.478 Q1074.94 268.983 1073.02 266.899 Q1071.12 264.816 1067.98 264.816 Q1064.41 264.816 1062.26 266.83 Q1060.13 268.844 1059.8 272.501 L1074.99 272.478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1102.77 262.594 L1102.77 266.622 Q1100.96 265.696 1099.02 265.233 Q1097.07 264.77 1094.99 264.77 Q1091.82 264.77 1090.22 265.742 Q1088.65 266.714 1088.65 268.659 Q1088.65 270.14 1089.78 270.997 Q1090.91 271.83 1094.34 272.594 L1095.8 272.918 Q1100.34 273.89 1102.23 275.672 Q1104.16 277.432 1104.16 280.603 Q1104.16 284.214 1101.29 286.321 Q1098.44 288.427 1093.44 288.427 Q1091.35 288.427 1089.09 288.01 Q1086.84 287.617 1084.34 286.807 L1084.34 282.409 Q1086.7 283.635 1088.99 284.26 Q1091.29 284.862 1093.53 284.862 Q1096.54 284.862 1098.16 283.844 Q1099.78 282.802 1099.78 280.927 Q1099.78 279.191 1098.6 278.265 Q1097.44 277.339 1093.48 276.483 L1092 276.135 Q1088.04 275.302 1086.29 273.589 Q1084.53 271.853 1084.53 268.844 Q1084.53 265.186 1087.12 263.196 Q1089.71 261.205 1094.48 261.205 Q1096.84 261.205 1098.92 261.552 Q1101.01 261.899 1102.77 262.594 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1127.47 262.594 L1127.47 266.622 Q1125.66 265.696 1123.72 265.233 Q1121.77 264.77 1119.69 264.77 Q1116.52 264.77 1114.92 265.742 Q1113.35 266.714 1113.35 268.659 Q1113.35 270.14 1114.48 270.997 Q1115.61 271.83 1119.04 272.594 L1120.5 272.918 Q1125.03 273.89 1126.93 275.672 Q1128.85 277.432 1128.85 280.603 Q1128.85 284.214 1125.98 286.321 Q1123.14 288.427 1118.14 288.427 Q1116.05 288.427 1113.78 288.01 Q1111.54 287.617 1109.04 286.807 L1109.04 282.409 Q1111.4 283.635 1113.69 284.26 Q1115.98 284.862 1118.23 284.862 Q1121.24 284.862 1122.86 283.844 Q1124.48 282.802 1124.48 280.927 Q1124.48 279.191 1123.3 278.265 Q1122.14 277.339 1118.18 276.483 L1116.7 276.135 Q1112.74 275.302 1110.98 273.589 Q1109.22 271.853 1109.22 268.844 Q1109.22 265.186 1111.82 263.196 Q1114.41 261.205 1119.18 261.205 Q1121.54 261.205 1123.62 261.552 Q1125.71 261.899 1127.47 262.594 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1135.64 261.83 L1139.9 261.83 L1139.9 287.756 L1135.64 287.756 L1135.64 261.83 M1135.64 251.737 L1139.9 251.737 L1139.9 257.131 L1135.64 257.131 L1135.64 251.737 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1158.85 264.816 Q1155.43 264.816 1153.44 267.501 Q1151.45 270.163 1151.45 274.816 Q1151.45 279.469 1153.41 282.154 Q1155.41 284.816 1158.85 284.816 Q1162.26 284.816 1164.25 282.131 Q1166.24 279.446 1166.24 274.816 Q1166.24 270.21 1164.25 267.524 Q1162.26 264.816 1158.85 264.816 M1158.85 261.205 Q1164.41 261.205 1167.58 264.816 Q1170.75 268.427 1170.75 274.816 Q1170.75 281.182 1167.58 284.816 Q1164.41 288.427 1158.85 288.427 Q1153.28 288.427 1150.1 284.816 Q1146.96 281.182 1146.96 274.816 Q1146.96 268.427 1150.1 264.816 Q1153.28 261.205 1158.85 261.205 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1199.36 272.108 L1199.36 287.756 L1195.1 287.756 L1195.1 272.247 Q1195.1 268.566 1193.67 266.737 Q1192.23 264.909 1189.36 264.909 Q1185.91 264.909 1183.92 267.108 Q1181.93 269.307 1181.93 273.103 L1181.93 287.756 L1177.65 287.756 L1177.65 261.83 L1181.93 261.83 L1181.93 265.858 Q1183.46 263.52 1185.52 262.362 Q1187.6 261.205 1190.31 261.205 Q1194.78 261.205 1197.07 263.983 Q1199.36 266.737 1199.36 272.108 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1223.48 266.228 L1253.16 266.228 L1253.16 270.117 L1223.48 270.117 L1223.48 266.228 M1223.48 275.672 L1253.16 275.672 L1253.16 279.608 L1223.48 279.608 L1223.48 275.672 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1275.57 272.872 L1288.04 272.872 L1288.04 276.668 L1275.57 276.668 L1275.57 272.872 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1305.43 256.274 Q1301.82 256.274 1299.99 259.839 Q1298.18 263.381 1298.18 270.51 Q1298.18 277.617 1299.99 281.182 Q1301.82 284.723 1305.43 284.723 Q1309.06 284.723 1310.87 281.182 Q1312.7 277.617 1312.7 270.51 Q1312.7 263.381 1310.87 259.839 Q1309.06 256.274 1305.43 256.274 M1305.43 252.571 Q1311.24 252.571 1314.29 257.177 Q1317.37 261.76 1317.37 270.51 Q1317.37 279.237 1314.29 283.844 Q1311.24 288.427 1305.43 288.427 Q1299.62 288.427 1296.54 283.844 Q1293.48 279.237 1293.48 270.51 Q1293.48 261.76 1296.54 257.177 Q1299.62 252.571 1305.43 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1325.59 281.876 L1330.47 281.876 L1330.47 287.756 L1325.59 287.756 L1325.59 281.876 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1350.66 256.274 Q1347.05 256.274 1345.22 259.839 Q1343.41 263.381 1343.41 270.51 Q1343.41 277.617 1345.22 281.182 Q1347.05 284.723 1350.66 284.723 Q1354.29 284.723 1356.1 281.182 Q1357.93 277.617 1357.93 270.51 Q1357.93 263.381 1356.1 259.839 Q1354.29 256.274 1350.66 256.274 M1350.66 252.571 Q1356.47 252.571 1359.52 257.177 Q1362.6 261.76 1362.6 270.51 Q1362.6 279.237 1359.52 283.844 Q1356.47 288.427 1350.66 288.427 Q1344.85 288.427 1341.77 283.844 Q1338.71 279.237 1338.71 270.51 Q1338.71 261.76 1341.77 257.177 Q1344.85 252.571 1350.66 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1380.82 256.274 Q1377.21 256.274 1375.38 259.839 Q1373.58 263.381 1373.58 270.51 Q1373.58 277.617 1375.38 281.182 Q1377.21 284.723 1380.82 284.723 Q1384.45 284.723 1386.26 281.182 Q1388.09 277.617 1388.09 270.51 Q1388.09 263.381 1386.26 259.839 Q1384.45 256.274 1380.82 256.274 M1380.82 252.571 Q1386.63 252.571 1389.69 257.177 Q1392.76 261.76 1392.76 270.51 Q1392.76 279.237 1389.69 283.844 Q1386.63 288.427 1380.82 288.427 Q1375.01 288.427 1371.93 283.844 Q1368.88 279.237 1368.88 270.51 Q1368.88 261.76 1371.93 257.177 Q1375.01 252.571 1380.82 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1399.8 253.196 L1422.02 253.196 L1422.02 255.186 L1409.48 287.756 L1404.59 287.756 L1416.4 257.131 L1399.8 257.131 L1399.8 253.196 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1462.95 258.034 L1462.95 270.927 L1475.84 270.927 L1475.84 274.862 L1462.95 274.862 L1462.95 287.756 L1459.06 287.756 L1459.06 274.862 L1446.17 274.862 L1446.17 270.927 L1459.06 270.927 L1459.06 258.034 L1462.95 258.034 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1511.01 256.274 Q1507.39 256.274 1505.57 259.839 Q1503.76 263.381 1503.76 270.51 Q1503.76 277.617 1505.57 281.182 Q1507.39 284.723 1511.01 284.723 Q1514.64 284.723 1516.44 281.182 Q1518.27 277.617 1518.27 270.51 Q1518.27 263.381 1516.44 259.839 Q1514.64 256.274 1511.01 256.274 M1511.01 252.571 Q1516.82 252.571 1519.87 257.177 Q1522.95 261.76 1522.95 270.51 Q1522.95 279.237 1519.87 283.844 Q1516.82 288.427 1511.01 288.427 Q1505.19 288.427 1502.12 283.844 Q1499.06 279.237 1499.06 270.51 Q1499.06 261.76 1502.12 257.177 Q1505.19 252.571 1511.01 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1531.17 281.876 L1536.05 281.876 L1536.05 287.756 L1531.17 287.756 L1531.17 281.876 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1556.24 256.274 Q1552.63 256.274 1550.8 259.839 Q1548.99 263.381 1548.99 270.51 Q1548.99 277.617 1550.8 281.182 Q1552.63 284.723 1556.24 284.723 Q1559.87 284.723 1561.68 281.182 Q1563.5 277.617 1563.5 270.51 Q1563.5 263.381 1561.68 259.839 Q1559.87 256.274 1556.24 256.274 M1556.24 252.571 Q1562.05 252.571 1565.1 257.177 Q1568.18 261.76 1568.18 270.51 Q1568.18 279.237 1565.1 283.844 Q1562.05 288.427 1556.24 288.427 Q1550.43 288.427 1547.35 283.844 Q1544.29 279.237 1544.29 270.51 Q1544.29 261.76 1547.35 257.177 Q1550.43 252.571 1556.24 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1586.98 268.612 Q1583.83 268.612 1581.98 270.765 Q1580.15 272.918 1580.15 276.668 Q1580.15 280.395 1581.98 282.571 Q1583.83 284.723 1586.98 284.723 Q1590.13 284.723 1591.95 282.571 Q1593.81 280.395 1593.81 276.668 Q1593.81 272.918 1591.95 270.765 Q1590.13 268.612 1586.98 268.612 M1596.26 253.96 L1596.26 258.219 Q1594.5 257.386 1592.69 256.946 Q1590.91 256.506 1589.15 256.506 Q1584.52 256.506 1582.07 259.631 Q1579.64 262.756 1579.29 269.075 Q1580.66 267.061 1582.72 265.997 Q1584.78 264.909 1587.25 264.909 Q1592.46 264.909 1595.47 268.08 Q1598.5 271.228 1598.5 276.668 Q1598.5 281.992 1595.36 285.209 Q1592.21 288.427 1586.98 288.427 Q1580.98 288.427 1577.81 283.844 Q1574.64 279.237 1574.64 270.51 Q1574.64 262.316 1578.53 257.455 Q1582.42 252.571 1588.97 252.571 Q1590.73 252.571 1592.51 252.918 Q1594.31 253.265 1596.26 253.96 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1606.61 253.196 L1624.96 253.196 L1624.96 257.131 L1610.89 257.131 L1610.89 265.603 Q1611.91 265.256 1612.93 265.094 Q1613.94 264.909 1614.96 264.909 Q1620.75 264.909 1624.13 268.08 Q1627.51 271.251 1627.51 276.668 Q1627.51 282.246 1624.04 285.348 Q1620.56 288.427 1614.25 288.427 Q1612.07 288.427 1609.8 288.057 Q1607.56 287.686 1605.15 286.946 L1605.15 282.246 Q1607.23 283.381 1609.45 283.936 Q1611.68 284.492 1614.15 284.492 Q1618.16 284.492 1620.5 282.385 Q1622.83 280.279 1622.83 276.668 Q1622.83 273.057 1620.5 270.95 Q1618.16 268.844 1614.15 268.844 Q1612.28 268.844 1610.4 269.26 Q1608.55 269.677 1606.61 270.557 L1606.61 253.196 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip250)" d="M1657.67 261.83 L1648.3 274.446 L1658.16 287.756 L1653.13 287.756 L1645.59 277.571 L1638.04 287.756 L1633.02 287.756 L1643.09 274.191 L1633.87 261.83 L1638.9 261.83 L1645.77 271.066 L1652.65 261.83 L1657.67 261.83 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path></svg>
\ No newline at end of file diff --git a/hw7/mvsb2.svg b/hw7/mvsb2.svg new file mode 100644 index 0000000..9415495 --- /dev/null +++ b/hw7/mvsb2.svg @@ -0,0 +1,46 @@ +<svg xmlns="http://www.w3.org/2000/svg" xmlns:xlink="http://www.w3.org/1999/xlink" width="600" height="400" viewBox="0 0 2400 1600"> +<defs> + <clipPath id="clip290"> + <rect x="0" y="0" width="2400" height="1600"></rect> + </clipPath> +</defs> +<path clip-path="url(#clip290)" d="M0 1600 L2400 1600 L2400 8.88178e-14 L0 8.88178e-14 Z" fill="#ffffff" fill-rule="evenodd" fill-opacity="1"></path> +<defs> + <clipPath id="clip291"> + <rect x="480" y="0" width="1681" height="1600"></rect> + </clipPath> +</defs> +<path clip-path="url(#clip290)" d="M597.179 1423.18 L2352.76 1423.18 L2352.76 123.472 L597.179 123.472 Z" fill="#ffffff" fill-rule="evenodd" fill-opacity="1"></path> +<defs> + <clipPath id="clip292"> + <rect x="597" y="123" width="1757" height="1301"></rect> + </clipPath> +</defs> +<polyline clip-path="url(#clip292)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="1302.87,1423.18 1302.87,123.472 "></polyline> +<polyline clip-path="url(#clip292)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="2022.15,1423.18 2022.15,123.472 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,1423.18 2352.76,1423.18 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="1302.87,1423.18 1302.87,1404.28 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="2022.15,1423.18 2022.15,1404.28 "></polyline> +<path clip-path="url(#clip290)" d="M1231.62 1471.55 L1231.62 1473.64 L1212.03 1473.64 Q1212.31 1478.03 1214.67 1480.35 Q1217.06 1482.64 1221.29 1482.64 Q1223.75 1482.64 1226.04 1482.04 Q1228.35 1481.44 1230.62 1480.23 L1230.62 1484.26 Q1228.33 1485.23 1225.92 1485.74 Q1223.51 1486.25 1221.04 1486.25 Q1214.83 1486.25 1211.2 1482.64 Q1207.59 1479.03 1207.59 1472.87 Q1207.59 1466.51 1211.01 1462.78 Q1214.46 1459.03 1220.3 1459.03 Q1225.53 1459.03 1228.56 1462.41 Q1231.62 1465.77 1231.62 1471.55 M1227.36 1470.3 Q1227.31 1466.81 1225.39 1464.72 Q1223.49 1462.64 1220.34 1462.64 Q1216.78 1462.64 1214.63 1464.65 Q1212.5 1466.67 1212.17 1470.33 L1227.36 1470.3 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1256.27 1451.02 L1268.84 1463.91 L1264.19 1463.91 L1254 1454.77 L1243.81 1463.91 L1239.16 1463.91 L1251.73 1451.02 L1256.27 1451.02 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1298.1 1489.98 L1298.1 1493.31 L1296.66 1493.31 Q1290.9 1493.31 1288.93 1491.6 Q1286.99 1489.89 1286.99 1484.77 L1286.99 1479.24 Q1286.99 1475.74 1285.74 1474.4 Q1284.49 1473.06 1281.2 1473.06 L1279.79 1473.06 L1279.79 1469.75 L1281.2 1469.75 Q1284.51 1469.75 1285.74 1468.43 Q1286.99 1467.08 1286.99 1463.64 L1286.99 1458.08 Q1286.99 1452.96 1288.93 1451.27 Q1290.9 1449.56 1296.66 1449.56 L1298.1 1449.56 L1298.1 1452.87 L1296.52 1452.87 Q1293.26 1452.87 1292.26 1453.89 Q1291.27 1454.91 1291.27 1458.17 L1291.27 1463.91 Q1291.27 1467.55 1290.2 1469.19 Q1289.16 1470.83 1286.62 1471.41 Q1289.19 1472.04 1290.23 1473.68 Q1291.27 1475.33 1291.27 1478.94 L1291.27 1484.68 Q1291.27 1487.94 1292.26 1488.96 Q1293.26 1489.98 1296.52 1489.98 L1298.1 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1309.05 1468.75 L1338.72 1468.75 L1338.72 1472.69 L1309.05 1472.69 L1309.05 1468.75 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1362.98 1466.95 Q1366.34 1467.66 1368.21 1469.93 Q1370.11 1472.2 1370.11 1475.53 Q1370.11 1480.65 1366.59 1483.45 Q1363.07 1486.25 1356.59 1486.25 Q1354.42 1486.25 1352.1 1485.81 Q1349.81 1485.39 1347.36 1484.54 L1347.36 1480.02 Q1349.3 1481.16 1351.62 1481.74 Q1353.93 1482.32 1356.45 1482.32 Q1360.85 1482.32 1363.14 1480.58 Q1365.46 1478.84 1365.46 1475.53 Q1365.46 1472.48 1363.31 1470.77 Q1361.18 1469.03 1357.36 1469.03 L1353.33 1469.03 L1353.33 1465.19 L1357.54 1465.19 Q1360.99 1465.19 1362.82 1463.82 Q1364.65 1462.43 1364.65 1459.84 Q1364.65 1457.18 1362.75 1455.77 Q1360.87 1454.33 1357.36 1454.33 Q1355.43 1454.33 1353.24 1454.75 Q1351.04 1455.16 1348.4 1456.04 L1348.4 1451.88 Q1351.06 1451.14 1353.37 1450.77 Q1355.71 1450.39 1357.77 1450.39 Q1363.1 1450.39 1366.2 1452.83 Q1369.3 1455.23 1369.3 1459.35 Q1369.3 1462.22 1367.66 1464.21 Q1366.01 1466.18 1362.98 1466.95 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1379.83 1489.98 L1381.45 1489.98 Q1384.69 1489.98 1385.67 1488.98 Q1386.66 1487.99 1386.66 1484.68 L1386.66 1478.94 Q1386.66 1475.33 1387.7 1473.68 Q1388.74 1472.04 1391.31 1471.41 Q1388.74 1470.83 1387.7 1469.19 Q1386.66 1467.55 1386.66 1463.91 L1386.66 1458.17 Q1386.66 1454.89 1385.67 1453.89 Q1384.69 1452.87 1381.45 1452.87 L1379.83 1452.87 L1379.83 1449.56 L1381.29 1449.56 Q1387.05 1449.56 1388.98 1451.27 Q1390.92 1452.96 1390.92 1458.08 L1390.92 1463.64 Q1390.92 1467.08 1392.17 1468.43 Q1393.42 1469.75 1396.71 1469.75 L1398.14 1469.75 L1398.14 1473.06 L1396.71 1473.06 Q1393.42 1473.06 1392.17 1474.4 Q1390.92 1475.74 1390.92 1479.24 L1390.92 1484.77 Q1390.92 1489.89 1388.98 1491.6 Q1387.05 1493.31 1381.29 1493.31 L1379.83 1493.31 L1379.83 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1950.9 1471.55 L1950.9 1473.64 L1931.31 1473.64 Q1931.59 1478.03 1933.95 1480.35 Q1936.34 1482.64 1940.57 1482.64 Q1943.03 1482.64 1945.32 1482.04 Q1947.63 1481.44 1949.9 1480.23 L1949.9 1484.26 Q1947.61 1485.23 1945.2 1485.74 Q1942.79 1486.25 1940.32 1486.25 Q1934.11 1486.25 1930.48 1482.64 Q1926.87 1479.03 1926.87 1472.87 Q1926.87 1466.51 1930.29 1462.78 Q1933.74 1459.03 1939.58 1459.03 Q1944.81 1459.03 1947.84 1462.41 Q1950.9 1465.77 1950.9 1471.55 M1946.64 1470.3 Q1946.59 1466.81 1944.67 1464.72 Q1942.77 1462.64 1939.62 1462.64 Q1936.06 1462.64 1933.91 1464.65 Q1931.78 1466.67 1931.45 1470.33 L1946.64 1470.3 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1975.55 1451.02 L1988.12 1463.91 L1983.47 1463.91 L1973.28 1454.77 L1963.1 1463.91 L1958.44 1463.91 L1971.01 1451.02 L1975.55 1451.02 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2017.38 1489.98 L2017.38 1493.31 L2015.94 1493.31 Q2010.18 1493.31 2008.21 1491.6 Q2006.27 1489.89 2006.27 1484.77 L2006.27 1479.24 Q2006.27 1475.74 2005.02 1474.4 Q2003.77 1473.06 2000.48 1473.06 L1999.07 1473.06 L1999.07 1469.75 L2000.48 1469.75 Q2003.79 1469.75 2005.02 1468.43 Q2006.27 1467.08 2006.27 1463.64 L2006.27 1458.08 Q2006.27 1452.96 2008.21 1451.27 Q2010.18 1449.56 2015.94 1449.56 L2017.38 1449.56 L2017.38 1452.87 L2015.8 1452.87 Q2012.54 1452.87 2011.54 1453.89 Q2010.55 1454.91 2010.55 1458.17 L2010.55 1463.91 Q2010.55 1467.55 2009.48 1469.19 Q2008.44 1470.83 2005.9 1471.41 Q2008.47 1472.04 2009.51 1473.68 Q2010.55 1475.33 2010.55 1478.94 L2010.55 1484.68 Q2010.55 1487.94 2011.54 1488.96 Q2012.54 1489.98 2015.8 1489.98 L2017.38 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2028.33 1468.75 L2058 1468.75 L2058 1472.69 L2028.33 1472.69 L2028.33 1468.75 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2072.12 1481.64 L2088.44 1481.64 L2088.44 1485.58 L2066.5 1485.58 L2066.5 1481.64 Q2069.16 1478.89 2073.74 1474.26 Q2078.35 1469.61 2079.53 1468.27 Q2081.78 1465.74 2082.66 1464.01 Q2083.56 1462.25 2083.56 1460.56 Q2083.56 1457.8 2081.61 1456.07 Q2079.69 1454.33 2076.59 1454.33 Q2074.39 1454.33 2071.94 1455.09 Q2069.51 1455.86 2066.73 1457.41 L2066.73 1452.69 Q2069.55 1451.55 2072.01 1450.97 Q2074.46 1450.39 2076.5 1450.39 Q2081.87 1450.39 2085.06 1453.08 Q2088.26 1455.77 2088.26 1460.26 Q2088.26 1462.39 2087.45 1464.31 Q2086.66 1466.2 2084.55 1468.8 Q2083.97 1469.47 2080.87 1472.69 Q2077.77 1475.88 2072.12 1481.64 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2099.11 1489.98 L2100.73 1489.98 Q2103.97 1489.98 2104.95 1488.98 Q2105.94 1487.99 2105.94 1484.68 L2105.94 1478.94 Q2105.94 1475.33 2106.98 1473.68 Q2108.03 1472.04 2110.59 1471.41 Q2108.03 1470.83 2106.98 1469.19 Q2105.94 1467.55 2105.94 1463.91 L2105.94 1458.17 Q2105.94 1454.89 2104.95 1453.89 Q2103.97 1452.87 2100.73 1452.87 L2099.11 1452.87 L2099.11 1449.56 L2100.57 1449.56 Q2106.34 1449.56 2108.26 1451.27 Q2110.2 1452.96 2110.2 1458.08 L2110.2 1463.64 Q2110.2 1467.08 2111.45 1468.43 Q2112.7 1469.75 2115.99 1469.75 L2117.42 1469.75 L2117.42 1473.06 L2115.99 1473.06 Q2112.7 1473.06 2111.45 1474.4 Q2110.2 1475.74 2110.2 1479.24 L2110.2 1484.77 Q2110.2 1489.89 2108.26 1491.6 Q2106.34 1493.31 2100.57 1493.31 L2099.11 1493.31 L2099.11 1489.98 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1456.86 1520.52 L1463.29 1520.52 L1463.29 1540 L1486.65 1540 L1486.65 1520.52 L1493.08 1520.52 L1493.08 1568.04 L1486.65 1568.04 L1486.65 1545.41 L1463.29 1545.41 L1463.29 1568.04 L1456.86 1568.04 L1456.86 1520.52 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><polyline clip-path="url(#clip292)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="597.179,1112.82 2352.76,1112.82 "></polyline> +<polyline clip-path="url(#clip292)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="597.179,740.195 2352.76,740.195 "></polyline> +<polyline clip-path="url(#clip292)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:2; stroke-opacity:0.1; fill:none" points="597.179,367.573 2352.76,367.573 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,1423.18 597.179,123.472 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,1112.82 616.077,1112.82 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,740.195 616.077,740.195 "></polyline> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="597.179,367.573 616.077,367.573 "></polyline> +<path clip-path="url(#clip290)" d="M138.288 1116.07 L138.288 1118.15 L118.705 1118.15 Q118.982 1122.55 121.343 1124.87 Q123.728 1127.16 127.964 1127.16 Q130.417 1127.16 132.709 1126.55 Q135.024 1125.95 137.292 1124.75 L137.292 1128.78 Q135.001 1129.75 132.593 1130.26 Q130.186 1130.77 127.709 1130.77 Q121.505 1130.77 117.871 1127.16 Q114.26 1123.55 114.26 1117.39 Q114.26 1111.02 117.686 1107.3 Q121.135 1103.55 126.968 1103.55 Q132.2 1103.55 135.232 1106.93 Q138.288 1110.28 138.288 1116.07 M134.029 1114.82 Q133.982 1111.32 132.061 1109.24 Q130.163 1107.16 127.015 1107.16 Q123.45 1107.16 121.297 1109.17 Q119.168 1111.18 118.843 1114.84 L134.029 1114.82 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M162.94 1095.54 L175.51 1108.43 L170.857 1108.43 L160.672 1099.29 L150.487 1108.43 L145.834 1108.43 L158.403 1095.54 L162.94 1095.54 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M204.769 1134.49 L204.769 1137.83 L203.334 1137.83 Q197.57 1137.83 195.602 1136.11 Q193.658 1134.4 193.658 1129.29 L193.658 1123.75 Q193.658 1120.26 192.408 1118.92 Q191.158 1117.57 187.871 1117.57 L186.459 1117.57 L186.459 1114.26 L187.871 1114.26 Q191.181 1114.26 192.408 1112.94 Q193.658 1111.6 193.658 1108.15 L193.658 1102.6 Q193.658 1097.48 195.602 1095.79 Q197.57 1094.08 203.334 1094.08 L204.769 1094.08 L204.769 1097.39 L203.195 1097.39 Q199.931 1097.39 198.936 1098.41 Q197.94 1099.43 197.94 1102.69 L197.94 1108.43 Q197.94 1112.06 196.875 1113.71 Q195.834 1115.35 193.288 1115.93 Q195.857 1116.55 196.899 1118.2 Q197.94 1119.84 197.94 1123.45 L197.94 1129.19 Q197.94 1132.46 198.936 1133.48 Q199.931 1134.49 203.195 1134.49 L204.769 1134.49 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M215.718 1113.27 L245.394 1113.27 L245.394 1117.2 L215.718 1117.2 L215.718 1113.27 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M265.486 1098.62 Q261.875 1098.62 260.046 1102.18 Q258.241 1105.72 258.241 1112.85 Q258.241 1119.96 260.046 1123.52 Q261.875 1127.06 265.486 1127.06 Q269.12 1127.06 270.926 1123.52 Q272.755 1119.96 272.755 1112.85 Q272.755 1105.72 270.926 1102.18 Q269.12 1098.62 265.486 1098.62 M265.486 1094.91 Q271.296 1094.91 274.352 1099.52 Q277.431 1104.1 277.431 1112.85 Q277.431 1121.58 274.352 1126.18 Q271.296 1130.77 265.486 1130.77 Q259.676 1130.77 256.597 1126.18 Q253.542 1121.58 253.542 1112.85 Q253.542 1104.1 256.597 1099.52 Q259.676 1094.91 265.486 1094.91 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M285.648 1124.22 L290.532 1124.22 L290.532 1130.1 L285.648 1130.1 L285.648 1124.22 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M304.745 1126.16 L321.065 1126.16 L321.065 1130.1 L299.12 1130.1 L299.12 1126.16 Q301.782 1123.41 306.366 1118.78 Q310.972 1114.12 312.153 1112.78 Q314.398 1110.26 315.278 1108.52 Q316.18 1106.76 316.18 1105.07 Q316.18 1102.32 314.236 1100.58 Q312.315 1098.85 309.213 1098.85 Q307.014 1098.85 304.56 1099.61 Q302.13 1100.37 299.352 1101.93 L299.352 1097.2 Q302.176 1096.07 304.63 1095.49 Q307.083 1094.91 309.12 1094.91 Q314.491 1094.91 317.685 1097.6 Q320.879 1100.28 320.879 1104.77 Q320.879 1106.9 320.069 1108.82 Q319.282 1110.72 317.176 1113.31 Q316.597 1113.99 313.495 1117.2 Q310.393 1120.4 304.745 1126.16 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M334.907 1126.16 L351.226 1126.16 L351.226 1130.1 L329.282 1130.1 L329.282 1126.16 Q331.944 1123.41 336.527 1118.78 Q341.134 1114.12 342.314 1112.78 Q344.56 1110.26 345.439 1108.52 Q346.342 1106.76 346.342 1105.07 Q346.342 1102.32 344.398 1100.58 Q342.477 1098.85 339.375 1098.85 Q337.176 1098.85 334.722 1099.61 Q332.291 1100.37 329.514 1101.93 L329.514 1097.2 Q332.338 1096.07 334.791 1095.49 Q337.245 1094.91 339.282 1094.91 Q344.652 1094.91 347.847 1097.6 Q351.041 1100.28 351.041 1104.77 Q351.041 1106.9 350.231 1108.82 Q349.444 1110.72 347.338 1113.31 Q346.759 1113.99 343.657 1117.2 Q340.555 1120.4 334.907 1126.16 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M371.041 1113.68 Q367.708 1113.68 365.787 1115.47 Q363.888 1117.25 363.888 1120.37 Q363.888 1123.5 365.787 1125.28 Q367.708 1127.06 371.041 1127.06 Q374.375 1127.06 376.296 1125.28 Q378.217 1123.48 378.217 1120.37 Q378.217 1117.25 376.296 1115.47 Q374.398 1113.68 371.041 1113.68 M366.365 1111.69 Q363.356 1110.95 361.666 1108.89 Q360 1106.83 360 1103.87 Q360 1099.73 362.939 1097.32 Q365.902 1094.91 371.041 1094.91 Q376.203 1094.91 379.143 1097.32 Q382.083 1099.73 382.083 1103.87 Q382.083 1106.83 380.393 1108.89 Q378.726 1110.95 375.74 1111.69 Q379.12 1112.48 380.995 1114.77 Q382.893 1117.06 382.893 1120.37 Q382.893 1125.4 379.814 1128.08 Q376.759 1130.77 371.041 1130.77 Q365.324 1130.77 362.245 1128.08 Q359.189 1125.4 359.189 1120.37 Q359.189 1117.06 361.088 1114.77 Q362.986 1112.48 366.365 1111.69 M364.652 1104.31 Q364.652 1106.99 366.319 1108.5 Q368.009 1110 371.041 1110 Q374.05 1110 375.74 1108.5 Q377.453 1106.99 377.453 1104.31 Q377.453 1101.62 375.74 1100.12 Q374.05 1098.62 371.041 1098.62 Q368.009 1098.62 366.319 1100.12 Q364.652 1101.62 364.652 1104.31 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M391.342 1129.38 L391.342 1125.12 Q393.101 1125.95 394.907 1126.39 Q396.712 1126.83 398.448 1126.83 Q403.078 1126.83 405.509 1123.73 Q407.962 1120.61 408.31 1114.26 Q406.967 1116.25 404.907 1117.32 Q402.847 1118.38 400.347 1118.38 Q395.161 1118.38 392.129 1115.26 Q389.12 1112.11 389.12 1106.67 Q389.12 1101.35 392.268 1098.13 Q395.416 1094.91 400.648 1094.91 Q406.643 1094.91 409.791 1099.52 Q412.962 1104.1 412.962 1112.85 Q412.962 1121.02 409.073 1125.91 Q405.208 1130.77 398.657 1130.77 Q396.898 1130.77 395.092 1130.42 Q393.286 1130.07 391.342 1129.38 M400.648 1114.73 Q403.796 1114.73 405.624 1112.57 Q407.476 1110.42 407.476 1106.67 Q407.476 1102.94 405.624 1100.79 Q403.796 1098.62 400.648 1098.62 Q397.499 1098.62 395.648 1100.79 Q393.819 1102.94 393.819 1106.67 Q393.819 1110.42 395.648 1112.57 Q397.499 1114.73 400.648 1114.73 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M434.212 1099.61 L422.407 1118.06 L434.212 1118.06 L434.212 1099.61 M432.985 1095.54 L438.865 1095.54 L438.865 1118.06 L443.795 1118.06 L443.795 1121.95 L438.865 1121.95 L438.865 1130.1 L434.212 1130.1 L434.212 1121.95 L418.61 1121.95 L418.61 1117.43 L432.985 1095.54 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M451.573 1095.54 L469.93 1095.54 L469.93 1099.47 L455.856 1099.47 L455.856 1107.94 Q456.874 1107.6 457.893 1107.43 Q458.911 1107.25 459.93 1107.25 Q465.717 1107.25 469.096 1110.42 Q472.476 1113.59 472.476 1119.01 Q472.476 1124.59 469.004 1127.69 Q465.531 1130.77 459.212 1130.77 Q457.036 1130.77 454.768 1130.4 Q452.522 1130.03 450.115 1129.29 L450.115 1124.59 Q452.198 1125.72 454.42 1126.28 Q456.643 1126.83 459.119 1126.83 Q463.124 1126.83 465.462 1124.73 Q467.8 1122.62 467.8 1119.01 Q467.8 1115.4 465.462 1113.29 Q463.124 1111.18 459.119 1111.18 Q457.244 1111.18 455.369 1111.6 Q453.518 1112.02 451.573 1112.9 L451.573 1095.54 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M494.536 1099.61 L482.73 1118.06 L494.536 1118.06 L494.536 1099.61 M493.309 1095.54 L499.189 1095.54 L499.189 1118.06 L504.119 1118.06 L504.119 1121.95 L499.189 1121.95 L499.189 1130.1 L494.536 1130.1 L494.536 1121.95 L478.934 1121.95 L478.934 1117.43 L493.309 1095.54 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M511.99 1129.38 L511.99 1125.12 Q513.749 1125.95 515.554 1126.39 Q517.36 1126.83 519.096 1126.83 Q523.726 1126.83 526.156 1123.73 Q528.61 1120.61 528.957 1114.26 Q527.614 1116.25 525.554 1117.32 Q523.494 1118.38 520.994 1118.38 Q515.809 1118.38 512.777 1115.26 Q509.767 1112.11 509.767 1106.67 Q509.767 1101.35 512.915 1098.13 Q516.064 1094.91 521.295 1094.91 Q527.29 1094.91 530.438 1099.52 Q533.61 1104.1 533.61 1112.85 Q533.61 1121.02 529.721 1125.91 Q525.855 1130.77 519.304 1130.77 Q517.545 1130.77 515.739 1130.42 Q513.934 1130.07 511.99 1129.38 M521.295 1114.73 Q524.443 1114.73 526.272 1112.57 Q528.124 1110.42 528.124 1106.67 Q528.124 1102.94 526.272 1100.79 Q524.443 1098.62 521.295 1098.62 Q518.147 1098.62 516.295 1100.79 Q514.466 1102.94 514.466 1106.67 Q514.466 1110.42 516.295 1112.57 Q518.147 1114.73 521.295 1114.73 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M542.869 1134.49 L544.489 1134.49 Q547.73 1134.49 548.702 1133.5 Q549.698 1132.5 549.698 1129.19 L549.698 1123.45 Q549.698 1119.84 550.739 1118.2 Q551.781 1116.55 554.35 1115.93 Q551.781 1115.35 550.739 1113.71 Q549.698 1112.06 549.698 1108.43 L549.698 1102.69 Q549.698 1099.4 548.702 1098.41 Q547.73 1097.39 544.489 1097.39 L542.869 1097.39 L542.869 1094.08 L544.327 1094.08 Q550.091 1094.08 552.012 1095.79 Q553.957 1097.48 553.957 1102.6 L553.957 1108.15 Q553.957 1111.6 555.207 1112.94 Q556.457 1114.26 559.744 1114.26 L561.179 1114.26 L561.179 1117.57 L559.744 1117.57 Q556.457 1117.57 555.207 1118.92 Q553.957 1120.26 553.957 1123.75 L553.957 1129.29 Q553.957 1134.4 552.012 1136.11 Q550.091 1137.83 544.327 1137.83 L542.869 1137.83 L542.869 1134.49 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M138.288 743.447 L138.288 745.53 L118.705 745.53 Q118.982 749.928 121.343 752.243 Q123.728 754.535 127.964 754.535 Q130.417 754.535 132.709 753.933 Q135.024 753.331 137.292 752.127 L137.292 756.155 Q135.001 757.127 132.593 757.637 Q130.186 758.146 127.709 758.146 Q121.505 758.146 117.871 754.535 Q114.26 750.924 114.26 744.766 Q114.26 738.401 117.686 734.674 Q121.135 730.924 126.968 730.924 Q132.2 730.924 135.232 734.303 Q138.288 737.66 138.288 743.447 M134.029 742.197 Q133.982 738.702 132.061 736.618 Q130.163 734.535 127.015 734.535 Q123.45 734.535 121.297 736.549 Q119.168 738.563 118.843 742.22 L134.029 742.197 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M162.94 722.915 L175.51 735.808 L170.857 735.808 L160.672 726.665 L150.487 735.808 L145.834 735.808 L158.403 722.915 L162.94 722.915 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M204.769 761.873 L204.769 765.206 L203.334 765.206 Q197.57 765.206 195.602 763.493 Q193.658 761.78 193.658 756.664 L193.658 751.132 Q193.658 747.637 192.408 746.294 Q191.158 744.951 187.871 744.951 L186.459 744.951 L186.459 741.641 L187.871 741.641 Q191.181 741.641 192.408 740.322 Q193.658 738.979 193.658 735.53 L193.658 729.975 Q193.658 724.859 195.602 723.169 Q197.57 721.456 203.334 721.456 L204.769 721.456 L204.769 724.766 L203.195 724.766 Q199.931 724.766 198.936 725.785 Q197.94 726.803 197.94 730.067 L197.94 735.808 Q197.94 739.442 196.875 741.086 Q195.834 742.729 193.288 743.308 Q195.857 743.933 196.899 745.576 Q197.94 747.22 197.94 750.831 L197.94 756.572 Q197.94 759.836 198.936 760.854 Q199.931 761.873 203.195 761.873 L204.769 761.873 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M215.718 740.646 L245.394 740.646 L245.394 744.581 L215.718 744.581 L215.718 740.646 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M265.486 725.993 Q261.875 725.993 260.046 729.558 Q258.241 733.1 258.241 740.229 Q258.241 747.336 260.046 750.901 Q261.875 754.442 265.486 754.442 Q269.12 754.442 270.926 750.901 Q272.755 747.336 272.755 740.229 Q272.755 733.1 270.926 729.558 Q269.12 725.993 265.486 725.993 M265.486 722.29 Q271.296 722.29 274.352 726.896 Q277.431 731.479 277.431 740.229 Q277.431 748.956 274.352 753.563 Q271.296 758.146 265.486 758.146 Q259.676 758.146 256.597 753.563 Q253.542 748.956 253.542 740.229 Q253.542 731.479 256.597 726.896 Q259.676 722.29 265.486 722.29 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M285.648 751.595 L290.532 751.595 L290.532 757.475 L285.648 757.475 L285.648 751.595 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M301.528 753.539 L309.167 753.539 L309.167 727.174 L300.856 728.84 L300.856 724.581 L309.12 722.915 L313.796 722.915 L313.796 753.539 L321.435 753.539 L321.435 757.475 L301.528 757.475 L301.528 753.539 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M340.879 741.063 Q337.546 741.063 335.625 742.845 Q333.727 744.627 333.727 747.752 Q333.727 750.877 335.625 752.66 Q337.546 754.442 340.879 754.442 Q344.213 754.442 346.134 752.66 Q348.055 750.854 348.055 747.752 Q348.055 744.627 346.134 742.845 Q344.236 741.063 340.879 741.063 M336.203 739.072 Q333.194 738.331 331.504 736.271 Q329.838 734.211 329.838 731.248 Q329.838 727.104 332.778 724.697 Q335.74 722.29 340.879 722.29 Q346.041 722.29 348.981 724.697 Q351.921 727.104 351.921 731.248 Q351.921 734.211 350.231 736.271 Q348.564 738.331 345.578 739.072 Q348.958 739.859 350.833 742.151 Q352.731 744.442 352.731 747.752 Q352.731 752.776 349.652 755.461 Q346.597 758.146 340.879 758.146 Q335.162 758.146 332.083 755.461 Q329.028 752.776 329.028 747.752 Q329.028 744.442 330.926 742.151 Q332.824 739.859 336.203 739.072 M334.49 731.688 Q334.49 734.373 336.157 735.877 Q337.847 737.382 340.879 737.382 Q343.889 737.382 345.578 735.877 Q347.291 734.373 347.291 731.688 Q347.291 729.003 345.578 727.498 Q343.889 725.993 340.879 725.993 Q337.847 725.993 336.157 727.498 Q334.49 729.003 334.49 731.688 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M375.208 738.84 Q378.564 739.558 380.439 741.827 Q382.337 744.095 382.337 747.428 Q382.337 752.544 378.819 755.345 Q375.3 758.146 368.819 758.146 Q366.643 758.146 364.328 757.706 Q362.037 757.289 359.583 756.433 L359.583 751.919 Q361.527 753.053 363.842 753.632 Q366.157 754.211 368.68 754.211 Q373.078 754.211 375.37 752.475 Q377.685 750.739 377.685 747.428 Q377.685 744.373 375.532 742.66 Q373.402 740.924 369.583 740.924 L365.555 740.924 L365.555 737.081 L369.768 737.081 Q373.217 737.081 375.046 735.715 Q376.874 734.327 376.874 731.734 Q376.874 729.072 374.976 727.66 Q373.101 726.225 369.583 726.225 Q367.662 726.225 365.463 726.641 Q363.263 727.058 360.625 727.938 L360.625 723.771 Q363.287 723.03 365.601 722.66 Q367.939 722.29 370 722.29 Q375.324 722.29 378.425 724.72 Q381.527 727.128 381.527 731.248 Q381.527 734.118 379.884 736.109 Q378.24 738.077 375.208 738.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M392.013 753.539 L399.652 753.539 L399.652 727.174 L391.342 728.84 L391.342 724.581 L399.606 722.915 L404.282 722.915 L404.282 753.539 L411.921 753.539 L411.921 757.475 L392.013 757.475 L392.013 753.539 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M421.411 722.915 L439.768 722.915 L439.768 726.85 L425.694 726.85 L425.694 735.322 Q426.712 734.975 427.731 734.813 Q428.749 734.627 429.768 734.627 Q435.555 734.627 438.934 737.799 Q442.314 740.97 442.314 746.387 Q442.314 751.965 438.842 755.067 Q435.37 758.146 429.05 758.146 Q426.874 758.146 424.606 757.776 Q422.36 757.405 419.953 756.664 L419.953 751.965 Q422.036 753.1 424.258 753.655 Q426.481 754.211 428.958 754.211 Q432.962 754.211 435.3 752.104 Q437.638 749.998 437.638 746.387 Q437.638 742.776 435.3 740.669 Q432.962 738.563 428.958 738.563 Q427.083 738.563 425.208 738.979 Q423.356 739.396 421.411 740.276 L421.411 722.915 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M462.106 738.331 Q458.957 738.331 457.106 740.484 Q455.277 742.637 455.277 746.387 Q455.277 750.114 457.106 752.289 Q458.957 754.442 462.106 754.442 Q465.254 754.442 467.082 752.289 Q468.934 750.114 468.934 746.387 Q468.934 742.637 467.082 740.484 Q465.254 738.331 462.106 738.331 M471.388 723.678 L471.388 727.938 Q469.629 727.104 467.823 726.665 Q466.041 726.225 464.281 726.225 Q459.652 726.225 457.198 729.35 Q454.768 732.475 454.42 738.794 Q455.786 736.78 457.846 735.715 Q459.906 734.627 462.383 734.627 Q467.592 734.627 470.601 737.799 Q473.633 740.947 473.633 746.387 Q473.633 751.711 470.485 754.928 Q467.337 758.146 462.106 758.146 Q456.11 758.146 452.939 753.563 Q449.768 748.956 449.768 740.229 Q449.768 732.035 453.656 727.174 Q457.545 722.29 464.096 722.29 Q465.855 722.29 467.638 722.637 Q469.443 722.984 471.388 723.678 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M495.855 738.84 Q499.212 739.558 501.087 741.827 Q502.985 744.095 502.985 747.428 Q502.985 752.544 499.466 755.345 Q495.948 758.146 489.466 758.146 Q487.291 758.146 484.976 757.706 Q482.684 757.289 480.23 756.433 L480.23 751.919 Q482.175 753.053 484.49 753.632 Q486.804 754.211 489.328 754.211 Q493.726 754.211 496.017 752.475 Q498.332 750.739 498.332 747.428 Q498.332 744.373 496.179 742.66 Q494.05 740.924 490.23 740.924 L486.203 740.924 L486.203 737.081 L490.416 737.081 Q493.865 737.081 495.693 735.715 Q497.522 734.327 497.522 731.734 Q497.522 729.072 495.624 727.66 Q493.749 726.225 490.23 726.225 Q488.309 726.225 486.11 726.641 Q483.911 727.058 481.272 727.938 L481.272 723.771 Q483.934 723.03 486.249 722.66 Q488.587 722.29 490.647 722.29 Q495.971 722.29 499.073 724.72 Q502.175 727.128 502.175 731.248 Q502.175 734.118 500.531 736.109 Q498.888 738.077 495.855 738.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M511.99 756.757 L511.99 752.498 Q513.749 753.331 515.554 753.771 Q517.36 754.211 519.096 754.211 Q523.726 754.211 526.156 751.109 Q528.61 747.984 528.957 741.641 Q527.614 743.632 525.554 744.697 Q523.494 745.762 520.994 745.762 Q515.809 745.762 512.777 742.637 Q509.767 739.489 509.767 734.049 Q509.767 728.725 512.915 725.507 Q516.064 722.29 521.295 722.29 Q527.29 722.29 530.438 726.896 Q533.61 731.479 533.61 740.229 Q533.61 748.401 529.721 753.285 Q525.855 758.146 519.304 758.146 Q517.545 758.146 515.739 757.799 Q513.934 757.451 511.99 756.757 M521.295 742.104 Q524.443 742.104 526.272 739.952 Q528.124 737.799 528.124 734.049 Q528.124 730.322 526.272 728.169 Q524.443 725.993 521.295 725.993 Q518.147 725.993 516.295 728.169 Q514.466 730.322 514.466 734.049 Q514.466 737.799 516.295 739.952 Q518.147 742.104 521.295 742.104 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M542.869 761.873 L544.489 761.873 Q547.73 761.873 548.702 760.877 Q549.698 759.882 549.698 756.572 L549.698 750.831 Q549.698 747.22 550.739 745.576 Q551.781 743.933 554.35 743.308 Q551.781 742.729 550.739 741.086 Q549.698 739.442 549.698 735.808 L549.698 730.067 Q549.698 726.78 548.702 725.785 Q547.73 724.766 544.489 724.766 L542.869 724.766 L542.869 721.456 L544.327 721.456 Q550.091 721.456 552.012 723.169 Q553.957 724.859 553.957 729.975 L553.957 735.53 Q553.957 738.979 555.207 740.322 Q556.457 741.641 559.744 741.641 L561.179 741.641 L561.179 744.951 L559.744 744.951 Q556.457 744.951 555.207 746.294 Q553.957 747.637 553.957 751.132 L553.957 756.664 Q553.957 761.78 552.012 763.493 Q550.091 765.206 544.327 765.206 L542.869 765.206 L542.869 761.873 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M138.288 370.825 L138.288 372.908 L118.705 372.908 Q118.982 377.306 121.343 379.621 Q123.728 381.913 127.964 381.913 Q130.417 381.913 132.709 381.311 Q135.024 380.709 137.292 379.505 L137.292 383.533 Q135.001 384.505 132.593 385.015 Q130.186 385.524 127.709 385.524 Q121.505 385.524 117.871 381.913 Q114.26 378.302 114.26 372.144 Q114.26 365.779 117.686 362.052 Q121.135 358.302 126.968 358.302 Q132.2 358.302 135.232 361.682 Q138.288 365.038 138.288 370.825 M134.029 369.575 Q133.982 366.08 132.061 363.996 Q130.163 361.913 127.015 361.913 Q123.45 361.913 121.297 363.927 Q119.168 365.941 118.843 369.598 L134.029 369.575 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M162.94 350.293 L175.51 363.186 L170.857 363.186 L160.672 354.043 L150.487 363.186 L145.834 363.186 L158.403 350.293 L162.94 350.293 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M204.769 389.251 L204.769 392.584 L203.334 392.584 Q197.57 392.584 195.602 390.871 Q193.658 389.158 193.658 384.042 L193.658 378.51 Q193.658 375.015 192.408 373.672 Q191.158 372.33 187.871 372.33 L186.459 372.33 L186.459 369.019 L187.871 369.019 Q191.181 369.019 192.408 367.7 Q193.658 366.357 193.658 362.908 L193.658 357.353 Q193.658 352.237 195.602 350.547 Q197.57 348.834 203.334 348.834 L204.769 348.834 L204.769 352.145 L203.195 352.145 Q199.931 352.145 198.936 353.163 Q197.94 354.182 197.94 357.445 L197.94 363.186 Q197.94 366.82 196.875 368.464 Q195.834 370.107 193.288 370.686 Q195.857 371.311 196.899 372.955 Q197.94 374.598 197.94 378.209 L197.94 383.95 Q197.94 387.214 198.936 388.232 Q199.931 389.251 203.195 389.251 L204.769 389.251 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M215.718 368.024 L245.394 368.024 L245.394 371.959 L215.718 371.959 L215.718 368.024 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M265.486 353.371 Q261.875 353.371 260.046 356.936 Q258.241 360.478 258.241 367.607 Q258.241 374.714 260.046 378.279 Q261.875 381.82 265.486 381.82 Q269.12 381.82 270.926 378.279 Q272.755 374.714 272.755 367.607 Q272.755 360.478 270.926 356.936 Q269.12 353.371 265.486 353.371 M265.486 349.668 Q271.296 349.668 274.352 354.274 Q277.431 358.857 277.431 367.607 Q277.431 376.334 274.352 380.941 Q271.296 385.524 265.486 385.524 Q259.676 385.524 256.597 380.941 Q253.542 376.334 253.542 367.607 Q253.542 358.857 256.597 354.274 Q259.676 349.668 265.486 349.668 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M285.648 378.973 L290.532 378.973 L290.532 384.853 L285.648 384.853 L285.648 378.973 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M301.528 380.918 L309.167 380.918 L309.167 354.552 L300.856 356.219 L300.856 351.959 L309.12 350.293 L313.796 350.293 L313.796 380.918 L321.435 380.918 L321.435 384.853 L301.528 384.853 L301.528 380.918 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M345.046 366.219 Q348.402 366.936 350.277 369.205 Q352.176 371.473 352.176 374.806 Q352.176 379.922 348.657 382.723 Q345.139 385.524 338.657 385.524 Q336.481 385.524 334.166 385.084 Q331.875 384.667 329.421 383.811 L329.421 379.297 Q331.365 380.431 333.68 381.01 Q335.995 381.589 338.518 381.589 Q342.916 381.589 345.208 379.853 Q347.523 378.117 347.523 374.806 Q347.523 371.751 345.37 370.038 Q343.24 368.302 339.421 368.302 L335.393 368.302 L335.393 364.459 L339.606 364.459 Q343.055 364.459 344.884 363.094 Q346.713 361.705 346.713 359.112 Q346.713 356.45 344.814 355.038 Q342.939 353.603 339.421 353.603 Q337.5 353.603 335.301 354.02 Q333.102 354.436 330.463 355.316 L330.463 351.149 Q333.125 350.408 335.44 350.038 Q337.777 349.668 339.838 349.668 Q345.162 349.668 348.264 352.098 Q351.365 354.506 351.365 358.626 Q351.365 361.496 349.722 363.487 Q348.078 365.455 345.046 366.219 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M359.861 350.293 L382.083 350.293 L382.083 352.283 L369.537 384.853 L364.652 384.853 L376.458 354.228 L359.861 354.228 L359.861 350.293 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M405.37 366.219 Q408.726 366.936 410.601 369.205 Q412.499 371.473 412.499 374.806 Q412.499 379.922 408.981 382.723 Q405.462 385.524 398.981 385.524 Q396.805 385.524 394.49 385.084 Q392.198 384.667 389.745 383.811 L389.745 379.297 Q391.689 380.431 394.004 381.01 Q396.319 381.589 398.842 381.589 Q403.24 381.589 405.532 379.853 Q407.847 378.117 407.847 374.806 Q407.847 371.751 405.694 370.038 Q403.564 368.302 399.745 368.302 L395.717 368.302 L395.717 364.459 L399.93 364.459 Q403.379 364.459 405.208 363.094 Q407.036 361.705 407.036 359.112 Q407.036 356.45 405.138 355.038 Q403.263 353.603 399.745 353.603 Q397.823 353.603 395.624 354.02 Q393.425 354.436 390.786 355.316 L390.786 351.149 Q393.448 350.408 395.763 350.038 Q398.101 349.668 400.161 349.668 Q405.485 349.668 408.587 352.098 Q411.689 354.506 411.689 358.626 Q411.689 361.496 410.046 363.487 Q408.402 365.455 405.37 366.219 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M431.944 365.709 Q428.796 365.709 426.944 367.862 Q425.115 370.015 425.115 373.765 Q425.115 377.492 426.944 379.668 Q428.796 381.82 431.944 381.82 Q435.092 381.82 436.92 379.668 Q438.772 377.492 438.772 373.765 Q438.772 370.015 436.92 367.862 Q435.092 365.709 431.944 365.709 M441.226 351.057 L441.226 355.316 Q439.467 354.482 437.661 354.043 Q435.879 353.603 434.12 353.603 Q429.49 353.603 427.036 356.728 Q424.606 359.853 424.258 366.172 Q425.624 364.158 427.684 363.094 Q429.745 362.006 432.221 362.006 Q437.43 362.006 440.439 365.177 Q443.471 368.325 443.471 373.765 Q443.471 379.089 440.323 382.306 Q437.175 385.524 431.944 385.524 Q425.948 385.524 422.777 380.941 Q419.606 376.334 419.606 367.607 Q419.606 359.413 423.495 354.552 Q427.383 349.668 433.934 349.668 Q435.694 349.668 437.476 350.015 Q439.282 350.362 441.226 351.057 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M450.346 350.293 L472.568 350.293 L472.568 352.283 L460.022 384.853 L455.138 384.853 L466.943 354.228 L450.346 354.228 L450.346 350.293 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M485.717 380.918 L502.036 380.918 L502.036 384.853 L480.092 384.853 L480.092 380.918 Q482.754 378.163 487.337 373.533 Q491.943 368.881 493.124 367.538 Q495.369 365.015 496.249 363.279 Q497.152 361.519 497.152 359.83 Q497.152 357.075 495.207 355.339 Q493.286 353.603 490.184 353.603 Q487.985 353.603 485.531 354.367 Q483.101 355.131 480.323 356.682 L480.323 351.959 Q483.147 350.825 485.601 350.246 Q488.054 349.668 490.091 349.668 Q495.462 349.668 498.656 352.353 Q501.851 355.038 501.851 359.529 Q501.851 361.658 501.04 363.58 Q500.253 365.478 498.147 368.07 Q497.568 368.742 494.466 371.959 Q491.365 375.154 485.717 380.918 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M511.99 384.135 L511.99 379.876 Q513.749 380.709 515.554 381.149 Q517.36 381.589 519.096 381.589 Q523.726 381.589 526.156 378.487 Q528.61 375.362 528.957 369.019 Q527.614 371.01 525.554 372.075 Q523.494 373.14 520.994 373.14 Q515.809 373.14 512.777 370.015 Q509.767 366.867 509.767 361.427 Q509.767 356.103 512.915 352.885 Q516.064 349.668 521.295 349.668 Q527.29 349.668 530.438 354.274 Q533.61 358.857 533.61 367.607 Q533.61 375.779 529.721 380.663 Q525.855 385.524 519.304 385.524 Q517.545 385.524 515.739 385.177 Q513.934 384.83 511.99 384.135 M521.295 369.482 Q524.443 369.482 526.272 367.33 Q528.124 365.177 528.124 361.427 Q528.124 357.7 526.272 355.547 Q524.443 353.371 521.295 353.371 Q518.147 353.371 516.295 355.547 Q514.466 357.7 514.466 361.427 Q514.466 365.177 516.295 367.33 Q518.147 369.482 521.295 369.482 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M542.869 389.251 L544.489 389.251 Q547.73 389.251 548.702 388.255 Q549.698 387.26 549.698 383.95 L549.698 378.209 Q549.698 374.598 550.739 372.955 Q551.781 371.311 554.35 370.686 Q551.781 370.107 550.739 368.464 Q549.698 366.82 549.698 363.186 L549.698 357.445 Q549.698 354.158 548.702 353.163 Q547.73 352.145 544.489 352.145 L542.869 352.145 L542.869 348.834 L544.327 348.834 Q550.091 348.834 552.012 350.547 Q553.957 352.237 553.957 357.353 L553.957 362.908 Q553.957 366.357 555.207 367.7 Q556.457 369.019 559.744 369.019 L561.179 369.019 L561.179 372.33 L559.744 372.33 Q556.457 372.33 555.207 373.672 Q553.957 375.015 553.957 378.51 L553.957 384.042 Q553.957 389.158 552.012 390.871 Q550.091 392.584 544.327 392.584 L542.869 392.584 L542.869 389.251 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M16.4842 795.065 L16.4842 785.484 L48.8219 773.358 L16.4842 761.167 L16.4842 751.587 L64.0042 751.587 L64.0042 757.857 L22.277 757.857 L54.8694 770.111 L54.8694 776.572 L22.277 788.826 L64.0042 788.826 L64.0042 795.065 L16.4842 795.065 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M408.121 12.096 L420.315 12.096 L435.749 53.2532 L451.263 12.096 L463.457 12.096 L463.457 72.576 L455.476 72.576 L455.476 19.4686 L439.88 60.9499 L431.657 60.9499 L416.061 19.4686 L416.061 72.576 L408.121 72.576 L408.121 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M499.996 49.7694 Q490.962 49.7694 487.479 51.8354 Q483.995 53.9013 483.995 58.8839 Q483.995 62.8538 486.587 65.2034 Q489.22 67.5124 493.717 67.5124 Q499.915 67.5124 503.642 63.1374 Q507.409 58.7219 507.409 51.4303 L507.409 49.7694 L499.996 49.7694 M514.863 46.6907 L514.863 72.576 L507.409 72.576 L507.409 65.6895 Q504.857 69.8214 501.049 71.8063 Q497.241 73.7508 491.732 73.7508 Q484.764 73.7508 480.633 69.8619 Q476.541 65.9325 476.541 59.3701 Q476.541 51.7138 481.645 47.825 Q486.79 43.9361 496.958 43.9361 L507.409 43.9361 L507.409 43.2069 Q507.409 38.0623 504.006 35.2672 Q500.644 32.4315 494.527 32.4315 Q490.638 32.4315 486.952 33.3632 Q483.266 34.295 479.863 36.1584 L479.863 29.2718 Q483.954 27.692 487.803 26.9223 Q491.651 26.1121 495.297 26.1121 Q505.141 26.1121 510.002 31.2163 Q514.863 36.3204 514.863 46.6907 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M560.071 49.3643 Q560.071 41.2625 556.709 36.8065 Q553.387 32.3505 547.351 32.3505 Q541.356 32.3505 537.993 36.8065 Q534.672 41.2625 534.672 49.3643 Q534.672 57.4256 537.993 61.8816 Q541.356 66.3376 547.351 66.3376 Q553.387 66.3376 556.709 61.8816 Q560.071 57.4256 560.071 49.3643 M567.524 66.9452 Q567.524 78.5308 562.38 84.1616 Q557.235 89.8329 546.622 89.8329 Q542.692 89.8329 539.209 89.2252 Q535.725 88.6581 532.444 87.4428 L532.444 80.1917 Q535.725 81.9741 538.925 82.8248 Q542.125 83.6755 545.447 83.6755 Q552.779 83.6755 556.425 79.8271 Q560.071 76.0193 560.071 68.282 L560.071 64.5957 Q557.762 68.6061 554.156 70.5911 Q550.551 72.576 545.528 72.576 Q537.183 72.576 532.079 66.2161 Q526.975 59.8562 526.975 49.3643 Q526.975 38.832 532.079 32.472 Q537.183 26.1121 545.528 26.1121 Q550.551 26.1121 554.156 28.0971 Q557.762 30.082 560.071 34.0924 L560.071 27.2059 L567.524 27.2059 L567.524 66.9452 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M620.591 45.1919 L620.591 72.576 L613.138 72.576 L613.138 45.4349 Q613.138 38.994 610.626 35.7938 Q608.114 32.5936 603.091 32.5936 Q597.056 32.5936 593.572 36.4419 Q590.088 40.2903 590.088 46.9338 L590.088 72.576 L582.594 72.576 L582.594 27.2059 L590.088 27.2059 L590.088 34.2544 Q592.762 30.163 596.367 28.1376 Q600.013 26.1121 604.752 26.1121 Q612.57 26.1121 616.581 30.9732 Q620.591 35.7938 620.591 45.1919 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M674.266 48.0275 L674.266 51.6733 L639.995 51.6733 Q640.481 59.3701 644.613 63.421 Q648.786 67.4314 656.199 67.4314 Q660.493 67.4314 664.503 66.3781 Q668.554 65.3249 672.524 63.2184 L672.524 70.267 Q668.513 71.9684 664.301 72.8596 Q660.088 73.7508 655.753 73.7508 Q644.897 73.7508 638.537 67.4314 Q632.217 61.1119 632.217 50.3365 Q632.217 39.1965 638.213 32.6746 Q644.249 26.1121 654.457 26.1121 Q663.612 26.1121 668.919 32.0264 Q674.266 37.9003 674.266 48.0275 M666.812 45.84 Q666.731 39.7232 663.369 36.0774 Q660.047 32.4315 654.538 32.4315 Q648.299 32.4315 644.532 35.9558 Q640.805 39.4801 640.238 45.8805 L666.812 45.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M693.872 14.324 L693.872 27.2059 L709.225 27.2059 L709.225 32.9987 L693.872 32.9987 L693.872 57.6282 Q693.872 63.1779 695.371 64.7578 Q696.91 66.3376 701.569 66.3376 L709.225 66.3376 L709.225 72.576 L701.569 72.576 Q692.94 72.576 689.659 69.3758 Q686.378 66.1351 686.378 57.6282 L686.378 32.9987 L680.909 32.9987 L680.909 27.2059 L686.378 27.2059 L686.378 14.324 L693.872 14.324 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M719.028 27.2059 L726.482 27.2059 L726.482 72.576 L719.028 72.576 L719.028 27.2059 M719.028 9.54393 L726.482 9.54393 L726.482 18.9825 L719.028 18.9825 L719.028 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M738.837 27.2059 L774.242 27.2059 L774.242 34.0114 L746.21 66.6212 L774.242 66.6212 L774.242 72.576 L737.824 72.576 L737.824 65.7705 L765.857 33.1607 L738.837 33.1607 L738.837 27.2059 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M806.244 49.7694 Q797.211 49.7694 793.727 51.8354 Q790.243 53.9013 790.243 58.8839 Q790.243 62.8538 792.836 65.2034 Q795.469 67.5124 799.965 67.5124 Q806.163 67.5124 809.89 63.1374 Q813.657 58.7219 813.657 51.4303 L813.657 49.7694 L806.244 49.7694 M821.111 46.6907 L821.111 72.576 L813.657 72.576 L813.657 65.6895 Q811.105 69.8214 807.297 71.8063 Q803.49 73.7508 797.98 73.7508 Q791.013 73.7508 786.881 69.8619 Q782.789 65.9325 782.789 59.3701 Q782.789 51.7138 787.894 47.825 Q793.038 43.9361 803.206 43.9361 L813.657 43.9361 L813.657 43.2069 Q813.657 38.0623 810.255 35.2672 Q806.892 32.4315 800.775 32.4315 Q796.887 32.4315 793.2 33.3632 Q789.514 34.295 786.111 36.1584 L786.111 29.2718 Q790.203 27.692 794.051 26.9223 Q797.899 26.1121 801.545 26.1121 Q811.389 26.1121 816.25 31.2163 Q821.111 36.3204 821.111 46.6907 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M843.837 14.324 L843.837 27.2059 L859.19 27.2059 L859.19 32.9987 L843.837 32.9987 L843.837 57.6282 Q843.837 63.1779 845.335 64.7578 Q846.875 66.3376 851.533 66.3376 L859.19 66.3376 L859.19 72.576 L851.533 72.576 Q842.905 72.576 839.624 69.3758 Q836.342 66.1351 836.342 57.6282 L836.342 32.9987 L830.874 32.9987 L830.874 27.2059 L836.342 27.2059 L836.342 14.324 L843.837 14.324 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M868.993 27.2059 L876.446 27.2059 L876.446 72.576 L868.993 72.576 L868.993 27.2059 M868.993 9.54393 L876.446 9.54393 L876.446 18.9825 L868.993 18.9825 L868.993 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M909.623 32.4315 Q903.628 32.4315 900.144 37.1306 Q896.66 41.7891 896.66 49.9314 Q896.66 58.0738 900.104 62.7728 Q903.587 67.4314 909.623 67.4314 Q915.578 67.4314 919.062 62.7323 Q922.546 58.0333 922.546 49.9314 Q922.546 41.8701 919.062 37.1711 Q915.578 32.4315 909.623 32.4315 M909.623 26.1121 Q919.345 26.1121 924.895 32.4315 Q930.445 38.7509 930.445 49.9314 Q930.445 61.0714 924.895 67.4314 Q919.345 73.7508 909.623 73.7508 Q899.861 73.7508 894.311 67.4314 Q888.802 61.0714 888.802 49.9314 Q888.802 38.7509 894.311 32.4315 Q899.861 26.1121 909.623 26.1121 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M980.514 45.1919 L980.514 72.576 L973.06 72.576 L973.06 45.4349 Q973.06 38.994 970.549 35.7938 Q968.037 32.5936 963.014 32.5936 Q956.978 32.5936 953.495 36.4419 Q950.011 40.2903 950.011 46.9338 L950.011 72.576 L942.517 72.576 L942.517 27.2059 L950.011 27.2059 L950.011 34.2544 Q952.684 30.163 956.29 28.1376 Q959.936 26.1121 964.675 26.1121 Q972.493 26.1121 976.504 30.9732 Q980.514 35.7938 980.514 45.1919 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1039.66 9.62495 Q1034.23 18.942 1031.6 28.0566 Q1028.96 37.1711 1028.96 46.5287 Q1028.96 55.8863 1031.6 65.0818 Q1034.27 74.2369 1039.66 83.5134 L1033.18 83.5134 Q1027.1 73.9938 1024.06 64.7983 Q1021.06 55.6027 1021.06 46.5287 Q1021.06 37.4952 1024.06 28.3401 Q1027.06 19.1851 1033.18 9.62495 L1039.66 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1054.44 12.096 L1066.64 12.096 L1082.07 53.2532 L1097.59 12.096 L1109.78 12.096 L1109.78 72.576 L1101.8 72.576 L1101.8 19.4686 L1086.2 60.9499 L1077.98 60.9499 L1062.38 19.4686 L1062.38 72.576 L1054.44 72.576 L1054.44 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1124.52 9.62495 L1131.01 9.62495 Q1137.08 19.1851 1140.08 28.3401 Q1143.12 37.4952 1143.12 46.5287 Q1143.12 55.6027 1140.08 64.7983 Q1137.08 73.9938 1131.01 83.5134 L1124.52 83.5134 Q1129.91 74.2369 1132.54 65.0818 Q1135.22 55.8863 1135.22 46.5287 Q1135.22 37.1711 1132.54 28.0566 Q1129.91 18.942 1124.52 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1179.09 27.2059 L1186.99 27.2059 L1201.17 65.2844 L1215.35 27.2059 L1223.24 27.2059 L1206.23 72.576 L1196.1 72.576 L1179.09 27.2059 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1262.46 28.5427 L1262.46 35.5912 Q1259.3 33.9709 1255.89 33.1607 Q1252.49 32.3505 1248.85 32.3505 Q1243.3 32.3505 1240.5 34.0519 Q1237.75 35.7533 1237.75 39.156 Q1237.75 41.7486 1239.73 43.2475 Q1241.72 44.7058 1247.71 46.0426 L1250.26 46.6097 Q1258.2 48.3111 1261.53 51.4303 Q1264.89 54.509 1264.89 60.0587 Q1264.89 66.3781 1259.86 70.0644 Q1254.88 73.7508 1246.13 73.7508 Q1242.49 73.7508 1238.52 73.0216 Q1234.59 72.3329 1230.21 70.9151 L1230.21 63.2184 Q1234.34 65.3654 1238.35 66.4591 Q1242.36 67.5124 1246.29 67.5124 Q1251.56 67.5124 1254.4 65.73 Q1257.23 63.9071 1257.23 60.6258 Q1257.23 57.5877 1255.17 55.9673 Q1253.14 54.3469 1246.21 52.8481 L1243.62 52.2405 Q1236.69 50.7821 1233.61 47.7845 Q1230.54 44.7463 1230.54 39.4801 Q1230.54 33.0797 1235.07 29.5959 Q1239.61 26.1121 1247.95 26.1121 Q1252.09 26.1121 1255.73 26.7198 Q1259.38 27.3274 1262.46 28.5427 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1303.45 12.096 L1338.21 12.096 L1338.21 18.9825 L1311.64 18.9825 L1311.64 36.8065 L1335.62 36.8065 L1335.62 43.6931 L1311.64 43.6931 L1311.64 72.576 L1303.45 72.576 L1303.45 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1344.81 27.2059 L1352.27 27.2059 L1352.27 72.576 L1344.81 72.576 L1344.81 27.2059 M1344.81 9.54393 L1352.27 9.54393 L1352.27 18.9825 L1344.81 18.9825 L1344.81 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1406.67 48.0275 L1406.67 51.6733 L1372.4 51.6733 Q1372.88 59.3701 1377.02 63.421 Q1381.19 67.4314 1388.6 67.4314 Q1392.9 67.4314 1396.91 66.3781 Q1400.96 65.3249 1404.93 63.2184 L1404.93 70.267 Q1400.92 71.9684 1396.7 72.8596 Q1392.49 73.7508 1388.16 73.7508 Q1377.3 73.7508 1370.94 67.4314 Q1364.62 61.1119 1364.62 50.3365 Q1364.62 39.1965 1370.62 32.6746 Q1376.65 26.1121 1386.86 26.1121 Q1396.02 26.1121 1401.32 32.0264 Q1406.67 37.9003 1406.67 48.0275 M1399.22 45.84 Q1399.13 39.7232 1395.77 36.0774 Q1392.45 32.4315 1386.94 32.4315 Q1380.7 32.4315 1376.94 35.9558 Q1373.21 39.4801 1372.64 45.8805 L1399.22 45.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1418.9 9.54393 L1426.36 9.54393 L1426.36 72.576 L1418.9 72.576 L1418.9 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1471.81 34.0924 L1471.81 9.54393 L1479.26 9.54393 L1479.26 72.576 L1471.81 72.576 L1471.81 65.7705 Q1469.46 69.8214 1465.85 71.8063 Q1462.29 73.7508 1457.27 73.7508 Q1449.04 73.7508 1443.86 67.1883 Q1438.71 60.6258 1438.71 49.9314 Q1438.71 39.2371 1443.86 32.6746 Q1449.04 26.1121 1457.27 26.1121 Q1462.29 26.1121 1465.85 28.0971 Q1469.46 30.0415 1471.81 34.0924 M1446.41 49.9314 Q1446.41 58.1548 1449.77 62.8538 Q1453.17 67.5124 1459.09 67.5124 Q1465 67.5124 1468.41 62.8538 Q1471.81 58.1548 1471.81 49.9314 Q1471.81 41.7081 1468.41 37.0496 Q1465 32.3505 1459.09 32.3505 Q1453.17 32.3505 1449.77 37.0496 Q1446.41 41.7081 1446.41 49.9314 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1538.89 9.62495 Q1533.46 18.942 1530.83 28.0566 Q1528.2 37.1711 1528.2 46.5287 Q1528.2 55.8863 1530.83 65.0818 Q1533.5 74.2369 1538.89 83.5134 L1532.41 83.5134 Q1526.33 73.9938 1523.29 64.7983 Q1520.3 55.6027 1520.3 46.5287 Q1520.3 37.4952 1523.29 28.3401 Q1526.29 19.1851 1532.41 9.62495 L1538.89 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1561.86 43.6931 L1561.86 65.8515 L1574.98 65.8515 Q1581.59 65.8515 1584.75 63.1374 Q1587.95 60.3828 1587.95 54.752 Q1587.95 49.0808 1584.75 46.4072 Q1581.59 43.6931 1574.98 43.6931 L1561.86 43.6931 M1561.86 18.8205 L1561.86 37.0496 L1573.97 37.0496 Q1579.97 37.0496 1582.88 34.8216 Q1585.84 32.5531 1585.84 27.935 Q1585.84 23.3575 1582.88 21.089 Q1579.97 18.8205 1573.97 18.8205 L1561.86 18.8205 M1553.68 12.096 L1574.58 12.096 Q1583.94 12.096 1589 15.9849 Q1594.06 19.8737 1594.06 27.0438 Q1594.06 32.5936 1591.47 35.8748 Q1588.88 39.156 1583.86 39.9662 Q1589.89 41.2625 1593.21 45.3944 Q1596.58 49.4858 1596.58 55.6432 Q1596.58 63.745 1591.07 68.1605 Q1585.56 72.576 1575.39 72.576 L1553.68 72.576 L1553.68 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1609.09 9.62495 L1615.57 9.62495 Q1621.65 19.1851 1624.65 28.3401 Q1627.69 37.4952 1627.69 46.5287 Q1627.69 55.6027 1624.65 64.7983 Q1621.65 73.9938 1615.57 83.5134 L1609.09 83.5134 Q1614.48 74.2369 1617.11 65.0818 Q1619.79 55.8863 1619.79 46.5287 Q1619.79 37.1711 1617.11 28.0566 Q1614.48 18.942 1609.09 9.62495 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1691.97 9.54393 L1691.97 15.7418 L1684.84 15.7418 Q1680.83 15.7418 1679.25 17.3622 Q1677.72 18.9825 1677.72 23.1955 L1677.72 27.2059 L1689.99 27.2059 L1689.99 32.9987 L1677.72 32.9987 L1677.72 72.576 L1670.22 72.576 L1670.22 32.9987 L1663.09 32.9987 L1663.09 27.2059 L1670.22 27.2059 L1670.22 24.0462 Q1670.22 16.471 1673.75 13.0277 Q1677.27 9.54393 1684.93 9.54393 L1691.97 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1715.79 32.4315 Q1709.8 32.4315 1706.31 37.1306 Q1702.83 41.7891 1702.83 49.9314 Q1702.83 58.0738 1706.27 62.7728 Q1709.76 67.4314 1715.79 67.4314 Q1721.75 67.4314 1725.23 62.7323 Q1728.72 58.0333 1728.72 49.9314 Q1728.72 41.8701 1725.23 37.1711 Q1721.75 32.4315 1715.79 32.4315 M1715.79 26.1121 Q1725.52 26.1121 1731.07 32.4315 Q1736.62 38.7509 1736.62 49.9314 Q1736.62 61.0714 1731.07 67.4314 Q1725.52 73.7508 1715.79 73.7508 Q1706.03 73.7508 1700.48 67.4314 Q1694.97 61.0714 1694.97 49.9314 Q1694.97 38.7509 1700.48 32.4315 Q1706.03 26.1121 1715.79 26.1121 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1775.26 34.1734 Q1774.01 33.4443 1772.51 33.1202 Q1771.05 32.7556 1769.27 32.7556 Q1762.95 32.7556 1759.54 36.8875 Q1756.18 40.9789 1756.18 48.6757 L1756.18 72.576 L1748.69 72.576 L1748.69 27.2059 L1756.18 27.2059 L1756.18 34.2544 Q1758.53 30.1225 1762.3 28.1376 Q1766.07 26.1121 1771.45 26.1121 Q1772.22 26.1121 1773.15 26.2337 Q1774.09 26.3147 1775.22 26.5172 L1775.26 34.1734 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1809.77 12.096 L1817.96 12.096 L1817.96 72.576 L1809.77 72.576 L1809.77 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1862.84 28.5427 L1862.84 35.5912 Q1859.68 33.9709 1856.28 33.1607 Q1852.88 32.3505 1849.23 32.3505 Q1843.68 32.3505 1840.89 34.0519 Q1838.13 35.7533 1838.13 39.156 Q1838.13 41.7486 1840.12 43.2475 Q1842.1 44.7058 1848.1 46.0426 L1850.65 46.6097 Q1858.59 48.3111 1861.91 51.4303 Q1865.27 54.509 1865.27 60.0587 Q1865.27 66.3781 1860.25 70.0644 Q1855.27 73.7508 1846.52 73.7508 Q1842.87 73.7508 1838.9 73.0216 Q1834.97 72.3329 1830.6 70.9151 L1830.6 63.2184 Q1834.73 65.3654 1838.74 66.4591 Q1842.75 67.5124 1846.68 67.5124 Q1851.94 67.5124 1854.78 65.73 Q1857.62 63.9071 1857.62 60.6258 Q1857.62 57.5877 1855.55 55.9673 Q1853.52 54.3469 1846.6 52.8481 L1844 52.2405 Q1837.08 50.7821 1834 47.7845 Q1830.92 44.7463 1830.92 39.4801 Q1830.92 33.0797 1835.46 29.5959 Q1839.99 26.1121 1848.34 26.1121 Q1852.47 26.1121 1856.12 26.7198 Q1859.76 27.3274 1862.84 28.5427 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1877.14 27.2059 L1884.59 27.2059 L1884.59 72.576 L1877.14 72.576 L1877.14 27.2059 M1877.14 9.54393 L1884.59 9.54393 L1884.59 18.9825 L1877.14 18.9825 L1877.14 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1937.9 45.1919 L1937.9 72.576 L1930.45 72.576 L1930.45 45.4349 Q1930.45 38.994 1927.94 35.7938 Q1925.43 32.5936 1920.4 32.5936 Q1914.37 32.5936 1910.89 36.4419 Q1907.4 40.2903 1907.4 46.9338 L1907.4 72.576 L1899.91 72.576 L1899.91 27.2059 L1907.4 27.2059 L1907.4 34.2544 Q1910.08 30.163 1913.68 28.1376 Q1917.33 26.1121 1922.07 26.1121 Q1929.88 26.1121 1933.89 30.9732 Q1937.9 35.7938 1937.9 45.1919 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1982.63 49.3643 Q1982.63 41.2625 1979.26 36.8065 Q1975.94 32.3505 1969.91 32.3505 Q1963.91 32.3505 1960.55 36.8065 Q1957.23 41.2625 1957.23 49.3643 Q1957.23 57.4256 1960.55 61.8816 Q1963.91 66.3376 1969.91 66.3376 Q1975.94 66.3376 1979.26 61.8816 Q1982.63 57.4256 1982.63 49.3643 M1990.08 66.9452 Q1990.08 78.5308 1984.94 84.1616 Q1979.79 89.8329 1969.18 89.8329 Q1965.25 89.8329 1961.76 89.2252 Q1958.28 88.6581 1955 87.4428 L1955 80.1917 Q1958.28 81.9741 1961.48 82.8248 Q1964.68 83.6755 1968 83.6755 Q1975.34 83.6755 1978.98 79.8271 Q1982.63 76.0193 1982.63 68.282 L1982.63 64.5957 Q1980.32 68.6061 1976.71 70.5911 Q1973.11 72.576 1968.08 72.576 Q1959.74 72.576 1954.64 66.2161 Q1949.53 59.8562 1949.53 49.3643 Q1949.53 38.832 1954.64 32.472 Q1959.74 26.1121 1968.08 26.1121 Q1973.11 26.1121 1976.71 28.0971 Q1980.32 30.082 1982.63 34.0924 L1982.63 27.2059 L1990.08 27.2059 L1990.08 66.9452 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2032.13 12.096 L2044.32 12.096 L2059.76 53.2532 L2075.27 12.096 L2087.46 12.096 L2087.46 72.576 L2079.48 72.576 L2079.48 19.4686 L2063.89 60.9499 L2055.66 60.9499 L2040.07 19.4686 L2040.07 72.576 L2032.13 72.576 L2032.13 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2120.97 32.4315 Q2114.97 32.4315 2111.49 37.1306 Q2108 41.7891 2108 49.9314 Q2108 58.0738 2111.45 62.7728 Q2114.93 67.4314 2120.97 67.4314 Q2126.92 67.4314 2130.4 62.7323 Q2133.89 58.0333 2133.89 49.9314 Q2133.89 41.8701 2130.4 37.1711 Q2126.92 32.4315 2120.97 32.4315 M2120.97 26.1121 Q2130.69 26.1121 2136.24 32.4315 Q2141.79 38.7509 2141.79 49.9314 Q2141.79 61.0714 2136.24 67.4314 Q2130.69 73.7508 2120.97 73.7508 Q2111.2 73.7508 2105.65 67.4314 Q2100.14 61.0714 2100.14 49.9314 Q2100.14 38.7509 2105.65 32.4315 Q2111.2 26.1121 2120.97 26.1121 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2184 34.0924 L2184 9.54393 L2191.45 9.54393 L2191.45 72.576 L2184 72.576 L2184 65.7705 Q2181.65 69.8214 2178.04 71.8063 Q2174.48 73.7508 2169.45 73.7508 Q2161.23 73.7508 2156.05 67.1883 Q2150.9 60.6258 2150.9 49.9314 Q2150.9 39.2371 2156.05 32.6746 Q2161.23 26.1121 2169.45 26.1121 Q2174.48 26.1121 2178.04 28.0971 Q2181.65 30.0415 2184 34.0924 M2158.6 49.9314 Q2158.6 58.1548 2161.96 62.8538 Q2165.36 67.5124 2171.28 67.5124 Q2177.19 67.5124 2180.59 62.8538 Q2184 58.1548 2184 49.9314 Q2184 41.7081 2180.59 37.0496 Q2177.19 32.3505 2171.28 32.3505 Q2165.36 32.3505 2161.96 37.0496 Q2158.6 41.7081 2158.6 49.9314 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2245.61 48.0275 L2245.61 51.6733 L2211.34 51.6733 Q2211.83 59.3701 2215.96 63.421 Q2220.13 67.4314 2227.54 67.4314 Q2231.84 67.4314 2235.85 66.3781 Q2239.9 65.3249 2243.87 63.2184 L2243.87 70.267 Q2239.86 71.9684 2235.65 72.8596 Q2231.43 73.7508 2227.1 73.7508 Q2216.24 73.7508 2209.88 67.4314 Q2203.56 61.1119 2203.56 50.3365 Q2203.56 39.1965 2209.56 32.6746 Q2215.59 26.1121 2225.8 26.1121 Q2234.96 26.1121 2240.26 32.0264 Q2245.61 37.9003 2245.61 48.0275 M2238.16 45.84 Q2238.08 39.7232 2234.71 36.0774 Q2231.39 32.4315 2225.88 32.4315 Q2219.65 32.4315 2215.88 35.9558 Q2212.15 39.4801 2211.58 45.8805 L2238.16 45.84 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2257.85 9.54393 L2265.3 9.54393 L2265.3 72.576 L2257.85 72.576 L2257.85 9.54393 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2327.89 49.7694 Q2318.85 49.7694 2315.37 51.8354 Q2311.88 53.9013 2311.88 58.8839 Q2311.88 62.8538 2314.48 65.2034 Q2317.11 67.5124 2321.61 67.5124 Q2327.8 67.5124 2331.53 63.1374 Q2335.3 58.7219 2335.3 51.4303 L2335.3 49.7694 L2327.89 49.7694 M2342.75 46.6907 L2342.75 72.576 L2335.3 72.576 L2335.3 65.6895 Q2332.75 69.8214 2328.94 71.8063 Q2325.13 73.7508 2319.62 73.7508 Q2312.65 73.7508 2308.52 69.8619 Q2304.43 65.9325 2304.43 59.3701 Q2304.43 51.7138 2309.53 47.825 Q2314.68 43.9361 2324.85 43.9361 L2335.3 43.9361 L2335.3 43.2069 Q2335.3 38.0623 2331.9 35.2672 Q2328.53 32.4315 2322.42 32.4315 Q2318.53 32.4315 2314.84 33.3632 Q2311.16 34.295 2307.75 36.1584 L2307.75 29.2718 Q2311.84 27.692 2315.69 26.9223 Q2319.54 26.1121 2323.19 26.1121 Q2333.03 26.1121 2337.89 31.2163 Q2342.75 36.3204 2342.75 46.6907 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2365.48 14.324 L2365.48 27.2059 L2380.83 27.2059 L2380.83 32.9987 L2365.48 32.9987 L2365.48 57.6282 Q2365.48 63.1779 2366.98 64.7578 Q2368.52 66.3376 2373.17 66.3376 L2380.83 66.3376 L2380.83 72.576 L2373.17 72.576 Q2364.55 72.576 2361.26 69.3758 Q2357.98 66.1351 2357.98 57.6282 L2357.98 32.9987 L2352.51 32.9987 L2352.51 27.2059 L2357.98 27.2059 L2357.98 14.324 L2365.48 14.324 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2408.94 12.096 L2460.11 12.096 L2460.11 18.9825 L2438.64 18.9825 L2438.64 72.576 L2430.41 72.576 L2430.41 18.9825 L2408.94 18.9825 L2408.94 12.096 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2502.16 86.3491 L2502.16 92.1419 L2459.05 92.1419 L2459.05 86.3491 L2502.16 86.3491 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M2541.81 28.9478 L2541.81 35.9153 Q2538.65 34.1734 2535.45 33.3227 Q2532.29 32.4315 2529.05 32.4315 Q2521.8 32.4315 2517.79 37.0496 Q2513.78 41.6271 2513.78 49.9314 Q2513.78 58.2358 2517.79 62.8538 Q2521.8 67.4314 2529.05 67.4314 Q2532.29 67.4314 2535.45 66.5807 Q2538.65 65.6895 2541.81 63.9476 L2541.81 70.8341 Q2538.69 72.2924 2535.33 73.0216 Q2532.01 73.7508 2528.24 73.7508 Q2517.99 73.7508 2511.96 67.3098 Q2505.92 60.8689 2505.92 49.9314 Q2505.92 38.832 2512 32.472 Q2518.12 26.1121 2528.73 26.1121 Q2532.17 26.1121 2535.45 26.8413 Q2538.73 27.5299 2541.81 28.9478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><circle clip-path="url(#clip292)" cx="646.865" cy="1386.4" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="1145.43" cy="1015.9" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="1437.08" cy="795.524" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="1644" cy="628.903" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="1804.5" cy="509.816" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="1935.64" cy="429.119" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="2046.52" cy="345.17" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="2142.57" cy="283.261" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="2227.29" cy="217.172" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<circle clip-path="url(#clip292)" cx="2303.07" cy="178.936" r="14.4" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="3.2"></circle> +<polyline clip-path="url(#clip292)" style="stroke:#ff0000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" stroke-dasharray="16, 10" points="646.865,1377.51 1145.43,1011.08 1437.08,796.731 1644,644.649 1804.5,526.685 1935.64,430.302 2046.52,348.811 2142.57,278.22 2227.29,215.955 2303.07,160.256 "></polyline> +<path clip-path="url(#clip290)" d="M655.698 322.316 L1677.66 322.316 L1677.66 166.796 L655.698 166.796 Z" fill="#ffffff" fill-rule="evenodd" fill-opacity="1"></path> +<polyline clip-path="url(#clip290)" style="stroke:#000000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" points="655.698,322.316 1677.66,322.316 1677.66,166.796 655.698,166.796 655.698,322.316 "></polyline> +<circle clip-path="url(#clip290)" cx="733.724" cy="218.636" r="20.48" fill="#009af9" fill-rule="evenodd" fill-opacity="1" stroke="#000000" stroke-opacity="1" stroke-width="4.55111"></circle> +<path clip-path="url(#clip290)" d="M811.75 201.356 L818.717 201.356 L827.537 224.874 L836.402 201.356 L843.37 201.356 L843.37 235.916 L838.81 235.916 L838.81 205.569 L829.898 229.272 L825.199 229.272 L816.287 205.569 L816.287 235.916 L811.75 235.916 L811.75 201.356 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M864.481 209.99 L868.995 209.99 L877.096 231.749 L885.198 209.99 L889.712 209.99 L879.99 235.916 L874.203 235.916 L864.481 209.99 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M912.119 210.754 L912.119 214.782 Q910.314 213.856 908.369 213.393 Q906.425 212.93 904.342 212.93 Q901.17 212.93 899.573 213.902 Q897.999 214.874 897.999 216.819 Q897.999 218.3 899.133 219.157 Q900.268 219.99 903.694 220.754 L905.152 221.078 Q909.689 222.05 911.587 223.832 Q913.508 225.592 913.508 228.763 Q913.508 232.374 910.638 234.481 Q907.791 236.587 902.791 236.587 Q900.707 236.587 898.439 236.17 Q896.194 235.777 893.694 234.967 L893.694 230.569 Q896.055 231.795 898.346 232.42 Q900.638 233.022 902.883 233.022 Q905.893 233.022 907.513 232.004 Q909.133 230.962 909.133 229.087 Q909.133 227.351 907.953 226.425 Q906.795 225.499 902.837 224.643 L901.356 224.295 Q897.397 223.462 895.638 221.749 Q893.879 220.013 893.879 217.004 Q893.879 213.346 896.471 211.356 Q899.064 209.365 903.832 209.365 Q906.194 209.365 908.277 209.712 Q910.36 210.059 912.119 210.754 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M935.545 201.356 L940.221 201.356 L940.221 215.522 L957.212 215.522 L957.212 201.356 L961.888 201.356 L961.888 235.916 L957.212 235.916 L957.212 219.457 L940.221 219.457 L940.221 235.916 L935.545 235.916 L935.545 201.356 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><polyline clip-path="url(#clip290)" style="stroke:#ff0000; stroke-linecap:round; stroke-linejoin:round; stroke-width:4; stroke-opacity:1; fill:none" stroke-dasharray="16, 10" points="675.205,270.476 792.243,270.476 "></polyline> +<path clip-path="url(#clip290)" d="M811.75 251.737 L816.009 251.737 L816.009 287.756 L811.75 287.756 L811.75 251.737 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M824.921 261.83 L829.18 261.83 L829.18 287.756 L824.921 287.756 L824.921 261.83 M824.921 251.737 L829.18 251.737 L829.18 257.131 L824.921 257.131 L824.921 251.737 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M859.643 272.108 L859.643 287.756 L855.384 287.756 L855.384 272.247 Q855.384 268.566 853.948 266.737 Q852.513 264.909 849.643 264.909 Q846.194 264.909 844.203 267.108 Q842.212 269.307 842.212 273.103 L842.212 287.756 L837.93 287.756 L837.93 261.83 L842.212 261.83 L842.212 265.858 Q843.74 263.52 845.8 262.362 Q847.884 261.205 850.592 261.205 Q855.06 261.205 857.351 263.983 Q859.643 266.737 859.643 272.108 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M890.314 273.728 L890.314 275.811 L870.731 275.811 Q871.009 280.209 873.37 282.524 Q875.754 284.816 879.99 284.816 Q882.444 284.816 884.735 284.214 Q887.05 283.612 889.319 282.409 L889.319 286.436 Q887.027 287.408 884.62 287.918 Q882.212 288.427 879.735 288.427 Q873.532 288.427 869.897 284.816 Q866.286 281.205 866.286 275.047 Q866.286 268.682 869.712 264.955 Q873.161 261.205 878.995 261.205 Q884.226 261.205 887.258 264.585 Q890.314 267.941 890.314 273.728 M886.055 272.478 Q886.008 268.983 884.087 266.899 Q882.189 264.816 879.041 264.816 Q875.476 264.816 873.323 266.83 Q871.194 268.844 870.87 272.501 L886.055 272.478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M909.087 274.723 Q903.925 274.723 901.934 275.904 Q899.944 277.084 899.944 279.932 Q899.944 282.2 901.425 283.543 Q902.93 284.862 905.499 284.862 Q909.041 284.862 911.17 282.362 Q913.323 279.839 913.323 275.672 L913.323 274.723 L909.087 274.723 M917.582 272.964 L917.582 287.756 L913.323 287.756 L913.323 283.821 Q911.865 286.182 909.689 287.316 Q907.513 288.427 904.365 288.427 Q900.383 288.427 898.022 286.205 Q895.684 283.959 895.684 280.209 Q895.684 275.834 898.601 273.612 Q901.541 271.39 907.351 271.39 L913.323 271.39 L913.323 270.973 Q913.323 268.034 911.379 266.436 Q909.457 264.816 905.962 264.816 Q903.74 264.816 901.633 265.348 Q899.527 265.881 897.582 266.946 L897.582 263.01 Q899.92 262.108 902.119 261.668 Q904.319 261.205 906.402 261.205 Q912.027 261.205 914.805 264.122 Q917.582 267.038 917.582 272.964 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M941.378 265.811 Q940.661 265.395 939.804 265.21 Q938.971 265.001 937.953 265.001 Q934.341 265.001 932.397 267.362 Q930.476 269.7 930.476 274.098 L930.476 287.756 L926.193 287.756 L926.193 261.83 L930.476 261.83 L930.476 265.858 Q931.818 263.497 933.971 262.362 Q936.124 261.205 939.203 261.205 Q939.642 261.205 940.175 261.274 Q940.707 261.321 941.355 261.436 L941.378 265.811 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M975.938 265.811 Q975.221 265.395 974.364 265.21 Q973.531 265.001 972.513 265.001 Q968.901 265.001 966.957 267.362 Q965.036 269.7 965.036 274.098 L965.036 287.756 L960.753 287.756 L960.753 261.83 L965.036 261.83 L965.036 265.858 Q966.378 263.497 968.531 262.362 Q970.684 261.205 973.763 261.205 Q974.202 261.205 974.735 261.274 Q975.267 261.321 975.915 261.436 L975.938 265.811 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1001.54 273.728 L1001.54 275.811 L981.957 275.811 Q982.235 280.209 984.596 282.524 Q986.98 284.816 991.216 284.816 Q993.67 284.816 995.962 284.214 Q998.276 283.612 1000.54 282.409 L1000.54 286.436 Q998.253 287.408 995.846 287.918 Q993.438 288.427 990.962 288.427 Q984.758 288.427 981.124 284.816 Q977.513 281.205 977.513 275.047 Q977.513 268.682 980.938 264.955 Q984.388 261.205 990.221 261.205 Q995.452 261.205 998.485 264.585 Q1001.54 267.941 1001.54 273.728 M997.281 272.478 Q997.235 268.983 995.313 266.899 Q993.415 264.816 990.267 264.816 Q986.702 264.816 984.55 266.83 Q982.42 268.844 982.096 272.501 L997.281 272.478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1025.59 274.492 Q1025.59 269.862 1023.67 267.316 Q1021.77 264.77 1018.32 264.77 Q1014.9 264.77 1012.98 267.316 Q1011.08 269.862 1011.08 274.492 Q1011.08 279.098 1012.98 281.645 Q1014.9 284.191 1018.32 284.191 Q1021.77 284.191 1023.67 281.645 Q1025.59 279.098 1025.59 274.492 M1029.85 284.538 Q1029.85 291.158 1026.91 294.376 Q1023.97 297.617 1017.91 297.617 Q1015.66 297.617 1013.67 297.27 Q1011.68 296.945 1009.8 296.251 L1009.8 292.108 Q1011.68 293.126 1013.51 293.612 Q1015.34 294.098 1017.23 294.098 Q1021.42 294.098 1023.51 291.899 Q1025.59 289.723 1025.59 285.302 L1025.59 283.196 Q1024.27 285.487 1022.21 286.621 Q1020.15 287.756 1017.28 287.756 Q1012.51 287.756 1009.6 284.121 Q1006.68 280.487 1006.68 274.492 Q1006.68 268.473 1009.6 264.839 Q1012.51 261.205 1017.28 261.205 Q1020.15 261.205 1022.21 262.339 Q1024.27 263.473 1025.59 265.765 L1025.59 261.83 L1029.85 261.83 L1029.85 284.538 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1053.65 265.811 Q1052.93 265.395 1052.07 265.21 Q1051.24 265.001 1050.22 265.001 Q1046.61 265.001 1044.66 267.362 Q1042.74 269.7 1042.74 274.098 L1042.74 287.756 L1038.46 287.756 L1038.46 261.83 L1042.74 261.83 L1042.74 265.858 Q1044.09 263.497 1046.24 262.362 Q1048.39 261.205 1051.47 261.205 Q1051.91 261.205 1052.44 261.274 Q1052.98 261.321 1053.62 261.436 L1053.65 265.811 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1079.25 273.728 L1079.25 275.811 L1059.66 275.811 Q1059.94 280.209 1062.3 282.524 Q1064.69 284.816 1068.92 284.816 Q1071.38 284.816 1073.67 284.214 Q1075.98 283.612 1078.25 282.409 L1078.25 286.436 Q1075.96 287.408 1073.55 287.918 Q1071.15 288.427 1068.67 288.427 Q1062.47 288.427 1058.83 284.816 Q1055.22 281.205 1055.22 275.047 Q1055.22 268.682 1058.65 264.955 Q1062.1 261.205 1067.93 261.205 Q1073.16 261.205 1076.19 264.585 Q1079.25 267.941 1079.25 273.728 M1074.99 272.478 Q1074.94 268.983 1073.02 266.899 Q1071.12 264.816 1067.98 264.816 Q1064.41 264.816 1062.26 266.83 Q1060.13 268.844 1059.8 272.501 L1074.99 272.478 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1102.77 262.594 L1102.77 266.622 Q1100.96 265.696 1099.02 265.233 Q1097.07 264.77 1094.99 264.77 Q1091.82 264.77 1090.22 265.742 Q1088.65 266.714 1088.65 268.659 Q1088.65 270.14 1089.78 270.997 Q1090.91 271.83 1094.34 272.594 L1095.8 272.918 Q1100.34 273.89 1102.23 275.672 Q1104.16 277.432 1104.16 280.603 Q1104.16 284.214 1101.29 286.321 Q1098.44 288.427 1093.44 288.427 Q1091.35 288.427 1089.09 288.01 Q1086.84 287.617 1084.34 286.807 L1084.34 282.409 Q1086.7 283.635 1088.99 284.26 Q1091.29 284.862 1093.53 284.862 Q1096.54 284.862 1098.16 283.844 Q1099.78 282.802 1099.78 280.927 Q1099.78 279.191 1098.6 278.265 Q1097.44 277.339 1093.48 276.483 L1092 276.135 Q1088.04 275.302 1086.29 273.589 Q1084.53 271.853 1084.53 268.844 Q1084.53 265.186 1087.12 263.196 Q1089.71 261.205 1094.48 261.205 Q1096.84 261.205 1098.92 261.552 Q1101.01 261.899 1102.77 262.594 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1127.47 262.594 L1127.47 266.622 Q1125.66 265.696 1123.72 265.233 Q1121.77 264.77 1119.69 264.77 Q1116.52 264.77 1114.92 265.742 Q1113.35 266.714 1113.35 268.659 Q1113.35 270.14 1114.48 270.997 Q1115.61 271.83 1119.04 272.594 L1120.5 272.918 Q1125.03 273.89 1126.93 275.672 Q1128.85 277.432 1128.85 280.603 Q1128.85 284.214 1125.98 286.321 Q1123.14 288.427 1118.14 288.427 Q1116.05 288.427 1113.78 288.01 Q1111.54 287.617 1109.04 286.807 L1109.04 282.409 Q1111.4 283.635 1113.69 284.26 Q1115.98 284.862 1118.23 284.862 Q1121.24 284.862 1122.86 283.844 Q1124.48 282.802 1124.48 280.927 Q1124.48 279.191 1123.3 278.265 Q1122.14 277.339 1118.18 276.483 L1116.7 276.135 Q1112.74 275.302 1110.98 273.589 Q1109.22 271.853 1109.22 268.844 Q1109.22 265.186 1111.82 263.196 Q1114.41 261.205 1119.18 261.205 Q1121.54 261.205 1123.62 261.552 Q1125.71 261.899 1127.47 262.594 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1135.64 261.83 L1139.9 261.83 L1139.9 287.756 L1135.64 287.756 L1135.64 261.83 M1135.64 251.737 L1139.9 251.737 L1139.9 257.131 L1135.64 257.131 L1135.64 251.737 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1158.85 264.816 Q1155.43 264.816 1153.44 267.501 Q1151.45 270.163 1151.45 274.816 Q1151.45 279.469 1153.41 282.154 Q1155.41 284.816 1158.85 284.816 Q1162.26 284.816 1164.25 282.131 Q1166.24 279.446 1166.24 274.816 Q1166.24 270.21 1164.25 267.524 Q1162.26 264.816 1158.85 264.816 M1158.85 261.205 Q1164.41 261.205 1167.58 264.816 Q1170.75 268.427 1170.75 274.816 Q1170.75 281.182 1167.58 284.816 Q1164.41 288.427 1158.85 288.427 Q1153.28 288.427 1150.1 284.816 Q1146.96 281.182 1146.96 274.816 Q1146.96 268.427 1150.1 264.816 Q1153.28 261.205 1158.85 261.205 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1199.36 272.108 L1199.36 287.756 L1195.1 287.756 L1195.1 272.247 Q1195.1 268.566 1193.67 266.737 Q1192.23 264.909 1189.36 264.909 Q1185.91 264.909 1183.92 267.108 Q1181.93 269.307 1181.93 273.103 L1181.93 287.756 L1177.65 287.756 L1177.65 261.83 L1181.93 261.83 L1181.93 265.858 Q1183.46 263.52 1185.52 262.362 Q1187.6 261.205 1190.31 261.205 Q1194.78 261.205 1197.07 263.983 Q1199.36 266.737 1199.36 272.108 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1223.48 266.228 L1253.16 266.228 L1253.16 270.117 L1223.48 270.117 L1223.48 266.228 M1223.48 275.672 L1253.16 275.672 L1253.16 279.608 L1223.48 279.608 L1223.48 275.672 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1275.57 272.872 L1288.04 272.872 L1288.04 276.668 L1275.57 276.668 L1275.57 272.872 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1305.43 256.274 Q1301.82 256.274 1299.99 259.839 Q1298.18 263.381 1298.18 270.51 Q1298.18 277.617 1299.99 281.182 Q1301.82 284.723 1305.43 284.723 Q1309.06 284.723 1310.87 281.182 Q1312.7 277.617 1312.7 270.51 Q1312.7 263.381 1310.87 259.839 Q1309.06 256.274 1305.43 256.274 M1305.43 252.571 Q1311.24 252.571 1314.29 257.177 Q1317.37 261.76 1317.37 270.51 Q1317.37 279.237 1314.29 283.844 Q1311.24 288.427 1305.43 288.427 Q1299.62 288.427 1296.54 283.844 Q1293.48 279.237 1293.48 270.51 Q1293.48 261.76 1296.54 257.177 Q1299.62 252.571 1305.43 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1325.59 281.876 L1330.47 281.876 L1330.47 287.756 L1325.59 287.756 L1325.59 281.876 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1350.66 256.274 Q1347.05 256.274 1345.22 259.839 Q1343.41 263.381 1343.41 270.51 Q1343.41 277.617 1345.22 281.182 Q1347.05 284.723 1350.66 284.723 Q1354.29 284.723 1356.1 281.182 Q1357.93 277.617 1357.93 270.51 Q1357.93 263.381 1356.1 259.839 Q1354.29 256.274 1350.66 256.274 M1350.66 252.571 Q1356.47 252.571 1359.52 257.177 Q1362.6 261.76 1362.6 270.51 Q1362.6 279.237 1359.52 283.844 Q1356.47 288.427 1350.66 288.427 Q1344.85 288.427 1341.77 283.844 Q1338.71 279.237 1338.71 270.51 Q1338.71 261.76 1341.77 257.177 Q1344.85 252.571 1350.66 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1380.82 256.274 Q1377.21 256.274 1375.38 259.839 Q1373.58 263.381 1373.58 270.51 Q1373.58 277.617 1375.38 281.182 Q1377.21 284.723 1380.82 284.723 Q1384.45 284.723 1386.26 281.182 Q1388.09 277.617 1388.09 270.51 Q1388.09 263.381 1386.26 259.839 Q1384.45 256.274 1380.82 256.274 M1380.82 252.571 Q1386.63 252.571 1389.69 257.177 Q1392.76 261.76 1392.76 270.51 Q1392.76 279.237 1389.69 283.844 Q1386.63 288.427 1380.82 288.427 Q1375.01 288.427 1371.93 283.844 Q1368.88 279.237 1368.88 270.51 Q1368.88 261.76 1371.93 257.177 Q1375.01 252.571 1380.82 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1399.8 253.196 L1422.02 253.196 L1422.02 255.186 L1409.48 287.756 L1404.59 287.756 L1416.4 257.131 L1399.8 257.131 L1399.8 253.196 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1462.95 258.034 L1462.95 270.927 L1475.84 270.927 L1475.84 274.862 L1462.95 274.862 L1462.95 287.756 L1459.06 287.756 L1459.06 274.862 L1446.17 274.862 L1446.17 270.927 L1459.06 270.927 L1459.06 258.034 L1462.95 258.034 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1511.01 256.274 Q1507.39 256.274 1505.57 259.839 Q1503.76 263.381 1503.76 270.51 Q1503.76 277.617 1505.57 281.182 Q1507.39 284.723 1511.01 284.723 Q1514.64 284.723 1516.44 281.182 Q1518.27 277.617 1518.27 270.51 Q1518.27 263.381 1516.44 259.839 Q1514.64 256.274 1511.01 256.274 M1511.01 252.571 Q1516.82 252.571 1519.87 257.177 Q1522.95 261.76 1522.95 270.51 Q1522.95 279.237 1519.87 283.844 Q1516.82 288.427 1511.01 288.427 Q1505.19 288.427 1502.12 283.844 Q1499.06 279.237 1499.06 270.51 Q1499.06 261.76 1502.12 257.177 Q1505.19 252.571 1511.01 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1531.17 281.876 L1536.05 281.876 L1536.05 287.756 L1531.17 287.756 L1531.17 281.876 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1556.24 256.274 Q1552.63 256.274 1550.8 259.839 Q1548.99 263.381 1548.99 270.51 Q1548.99 277.617 1550.8 281.182 Q1552.63 284.723 1556.24 284.723 Q1559.87 284.723 1561.68 281.182 Q1563.5 277.617 1563.5 270.51 Q1563.5 263.381 1561.68 259.839 Q1559.87 256.274 1556.24 256.274 M1556.24 252.571 Q1562.05 252.571 1565.1 257.177 Q1568.18 261.76 1568.18 270.51 Q1568.18 279.237 1565.1 283.844 Q1562.05 288.427 1556.24 288.427 Q1550.43 288.427 1547.35 283.844 Q1544.29 279.237 1544.29 270.51 Q1544.29 261.76 1547.35 257.177 Q1550.43 252.571 1556.24 252.571 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1586.98 268.612 Q1583.83 268.612 1581.98 270.765 Q1580.15 272.918 1580.15 276.668 Q1580.15 280.395 1581.98 282.571 Q1583.83 284.723 1586.98 284.723 Q1590.13 284.723 1591.95 282.571 Q1593.81 280.395 1593.81 276.668 Q1593.81 272.918 1591.95 270.765 Q1590.13 268.612 1586.98 268.612 M1596.26 253.96 L1596.26 258.219 Q1594.5 257.386 1592.69 256.946 Q1590.91 256.506 1589.15 256.506 Q1584.52 256.506 1582.07 259.631 Q1579.64 262.756 1579.29 269.075 Q1580.66 267.061 1582.72 265.997 Q1584.78 264.909 1587.25 264.909 Q1592.46 264.909 1595.47 268.08 Q1598.5 271.228 1598.5 276.668 Q1598.5 281.992 1595.36 285.209 Q1592.21 288.427 1586.98 288.427 Q1580.98 288.427 1577.81 283.844 Q1574.64 279.237 1574.64 270.51 Q1574.64 262.316 1578.53 257.455 Q1582.42 252.571 1588.97 252.571 Q1590.73 252.571 1592.51 252.918 Q1594.31 253.265 1596.26 253.96 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1606.61 253.196 L1624.96 253.196 L1624.96 257.131 L1610.89 257.131 L1610.89 265.603 Q1611.91 265.256 1612.93 265.094 Q1613.94 264.909 1614.96 264.909 Q1620.75 264.909 1624.13 268.08 Q1627.51 271.251 1627.51 276.668 Q1627.51 282.246 1624.04 285.348 Q1620.56 288.427 1614.25 288.427 Q1612.07 288.427 1609.8 288.057 Q1607.56 287.686 1605.15 286.946 L1605.15 282.246 Q1607.23 283.381 1609.45 283.936 Q1611.68 284.492 1614.15 284.492 Q1618.16 284.492 1620.5 282.385 Q1622.83 280.279 1622.83 276.668 Q1622.83 273.057 1620.5 270.95 Q1618.16 268.844 1614.15 268.844 Q1612.28 268.844 1610.4 269.26 Q1608.55 269.677 1606.61 270.557 L1606.61 253.196 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path><path clip-path="url(#clip290)" d="M1657.67 261.83 L1648.3 274.446 L1658.16 287.756 L1653.13 287.756 L1645.59 277.571 L1638.04 287.756 L1633.02 287.756 L1643.09 274.191 L1633.87 261.83 L1638.9 261.83 L1645.77 271.066 L1652.65 261.83 L1657.67 261.83 Z" fill="#000000" fill-rule="nonzero" fill-opacity="1"></path></svg>
\ No newline at end of file diff --git a/hw7/tightbinding (1).jl b/hw7/tightbinding (1).jl new file mode 100644 index 0000000..0d1cc8c --- /dev/null +++ b/hw7/tightbinding (1).jl @@ -0,0 +1,24 @@ +using LinearAlgebra + +# Define the tight binding Hamiltonian +function tight_binding_hamiltonian(n_sites::Int64, t::Float64) + H = zeros(n_sites, n_sites) + for i in 1:(n_sites-1) + H[i, i+1] = t + H[i+1, i] = t + end + H +end + +# Find the eigenenergies of the Hamiltonian +function eigenenergies(H::Array{Float64, 2}) + eigvals(H) +end + +n_sites = 10 # number of sites in the chain +t = 1.0 # hopping parameter +H = tight_binding_hamiltonian(n_sites, t) +energies = eigenenergies(H) +println(energies) + + |