aboutsummaryrefslogtreecommitdiff
diff options
context:
space:
mode:
authorJohannes Ranke <jranke@uni-bremen.de>2020-12-08 22:08:38 +0100
committerJohannes Ranke <jranke@uni-bremen.de>2020-12-08 22:08:38 +0100
commitf606838c5310f365eea1c0d6421f5c3636a4dc79 (patch)
treebdf4fdb5cb3a94cc46176f9e69132af11e81f749
parent2663158c85fca9c088d1f8cfa3bc05ad1ac36f94 (diff)
mixed.mmkin and test coverage
-rw-r--r--NAMESPACE3
-rw-r--r--NEWS.md2
-rw-r--r--R/mixed.mmkin.R101
-rw-r--r--R/mkinfit.R4
-rw-r--r--R/plot.mixed.mmkin.R61
-rw-r--r--R/saem.R4
-rw-r--r--R/summary.saem.mmkin.R75
-rw-r--r--check.log9
-rw-r--r--man/mixed.Rd69
-rw-r--r--man/mkinmod.Rd4
-rw-r--r--man/plot.mixed.mmkin.Rd2
-rw-r--r--man/saem.Rd26
-rw-r--r--test.log40
-rw-r--r--tests/figs/plotting/mixed-model-fit-for-mmkin-object.svg2482
-rw-r--r--tests/figs/plotting/mixed-model-fit-for-nlme-object.svg2482
-rw-r--r--tests/figs/plotting/mixed-model-fit-for-saem-object-with-mkin-transformations.svg2482
-rw-r--r--tests/figs/plotting/mixed-model-fit-for-saem-object-with-saemix-transformations.svg2482
-rw-r--r--tests/testthat/setup_script.R64
-rw-r--r--tests/testthat/test_AIC.R1
-rw-r--r--tests/testthat/test_confidence.R17
-rw-r--r--tests/testthat/test_mixed.R35
-rw-r--r--tests/testthat/test_nafta.R2
-rw-r--r--tests/testthat/test_plot.R10
-rw-r--r--tests/testthat/test_saem.R118
24 files changed, 10487 insertions, 88 deletions
diff --git a/NAMESPACE b/NAMESPACE
index 6ff00109..f2497283 100644
--- a/NAMESPACE
+++ b/NAMESPACE
@@ -12,6 +12,7 @@ S3method(loftest,mkinfit)
S3method(logLik,mkinfit)
S3method(lrtest,mkinfit)
S3method(lrtest,mmkin)
+S3method(mixed,mmkin)
S3method(mkinpredict,mkinfit)
S3method(mkinpredict,mkinmod)
S3method(nlme,mmkin)
@@ -22,6 +23,7 @@ S3method(plot,mixed.mmkin)
S3method(plot,mkinfit)
S3method(plot,mmkin)
S3method(plot,nafta)
+S3method(print,mixed.mmkin)
S3method(print,mkinds)
S3method(print,mkindsg)
S3method(print,mkinmod)
@@ -65,6 +67,7 @@ export(max_twa_hs)
export(max_twa_parent)
export(max_twa_sfo)
export(mean_degparms)
+export(mixed)
export(mkin_long_to_wide)
export(mkin_wide_to_long)
export(mkinds)
diff --git a/NEWS.md b/NEWS.md
index 0fd78b59..ac67688d 100644
--- a/NEWS.md
+++ b/NEWS.md
@@ -1,5 +1,7 @@
# mkin 0.9.50.4 (unreleased)
+- 'mixed.mmkin' New container for mmkin objects for plotting with the 'plot.mixed.mmkin' method
+
- 'mkinmod' models gain arguments 'name' and 'dll_dir' which, in conjunction with a current version of the 'inline' package, make it possible to still use the DLL used for fast ODE solutions with 'deSolve' after saving and restoring the 'mkinmod' object.
- 'f_norm_temp_focus' generic function to normalise time intervals using the FOCUS method, with methods for numeric vectors and 'mkindsg' objects
diff --git a/R/mixed.mmkin.R b/R/mixed.mmkin.R
new file mode 100644
index 00000000..6fe5130d
--- /dev/null
+++ b/R/mixed.mmkin.R
@@ -0,0 +1,101 @@
+#' Create a mixed effects model from an mmkin row object
+#'
+#' @param object An [mmkin] row object
+#' @param method The method to be used
+#' @param \dots Currently not used
+#' @examples
+#' sampling_times = c(0, 1, 3, 7, 14, 28, 60, 90, 120)
+#' n_biphasic <- 8
+#' err_1 = list(const = 1, prop = 0.07)
+#'
+#' DFOP_SFO <- mkinmod(
+#' parent = mkinsub("DFOP", "m1"),
+#' m1 = mkinsub("SFO"),
+#' quiet = TRUE)
+#'
+#' set.seed(123456)
+#' log_sd <- 0.3
+#' syn_biphasic_parms <- as.matrix(data.frame(
+#' k1 = rlnorm(n_biphasic, log(0.05), log_sd),
+#' k2 = rlnorm(n_biphasic, log(0.01), log_sd),
+#' g = plogis(rnorm(n_biphasic, 0, log_sd)),
+#' f_parent_to_m1 = plogis(rnorm(n_biphasic, 0, log_sd)),
+#' k_m1 = rlnorm(n_biphasic, log(0.002), log_sd)))
+#'
+#' ds_biphasic_mean <- lapply(1:n_biphasic,
+#' function(i) {
+#' mkinpredict(DFOP_SFO, syn_biphasic_parms[i, ],
+#' c(parent = 100, m1 = 0), sampling_times)
+#' }
+#' )
+#'
+#' set.seed(123456L)
+#' ds_biphasic <- lapply(ds_biphasic_mean, function(ds) {
+#' add_err(ds,
+#' sdfunc = function(value) sqrt(err_1$const^2 + value^2 * err_1$prop^2),
+#' n = 1, secondary = "m1")[[1]]
+#' })
+#'
+#' \dontrun{
+#' f_mmkin <- mmkin(list("DFOP-SFO" = DFOP_SFO), ds_biphasic, error_model = "tc", quiet = TRUE)
+#'
+#' f_mixed <- mixed(f_mmkin)
+#' print(f_mixed)
+#' plot(f_mixed)
+#' }
+#' @export
+mixed <- function(object, ...) {
+ UseMethod("mixed")
+}
+
+#' @export
+#' @rdname mixed
+mixed.mmkin <- function(object, method = c("none"), ...) {
+ if (nrow(object) > 1) stop("Only row objects allowed")
+
+ method <- match.arg(method)
+ if (method == "default") method = c("naive", "nlme")
+
+ ds_names <- colnames(object)
+ res <- list(mmkin = object, mkinmod = object[[1]]$mkinmod)
+
+ if (method[1] == "none") {
+ ds_list <- lapply(object,
+ function(x) x$data[c("variable", "time", "observed", "predicted", "residual")])
+
+ names(ds_list) <- ds_names
+ res$data <- purrr::map_dfr(ds_list, function(x) x, .id = "ds")
+ names(res$data)[1:4] <- c("ds", "name", "time", "value")
+ res$data$name <- as.character(res$data$name)
+ res$data$ds <- ordered(res$data$ds, levels = unique(res$data$ds))
+ standardized <- unlist(lapply(object, residuals, standardized = TRUE))
+ res$data$std <- res$data$residual / standardized
+ res$data$standardized <- standardized
+
+ class(res) <- c("mixed.mmkin")
+ return(res)
+ }
+}
+
+#' @export
+#' @rdname mixed
+#' @param x A mixed.mmkin object to print
+#' @param digits Number of digits to use for printing.
+print.mixed.mmkin <- function(x, digits = max(3, getOption("digits") - 3), ...) {
+ cat("Kinetic model fitted by nonlinear regression to each dataset" )
+ cat("\nStructural model:\n")
+ diffs <- x$mmkin[[1]]$mkinmod$diffs
+ nice_diffs <- gsub("^(d.*) =", "\\1/dt =", diffs)
+ writeLines(strwrap(nice_diffs, exdent = 11))
+ cat("\nData:\n")
+ cat(nrow(x$data), "observations of",
+ length(unique(x$data$name)), "variable(s) grouped in",
+ length(unique(x$data$ds)), "datasets\n\n")
+
+ print(x$mmkin)
+
+ cat("\nMean fitted parameters:\n")
+ print(mean_degparms(x$mmkin))
+
+ invisible(x)
+}
diff --git a/R/mkinfit.R b/R/mkinfit.R
index a6efc858..c659e446 100644
--- a/R/mkinfit.R
+++ b/R/mkinfit.R
@@ -885,8 +885,8 @@ mkinfit <- function(mkinmod, observed,
fit$rss <- function(P) cost_function(P, OLS = TRUE, update_data = FALSE)
# Log-likelihood with possibility to fix degparms or errparms
- fit$ll <- function(P, fixed_degparms = FALSE, fixed_errparms = FALSE) {
- - cost_function(P, trans = FALSE, fixed_degparms = fixed_degparms,
+ fit$ll <- function(P, fixed_degparms = FALSE, fixed_errparms = FALSE, trans = FALSE) {
+ - cost_function(P, trans = trans, fixed_degparms = fixed_degparms,
fixed_errparms = fixed_errparms, OLS = FALSE, update_data = FALSE)
}
diff --git a/R/plot.mixed.mmkin.R b/R/plot.mixed.mmkin.R
index d8a1c2ac..db29376e 100644
--- a/R/plot.mixed.mmkin.R
+++ b/R/plot.mixed.mmkin.R
@@ -2,7 +2,7 @@ utils::globalVariables("ds")
#' Plot predictions from a fitted nonlinear mixed model obtained via an mmkin row object
#'
-#' @param x An object of class [saem.mmkin] or [nlme.mmkin]
+#' @param x An object of class [mixed.mmkin], [saem.mmkin] or [nlme.mmkin]
#' @param i A numeric index to select datasets for which to plot the individual predictions,
#' in case plots get too large
#' @inheritParams plot.mkinfit
@@ -63,31 +63,43 @@ plot.mixed.mmkin <- function(x,
fit_1 <- x$mmkin[[1]]
ds_names <- colnames(x$mmkin)
+ backtransform = TRUE
+
+ if (identical(class(x), "mixed.mmkin")) {
+ degparms_pop <- mean_degparms(x$mmkin)
+
+ degparms_tmp <- parms(x$mmkin, transformed = TRUE)
+ degparms_i <- as.data.frame(t(degparms_tmp[setdiff(rownames(degparms_tmp), names(fit_1$errparms)), ]))
+ residual_type = ifelse(standardized, "standardized", "residual")
+ residuals <- x$data[[residual_type]]
+ }
+
if (inherits(x, "nlme.mmkin")) {
- degparms_optim <- coefficients(x)
+ degparms_i <- coefficients(x)
degparms_pop <- nlme::fixef(x)
residuals <- residuals(x,
type = ifelse(standardized, "pearson", "response"))
}
if (inherits(x, "saem.mmkin")) {
- degparms_optim <- saemix::psi(x$so)
- rownames(degparms_optim) <- ds_names
- degparms_optim_names <- setdiff(names(fit_1$par), names(fit_1$errparms))
- colnames(degparms_optim) <- degparms_optim_names
- residual_type = ifelse(standardized, "residual", "standardized")
+ if (x$transformations == "saemix") backtransform = FALSE
+ degparms_i <- saemix::psi(x$so)
+ rownames(degparms_i) <- ds_names
+ degparms_i_names <- setdiff(x$so@results@name.fixed, names(fit_1$errparms))
+ colnames(degparms_i) <- degparms_i_names
+ residual_type = ifelse(standardized, "standardized", "residual")
residuals <- x$data[[residual_type]]
degparms_pop <- x$so@results@fixed.effects
- names(degparms_pop) <- degparms_optim_names
+ names(degparms_pop) <- degparms_i_names
}
degparms_fixed <- fit_1$fixed$value
names(degparms_fixed) <- rownames(fit_1$fixed)
- degparms_all <- cbind(as.matrix(degparms_optim),
- matrix(rep(degparms_fixed, nrow(degparms_optim)),
+ degparms_all <- cbind(as.matrix(degparms_i),
+ matrix(rep(degparms_fixed, nrow(degparms_i)),
ncol = length(degparms_fixed),
- nrow = nrow(degparms_optim), byrow = TRUE))
- degparms_all_names <- c(names(degparms_optim), names(degparms_fixed))
+ nrow = nrow(degparms_i), byrow = TRUE))
+ degparms_all_names <- c(names(degparms_i), names(degparms_fixed))
colnames(degparms_all) <- degparms_all_names
degparms_all_pop <- c(degparms_pop, degparms_fixed)
@@ -106,10 +118,14 @@ plot.mixed.mmkin <- function(x,
pred_ds <- purrr::map_dfr(i, function(ds_i) {
odeparms_trans <- degparms_all[ds_i, odeparms_names]
names(odeparms_trans) <- odeparms_names # needed if only one odeparm
- odeparms <- backtransform_odeparms(odeparms_trans,
- x$mkinmod,
- transform_rates = fit_1$transform_rates,
- transform_fractions = fit_1$transform_fractions)
+ if (backtransform) {
+ odeparms <- backtransform_odeparms(odeparms_trans,
+ x$mkinmod,
+ transform_rates = fit_1$transform_rates,
+ transform_fractions = fit_1$transform_fractions)
+ } else {
+ odeparms <- odeparms_trans
+ }
odeini <- degparms_all[ds_i, odeini_names]
names(odeini) <- gsub("_0", "", odeini_names)
@@ -121,10 +137,15 @@ plot.mixed.mmkin <- function(x,
})
odeparms_pop_trans <- degparms_all_pop[odeparms_names]
- odeparms_pop <- backtransform_odeparms(odeparms_pop_trans,
- x$mkinmod,
- transform_rates = fit_1$transform_rates,
- transform_fractions = fit_1$transform_fractions)
+
+ if (backtransform) {
+ odeparms_pop <- backtransform_odeparms(odeparms_pop_trans,
+ x$mkinmod,
+ transform_rates = fit_1$transform_rates,
+ transform_fractions = fit_1$transform_fractions)
+ } else {
+ odeparms_pop <- odeparms_pop_trans
+ }
odeini_pop <- degparms_all_pop[odeini_names]
names(odeini_pop) <- gsub("_0", "", odeini_names)
diff --git a/R/saem.R b/R/saem.R
index e5634ac7..88b8e172 100644
--- a/R/saem.R
+++ b/R/saem.R
@@ -92,7 +92,7 @@ utils::globalVariables(c("predicted", "std"))
#' plot(f_saem_fomc)
#' }
#' @export
-saem <- function(object, control, ...) UseMethod("saem")
+saem <- function(object, ...) UseMethod("saem")
#' @rdname saem
#' @export
@@ -104,9 +104,11 @@ saem.mmkin <- function(object,
cores = 1,
verbose = FALSE, suppressPlot = TRUE, quiet = FALSE, ...)
{
+ transformations <- match.arg(transformations)
m_saemix <- saemix_model(object, cores = cores, verbose = verbose,
solution_type = solution_type, transformations = transformations, ...)
d_saemix <- saemix_data(object, verbose = verbose)
+
if (suppressPlot) {
# We suppress the log-likelihood curve that saemix currently
# produces at the end of the fit by plotting to a file
diff --git a/R/summary.saem.mmkin.R b/R/summary.saem.mmkin.R
index 97f9f2da..27c2ce6c 100644
--- a/R/summary.saem.mmkin.R
+++ b/R/summary.saem.mmkin.R
@@ -89,9 +89,42 @@ summary.saem.mmkin <- function(object, data = FALSE, verbose = FALSE, distimes =
confint_trans <- as.matrix(conf.int[pnames, c("estimate", "lower", "upper")])
colnames(confint_trans)[1] <- "est."
- bp <- backtransform_odeparms(confint_trans[, "est."], object$mkinmod,
- object$transform_rates, object$transform_fractions)
- bpnames <- names(bp)
+ if (object$transformations == "mkin") {
+ bp <- backtransform_odeparms(confint_trans[, "est."], object$mkinmod,
+ object$transform_rates, object$transform_fractions)
+ bpnames <- names(bp)
+
+ # Transform boundaries of CI for one parameter at a time,
+ # with the exception of sets of formation fractions (single fractions are OK).
+ f_names_skip <- character(0)
+ for (box in mod_vars) { # Figure out sets of fractions to skip
+ f_names <- grep(paste("^f", box, sep = "_"), pnames, value = TRUE)
+ n_paths <- length(f_names)
+ if (n_paths > 1) f_names_skip <- c(f_names_skip, f_names)
+ }
+
+ confint_back <- matrix(NA, nrow = length(bp), ncol = 3,
+ dimnames = list(bpnames, colnames(confint_trans)))
+ confint_back[, "est."] <- bp
+
+ for (pname in pnames) {
+ if (!pname %in% f_names_skip) {
+ par.lower <- confint_trans[pname, "lower"]
+ par.upper <- confint_trans[pname, "upper"]
+ names(par.lower) <- names(par.upper) <- pname
+ bpl <- backtransform_odeparms(par.lower, object$mkinmod,
+ object$transform_rates,
+ object$transform_fractions)
+ bpu <- backtransform_odeparms(par.upper, object$mkinmod,
+ object$transform_rates,
+ object$transform_fractions)
+ confint_back[names(bpl), "lower"] <- bpl
+ confint_back[names(bpu), "upper"] <- bpu
+ }
+ }
+ } else {
+ confint_back <- confint_trans
+ }
# Correlation of fixed effects (inspired by summary.nlme)
varFix <- vcov(object$so)[1:np, 1:np]
@@ -111,34 +144,6 @@ summary.saem.mmkin <- function(object, data = FALSE, verbose = FALSE, distimes =
confint_errmod <- as.matrix(conf.int[enames, c("estimate", "lower", "upper")])
colnames(confint_errmod)[1] <- "est."
- # Transform boundaries of CI for one parameter at a time,
- # with the exception of sets of formation fractions (single fractions are OK).
- f_names_skip <- character(0)
- for (box in mod_vars) { # Figure out sets of fractions to skip
- f_names <- grep(paste("^f", box, sep = "_"), pnames, value = TRUE)
- n_paths <- length(f_names)
- if (n_paths > 1) f_names_skip <- c(f_names_skip, f_names)
- }
-
- confint_back <- matrix(NA, nrow = length(bp), ncol = 3,
- dimnames = list(bpnames, colnames(confint_trans)))
- confint_back[, "est."] <- bp
-
- for (pname in pnames) {
- if (!pname %in% f_names_skip) {
- par.lower <- confint_trans[pname, "lower"]
- par.upper <- confint_trans[pname, "upper"]
- names(par.lower) <- names(par.upper) <- pname
- bpl <- backtransform_odeparms(par.lower, object$mkinmod,
- object$transform_rates,
- object$transform_fractions)
- bpu <- backtransform_odeparms(par.upper, object$mkinmod,
- object$transform_rates,
- object$transform_fractions)
- confint_back[names(bpl), "lower"] <- bpl
- confint_back[names(bpu), "upper"] <- bpu
- }
- }
object$confint_trans <- confint_trans
object$confint_ranef <- confint_ranef
@@ -213,7 +218,7 @@ print.summary.saem.mmkin <- function(x, digits = max(3, getOption("digits") - 3)
print(data.frame(AIC = x$AIC, BIC = x$BIC, logLik = x$logLik,
row.names = " "), digits = digits)
- cat("\nOptimised, transformed parameters with symmetric confidence intervals:\n")
+ cat("\nOptimised parameters:\n")
print(x$confint_trans, digits = digits)
if (nrow(x$confint_trans) > 1) {
@@ -228,8 +233,10 @@ print.summary.saem.mmkin <- function(x, digits = max(3, getOption("digits") - 3)
cat("\nVariance model:\n")
print(x$confint_errmod, digits = digits)
- cat("\nBacktransformed parameters with asymmetric confidence intervals:\n")
- print(x$confint_back, digits = digits)
+ if (x$transformations == "mkin") {
+ cat("\nBacktransformed parameters:\n")
+ print(x$confint_back, digits = digits)
+ }
printSFORB <- !is.null(x$SFORB)
if(printSFORB){
diff --git a/check.log b/check.log
index 3dfee39f..68367bee 100644
--- a/check.log
+++ b/check.log
@@ -21,7 +21,8 @@ Maintainer: ‘Johannes Ranke <jranke@uni-bremen.de>’
* checking whether package ‘mkin’ can be installed ... OK
* checking installed package size ... OK
* checking package directory ... OK
-* checking for future file timestamps ... OK
+* checking for future file timestamps ... NOTE
+unable to verify current time
* checking ‘build’ directory ... OK
* checking DESCRIPTION meta-information ... OK
* checking top-level files ... OK
@@ -67,5 +68,9 @@ Maintainer: ‘Johannes Ranke <jranke@uni-bremen.de>’
* checking for detritus in the temp directory ... OK
* DONE
-Status: OK
+Status: 1 NOTE
+See
+ ‘/home/jranke/git/mkin/mkin.Rcheck/00check.log’
+for details.
+
diff --git a/man/mixed.Rd b/man/mixed.Rd
new file mode 100644
index 00000000..8b00382d
--- /dev/null
+++ b/man/mixed.Rd
@@ -0,0 +1,69 @@
+% Generated by roxygen2: do not edit by hand
+% Please edit documentation in R/mixed.mmkin.R
+\name{mixed}
+\alias{mixed}
+\alias{mixed.mmkin}
+\alias{print.mixed.mmkin}
+\title{Create a mixed effects model from an mmkin row object}
+\usage{
+mixed(object, ...)
+
+\method{mixed}{mmkin}(object, method = c("none"), ...)
+
+\method{print}{mixed.mmkin}(x, digits = max(3, getOption("digits") - 3), ...)
+}
+\arguments{
+\item{object}{An \link{mmkin} row object}
+
+\item{\dots}{Currently not used}
+
+\item{method}{The method to be used}
+
+\item{x}{A mixed.mmkin object to print}
+
+\item{digits}{Number of digits to use for printing.}
+}
+\description{
+Create a mixed effects model from an mmkin row object
+}
+\examples{
+sampling_times = c(0, 1, 3, 7, 14, 28, 60, 90, 120)
+n_biphasic <- 8
+err_1 = list(const = 1, prop = 0.07)
+
+DFOP_SFO <- mkinmod(
+ parent = mkinsub("DFOP", "m1"),
+ m1 = mkinsub("SFO"),
+ quiet = TRUE)
+
+set.seed(123456)
+log_sd <- 0.3
+syn_biphasic_parms <- as.matrix(data.frame(
+ k1 = rlnorm(n_biphasic, log(0.05), log_sd),
+ k2 = rlnorm(n_biphasic, log(0.01), log_sd),
+ g = plogis(rnorm(n_biphasic, 0, log_sd)),
+ f_parent_to_m1 = plogis(rnorm(n_biphasic, 0, log_sd)),
+ k_m1 = rlnorm(n_biphasic, log(0.002), log_sd)))
+
+ds_biphasic_mean <- lapply(1:n_biphasic,
+ function(i) {
+ mkinpredict(DFOP_SFO, syn_biphasic_parms[i, ],
+ c(parent = 100, m1 = 0), sampling_times)
+ }
+)
+
+set.seed(123456L)
+ds_biphasic <- lapply(ds_biphasic_mean, function(ds) {
+ add_err(ds,
+ sdfunc = function(value) sqrt(err_1$const^2 + value^2 * err_1$prop^2),
+ n = 1, secondary = "m1")[[1]]
+})
+
+\dontrun{
+f_mmkin <- mmkin(list("DFOP-SFO" = DFOP_SFO), ds_biphasic, error_model = "tc", quiet = TRUE)
+
+f_mixed <- mixed(f_mmkin)
+print(f_mixed)
+plot(f_mixed)
+}
+}
diff --git a/man/mkinmod.Rd b/man/mkinmod.Rd
index 95cec09a..bf073634 100644
--- a/man/mkinmod.Rd
+++ b/man/mkinmod.Rd
@@ -41,8 +41,8 @@ In print.mkinmod, this argument is currently not used.}
\item{use_of_ff}{Specification of the use of formation fractions in the
model equations and, if applicable, the coefficient matrix. If "max",
formation fractions are always used (default). If "min", a minimum use of
-formation fractions is made, i.e. each pathway to a metabolite has its
-own rate constant.}
+formation fractions is made, i.e. each first-order pathway to a metabolite
+has its own rate constant.}
\item{name}{A name for the model. Should be a valid R object name.}
diff --git a/man/plot.mixed.mmkin.Rd b/man/plot.mixed.mmkin.Rd
index 66e79f09..b90a4b3a 100644
--- a/man/plot.mixed.mmkin.Rd
+++ b/man/plot.mixed.mmkin.Rd
@@ -26,7 +26,7 @@
)
}
\arguments{
-\item{x}{An object of class \link{saem.mmkin} or \link{nlme.mmkin}}
+\item{x}{An object of class \link{mixed.mmkin}, \link{saem.mmkin} or \link{nlme.mmkin}}
\item{i}{A numeric index to select datasets for which to plot the individual predictions,
in case plots get too large}
diff --git a/man/saem.Rd b/man/saem.Rd
index ef5480f1..d8d6ea0f 100644
--- a/man/saem.Rd
+++ b/man/saem.Rd
@@ -8,10 +8,12 @@
\alias{saemix_data}
\title{Fit nonlinear mixed models with SAEM}
\usage{
-saem(object, control, ...)
+saem(object, ...)
\method{saem}{mmkin}(
object,
+ transformations = c("mkin", "saemix"),
+ solution_type = "auto",
control = list(displayProgress = FALSE, print = FALSE, save = FALSE, save.graphs =
FALSE),
cores = 1,
@@ -23,7 +25,14 @@ saem(object, control, ...)
\method{print}{saem.mmkin}(x, digits = max(3, getOption("digits") - 3), ...)
-saemix_model(object, cores = 1, verbose = FALSE, ...)
+saemix_model(
+ object,
+ solution_type = "auto",
+ transformations = c("mkin", "saemix"),
+ cores = 1,
+ verbose = FALSE,
+ ...
+)
saemix_data(object, verbose = FALSE, ...)
}
@@ -31,10 +40,19 @@ saemix_data(object, verbose = FALSE, ...)
\item{object}{An \link{mmkin} row object containing several fits of the same
\link{mkinmod} model to different datasets}
-\item{control}{Passed to \link[saemix:saemix]{saemix::saemix}}
-
\item{\dots}{Further parameters passed to \link[saemix:saemixModel]{saemix::saemixModel}.}
+\item{transformations}{Per default, all parameter transformations are done
+in mkin. If this argument is set to 'saemix', parameter transformations
+are done in 'saemix' for the supported cases. Currently this is only
+supported in cases where the initial concentration of the parent is not fixed,
+SFO or DFOP is used for the parent and there is either no metabolite or one.}
+
+\item{solution_type}{Possibility to specify the solution type in case the
+automatic choice is not desired}
+
+\item{control}{Passed to \link[saemix:saemix]{saemix::saemix}}
+
\item{cores}{The number of cores to be used for multicore processing using
\code{\link[parallel:mclapply]{parallel::mclapply()}}. Using more than 1 core is experimental and may
lead to excessive forking, apparently depending on the BLAS version
diff --git a/test.log b/test.log
index c977d6a0..70011abb 100644
--- a/test.log
+++ b/test.log
@@ -2,48 +2,54 @@ Loading mkin
Loading required package: parallel
Testing mkin
✔ | OK F W S | Context
-✔ | 4 | AIC calculation
+✔ | 5 | AIC calculation
✔ | 2 | Export dataset for reading into CAKE
-✔ | 14 | Results for FOCUS D established in expertise for UBA (Ranke 2014) [0.9 s]
-✔ | 4 | Calculation of FOCUS chi2 error levels [0.4 s]
+✔ | 14 | Results for FOCUS D established in expertise for UBA (Ranke 2014) [1.0 s]
+✔ | 4 | Calculation of FOCUS chi2 error levels [0.5 s]
✔ | 7 | Fitting the SFORB model [3.5 s]
-✔ | 5 | Analytical solutions for coupled models [3.1 s]
+✔ | 5 | Analytical solutions for coupled models [3.2 s]
✔ | 5 | Calculation of Akaike weights
-✔ | 10 | Confidence intervals and p-values [1.0 s]
-✔ | 14 | Error model fitting [4.7 s]
+✔ | 14 | Confidence intervals and p-values [1.2 s]
+✔ | 14 | Error model fitting [4.5 s]
✔ | 4 | Test fitting the decline of metabolites from their maximum [0.3 s]
✔ | 1 | Fitting the logistic model [0.2 s]
✔ | 1 | Test dataset class mkinds used in gmkin
✔ | 1 | mkinfit features [0.3 s]
✔ | 12 | Special cases of mkinfit calls [0.7 s]
-✔ | 8 | mkinmod model generation and printing [0.3 s]
+✔ | 8 | mkinmod model generation and printing [0.2 s]
✔ | 3 | Model predictions with mkinpredict [0.4 s]
-✔ | 14 2 | Evaluations according to 2015 NAFTA guidance [1.2 s]
+✔ | 14 2 | Evaluations according to 2015 NAFTA guidance [1.3 s]
────────────────────────────────────────────────────────────────────────────────
-Skip (test_nafta.R:26:5): Test data from Appendix B are correctly evaluated
+Skip (test_nafta.R:25:5): Test data from Appendix B are correctly evaluated
Reason: getRversion() < "4.1.0" is TRUE
-Skip (test_nafta.R:55:5): Test data from Appendix D are correctly evaluated
+Skip (test_nafta.R:53:5): Test data from Appendix D are correctly evaluated
Reason: getRversion() < "4.1.0" is TRUE
────────────────────────────────────────────────────────────────────────────────
-✔ | 9 | Nonlinear mixed-effects models [8.0 s]
+✔ | 9 | Nonlinear mixed-effects models [7.9 s]
✔ | 0 1 | Plotting [0.7 s]
────────────────────────────────────────────────────────────────────────────────
-Skip (test_plot.R:25:3): Plotting mkinfit and mmkin objects is reproducible
+Skip (test_plot.R:28:3): Plotting mkinfit and mmkin objects is reproducible
Reason: getRversion() < "4.1.0" is TRUE
────────────────────────────────────────────────────────────────────────────────
✔ | 4 | Residuals extracted from mkinfit models
-✔ | 2 | Complex test case from Schaefer et al. (2007) Piacenza paper [1.7 s]
-✔ | 4 | Summary [0.2 s]
+✔ | 13 1 | Nonlinear mixed effects models fitted with SAEM from saemix [19.0 s]
+────────────────────────────────────────────────────────────────────────────────
+Skip (test_saem.R:103:1): Simple models with metabolite can be fitted with saemix
+Reason: empty test
+────────────────────────────────────────────────────────────────────────────────
+✔ | 2 | Complex test case from Schaefer et al. (2007) Piacenza paper [1.5 s]
+✔ | 4 | Summary [0.1 s]
✔ | 1 | Summaries of old mkinfit objects
✔ | 4 | Results for synthetic data established in expertise for UBA (Ranke 2014) [2.3 s]
-✔ | 9 | Hypothesis tests [7.2 s]
+✔ | 9 | Hypothesis tests [7.3 s]
✔ | 4 | Calculation of maximum time weighted average concentrations (TWAs) [2.4 s]
══ Results ═════════════════════════════════════════════════════════════════════
-Duration: 39.8 s
+Duration: 59.7 s
── Skipped tests ──────────────────────────────────────────────────────────────
+● empty test (1)
● getRversion() < "4.1.0" is TRUE (3)
-[ FAIL 0 | WARN 0 | SKIP 3 | PASS 146 ]
+[ FAIL 0 | WARN 0 | SKIP 4 | PASS 164 ]
diff --git a/tests/figs/plotting/mixed-model-fit-for-mmkin-object.svg b/tests/figs/plotting/mixed-model-fit-for-mmkin-object.svg
new file mode 100644
index 00000000..53a826df
--- /dev/null
+++ b/tests/figs/plotting/mixed-model-fit-for-mmkin-object.svg
@@ -0,0 +1,2482 @@
+<?xml version='1.0' encoding='UTF-8' ?>
+<svg xmlns='http://www.w3.org/2000/svg' xmlns:xlink='http://www.w3.org/1999/xlink' viewBox='0 0 720.00 576.00'>
+<defs>
+ <style type='text/css'><![CDATA[
+ line, polyline, polygon, path, rect, circle {
+ fill: none;
+ stroke: #000000;
+ stroke-linecap: round;
+ stroke-linejoin: round;
+ stroke-miterlimit: 10.00;
+ }
+ ]]></style>
+</defs>
+<rect width='100%' height='100%' style='stroke: none; fill: #FFFFFF;'/>
+<defs>
+ <clipPath id='cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA='>
+ <rect x='19.96' y='5.70' width='680.08' height='75.63' />
+ </clipPath>
+</defs>
+<line x1='238.69' y1='29.26' x2='252.94' y2='29.26' style='stroke-width: 1.50;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='38.77' x2='252.94' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='48.27' x2='252.94' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='57.77' x2='252.94' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='29.26' x2='313.78' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='38.77' x2='313.78' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='48.27' x2='313.78' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='57.77' x2='313.78' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='29.26' x2='374.61' y2='29.26' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='38.77' x2='374.61' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='48.27' x2='374.61' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='57.77' x2='374.61' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='29.26' x2='435.45' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='38.77' x2='435.45' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='48.27' x2='435.45' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='57.77' x2='435.45' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='245.81' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='245.81,45.50 248.21,49.66 243.41,49.66 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='243.29' y1='57.77' x2='248.33' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='245.81' y1='60.29' x2='245.81' y2='55.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='31.04' x2='308.43' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='27.48' x2='308.43' y2='31.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='304.13,38.77 306.65,36.25 309.17,38.77 306.65,41.29 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='306.65,51.04 309.05,46.89 304.25,46.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='304.87' y='55.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='59.56' x2='308.43' y2='55.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='55.99' x2='308.43' y2='59.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='31.04' x2='369.27' y2='27.48' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='27.48' x2='369.27' y2='31.04' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='29.26' x2='370.00' y2='29.26' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='31.78' x2='367.48' y2='26.74' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='38.77' x2='370.00' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='41.29' x2='367.48' y2='36.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='364.96,38.77 367.48,36.25 370.00,38.77 367.48,41.29 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='367.48' cy='48.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='48.27' x2='369.27' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='50.05' x2='367.48' y2='46.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,60.55 369.88,55.70 365.08,55.70 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,55.00 369.88,59.85 365.08,59.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='29.26' x2='430.10' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='428.32' y1='31.04' x2='428.32' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='27.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='428.32' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='40.55' x2='430.10' y2='36.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='36.98' x2='430.10' y2='40.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='428.32,46.49 430.10,50.05 426.54,50.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='46.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='426.54,59.56 430.10,59.56 430.10,55.99 426.54,55.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='37.31px' lengthAdjust='spacingAndGlyphs'>Population</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>1</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>3</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>5</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>6</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>7</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>8</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>9</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.19px' lengthAdjust='spacingAndGlyphs'>11</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>12</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>13</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>14</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>15</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<polyline points='50.12,124.05 52.44,129.08 55.81,136.04 57.09,138.59 61.50,146.98 66.38,155.60 67.19,156.97 72.87,166.10 78.56,174.45 82.64,180.01 84.25,182.11 89.94,189.12 95.63,195.56 101.32,201.48 107.01,206.92 112.70,211.92 115.16,213.96 118.39,216.53 124.08,220.78 129.77,224.71 135.46,228.34 141.15,231.70 146.83,234.81 152.52,237.69 158.21,240.36 163.90,242.84 169.59,245.15 175.28,247.30 180.97,249.31 186.66,251.17 189.50,252.06 192.35,252.92 198.04,254.54 203.73,256.07 209.42,257.49 215.11,258.83 220.79,260.08 226.48,261.25 232.17,262.35 237.86,263.39 243.55,264.36 249.24,265.28 254.93,266.14 259.20,266.76 260.62,266.96 266.31,267.72 272.00,268.45 277.69,269.13 283.38,269.77 289.07,270.38 294.76,270.96 300.44,271.50 306.13,272.02 311.82,272.51 317.51,272.97 323.20,273.41 328.89,273.82 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='288.88' x2='328.89' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='288.88' x2='50.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='288.88' x2='96.58' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='288.88' x2='143.04' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='288.88' x2='189.50' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='288.88' x2='235.97' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='288.88' x2='282.43' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='288.88' x2='328.89' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='281.96' x2='38.97' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='281.96' x2='34.21' y2='281.96' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='250.60' x2='34.21' y2='250.60' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='219.24' x2='34.21' y2='219.24' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='187.88' x2='34.21' y2='187.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='156.51' x2='34.21' y2='156.51' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='125.15' x2='34.21' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,284.16) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,254.99) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,223.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,192.27) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,160.90) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,131.74) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<polygon points='38.97,288.88 340.04,288.88 340.04,102.24 38.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5'>
+ <rect x='0.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text x='180.87' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text transform='translate(8.55,206.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='22.41px' lengthAdjust='spacingAndGlyphs'>parent</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<circle cx='50.12' cy='117.47' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='130.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='129.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='142.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='156.51' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='131.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='160.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='166.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='174.55' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='183.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='203.87' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='200.58' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.16' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.00' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='246.99' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='247.46' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='253.27' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='254.68' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,127.49 52.44,133.45 55.81,141.26 57.09,144.00 61.50,152.59 66.38,160.76 67.19,161.99 72.87,169.87 78.56,176.56 82.64,180.74 84.25,182.28 89.94,187.25 95.63,191.61 101.32,195.48 107.01,198.95 112.70,202.11 115.16,203.39 118.39,204.99 124.08,207.67 129.77,210.15 135.46,212.49 141.15,214.69 146.83,216.78 152.52,218.77 158.21,220.68 163.90,222.50 169.59,224.26 175.28,225.95 180.97,227.58 186.66,229.15 189.50,229.92 192.35,230.67 198.04,232.15 203.73,233.58 209.42,234.96 215.11,236.30 220.79,237.61 226.48,238.87 232.17,240.10 237.86,241.29 243.55,242.44 249.24,243.57 254.93,244.66 259.20,245.46 260.62,245.72 266.31,246.75 272.00,247.75 277.69,248.72 283.38,249.66 289.07,250.58 294.76,251.47 300.44,252.33 306.13,253.17 311.82,253.99 317.51,254.78 323.20,255.55 328.89,256.30 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,120.34 52.52,124.50 47.72,124.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.01 52.52,127.16 47.72,127.16 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,130.38 54.84,134.53 50.04,134.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,128.65 54.84,132.81 50.04,132.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.43 59.49,141.59 54.69,141.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.51 59.49,145.67 54.69,145.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,141.67 68.78,145.82 63.98,145.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.23 68.78,155.39 63.98,155.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,169.27 85.04,173.42 80.24,173.42 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,161.43 85.04,165.58 80.24,165.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,202.51 117.56,206.67 112.76,206.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,205.49 117.56,209.65 112.76,209.65 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,232.46 191.90,236.62 187.10,236.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.23 191.90,232.39 187.10,232.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.42 261.60,242.58 256.80,242.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.46 261.60,244.62 256.80,244.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,248.46 331.29,252.61 326.49,252.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.44 331.29,255.59 326.49,255.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.15 52.44,130.34 55.81,136.14 57.09,138.27 61.50,145.30 66.38,152.53 67.19,153.67 72.87,161.35 78.56,168.38 82.64,173.05 84.25,174.82 89.94,180.73 95.63,186.15 101.32,191.13 107.01,195.70 112.70,199.90 115.16,201.61 118.39,203.76 124.08,207.32 129.77,210.59 135.46,213.61 141.15,216.39 146.83,218.96 152.52,221.33 158.21,223.53 163.90,225.56 169.59,227.44 175.28,229.19 180.97,230.81 186.66,232.32 189.50,233.04 192.35,233.73 198.04,235.04 203.73,236.27 209.42,237.41 215.11,238.49 220.79,239.49 226.48,240.44 232.17,241.33 237.86,242.17 243.55,242.96 249.24,243.71 254.93,244.42 259.20,244.93 260.62,245.09 266.31,245.73 272.00,246.34 277.69,246.92 283.38,247.48 289.07,248.01 294.76,248.52 300.44,249.01 306.13,249.48 311.82,249.93 317.51,250.37 323.20,250.79 328.89,251.20 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='141.15' x2='52.64' y2='141.15' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='143.67' x2='50.12' y2='138.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='127.97' x2='52.64' y2='127.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='130.49' x2='50.12' y2='125.45' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='126.25' x2='54.96' y2='126.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='128.77' x2='52.44' y2='123.73' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='129.86' x2='59.61' y2='129.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='132.38' x2='57.09' y2='127.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.68' x2='59.61' y2='140.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.20' x2='57.09' y2='138.16' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='150.55' x2='68.90' y2='150.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='153.07' x2='66.38' y2='148.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='152.12' x2='68.90' y2='152.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='154.64' x2='66.38' y2='149.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='164.04' x2='85.16' y2='164.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.56' x2='82.64' y2='161.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='175.49' x2='85.16' y2='175.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='178.01' x2='82.64' y2='172.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='193.84' x2='117.68' y2='193.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='196.36' x2='115.16' y2='191.31' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='196.81' x2='117.68' y2='196.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='199.33' x2='115.16' y2='194.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='234.29' x2='192.02' y2='234.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='236.81' x2='189.50' y2='231.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='237.43' x2='192.02' y2='237.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='239.95' x2='189.50' y2='234.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='267.54' x2='331.41' y2='267.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.06' x2='328.89' y2='265.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='263.77' x2='331.41' y2='263.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='266.29' x2='328.89' y2='261.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,128.11 52.44,131.60 55.81,136.47 57.09,138.26 61.50,144.23 66.38,150.46 67.19,151.45 72.87,158.18 78.56,164.47 82.64,168.72 84.25,170.35 89.94,175.85 95.63,181.02 101.32,185.87 107.01,190.44 112.70,194.73 115.16,196.52 118.39,198.79 124.08,202.61 129.77,206.23 135.46,209.65 141.15,212.89 146.83,215.97 152.52,218.88 158.21,221.65 163.90,224.28 169.59,226.78 175.28,229.16 180.97,231.42 186.66,233.58 189.50,234.62 192.35,235.64 198.04,237.60 203.73,239.47 209.42,241.26 215.11,242.97 220.79,244.60 226.48,246.16 232.17,247.65 237.86,249.07 243.55,250.44 249.24,251.74 254.93,252.99 259.20,253.89 260.62,254.18 266.31,255.32 272.00,256.42 277.69,257.47 283.38,258.47 289.07,259.43 294.76,260.36 300.44,261.24 306.13,262.09 311.82,262.90 317.51,263.67 323.20,264.42 328.89,265.13 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='124.58' x2='51.90' y2='121.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='121.02' x2='51.90' y2='124.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.17' x2='51.90' y2='119.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='119.61' x2='51.90' y2='123.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='121.92' x2='54.22' y2='118.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='118.35' x2='54.22' y2='121.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.14' x2='54.22' y2='138.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='138.58' x2='54.22' y2='142.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.71' x2='58.87' y2='140.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.15' x2='58.87' y2='143.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.87' x2='58.87' y2='140.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.30' x2='58.87' y2='143.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.57' x2='68.16' y2='145.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.01' x2='68.16' y2='148.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='164.10' x2='68.16' y2='160.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.53' x2='68.16' y2='164.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='176.49' x2='84.42' y2='172.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='172.92' x2='84.42' y2='176.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='167.55' x2='84.42' y2='163.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='163.98' x2='84.42' y2='167.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.83' x2='116.95' y2='199.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.27' x2='116.95' y2='202.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.18' x2='116.95' y2='201.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.62' x2='116.95' y2='205.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.31' x2='191.29' y2='236.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.74' x2='191.29' y2='240.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.15' x2='191.29' y2='236.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.59' x2='191.29' y2='240.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.50' x2='260.98' y2='254.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='254.93' x2='260.98' y2='258.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.97' x2='260.98' y2='255.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.41' x2='260.98' y2='258.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='269.32' x2='330.67' y2='265.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='265.75' x2='330.67' y2='269.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.57' x2='330.67' y2='267.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.01' x2='330.67' y2='270.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,124.04 52.44,130.41 55.81,137.81 57.09,140.22 61.50,147.40 66.38,154.02 67.19,155.03 72.87,161.66 78.56,167.71 82.64,171.79 84.25,173.36 89.94,178.68 95.63,183.72 101.32,188.51 107.01,193.06 112.70,197.39 115.16,199.20 118.39,201.51 124.08,205.42 129.77,209.15 135.46,212.70 141.15,216.07 146.83,219.28 152.52,222.33 158.21,225.23 163.90,227.99 169.59,230.62 175.28,233.12 180.97,235.50 186.66,237.76 189.50,238.85 192.35,239.91 198.04,241.96 203.73,243.91 209.42,245.76 215.11,247.52 220.79,249.20 226.48,250.79 232.17,252.31 237.86,253.75 243.55,255.13 249.24,256.43 254.93,257.68 259.20,258.57 260.62,258.86 266.31,259.98 272.00,261.05 277.69,262.07 283.38,263.04 289.07,263.96 294.76,264.84 300.44,265.67 306.13,266.46 311.82,267.22 317.51,267.94 323.20,268.62 328.89,269.27 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.86 50.12,111.34 52.64,113.86 50.12,116.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.39 50.12,110.87 52.64,113.39 50.12,115.91 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,133.31 52.44,130.79 54.96,133.31 52.44,135.83 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,145.85 52.44,143.33 54.96,145.85 52.44,148.37 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.91 57.09,142.39 59.61,144.91 57.09,147.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.44 57.09,141.92 59.61,144.44 57.09,146.96 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.67 66.38,162.15 68.90,164.67 66.38,167.19 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,168.75 66.38,166.22 68.90,168.75 66.38,171.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,193.21 82.64,190.69 85.16,193.21 82.64,195.73 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,190.86 82.64,188.34 85.16,190.86 82.64,193.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,207.95 115.16,205.43 117.68,207.95 115.16,210.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,206.69 115.16,204.17 117.68,206.69 115.16,209.21 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,239.00 189.50,236.48 192.02,239.00 189.50,241.52 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,234.29 189.50,231.77 192.02,234.29 189.50,236.81 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,251.70 259.20,249.18 261.72,251.70 259.20,254.22 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,250.60 259.20,248.08 261.72,250.60 259.20,253.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,260.48 328.89,257.96 331.41,260.48 328.89,263.00 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,261.26 328.89,258.74 331.41,261.26 328.89,263.78 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,120.32 52.44,130.34 55.81,142.53 57.09,146.56 61.50,158.35 66.38,168.45 67.19,169.89 72.87,178.54 78.56,185.26 82.64,189.22 84.25,190.64 89.94,195.12 95.63,198.97 101.32,202.36 107.01,205.43 112.70,208.25 115.16,209.41 118.39,210.88 124.08,213.37 129.77,215.73 135.46,217.98 141.15,220.14 146.83,222.22 152.52,224.22 158.21,226.15 163.90,228.01 169.59,229.80 175.28,231.54 180.97,233.21 186.66,234.83 189.50,235.62 192.35,236.40 198.04,237.91 203.73,239.38 209.42,240.79 215.11,242.16 220.79,243.48 226.48,244.76 232.17,245.99 237.86,247.19 243.55,248.34 249.24,249.46 254.93,250.54 259.20,251.32 260.62,251.58 266.31,252.59 272.00,253.57 277.69,254.51 283.38,255.42 289.07,256.30 294.76,257.15 300.44,257.98 306.13,258.77 311.82,259.54 317.51,260.29 323.20,261.01 328.89,261.70 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.69 52.52,119.53 47.72,119.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.06 52.52,118.90 47.72,118.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,138.12 54.84,133.96 50.04,133.96 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,143.45 54.84,139.29 50.04,139.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.80 59.49,133.64 54.69,133.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.39 59.49,140.23 54.69,140.23 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.29 68.78,147.13 63.98,147.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,150.66 68.78,146.50 63.98,146.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.14 85.04,167.99 80.24,167.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.88 85.04,182.73 80.24,182.73 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,191.27 117.56,187.12 112.76,187.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.29 117.56,200.13 112.76,200.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.75 191.90,224.60 187.10,224.60 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,230.79 191.90,226.63 187.10,226.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.36 261.60,236.20 256.80,236.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,241.30 261.60,237.14 256.80,237.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,250.08 331.29,245.92 326.49,245.92 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,253.37 331.29,249.22 326.49,249.22 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.84 52.44,130.32 55.81,136.42 57.09,138.63 61.50,145.80 66.38,153.01 67.19,154.13 72.87,161.54 78.56,168.17 82.64,172.48 84.25,174.10 89.94,179.42 95.63,184.23 101.32,188.57 107.01,192.51 112.70,196.09 115.16,197.55 118.39,199.37 124.08,202.38 129.77,205.15 135.46,207.71 141.15,210.08 146.83,212.29 152.52,214.36 158.21,216.30 163.90,218.12 169.59,219.84 175.28,221.48 180.97,223.02 186.66,224.50 189.50,225.21 192.35,225.91 198.04,227.26 203.73,228.55 209.42,229.79 215.11,230.99 220.79,232.15 226.48,233.26 232.17,234.34 237.86,235.39 243.55,236.41 249.24,237.39 254.93,238.35 259.20,239.05 260.62,239.28 266.31,240.19 272.00,241.07 277.69,241.93 283.38,242.78 289.07,243.60 294.76,244.40 300.44,245.18 306.13,245.94 311.82,246.69 317.51,247.42 323.20,248.13 328.89,248.83 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='130.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='133.83' x2='51.90' y2='130.27' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.27' x2='51.90' y2='133.83' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='115.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='118.78' x2='51.90' y2='115.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.22' x2='51.90' y2='118.78' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='127.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='130.70' x2='54.22' y2='127.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.13' x2='54.22' y2='130.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='137.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='140.89' x2='54.22' y2='137.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='137.33' x2='54.22' y2='140.89' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='159.59' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='163.16' x2='58.87' y2='159.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='159.59' x2='58.87' y2='163.16' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='142.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='146.53' x2='58.87' y2='142.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='142.97' x2='58.87' y2='146.53' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='173.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='177.43' x2='68.16' y2='173.86' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.86' x2='68.16' y2='177.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='154.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='157.98' x2='68.16' y2='154.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.42' x2='68.16' y2='157.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='190.44' x2='84.42' y2='186.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='186.88' x2='84.42' y2='190.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='191.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='195.15' x2='84.42' y2='191.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='191.58' x2='84.42' y2='195.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='225.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='229.49' x2='116.95' y2='225.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.92' x2='116.95' y2='229.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='224.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='227.76' x2='116.95' y2='224.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.20' x2='116.95' y2='227.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='258.97' x2='191.29' y2='255.41' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.41' x2='191.29' y2='258.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='259.44' x2='191.29' y2='255.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.88' x2='191.29' y2='259.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='264.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='267.59' x2='260.98' y2='264.03' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='264.03' x2='260.98' y2='267.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='265.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='268.85' x2='260.98' y2='265.28' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='265.28' x2='260.98' y2='268.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='270.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='274.18' x2='330.67' y2='270.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.62' x2='330.67' y2='274.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='267.95' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='271.51' x2='330.67' y2='267.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.95' x2='330.67' y2='271.51' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,127.55 52.44,134.22 55.81,143.24 57.09,146.48 61.50,156.92 66.38,167.27 67.19,168.87 72.87,179.33 78.56,188.50 82.64,194.39 84.25,196.57 89.94,203.67 95.63,209.94 101.32,215.50 107.01,220.43 112.70,224.83 115.16,226.58 118.39,228.75 124.08,232.27 129.77,235.43 135.46,238.29 141.15,240.87 146.83,243.21 152.52,245.35 158.21,247.31 163.90,249.10 169.59,250.75 175.28,252.28 180.97,253.69 186.66,255.00 189.50,255.63 192.35,256.23 198.04,257.37 203.73,258.44 209.42,259.45 215.11,260.40 220.79,261.29 226.48,262.13 232.17,262.93 237.86,263.69 243.55,264.41 249.24,265.10 254.93,265.75 259.20,266.22 260.62,266.38 266.31,266.97 272.00,267.54 277.69,268.09 283.38,268.61 289.07,269.11 294.76,269.59 300.44,270.04 306.13,270.49 311.82,270.91 317.51,271.32 323.20,271.71 328.89,272.08 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='131.48' x2='51.90' y2='127.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.92' x2='51.90' y2='131.48' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='129.70' x2='52.64' y2='129.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='132.22' x2='50.12' y2='127.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.17' x2='51.90' y2='111.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='111.61' x2='51.90' y2='115.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='113.39' x2='52.64' y2='113.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='115.91' x2='50.12' y2='110.87' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='129.76' x2='54.22' y2='126.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.19' x2='54.22' y2='129.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.97' x2='54.96' y2='127.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='130.49' x2='52.44' y2='125.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='145.59' x2='54.22' y2='142.03' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.03' x2='54.22' y2='145.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='143.81' x2='54.96' y2='143.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='146.33' x2='52.44' y2='141.29' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='149.36' x2='58.87' y2='145.79' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='145.79' x2='58.87' y2='149.36' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='147.58' x2='59.61' y2='147.58' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='150.10' x2='57.09' y2='145.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='165.51' x2='58.87' y2='161.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='161.95' x2='58.87' y2='165.51' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='163.73' x2='59.61' y2='163.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='166.25' x2='57.09' y2='161.21' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.98' x2='68.16' y2='170.41' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='170.41' x2='68.16' y2='173.98' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='172.19' x2='68.90' y2='172.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='174.72' x2='66.38' y2='169.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='179.15' x2='68.16' y2='175.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='175.59' x2='68.16' y2='179.15' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='177.37' x2='68.90' y2='177.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='179.89' x2='66.38' y2='174.85' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='209.73' x2='84.42' y2='206.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='206.17' x2='84.42' y2='209.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='207.95' x2='85.16' y2='207.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='210.47' x2='82.64' y2='205.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='204.24' x2='84.42' y2='200.68' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='200.68' x2='84.42' y2='204.24' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='202.46' x2='85.16' y2='202.46' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='204.98' x2='82.64' y2='199.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='228.39' x2='116.95' y2='224.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.83' x2='116.95' y2='228.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='226.61' x2='117.68' y2='226.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='229.13' x2='115.16' y2='224.09' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.72' x2='116.95' y2='222.16' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='222.16' x2='116.95' y2='225.72' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='223.94' x2='117.68' y2='223.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='226.46' x2='115.16' y2='221.42' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='247.05' x2='191.29' y2='243.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='243.49' x2='191.29' y2='247.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='245.27' x2='192.02' y2='245.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='247.79' x2='189.50' y2='242.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='246.11' x2='191.29' y2='242.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.55' x2='191.29' y2='246.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.33' x2='192.02' y2='244.33' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.85' x2='189.50' y2='241.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.52' x2='260.98' y2='251.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='251.96' x2='260.98' y2='255.52' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.83' x2='260.98' y2='252.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='252.27' x2='260.98' y2='255.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='254.05' x2='261.72' y2='254.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.57' x2='259.20' y2='251.53' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='263.67' x2='330.67' y2='260.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.11' x2='330.67' y2='263.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='261.89' x2='331.41' y2='261.89' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.41' x2='328.89' y2='259.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.73' x2='330.67' y2='259.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.17' x2='330.67' y2='262.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='260.95' x2='331.41' y2='260.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.47' x2='328.89' y2='258.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,124.69 52.44,134.63 55.81,147.35 57.09,151.71 61.50,165.04 66.38,177.16 67.19,178.93 72.87,189.90 78.56,198.61 82.64,203.76 84.25,205.59 89.94,211.23 95.63,215.85 101.32,219.67 107.01,222.87 112.70,225.59 115.16,226.65 118.39,227.94 124.08,230.00 129.77,231.82 135.46,233.47 141.15,234.96 146.83,236.34 152.52,237.63 158.21,238.84 163.90,239.98 169.59,241.06 175.28,242.10 180.97,243.10 186.66,244.06 189.50,244.52 192.35,244.99 198.04,245.88 203.73,246.76 209.42,247.60 215.11,248.43 220.79,249.23 226.48,250.01 232.17,250.77 237.86,251.51 243.55,252.23 249.24,252.94 254.93,253.63 259.20,254.13 260.62,254.30 266.31,254.95 272.00,255.59 277.69,256.22 283.38,256.82 289.07,257.42 294.76,258.00 300.44,258.57 306.13,259.12 311.82,259.66 317.51,260.19 323.20,260.70 328.89,261.21 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='109.16' x2='52.64' y2='109.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='111.68' x2='50.12' y2='106.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,109.16 50.12,106.64 52.64,109.16 50.12,111.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='139.11' x2='52.64' y2='139.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='141.63' x2='50.12' y2='136.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,139.11 50.12,136.59 52.64,139.11 50.12,141.63 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,127.19 52.44,124.67 54.96,127.19 52.44,129.71 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='118.25' x2='54.96' y2='118.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='120.77' x2='52.44' y2='115.73' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,118.25 52.44,115.73 54.96,118.25 52.44,120.77 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='149.61' x2='59.61' y2='149.61' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='152.13' x2='57.09' y2='147.09' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,149.61 57.09,147.09 59.61,149.61 57.09,152.13 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.52' x2='59.61' y2='140.52' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.04' x2='57.09' y2='138.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,140.52 57.09,138.00 59.61,140.52 57.09,143.04 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='158.55' x2='68.90' y2='158.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.07' x2='66.38' y2='156.03' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,158.55 66.38,156.03 68.90,158.55 66.38,161.07 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='164.98' x2='68.90' y2='164.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='167.50' x2='66.38' y2='162.46' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.98 66.38,162.46 68.90,164.98 66.38,167.50 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='192.27' x2='85.16' y2='192.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='194.79' x2='82.64' y2='189.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,192.27 82.64,189.75 85.16,192.27 82.64,194.79 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='183.80' x2='85.16' y2='183.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='186.32' x2='82.64' y2='181.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,183.80 82.64,181.28 85.16,183.80 82.64,186.32 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='215.32' x2='117.68' y2='215.32' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='217.84' x2='115.16' y2='212.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,215.32 115.16,212.80 117.68,215.32 115.16,217.84 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='211.08' x2='117.68' y2='211.08' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='213.60' x2='115.16' y2='208.56' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,211.08 115.16,208.56 117.68,211.08 115.16,213.60 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.17' x2='192.02' y2='244.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.69' x2='189.50' y2='241.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,244.17 189.50,241.65 192.02,244.17 189.50,246.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='242.76' x2='192.02' y2='242.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='245.28' x2='189.50' y2='240.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,242.76 189.50,240.24 192.02,242.76 189.50,245.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,253.74 259.20,251.22 261.72,253.74 259.20,256.26 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='258.28' x2='261.72' y2='258.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='260.80' x2='259.20' y2='255.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,258.28 259.20,255.76 261.72,258.28 259.20,260.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='268.16' x2='331.41' y2='268.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.68' x2='328.89' y2='265.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,268.16 328.89,265.64 331.41,268.16 328.89,270.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='262.36' x2='331.41' y2='262.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.88' x2='328.89' y2='259.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,262.36 328.89,259.84 331.41,262.36 328.89,264.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,121.15 52.44,128.54 55.81,138.26 57.09,141.67 61.50,152.36 66.38,162.53 67.19,164.07 72.87,173.86 78.56,182.13 82.64,187.28 84.25,189.16 89.94,195.22 95.63,200.47 101.32,205.08 107.01,209.16 112.70,212.82 115.16,214.28 118.39,216.11 124.08,219.11 129.77,221.87 135.46,224.41 141.15,226.78 146.83,228.99 152.52,231.07 158.21,233.04 163.90,234.90 169.59,236.66 175.28,238.35 180.97,239.95 186.66,241.49 189.50,242.24 192.35,242.96 198.04,244.37 203.73,245.73 209.42,247.03 215.11,248.28 220.79,249.49 226.48,250.65 232.17,251.76 237.86,252.84 243.55,253.87 249.24,254.87 254.93,255.83 259.20,256.53 260.62,256.76 266.31,257.65 272.00,258.52 277.69,259.35 283.38,260.15 289.07,260.92 294.76,261.67 300.44,262.38 306.13,263.08 311.82,263.75 317.51,264.39 323.20,265.01 328.89,265.61 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='122.80' x2='51.90' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.58' x2='50.12' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='123.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.09' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.09' x2='54.22' y2='126.09' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='127.87' x2='52.44' y2='124.31' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='122.80' x2='54.22' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='124.58' x2='52.44' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='136.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.28' x2='58.87' y2='136.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='138.07' x2='57.09' y2='134.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='139.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.11' x2='58.87' y2='139.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='140.89' x2='57.09' y2='137.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='159.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='159.81' x2='68.16' y2='159.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.59' x2='66.38' y2='158.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='147.58' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='147.58' x2='68.16' y2='147.58' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='149.36' x2='66.38' y2='145.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.14' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.14' x2='84.42' y2='165.14' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.92' x2='82.64' y2='163.36' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.61' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.61' x2='84.42' y2='165.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='167.39' x2='82.64' y2='163.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='202.62' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.62' x2='116.95' y2='202.62' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='204.40' x2='115.16' y2='200.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='191.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='191.17' x2='116.95' y2='191.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='192.95' x2='115.16' y2='189.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.39' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.39' x2='191.29' y2='235.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.17' x2='189.50' y2='233.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.23' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.23' x2='191.29' y2='235.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.02' x2='189.50' y2='233.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='245.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='245.27' x2='260.98' y2='245.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='247.05' x2='259.20' y2='243.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='249.66' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.66' x2='260.98' y2='249.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='251.44' x2='259.20' y2='247.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.73' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.73' x2='330.67' y2='261.73' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.52' x2='328.89' y2='259.95' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='259.38' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.38' x2='330.67' y2='259.38' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='261.16' x2='328.89' y2='257.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,122.68 52.44,127.10 55.81,133.15 57.09,135.36 61.50,142.54 66.38,149.84 67.19,150.99 72.87,158.61 78.56,165.51 82.64,170.07 84.25,171.79 89.94,177.51 95.63,182.75 101.32,187.56 107.01,191.99 112.70,196.09 115.16,197.77 118.39,199.90 124.08,203.44 129.77,206.74 135.46,209.84 141.15,212.74 146.83,215.48 152.52,218.06 158.21,220.49 163.90,222.81 169.59,225.00 175.28,227.09 180.97,229.08 186.66,230.97 189.50,231.89 192.35,232.79 198.04,234.52 203.73,236.18 209.42,237.77 215.11,239.30 220.79,240.77 226.48,242.17 232.17,243.53 237.86,244.83 243.55,246.09 249.24,247.30 254.93,248.47 259.20,249.31 260.62,249.59 266.31,250.67 272.00,251.72 277.69,252.73 283.38,253.70 289.07,254.64 294.76,255.55 300.44,256.42 306.13,257.27 311.82,258.09 317.51,258.88 323.20,259.64 328.89,260.38 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,131.06 52.52,126.21 47.72,126.21 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,125.52 52.52,130.37 47.72,130.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,129.65 52.52,124.80 47.72,124.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,124.10 52.52,128.95 47.72,128.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,135.45 54.84,130.60 50.04,130.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,129.91 54.84,134.76 50.04,134.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,117.57 54.84,112.72 50.04,112.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,112.03 54.84,116.88 50.04,116.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,140.47 59.49,135.62 54.69,135.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,134.92 59.49,139.77 54.69,139.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.54 59.49,139.69 54.69,139.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,139.00 59.49,143.85 54.69,143.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,142.66 68.78,137.81 63.98,137.81 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,137.12 68.78,141.97 63.98,141.97 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,157.87 68.78,153.02 63.98,153.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,152.33 68.78,157.18 63.98,157.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,168.54 85.04,163.69 80.24,163.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,162.99 85.04,167.84 80.24,167.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.77 85.04,167.92 80.24,167.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,167.23 85.04,172.08 80.24,172.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,188.30 117.56,183.45 112.76,183.45 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,182.75 117.56,187.60 112.76,187.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,183.59 117.56,178.74 112.76,178.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,178.05 117.56,182.90 112.76,182.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,224.21 191.90,219.36 187.10,219.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,218.66 191.90,223.51 187.10,223.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,225.77 191.90,220.92 187.10,220.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,220.23 191.90,225.08 187.10,225.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,244.12 261.60,239.27 256.80,239.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.58 261.60,243.43 256.80,243.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,237.69 261.60,232.84 256.80,232.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,232.15 261.60,237.00 256.80,237.00 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,252.12 331.29,247.27 326.49,247.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.58 331.29,251.42 326.49,251.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.96 331.29,247.11 326.49,247.11 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.42 331.29,251.27 326.49,251.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.82 52.44,129.38 55.81,134.26 57.09,136.04 61.50,141.86 66.38,147.80 67.19,148.73 72.87,154.97 78.56,160.66 82.64,164.44 84.25,165.88 89.94,170.67 95.63,175.09 101.32,179.19 107.01,183.00 112.70,186.56 115.16,188.03 118.39,189.89 124.08,193.02 129.77,195.98 135.46,198.77 141.15,201.42 146.83,203.94 152.52,206.34 158.21,208.63 163.90,210.83 169.59,212.93 175.28,214.95 180.97,216.89 186.66,218.75 189.50,219.66 192.35,220.56 198.04,222.29 203.73,223.97 209.42,225.59 215.11,227.16 220.79,228.68 226.48,230.16 232.17,231.58 237.86,232.97 243.55,234.31 249.24,235.61 254.93,236.87 259.20,237.80 260.62,238.10 266.31,239.29 272.00,240.45 277.69,241.58 283.38,242.67 289.07,243.73 294.76,244.77 300.44,245.77 306.13,246.75 311.82,247.70 317.51,248.62 323.20,249.52 328.89,250.40 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='137.70' x2='51.90' y2='137.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='139.48' x2='50.12' y2='135.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='135.91' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='121.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.50' x2='54.22' y2='127.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.29' x2='52.44' y2='125.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='125.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='132.99' x2='54.22' y2='132.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='134.77' x2='52.44' y2='131.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='131.21' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='120.76' x2='58.87' y2='120.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='122.54' x2='57.09' y2='118.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='118.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.89' x2='58.87' y2='139.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='141.67' x2='57.09' y2='138.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='138.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.28' x2='68.16' y2='160.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='162.06' x2='66.38' y2='158.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='158.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.54' x2='68.16' y2='145.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='147.32' x2='66.38' y2='143.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='143.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='174.23' x2='84.42' y2='174.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='176.02' x2='82.64' y2='172.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='172.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.57' x2='84.42' y2='171.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='173.35' x2='82.64' y2='169.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='169.79' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.52' x2='116.95' y2='201.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='203.30' x2='115.16' y2='199.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='199.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.64' x2='116.95' y2='199.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='201.42' x2='115.16' y2='197.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='197.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.17' x2='191.29' y2='236.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.96' x2='189.50' y2='234.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.49' x2='191.29' y2='236.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='238.27' x2='189.50' y2='234.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.74' x2='260.98' y2='253.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.52' x2='259.20' y2='251.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='251.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.19' x2='260.98' y2='249.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='250.97' x2='259.20' y2='247.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='247.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.32' x2='330.67' y2='260.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='262.11' x2='328.89' y2='258.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='258.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.26' x2='330.67' y2='261.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.05' x2='328.89' y2='259.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='259.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.12 52.44,130.07 55.81,135.58 57.09,137.60 61.50,144.32 66.38,151.29 67.19,152.40 72.87,159.88 78.56,166.79 82.64,171.44 84.25,173.20 89.94,179.14 95.63,184.65 101.32,189.76 107.01,194.50 112.70,198.91 115.16,200.73 118.39,203.02 124.08,206.84 129.77,210.40 135.46,213.71 141.15,216.81 146.83,219.71 152.52,222.41 158.21,224.94 163.90,227.32 169.59,229.54 175.28,231.63 180.97,233.60 186.66,235.44 189.50,236.33 192.35,237.18 198.04,238.82 203.73,240.37 209.42,241.84 215.11,243.22 220.79,244.53 226.48,245.78 232.17,246.96 237.86,248.08 243.55,249.14 249.24,250.16 254.93,251.13 259.20,251.82 260.62,252.05 266.31,252.93 272.00,253.77 277.69,254.58 283.38,255.36 289.07,256.10 294.76,256.81 300.44,257.49 306.13,258.15 311.82,258.78 317.51,259.39 323.20,259.98 328.89,260.54 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='125.31' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.09' x2='51.90' y2='123.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.53' x2='51.90' y2='127.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='128.60' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.38' x2='51.90' y2='126.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='126.82' x2='51.90' y2='130.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.88' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='128.66' x2='54.22' y2='125.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='125.09' x2='54.22' y2='128.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='115.74' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='117.52' x2='54.22' y2='113.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='113.96' x2='54.22' y2='117.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='138.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.42' x2='58.87' y2='136.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.86' x2='58.87' y2='140.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='126.41' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='128.19' x2='58.87' y2='124.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='124.62' x2='58.87' y2='128.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='152.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.69' x2='68.16' y2='151.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.13' x2='68.16' y2='154.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='150.08' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.87' x2='68.16' y2='148.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.30' x2='68.16' y2='151.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='173.61' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='175.39' x2='84.42' y2='171.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.82' x2='84.42' y2='175.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='180.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='181.97' x2='84.42' y2='178.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='178.41' x2='84.42' y2='181.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='205.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='207.53' x2='116.95' y2='203.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='203.97' x2='116.95' y2='207.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='204.03' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.81' x2='116.95' y2='202.25' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.25' x2='116.95' y2='205.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='243.86' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='245.64' x2='191.29' y2='242.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.08' x2='191.29' y2='245.64' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='239.94' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='241.72' x2='191.29' y2='238.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='238.16' x2='191.29' y2='241.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='258.44' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='260.22' x2='260.98' y2='256.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='256.66' x2='260.98' y2='260.22' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='252.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.95' x2='260.98' y2='250.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='250.39' x2='260.98' y2='253.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='262.52' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='264.30' x2='330.67' y2='260.74' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.74' x2='330.67' y2='264.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.11' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.89' x2='330.67' y2='259.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.33' x2='330.67' y2='262.89' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,121.51 52.44,126.19 55.81,132.69 57.09,135.07 61.50,142.93 66.38,151.04 67.19,152.32 72.87,160.93 78.56,168.83 82.64,174.08 84.25,176.07 89.94,182.73 95.63,188.84 101.32,194.45 107.01,199.61 112.70,204.36 115.16,206.29 118.39,208.72 124.08,212.75 129.77,216.45 135.46,219.87 141.15,223.02 146.83,225.93 152.52,228.63 158.21,231.11 163.90,233.42 169.59,235.55 175.28,237.53 180.97,239.37 186.66,241.08 189.50,241.89 192.35,242.67 198.04,244.15 203.73,245.53 209.42,246.82 215.11,248.02 220.79,249.15 226.48,250.21 232.17,251.20 237.86,252.13 243.55,253.01 249.24,253.84 254.93,254.62 259.20,255.17 260.62,255.35 266.31,256.05 272.00,256.71 277.69,257.34 283.38,257.94 289.07,258.51 294.76,259.05 300.44,259.57 306.13,260.06 311.82,260.53 317.51,260.99 323.20,261.42 328.89,261.84 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,116.00 51.90,119.56 48.34,119.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='116.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,122.43 51.90,125.99 48.34,125.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='122.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,126.35 54.22,129.91 50.66,129.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='126.35' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,116.31 54.22,119.88 50.66,119.88 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='116.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.56 58.87,145.12 55.30,145.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='141.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,145.64 58.87,149.20 55.30,149.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='145.64' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,156.61 68.16,160.18 64.60,160.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='156.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,155.67 68.16,159.24 64.60,159.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='155.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.72 84.42,190.29 80.86,190.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,177.94 84.42,181.50 80.86,181.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='177.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,207.11 116.95,210.67 113.38,210.67 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='207.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.28 116.95,207.85 113.38,207.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='204.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,238.94 191.29,242.50 187.72,242.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='238.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,239.72 191.29,243.29 187.72,243.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='239.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,253.05 260.98,256.62 257.42,256.62 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='253.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,249.76 260.98,253.32 257.42,253.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='249.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,262.15 330.67,265.71 327.11,265.71 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='262.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,261.83 330.67,265.40 327.11,265.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='261.83' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,120.60 52.44,127.58 55.81,136.73 57.09,139.94 61.50,149.99 66.38,159.54 67.19,160.98 72.87,170.18 78.56,177.98 82.64,182.86 84.25,184.65 89.94,190.44 95.63,195.51 101.32,200.01 107.01,204.04 112.70,207.68 115.16,209.16 118.39,211.01 124.08,214.08 129.77,216.93 135.46,219.58 141.15,222.08 146.83,224.43 152.52,226.65 158.21,228.77 163.90,230.78 169.59,232.70 175.28,234.54 180.97,236.29 186.66,237.98 189.50,238.80 192.35,239.60 198.04,241.15 203.73,242.64 209.42,244.08 215.11,245.46 220.79,246.79 226.48,248.07 232.17,249.30 237.86,250.49 243.55,251.63 249.24,252.73 254.93,253.79 259.20,254.56 260.62,254.82 266.31,255.80 272.00,256.75 277.69,257.66 283.38,258.55 289.07,259.39 294.76,260.21 300.44,261.00 306.13,261.76 311.82,262.49 317.51,263.20 323.20,263.88 328.89,264.53 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,118.94 51.90,118.94 51.90,115.37 48.34,115.37 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,117.21 51.90,117.21 51.90,113.65 48.34,113.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,128.19 54.22,128.19 54.22,124.62 50.66,124.62 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,130.85 54.22,130.85 54.22,127.29 50.66,127.29 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,146.38 58.87,146.38 58.87,142.81 55.30,142.81 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,140.42 58.87,140.42 58.87,136.86 55.30,136.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,162.53 68.16,162.53 68.16,158.97 64.60,158.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,164.57 68.16,164.57 68.16,161.00 64.60,161.00 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,186.37 84.42,186.37 84.42,182.80 80.86,182.80 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,193.11 84.42,193.11 84.42,189.54 80.86,189.54 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,213.81 116.95,213.81 116.95,210.24 113.38,210.24 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,210.36 116.95,210.36 116.95,206.79 113.38,206.79 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,237.96 191.29,237.96 191.29,234.39 187.72,234.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,238.27 191.29,238.27 191.29,234.71 187.72,234.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,250.81 260.98,250.81 260.98,247.25 257.42,247.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,249.40 260.98,249.40 260.98,245.84 257.42,245.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,259.91 330.67,259.91 330.67,256.35 327.11,256.35 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,255.05 330.67,255.05 330.67,251.48 327.11,251.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,118.73 52.44,126.51 55.81,136.68 57.09,140.24 61.50,151.35 66.38,161.84 67.19,163.41 72.87,173.38 78.56,181.66 82.64,186.76 84.25,188.61 89.94,194.47 95.63,199.47 101.32,203.76 107.01,207.49 112.70,210.76 115.16,212.06 118.39,213.66 124.08,216.26 129.77,218.60 135.46,220.74 141.15,222.71 146.83,224.54 152.52,226.25 158.21,227.85 163.90,229.37 169.59,230.82 175.28,232.20 180.97,233.52 186.66,234.78 189.50,235.40 192.35,236.01 198.04,237.19 203.73,238.33 209.42,239.43 215.11,240.50 220.79,241.54 226.48,242.56 232.17,243.54 237.86,244.49 243.55,245.42 249.24,246.33 254.93,247.21 259.20,247.86 260.62,248.07 266.31,248.91 272.00,249.73 277.69,250.52 283.38,251.30 289.07,252.06 294.76,252.79 300.44,253.51 306.13,254.22 311.82,254.90 317.51,255.57 323.20,256.22 328.89,256.85 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='288.88' x2='677.93' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='288.88' x2='410.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='463.68' y1='288.88' x2='463.68' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='517.24' y1='288.88' x2='517.24' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='570.81' y1='288.88' x2='570.81' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='624.37' y1='288.88' x2='624.37' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='677.93' y1='288.88' x2='677.93' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='459.29' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='512.85' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='566.41' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='619.98' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='671.35' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<line x1='398.97' y1='265.50' x2='398.97' y2='125.62' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='265.50' x2='394.21' y2='265.50' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='230.53' x2='394.21' y2='230.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='195.56' x2='394.21' y2='195.56' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='160.59' x2='394.21' y2='160.59' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='125.62' x2='394.21' y2='125.62' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,269.02) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,234.05) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,197.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,162.78) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,127.81) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,288.88 700.04,288.88 700.04,102.24 398.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk='>
+ <rect x='360.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text x='532.82' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text transform='translate(368.55,233.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='195.56' x2='700.04' y2='195.56' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='673.93' cy='157.27' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='673.93' cy='208.78' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='663.76' cy='181.84' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='663.76' cy='229.76' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='645.74' cy='243.36' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='645.74' cy='147.52' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='617.12' cy='194.92' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='617.12' cy='216.49' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='582.99' cy='171.89' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='582.99' cy='205.43' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='544.32' cy='197.41' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='544.32' cy='184.83' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='499.00' cy='200.29' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='499.00' cy='199.69' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='472.47' cy='201.44' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='472.47' cy='203.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='453.94' cy='183.96' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='453.94' cy='189.35' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.23,176.56 678.63,180.72 673.83,180.72 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.23,190.82 678.63,194.98 673.83,194.98 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='669.08,207.83 671.48,211.99 666.68,211.99 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='669.08,198.61 671.48,202.76 666.68,202.76 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='655.52,203.12 657.92,207.27 653.12,207.27 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='655.52,224.93 657.92,229.08 653.12,229.08 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='631.17,149.51 633.57,153.66 628.77,153.66 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='631.17,200.67 633.57,204.83 628.77,204.83 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='596.13,187.37 598.53,191.53 593.73,191.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='596.13,145.43 598.53,149.59 593.73,149.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='547.35,212.42 549.75,216.57 544.95,216.57 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='547.35,228.35 549.75,232.51 544.95,232.51 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='493.67,204.52 496.07,208.68 491.27,208.68 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='493.67,181.88 496.07,186.03 491.27,186.03 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='473.37,172.81 475.77,176.97 470.97,176.97 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='473.37,183.72 475.77,187.87 470.97,187.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='462.65,192.92 465.05,197.08 460.25,197.08 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='462.65,208.86 465.05,213.02 460.25,213.02 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='670.35' y1='255.96' x2='675.39' y2='255.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.87' y1='258.48' x2='672.87' y2='253.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='670.35' y1='194.91' x2='675.39' y2='194.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.87' y1='197.43' x2='672.87' y2='192.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.40' y1='170.76' x2='669.44' y2='170.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='666.92' y1='173.28' x2='666.92' y2='168.24' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.40' y1='175.12' x2='669.44' y2='175.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='666.92' y1='177.64' x2='666.92' y2='172.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='653.02' y1='156.59' x2='658.06' y2='156.59' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.54' y1='159.11' x2='655.54' y2='154.07' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='653.02' y1='206.74' x2='658.06' y2='206.74' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.54' y1='209.26' x2='655.54' y2='204.22' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='632.19' y1='196.01' x2='637.23' y2='196.01' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='634.71' y1='198.53' x2='634.71' y2='193.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='632.19' y1='203.28' x2='637.23' y2='203.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='634.71' y1='205.80' x2='634.71' y2='200.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.00' y1='173.86' x2='606.04' y2='173.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='603.52' y1='176.38' x2='603.52' y2='171.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.00' y1='226.92' x2='606.04' y2='226.92' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='603.52' y1='229.44' x2='603.52' y2='224.40' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.52' y1='183.11' x2='558.56' y2='183.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.04' y1='185.63' x2='556.04' y2='180.59' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.52' y1='196.92' x2='558.56' y2='196.92' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.04' y1='199.44' x2='556.04' y2='194.40' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.45' y1='194.03' x2='493.49' y2='194.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.97' y1='196.55' x2='490.97' y2='191.51' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.45' y1='208.57' x2='493.49' y2='208.57' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.97' y1='211.09' x2='490.97' y2='206.05' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.55' y1='191.23' x2='460.59' y2='191.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='458.07' y1='193.75' x2='458.07' y2='188.71' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.55' y1='191.23' x2='460.59' y2='191.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='458.07' y1='193.75' x2='458.07' y2='188.71' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='436.34' y1='206.69' x2='441.38' y2='206.69' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='438.86' y1='209.21' x2='438.86' y2='204.17' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='436.34' y1='189.25' x2='441.38' y2='189.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='438.86' y1='191.77' x2='438.86' y2='186.73' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='678.05' y1='191.65' x2='681.62' y2='188.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='678.05' y1='188.09' x2='681.62' y2='191.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='678.05' y1='185.16' x2='681.62' y2='181.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='678.05' y1='181.60' x2='681.62' y2='185.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.18' y1='150.11' x2='670.74' y2='146.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.18' y1='146.55' x2='670.74' y2='150.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.18' y1='243.12' x2='670.74' y2='239.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.18' y1='239.56' x2='670.74' y2='243.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='650.41' y1='205.19' x2='653.97' y2='201.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='650.41' y1='201.63' x2='653.97' y2='205.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='650.41' y1='205.91' x2='653.97' y2='202.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='650.41' y1='202.35' x2='653.97' y2='205.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='626.84' y1='164.09' x2='630.41' y2='160.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='626.84' y1='160.53' x2='630.41' y2='164.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='626.84' y1='235.48' x2='630.41' y2='231.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='626.84' y1='231.91' x2='630.41' y2='235.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.49' y1='210.73' x2='600.06' y2='207.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.49' y1='207.16' x2='600.06' y2='210.73' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.49' y1='169.63' x2='600.06' y2='166.06' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.49' y1='166.06' x2='600.06' y2='169.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='549.68' y1='205.84' x2='553.25' y2='202.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='549.68' y1='202.28' x2='553.25' y2='205.84' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='549.68' y1='216.66' x2='553.25' y2='213.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='549.68' y1='213.09' x2='553.25' y2='216.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.97' y1='195.86' x2='485.53' y2='192.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.97' y1='192.30' x2='485.53' y2='195.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.97' y1='195.14' x2='485.53' y2='191.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.97' y1='191.58' x2='485.53' y2='195.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.29' y1='188.83' x2='451.85' y2='185.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.29' y1='185.26' x2='451.85' y2='188.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.29' y1='190.99' x2='451.85' y2='187.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.29' y1='187.43' x2='451.85' y2='190.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='430.02' y1='189.38' x2='433.58' y2='185.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='430.02' y1='185.81' x2='433.58' y2='189.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='430.02' y1='195.15' x2='433.58' y2='191.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='430.02' y1='191.58' x2='433.58' y2='195.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.67,165.59 686.19,163.07 688.71,165.59 686.19,168.11 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.67,163.41 686.19,160.89 688.71,163.41 686.19,165.93 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.56,209.34 669.08,206.82 671.60,209.34 669.08,211.86 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.56,267.56 669.08,265.04 671.60,267.56 669.08,270.08 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='638.85,187.91 641.37,185.39 643.89,187.91 641.37,190.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='638.85,185.72 641.37,183.20 643.89,185.72 641.37,188.24 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.46,177.99 603.98,175.47 606.50,177.99 603.98,180.51 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.46,196.91 603.98,194.39 606.50,196.91 603.98,199.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='565.98,214.04 568.50,211.52 571.02,214.04 568.50,216.56 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='565.98,203.13 568.50,200.61 571.02,203.13 568.50,205.65 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.51,188.77 534.03,186.25 536.55,188.77 534.03,191.29 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.51,182.95 534.03,180.43 536.55,182.95 534.03,185.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.74,211.21 489.26,208.69 491.78,211.21 489.26,213.73 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.74,189.38 489.26,186.86 491.78,189.38 489.26,191.90 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='459.93,197.30 462.45,194.78 464.97,197.30 462.45,199.82 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='459.93,192.21 462.45,189.69 464.97,192.21 462.45,194.73 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='442.20,189.89 444.72,187.37 447.24,189.89 444.72,192.41 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='442.20,193.52 444.72,191.00 447.24,193.52 444.72,196.04 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.75,177.21 679.15,173.06 674.35,173.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.75,174.52 679.15,170.37 674.35,170.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='669.10,219.87 671.50,215.72 666.70,215.72 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='669.10,242.73 671.50,238.58 666.70,238.58 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.91,182.89 657.31,178.74 652.51,178.74 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.91,211.13 657.31,206.97 652.51,206.97 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='630.36,179.08 632.76,174.93 627.96,174.93 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='630.36,176.39 632.76,172.24 627.96,172.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='597.10,185.00 599.50,180.84 594.70,180.84 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='597.10,248.20 599.50,244.04 594.70,244.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='554.29,159.55 556.69,155.39 551.89,155.39 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='554.29,215.35 556.69,211.20 551.89,211.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='507.04,201.63 509.44,197.47 504.64,197.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='507.04,210.37 509.44,206.21 504.64,206.21 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='483.41,192.05 485.81,187.89 481.01,187.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='483.41,196.08 485.81,191.93 481.01,191.93 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='466.71,191.81 469.11,187.65 464.31,187.65 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='466.71,205.93 469.11,201.77 464.31,201.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='672.06' y='210.06' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.06' y1='213.62' x2='675.62' y2='210.06' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.06' y1='210.06' x2='675.62' y2='213.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='672.06' y='155.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.06' y1='159.22' x2='675.62' y2='155.65' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.06' y1='155.65' x2='675.62' y2='159.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='660.67' y='174.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.67' y1='178.18' x2='664.23' y2='174.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.67' y1='174.62' x2='664.23' y2='178.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='660.67' y='211.46' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.67' y1='215.02' x2='664.23' y2='211.46' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.67' y1='211.46' x2='664.23' y2='215.02' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='639.72' y='247.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.72' y1='251.17' x2='643.29' y2='247.61' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.72' y1='247.61' x2='643.29' y2='251.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='639.72' y='187.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.72' y1='191.10' x2='643.29' y2='187.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.72' y1='187.54' x2='643.29' y2='191.10' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='604.21' y='224.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='604.21' y1='227.60' x2='607.77' y2='224.03' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='604.21' y1='224.03' x2='607.77' y2='227.60' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='604.21' y='153.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='604.21' y1='157.32' x2='607.77' y2='153.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='604.21' y1='153.76' x2='607.77' y2='157.32' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='557.91' y='173.09' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.91' y1='176.65' x2='561.47' y2='173.09' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.91' y1='173.09' x2='561.47' y2='176.65' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='557.91' y='190.09' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.91' y1='193.65' x2='561.47' y2='190.09' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.91' y1='190.09' x2='561.47' y2='193.65' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='502.92' y='197.85' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.92' y1='201.41' x2='506.49' y2='197.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.92' y1='197.85' x2='506.49' y2='201.41' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='502.92' y='191.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.92' y1='195.18' x2='506.49' y2='191.61' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.92' y1='191.61' x2='506.49' y2='195.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='453.32' y='199.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.32' y1='202.98' x2='456.88' y2='199.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.32' y1='199.42' x2='456.88' y2='202.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='453.32' y='201.12' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.32' y1='204.68' x2='456.88' y2='201.12' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.32' y1='201.12' x2='456.88' y2='204.68' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.21' y='192.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.21' y1='195.85' x2='438.78' y2='192.29' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.21' y1='192.29' x2='438.78' y2='195.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.21' y='196.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.21' y1='200.38' x2='438.78' y2='196.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.21' y1='196.82' x2='438.78' y2='200.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='425.21' y='194.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='425.21' y1='198.49' x2='428.78' y2='194.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='425.21' y1='194.92' x2='428.78' y2='198.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='425.21' y='185.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='425.21' y1='188.85' x2='428.78' y2='185.29' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='425.21' y1='185.29' x2='428.78' y2='188.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.94' y1='217.15' x2='680.50' y2='213.58' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.94' y1='213.58' x2='680.50' y2='217.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.20' y1='215.37' x2='681.24' y2='215.37' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='678.72' y1='217.89' x2='678.72' y2='212.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.94' y1='152.65' x2='680.50' y2='149.08' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.94' y1='149.08' x2='680.50' y2='152.65' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.20' y1='150.87' x2='681.24' y2='150.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='678.72' y1='153.39' x2='678.72' y2='148.35' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.97' y1='171.03' x2='663.53' y2='167.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.97' y1='167.46' x2='663.53' y2='171.03' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.23' y1='169.25' x2='664.27' y2='169.25' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.75' y1='171.77' x2='661.75' y2='166.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.97' y1='233.67' x2='663.53' y2='230.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.97' y1='230.10' x2='663.53' y2='233.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.23' y1='231.88' x2='664.27' y2='231.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.75' y1='234.40' x2='661.75' y2='229.36' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='630.78' y1='180.97' x2='634.35' y2='177.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='630.78' y1='177.41' x2='634.35' y2='180.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='630.05' y1='179.19' x2='635.09' y2='179.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='632.57' y1='181.71' x2='632.57' y2='176.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='630.78' y1='244.85' x2='634.35' y2='241.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='630.78' y1='241.29' x2='634.35' y2='244.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='630.05' y1='243.07' x2='635.09' y2='243.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='632.57' y1='245.59' x2='632.57' y2='240.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='587.32' y1='177.70' x2='590.89' y2='174.14' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='587.32' y1='174.14' x2='590.89' y2='177.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='586.59' y1='175.92' x2='591.63' y2='175.92' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='589.11' y1='178.44' x2='589.11' y2='173.40' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='587.32' y1='198.17' x2='590.89' y2='194.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='587.32' y1='194.61' x2='590.89' y2='198.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='586.59' y1='196.39' x2='591.63' y2='196.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='589.11' y1='198.91' x2='589.11' y2='193.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='541.89' y1='213.90' x2='545.46' y2='210.33' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='541.89' y1='210.33' x2='545.46' y2='213.90' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='541.15' y1='212.12' x2='546.19' y2='212.12' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.67' y1='214.64' x2='543.67' y2='209.60' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='541.89' y1='192.19' x2='545.46' y2='188.63' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='541.89' y1='188.63' x2='545.46' y2='192.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='541.15' y1='190.41' x2='546.19' y2='190.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.67' y1='192.93' x2='543.67' y2='187.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.80' y1='197.17' x2='506.36' y2='193.60' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.80' y1='193.60' x2='506.36' y2='197.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.06' y1='195.39' x2='507.10' y2='195.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='504.58' y1='197.91' x2='504.58' y2='192.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.80' y1='186.62' x2='506.36' y2='183.06' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.80' y1='183.06' x2='506.36' y2='186.62' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='502.06' y1='184.84' x2='507.10' y2='184.84' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='504.58' y1='187.36' x2='504.58' y2='182.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='472.28' y1='200.29' x2='475.84' y2='196.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='472.28' y1='196.72' x2='475.84' y2='200.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='471.54' y1='198.50' x2='476.58' y2='198.50' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.06' y1='201.02' x2='474.06' y2='195.98' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='472.28' y1='196.57' x2='475.84' y2='193.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='472.28' y1='193.00' x2='475.84' y2='196.57' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='471.54' y1='194.78' x2='476.58' y2='194.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.06' y1='197.30' x2='474.06' y2='192.26' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.87' y1='195.79' x2='459.43' y2='192.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.87' y1='192.22' x2='459.43' y2='195.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.13' y1='194.00' x2='460.17' y2='194.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.65' y1='196.52' x2='457.65' y2='191.48' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.87' y1='197.03' x2='459.43' y2='193.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.87' y1='193.46' x2='459.43' y2='197.03' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.13' y1='195.24' x2='460.17' y2='195.24' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.65' y1='197.76' x2='457.65' y2='192.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.79' y1='200.06' x2='447.35' y2='196.49' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.79' y1='196.49' x2='447.35' y2='200.06' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.05' y1='198.27' x2='448.09' y2='198.27' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='445.57' y1='200.79' x2='445.57' y2='195.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.79' y1='196.34' x2='447.35' y2='192.77' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.79' y1='192.77' x2='447.35' y2='196.34' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.05' y1='194.55' x2='448.09' y2='194.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='445.57' y1='197.07' x2='445.57' y2='192.03' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.25' y1='152.76' x2='687.29' y2='152.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.77' y1='155.28' x2='684.77' y2='150.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='682.25,152.76 684.77,150.24 687.29,152.76 684.77,155.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.25' y1='259.67' x2='687.29' y2='259.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.77' y1='262.19' x2='684.77' y2='257.15' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='682.25,259.67 684.77,257.15 687.29,259.67 684.77,262.19 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.62' y1='190.73' x2='674.66' y2='190.73' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.14' y1='193.25' x2='672.14' y2='188.21' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='669.62,190.73 672.14,188.21 674.66,190.73 672.14,193.25 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.62' y1='158.83' x2='674.66' y2='158.83' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.14' y1='161.35' x2='672.14' y2='156.31' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='669.62,158.83 672.14,156.31 674.66,158.83 672.14,161.35 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='647.20' y1='223.92' x2='652.24' y2='223.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='649.72' y1='226.44' x2='649.72' y2='221.40' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='647.20,223.92 649.72,221.40 652.24,223.92 649.72,226.44 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='647.20' y1='191.45' x2='652.24' y2='191.45' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='649.72' y1='193.97' x2='649.72' y2='188.93' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='647.20,191.45 649.72,188.93 652.24,191.45 649.72,193.97 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='611.57' y1='181.34' x2='616.61' y2='181.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='614.09' y1='183.86' x2='614.09' y2='178.82' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='611.57,181.34 614.09,178.82 616.61,181.34 614.09,183.86 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='611.57' y1='204.29' x2='616.61' y2='204.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='614.09' y1='206.81' x2='614.09' y2='201.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='611.57,204.29 614.09,201.77 616.61,204.29 614.09,206.81 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='569.31' y1='213.36' x2='574.35' y2='213.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='571.83' y1='215.88' x2='571.83' y2='210.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='569.31,213.36 571.83,210.84 574.35,213.36 571.83,215.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='569.31' y1='183.14' x2='574.35' y2='183.14' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='571.83' y1='185.66' x2='571.83' y2='180.62' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='569.31,183.14 571.83,180.62 574.35,183.14 571.83,185.66 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.19' y1='199.25' x2='528.23' y2='199.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='525.71' y1='201.77' x2='525.71' y2='196.73' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.19,199.25 525.71,196.73 528.23,199.25 525.71,201.77 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.19' y1='184.14' x2='528.23' y2='184.14' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='525.71' y1='186.66' x2='525.71' y2='181.62' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.19,184.14 525.71,181.62 528.23,184.14 525.71,186.66 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.45' y1='202.47' x2='480.49' y2='202.47' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='477.97' y1='204.99' x2='477.97' y2='199.95' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.45,202.47 477.97,199.95 480.49,202.47 477.97,204.99 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.45' y1='197.44' x2='480.49' y2='197.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='477.97' y1='199.96' x2='477.97' y2='194.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.45,197.44 477.97,194.92 480.49,197.44 477.97,199.96 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.03' y1='185.59' x2='456.07' y2='185.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.55' y1='188.11' x2='453.55' y2='183.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.03,185.59 453.55,183.07 456.07,185.59 453.55,188.11 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.03' y1='201.82' x2='456.07' y2='201.82' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.55' y1='204.34' x2='453.55' y2='199.30' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.03,201.82 453.55,199.30 456.07,201.82 453.55,204.34 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.52' y1='204.66' x2='440.56' y2='204.66' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='438.04' y1='207.18' x2='438.04' y2='202.14' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='435.52,204.66 438.04,202.14 440.56,204.66 438.04,207.18 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.52' y1='183.95' x2='440.56' y2='183.95' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='438.04' y1='186.47' x2='438.04' y2='181.43' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='435.52,183.95 438.04,181.43 440.56,183.95 438.04,186.47 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='682.15' cy='196.22' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.37' y1='196.22' x2='683.93' y2='196.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.15' y1='198.00' x2='682.15' y2='194.43' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='682.15' cy='197.95' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.37' y1='197.95' x2='683.93' y2='197.95' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.15' y1='199.74' x2='682.15' y2='196.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='674.61' cy='189.99' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.82' y1='189.99' x2='676.39' y2='189.99' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.61' y1='191.77' x2='674.61' y2='188.21' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='674.61' cy='171.76' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.82' y1='171.76' x2='676.39' y2='171.76' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.61' y1='173.55' x2='674.61' y2='169.98' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='660.50' cy='200.71' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='658.72' y1='200.71' x2='662.29' y2='200.71' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.50' y1='202.49' x2='660.50' y2='198.92' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='660.50' cy='216.33' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='658.72' y1='216.33' x2='662.29' y2='216.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.50' y1='218.11' x2='660.50' y2='214.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='635.76' cy='250.71' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='633.98' y1='250.71' x2='637.54' y2='250.71' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.76' y1='252.49' x2='635.76' y2='248.93' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='635.76' cy='183.00' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='633.98' y1='183.00' x2='637.54' y2='183.00' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.76' y1='184.78' x2='635.76' y2='181.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='601.22' cy='168.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='599.44' y1='168.27' x2='603.00' y2='168.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.22' y1='170.05' x2='601.22' y2='166.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='601.22' cy='170.87' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='599.44' y1='170.87' x2='603.00' y2='170.87' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.22' y1='172.66' x2='601.22' y2='169.09' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='553.90' cy='222.37' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='552.12' y1='222.37' x2='555.68' y2='222.37' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.90' y1='224.15' x2='553.90' y2='220.58' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='553.90' cy='159.00' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='552.12' y1='159.00' x2='555.68' y2='159.00' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.90' y1='160.78' x2='553.90' y2='157.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='495.64' cy='214.94' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.85' y1='214.94' x2='497.42' y2='214.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='495.64' y1='216.72' x2='495.64' y2='213.15' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='495.64' cy='214.07' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.85' y1='214.07' x2='497.42' y2='214.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='495.64' y1='215.85' x2='495.64' y2='212.29' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='465.88' cy='173.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.10' y1='173.18' x2='467.66' y2='173.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='465.88' y1='174.96' x2='465.88' y2='171.40' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='465.88' cy='197.49' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.10' y1='197.49' x2='467.66' y2='197.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='465.88' y1='199.27' x2='465.88' y2='195.71' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='446.98' cy='203.06' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='445.20' y1='203.06' x2='448.76' y2='203.06' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.98' y1='204.84' x2='446.98' y2='201.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='446.98' cy='190.04' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='445.20' y1='190.04' x2='448.76' y2='190.04' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.98' y1='191.82' x2='446.98' y2='188.26' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.78,208.77 679.18,203.92 674.38,203.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.78,203.23 679.18,208.08 674.38,208.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.78,202.79 679.18,197.94 674.38,197.94 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.78,197.25 679.18,202.10 674.38,202.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.71,212.32 673.11,207.47 668.31,207.47 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.71,206.78 673.11,211.63 668.31,211.63 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.71,136.56 673.11,131.71 668.31,131.71 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.71,131.02 673.11,135.87 668.31,135.87 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='659.34,205.36 661.74,200.51 656.94,200.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='659.34,199.82 661.74,204.67 656.94,204.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='659.34,222.64 661.74,217.79 656.94,217.79 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='659.34,217.10 661.74,221.95 656.94,221.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='639.25,164.82 641.65,159.97 636.85,159.97 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='639.25,159.28 641.65,164.13 636.85,164.13 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='639.25,229.29 641.65,224.44 636.85,224.44 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='639.25,223.75 641.65,228.60 636.85,228.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='610.82,203.93 613.22,199.08 608.42,199.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='610.82,198.39 613.22,203.24 608.42,203.24 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='610.82,221.87 613.22,217.02 608.42,217.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='610.82,216.33 613.22,221.18 608.42,221.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='570.55,187.72 572.95,182.87 568.15,182.87 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='570.55,182.18 572.95,187.03 568.15,187.03 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='570.55,167.78 572.95,162.93 568.15,162.93 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='570.55,162.24 572.95,167.09 568.15,167.09 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='516.52,205.84 518.92,200.99 514.12,200.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='516.52,200.29 518.92,205.14 514.12,205.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='516.52,212.48 518.92,207.63 514.12,207.63 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='516.52,206.94 518.92,211.79 514.12,211.79 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.55,213.38 487.95,208.53 483.15,208.53 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.55,207.84 487.95,212.69 483.15,212.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.55,186.13 487.95,181.29 483.15,181.29 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.55,180.59 487.95,185.44 483.15,185.44 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='464.03,193.88 466.43,189.04 461.63,189.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='464.03,188.34 466.43,193.19 461.63,193.19 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='464.03,193.22 466.43,188.37 461.63,188.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='464.03,187.68 466.43,192.53 461.63,192.53 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.50' y1='242.38' x2='678.07' y2='242.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.28' y1='244.16' x2='676.28' y2='240.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='674.50' y='240.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.50' y1='183.42' x2='678.07' y2='183.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.28' y1='185.20' x2='676.28' y2='181.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='674.50' y='181.64' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.75' y1='185.18' x2='671.31' y2='185.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.53' y1='186.97' x2='669.53' y2='183.40' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='667.75' y='183.40' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.75' y1='207.37' x2='671.31' y2='207.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.53' y1='209.16' x2='669.53' y2='205.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='667.75' y='205.59' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='654.88' y1='127.46' x2='658.45' y2='127.46' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='656.66' y1='129.24' x2='656.66' y2='125.68' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='654.88' y='125.68' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='654.88' y1='204.81' x2='658.45' y2='204.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='656.66' y1='206.59' x2='656.66' y2='203.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='654.88' y='203.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='631.50' y1='231.88' x2='635.07' y2='231.88' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='633.28' y1='233.66' x2='633.28' y2='230.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='631.50' y='230.10' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='631.50' y1='172.29' x2='635.07' y2='172.29' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='633.28' y1='174.07' x2='633.28' y2='170.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='631.50' y='170.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='597.10' y1='206.87' x2='600.67' y2='206.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='598.88' y1='208.65' x2='598.88' y2='205.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='597.10' y='205.09' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='597.10' y1='196.09' x2='600.67' y2='196.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='598.88' y1='197.87' x2='598.88' y2='194.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='597.10' y='194.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.07' y1='198.75' x2='550.64' y2='198.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='548.85' y1='200.53' x2='548.85' y2='196.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='547.07' y='196.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.07' y1='191.14' x2='550.64' y2='191.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='548.85' y1='192.93' x2='548.85' y2='189.36' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='547.07' y='189.36' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='486.28' y1='194.94' x2='489.84' y2='194.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.06' y1='196.72' x2='488.06' y2='193.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='486.28' y='193.16' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='486.28' y1='196.21' x2='489.84' y2='196.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.06' y1='197.99' x2='488.06' y2='194.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='486.28' y='194.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.81' y1='203.30' x2='463.38' y2='203.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='461.59' y1='205.08' x2='461.59' y2='201.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='459.81' y='201.52' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.81' y1='184.91' x2='463.38' y2='184.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='461.59' y1='186.70' x2='461.59' y2='183.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='459.81' y='183.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.92' y1='194.67' x2='448.48' y2='194.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.70' y1='196.45' x2='446.70' y2='192.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.92' y='192.89' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.92' y1='198.48' x2='448.48' y2='198.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.70' y1='200.26' x2='446.70' y2='196.69' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.92' y='196.69' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='684.15' cy='214.52' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.37' y1='216.30' x2='685.94' y2='212.74' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.37' y1='212.74' x2='685.94' y2='216.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='684.15' cy='230.95' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.37' y1='232.73' x2='685.94' y2='229.17' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.37' y1='229.17' x2='685.94' y2='232.73' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='676.16' cy='198.98' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.37' y1='200.76' x2='677.94' y2='197.20' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.37' y1='197.20' x2='677.94' y2='200.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='676.16' cy='143.43' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.37' y1='145.22' x2='677.94' y2='141.65' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.37' y1='141.65' x2='677.94' y2='145.22' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='660.99' cy='213.35' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.21' y1='215.14' x2='662.77' y2='211.57' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.21' y1='211.57' x2='662.77' y2='215.14' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='660.99' cy='152.33' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.21' y1='154.11' x2='662.77' y2='150.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='659.21' y1='150.55' x2='662.77' y2='154.11' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='633.72' cy='204.88' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='631.94' y1='206.66' x2='635.50' y2='203.10' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='631.94' y1='203.10' x2='635.50' y2='206.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='633.72' cy='190.80' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='631.94' y1='192.58' x2='635.50' y2='189.01' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='631.94' y1='189.01' x2='635.50' y2='192.58' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='594.36' cy='193.18' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='592.58' y1='194.96' x2='596.14' y2='191.40' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='592.58' y1='191.40' x2='596.14' y2='194.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='594.36' cy='226.04' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='592.58' y1='227.82' x2='596.14' y2='224.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='592.58' y1='224.26' x2='596.14' y2='227.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='539.35' cy='192.87' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='537.57' y1='194.65' x2='541.13' y2='191.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='537.57' y1='191.08' x2='541.13' y2='194.65' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='539.35' cy='184.26' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='537.57' y1='186.04' x2='541.13' y2='182.48' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='537.57' y1='182.48' x2='541.13' y2='186.04' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='478.56' cy='205.39' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.78' y1='207.17' x2='480.34' y2='203.60' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.78' y1='203.60' x2='480.34' y2='207.17' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='478.56' cy='185.83' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.78' y1='187.61' x2='480.34' y2='184.05' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.78' y1='184.05' x2='480.34' y2='187.61' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='455.87' cy='211.87' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.09' y1='213.65' x2='457.65' y2='210.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.09' y1='210.09' x2='457.65' y2='213.65' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='455.87' cy='180.57' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.09' y1='182.36' x2='457.65' y2='178.79' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.09' y1='178.79' x2='457.65' y2='182.36' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='444.48' cy='198.93' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.70' y1='200.72' x2='446.26' y2='197.15' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.70' y1='197.15' x2='446.26' y2='200.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='444.48' cy='191.89' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.70' y1='193.68' x2='446.26' y2='190.11' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.70' y1='190.11' x2='446.26' y2='193.68' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='685.71,178.38 687.49,181.94 683.93,181.94 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='683.93' y='178.38' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='685.71,213.53 687.49,217.09 683.93,217.09 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='683.93' y='213.53' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.78,196.79 675.56,200.35 672.00,200.35 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='672.00' y='196.79' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.78,141.92 675.56,145.49 672.00,145.49 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='672.00' y='141.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='652.67,212.37 654.45,215.93 650.89,215.93 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='650.89' y='212.37' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='652.67,234.66 654.45,238.22 650.89,238.22 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='650.89' y='234.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.21,187.54 620.99,191.10 617.42,191.10 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='617.42' y='187.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.21,182.39 620.99,185.96 617.42,185.96 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='617.42' y='182.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='579.37,224.62 581.15,228.18 577.59,228.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='577.59' y='224.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='579.37,176.61 581.15,180.18 577.59,180.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='577.59' y='176.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='534.45,192.28 536.23,195.85 532.67,195.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='532.67' y='192.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='534.45,176.85 536.23,180.42 532.67,180.42 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='532.67' y='176.85' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='483.84,204.30 485.62,207.87 482.06,207.87 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='482.06' y='204.30' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='483.84,208.59 485.62,212.15 482.06,212.15 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='482.06' y='208.59' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='456.91,195.25 458.69,198.82 455.13,198.82 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='455.13' y='195.25' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='456.91,177.25 458.69,180.82 455.13,180.82 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='455.13' y='177.25' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='439.88,190.48 441.67,194.04 438.10,194.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='438.10' y='190.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='439.88,188.76 441.67,192.33 438.10,192.33 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='438.10' y='188.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,185.72 690.67,185.72 690.67,182.15 687.11,182.15 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,173.03 690.67,173.03 690.67,169.47 687.11,169.47 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.84,196.61 677.40,196.61 677.40,193.05 673.84,193.05 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.84,216.22 677.40,216.22 677.40,212.65 673.84,212.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='650.38,229.38 653.94,229.38 653.94,225.82 650.38,225.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='650.38,185.55 653.94,185.55 653.94,181.99 650.38,181.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='613.49,189.30 617.05,189.30 617.05,185.74 613.49,185.74 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='613.49,204.30 617.05,204.30 617.05,200.73 613.49,200.73 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='570.93,181.32 574.49,181.32 574.49,177.76 570.93,177.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='570.93,230.92 574.49,230.92 574.49,227.35 570.93,227.35 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='527.72,197.07 531.28,197.07 531.28,193.51 527.72,193.51 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='527.72,171.70 531.28,171.70 531.28,168.13 527.72,168.13 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.86,203.03 491.42,203.03 491.42,199.47 487.86,199.47 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.86,205.34 491.42,205.34 491.42,201.78 487.86,201.78 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='466.58,205.96 470.14,205.96 470.14,202.40 466.58,202.40 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='466.58,195.58 470.14,195.58 470.14,192.02 466.58,192.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.22,206.73 454.79,206.73 454.79,203.17 451.22,203.17 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.22,170.98 454.79,170.98 454.79,167.41 451.22,167.41 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<polyline points='50.12,520.49 52.44,514.82 55.81,506.99 57.09,504.13 61.50,494.73 66.38,485.12 67.19,483.60 72.87,473.48 78.56,464.29 82.64,458.21 84.25,455.92 89.94,448.31 95.63,441.38 101.32,435.08 107.01,429.34 112.70,424.11 115.16,421.99 118.39,419.35 124.08,415.02 129.77,411.07 135.46,407.47 141.15,404.20 146.83,401.22 152.52,398.51 158.21,396.05 163.90,393.81 169.59,391.78 175.28,389.94 180.97,388.27 186.66,386.76 189.50,386.06 192.35,385.40 198.04,384.17 203.73,383.07 209.42,382.08 215.11,381.20 220.79,380.42 226.48,379.72 232.17,379.11 237.86,378.58 243.55,378.12 249.24,377.73 254.93,377.40 259.20,377.19 260.62,377.13 266.31,376.91 272.00,376.74 277.69,376.61 283.38,376.53 289.07,376.49 294.76,376.49 300.44,376.52 306.13,376.59 311.82,376.69 317.51,376.81 323.20,376.96 328.89,377.14 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='527.53' x2='328.89' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='527.53' x2='50.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='527.53' x2='96.58' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='527.53' x2='143.04' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='527.53' x2='189.50' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='527.53' x2='235.97' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='527.53' x2='282.43' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='527.53' x2='328.89' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='520.49' x2='38.97' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='520.49' x2='34.21' y2='520.49' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='483.65' x2='34.21' y2='483.65' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='446.81' x2='34.21' y2='446.81' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='409.97' x2='34.21' y2='409.97' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='373.13' x2='34.21' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,522.68) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,488.04) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,451.20) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,414.36) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,377.52) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<polygon points='38.97,527.53 340.04,527.53 340.04,337.35 38.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ=='>
+ <rect x='0.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text x='180.87' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text transform='translate(8.55,437.93) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='10.98px' lengthAdjust='spacingAndGlyphs'>m1</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<circle cx='52.44' cy='511.64' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='513.49' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='498.75' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='504.28' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='486.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='490.65' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='459.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='470.01' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='433.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='432.07' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='404.81' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='401.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='408.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='388.60' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.70' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,513.81 55.81,505.08 57.09,502.02 61.50,492.47 66.38,483.43 67.19,482.07 72.87,473.42 78.56,466.15 82.64,461.63 84.25,459.98 89.94,454.69 95.63,450.10 101.32,446.08 107.01,442.52 112.70,439.34 115.16,438.06 118.39,436.46 124.08,433.85 129.77,431.44 135.46,429.23 141.15,427.16 146.83,425.24 152.52,423.43 158.21,421.73 163.90,420.12 169.59,418.60 175.28,417.16 180.97,415.80 186.66,414.50 189.50,413.87 192.35,413.26 198.04,412.09 203.73,410.97 209.42,409.90 215.11,408.89 220.79,407.93 226.48,407.01 232.17,406.14 237.86,405.31 243.55,404.53 249.24,403.78 254.93,403.08 259.20,402.58 260.62,402.41 266.31,401.78 272.00,401.19 277.69,400.63 283.38,400.11 289.07,399.61 294.76,399.15 300.44,398.72 306.13,398.32 311.82,397.94 317.51,397.60 323.20,397.28 328.89,396.99 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.35 54.84,521.50 50.04,521.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,510.71 54.84,514.87 50.04,514.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,503.72 59.49,507.87 54.69,507.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,515.61 54.69,515.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,488.24 68.78,492.40 63.98,492.40 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,492.66 68.78,496.82 63.98,496.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,464.30 85.04,468.45 80.24,468.45 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,471.66 85.04,475.82 80.24,475.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,451.03 117.56,455.19 112.76,455.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,437.03 117.56,441.19 112.76,441.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.19 191.90,425.35 187.10,425.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.30 187.10,428.30 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.56 261.60,411.72 256.80,411.72 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.19 261.60,411.35 256.80,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,417.51 331.29,421.67 326.49,421.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.19 331.29,411.35 326.49,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.28 55.81,510.46 57.09,508.34 61.50,501.34 66.38,494.16 67.19,493.02 72.87,485.46 78.56,478.57 82.64,474.01 84.25,472.30 89.94,466.59 95.63,461.40 101.32,456.68 107.01,452.38 112.70,448.48 115.16,446.90 118.39,444.93 124.08,441.71 129.77,438.78 135.46,436.12 141.15,433.71 146.83,431.53 152.52,429.55 158.21,427.76 163.90,426.14 169.59,424.68 175.28,423.36 180.97,422.17 186.66,421.09 189.50,420.60 192.35,420.13 198.04,419.27 203.73,418.50 209.42,417.81 215.11,417.19 220.79,416.65 226.48,416.17 232.17,415.74 237.86,415.37 243.55,415.05 249.24,414.78 254.93,414.54 259.20,414.39 260.62,414.34 266.31,414.18 272.00,414.05 277.69,413.94 283.38,413.86 289.07,413.81 294.76,413.78 300.44,413.77 306.13,413.78 311.82,413.80 317.51,413.84 323.20,413.90 328.89,413.97 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='513.49' x2='54.96' y2='513.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.01' x2='52.44' y2='510.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='508.33' x2='59.61' y2='508.33' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='510.85' x2='57.09' y2='505.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='512.75' x2='59.61' y2='512.75' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='515.27' x2='57.09' y2='510.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='483.65' x2='68.90' y2='483.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='486.17' x2='66.38' y2='481.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='486.96' x2='68.90' y2='486.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='489.48' x2='66.38' y2='484.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='469.28' x2='85.16' y2='469.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='471.80' x2='82.64' y2='466.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='462.65' x2='85.16' y2='462.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='465.17' x2='82.64' y2='460.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='437.96' x2='117.68' y2='437.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='440.48' x2='115.16' y2='435.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='435.39' x2='117.68' y2='435.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='437.91' x2='115.16' y2='432.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='404.81' x2='192.02' y2='404.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='407.33' x2='189.50' y2='402.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='387.86' x2='192.02' y2='387.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='390.38' x2='189.50' y2='385.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='386.02' x2='261.72' y2='386.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='388.54' x2='259.20' y2='383.50' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.86' x2='261.72' y2='394.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.38' x2='259.20' y2='392.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='387.49' x2='331.41' y2='387.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='390.01' x2='328.89' y2='384.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='378.28' x2='331.41' y2='378.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='380.80' x2='328.89' y2='375.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,515.88 55.81,509.48 57.09,507.13 61.50,499.36 66.38,491.31 67.19,490.03 72.87,481.43 78.56,473.50 82.64,468.19 84.25,466.17 89.94,459.40 95.63,453.14 101.32,447.35 107.01,441.99 112.70,437.02 115.16,434.99 118.39,432.43 124.08,428.17 129.77,424.23 135.46,420.58 141.15,417.20 146.83,414.07 152.52,411.18 158.21,408.51 163.90,406.04 169.59,403.76 175.28,401.67 180.97,399.74 186.66,397.97 189.50,397.15 192.35,396.35 198.04,394.87 203.73,393.53 209.42,392.30 215.11,391.20 220.79,390.20 226.48,389.31 232.17,388.51 237.86,387.81 243.55,387.20 249.24,386.67 254.93,386.21 259.20,385.92 260.62,385.84 266.31,385.53 272.00,385.29 277.69,385.11 283.38,384.99 289.07,384.93 294.76,384.93 300.44,384.97 306.13,385.06 311.82,385.20 317.51,385.38 323.20,385.60 328.89,385.86 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.79' x2='54.22' y2='510.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='510.23' x2='54.22' y2='513.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.37' x2='54.22' y2='505.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.81' x2='54.22' y2='509.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='502.37' x2='58.87' y2='498.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='498.81' x2='58.87' y2='502.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='510.11' x2='58.87' y2='506.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.55' x2='58.87' y2='510.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='484.32' x2='68.16' y2='480.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='480.76' x2='68.16' y2='484.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='485.43' x2='68.16' y2='481.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='481.86' x2='68.16' y2='485.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='452.64' x2='84.42' y2='449.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='449.08' x2='84.42' y2='452.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='468.11' x2='84.42' y2='464.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='464.55' x2='84.42' y2='468.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.27' x2='116.95' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='413.71' x2='116.95' y2='417.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='420.22' x2='116.95' y2='416.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.66' x2='116.95' y2='420.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='374.91' x2='191.29' y2='371.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='371.34' x2='191.29' y2='374.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='368.64' x2='191.29' y2='365.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='365.08' x2='191.29' y2='368.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='360.91' x2='260.98' y2='357.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='357.34' x2='260.98' y2='360.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='354.65' x2='260.98' y2='351.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='351.08' x2='260.98' y2='354.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='357.22' x2='330.67' y2='353.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='353.66' x2='330.67' y2='357.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='347.65' x2='330.67' y2='344.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='344.08' x2='330.67' y2='347.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,511.70 55.81,501.51 57.09,498.20 61.50,488.39 66.38,479.39 67.19,478.03 72.87,469.08 78.56,460.99 82.64,455.57 84.25,453.49 89.94,446.48 95.63,439.88 101.32,433.66 107.01,427.80 112.70,422.27 115.16,419.97 118.39,417.06 124.08,412.15 129.77,407.53 135.46,403.18 141.15,399.08 146.83,395.23 152.52,391.62 158.21,388.23 163.90,385.05 169.59,382.06 175.28,379.27 180.97,376.66 186.66,374.22 189.50,373.07 192.35,371.95 198.04,369.83 203.73,367.86 209.42,366.02 215.11,364.32 220.79,362.75 226.48,361.30 232.17,359.96 237.86,358.72 243.55,357.60 249.24,356.56 254.93,355.62 259.20,354.98 260.62,354.77 266.31,354.00 272.00,353.32 277.69,352.70 283.38,352.16 289.07,351.68 294.76,351.27 300.44,350.92 306.13,350.63 311.82,350.39 317.51,350.20 323.20,350.07 328.89,349.98 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,515.33 52.44,512.81 54.96,515.33 52.44,517.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,512.38 52.44,509.86 54.96,512.38 52.44,514.90 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,502.07 57.09,499.55 59.61,502.07 57.09,504.59 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,500.22 57.09,497.70 59.61,500.22 57.09,502.74 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,485.12 66.38,482.60 68.90,485.12 66.38,487.64 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,482.54 66.38,480.02 68.90,482.54 66.38,485.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,457.86 82.64,455.34 85.16,457.86 82.64,460.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,465.23 82.64,462.71 85.16,465.23 82.64,467.75 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,442.75 115.16,440.23 117.68,442.75 115.16,445.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,440.91 115.16,438.39 117.68,440.91 115.16,443.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,422.86 189.50,420.34 192.02,422.86 189.50,425.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,421.75 189.50,419.23 192.02,421.75 189.50,424.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,421.02 259.20,418.50 261.72,421.02 259.20,423.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,416.60 259.20,414.08 261.72,416.60 259.20,419.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,412.54 328.89,410.02 331.41,412.54 328.89,415.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,430.96 328.89,428.44 331.41,430.96 328.89,433.48 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,511.54 55.81,500.68 57.09,497.10 61.50,486.69 66.38,477.84 67.19,476.59 72.87,469.13 78.56,463.44 82.64,460.13 84.25,458.96 89.94,455.32 95.63,452.27 101.32,449.64 107.01,447.32 112.70,445.22 115.16,444.37 118.39,443.31 124.08,441.54 129.77,439.89 135.46,438.35 141.15,436.89 146.83,435.53 152.52,434.23 158.21,433.01 163.90,431.86 169.59,430.77 175.28,429.74 180.97,428.77 186.66,427.86 189.50,427.42 192.35,427.00 198.04,426.19 203.73,425.43 209.42,424.72 215.11,424.05 220.79,423.43 226.48,422.85 232.17,422.32 237.86,421.82 243.55,421.36 249.24,420.94 254.93,420.55 259.20,420.28 260.62,420.20 266.31,419.88 272.00,419.59 277.69,419.33 283.38,419.11 289.07,418.91 294.76,418.73 300.44,418.59 306.13,418.47 311.82,418.37 317.51,418.30 323.20,418.25 328.89,418.22 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.94 54.84,508.78 50.04,508.78 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.20 54.84,508.05 50.04,508.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.47 59.49,507.31 54.69,507.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,519.20 59.49,515.05 54.69,515.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.63 68.78,491.47 63.98,491.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,498.94 68.78,494.79 63.98,494.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,473.15 85.04,469.00 80.24,469.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,479.79 85.04,475.63 80.24,475.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,455.10 117.56,450.95 112.76,450.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.94 117.56,452.79 112.76,452.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,444.05 191.90,439.89 187.10,439.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,440.37 191.90,436.21 187.10,436.21 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,430.79 261.60,426.63 256.80,426.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,427.84 261.60,423.68 256.80,423.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,434.47 331.29,430.32 326.49,430.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,435.95 331.29,431.79 326.49,431.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.08 55.81,510.11 57.09,507.96 61.50,501.00 66.38,494.07 67.19,493.00 72.87,485.96 78.56,479.76 82.64,475.78 84.25,474.30 89.94,469.47 95.63,465.19 101.32,461.41 107.01,458.05 112.70,455.07 115.16,453.88 118.39,452.41 124.08,450.05 129.77,447.93 135.46,446.04 141.15,444.35 146.83,442.83 152.52,441.47 158.21,440.25 163.90,439.14 169.59,438.15 175.28,437.25 180.97,436.45 186.66,435.72 189.50,435.38 192.35,435.06 198.04,434.47 203.73,433.94 209.42,433.46 215.11,433.03 220.79,432.64 226.48,432.30 232.17,431.99 237.86,431.72 243.55,431.49 249.24,431.28 254.93,431.11 259.20,430.99 260.62,430.96 266.31,430.83 272.00,430.73 277.69,430.65 283.38,430.60 289.07,430.56 294.76,430.55 300.44,430.55 306.13,430.57 311.82,430.61 317.51,430.66 323.20,430.73 328.89,430.81 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='516.00' x2='54.22' y2='512.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='512.44' x2='54.22' y2='516.00' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='508.64' x2='54.22' y2='505.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.07' x2='54.22' y2='508.64' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='492.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='495.74' x2='58.87' y2='492.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='492.18' x2='58.87' y2='495.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='499.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.48' x2='58.87' y2='499.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='499.92' x2='58.87' y2='503.48' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='468.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='472.17' x2='68.16' y2='468.60' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='468.60' x2='68.16' y2='472.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='467.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='470.69' x2='68.16' y2='467.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='467.13' x2='68.16' y2='470.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='431.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='434.96' x2='84.42' y2='431.39' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='431.39' x2='84.42' y2='434.96' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='450.55' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='454.11' x2='84.42' y2='450.55' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='450.55' x2='84.42' y2='454.11' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='400.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='404.38' x2='116.95' y2='400.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='400.82' x2='116.95' y2='404.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='405.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='409.54' x2='116.95' y2='405.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='405.97' x2='116.95' y2='409.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='389.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='393.33' x2='191.29' y2='389.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='389.76' x2='191.29' y2='393.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='387.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='390.75' x2='191.29' y2='387.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='387.18' x2='191.29' y2='390.75' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='399.22' x2='260.98' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='395.66' x2='260.98' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='377.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='380.80' x2='260.98' y2='377.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='377.24' x2='260.98' y2='380.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='399.22' x2='330.67' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='395.66' x2='330.67' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='373.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='377.49' x2='330.67' y2='373.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='373.92' x2='330.67' y2='377.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.53 55.81,501.81 57.09,497.97 61.50,485.66 66.38,473.55 67.19,471.69 72.87,459.59 78.56,449.12 82.64,442.49 84.25,440.05 89.94,432.19 95.63,425.37 101.32,419.45 107.01,414.32 112.70,409.88 115.16,408.14 118.39,406.02 124.08,402.67 129.77,399.77 135.46,397.27 141.15,395.10 146.83,393.23 152.52,391.62 158.21,390.24 163.90,389.07 169.59,388.07 175.28,387.23 180.97,386.53 186.66,385.95 189.50,385.70 192.35,385.48 198.04,385.12 203.73,384.84 209.42,384.64 215.11,384.51 220.79,384.45 226.48,384.44 232.17,384.49 237.86,384.59 243.55,384.73 249.24,384.92 254.93,385.14 259.20,385.32 260.62,385.39 266.31,385.68 272.00,385.99 277.69,386.33 283.38,386.70 289.07,387.09 294.76,387.50 300.44,387.94 306.13,388.39 311.82,388.86 317.51,389.34 323.20,389.84 328.89,390.36 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.06' x2='54.22' y2='509.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.49' x2='54.22' y2='513.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='511.28' x2='54.96' y2='511.28' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.80' x2='52.44' y2='508.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.74' x2='54.22' y2='506.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='506.18' x2='54.22' y2='509.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='507.96' x2='54.96' y2='507.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='510.48' x2='52.44' y2='505.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='493.90' x2='58.87' y2='490.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='490.34' x2='58.87' y2='493.90' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='492.12' x2='59.61' y2='492.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='494.64' x2='57.09' y2='489.60' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='488.37' x2='58.87' y2='484.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='484.81' x2='58.87' y2='488.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='486.59' x2='59.61' y2='486.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='489.11' x2='57.09' y2='484.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='459.64' x2='68.16' y2='456.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.08' x2='68.16' y2='459.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='457.86' x2='68.90' y2='457.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='460.38' x2='66.38' y2='455.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='460.38' x2='68.16' y2='456.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.81' x2='68.16' y2='460.38' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='458.59' x2='68.90' y2='458.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='461.11' x2='66.38' y2='456.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='430.54' x2='84.42' y2='426.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='426.97' x2='84.42' y2='430.54' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='428.75' x2='85.16' y2='428.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.27' x2='82.64' y2='426.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='441.22' x2='84.42' y2='437.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='437.66' x2='84.42' y2='441.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='439.44' x2='85.16' y2='439.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='441.96' x2='82.64' y2='436.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='397.01' x2='116.95' y2='393.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='393.45' x2='116.95' y2='397.01' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='395.23' x2='117.68' y2='395.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='397.75' x2='115.16' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='391.49' x2='116.95' y2='387.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='387.92' x2='116.95' y2='391.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='389.70' x2='117.68' y2='389.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='392.22' x2='115.16' y2='387.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='377.12' x2='191.29' y2='373.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='373.55' x2='191.29' y2='377.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='375.34' x2='192.02' y2='375.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='377.86' x2='189.50' y2='372.82' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='399.22' x2='191.29' y2='395.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='395.66' x2='191.29' y2='399.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='397.44' x2='192.02' y2='397.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='399.96' x2='189.50' y2='394.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='382.64' x2='260.98' y2='379.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='379.08' x2='260.98' y2='382.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='380.86' x2='261.72' y2='380.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='383.38' x2='259.20' y2='378.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='396.27' x2='260.98' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='392.71' x2='260.98' y2='396.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.49' x2='261.72' y2='394.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.01' x2='259.20' y2='391.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='374.91' x2='330.67' y2='371.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='371.34' x2='330.67' y2='374.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='373.13' x2='331.41' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='375.65' x2='328.89' y2='370.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='393.70' x2='330.67' y2='390.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='390.13' x2='330.67' y2='393.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='391.91' x2='331.41' y2='391.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='394.43' x2='328.89' y2='389.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,508.44 55.81,493.06 57.09,487.79 61.50,471.76 66.38,457.29 67.19,455.18 72.87,442.22 78.56,432.05 82.64,426.11 84.25,424.02 89.94,417.65 95.63,412.56 101.32,408.46 107.01,405.12 112.70,402.38 115.16,401.34 118.39,400.10 124.08,398.19 129.77,396.57 135.46,395.18 141.15,393.97 146.83,392.91 152.52,391.97 158.21,391.13 163.90,390.37 169.59,389.69 175.28,389.06 180.97,388.49 186.66,387.96 189.50,387.71 192.35,387.47 198.04,387.03 203.73,386.61 209.42,386.23 215.11,385.88 220.79,385.56 226.48,385.27 232.17,385.00 237.86,384.75 243.55,384.53 249.24,384.33 254.93,384.16 259.20,384.04 260.62,384.00 266.31,383.87 272.00,383.75 277.69,383.65 283.38,383.58 289.07,383.52 294.76,383.47 300.44,383.45 306.13,383.44 311.82,383.44 317.51,383.47 323.20,383.50 328.89,383.55 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='505.38' x2='54.96' y2='505.38' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='507.90' x2='52.44' y2='502.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,505.38 52.44,502.86 54.96,505.38 52.44,507.90 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='509.07' x2='54.96' y2='509.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='511.59' x2='52.44' y2='506.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,509.07 52.44,506.55 54.96,509.07 52.44,511.59 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='487.70' x2='59.61' y2='487.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='490.22' x2='57.09' y2='485.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,487.70 57.09,485.18 59.61,487.70 57.09,490.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='493.22' x2='59.61' y2='493.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='495.74' x2='57.09' y2='490.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,493.22 57.09,490.70 59.61,493.22 57.09,495.74 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='461.17' x2='68.90' y2='461.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='463.69' x2='66.38' y2='458.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,461.17 66.38,458.65 68.90,461.17 66.38,463.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='469.28' x2='68.90' y2='469.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='471.80' x2='66.38' y2='466.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,469.28 66.38,466.76 68.90,469.28 66.38,471.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.12' x2='85.16' y2='429.12' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.64' x2='82.64' y2='426.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.12 82.64,426.60 85.16,429.12 82.64,431.64 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.86' x2='85.16' y2='429.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='432.38' x2='82.64' y2='427.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.86 82.64,427.34 85.16,429.86 82.64,432.38 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='391.91' x2='117.68' y2='391.91' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='394.43' x2='115.16' y2='389.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,391.91 115.16,389.39 117.68,391.91 115.16,394.43 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='404.81' x2='117.68' y2='404.81' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='407.33' x2='115.16' y2='402.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,404.81 115.16,402.29 117.68,404.81 115.16,407.33 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='361.70' x2='192.02' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='364.22' x2='189.50' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,361.70 189.50,359.18 192.02,361.70 189.50,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='355.44' x2='192.02' y2='355.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='357.96' x2='189.50' y2='352.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,355.44 189.50,352.92 192.02,355.44 189.50,357.96 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='361.70' x2='261.72' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='364.22' x2='259.20' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,361.70 259.20,359.18 261.72,361.70 259.20,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='358.76' x2='261.72' y2='358.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='361.28' x2='259.20' y2='356.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,358.76 259.20,356.24 261.72,358.76 259.20,361.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='344.39' x2='331.41' y2='344.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='346.91' x2='328.89' y2='341.87' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,344.39 328.89,341.87 331.41,344.39 328.89,346.91 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='353.23' x2='331.41' y2='353.23' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='355.75' x2='328.89' y2='350.71' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,353.23 328.89,350.71 331.41,353.23 328.89,355.75 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,510.23 55.81,496.80 57.09,492.09 61.50,477.38 66.38,463.46 67.19,461.37 72.87,448.08 78.56,436.96 82.64,430.09 84.25,427.59 89.94,419.63 95.63,412.81 101.32,406.91 107.01,401.77 112.70,397.25 115.16,395.45 118.39,393.24 124.08,389.65 129.77,386.43 135.46,383.50 141.15,380.84 146.83,378.40 152.52,376.16 158.21,374.09 163.90,372.17 169.59,370.39 175.28,368.73 180.97,367.19 186.66,365.75 189.50,365.06 192.35,364.40 198.04,363.15 203.73,361.98 209.42,360.89 215.11,359.87 220.79,358.92 226.48,358.04 232.17,357.23 237.86,356.47 243.55,355.77 249.24,355.13 254.93,354.54 259.20,354.13 260.62,354.00 266.31,353.51 272.00,353.07 277.69,352.67 283.38,352.31 289.07,351.99 294.76,351.72 300.44,351.48 306.13,351.28 311.82,351.11 317.51,350.98 323.20,350.88 328.89,350.81 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='514.59' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='514.59' x2='54.22' y2='514.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.37' x2='52.44' y2='512.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='517.17' x2='54.22' y2='517.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='518.95' x2='52.44' y2='515.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='507.22' x2='58.87' y2='507.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='509.01' x2='57.09' y2='505.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='503.91' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.91' x2='58.87' y2='503.91' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='505.69' x2='57.09' y2='502.13' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='483.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='483.28' x2='68.16' y2='483.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='485.06' x2='66.38' y2='481.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='479.96' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='479.96' x2='68.16' y2='479.96' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='481.74' x2='66.38' y2='478.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='456.02' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='456.02' x2='84.42' y2='456.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='457.80' x2='82.64' y2='454.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='457.86' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='457.86' x2='84.42' y2='457.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='459.64' x2='82.64' y2='456.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='416.60' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.60' x2='116.95' y2='416.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='418.38' x2='115.16' y2='414.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='417.33' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.33' x2='116.95' y2='417.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='419.12' x2='115.16' y2='415.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='383.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='383.81' x2='191.29' y2='383.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='385.59' x2='189.50' y2='382.03' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='391.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='391.18' x2='191.29' y2='391.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='392.96' x2='189.50' y2='389.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='368.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='368.34' x2='260.98' y2='368.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='370.12' x2='259.20' y2='366.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='361.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='361.34' x2='260.98' y2='361.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='363.12' x2='259.20' y2='359.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='355.07' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='355.07' x2='330.67' y2='355.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='356.86' x2='328.89' y2='353.29' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='349.55' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='349.55' x2='330.67' y2='349.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='351.33' x2='328.89' y2='347.77' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.59 55.81,506.51 57.09,503.58 61.50,494.03 66.38,484.36 67.19,482.84 72.87,472.79 78.56,463.72 82.64,457.77 84.25,455.52 89.94,448.09 95.63,441.32 101.32,435.14 107.01,429.48 112.70,424.29 115.16,422.17 118.39,419.50 124.08,415.08 129.77,410.99 135.46,407.19 141.15,403.66 146.83,400.36 152.52,397.29 158.21,394.40 163.90,391.70 169.59,389.16 175.28,386.77 180.97,384.52 186.66,382.40 189.50,381.39 192.35,380.40 198.04,378.51 203.73,376.73 209.42,375.04 215.11,373.44 220.79,371.92 226.48,370.49 232.17,369.14 237.86,367.85 243.55,366.64 249.24,365.49 254.93,364.40 259.20,363.63 260.62,363.38 266.31,362.40 272.00,361.49 277.69,360.62 283.38,359.81 289.07,359.04 294.76,358.31 300.44,357.63 306.13,357.00 311.82,356.40 317.51,355.84 323.20,355.32 328.89,354.83 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,518.10 54.84,513.25 50.04,513.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.56 54.84,517.41 50.04,517.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.36 54.84,512.51 50.04,512.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,511.82 54.84,516.67 50.04,516.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,516.99 59.49,512.14 54.69,512.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,516.30 54.69,516.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,509.99 59.49,505.14 54.69,505.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,504.45 59.49,509.30 54.69,509.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,501.52 68.78,496.67 63.98,496.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.98 68.78,500.83 63.98,500.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,503.36 68.78,498.51 63.98,498.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,497.82 68.78,502.67 63.98,502.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,480.89 85.04,476.04 80.24,476.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,475.35 85.04,480.20 80.24,480.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,487.52 85.04,482.67 80.24,482.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,481.98 85.04,486.83 80.24,486.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,461.73 117.56,456.88 112.76,456.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.19 117.56,461.04 112.76,461.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,449.21 117.56,444.36 112.76,444.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,443.67 117.56,448.52 112.76,448.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.95 191.90,417.10 187.10,417.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,416.40 191.90,421.25 187.10,421.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,429.68 191.90,424.83 187.10,424.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.99 187.10,428.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,425.63 261.60,420.78 256.80,420.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.09 261.60,424.94 256.80,424.94 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,426.37 261.60,421.52 256.80,421.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.83 261.60,425.67 256.80,425.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,409.42 331.29,404.57 326.49,404.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,403.88 331.29,408.73 326.49,408.73 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,413.47 331.29,408.62 326.49,408.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.93 331.29,412.78 326.49,412.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.59 55.81,511.26 57.09,509.32 61.50,503.01 66.38,496.61 67.19,495.61 72.87,488.95 78.56,482.94 82.64,478.99 84.25,477.50 89.94,472.56 95.63,468.05 101.32,463.92 107.01,460.14 112.70,456.67 115.16,455.24 118.39,453.46 124.08,450.49 129.77,447.74 135.46,445.18 141.15,442.80 146.83,440.58 152.52,438.50 158.21,436.55 163.90,434.73 169.59,433.02 175.28,431.41 180.97,429.90 186.66,428.48 189.50,427.80 192.35,427.14 198.04,425.88 203.73,424.69 209.42,423.58 215.11,422.52 220.79,421.53 226.48,420.60 232.17,419.73 237.86,418.90 243.55,418.13 249.24,417.41 254.93,416.74 259.20,416.26 260.62,416.10 266.31,415.52 272.00,414.97 277.69,414.46 283.38,413.99 289.07,413.56 294.76,413.16 300.44,412.80 306.13,412.47 311.82,412.17 317.51,411.91 323.20,411.67 328.89,411.46 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='519.38' x2='54.22' y2='519.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='521.16' x2='52.44' y2='517.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='517.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='511.28' x2='54.22' y2='511.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.06' x2='52.44' y2='509.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.85' x2='58.87' y2='506.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='508.64' x2='57.09' y2='505.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.75' x2='58.87' y2='505.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='507.53' x2='57.09' y2='503.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='503.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.70' x2='68.16' y2='494.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='496.48' x2='66.38' y2='492.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='492.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='497.28' x2='68.16' y2='497.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='499.06' x2='66.38' y2='495.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='495.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.91' x2='84.42' y2='475.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='477.69' x2='82.64' y2='474.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='474.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='478.49' x2='84.42' y2='478.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='480.27' x2='82.64' y2='476.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='476.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.44' x2='116.95' y2='453.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.22' x2='115.16' y2='451.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='451.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.81' x2='116.95' y2='453.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.59' x2='115.16' y2='452.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='452.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='415.49' x2='191.29' y2='415.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='417.27' x2='189.50' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='413.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.75' x2='191.29' y2='421.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='423.54' x2='189.50' y2='419.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='419.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.86' x2='260.98' y2='401.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='403.64' x2='259.20' y2='400.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='400.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='414.39' x2='260.98' y2='414.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='416.17' x2='259.20' y2='412.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='412.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='394.12' x2='330.67' y2='394.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='395.91' x2='328.89' y2='392.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='409.23' x2='330.67' y2='409.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='411.01' x2='328.89' y2='407.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='407.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.77 55.81,511.60 57.09,509.70 61.50,503.40 66.38,496.88 67.19,495.84 72.87,488.86 78.56,482.42 82.64,478.11 84.25,476.47 89.94,470.97 95.63,465.89 101.32,461.18 107.01,456.83 112.70,452.80 115.16,451.15 118.39,449.07 124.08,445.61 129.77,442.40 135.46,439.42 141.15,436.66 146.83,434.09 152.52,431.70 158.21,429.48 163.90,427.42 169.59,425.49 175.28,423.70 180.97,422.03 186.66,420.47 189.50,419.73 192.35,419.02 198.04,417.66 203.73,416.39 209.42,415.20 215.11,414.09 220.79,413.05 226.48,412.07 232.17,411.16 237.86,410.30 243.55,409.50 249.24,408.74 254.93,408.03 259.20,407.53 260.62,407.37 266.31,406.74 272.00,406.16 277.69,405.60 283.38,405.08 289.07,404.59 294.76,404.13 300.44,403.70 306.13,403.29 311.82,402.91 317.51,402.55 323.20,402.21 328.89,401.89 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.95' x2='54.22' y2='515.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='515.39' x2='54.22' y2='518.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='520.12' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='521.90' x2='54.22' y2='518.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.34' x2='54.22' y2='521.90' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='509.01' x2='58.87' y2='505.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.44' x2='58.87' y2='509.01' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='502.07' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.85' x2='58.87' y2='500.28' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='500.28' x2='58.87' y2='503.85' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='492.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.27' x2='68.16' y2='490.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='490.71' x2='68.16' y2='494.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='496.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='498.32' x2='68.16' y2='494.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.76' x2='68.16' y2='498.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='477.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='479.53' x2='84.42' y2='475.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.97' x2='84.42' y2='479.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='472.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='474.38' x2='84.42' y2='470.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='470.81' x2='84.42' y2='474.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='443.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='445.27' x2='116.95' y2='441.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='441.71' x2='116.95' y2='445.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='451.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.38' x2='116.95' y2='449.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='449.81' x2='116.95' y2='453.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.33' x2='191.29' y2='417.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='417.76' x2='191.29' y2='421.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='406.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='408.43' x2='191.29' y2='404.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='404.87' x2='191.29' y2='408.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='421.69' x2='260.98' y2='418.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='418.13' x2='260.98' y2='421.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='400.02' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.80' x2='260.98' y2='398.24' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='398.24' x2='260.98' y2='401.80' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='405.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='407.33' x2='330.67' y2='403.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='403.76' x2='330.67' y2='407.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.33' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='405.12' x2='330.67' y2='401.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='401.55' x2='330.67' y2='405.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.30 55.81,510.51 57.09,508.39 61.50,501.39 66.38,494.19 67.19,493.05 72.87,485.43 78.56,478.46 82.64,473.83 84.25,472.09 89.94,466.25 95.63,460.92 101.32,456.04 107.01,451.58 112.70,447.49 115.16,445.83 118.39,443.76 124.08,440.33 129.77,437.20 135.46,434.33 141.15,431.71 146.83,429.30 152.52,427.10 158.21,425.09 163.90,423.24 169.59,421.55 175.28,420.00 180.97,418.57 186.66,417.27 189.50,416.66 192.35,416.08 198.04,414.99 203.73,413.99 209.42,413.07 215.11,412.23 220.79,411.46 226.48,410.76 232.17,410.11 237.86,409.52 243.55,408.98 249.24,408.49 254.93,408.03 259.20,407.72 260.62,407.62 266.31,407.25 272.00,406.90 277.69,406.59 283.38,406.31 289.07,406.05 294.76,405.82 300.44,405.61 306.13,405.42 311.82,405.25 317.51,405.09 323.20,404.96 328.89,404.83 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.44 54.22,516.00 50.66,516.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,509.86 54.22,513.43 50.66,513.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,497.34 58.87,500.90 55.30,500.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='497.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,498.81 58.87,502.37 55.30,502.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='498.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,485.18 68.16,488.74 64.60,488.74 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='485.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,471.92 68.16,475.48 64.60,475.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='471.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,446.87 84.42,450.43 80.86,450.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='446.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,451.29 84.42,454.85 80.86,454.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='451.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,431.02 116.95,434.59 113.38,434.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='431.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,421.08 116.95,424.64 113.38,424.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='421.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,397.50 191.29,401.06 187.72,401.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='397.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,386.82 191.29,390.38 187.72,390.38 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='386.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,399.34 260.98,402.91 257.42,402.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='399.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,383.87 260.98,387.43 257.42,387.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='383.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,396.03 330.67,399.59 327.11,399.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='396.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,392.34 330.67,395.91 327.11,395.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.52 55.81,502.13 57.09,498.49 61.50,487.18 66.38,476.51 67.19,474.91 72.87,464.76 78.56,456.28 82.64,451.04 84.25,449.14 89.94,443.06 95.63,437.83 101.32,433.30 107.01,429.34 112.70,425.83 115.16,424.44 118.39,422.71 124.08,419.92 129.77,417.39 135.46,415.10 141.15,413.01 146.83,411.09 152.52,409.34 158.21,407.72 163.90,406.23 169.59,404.85 175.28,403.58 180.97,402.41 186.66,401.33 189.50,400.82 192.35,400.33 198.04,399.41 203.73,398.57 209.42,397.80 215.11,397.10 220.79,396.46 226.48,395.88 232.17,395.36 237.86,394.90 243.55,394.48 249.24,394.12 254.93,393.81 259.20,393.61 260.62,393.55 266.31,393.33 272.00,393.15 277.69,393.01 283.38,392.91 289.07,392.85 294.76,392.82 300.44,392.83 306.13,392.87 311.82,392.94 317.51,393.04 323.20,393.17 328.89,393.32 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,513.06 54.22,513.06 54.22,509.49 50.66,509.49 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,514.90 54.22,514.90 54.22,511.34 50.66,511.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,501.64 58.87,501.64 58.87,498.07 55.30,498.07 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,499.43 58.87,499.43 58.87,495.86 55.30,495.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,486.90 68.16,486.90 68.16,483.34 64.60,483.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,472.90 68.16,472.90 68.16,469.34 64.60,469.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,462.22 84.42,462.22 84.42,458.65 80.86,458.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,455.22 84.42,455.22 84.42,451.65 80.86,451.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,427.59 116.95,427.59 116.95,424.02 113.38,424.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,428.33 116.95,428.33 116.95,424.76 113.38,424.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,400.33 191.29,400.33 191.29,396.76 187.72,396.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,399.96 191.29,399.96 191.29,396.39 187.72,396.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,390.38 260.98,390.38 260.98,386.82 257.42,386.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,396.27 260.98,396.27 260.98,392.71 257.42,392.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,383.38 330.67,383.38 330.67,379.82 327.11,379.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,402.54 330.67,402.54 330.67,398.97 327.11,398.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.53 55.81,502.12 57.09,498.48 61.50,487.13 66.38,476.45 67.19,474.85 72.87,464.72 78.56,456.33 82.64,451.19 84.25,449.33 89.94,443.44 95.63,438.45 101.32,434.18 107.01,430.50 112.70,427.30 115.16,426.03 118.39,424.48 124.08,421.98 129.77,419.73 135.46,417.70 141.15,415.85 146.83,414.15 152.52,412.57 158.21,411.10 163.90,409.72 169.59,408.42 175.28,407.19 180.97,406.02 186.66,404.90 189.50,404.36 192.35,403.83 198.04,402.81 203.73,401.83 209.42,400.89 215.11,399.98 220.79,399.11 226.48,398.27 232.17,397.46 237.86,396.68 243.55,395.92 249.24,395.19 254.93,394.49 259.20,393.98 260.62,393.81 266.31,393.15 272.00,392.52 277.69,391.91 283.38,391.32 289.07,390.75 294.76,390.20 300.44,389.67 306.13,389.16 311.82,388.67 317.51,388.20 323.20,387.74 328.89,387.31 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='527.53' x2='651.04' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='527.53' x2='410.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='470.35' y1='527.53' x2='470.35' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='530.58' y1='527.53' x2='530.58' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='590.81' y1='527.53' x2='590.81' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='651.04' y1='527.53' x2='651.04' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='465.96' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='526.19' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='586.42' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='646.65' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<line x1='398.97' y1='503.71' x2='398.97' y2='361.16' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='503.71' x2='394.21' y2='503.71' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='468.07' x2='394.21' y2='468.07' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='432.44' x2='394.21' y2='432.44' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='396.80' x2='394.21' y2='396.80' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='361.16' x2='394.21' y2='361.16' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,507.23) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,471.59) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,434.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,399.00) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,363.36) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,527.53 700.04,527.53 700.04,337.35 398.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5'>
+ <rect x='360.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text x='532.82' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text transform='translate(368.55,470.64) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='432.44' x2='700.04' y2='432.44' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='421.03' cy='428.85' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='421.03' cy='431.90' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='440.31' cy='427.02' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='440.31' cy='436.17' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='470.70' cy='437.68' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='470.70' cy='444.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='506.35' cy='428.63' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='506.35' cy='446.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='544.88' cy='425.57' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='544.88' cy='422.52' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='584.42' cy='417.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='584.42' cy='442.45' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='602.89' cy='431.25' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='602.89' cy='442.85' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='612.03' cy='418.54' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='612.03' cy='443.56' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.99,438.57 419.39,442.73 414.59,442.73 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.99,423.18 419.39,427.34 414.59,427.34 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.98,425.38 432.38,429.53 427.58,429.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.98,443.33 432.38,447.48 427.58,447.48 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='453.17,422.38 455.57,426.53 450.77,426.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='453.17,432.63 455.57,436.79 450.77,436.79 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='486.09,413.55 488.49,417.70 483.69,417.70 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='486.09,430.64 488.49,434.80 483.69,434.80 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='530.43,445.69 532.83,449.85 528.03,449.85 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='530.43,413.21 532.83,417.37 528.03,417.37 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='573.43,437.47 575.83,441.63 571.03,441.63 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='573.43,444.31 575.83,448.47 571.03,448.47 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='583.58,420.26 585.98,424.41 581.18,424.41 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='583.58,419.40 585.98,423.56 581.18,423.56 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='584.26,444.31 586.66,448.46 581.86,448.46 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='584.26,420.37 586.66,424.53 581.86,424.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.13' y1='427.62' x2='420.17' y2='427.62' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.65' y1='430.14' x2='417.65' y2='425.10' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.43' y1='434.85' x2='434.47' y2='434.85' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='431.95' y1='437.37' x2='431.95' y2='432.33' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.43' y1='443.74' x2='434.47' y2='443.74' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='431.95' y1='446.26' x2='431.95' y2='441.22' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.31' y1='417.04' x2='460.35' y2='417.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='457.83' y1='419.56' x2='457.83' y2='414.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.31' y1='423.70' x2='460.35' y2='423.70' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='457.83' y1='426.22' x2='457.83' y2='421.18' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='493.10' y1='434.63' x2='498.14' y2='434.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='495.62' y1='437.15' x2='495.62' y2='432.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='493.10' y1='421.30' x2='498.14' y2='421.30' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='495.62' y1='423.82' x2='495.62' y2='418.78' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='547.38' y1='438.42' x2='552.42' y2='438.42' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='549.90' y1='440.94' x2='549.90' y2='435.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='547.38' y1='433.24' x2='552.42' y2='433.24' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='549.90' y1='435.76' x2='549.90' y2='430.72' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='609.25' y1='447.84' x2='614.29' y2='447.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='611.77' y1='450.36' x2='611.77' y2='445.32' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='609.25' y1='413.77' x2='614.29' y2='413.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='611.77' y1='416.29' x2='611.77' y2='411.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.60' y1='432.63' x2='632.64' y2='432.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.12' y1='435.15' x2='630.12' y2='430.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.60' y1='450.40' x2='632.64' y2='450.40' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.12' y1='452.92' x2='630.12' y2='447.88' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.70' y1='435.72' x2='632.74' y2='435.72' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.22' y1='438.24' x2='630.22' y2='433.20' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.70' y1='417.20' x2='632.74' y2='417.20' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.22' y1='419.72' x2='630.22' y2='414.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='422.70' y1='434.85' x2='426.27' y2='431.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='422.70' y1='431.28' x2='426.27' y2='434.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='422.70' y1='426.03' x2='426.27' y2='422.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='422.70' y1='422.47' x2='426.27' y2='426.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='444.77' y1='438.99' x2='448.34' y2='435.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='444.77' y1='435.43' x2='448.34' y2='438.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='444.77' y1='454.42' x2='448.34' y2='450.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='444.77' y1='450.86' x2='448.34' y2='454.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='475.53' y1='440.51' x2='479.09' y2='436.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='475.53' y1='436.94' x2='479.09' y2='440.51' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='475.53' y1='442.71' x2='479.09' y2='439.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='475.53' y1='439.15' x2='479.09' y2='442.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.48' y1='424.83' x2='518.04' y2='421.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.48' y1='421.27' x2='518.04' y2='424.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.48' y1='455.69' x2='518.04' y2='452.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.48' y1='452.13' x2='518.04' y2='455.69' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='572.67' y1='425.28' x2='576.23' y2='421.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='572.67' y1='421.72' x2='576.23' y2='425.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='572.67' y1='431.16' x2='576.23' y2='427.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='572.67' y1='427.59' x2='576.23' y2='431.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='649.36' y1='434.34' x2='652.92' y2='430.77' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='649.36' y1='430.77' x2='652.92' y2='434.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='649.36' y1='421.84' x2='652.92' y2='418.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='649.36' y1='418.28' x2='652.92' y2='421.84' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='678.93' y1='442.49' x2='682.49' y2='438.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='678.93' y1='438.93' x2='682.49' y2='442.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='678.93' y1='430.00' x2='682.49' y2='426.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='678.93' y1='426.44' x2='682.49' y2='430.00' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.11' y1='445.12' x2='690.67' y2='441.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.11' y1='441.56' x2='690.67' y2='445.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.11' y1='426.02' x2='690.67' y2='422.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.11' y1='422.45' x2='690.67' y2='426.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='422.23,440.07 424.75,437.55 427.27,440.07 424.75,442.59 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='422.23,434.14 424.75,431.62 427.27,434.14 424.75,436.66 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='445.83,442.43 448.35,439.91 450.87,442.43 448.35,444.95 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='445.83,438.72 448.35,436.20 450.87,438.72 448.35,441.24 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='477.32,447.09 479.84,444.57 482.36,447.09 479.84,449.61 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='477.32,441.90 479.84,439.38 482.36,441.90 479.84,444.42 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='506.27,427.86 508.79,425.34 511.31,427.86 508.79,430.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='506.27,442.69 508.79,440.17 511.31,442.69 508.79,445.21 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='532.04,429.18 534.56,426.66 537.08,429.18 534.56,431.70 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='532.04,425.47 534.56,422.95 537.08,425.47 534.56,427.99 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='559.75,423.25 562.27,420.73 564.79,423.25 562.27,425.77 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='559.75,421.03 562.27,418.51 564.79,421.03 562.27,423.55 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.42,433.91 573.94,431.39 576.46,433.91 573.94,436.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.42,425.01 573.94,422.49 576.46,425.01 573.94,427.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='574.80,421.02 577.32,418.50 579.84,421.02 577.32,423.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='574.80,458.10 577.32,455.57 579.84,458.10 577.32,460.62 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.31,424.21 419.71,420.05 414.91,420.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.31,422.84 419.71,418.68 414.91,418.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='430.60,436.59 433.00,432.43 428.20,432.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='430.60,450.97 433.00,446.82 428.20,446.82 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='453.30,432.94 455.70,428.79 450.90,428.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='453.30,439.11 455.70,434.95 450.90,434.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='483.21,425.18 485.61,421.02 480.81,421.02 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='483.21,437.51 485.61,433.35 480.81,433.35 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.01,432.33 521.41,428.17 516.61,428.17 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.01,435.75 521.41,431.60 516.61,431.60 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='549.26,446.18 551.66,442.02 546.86,442.02 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='549.26,439.33 551.66,435.17 546.86,435.17 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='556.44,429.68 558.84,425.52 554.04,425.52 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='556.44,424.20 558.84,420.04 554.04,420.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='556.73,436.86 559.13,432.71 554.33,432.71 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='556.73,439.60 559.13,435.45 554.33,435.45 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.34' y='433.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.34' y1='436.88' x2='424.91' y2='433.31' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.34' y1='433.31' x2='424.91' y2='436.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.34' y='421.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.34' y1='425.33' x2='424.91' y2='421.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.34' y1='421.76' x2='424.91' y2='425.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='445.15' y='424.38' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.15' y1='427.94' x2='448.72' y2='424.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.15' y1='424.38' x2='448.72' y2='427.94' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='445.15' y='436.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.15' y1='440.07' x2='448.72' y2='436.50' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.15' y1='436.50' x2='448.72' y2='440.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='485.08' y='425.70' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.08' y1='429.26' x2='488.64' y2='425.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.08' y1='425.70' x2='488.64' y2='429.26' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='485.08' y='423.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.08' y1='426.95' x2='488.64' y2='423.39' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.08' y1='423.39' x2='488.64' y2='426.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='535.86' y='416.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.86' y1='419.62' x2='539.42' y2='416.05' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.86' y1='416.05' x2='539.42' y2='419.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='535.86' y='446.09' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.86' y1='449.65' x2='539.42' y2='446.09' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.86' y1='446.09' x2='539.42' y2='449.65' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='592.02' y='421.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.02' y1='425.54' x2='595.58' y2='421.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.02' y1='421.97' x2='595.58' y2='425.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='592.02' y='430.06' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.02' y1='433.62' x2='595.58' y2='430.06' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.02' y1='430.06' x2='595.58' y2='433.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='628.70' y='439.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.70' y1='443.38' x2='632.26' y2='439.81' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.70' y1='439.81' x2='632.26' y2='443.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='628.70' y='435.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.70' y1='439.33' x2='632.26' y2='435.77' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.70' y1='435.77' x2='632.26' y2='439.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='629.32' y='449.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.32' y1='453.21' x2='632.88' y2='449.65' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.32' y1='449.65' x2='632.88' y2='453.21' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='629.32' y='420.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.32' y1='424.34' x2='632.88' y2='420.77' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.32' y1='420.77' x2='632.88' y2='424.34' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='621.09' y='441.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='621.09' y1='445.32' x2='624.65' y2='441.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='621.09' y1='441.76' x2='624.65' y2='445.32' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='621.09' y='407.69' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='621.09' y1='411.25' x2='624.65' y2='407.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='621.09' y1='407.69' x2='624.65' y2='411.25' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='439.09' x2='431.60' y2='435.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='435.53' x2='431.60' y2='439.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.30' y1='437.31' x2='432.34' y2='437.31' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.82' y1='439.83' x2='429.82' y2='434.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='433.40' x2='431.60' y2='429.84' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='429.84' x2='431.60' y2='433.40' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.30' y1='431.62' x2='432.34' y2='431.62' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.82' y1='434.14' x2='429.82' y2='429.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.80' y1='441.65' x2='465.36' y2='438.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.80' y1='438.09' x2='465.36' y2='441.65' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.06' y1='439.87' x2='466.10' y2='439.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.58' y1='442.39' x2='463.58' y2='437.35' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.80' y1='432.17' x2='465.36' y2='428.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.80' y1='428.61' x2='465.36' y2='432.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.06' y1='430.39' x2='466.10' y2='430.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.58' y1='432.91' x2='463.58' y2='427.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.66' y1='435.20' x2='515.23' y2='431.63' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.66' y1='431.63' x2='515.23' y2='435.20' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.92' y1='433.42' x2='515.96' y2='433.42' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.44' y1='435.94' x2='513.44' y2='430.90' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.66' y1='436.46' x2='515.23' y2='432.90' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.66' y1='432.90' x2='515.23' y2='436.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.92' y1='434.68' x2='515.96' y2='434.68' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.44' y1='437.20' x2='513.44' y2='432.16' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='562.63' y1='438.75' x2='566.20' y2='435.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='562.63' y1='435.19' x2='566.20' y2='438.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='561.90' y1='436.97' x2='566.94' y2='436.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.42' y1='439.49' x2='564.42' y2='434.45' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='562.63' y1='457.08' x2='566.20' y2='453.52' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='562.63' y1='453.52' x2='566.20' y2='457.08' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='561.90' y1='455.30' x2='566.94' y2='455.30' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.42' y1='457.82' x2='564.42' y2='452.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.13' y1='423.73' x2='606.69' y2='420.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.13' y1='420.17' x2='606.69' y2='423.73' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.39' y1='421.95' x2='607.43' y2='421.95' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.91' y1='424.47' x2='604.91' y2='419.43' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.13' y1='414.25' x2='606.69' y2='410.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.13' y1='410.69' x2='606.69' y2='414.25' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.39' y1='412.47' x2='607.43' y2='412.47' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.91' y1='414.99' x2='604.91' y2='409.95' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='625.41' y1='412.99' x2='628.98' y2='409.43' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='625.41' y1='409.43' x2='628.98' y2='412.99' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='624.68' y1='411.21' x2='629.72' y2='411.21' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.20' y1='413.73' x2='627.20' y2='408.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='625.41' y1='450.91' x2='628.98' y2='447.35' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='625.41' y1='447.35' x2='628.98' y2='450.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='624.68' y1='449.13' x2='629.72' y2='449.13' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.20' y1='451.65' x2='627.20' y2='446.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.42' y1='428.77' x2='634.98' y2='425.21' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.42' y1='425.21' x2='634.98' y2='428.77' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.68' y1='426.99' x2='635.72' y2='426.99' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.20' y1='429.51' x2='633.20' y2='424.47' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.42' y1='452.15' x2='634.98' y2='448.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.42' y1='448.59' x2='634.98' y2='452.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.68' y1='450.37' x2='635.72' y2='450.37' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.20' y1='452.89' x2='633.20' y2='447.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.21' y1='416.33' x2='635.77' y2='412.76' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.21' y1='412.76' x2='635.77' y2='416.33' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.47' y1='414.55' x2='636.51' y2='414.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.99' y1='417.07' x2='633.99' y2='412.03' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.21' y1='448.56' x2='635.77' y2='445.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.21' y1='445.00' x2='635.77' y2='448.56' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.47' y1='446.78' x2='636.51' y2='446.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.99' y1='449.30' x2='633.99' y2='444.26' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='424.36' y1='424.93' x2='429.40' y2='424.93' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='426.88' y1='427.45' x2='426.88' y2='422.41' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='424.36,424.93 426.88,422.41 429.40,424.93 426.88,427.45 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='424.36' y1='430.63' x2='429.40' y2='430.63' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='426.88' y1='433.15' x2='426.88' y2='428.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='424.36,430.63 426.88,428.11 429.40,430.63 426.88,433.15 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.02' y1='425.63' x2='459.06' y2='425.63' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='456.54' y1='428.15' x2='456.54' y2='423.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='454.02,425.63 456.54,423.11 459.06,425.63 456.54,428.15 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.02' y1='434.19' x2='459.06' y2='434.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='456.54' y1='436.71' x2='456.54' y2='431.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='454.02,434.19 456.54,431.67 459.06,434.19 456.54,436.71 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='500.83' y1='428.90' x2='505.87' y2='428.90' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='503.35' y1='431.42' x2='503.35' y2='426.38' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='500.83,428.90 503.35,426.38 505.87,428.90 503.35,431.42 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='500.83' y1='441.45' x2='505.87' y2='441.45' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='503.35' y1='443.97' x2='503.35' y2='438.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='500.83,441.45 503.35,438.92 505.87,441.45 503.35,443.97 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='555.38' y1='430.93' x2='560.42' y2='430.93' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='557.90' y1='433.46' x2='557.90' y2='428.41' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='555.38,430.93 557.90,428.41 560.42,430.93 557.90,433.46 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='555.38' y1='432.08' x2='560.42' y2='432.08' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='557.90' y1='434.60' x2='557.90' y2='429.56' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='555.38,432.08 557.90,429.56 560.42,432.08 557.90,434.60 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='612.02' y1='426.96' x2='617.06' y2='426.96' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='614.54' y1='429.48' x2='614.54' y2='424.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.02,426.96 614.54,424.44 617.06,426.96 614.54,429.48 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='612.02' y1='446.92' x2='617.06' y2='446.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='614.54' y1='449.44' x2='614.54' y2='444.40' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.02,446.92 614.54,444.40 617.06,446.92 614.54,449.44 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='661.70' y1='427.24' x2='666.74' y2='427.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='664.22' y1='429.76' x2='664.22' y2='424.72' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='661.70,427.24 664.22,424.72 666.74,427.24 664.22,429.76 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='661.70' y1='417.54' x2='666.74' y2='417.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='664.22' y1='420.06' x2='664.22' y2='415.02' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='661.70,417.54 664.22,415.02 666.74,417.54 664.22,420.06 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='679.58' y1='444.16' x2='684.62' y2='444.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='682.10' y1='446.68' x2='682.10' y2='441.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='679.58,444.16 682.10,441.64 684.62,444.16 682.10,446.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='679.58' y1='439.60' x2='684.62' y2='439.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='682.10' y1='442.12' x2='682.10' y2='437.08' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='679.58,439.60 682.10,437.08 684.62,439.60 682.10,442.12 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='685.01' y1='422.50' x2='690.05' y2='422.50' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.53' y1='425.02' x2='687.53' y2='419.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='685.01,422.50 687.53,419.98 690.05,422.50 687.53,425.02 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='685.01' y1='436.19' x2='690.05' y2='436.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.53' y1='438.71' x2='687.53' y2='433.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='685.01,436.19 687.53,433.67 690.05,436.19 687.53,438.71 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.76' cy='432.45' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.98' y1='432.45' x2='421.54' y2='432.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.76' y1='434.23' x2='419.76' y2='430.67' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.76' cy='438.64' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.98' y1='438.64' x2='421.54' y2='438.64' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.76' y1='440.42' x2='419.76' y2='436.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='437.75' cy='441.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.97' y1='441.18' x2='439.54' y2='441.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='437.75' y1='442.96' x2='437.75' y2='439.40' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='437.75' cy='433.22' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.97' y1='433.22' x2='439.54' y2='433.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='437.75' y1='435.00' x2='437.75' y2='431.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='469.19' cy='429.85' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='467.41' y1='429.85' x2='470.97' y2='429.85' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='469.19' y1='431.63' x2='469.19' y2='428.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='469.19' cy='421.89' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='467.41' y1='421.89' x2='470.97' y2='421.89' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='469.19' y1='423.67' x2='469.19' y2='420.10' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='512.66' cy='428.23' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.88' y1='428.23' x2='514.44' y2='428.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.66' y1='430.02' x2='512.66' y2='426.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='512.66' cy='432.66' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.88' y1='432.66' x2='514.44' y2='432.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.66' y1='434.44' x2='512.66' y2='430.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='570.87' cy='419.07' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='569.08' y1='419.07' x2='572.65' y2='419.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='570.87' y1='420.85' x2='570.87' y2='417.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='570.87' cy='420.84' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='569.08' y1='420.84' x2='572.65' y2='420.84' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='570.87' y1='422.62' x2='570.87' y2='419.05' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='637.53' cy='438.25' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.75' y1='438.25' x2='639.32' y2='438.25' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.53' y1='440.03' x2='637.53' y2='436.47' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='637.53' cy='455.94' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.75' y1='455.94' x2='639.32' y2='455.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.53' y1='457.72' x2='637.53' y2='454.16' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='666.57' cy='443.74' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='664.79' y1='443.74' x2='668.35' y2='443.74' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='666.57' y1='445.53' x2='666.57' y2='441.96' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='666.57' cy='426.94' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='664.79' y1='426.94' x2='668.35' y2='426.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='666.57' y1='428.72' x2='666.57' y2='425.15' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='680.95' cy='433.02' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='679.17' y1='433.02' x2='682.73' y2='433.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='680.95' y1='434.80' x2='680.95' y2='431.24' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='680.95' cy='419.75' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='679.17' y1='419.75' x2='682.73' y2='419.75' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='680.95' y1='421.53' x2='680.95' y2='417.97' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.48,432.89 418.88,428.04 414.08,428.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.48,427.34 418.88,432.19 414.08,432.19 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.48,431.53 418.88,426.68 414.08,426.68 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.48,425.99 418.88,430.84 414.08,430.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='428.37,444.22 430.77,439.37 425.97,439.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='428.37,438.67 430.77,443.52 425.97,443.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='428.37,431.35 430.77,426.50 425.97,426.50 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='428.37,425.81 430.77,430.66 425.97,430.66 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='449.15,439.14 451.55,434.29 446.75,434.29 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='449.15,433.60 451.55,438.45 446.75,438.45 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='449.15,442.52 451.55,437.67 446.75,437.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='449.15,436.98 451.55,441.83 446.75,441.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='477.96,433.61 480.36,428.76 475.56,428.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='477.96,428.07 480.36,432.91 475.56,432.91 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='477.96,445.80 480.36,440.95 475.56,440.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='477.96,440.26 480.36,445.11 475.56,445.11 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='516.78,442.05 519.18,437.20 514.38,437.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='516.78,436.50 519.18,441.35 514.38,441.35 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='516.78,419.02 519.18,414.17 514.38,414.17 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='516.78,413.48 519.18,418.33 514.38,418.33 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='561.65,419.35 564.05,414.50 559.25,414.50 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='561.65,413.81 564.05,418.66 559.25,418.66 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='561.65,433.58 564.05,428.73 559.25,428.73 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='561.65,428.03 564.05,432.88 559.25,432.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='580.52,447.34 582.92,442.49 578.12,442.49 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='580.52,441.80 582.92,446.65 578.12,446.65 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='580.52,448.70 582.92,443.85 578.12,443.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='580.52,443.16 582.92,448.01 578.12,448.01 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='588.37,426.37 590.77,421.52 585.97,421.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='588.37,420.83 590.77,425.68 585.97,425.68 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='588.37,433.82 590.77,428.97 585.97,428.97 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='588.37,428.28 590.77,433.13 585.97,433.13 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.41' y1='437.02' x2='417.98' y2='437.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.19' y1='438.80' x2='416.19' y2='435.24' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='414.41' y='435.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.41' y1='422.80' x2='417.98' y2='422.80' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.19' y1='424.59' x2='416.19' y2='421.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='414.41' y='421.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='425.98' y1='427.46' x2='429.54' y2='427.46' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.76' y1='429.24' x2='427.76' y2='425.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='425.98' y='425.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='425.98' y1='425.52' x2='429.54' y2='425.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.76' y1='427.30' x2='427.76' y2='423.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='425.98' y='423.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='446.94' y1='428.62' x2='450.50' y2='428.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='448.72' y1='430.40' x2='448.72' y2='426.84' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='446.94' y='426.84' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='446.94' y1='433.14' x2='450.50' y2='433.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='448.72' y1='434.92' x2='448.72' y2='431.36' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='446.94' y='431.36' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='477.62' y1='428.58' x2='481.18' y2='428.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='479.40' y1='430.36' x2='479.40' y2='426.80' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='477.62' y='426.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='477.62' y1='433.10' x2='481.18' y2='433.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='479.40' y1='434.89' x2='479.40' y2='431.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='477.62' y='431.32' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='521.70' y1='436.45' x2='525.26' y2='436.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='523.48' y1='438.23' x2='523.48' y2='434.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='521.70' y='434.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='521.70' y1='437.10' x2='525.26' y2='437.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='523.48' y1='438.88' x2='523.48' y2='435.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='521.70' y='435.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='573.06' y1='425.00' x2='576.63' y2='425.00' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='574.84' y1='426.78' x2='574.84' y2='423.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='573.06' y='423.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='573.06' y1='435.98' x2='576.63' y2='435.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='574.84' y1='437.77' x2='574.84' y2='434.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='573.06' y='434.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='593.01' y1='422.49' x2='596.57' y2='422.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='594.79' y1='424.27' x2='594.79' y2='420.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='593.01' y='420.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='593.01' y1='444.46' x2='596.57' y2='444.46' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='594.79' y1='446.24' x2='594.79' y2='442.68' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='593.01' y='442.68' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.24' y1='418.82' x2='605.80' y2='418.82' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.02' y1='420.61' x2='604.02' y2='417.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='602.24' y='417.04' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.24' y1='445.31' x2='605.80' y2='445.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.02' y1='447.09' x2='604.02' y2='443.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='602.24' y='443.53' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='416.95' cy='434.31' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.17' y1='436.09' x2='418.74' y2='432.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.17' y1='432.53' x2='418.74' y2='436.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='416.95' cy='440.69' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.17' y1='442.47' x2='418.74' y2='438.91' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.17' y1='438.91' x2='418.74' y2='442.47' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='429.90' cy='429.92' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.12' y1='431.70' x2='431.68' y2='428.14' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.12' y1='428.14' x2='431.68' y2='431.70' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='429.90' cy='418.76' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.12' y1='420.54' x2='431.68' y2='416.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.12' y1='416.98' x2='431.68' y2='420.54' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='453.11' cy='428.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.33' y1='430.54' x2='454.89' y2='426.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.33' y1='426.97' x2='454.89' y2='430.54' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='453.11' cy='437.52' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.33' y1='439.31' x2='454.89' y2='435.74' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.33' y1='435.74' x2='454.89' y2='439.31' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='486.39' cy='440.92' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.61' y1='442.70' x2='488.17' y2='439.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.61' y1='439.13' x2='488.17' y2='442.70' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='486.39' cy='429.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.61' y1='431.54' x2='488.17' y2='427.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.61' y1='427.97' x2='488.17' y2='431.54' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='532.17' cy='427.37' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='530.39' y1='429.15' x2='533.95' y2='425.59' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='530.39' y1='425.59' x2='533.95' y2='429.15' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='532.17' cy='444.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='530.39' y1='446.69' x2='533.95' y2='443.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='530.39' y1='443.12' x2='533.95' y2='446.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='579.86' cy='438.67' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='578.08' y1='440.45' x2='581.64' y2='436.89' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='578.08' y1='436.89' x2='581.64' y2='440.45' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='579.86' cy='410.77' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='578.08' y1='412.55' x2='581.64' y2='408.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='578.08' y1='408.98' x2='581.64' y2='412.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='594.48' cy='458.82' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.70' y1='460.60' x2='596.26' y2='457.04' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.70' y1='457.04' x2='596.26' y2='460.60' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='594.48' cy='415.77' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.70' y1='417.55' x2='596.26' y2='413.99' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.70' y1='413.99' x2='596.26' y2='417.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='599.20' cy='433.97' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.42' y1='435.76' x2='600.98' y2='432.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.42' y1='432.19' x2='600.98' y2='435.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='599.20' cy='429.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.42' y1='430.97' x2='600.98' y2='427.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.42' y1='427.41' x2='600.98' y2='430.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='423.14,434.69 424.92,438.25 421.35,438.25 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.35' y='434.69' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='423.14,428.57 424.92,432.14 421.35,432.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.35' y='428.57' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='446.07,432.14 447.85,435.70 444.29,435.70 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='444.29' y='432.14' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='446.07,435.63 447.85,439.19 444.29,439.19 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='444.29' y='435.63' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='482.02,455.45 483.80,459.01 480.24,459.01 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='480.24' y='455.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='482.02,424.00 483.80,427.56 480.24,427.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='480.24' y='424.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='523.65,424.98 525.44,428.54 521.87,428.54 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='521.87' y='424.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='523.65,435.46 525.44,439.03 521.87,439.03 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='521.87' y='435.46' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.15,450.50 568.93,454.06 565.37,454.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='565.37' y='450.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.15,426.91 568.93,430.48 565.37,430.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='565.37' y='426.91' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='605.77,427.02 607.55,430.58 603.99,430.58 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='603.99' y='427.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='605.77,401.68 607.55,405.25 603.99,405.25 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='603.99' y='401.68' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='617.55,448.48 619.34,452.04 615.77,452.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='615.77' y='448.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='617.55,411.79 619.34,415.35 615.77,415.35 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='615.77' y='411.79' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.02,441.29 619.80,444.86 616.24,444.86 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='616.24' y='441.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.02,432.56 619.80,436.12 616.24,436.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='616.24' y='432.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.34,430.22 424.91,430.22 424.91,426.66 421.34,426.66 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.34,436.10 424.91,436.10 424.91,432.53 421.34,432.53 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='444.31,438.60 447.87,438.60 447.87,435.04 444.31,435.04 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='444.31,431.55 447.87,431.55 447.87,427.99 444.31,427.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='480.34,461.89 483.90,461.89 483.90,458.33 480.34,458.33 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='480.34,417.23 483.90,417.23 483.90,413.66 480.34,413.66 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='521.64,463.73 525.20,463.73 525.20,460.17 521.64,460.17 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='521.64,441.40 525.20,441.40 525.20,437.84 521.64,437.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='562.76,433.49 566.32,433.49 566.32,429.93 562.76,429.93 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='562.76,435.84 566.32,435.84 566.32,432.28 562.76,432.28 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='598.19,415.67 601.76,415.67 601.76,412.10 598.19,412.10 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='598.19,414.49 601.76,414.49 601.76,410.93 598.19,410.93 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='615.17,417.07 618.74,417.07 618.74,413.50 615.17,413.50 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='615.17,435.87 618.74,435.87 618.74,432.31 615.17,432.31 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='626.07,416.01 629.64,416.01 629.64,412.44 626.07,412.44 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='626.07,477.12 629.64,477.12 629.64,473.56 626.07,473.56 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+</svg>
diff --git a/tests/figs/plotting/mixed-model-fit-for-nlme-object.svg b/tests/figs/plotting/mixed-model-fit-for-nlme-object.svg
new file mode 100644
index 00000000..4ac2d738
--- /dev/null
+++ b/tests/figs/plotting/mixed-model-fit-for-nlme-object.svg
@@ -0,0 +1,2482 @@
+<?xml version='1.0' encoding='UTF-8' ?>
+<svg xmlns='http://www.w3.org/2000/svg' xmlns:xlink='http://www.w3.org/1999/xlink' viewBox='0 0 720.00 576.00'>
+<defs>
+ <style type='text/css'><![CDATA[
+ line, polyline, polygon, path, rect, circle {
+ fill: none;
+ stroke: #000000;
+ stroke-linecap: round;
+ stroke-linejoin: round;
+ stroke-miterlimit: 10.00;
+ }
+ ]]></style>
+</defs>
+<rect width='100%' height='100%' style='stroke: none; fill: #FFFFFF;'/>
+<defs>
+ <clipPath id='cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA='>
+ <rect x='19.96' y='5.70' width='680.08' height='75.63' />
+ </clipPath>
+</defs>
+<line x1='238.69' y1='29.26' x2='252.94' y2='29.26' style='stroke-width: 1.50;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='38.77' x2='252.94' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='48.27' x2='252.94' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='57.77' x2='252.94' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='29.26' x2='313.78' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='38.77' x2='313.78' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='48.27' x2='313.78' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='57.77' x2='313.78' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='29.26' x2='374.61' y2='29.26' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='38.77' x2='374.61' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='48.27' x2='374.61' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='57.77' x2='374.61' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='29.26' x2='435.45' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='38.77' x2='435.45' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='48.27' x2='435.45' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='57.77' x2='435.45' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='245.81' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='245.81,45.50 248.21,49.66 243.41,49.66 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='243.29' y1='57.77' x2='248.33' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='245.81' y1='60.29' x2='245.81' y2='55.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='31.04' x2='308.43' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='27.48' x2='308.43' y2='31.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='304.13,38.77 306.65,36.25 309.17,38.77 306.65,41.29 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='306.65,51.04 309.05,46.89 304.25,46.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='304.87' y='55.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='59.56' x2='308.43' y2='55.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='55.99' x2='308.43' y2='59.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='31.04' x2='369.27' y2='27.48' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='27.48' x2='369.27' y2='31.04' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='29.26' x2='370.00' y2='29.26' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='31.78' x2='367.48' y2='26.74' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='38.77' x2='370.00' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='41.29' x2='367.48' y2='36.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='364.96,38.77 367.48,36.25 370.00,38.77 367.48,41.29 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='367.48' cy='48.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='48.27' x2='369.27' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='50.05' x2='367.48' y2='46.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,60.55 369.88,55.70 365.08,55.70 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,55.00 369.88,59.85 365.08,59.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='29.26' x2='430.10' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='428.32' y1='31.04' x2='428.32' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='27.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='428.32' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='40.55' x2='430.10' y2='36.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='36.98' x2='430.10' y2='40.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='428.32,46.49 430.10,50.05 426.54,50.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='46.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='426.54,59.56 430.10,59.56 430.10,55.99 426.54,55.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='37.31px' lengthAdjust='spacingAndGlyphs'>Population</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>1</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>3</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>5</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>6</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>7</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>8</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>9</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.19px' lengthAdjust='spacingAndGlyphs'>11</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>12</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>13</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>14</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>15</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<polyline points='50.12,124.58 52.44,128.85 55.81,134.81 57.09,137.00 61.50,144.26 66.38,151.80 67.19,153.00 72.87,161.09 78.56,168.59 82.64,173.62 84.25,175.54 89.94,181.98 95.63,187.97 101.32,193.53 107.01,198.70 112.70,203.51 115.16,205.49 118.39,207.99 124.08,212.17 129.77,216.06 135.46,219.70 141.15,223.10 146.83,226.27 152.52,229.25 158.21,232.03 163.90,234.64 169.59,237.09 175.28,239.39 180.97,241.55 186.66,243.58 189.50,244.55 192.35,245.49 198.04,247.29 203.73,248.99 209.42,250.59 215.11,252.10 220.79,253.52 226.48,254.87 232.17,256.14 237.86,257.34 243.55,258.48 249.24,259.56 254.93,260.59 259.20,261.32 260.62,261.56 266.31,262.48 272.00,263.35 277.69,264.18 283.38,264.97 289.07,265.72 294.76,266.43 300.44,267.11 306.13,267.76 311.82,268.37 317.51,268.96 323.20,269.52 328.89,270.05 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='288.88' x2='328.89' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='288.88' x2='50.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='288.88' x2='96.58' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='288.88' x2='143.04' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='288.88' x2='189.50' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='288.88' x2='235.97' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='288.88' x2='282.43' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='288.88' x2='328.89' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='281.96' x2='38.97' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='281.96' x2='34.21' y2='281.96' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='250.60' x2='34.21' y2='250.60' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='219.24' x2='34.21' y2='219.24' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='187.88' x2='34.21' y2='187.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='156.51' x2='34.21' y2='156.51' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='125.15' x2='34.21' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,284.16) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,254.99) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,223.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,192.27) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,160.90) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,131.74) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<polygon points='38.97,288.88 340.04,288.88 340.04,102.24 38.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5'>
+ <rect x='0.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text x='180.87' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text transform='translate(8.55,206.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='22.41px' lengthAdjust='spacingAndGlyphs'>parent</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<circle cx='50.12' cy='117.47' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='130.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='129.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='142.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='156.51' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='131.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='160.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='166.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='174.55' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='183.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='203.87' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='200.58' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.16' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.00' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='246.99' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='247.46' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='253.27' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='254.68' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.17 52.44,131.83 55.81,139.39 57.09,142.09 61.50,150.69 66.38,159.08 67.19,160.37 72.87,168.71 78.56,175.93 82.64,180.52 84.25,182.21 89.94,187.71 95.63,192.55 101.32,196.84 107.01,200.67 112.70,204.10 115.16,205.48 118.39,207.20 124.08,210.03 129.77,212.61 135.46,214.99 141.15,217.19 146.83,219.24 152.52,221.17 158.21,222.97 163.90,224.68 169.59,226.30 175.28,227.85 180.97,229.32 186.66,230.73 189.50,231.42 192.35,232.09 198.04,233.40 203.73,234.65 209.42,235.87 215.11,237.04 220.79,238.18 226.48,239.28 232.17,240.35 237.86,241.39 243.55,242.40 249.24,243.39 254.93,244.34 259.20,245.04 260.62,245.27 266.31,246.18 272.00,247.06 277.69,247.92 283.38,248.75 289.07,249.57 294.76,250.36 300.44,251.14 306.13,251.89 311.82,252.63 317.51,253.34 323.20,254.04 328.89,254.73 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,120.34 52.52,124.50 47.72,124.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.01 52.52,127.16 47.72,127.16 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,130.38 54.84,134.53 50.04,134.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,128.65 54.84,132.81 50.04,132.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.43 59.49,141.59 54.69,141.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.51 59.49,145.67 54.69,145.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,141.67 68.78,145.82 63.98,145.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.23 68.78,155.39 63.98,155.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,169.27 85.04,173.42 80.24,173.42 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,161.43 85.04,165.58 80.24,165.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,202.51 117.56,206.67 112.76,206.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,205.49 117.56,209.65 112.76,209.65 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,232.46 191.90,236.62 187.10,236.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.23 191.90,232.39 187.10,232.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.42 261.60,242.58 256.80,242.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.46 261.60,244.62 256.80,244.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,248.46 331.29,252.61 326.49,252.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.44 331.29,255.59 326.49,255.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.23 52.44,129.71 55.81,135.87 57.09,138.11 61.50,145.44 66.38,152.89 67.19,154.06 72.87,161.84 78.56,168.87 82.64,173.49 84.25,175.23 89.94,181.00 95.63,186.24 101.32,191.01 107.01,195.36 112.70,199.33 115.16,200.95 118.39,202.97 124.08,206.32 129.77,209.39 135.46,212.23 141.15,214.85 146.83,217.28 152.52,219.54 158.21,221.64 163.90,223.61 169.59,225.45 175.28,227.18 180.97,228.80 186.66,230.34 189.50,231.07 192.35,231.79 198.04,233.16 203.73,234.47 209.42,235.71 215.11,236.89 220.79,238.02 226.48,239.11 232.17,240.15 237.86,241.15 243.55,242.11 249.24,243.03 254.93,243.93 259.20,244.57 260.62,244.79 266.31,245.62 272.00,246.43 277.69,247.21 283.38,247.97 289.07,248.71 294.76,249.43 300.44,250.12 306.13,250.80 311.82,251.46 317.51,252.11 323.20,252.73 328.89,253.34 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='141.15' x2='52.64' y2='141.15' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='143.67' x2='50.12' y2='138.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='127.97' x2='52.64' y2='127.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='130.49' x2='50.12' y2='125.45' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='126.25' x2='54.96' y2='126.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='128.77' x2='52.44' y2='123.73' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='129.86' x2='59.61' y2='129.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='132.38' x2='57.09' y2='127.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.68' x2='59.61' y2='140.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.20' x2='57.09' y2='138.16' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='150.55' x2='68.90' y2='150.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='153.07' x2='66.38' y2='148.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='152.12' x2='68.90' y2='152.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='154.64' x2='66.38' y2='149.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='164.04' x2='85.16' y2='164.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.56' x2='82.64' y2='161.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='175.49' x2='85.16' y2='175.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='178.01' x2='82.64' y2='172.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='193.84' x2='117.68' y2='193.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='196.36' x2='115.16' y2='191.31' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='196.81' x2='117.68' y2='196.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='199.33' x2='115.16' y2='194.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='234.29' x2='192.02' y2='234.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='236.81' x2='189.50' y2='231.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='237.43' x2='192.02' y2='237.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='239.95' x2='189.50' y2='234.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='267.54' x2='331.41' y2='267.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.06' x2='328.89' y2='265.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='263.77' x2='331.41' y2='263.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='266.29' x2='328.89' y2='261.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.05 52.44,129.73 55.81,134.87 57.09,136.77 61.50,143.09 66.38,149.68 67.19,150.73 72.87,157.87 78.56,164.52 82.64,169.01 84.25,170.73 89.94,176.53 95.63,181.95 101.32,187.02 107.01,191.77 112.70,196.22 115.16,198.07 118.39,200.40 124.08,204.32 129.77,208.00 135.46,211.46 141.15,214.71 146.83,217.77 152.52,220.66 158.21,223.39 163.90,225.96 169.59,228.38 175.28,230.68 180.97,232.85 186.66,234.91 189.50,235.90 192.35,236.86 198.04,238.70 203.73,240.46 209.42,242.12 215.11,243.70 220.79,245.21 226.48,246.64 232.17,248.01 237.86,249.31 243.55,250.55 249.24,251.73 254.93,252.86 259.20,253.67 260.62,253.94 266.31,254.97 272.00,255.95 277.69,256.90 283.38,257.80 289.07,258.67 294.76,259.50 300.44,260.29 306.13,261.05 311.82,261.79 317.51,262.49 323.20,263.17 328.89,263.81 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='124.58' x2='51.90' y2='121.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='121.02' x2='51.90' y2='124.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.17' x2='51.90' y2='119.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='119.61' x2='51.90' y2='123.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='121.92' x2='54.22' y2='118.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='118.35' x2='54.22' y2='121.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.14' x2='54.22' y2='138.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='138.58' x2='54.22' y2='142.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.71' x2='58.87' y2='140.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.15' x2='58.87' y2='143.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.87' x2='58.87' y2='140.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.30' x2='58.87' y2='143.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.57' x2='68.16' y2='145.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.01' x2='68.16' y2='148.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='164.10' x2='68.16' y2='160.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.53' x2='68.16' y2='164.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='176.49' x2='84.42' y2='172.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='172.92' x2='84.42' y2='176.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='167.55' x2='84.42' y2='163.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='163.98' x2='84.42' y2='167.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.83' x2='116.95' y2='199.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.27' x2='116.95' y2='202.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.18' x2='116.95' y2='201.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.62' x2='116.95' y2='205.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.31' x2='191.29' y2='236.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.74' x2='191.29' y2='240.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.15' x2='191.29' y2='236.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.59' x2='191.29' y2='240.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.50' x2='260.98' y2='254.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='254.93' x2='260.98' y2='258.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.97' x2='260.98' y2='255.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.41' x2='260.98' y2='258.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='269.32' x2='330.67' y2='265.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='265.75' x2='330.67' y2='269.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.57' x2='330.67' y2='267.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.01' x2='330.67' y2='270.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.37 52.44,129.39 55.81,134.99 57.09,137.06 61.50,143.91 66.38,151.04 67.19,152.18 72.87,159.85 78.56,166.98 82.64,171.78 84.25,173.61 89.94,179.77 95.63,185.51 101.32,190.85 107.01,195.83 112.70,200.48 115.16,202.39 118.39,204.81 124.08,208.87 129.77,212.66 135.46,216.20 141.15,219.52 146.83,222.64 152.52,225.56 158.21,228.30 163.90,230.88 169.59,233.30 175.28,235.58 180.97,237.73 186.66,239.75 189.50,240.72 192.35,241.66 198.04,243.47 203.73,245.17 209.42,246.78 215.11,248.31 220.79,249.75 226.48,251.12 232.17,252.42 237.86,253.65 243.55,254.82 249.24,255.94 254.93,256.99 259.20,257.75 260.62,258.00 266.31,258.96 272.00,259.87 277.69,260.74 283.38,261.57 289.07,262.37 294.76,263.12 300.44,263.85 306.13,264.54 311.82,265.20 317.51,265.83 323.20,266.44 328.89,267.02 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.86 50.12,111.34 52.64,113.86 50.12,116.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.39 50.12,110.87 52.64,113.39 50.12,115.91 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,133.31 52.44,130.79 54.96,133.31 52.44,135.83 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,145.85 52.44,143.33 54.96,145.85 52.44,148.37 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.91 57.09,142.39 59.61,144.91 57.09,147.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.44 57.09,141.92 59.61,144.44 57.09,146.96 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.67 66.38,162.15 68.90,164.67 66.38,167.19 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,168.75 66.38,166.22 68.90,168.75 66.38,171.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,193.21 82.64,190.69 85.16,193.21 82.64,195.73 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,190.86 82.64,188.34 85.16,190.86 82.64,193.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,207.95 115.16,205.43 117.68,207.95 115.16,210.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,206.69 115.16,204.17 117.68,206.69 115.16,209.21 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,239.00 189.50,236.48 192.02,239.00 189.50,241.52 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,234.29 189.50,231.77 192.02,234.29 189.50,236.81 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,251.70 259.20,249.18 261.72,251.70 259.20,254.22 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,250.60 259.20,248.08 261.72,250.60 259.20,253.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,260.48 328.89,257.96 331.41,260.48 328.89,263.00 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,261.26 328.89,258.74 331.41,261.26 328.89,263.78 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.45 52.44,131.69 55.81,142.22 57.09,145.84 61.50,156.90 66.38,167.01 67.19,168.50 72.87,177.77 78.56,185.27 82.64,189.81 84.25,191.44 89.94,196.59 95.63,200.97 101.32,204.74 107.01,208.05 112.70,211.00 115.16,212.19 118.39,213.67 124.08,216.11 129.77,218.37 135.46,220.48 141.15,222.46 146.83,224.34 152.52,226.13 158.21,227.84 163.90,229.48 169.59,231.06 175.28,232.58 180.97,234.05 186.66,235.47 189.50,236.16 192.35,236.84 198.04,238.17 203.73,239.46 209.42,240.70 215.11,241.91 220.79,243.09 226.48,244.23 232.17,245.33 237.86,246.40 243.55,247.44 249.24,248.45 254.93,249.43 259.20,250.15 260.62,250.39 266.31,251.31 272.00,252.20 277.69,253.07 283.38,253.92 289.07,254.74 294.76,255.53 300.44,256.31 306.13,257.06 311.82,257.78 317.51,258.49 323.20,259.18 328.89,259.84 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.69 52.52,119.53 47.72,119.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.06 52.52,118.90 47.72,118.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,138.12 54.84,133.96 50.04,133.96 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,143.45 54.84,139.29 50.04,139.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.80 59.49,133.64 54.69,133.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.39 59.49,140.23 54.69,140.23 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.29 68.78,147.13 63.98,147.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,150.66 68.78,146.50 63.98,146.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.14 85.04,167.99 80.24,167.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.88 85.04,182.73 80.24,182.73 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,191.27 117.56,187.12 112.76,187.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.29 117.56,200.13 112.76,200.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.75 191.90,224.60 187.10,224.60 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,230.79 191.90,226.63 187.10,226.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.36 261.60,236.20 256.80,236.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,241.30 261.60,237.14 256.80,237.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,250.08 331.29,245.92 326.49,245.92 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,253.37 331.29,249.22 326.49,249.22 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.17 52.44,129.71 55.81,135.91 57.09,138.16 61.50,145.46 66.38,152.81 67.19,153.95 72.87,161.53 78.56,168.30 82.64,172.71 84.25,174.37 89.94,179.81 95.63,184.72 101.32,189.15 107.01,193.16 112.70,196.81 115.16,198.29 118.39,200.13 124.08,203.17 129.77,205.96 135.46,208.53 141.15,210.90 146.83,213.10 152.52,215.15 158.21,217.06 163.90,218.85 169.59,220.53 175.28,222.12 180.97,223.62 186.66,225.04 189.50,225.72 192.35,226.39 198.04,227.68 203.73,228.92 209.42,230.10 215.11,231.23 220.79,232.32 226.48,233.38 232.17,234.39 237.86,235.38 243.55,236.33 249.24,237.25 254.93,238.15 259.20,238.81 260.62,239.02 266.31,239.87 272.00,240.70 277.69,241.51 283.38,242.29 289.07,243.06 294.76,243.81 300.44,244.54 306.13,245.25 311.82,245.95 317.51,246.64 323.20,247.31 328.89,247.96 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='130.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='133.83' x2='51.90' y2='130.27' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.27' x2='51.90' y2='133.83' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='115.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='118.78' x2='51.90' y2='115.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.22' x2='51.90' y2='118.78' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='127.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='130.70' x2='54.22' y2='127.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.13' x2='54.22' y2='130.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='137.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='140.89' x2='54.22' y2='137.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='137.33' x2='54.22' y2='140.89' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='159.59' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='163.16' x2='58.87' y2='159.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='159.59' x2='58.87' y2='163.16' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='142.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='146.53' x2='58.87' y2='142.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='142.97' x2='58.87' y2='146.53' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='173.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='177.43' x2='68.16' y2='173.86' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.86' x2='68.16' y2='177.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='154.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='157.98' x2='68.16' y2='154.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.42' x2='68.16' y2='157.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='190.44' x2='84.42' y2='186.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='186.88' x2='84.42' y2='190.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='191.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='195.15' x2='84.42' y2='191.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='191.58' x2='84.42' y2='195.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='225.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='229.49' x2='116.95' y2='225.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.92' x2='116.95' y2='229.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='224.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='227.76' x2='116.95' y2='224.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.20' x2='116.95' y2='227.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='258.97' x2='191.29' y2='255.41' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.41' x2='191.29' y2='258.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='259.44' x2='191.29' y2='255.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.88' x2='191.29' y2='259.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='264.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='267.59' x2='260.98' y2='264.03' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='264.03' x2='260.98' y2='267.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='265.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='268.85' x2='260.98' y2='265.28' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='265.28' x2='260.98' y2='268.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='270.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='274.18' x2='330.67' y2='270.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.62' x2='330.67' y2='274.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='267.95' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='271.51' x2='330.67' y2='267.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.95' x2='330.67' y2='271.51' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.59 52.44,132.78 55.81,142.42 57.09,145.86 61.50,156.86 66.38,167.63 67.19,169.27 72.87,179.99 78.56,189.27 82.64,195.16 84.25,197.33 89.94,204.37 95.63,210.53 101.32,215.96 107.01,220.75 112.70,225.01 115.16,226.71 118.39,228.81 124.08,232.21 129.77,235.28 135.46,238.05 141.15,240.57 146.83,242.87 152.52,244.97 158.21,246.91 163.90,248.70 169.59,250.36 175.28,251.91 180.97,253.35 186.66,254.70 189.50,255.34 192.35,255.96 198.04,257.15 203.73,258.27 209.42,259.33 215.11,260.33 220.79,261.28 226.48,262.18 232.17,263.04 237.86,263.85 243.55,264.63 249.24,265.36 254.93,266.07 259.20,266.57 260.62,266.74 266.31,267.38 272.00,267.99 277.69,268.58 283.38,269.14 289.07,269.67 294.76,270.19 300.44,270.68 306.13,271.14 311.82,271.59 317.51,272.02 323.20,272.44 328.89,272.83 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='131.48' x2='51.90' y2='127.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.92' x2='51.90' y2='131.48' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='129.70' x2='52.64' y2='129.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='132.22' x2='50.12' y2='127.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.17' x2='51.90' y2='111.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='111.61' x2='51.90' y2='115.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='113.39' x2='52.64' y2='113.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='115.91' x2='50.12' y2='110.87' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='129.76' x2='54.22' y2='126.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.19' x2='54.22' y2='129.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.97' x2='54.96' y2='127.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='130.49' x2='52.44' y2='125.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='145.59' x2='54.22' y2='142.03' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.03' x2='54.22' y2='145.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='143.81' x2='54.96' y2='143.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='146.33' x2='52.44' y2='141.29' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='149.36' x2='58.87' y2='145.79' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='145.79' x2='58.87' y2='149.36' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='147.58' x2='59.61' y2='147.58' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='150.10' x2='57.09' y2='145.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='165.51' x2='58.87' y2='161.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='161.95' x2='58.87' y2='165.51' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='163.73' x2='59.61' y2='163.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='166.25' x2='57.09' y2='161.21' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.98' x2='68.16' y2='170.41' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='170.41' x2='68.16' y2='173.98' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='172.19' x2='68.90' y2='172.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='174.72' x2='66.38' y2='169.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='179.15' x2='68.16' y2='175.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='175.59' x2='68.16' y2='179.15' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='177.37' x2='68.90' y2='177.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='179.89' x2='66.38' y2='174.85' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='209.73' x2='84.42' y2='206.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='206.17' x2='84.42' y2='209.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='207.95' x2='85.16' y2='207.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='210.47' x2='82.64' y2='205.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='204.24' x2='84.42' y2='200.68' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='200.68' x2='84.42' y2='204.24' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='202.46' x2='85.16' y2='202.46' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='204.98' x2='82.64' y2='199.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='228.39' x2='116.95' y2='224.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.83' x2='116.95' y2='228.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='226.61' x2='117.68' y2='226.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='229.13' x2='115.16' y2='224.09' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.72' x2='116.95' y2='222.16' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='222.16' x2='116.95' y2='225.72' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='223.94' x2='117.68' y2='223.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='226.46' x2='115.16' y2='221.42' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='247.05' x2='191.29' y2='243.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='243.49' x2='191.29' y2='247.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='245.27' x2='192.02' y2='245.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='247.79' x2='189.50' y2='242.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='246.11' x2='191.29' y2='242.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.55' x2='191.29' y2='246.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.33' x2='192.02' y2='244.33' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.85' x2='189.50' y2='241.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.52' x2='260.98' y2='251.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='251.96' x2='260.98' y2='255.52' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.83' x2='260.98' y2='252.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='252.27' x2='260.98' y2='255.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='254.05' x2='261.72' y2='254.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.57' x2='259.20' y2='251.53' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='263.67' x2='330.67' y2='260.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.11' x2='330.67' y2='263.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='261.89' x2='331.41' y2='261.89' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.41' x2='328.89' y2='259.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.73' x2='330.67' y2='259.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.17' x2='330.67' y2='262.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='260.95' x2='331.41' y2='260.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.47' x2='328.89' y2='258.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,124.56 52.44,134.69 55.81,147.58 57.09,151.98 61.50,165.33 66.38,177.36 67.19,179.11 72.87,189.87 78.56,198.36 82.64,203.36 84.25,205.13 89.94,210.58 95.63,215.04 101.32,218.74 107.01,221.86 112.70,224.53 115.16,225.58 118.39,226.86 124.08,228.92 129.77,230.77 135.46,232.45 141.15,234.00 146.83,235.45 152.52,236.80 158.21,238.09 163.90,239.31 169.59,240.48 175.28,241.60 180.97,242.68 186.66,243.72 189.50,244.23 192.35,244.73 198.04,245.71 203.73,246.66 209.42,247.58 215.11,248.48 220.79,249.35 226.48,250.20 232.17,251.02 237.86,251.82 243.55,252.60 249.24,253.36 254.93,254.10 259.20,254.65 260.62,254.83 266.31,255.53 272.00,256.21 277.69,256.88 283.38,257.53 289.07,258.16 294.76,258.77 300.44,259.37 306.13,259.96 311.82,260.53 317.51,261.08 323.20,261.62 328.89,262.15 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='109.16' x2='52.64' y2='109.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='111.68' x2='50.12' y2='106.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,109.16 50.12,106.64 52.64,109.16 50.12,111.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='139.11' x2='52.64' y2='139.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='141.63' x2='50.12' y2='136.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,139.11 50.12,136.59 52.64,139.11 50.12,141.63 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,127.19 52.44,124.67 54.96,127.19 52.44,129.71 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='118.25' x2='54.96' y2='118.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='120.77' x2='52.44' y2='115.73' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,118.25 52.44,115.73 54.96,118.25 52.44,120.77 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='149.61' x2='59.61' y2='149.61' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='152.13' x2='57.09' y2='147.09' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,149.61 57.09,147.09 59.61,149.61 57.09,152.13 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.52' x2='59.61' y2='140.52' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.04' x2='57.09' y2='138.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,140.52 57.09,138.00 59.61,140.52 57.09,143.04 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='158.55' x2='68.90' y2='158.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.07' x2='66.38' y2='156.03' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,158.55 66.38,156.03 68.90,158.55 66.38,161.07 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='164.98' x2='68.90' y2='164.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='167.50' x2='66.38' y2='162.46' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.98 66.38,162.46 68.90,164.98 66.38,167.50 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='192.27' x2='85.16' y2='192.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='194.79' x2='82.64' y2='189.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,192.27 82.64,189.75 85.16,192.27 82.64,194.79 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='183.80' x2='85.16' y2='183.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='186.32' x2='82.64' y2='181.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,183.80 82.64,181.28 85.16,183.80 82.64,186.32 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='215.32' x2='117.68' y2='215.32' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='217.84' x2='115.16' y2='212.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,215.32 115.16,212.80 117.68,215.32 115.16,217.84 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='211.08' x2='117.68' y2='211.08' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='213.60' x2='115.16' y2='208.56' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,211.08 115.16,208.56 117.68,211.08 115.16,213.60 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.17' x2='192.02' y2='244.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.69' x2='189.50' y2='241.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,244.17 189.50,241.65 192.02,244.17 189.50,246.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='242.76' x2='192.02' y2='242.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='245.28' x2='189.50' y2='240.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,242.76 189.50,240.24 192.02,242.76 189.50,245.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,253.74 259.20,251.22 261.72,253.74 259.20,256.26 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='258.28' x2='261.72' y2='258.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='260.80' x2='259.20' y2='255.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,258.28 259.20,255.76 261.72,258.28 259.20,260.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='268.16' x2='331.41' y2='268.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.68' x2='328.89' y2='265.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,268.16 328.89,265.64 331.41,268.16 328.89,270.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='262.36' x2='331.41' y2='262.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.88' x2='328.89' y2='259.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,262.36 328.89,259.84 331.41,262.36 328.89,264.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.22 52.44,129.81 55.81,138.63 57.09,141.78 61.50,151.83 66.38,161.67 67.19,163.17 72.87,172.95 78.56,181.42 82.64,186.80 84.25,188.78 89.94,195.21 95.63,200.86 101.32,205.84 107.01,210.26 112.70,214.20 115.16,215.78 118.39,217.74 124.08,220.93 129.77,223.82 135.46,226.46 141.15,228.88 146.83,231.11 152.52,233.17 158.21,235.09 163.90,236.89 169.59,238.57 175.28,240.15 180.97,241.65 186.66,243.06 189.50,243.75 192.35,244.41 198.04,245.69 203.73,246.91 209.42,248.08 215.11,249.20 220.79,250.28 226.48,251.31 232.17,252.30 237.86,253.25 243.55,254.17 249.24,255.06 254.93,255.92 259.20,256.54 260.62,256.74 266.31,257.54 272.00,258.31 277.69,259.05 283.38,259.77 289.07,260.47 294.76,261.14 300.44,261.80 306.13,262.43 311.82,263.04 317.51,263.63 323.20,264.20 328.89,264.76 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='122.80' x2='51.90' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.58' x2='50.12' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='123.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.09' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.09' x2='54.22' y2='126.09' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='127.87' x2='52.44' y2='124.31' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='122.80' x2='54.22' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='124.58' x2='52.44' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='136.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.28' x2='58.87' y2='136.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='138.07' x2='57.09' y2='134.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='139.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.11' x2='58.87' y2='139.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='140.89' x2='57.09' y2='137.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='159.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='159.81' x2='68.16' y2='159.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.59' x2='66.38' y2='158.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='147.58' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='147.58' x2='68.16' y2='147.58' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='149.36' x2='66.38' y2='145.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.14' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.14' x2='84.42' y2='165.14' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.92' x2='82.64' y2='163.36' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.61' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.61' x2='84.42' y2='165.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='167.39' x2='82.64' y2='163.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='202.62' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.62' x2='116.95' y2='202.62' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='204.40' x2='115.16' y2='200.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='191.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='191.17' x2='116.95' y2='191.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='192.95' x2='115.16' y2='189.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.39' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.39' x2='191.29' y2='235.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.17' x2='189.50' y2='233.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.23' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.23' x2='191.29' y2='235.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.02' x2='189.50' y2='233.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='245.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='245.27' x2='260.98' y2='245.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='247.05' x2='259.20' y2='243.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='249.66' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.66' x2='260.98' y2='249.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='251.44' x2='259.20' y2='247.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.73' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.73' x2='330.67' y2='261.73' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.52' x2='328.89' y2='259.95' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='259.38' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.38' x2='330.67' y2='259.38' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='261.16' x2='328.89' y2='257.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.88 52.44,127.88 55.81,133.43 57.09,135.47 61.50,142.20 66.38,149.17 67.19,150.27 72.87,157.70 78.56,164.55 82.64,169.13 84.25,170.87 89.94,176.71 95.63,182.11 101.32,187.12 107.01,191.76 112.70,196.08 115.16,197.86 118.39,200.10 124.08,203.84 129.77,207.33 135.46,210.60 141.15,213.65 146.83,216.52 152.52,219.20 158.21,221.73 163.90,224.11 169.59,226.35 175.28,228.47 180.97,230.47 186.66,232.36 189.50,233.27 192.35,234.16 198.04,235.86 203.73,237.48 209.42,239.02 215.11,240.48 220.79,241.88 226.48,243.22 232.17,244.49 237.86,245.71 243.55,246.88 249.24,248.00 254.93,249.07 259.20,249.85 260.62,250.10 266.31,251.09 272.00,252.05 277.69,252.96 283.38,253.85 289.07,254.70 294.76,255.51 300.44,256.30 306.13,257.07 311.82,257.80 317.51,258.51 323.20,259.20 328.89,259.87 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,131.06 52.52,126.21 47.72,126.21 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,125.52 52.52,130.37 47.72,130.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,129.65 52.52,124.80 47.72,124.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,124.10 52.52,128.95 47.72,128.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,135.45 54.84,130.60 50.04,130.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,129.91 54.84,134.76 50.04,134.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,117.57 54.84,112.72 50.04,112.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,112.03 54.84,116.88 50.04,116.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,140.47 59.49,135.62 54.69,135.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,134.92 59.49,139.77 54.69,139.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.54 59.49,139.69 54.69,139.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,139.00 59.49,143.85 54.69,143.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,142.66 68.78,137.81 63.98,137.81 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,137.12 68.78,141.97 63.98,141.97 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,157.87 68.78,153.02 63.98,153.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,152.33 68.78,157.18 63.98,157.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,168.54 85.04,163.69 80.24,163.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,162.99 85.04,167.84 80.24,167.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.77 85.04,167.92 80.24,167.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,167.23 85.04,172.08 80.24,172.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,188.30 117.56,183.45 112.76,183.45 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,182.75 117.56,187.60 112.76,187.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,183.59 117.56,178.74 112.76,178.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,178.05 117.56,182.90 112.76,182.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,224.21 191.90,219.36 187.10,219.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,218.66 191.90,223.51 187.10,223.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,225.77 191.90,220.92 187.10,220.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,220.23 191.90,225.08 187.10,225.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,244.12 261.60,239.27 256.80,239.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.58 261.60,243.43 256.80,243.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,237.69 261.60,232.84 256.80,232.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,232.15 261.60,237.00 256.80,237.00 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,252.12 331.29,247.27 326.49,247.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.58 331.29,251.42 326.49,251.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.96 331.29,247.11 326.49,247.11 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.42 331.29,251.27 326.49,251.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.44 52.44,128.76 55.81,133.38 57.09,135.08 61.50,140.73 66.38,146.61 67.19,147.55 72.87,153.87 78.56,159.74 82.64,163.69 84.25,165.19 89.94,170.27 95.63,174.99 101.32,179.40 107.01,183.52 112.70,187.37 115.16,188.96 118.39,190.97 124.08,194.35 129.77,197.52 135.46,200.50 141.15,203.30 146.83,205.94 152.52,208.43 158.21,210.78 163.90,213.00 169.59,215.11 175.28,217.11 180.97,219.01 186.66,220.81 189.50,221.68 192.35,222.53 198.04,224.17 203.73,225.74 209.42,227.23 215.11,228.66 220.79,230.03 226.48,231.35 232.17,232.61 237.86,233.82 243.55,234.99 249.24,236.12 254.93,237.20 259.20,237.99 260.62,238.25 266.31,239.26 272.00,240.24 277.69,241.18 283.38,242.10 289.07,242.99 294.76,243.85 300.44,244.68 306.13,245.49 311.82,246.28 317.51,247.05 323.20,247.79 328.89,248.52 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='137.70' x2='51.90' y2='137.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='139.48' x2='50.12' y2='135.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='135.91' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='121.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.50' x2='54.22' y2='127.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.29' x2='52.44' y2='125.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='125.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='132.99' x2='54.22' y2='132.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='134.77' x2='52.44' y2='131.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='131.21' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='120.76' x2='58.87' y2='120.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='122.54' x2='57.09' y2='118.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='118.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.89' x2='58.87' y2='139.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='141.67' x2='57.09' y2='138.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='138.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.28' x2='68.16' y2='160.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='162.06' x2='66.38' y2='158.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='158.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.54' x2='68.16' y2='145.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='147.32' x2='66.38' y2='143.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='143.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='174.23' x2='84.42' y2='174.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='176.02' x2='82.64' y2='172.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='172.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.57' x2='84.42' y2='171.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='173.35' x2='82.64' y2='169.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='169.79' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.52' x2='116.95' y2='201.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='203.30' x2='115.16' y2='199.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='199.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.64' x2='116.95' y2='199.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='201.42' x2='115.16' y2='197.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='197.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.17' x2='191.29' y2='236.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.96' x2='189.50' y2='234.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.49' x2='191.29' y2='236.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='238.27' x2='189.50' y2='234.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.74' x2='260.98' y2='253.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.52' x2='259.20' y2='251.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='251.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.19' x2='260.98' y2='249.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='250.97' x2='259.20' y2='247.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='247.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.32' x2='330.67' y2='260.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='262.11' x2='328.89' y2='258.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='258.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.26' x2='330.67' y2='261.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.05' x2='328.89' y2='259.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='259.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.46 52.44,129.50 55.81,135.11 57.09,137.17 61.50,143.97 66.38,151.01 67.19,152.12 72.87,159.62 78.56,166.54 82.64,171.16 84.25,172.92 89.94,178.81 95.63,184.26 101.32,189.31 107.01,194.00 112.70,198.34 115.16,200.13 118.39,202.39 124.08,206.15 129.77,209.66 135.46,212.94 141.15,216.00 146.83,218.87 152.52,221.56 158.21,224.08 163.90,226.46 169.59,228.69 175.28,230.80 180.97,232.79 186.66,234.67 189.50,235.57 192.35,236.45 198.04,238.13 203.73,239.73 209.42,241.25 215.11,242.70 220.79,244.08 226.48,245.39 232.17,246.64 237.86,247.83 243.55,248.98 249.24,250.07 254.93,251.12 259.20,251.87 260.62,252.12 266.31,253.08 272.00,254.01 277.69,254.90 283.38,255.75 289.07,256.57 294.76,257.36 300.44,258.12 306.13,258.86 311.82,259.56 317.51,260.25 323.20,260.91 328.89,261.54 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='125.31' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.09' x2='51.90' y2='123.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.53' x2='51.90' y2='127.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='128.60' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.38' x2='51.90' y2='126.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='126.82' x2='51.90' y2='130.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.88' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='128.66' x2='54.22' y2='125.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='125.09' x2='54.22' y2='128.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='115.74' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='117.52' x2='54.22' y2='113.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='113.96' x2='54.22' y2='117.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='138.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.42' x2='58.87' y2='136.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.86' x2='58.87' y2='140.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='126.41' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='128.19' x2='58.87' y2='124.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='124.62' x2='58.87' y2='128.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='152.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.69' x2='68.16' y2='151.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.13' x2='68.16' y2='154.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='150.08' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.87' x2='68.16' y2='148.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.30' x2='68.16' y2='151.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='173.61' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='175.39' x2='84.42' y2='171.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.82' x2='84.42' y2='175.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='180.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='181.97' x2='84.42' y2='178.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='178.41' x2='84.42' y2='181.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='205.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='207.53' x2='116.95' y2='203.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='203.97' x2='116.95' y2='207.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='204.03' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.81' x2='116.95' y2='202.25' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.25' x2='116.95' y2='205.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='243.86' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='245.64' x2='191.29' y2='242.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.08' x2='191.29' y2='245.64' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='239.94' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='241.72' x2='191.29' y2='238.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='238.16' x2='191.29' y2='241.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='258.44' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='260.22' x2='260.98' y2='256.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='256.66' x2='260.98' y2='260.22' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='252.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.95' x2='260.98' y2='250.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='250.39' x2='260.98' y2='253.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='262.52' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='264.30' x2='330.67' y2='260.74' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.74' x2='330.67' y2='264.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.11' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.89' x2='330.67' y2='259.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.33' x2='330.67' y2='262.89' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.24 52.44,127.85 55.81,134.22 57.09,136.55 61.50,144.20 66.38,152.05 67.19,153.29 72.87,161.56 78.56,169.12 82.64,174.13 84.25,176.02 89.94,182.34 95.63,188.13 101.32,193.44 107.01,198.33 112.70,202.83 115.16,204.67 118.39,206.98 124.08,210.82 129.77,214.38 135.46,217.67 141.15,220.74 146.83,223.59 152.52,226.24 158.21,228.72 163.90,231.05 169.59,233.22 175.28,235.26 180.97,237.19 186.66,238.99 189.50,239.86 192.35,240.70 198.04,242.31 203.73,243.84 209.42,245.28 215.11,246.65 220.79,247.95 226.48,249.19 232.17,250.37 237.86,251.49 243.55,252.57 249.24,253.59 254.93,254.57 259.20,255.28 260.62,255.51 266.31,256.41 272.00,257.27 277.69,258.10 283.38,258.89 289.07,259.66 294.76,260.39 300.44,261.10 306.13,261.78 311.82,262.43 317.51,263.06 323.20,263.67 328.89,264.26 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,116.00 51.90,119.56 48.34,119.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='116.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,122.43 51.90,125.99 48.34,125.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='122.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,126.35 54.22,129.91 50.66,129.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='126.35' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,116.31 54.22,119.88 50.66,119.88 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='116.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.56 58.87,145.12 55.30,145.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='141.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,145.64 58.87,149.20 55.30,149.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='145.64' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,156.61 68.16,160.18 64.60,160.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='156.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,155.67 68.16,159.24 64.60,159.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='155.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.72 84.42,190.29 80.86,190.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,177.94 84.42,181.50 80.86,181.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='177.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,207.11 116.95,210.67 113.38,210.67 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='207.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.28 116.95,207.85 113.38,207.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='204.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,238.94 191.29,242.50 187.72,242.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='238.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,239.72 191.29,243.29 187.72,243.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='239.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,253.05 260.98,256.62 257.42,256.62 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='253.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,249.76 260.98,253.32 257.42,253.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='249.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,262.15 330.67,265.71 327.11,265.71 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='262.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,261.83 330.67,265.40 327.11,265.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='261.83' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.25 52.44,129.14 55.81,137.11 57.09,139.98 61.50,149.20 66.38,158.35 67.19,159.77 72.87,169.03 78.56,177.17 82.64,182.41 84.25,184.35 89.94,190.71 95.63,196.35 101.32,201.39 107.01,205.89 112.70,209.95 115.16,211.57 118.39,213.60 124.08,216.92 129.77,219.93 135.46,222.69 141.15,225.23 146.83,227.56 152.52,229.72 158.21,231.73 163.90,233.61 169.59,235.36 175.28,237.01 180.97,238.57 186.66,240.04 189.50,240.74 192.35,241.43 198.04,242.75 203.73,244.01 209.42,245.21 215.11,246.36 220.79,247.47 226.48,248.52 232.17,249.54 237.86,250.52 243.55,251.46 249.24,252.36 254.93,253.24 259.20,253.88 260.62,254.08 266.31,254.90 272.00,255.69 277.69,256.46 283.38,257.20 289.07,257.91 294.76,258.61 300.44,259.28 306.13,259.93 311.82,260.57 317.51,261.18 323.20,261.77 328.89,262.35 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,118.94 51.90,118.94 51.90,115.37 48.34,115.37 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,117.21 51.90,117.21 51.90,113.65 48.34,113.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,128.19 54.22,128.19 54.22,124.62 50.66,124.62 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,130.85 54.22,130.85 54.22,127.29 50.66,127.29 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,146.38 58.87,146.38 58.87,142.81 55.30,142.81 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,140.42 58.87,140.42 58.87,136.86 55.30,136.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,162.53 68.16,162.53 68.16,158.97 64.60,158.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,164.57 68.16,164.57 68.16,161.00 64.60,161.00 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,186.37 84.42,186.37 84.42,182.80 80.86,182.80 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,193.11 84.42,193.11 84.42,189.54 80.86,189.54 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,213.81 116.95,213.81 116.95,210.24 113.38,210.24 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,210.36 116.95,210.36 116.95,206.79 113.38,206.79 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,237.96 191.29,237.96 191.29,234.39 187.72,234.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,238.27 191.29,238.27 191.29,234.71 187.72,234.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,250.81 260.98,250.81 260.98,247.25 257.42,247.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,249.40 260.98,249.40 260.98,245.84 257.42,245.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,259.91 330.67,259.91 330.67,256.35 327.11,256.35 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,255.05 330.67,255.05 330.67,251.48 327.11,251.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,122.60 52.44,129.34 55.81,138.30 57.09,141.47 61.50,151.50 66.38,161.18 67.19,162.64 72.87,172.08 78.56,180.12 82.64,185.16 84.25,187.01 89.94,192.93 95.63,198.06 101.32,202.54 107.01,206.47 112.70,209.94 115.16,211.33 118.39,213.04 124.08,215.82 129.77,218.34 135.46,220.63 141.15,222.73 146.83,224.67 152.52,226.48 158.21,228.16 163.90,229.75 169.59,231.25 175.28,232.67 180.97,234.02 186.66,235.31 189.50,235.94 192.35,236.55 198.04,237.74 203.73,238.88 209.42,239.99 215.11,241.05 220.79,242.09 226.48,243.09 232.17,244.06 237.86,245.00 243.55,245.92 249.24,246.81 254.93,247.68 259.20,248.31 260.62,248.52 266.31,249.34 272.00,250.14 277.69,250.92 283.38,251.68 289.07,252.42 294.76,253.14 300.44,253.84 306.13,254.53 311.82,255.20 317.51,255.85 323.20,256.49 328.89,257.11 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='288.88' x2='684.42' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='288.88' x2='410.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='464.98' y1='288.88' x2='464.98' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='519.84' y1='288.88' x2='519.84' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='574.70' y1='288.88' x2='574.70' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='629.56' y1='288.88' x2='629.56' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='684.42' y1='288.88' x2='684.42' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='460.59' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='515.45' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='570.31' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='625.17' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='677.84' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<line x1='398.97' y1='271.22' x2='398.97' y2='119.90' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='271.22' x2='394.21' y2='271.22' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='233.39' x2='394.21' y2='233.39' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='195.56' x2='394.21' y2='195.56' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='157.73' x2='394.21' y2='157.73' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='119.90' x2='394.21' y2='119.90' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,274.74) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,236.91) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,197.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,159.92) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,122.09) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,288.88 700.04,288.88 700.04,102.24 398.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk='>
+ <rect x='360.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text x='532.82' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text transform='translate(368.55,233.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='195.56' x2='700.04' y2='195.56' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='682.64' cy='157.35' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='682.64' cy='216.54' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='672.74' cy='186.90' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='672.74' cy='241.96' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='654.79' cy='258.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='654.79' cy='148.74' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='625.07' cy='202.18' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='625.07' cy='226.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='587.57' cy='169.36' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='587.57' cy='207.90' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='543.90' cy='188.48' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='543.90' cy='174.03' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='498.53' cy='194.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='498.53' cy='193.72' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='474.71' cy='204.14' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='474.71' cy='206.20' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='457.76' cy='189.15' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='457.76' cy='195.35' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.28,183.49 686.68,187.65 681.88,187.65 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.28,195.19 686.68,199.35 681.88,199.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.45,207.87 678.85,212.03 674.05,212.03 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.45,200.30 678.85,204.46 674.05,204.46 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.75,201.98 664.15,206.14 659.35,206.14 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.75,219.87 664.15,224.03 659.35,224.03 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.89,155.68 638.29,159.84 633.49,159.84 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.89,197.66 638.29,201.82 633.49,201.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='599.86,186.40 602.26,190.55 597.46,190.55 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='599.86,151.98 602.26,156.14 597.46,156.14 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='551.83,211.80 554.23,215.96 549.43,215.96 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='551.83,224.88 554.23,229.03 549.43,229.03 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='499.14,211.05 501.54,215.21 496.74,215.21 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='499.14,192.47 501.54,196.63 496.74,196.63 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.52,177.94 477.92,182.10 473.12,182.10 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.52,186.89 477.92,191.05 473.12,191.05 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.18,183.50 462.58,187.66 457.78,187.66 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.18,196.58 462.58,200.73 457.78,200.73 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.33' y1='261.82' x2='685.37' y2='261.82' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.85' y1='264.34' x2='682.85' y2='259.30' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.33' y1='204.01' x2='685.37' y2='204.01' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.85' y1='206.53' x2='682.85' y2='201.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.90' y1='180.29' x2='678.94' y2='180.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.42' y1='182.81' x2='676.42' y2='177.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.90' y1='184.42' x2='678.94' y2='184.42' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.42' y1='186.94' x2='676.42' y2='181.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.58' y1='165.21' x2='666.62' y2='165.21' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.10' y1='167.73' x2='664.10' y2='162.69' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.58' y1='212.69' x2='666.62' y2='212.69' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.10' y1='215.21' x2='664.10' y2='210.17' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.99' y1='199.38' x2='644.03' y2='199.38' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='641.51' y1='201.90' x2='641.51' y2='196.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.99' y1='206.27' x2='644.03' y2='206.27' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='641.51' y1='208.79' x2='641.51' y2='203.75' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.18' y1='173.75' x2='610.22' y2='173.75' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.70' y1='176.27' x2='607.70' y2='171.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.18' y1='223.99' x2='610.22' y2='223.99' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.70' y1='226.51' x2='607.70' y2='221.47' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.36' y1='176.99' x2='559.40' y2='176.99' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.88' y1='179.51' x2='556.88' y2='174.47' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.36' y1='190.07' x2='559.40' y2='190.07' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.88' y1='192.59' x2='556.88' y2='187.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.18' y1='188.53' x2='493.22' y2='188.53' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.70' y1='191.05' x2='490.70' y2='186.01' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.18' y1='202.29' x2='493.22' y2='202.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.70' y1='204.81' x2='490.70' y2='199.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.09' y1='192.41' x2='462.13' y2='192.41' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.61' y1='194.93' x2='459.61' y2='189.89' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.09' y1='192.41' x2='462.13' y2='192.41' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.61' y1='194.93' x2='459.61' y2='189.89' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.35' y1='211.90' x2='444.39' y2='211.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.87' y1='214.42' x2='441.87' y2='209.38' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.35' y1='195.38' x2='444.39' y2='195.38' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.87' y1='197.90' x2='441.87' y2='192.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.26' y1='186.06' x2='685.82' y2='182.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.26' y1='182.49' x2='685.82' y2='186.06' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.26' y1='179.86' x2='685.82' y2='176.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.26' y1='176.30' x2='685.82' y2='179.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.23' y1='156.72' x2='678.79' y2='153.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.23' y1='153.16' x2='678.79' y2='156.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.23' y1='245.51' x2='678.79' y2='241.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.23' y1='241.94' x2='678.79' y2='245.51' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.81' y1='218.73' x2='665.38' y2='215.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.81' y1='215.17' x2='665.38' y2='218.73' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.81' y1='219.42' x2='665.38' y2='215.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.81' y1='215.86' x2='665.38' y2='219.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.35' y1='178.67' x2='640.91' y2='175.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.35' y1='175.11' x2='640.91' y2='178.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.35' y1='246.81' x2='640.91' y2='243.25' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.35' y1='243.25' x2='640.91' y2='246.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.07' y1='210.17' x2='604.64' y2='206.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.07' y1='206.61' x2='604.64' y2='210.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.07' y1='170.94' x2='604.64' y2='167.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.07' y1='167.38' x2='604.64' y2='170.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.53' y1='191.44' x2='551.09' y2='187.88' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.53' y1='187.88' x2='551.09' y2='191.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.53' y1='201.77' x2='551.09' y2='198.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.53' y1='198.20' x2='551.09' y2='201.77' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.48' y1='187.71' x2='484.04' y2='184.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.48' y1='184.14' x2='484.04' y2='187.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.48' y1='187.02' x2='484.04' y2='183.46' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.48' y1='183.46' x2='484.04' y2='187.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='450.69' y1='192.79' x2='454.25' y2='189.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='450.69' y1='189.23' x2='454.25' y2='192.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='450.69' y1='194.86' x2='454.25' y2='191.29' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='450.69' y1='191.29' x2='454.25' y2='194.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.48' y1='199.61' x2='438.04' y2='196.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.48' y1='196.05' x2='438.04' y2='199.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.48' y1='205.12' x2='438.04' y2='201.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.48' y1='201.56' x2='438.04' y2='205.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.87,153.46 687.39,150.94 689.91,153.46 687.39,155.98 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.87,151.40 687.39,148.88 689.91,151.40 687.39,153.92 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.47,202.65 672.99,200.13 675.51,202.65 672.99,205.17 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.47,257.71 672.99,255.19 675.51,257.71 672.99,260.23 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='645.71,191.46 648.23,188.94 650.75,191.46 648.23,193.98 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='645.71,189.40 648.23,186.88 650.75,189.40 648.23,191.92 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='608.67,185.26 611.19,182.74 613.71,185.26 611.19,187.78 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='608.67,203.16 611.19,200.64 613.71,203.16 611.19,205.68 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='568.80,210.47 571.32,207.95 573.84,210.47 571.32,212.99 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='568.80,200.14 571.32,197.62 573.84,200.14 571.32,202.66 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='529.65,176.94 532.17,174.42 534.69,176.94 532.17,179.46 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='529.65,171.43 532.17,168.91 534.69,171.43 532.17,173.95 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.72,208.02 490.24,205.50 492.76,208.02 490.24,210.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.72,187.37 490.24,184.85 492.76,187.37 490.24,189.89 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='463.25,202.36 465.77,199.84 468.29,202.36 465.77,204.88 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='463.25,197.54 465.77,195.02 468.29,197.54 465.77,200.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='446.29,198.35 448.81,195.83 451.33,198.35 448.81,200.87 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='446.29,201.80 448.81,199.28 451.33,201.80 448.81,204.32 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.40,179.68 686.80,175.53 682.00,175.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.40,176.93 686.80,172.77 682.00,172.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.45,223.06 678.85,218.90 674.05,218.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.45,246.46 678.85,242.30 674.05,242.30 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.67,184.60 664.07,180.44 659.27,180.44 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.67,213.50 664.07,209.35 659.27,209.35 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='636.04,179.49 638.44,175.33 633.64,175.33 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='636.04,176.74 638.44,172.58 633.64,172.58 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.22,183.66 603.62,179.51 598.82,179.51 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.22,248.36 603.62,244.20 598.82,244.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='556.49,155.39 558.89,151.24 554.09,151.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='556.49,212.52 558.89,208.36 554.09,208.36 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='508.50,199.46 510.90,195.31 506.10,195.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='508.50,208.41 510.90,204.25 506.10,204.25 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.61,192.96 488.01,188.81 483.21,188.81 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.61,197.09 488.01,192.94 483.21,192.94 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='469.59,195.45 471.99,191.29 467.19,191.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='469.59,209.90 471.99,205.75 467.19,205.75 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='681.87' y='222.12' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.87' y1='225.69' x2='685.43' y2='222.12' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.87' y1='222.12' x2='685.43' y2='225.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='681.87' y='156.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.87' y1='159.62' x2='685.43' y2='156.05' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.87' y1='156.05' x2='685.43' y2='159.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='669.29' y='176.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.29' y1='180.37' x2='672.86' y2='176.81' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.29' y1='176.81' x2='672.86' y2='180.37' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='669.29' y='221.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.29' y1='225.11' x2='672.86' y2='221.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='669.29' y1='221.54' x2='672.86' y2='225.11' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='646.41' y='261.85' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='646.41' y1='265.41' x2='649.97' y2='261.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='646.41' y1='261.85' x2='649.97' y2='265.41' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='646.41' y='188.90' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='646.41' y1='192.46' x2='649.97' y2='188.90' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='646.41' y1='188.90' x2='649.97' y2='192.46' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='608.34' y='228.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.34' y1='232.54' x2='611.91' y2='228.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.34' y1='228.98' x2='611.91' y2='232.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='608.34' y='143.63' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.34' y1='147.20' x2='611.91' y2='143.63' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.34' y1='143.63' x2='611.91' y2='147.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='560.18' y='165.25' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.18' y1='168.82' x2='563.74' y2='165.25' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.18' y1='165.25' x2='563.74' y2='168.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='560.18' y='185.90' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.18' y1='189.46' x2='563.74' y2='185.90' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.18' y1='185.90' x2='563.74' y2='189.46' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='504.99' y='198.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='504.99' y1='201.72' x2='508.55' y2='198.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='504.99' y1='198.15' x2='508.55' y2='201.72' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='504.99' y='190.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='504.99' y1='194.15' x2='508.55' y2='190.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='504.99' y1='190.58' x2='508.55' y2='194.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='454.91' y='201.89' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.91' y1='205.45' x2='458.47' y2='201.89' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.91' y1='201.89' x2='458.47' y2='205.45' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='454.91' y='203.95' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.91' y1='207.52' x2='458.47' y2='203.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.91' y1='203.95' x2='458.47' y2='207.52' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.25' y='190.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.25' y1='193.99' x2='438.82' y2='190.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.25' y1='190.43' x2='438.82' y2='193.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.25' y='195.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.25' y1='199.50' x2='438.82' y2='195.94' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.25' y1='195.94' x2='438.82' y2='199.50' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='424.31' y='191.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.31' y1='195.45' x2='427.88' y2='191.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.31' y1='191.88' x2='427.88' y2='195.45' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='424.31' y='180.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.31' y1='183.75' x2='427.88' y2='180.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.31' y1='180.18' x2='427.88' y2='183.75' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.67' y1='219.89' x2='687.24' y2='216.33' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.67' y1='216.33' x2='687.24' y2='219.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.94' y1='218.11' x2='687.98' y2='218.11' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.46' y1='220.63' x2='685.46' y2='215.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.67' y1='148.32' x2='687.24' y2='144.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.67' y1='144.75' x2='687.24' y2='148.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.94' y1='146.53' x2='687.98' y2='146.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.46' y1='149.05' x2='685.46' y2='144.01' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.95' y1='167.84' x2='669.51' y2='164.28' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.95' y1='164.28' x2='669.51' y2='167.84' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.21' y1='166.06' x2='670.25' y2='166.06' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.73' y1='168.58' x2='667.73' y2='163.54' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.95' y1='237.36' x2='669.51' y2='233.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.95' y1='233.79' x2='669.51' y2='237.36' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.21' y1='235.57' x2='670.25' y2='235.57' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.73' y1='238.09' x2='667.73' y2='233.05' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.71' y1='178.00' x2='639.27' y2='174.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.71' y1='174.44' x2='639.27' y2='178.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='634.97' y1='176.22' x2='640.01' y2='176.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.49' y1='178.74' x2='637.49' y2='173.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.71' y1='248.89' x2='639.27' y2='245.33' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.71' y1='245.33' x2='639.27' y2='248.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='634.97' y1='247.11' x2='640.01' y2='247.11' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.49' y1='249.63' x2='637.49' y2='244.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.32' y1='174.68' x2='594.88' y2='171.12' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.32' y1='171.12' x2='594.88' y2='174.68' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='590.58' y1='172.90' x2='595.62' y2='172.90' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='593.10' y1='175.42' x2='593.10' y2='170.38' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.32' y1='197.39' x2='594.88' y2='193.83' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.32' y1='193.83' x2='594.88' y2='197.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='590.58' y1='195.61' x2='595.62' y2='195.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='593.10' y1='198.13' x2='593.10' y2='193.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.83' y1='217.48' x2='549.40' y2='213.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.83' y1='213.91' x2='549.40' y2='217.48' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.10' y1='215.70' x2='550.14' y2='215.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.62' y1='218.22' x2='547.62' y2='213.18' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.83' y1='193.39' x2='549.40' y2='189.83' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.83' y1='189.83' x2='549.40' y2='193.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.10' y1='191.61' x2='550.14' y2='191.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.62' y1='194.13' x2='547.62' y2='189.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.97' y1='201.87' x2='510.53' y2='198.31' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.97' y1='198.31' x2='510.53' y2='201.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.23' y1='200.09' x2='511.27' y2='200.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='508.75' y1='202.61' x2='508.75' y2='197.57' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.97' y1='190.17' x2='510.53' y2='186.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.97' y1='186.61' x2='510.53' y2='190.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.23' y1='188.39' x2='511.27' y2='188.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='508.75' y1='190.91' x2='508.75' y2='185.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.33' y1='201.89' x2='477.90' y2='198.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.33' y1='198.32' x2='477.90' y2='201.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.60' y1='200.10' x2='478.64' y2='200.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.12' y1='202.62' x2='476.12' y2='197.58' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.33' y1='197.76' x2='477.90' y2='194.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.33' y1='194.19' x2='477.90' y2='197.76' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.60' y1='195.98' x2='478.64' y2='195.98' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.12' y1='198.50' x2='476.12' y2='193.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.12' y1='193.35' x2='459.68' y2='189.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.12' y1='189.78' x2='459.68' y2='193.35' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.38' y1='191.57' x2='460.42' y2='191.57' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.90' y1='194.09' x2='457.90' y2='189.05' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.12' y1='194.72' x2='459.68' y2='191.16' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.12' y1='191.16' x2='459.68' y2='194.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.38' y1='192.94' x2='460.42' y2='192.94' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.90' y1='195.46' x2='457.90' y2='190.42' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.00' y1='196.22' x2='446.56' y2='192.66' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.00' y1='192.66' x2='446.56' y2='196.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.26' y1='194.44' x2='447.30' y2='194.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.78' y1='196.96' x2='444.78' y2='191.92' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.00' y1='192.09' x2='446.56' y2='188.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.00' y1='188.53' x2='446.56' y2='192.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.26' y1='190.31' x2='447.30' y2='190.31' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.78' y1='192.83' x2='444.78' y2='187.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.28' y1='133.83' x2='690.32' y2='133.83' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='687.80' y1='136.35' x2='687.80' y2='131.31' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='685.28,133.83 687.80,131.31 690.32,133.83 687.80,136.35 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.28' y1='265.29' x2='690.32' y2='265.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='687.80' y1='267.81' x2='687.80' y2='262.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='685.28,265.29 687.80,262.77 690.32,265.29 687.80,267.81 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.76' y1='184.07' x2='678.80' y2='184.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.28' y1='186.59' x2='676.28' y2='181.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.76,184.07 676.28,181.55 678.80,184.07 676.28,186.59 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.76' y1='144.84' x2='678.80' y2='144.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.28' y1='147.36' x2='676.28' y2='142.32' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.76,144.84 676.28,142.32 678.80,144.84 676.28,147.36 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='652.81' y1='229.93' x2='657.85' y2='229.93' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.33' y1='232.45' x2='655.33' y2='227.41' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='652.81,229.93 655.33,227.41 657.85,229.93 655.33,232.45 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='652.81' y1='190.01' x2='657.85' y2='190.01' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.33' y1='192.53' x2='655.33' y2='187.49' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='652.81,190.01 655.33,187.49 657.85,190.01 655.33,192.53 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='618.03' y1='181.89' x2='623.07' y2='181.89' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='620.55' y1='184.41' x2='620.55' y2='179.37' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='618.03,181.89 620.55,179.37 623.07,181.89 620.55,184.41 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='618.03' y1='210.11' x2='623.07' y2='210.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='620.55' y1='212.63' x2='620.55' y2='207.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='618.03,210.11 620.55,207.59 623.07,210.11 620.55,212.63 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='574.07' y1='219.57' x2='579.11' y2='219.57' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='576.59' y1='222.09' x2='576.59' y2='217.05' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='574.07,219.57 576.59,217.05 579.11,219.57 576.59,222.09 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='574.07' y1='182.41' x2='579.11' y2='182.41' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='576.59' y1='184.93' x2='576.59' y2='179.89' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='574.07,182.41 576.59,179.89 579.11,182.41 576.59,184.93 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.36' y1='193.52' x2='528.40' y2='193.52' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='525.88' y1='196.04' x2='525.88' y2='191.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.36,193.52 525.88,191.00 528.40,193.52 525.88,196.04 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.36' y1='174.94' x2='528.40' y2='174.94' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='525.88' y1='177.46' x2='525.88' y2='172.42' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.36,174.94 525.88,172.42 528.40,174.94 525.88,177.46 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.45' y1='197.43' x2='479.49' y2='197.43' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.97' y1='199.95' x2='476.97' y2='194.91' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='474.45,197.43 476.97,194.91 479.49,197.43 476.97,199.95 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.45' y1='191.24' x2='479.49' y2='191.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='476.97' y1='193.76' x2='476.97' y2='188.72' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='474.45,191.24 476.97,188.72 479.49,191.24 476.97,193.76 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='452.07' y1='183.27' x2='457.11' y2='183.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.59' y1='185.79' x2='454.59' y2='180.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='452.07,183.27 454.59,180.75 457.11,183.27 454.59,185.79 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='452.07' y1='203.23' x2='457.11' y2='203.23' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.59' y1='205.75' x2='454.59' y2='200.71' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='452.07,203.23 454.59,200.71 457.11,203.23 454.59,205.75 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='437.70' y1='210.52' x2='442.74' y2='210.52' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='440.22' y1='213.04' x2='440.22' y2='208.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='437.70,210.52 440.22,208.00 442.74,210.52 440.22,213.04 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='437.70' y1='185.05' x2='442.74' y2='185.05' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='440.22' y1='187.57' x2='440.22' y2='182.53' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='437.70,185.05 440.22,182.53 442.74,185.05 440.22,187.57 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='686.65' cy='190.82' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.87' y1='190.82' x2='688.43' y2='190.82' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.65' y1='192.60' x2='686.65' y2='189.04' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='686.65' cy='192.19' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.87' y1='192.19' x2='688.43' y2='192.19' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.65' y1='193.98' x2='686.65' y2='190.41' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.65' cy='187.72' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.87' y1='187.72' x2='681.43' y2='187.72' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.65' y1='189.50' x2='679.65' y2='185.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.65' cy='173.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.87' y1='173.27' x2='681.43' y2='173.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.65' y1='175.05' x2='679.65' y2='171.48' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='666.37' cy='199.14' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.59' y1='199.14' x2='668.15' y2='199.14' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='666.37' y1='200.92' x2='666.37' y2='197.35' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='666.37' cy='211.52' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.59' y1='211.52' x2='668.15' y2='211.52' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='666.37' y1='213.31' x2='666.37' y2='209.74' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='642.41' cy='242.24' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.63' y1='242.24' x2='644.19' y2='242.24' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='642.41' y1='244.03' x2='642.41' y2='240.46' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='642.41' cy='188.56' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.63' y1='188.56' x2='644.19' y2='188.56' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='642.41' y1='190.34' x2='642.41' y2='186.78' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='607.50' cy='178.05' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.71' y1='178.05' x2='609.28' y2='178.05' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.50' y1='179.83' x2='607.50' y2='176.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='607.50' cy='180.12' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.71' y1='180.12' x2='609.28' y2='180.12' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.50' y1='181.90' x2='607.50' y2='178.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='557.24' cy='216.45' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='555.46' y1='216.45' x2='559.02' y2='216.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.24' y1='218.23' x2='557.24' y2='214.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='557.24' cy='166.21' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='555.46' y1='166.21' x2='559.02' y2='166.21' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.24' y1='167.99' x2='557.24' y2='164.42' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='495.29' cy='204.87' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.51' y1='204.87' x2='497.08' y2='204.87' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='495.29' y1='206.65' x2='495.29' y2='203.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='495.29' cy='204.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.51' y1='204.18' x2='497.08' y2='204.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='495.29' y1='205.96' x2='495.29' y2='202.40' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='466.29' cy='175.45' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.51' y1='175.45' x2='468.07' y2='175.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='466.29' y1='177.24' x2='466.29' y2='173.67' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='466.29' cy='194.72' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.51' y1='194.72' x2='468.07' y2='194.72' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='466.29' y1='196.51' x2='466.29' y2='192.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='448.77' cy='203.76' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.99' y1='203.76' x2='450.55' y2='203.76' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.77' y1='205.54' x2='448.77' y2='201.98' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='448.77' cy='193.43' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.99' y1='193.43' x2='450.55' y2='193.43' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.77' y1='195.22' x2='448.77' y2='191.65' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.92,210.83 686.32,205.98 681.52,205.98 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.92,205.29 686.32,210.14 681.52,210.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.92,204.64 686.32,199.79 681.52,199.79 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.92,199.10 686.32,203.95 681.52,203.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='678.12,215.54 680.52,210.69 675.72,210.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='678.12,210.00 680.52,214.85 675.72,214.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='678.12,137.08 680.52,132.23 675.72,132.23 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='678.12,131.54 680.52,136.39 675.72,136.39 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='667.05,209.79 669.45,204.94 664.65,204.94 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='667.05,204.25 669.45,209.10 664.65,209.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='667.05,227.69 669.45,222.84 664.65,222.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='667.05,222.14 669.45,226.99 664.65,226.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.88,168.83 649.28,163.98 644.48,163.98 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.88,163.29 649.28,168.14 644.48,168.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.88,235.59 649.28,230.74 644.48,230.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.88,230.05 649.28,234.90 644.48,234.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.02,207.46 619.42,202.61 614.62,202.61 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.02,201.92 619.42,206.77 614.62,206.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.02,226.04 619.42,221.20 614.62,221.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.02,220.50 619.42,225.35 614.62,225.35 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.80,183.25 575.20,178.40 570.40,178.40 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.80,177.70 575.20,182.55 570.40,182.55 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.80,162.60 575.20,157.75 570.40,157.75 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.80,157.06 575.20,161.91 570.40,161.91 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.56,197.24 517.96,192.39 513.16,192.39 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.56,191.70 517.96,196.55 513.16,196.55 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.56,204.12 517.96,199.27 513.16,199.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.56,198.58 517.96,203.43 513.16,203.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.04,213.07 489.44,208.22 484.64,208.22 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.04,207.53 489.44,212.38 484.64,212.38 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.04,184.85 489.44,180.00 484.64,180.00 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.04,179.31 489.44,184.16 484.64,184.16 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.62,201.97 471.02,197.12 466.22,197.12 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.62,196.43 471.02,201.28 466.22,201.28 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.62,201.28 471.02,196.43 466.22,196.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.62,195.74 471.02,200.59 466.22,200.59 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.11' y1='249.28' x2='685.67' y2='249.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.89' y1='251.06' x2='683.89' y2='247.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='682.11' y='247.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.11' y1='185.28' x2='685.67' y2='185.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.89' y1='187.06' x2='683.89' y2='183.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='682.11' y='183.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.04' y1='186.81' x2='678.60' y2='186.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.82' y1='188.60' x2='676.82' y2='185.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.04' y='185.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.04' y1='210.90' x2='678.60' y2='210.90' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.82' y1='212.68' x2='676.82' y2='209.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.04' y='209.12' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.62' y1='123.56' x2='665.19' y2='123.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.41' y1='125.34' x2='663.41' y2='121.77' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='661.62' y='121.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.62' y1='207.52' x2='665.19' y2='207.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.41' y1='209.30' x2='663.41' y2='205.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='661.62' y='205.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.41' y1='236.25' x2='640.98' y2='236.25' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.20' y1='238.03' x2='639.20' y2='234.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='637.41' y='234.47' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.41' y1='171.55' x2='640.98' y2='171.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.20' y1='173.34' x2='639.20' y2='169.77' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='637.41' y='169.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='602.16' y1='209.04' x2='605.72' y2='209.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='603.94' y1='210.82' x2='603.94' y2='207.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='602.16' y='207.26' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='602.16' y1='197.34' x2='605.72' y2='197.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='603.94' y1='199.12' x2='603.94' y2='195.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='602.16' y='195.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='551.48' y1='201.65' x2='555.04' y2='201.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.26' y1='203.43' x2='553.26' y2='199.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='551.48' y='199.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='551.48' y1='193.39' x2='555.04' y2='193.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.26' y1='195.17' x2='553.26' y2='191.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='551.48' y='191.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='489.49' y1='198.21' x2='493.05' y2='198.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='491.27' y1='199.99' x2='491.27' y2='196.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='489.49' y='196.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='489.49' y1='199.58' x2='493.05' y2='199.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='491.27' y1='201.37' x2='491.27' y2='197.80' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='489.49' y='197.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='460.97' y1='203.74' x2='464.53' y2='203.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='462.75' y1='205.52' x2='462.75' y2='201.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='460.97' y='201.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='460.97' y1='183.78' x2='464.53' y2='183.78' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='462.75' y1='185.56' x2='462.75' y2='182.00' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='460.97' y='182.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.06' y1='190.21' x2='447.62' y2='190.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='445.84' y1='191.99' x2='445.84' y2='188.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.06' y='188.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.06' y1='194.34' x2='447.62' y2='194.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='445.84' y1='196.12' x2='445.84' y2='192.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.06' y='192.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='687.77' cy='204.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.99' y1='206.43' x2='689.55' y2='202.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.99' y1='202.87' x2='689.55' y2='206.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='687.77' cy='219.10' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.99' y1='220.88' x2='689.55' y2='217.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.99' y1='217.32' x2='689.55' y2='220.88' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.70' cy='191.29' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.92' y1='193.07' x2='681.48' y2='189.50' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.92' y1='189.50' x2='681.48' y2='193.07' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.70' cy='142.42' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.92' y1='144.20' x2='681.48' y2='140.64' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.92' y1='140.64' x2='681.48' y2='144.20' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='664.48' cy='204.72' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.70' y1='206.50' x2='666.27' y2='202.94' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.70' y1='202.94' x2='666.27' y2='206.50' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='664.48' cy='151.04' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.70' y1='152.82' x2='666.27' y2='149.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.70' y1='149.26' x2='666.27' y2='152.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='637.37' cy='199.32' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.59' y1='201.10' x2='639.15' y2='197.54' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.59' y1='197.54' x2='639.15' y2='201.10' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='637.37' cy='186.93' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.59' y1='188.72' x2='639.15' y2='185.15' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.59' y1='185.15' x2='639.15' y2='188.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='598.75' cy='193.28' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.97' y1='195.06' x2='600.54' y2='191.50' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.97' y1='191.50' x2='600.54' y2='195.06' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='598.75' cy='222.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.97' y1='223.97' x2='600.54' y2='220.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.97' y1='220.41' x2='600.54' y2='223.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='545.32' cy='200.30' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='202.09' x2='547.10' y2='198.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='198.52' x2='547.10' y2='202.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='545.32' cy='192.73' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='194.52' x2='547.10' y2='190.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='190.95' x2='547.10' y2='194.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='483.77' cy='213.11' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.99' y1='214.89' x2='485.55' y2='211.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.99' y1='211.33' x2='485.55' y2='214.89' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='483.77' cy='195.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.99' y1='197.69' x2='485.55' y2='194.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.99' y1='194.12' x2='485.55' y2='197.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='456.79' cy='209.43' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.01' y1='211.22' x2='458.58' y2='207.65' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.01' y1='207.65' x2='458.58' y2='211.22' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='456.79' cy='181.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.01' y1='183.69' x2='458.58' y2='180.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.01' y1='180.12' x2='458.58' y2='183.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='441.09' cy='187.94' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.31' y1='189.72' x2='442.88' y2='186.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.31' y1='186.16' x2='442.88' y2='189.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='441.09' cy='181.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.31' y1='183.53' x2='442.88' y2='179.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.31' y1='179.96' x2='442.88' y2='183.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.75,169.77 689.53,173.34 685.97,173.34 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='685.97' y='169.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.75,197.99 689.53,201.55 685.97,201.55 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='685.97' y='197.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.44,189.33 679.22,192.89 675.66,192.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.66' y='189.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.44,145.28 679.22,148.85 675.66,148.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.66' y='145.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='658.49,208.54 660.27,212.10 656.70,212.10 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='656.70' y='208.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='658.49,226.43 660.27,230.00 656.70,230.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='656.70' y='226.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='626.34,193.96 628.13,197.53 624.56,197.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='624.56' y='193.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='626.34,189.83 628.13,193.40 624.56,193.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='624.56' y='189.83' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='584.27,220.54 586.05,224.11 582.49,224.11 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='582.49' y='220.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='584.27,182.00 586.05,185.56 582.49,185.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='582.49' y='182.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='533.25,181.99 535.03,185.55 531.46,185.55 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='531.46' y='181.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='533.25,169.60 535.03,173.17 531.46,173.17 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='531.46' y='169.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='482.23,193.69 484.01,197.26 480.44,197.26 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='480.44' y='193.69' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='482.23,197.14 484.01,200.70 480.44,200.70 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='480.44' y='197.14' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='459.25,197.99 461.03,201.55 457.47,201.55 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='457.47' y='197.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='459.25,183.54 461.03,187.10 457.47,187.10 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='457.47' y='183.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='444.42,200.70 446.20,204.27 442.64,204.27 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='442.64' y='200.70' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='444.42,199.33 446.20,202.89 442.64,202.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='442.64' y='199.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,173.45 690.67,173.45 690.67,169.89 687.11,169.89 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,165.88 690.67,165.88 690.67,162.32 687.11,162.32 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.31,184.45 678.87,184.45 678.87,180.88 675.31,180.88 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.31,196.15 678.87,196.15 678.87,192.58 675.31,192.58 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.09,211.05 657.65,211.05 657.65,207.48 654.09,207.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.09,184.89 657.65,184.89 657.65,181.33 654.09,181.33 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.62,195.46 623.19,195.46 623.19,191.90 619.62,191.90 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.62,204.41 623.19,204.41 623.19,200.84 619.62,200.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='577.67,194.81 581.23,194.81 581.23,191.24 577.67,191.24 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='577.67,224.40 581.23,224.40 581.23,220.84 577.67,220.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.90,200.40 535.46,200.40 535.46,196.84 531.90,196.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.90,185.26 535.46,185.26 535.46,181.70 531.90,181.70 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='488.85,198.39 492.41,198.39 492.41,194.83 488.85,194.83 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='488.85,199.77 492.41,199.77 492.41,196.20 488.85,196.20 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='467.20,200.51 470.77,200.51 470.77,196.95 467.20,196.95 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='467.20,194.32 470.77,194.32 470.77,190.75 467.20,190.75 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.82,201.82 455.38,201.82 455.38,198.26 451.82,198.26 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.82,180.49 455.38,180.49 455.38,176.92 451.82,176.92 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<polyline points='50.12,520.49 52.44,515.67 55.81,508.97 57.09,506.51 61.50,498.38 66.38,489.97 67.19,488.64 72.87,479.68 78.56,471.44 82.64,465.94 84.25,463.85 89.94,456.86 95.63,450.43 101.32,444.51 107.01,439.05 112.70,434.03 115.16,431.97 118.39,429.40 124.08,425.13 129.77,421.20 135.46,417.58 141.15,414.25 146.83,411.18 152.52,408.36 158.21,405.76 163.90,403.37 169.59,401.18 175.28,399.16 180.97,397.31 186.66,395.62 189.50,394.83 192.35,394.07 198.04,392.65 203.73,391.35 209.42,390.17 215.11,389.10 220.79,388.13 226.48,387.25 232.17,386.46 237.86,385.74 243.55,385.11 249.24,384.54 254.93,384.04 259.20,383.71 260.62,383.61 266.31,383.23 272.00,382.90 277.69,382.63 283.38,382.40 289.07,382.22 294.76,382.08 300.44,381.98 306.13,381.92 311.82,381.89 317.51,381.90 323.20,381.94 328.89,382.00 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='527.53' x2='328.89' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='527.53' x2='50.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='527.53' x2='96.58' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='527.53' x2='143.04' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='527.53' x2='189.50' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='527.53' x2='235.97' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='527.53' x2='282.43' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='527.53' x2='328.89' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='520.49' x2='38.97' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='520.49' x2='34.21' y2='520.49' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='483.65' x2='34.21' y2='483.65' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='446.81' x2='34.21' y2='446.81' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='409.97' x2='34.21' y2='409.97' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='373.13' x2='34.21' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,522.68) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,488.04) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,451.20) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,414.36) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,377.52) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<polygon points='38.97,527.53 340.04,527.53 340.04,337.35 38.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ=='>
+ <rect x='0.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text x='180.87' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text transform='translate(8.55,437.93) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='10.98px' lengthAdjust='spacingAndGlyphs'>m1</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<circle cx='52.44' cy='511.64' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='513.49' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='498.75' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='504.28' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='486.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='490.65' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='459.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='470.01' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='433.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='432.07' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='404.81' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='401.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='408.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='388.60' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.70' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.17 55.81,505.75 57.09,502.75 61.50,493.23 66.38,483.98 67.19,482.57 72.87,473.45 78.56,465.63 82.64,460.70 84.25,458.88 89.94,453.05 95.63,447.98 101.32,443.54 107.01,439.65 112.70,436.21 115.16,434.84 118.39,433.15 124.08,430.42 129.77,427.98 135.46,425.77 141.15,423.77 146.83,421.95 152.52,420.28 158.21,418.74 163.90,417.32 169.59,416.01 175.28,414.79 180.97,413.66 186.66,412.60 189.50,412.09 192.35,411.60 198.04,410.67 203.73,409.80 209.42,408.97 215.11,408.20 220.79,407.47 226.48,406.78 232.17,406.14 237.86,405.53 243.55,404.95 249.24,404.42 254.93,403.91 259.20,403.55 260.62,403.43 266.31,402.99 272.00,402.57 277.69,402.18 283.38,401.81 289.07,401.47 294.76,401.16 300.44,400.87 306.13,400.60 311.82,400.36 317.51,400.14 323.20,399.93 328.89,399.75 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.35 54.84,521.50 50.04,521.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,510.71 54.84,514.87 50.04,514.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,503.72 59.49,507.87 54.69,507.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,515.61 54.69,515.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,488.24 68.78,492.40 63.98,492.40 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,492.66 68.78,496.82 63.98,496.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,464.30 85.04,468.45 80.24,468.45 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,471.66 85.04,475.82 80.24,475.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,451.03 117.56,455.19 112.76,455.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,437.03 117.56,441.19 112.76,441.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.19 191.90,425.35 187.10,425.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.30 187.10,428.30 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.56 261.60,411.72 256.80,411.72 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.19 261.60,411.35 256.80,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,417.51 331.29,421.67 326.49,421.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.19 331.29,411.35 326.49,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,515.98 55.81,509.79 57.09,507.55 61.50,500.23 66.38,492.82 67.19,491.66 72.87,483.98 78.56,477.09 82.64,472.59 84.25,470.91 89.94,465.35 95.63,460.35 101.32,455.84 107.01,451.78 112.70,448.12 115.16,446.64 118.39,444.81 124.08,441.81 129.77,439.10 135.46,436.64 141.15,434.41 146.83,432.38 152.52,430.53 158.21,428.85 163.90,427.32 169.59,425.91 175.28,424.63 180.97,423.46 186.66,422.38 189.50,421.88 192.35,421.40 198.04,420.49 203.73,419.66 209.42,418.90 215.11,418.20 220.79,417.55 226.48,416.96 232.17,416.41 237.86,415.91 243.55,415.44 249.24,415.02 254.93,414.63 259.20,414.36 260.62,414.27 266.31,413.94 272.00,413.64 277.69,413.37 283.38,413.12 289.07,412.89 294.76,412.69 300.44,412.51 306.13,412.35 311.82,412.20 317.51,412.07 323.20,411.97 328.89,411.87 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='513.49' x2='54.96' y2='513.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.01' x2='52.44' y2='510.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='508.33' x2='59.61' y2='508.33' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='510.85' x2='57.09' y2='505.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='512.75' x2='59.61' y2='512.75' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='515.27' x2='57.09' y2='510.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='483.65' x2='68.90' y2='483.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='486.17' x2='66.38' y2='481.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='486.96' x2='68.90' y2='486.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='489.48' x2='66.38' y2='484.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='469.28' x2='85.16' y2='469.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='471.80' x2='82.64' y2='466.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='462.65' x2='85.16' y2='462.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='465.17' x2='82.64' y2='460.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='437.96' x2='117.68' y2='437.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='440.48' x2='115.16' y2='435.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='435.39' x2='117.68' y2='435.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='437.91' x2='115.16' y2='432.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='404.81' x2='192.02' y2='404.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='407.33' x2='189.50' y2='402.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='387.86' x2='192.02' y2='387.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='390.38' x2='189.50' y2='385.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='386.02' x2='261.72' y2='386.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='388.54' x2='259.20' y2='383.50' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.86' x2='261.72' y2='394.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.38' x2='259.20' y2='392.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='387.49' x2='331.41' y2='387.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='390.01' x2='328.89' y2='384.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='378.28' x2='331.41' y2='378.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='380.80' x2='328.89' y2='375.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.13 55.81,510.05 57.09,507.81 61.50,500.38 66.38,492.66 67.19,491.43 72.87,483.13 78.56,475.44 82.64,470.28 84.25,468.31 89.94,461.70 95.63,455.57 101.32,449.88 107.01,444.60 112.70,439.70 115.16,437.68 118.39,435.15 124.08,430.92 129.77,427.00 135.46,423.35 141.15,419.97 146.83,416.83 152.52,413.91 158.21,411.20 163.90,408.68 169.59,406.35 175.28,404.18 180.97,402.17 186.66,400.31 189.50,399.43 192.35,398.58 198.04,396.98 203.73,395.50 209.42,394.13 215.11,392.87 220.79,391.70 226.48,390.62 232.17,389.63 237.86,388.72 243.55,387.89 249.24,387.13 254.93,386.43 259.20,385.95 260.62,385.80 266.31,385.23 272.00,384.71 277.69,384.25 283.38,383.83 289.07,383.47 294.76,383.14 300.44,382.86 306.13,382.62 311.82,382.42 317.51,382.25 323.20,382.11 328.89,382.01 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.79' x2='54.22' y2='510.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='510.23' x2='54.22' y2='513.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.37' x2='54.22' y2='505.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.81' x2='54.22' y2='509.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='502.37' x2='58.87' y2='498.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='498.81' x2='58.87' y2='502.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='510.11' x2='58.87' y2='506.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.55' x2='58.87' y2='510.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='484.32' x2='68.16' y2='480.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='480.76' x2='68.16' y2='484.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='485.43' x2='68.16' y2='481.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='481.86' x2='68.16' y2='485.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='452.64' x2='84.42' y2='449.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='449.08' x2='84.42' y2='452.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='468.11' x2='84.42' y2='464.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='464.55' x2='84.42' y2='468.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.27' x2='116.95' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='413.71' x2='116.95' y2='417.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='420.22' x2='116.95' y2='416.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.66' x2='116.95' y2='420.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='374.91' x2='191.29' y2='371.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='371.34' x2='191.29' y2='374.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='368.64' x2='191.29' y2='365.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='365.08' x2='191.29' y2='368.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='360.91' x2='260.98' y2='357.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='357.34' x2='260.98' y2='360.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='354.65' x2='260.98' y2='351.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='351.08' x2='260.98' y2='354.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='357.22' x2='330.67' y2='353.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='353.66' x2='330.67' y2='357.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='347.65' x2='330.67' y2='344.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='344.08' x2='330.67' y2='347.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.89 55.81,507.11 57.09,504.24 61.50,494.77 66.38,484.95 67.19,483.39 72.87,472.89 78.56,463.21 82.64,456.73 84.25,454.27 89.94,446.02 95.63,438.40 101.32,431.36 107.01,424.86 112.70,418.86 115.16,416.41 118.39,413.32 124.08,408.20 129.77,403.47 135.46,399.10 141.15,395.06 146.83,391.34 152.52,387.89 158.21,384.72 163.90,381.79 169.59,379.08 175.28,376.59 180.97,374.30 186.66,372.18 189.50,371.19 192.35,370.24 198.04,368.45 203.73,366.81 209.42,365.31 215.11,363.93 220.79,362.68 226.48,361.53 232.17,360.49 237.86,359.54 243.55,358.69 249.24,357.92 254.93,357.23 259.20,356.76 260.62,356.61 266.31,356.07 272.00,355.59 277.69,355.17 283.38,354.81 289.07,354.50 294.76,354.25 300.44,354.04 306.13,353.88 311.82,353.76 317.51,353.68 323.20,353.64 328.89,353.63 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,515.33 52.44,512.81 54.96,515.33 52.44,517.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,512.38 52.44,509.86 54.96,512.38 52.44,514.90 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,502.07 57.09,499.55 59.61,502.07 57.09,504.59 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,500.22 57.09,497.70 59.61,500.22 57.09,502.74 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,485.12 66.38,482.60 68.90,485.12 66.38,487.64 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,482.54 66.38,480.02 68.90,482.54 66.38,485.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,457.86 82.64,455.34 85.16,457.86 82.64,460.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,465.23 82.64,462.71 85.16,465.23 82.64,467.75 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,442.75 115.16,440.23 117.68,442.75 115.16,445.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,440.91 115.16,438.39 117.68,440.91 115.16,443.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,422.86 189.50,420.34 192.02,422.86 189.50,425.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,421.75 189.50,419.23 192.02,421.75 189.50,424.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,421.02 259.20,418.50 261.72,421.02 259.20,423.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,416.60 259.20,414.08 261.72,416.60 259.20,419.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,412.54 328.89,410.02 331.41,412.54 328.89,415.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,430.96 328.89,428.44 331.41,430.96 328.89,433.48 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.96 55.81,503.36 57.09,500.08 61.50,490.06 66.38,480.96 67.19,479.63 72.87,471.37 78.56,464.76 82.64,460.81 84.25,459.40 89.94,454.99 95.63,451.32 101.32,448.21 107.01,445.54 112.70,443.21 115.16,442.28 118.39,441.14 124.08,439.30 129.77,437.63 135.46,436.11 141.15,434.70 146.83,433.40 152.52,432.19 158.21,431.05 163.90,429.98 169.59,428.98 175.28,428.03 180.97,427.14 186.66,426.29 189.50,425.89 192.35,425.49 198.04,424.73 203.73,424.02 209.42,423.35 215.11,422.71 220.79,422.11 226.48,421.54 232.17,421.01 237.86,420.51 243.55,420.04 249.24,419.60 254.93,419.19 259.20,418.91 260.62,418.81 266.31,418.46 272.00,418.13 277.69,417.83 283.38,417.55 289.07,417.30 294.76,417.07 300.44,416.86 306.13,416.68 311.82,416.51 317.51,416.37 323.20,416.24 328.89,416.13 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.94 54.84,508.78 50.04,508.78 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.20 54.84,508.05 50.04,508.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.47 59.49,507.31 54.69,507.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,519.20 59.49,515.05 54.69,515.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.63 68.78,491.47 63.98,491.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,498.94 68.78,494.79 63.98,494.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,473.15 85.04,469.00 80.24,469.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,479.79 85.04,475.63 80.24,475.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,455.10 117.56,450.95 112.76,450.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.94 117.56,452.79 112.76,452.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,444.05 191.90,439.89 187.10,439.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,440.37 191.90,436.21 187.10,436.21 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,430.79 261.60,426.63 256.80,426.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,427.84 261.60,423.68 256.80,423.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,434.47 331.29,430.32 326.49,430.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,435.95 331.29,431.79 326.49,431.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.34 55.81,510.69 57.09,508.64 61.50,502.03 66.38,495.40 67.19,494.37 72.87,487.59 78.56,481.57 82.64,477.68 84.25,476.23 89.94,471.47 95.63,467.24 101.32,463.45 107.01,460.07 112.70,457.03 115.16,455.81 118.39,454.31 124.08,451.85 129.77,449.64 135.46,447.64 141.15,445.83 146.83,444.18 152.52,442.68 158.21,441.31 163.90,440.06 169.59,438.91 175.28,437.86 180.97,436.89 186.66,435.99 189.50,435.57 192.35,435.16 198.04,434.40 203.73,433.68 209.42,433.02 215.11,432.41 220.79,431.84 226.48,431.30 232.17,430.80 237.86,430.34 243.55,429.90 249.24,429.49 254.93,429.11 259.20,428.84 260.62,428.76 266.31,428.42 272.00,428.11 277.69,427.82 283.38,427.55 289.07,427.30 294.76,427.06 300.44,426.84 306.13,426.64 311.82,426.46 317.51,426.28 323.20,426.12 328.89,425.98 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='516.00' x2='54.22' y2='512.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='512.44' x2='54.22' y2='516.00' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='508.64' x2='54.22' y2='505.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.07' x2='54.22' y2='508.64' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='492.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='495.74' x2='58.87' y2='492.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='492.18' x2='58.87' y2='495.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='499.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.48' x2='58.87' y2='499.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='499.92' x2='58.87' y2='503.48' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='468.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='472.17' x2='68.16' y2='468.60' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='468.60' x2='68.16' y2='472.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='467.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='470.69' x2='68.16' y2='467.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='467.13' x2='68.16' y2='470.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='431.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='434.96' x2='84.42' y2='431.39' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='431.39' x2='84.42' y2='434.96' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='450.55' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='454.11' x2='84.42' y2='450.55' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='450.55' x2='84.42' y2='454.11' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='400.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='404.38' x2='116.95' y2='400.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='400.82' x2='116.95' y2='404.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='405.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='409.54' x2='116.95' y2='405.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='405.97' x2='116.95' y2='409.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='389.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='393.33' x2='191.29' y2='389.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='389.76' x2='191.29' y2='393.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='387.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='390.75' x2='191.29' y2='387.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='387.18' x2='191.29' y2='390.75' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='399.22' x2='260.98' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='395.66' x2='260.98' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='377.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='380.80' x2='260.98' y2='377.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='377.24' x2='260.98' y2='380.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='399.22' x2='330.67' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='395.66' x2='330.67' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='373.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='377.49' x2='330.67' y2='373.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='373.92' x2='330.67' y2='377.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.52 55.81,501.86 57.09,498.07 61.50,485.98 66.38,474.20 67.19,472.40 72.87,460.78 78.56,450.80 82.64,444.51 84.25,442.21 89.94,434.80 95.63,428.39 101.32,422.83 107.01,417.99 112.70,413.77 115.16,412.11 118.39,410.08 124.08,406.84 129.77,404.00 135.46,401.49 141.15,399.28 146.83,397.32 152.52,395.58 158.21,394.03 163.90,392.66 169.59,391.43 175.28,390.34 180.97,389.38 186.66,388.51 189.50,388.12 192.35,387.75 198.04,387.07 203.73,386.47 209.42,385.94 215.11,385.48 220.79,385.08 226.48,384.73 232.17,384.44 237.86,384.19 243.55,383.99 249.24,383.83 254.93,383.71 259.20,383.64 260.62,383.62 266.31,383.57 272.00,383.55 277.69,383.56 283.38,383.60 289.07,383.66 294.76,383.75 300.44,383.87 306.13,384.01 311.82,384.16 317.51,384.34 323.20,384.54 328.89,384.76 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.06' x2='54.22' y2='509.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.49' x2='54.22' y2='513.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='511.28' x2='54.96' y2='511.28' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.80' x2='52.44' y2='508.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.74' x2='54.22' y2='506.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='506.18' x2='54.22' y2='509.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='507.96' x2='54.96' y2='507.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='510.48' x2='52.44' y2='505.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='493.90' x2='58.87' y2='490.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='490.34' x2='58.87' y2='493.90' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='492.12' x2='59.61' y2='492.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='494.64' x2='57.09' y2='489.60' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='488.37' x2='58.87' y2='484.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='484.81' x2='58.87' y2='488.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='486.59' x2='59.61' y2='486.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='489.11' x2='57.09' y2='484.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='459.64' x2='68.16' y2='456.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.08' x2='68.16' y2='459.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='457.86' x2='68.90' y2='457.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='460.38' x2='66.38' y2='455.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='460.38' x2='68.16' y2='456.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.81' x2='68.16' y2='460.38' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='458.59' x2='68.90' y2='458.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='461.11' x2='66.38' y2='456.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='430.54' x2='84.42' y2='426.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='426.97' x2='84.42' y2='430.54' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='428.75' x2='85.16' y2='428.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.27' x2='82.64' y2='426.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='441.22' x2='84.42' y2='437.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='437.66' x2='84.42' y2='441.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='439.44' x2='85.16' y2='439.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='441.96' x2='82.64' y2='436.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='397.01' x2='116.95' y2='393.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='393.45' x2='116.95' y2='397.01' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='395.23' x2='117.68' y2='395.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='397.75' x2='115.16' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='391.49' x2='116.95' y2='387.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='387.92' x2='116.95' y2='391.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='389.70' x2='117.68' y2='389.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='392.22' x2='115.16' y2='387.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='377.12' x2='191.29' y2='373.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='373.55' x2='191.29' y2='377.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='375.34' x2='192.02' y2='375.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='377.86' x2='189.50' y2='372.82' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='399.22' x2='191.29' y2='395.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='395.66' x2='191.29' y2='399.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='397.44' x2='192.02' y2='397.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='399.96' x2='189.50' y2='394.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='382.64' x2='260.98' y2='379.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='379.08' x2='260.98' y2='382.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='380.86' x2='261.72' y2='380.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='383.38' x2='259.20' y2='378.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='396.27' x2='260.98' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='392.71' x2='260.98' y2='396.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.49' x2='261.72' y2='394.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.01' x2='259.20' y2='391.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='374.91' x2='330.67' y2='371.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='371.34' x2='330.67' y2='374.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='373.13' x2='331.41' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='375.65' x2='328.89' y2='370.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='393.70' x2='330.67' y2='390.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='390.13' x2='330.67' y2='393.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='391.91' x2='331.41' y2='391.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='394.43' x2='328.89' y2='389.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,508.25 55.81,492.74 57.09,487.45 61.50,471.47 66.38,457.17 67.19,455.10 72.87,442.44 78.56,432.58 82.64,426.85 84.25,424.85 89.94,418.73 95.63,413.85 101.32,409.90 107.01,406.67 112.70,404.00 115.16,402.98 118.39,401.75 124.08,399.84 129.77,398.19 135.46,396.75 141.15,395.47 146.83,394.33 152.52,393.30 158.21,392.36 163.90,391.51 169.59,390.72 175.28,389.99 180.97,389.31 186.66,388.68 189.50,388.39 192.35,388.10 198.04,387.56 203.73,387.05 209.42,386.58 215.11,386.15 220.79,385.74 226.48,385.37 232.17,385.02 237.86,384.71 243.55,384.42 249.24,384.16 254.93,383.92 259.20,383.76 260.62,383.71 266.31,383.52 272.00,383.35 277.69,383.21 283.38,383.08 289.07,382.98 294.76,382.90 300.44,382.84 306.13,382.80 311.82,382.77 317.51,382.77 323.20,382.78 328.89,382.81 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='505.38' x2='54.96' y2='505.38' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='507.90' x2='52.44' y2='502.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,505.38 52.44,502.86 54.96,505.38 52.44,507.90 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='509.07' x2='54.96' y2='509.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='511.59' x2='52.44' y2='506.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,509.07 52.44,506.55 54.96,509.07 52.44,511.59 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='487.70' x2='59.61' y2='487.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='490.22' x2='57.09' y2='485.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,487.70 57.09,485.18 59.61,487.70 57.09,490.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='493.22' x2='59.61' y2='493.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='495.74' x2='57.09' y2='490.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,493.22 57.09,490.70 59.61,493.22 57.09,495.74 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='461.17' x2='68.90' y2='461.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='463.69' x2='66.38' y2='458.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,461.17 66.38,458.65 68.90,461.17 66.38,463.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='469.28' x2='68.90' y2='469.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='471.80' x2='66.38' y2='466.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,469.28 66.38,466.76 68.90,469.28 66.38,471.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.12' x2='85.16' y2='429.12' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.64' x2='82.64' y2='426.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.12 82.64,426.60 85.16,429.12 82.64,431.64 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.86' x2='85.16' y2='429.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='432.38' x2='82.64' y2='427.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.86 82.64,427.34 85.16,429.86 82.64,432.38 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='391.91' x2='117.68' y2='391.91' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='394.43' x2='115.16' y2='389.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,391.91 115.16,389.39 117.68,391.91 115.16,394.43 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='404.81' x2='117.68' y2='404.81' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='407.33' x2='115.16' y2='402.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,404.81 115.16,402.29 117.68,404.81 115.16,407.33 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='361.70' x2='192.02' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='364.22' x2='189.50' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,361.70 189.50,359.18 192.02,361.70 189.50,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='355.44' x2='192.02' y2='355.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='357.96' x2='189.50' y2='352.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,355.44 189.50,352.92 192.02,355.44 189.50,357.96 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='361.70' x2='261.72' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='364.22' x2='259.20' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,361.70 259.20,359.18 261.72,361.70 259.20,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='358.76' x2='261.72' y2='358.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='361.28' x2='259.20' y2='356.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,358.76 259.20,356.24 261.72,358.76 259.20,361.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='344.39' x2='331.41' y2='344.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='346.91' x2='328.89' y2='341.87' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,344.39 328.89,341.87 331.41,344.39 328.89,346.91 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='353.23' x2='331.41' y2='353.23' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='355.75' x2='328.89' y2='350.71' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,353.23 328.89,350.71 331.41,353.23 328.89,355.75 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,511.20 55.81,498.79 57.09,494.37 61.50,480.31 66.38,466.63 67.19,464.54 72.87,451.04 78.56,439.46 82.64,432.16 84.25,429.48 89.94,420.86 95.63,413.39 101.32,406.89 107.01,401.22 112.70,396.24 115.16,394.27 118.39,391.86 124.08,387.98 129.77,384.55 135.46,381.49 141.15,378.75 146.83,376.29 152.52,374.08 158.21,372.08 163.90,370.27 169.59,368.62 175.28,367.12 180.97,365.76 186.66,364.50 189.50,363.92 192.35,363.36 198.04,362.31 203.73,361.35 209.42,360.47 215.11,359.66 220.79,358.92 226.48,358.25 232.17,357.63 237.86,357.07 243.55,356.56 249.24,356.10 254.93,355.68 259.20,355.40 260.62,355.31 266.31,354.98 272.00,354.70 277.69,354.44 283.38,354.23 289.07,354.05 294.76,353.90 300.44,353.78 306.13,353.69 311.82,353.63 317.51,353.60 323.20,353.60 328.89,353.62 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='514.59' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='514.59' x2='54.22' y2='514.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.37' x2='52.44' y2='512.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='517.17' x2='54.22' y2='517.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='518.95' x2='52.44' y2='515.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='507.22' x2='58.87' y2='507.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='509.01' x2='57.09' y2='505.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='503.91' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.91' x2='58.87' y2='503.91' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='505.69' x2='57.09' y2='502.13' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='483.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='483.28' x2='68.16' y2='483.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='485.06' x2='66.38' y2='481.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='479.96' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='479.96' x2='68.16' y2='479.96' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='481.74' x2='66.38' y2='478.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='456.02' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='456.02' x2='84.42' y2='456.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='457.80' x2='82.64' y2='454.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='457.86' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='457.86' x2='84.42' y2='457.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='459.64' x2='82.64' y2='456.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='416.60' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.60' x2='116.95' y2='416.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='418.38' x2='115.16' y2='414.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='417.33' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.33' x2='116.95' y2='417.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='419.12' x2='115.16' y2='415.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='383.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='383.81' x2='191.29' y2='383.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='385.59' x2='189.50' y2='382.03' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='391.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='391.18' x2='191.29' y2='391.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='392.96' x2='189.50' y2='389.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='368.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='368.34' x2='260.98' y2='368.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='370.12' x2='259.20' y2='366.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='361.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='361.34' x2='260.98' y2='361.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='363.12' x2='259.20' y2='359.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='355.07' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='355.07' x2='330.67' y2='355.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='356.86' x2='328.89' y2='353.29' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='349.55' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='349.55' x2='330.67' y2='349.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='351.33' x2='328.89' y2='347.77' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.92 55.81,507.22 57.09,504.40 61.50,495.10 66.38,485.53 67.19,484.02 72.87,473.88 78.56,464.59 82.64,458.42 84.25,456.08 89.94,448.28 95.63,441.12 101.32,434.55 107.01,428.51 112.70,422.96 115.16,420.69 118.39,417.85 124.08,413.14 129.77,408.81 135.46,404.81 141.15,401.13 146.83,397.72 152.52,394.58 158.21,391.68 163.90,388.99 169.59,386.51 175.28,384.22 180.97,382.09 186.66,380.13 189.50,379.20 192.35,378.31 198.04,376.63 203.73,375.07 209.42,373.63 215.11,372.30 220.79,371.07 226.48,369.93 232.17,368.89 237.86,367.92 243.55,367.03 249.24,366.21 254.93,365.46 259.20,364.94 260.62,364.78 266.31,364.15 272.00,363.58 277.69,363.06 283.38,362.59 289.07,362.17 294.76,361.79 300.44,361.46 306.13,361.16 311.82,360.91 317.51,360.69 323.20,360.50 328.89,360.34 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,518.10 54.84,513.25 50.04,513.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.56 54.84,517.41 50.04,517.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.36 54.84,512.51 50.04,512.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,511.82 54.84,516.67 50.04,516.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,516.99 59.49,512.14 54.69,512.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,516.30 54.69,516.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,509.99 59.49,505.14 54.69,505.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,504.45 59.49,509.30 54.69,509.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,501.52 68.78,496.67 63.98,496.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.98 68.78,500.83 63.98,500.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,503.36 68.78,498.51 63.98,498.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,497.82 68.78,502.67 63.98,502.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,480.89 85.04,476.04 80.24,476.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,475.35 85.04,480.20 80.24,480.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,487.52 85.04,482.67 80.24,482.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,481.98 85.04,486.83 80.24,486.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,461.73 117.56,456.88 112.76,456.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.19 117.56,461.04 112.76,461.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,449.21 117.56,444.36 112.76,444.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,443.67 117.56,448.52 112.76,448.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.95 191.90,417.10 187.10,417.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,416.40 191.90,421.25 187.10,421.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,429.68 191.90,424.83 187.10,424.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.99 187.10,428.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,425.63 261.60,420.78 256.80,420.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.09 261.60,424.94 256.80,424.94 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,426.37 261.60,421.52 256.80,421.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.83 261.60,425.67 256.80,425.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,409.42 331.29,404.57 326.49,404.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,403.88 331.29,408.73 326.49,408.73 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,413.47 331.29,408.62 326.49,408.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.93 331.29,412.78 326.49,412.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,517.00 55.81,512.16 57.09,510.38 61.50,504.49 66.38,498.38 67.19,497.42 72.87,490.90 78.56,484.89 82.64,480.87 84.25,479.34 89.94,474.21 95.63,469.48 101.32,465.10 107.01,461.05 112.70,457.30 115.16,455.76 118.39,453.82 124.08,450.60 129.77,447.61 135.46,444.84 141.15,442.27 146.83,439.87 152.52,437.65 158.21,435.58 163.90,433.66 169.59,431.86 175.28,430.19 180.97,428.64 186.66,427.18 189.50,426.50 192.35,425.83 198.04,424.57 203.73,423.39 209.42,422.28 215.11,421.26 220.79,420.30 226.48,419.40 232.17,418.56 237.86,417.78 243.55,417.04 249.24,416.36 254.93,415.72 259.20,415.27 260.62,415.13 266.31,414.57 272.00,414.06 277.69,413.58 283.38,413.13 289.07,412.72 294.76,412.33 300.44,411.98 306.13,411.65 311.82,411.34 317.51,411.06 323.20,410.81 328.89,410.58 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='519.38' x2='54.22' y2='519.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='521.16' x2='52.44' y2='517.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='517.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='511.28' x2='54.22' y2='511.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.06' x2='52.44' y2='509.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.85' x2='58.87' y2='506.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='508.64' x2='57.09' y2='505.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.75' x2='58.87' y2='505.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='507.53' x2='57.09' y2='503.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='503.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.70' x2='68.16' y2='494.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='496.48' x2='66.38' y2='492.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='492.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='497.28' x2='68.16' y2='497.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='499.06' x2='66.38' y2='495.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='495.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.91' x2='84.42' y2='475.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='477.69' x2='82.64' y2='474.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='474.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='478.49' x2='84.42' y2='478.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='480.27' x2='82.64' y2='476.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='476.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.44' x2='116.95' y2='453.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.22' x2='115.16' y2='451.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='451.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.81' x2='116.95' y2='453.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.59' x2='115.16' y2='452.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='452.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='415.49' x2='191.29' y2='415.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='417.27' x2='189.50' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='413.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.75' x2='191.29' y2='421.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='423.54' x2='189.50' y2='419.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='419.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.86' x2='260.98' y2='401.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='403.64' x2='259.20' y2='400.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='400.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='414.39' x2='260.98' y2='414.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='416.17' x2='259.20' y2='412.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='412.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='394.12' x2='330.67' y2='394.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='395.91' x2='328.89' y2='392.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='409.23' x2='330.67' y2='409.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='411.01' x2='328.89' y2='407.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='407.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.43 55.81,510.81 57.09,508.76 61.50,501.98 66.38,495.00 67.19,493.89 72.87,486.50 78.56,479.73 82.64,475.24 84.25,473.54 89.94,467.85 95.63,462.64 101.32,457.86 107.01,453.47 112.70,449.43 115.16,447.78 118.39,445.72 124.08,442.31 129.77,439.16 135.46,436.27 141.15,433.60 146.83,431.15 152.52,428.88 158.21,426.79 163.90,424.86 169.59,423.08 175.28,421.44 180.97,419.92 186.66,418.52 189.50,417.86 192.35,417.22 198.04,416.03 203.73,414.93 209.42,413.91 215.11,412.97 220.79,412.11 226.48,411.32 232.17,410.59 237.86,409.92 243.55,409.30 249.24,408.74 254.93,408.23 259.20,407.88 260.62,407.76 266.31,407.34 272.00,406.96 277.69,406.61 283.38,406.30 289.07,406.03 294.76,405.79 300.44,405.57 306.13,405.39 311.82,405.23 317.51,405.10 323.20,405.00 328.89,404.92 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.95' x2='54.22' y2='515.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='515.39' x2='54.22' y2='518.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='520.12' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='521.90' x2='54.22' y2='518.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.34' x2='54.22' y2='521.90' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='509.01' x2='58.87' y2='505.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.44' x2='58.87' y2='509.01' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='502.07' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.85' x2='58.87' y2='500.28' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='500.28' x2='58.87' y2='503.85' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='492.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.27' x2='68.16' y2='490.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='490.71' x2='68.16' y2='494.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='496.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='498.32' x2='68.16' y2='494.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.76' x2='68.16' y2='498.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='477.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='479.53' x2='84.42' y2='475.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.97' x2='84.42' y2='479.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='472.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='474.38' x2='84.42' y2='470.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='470.81' x2='84.42' y2='474.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='443.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='445.27' x2='116.95' y2='441.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='441.71' x2='116.95' y2='445.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='451.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.38' x2='116.95' y2='449.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='449.81' x2='116.95' y2='453.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.33' x2='191.29' y2='417.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='417.76' x2='191.29' y2='421.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='406.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='408.43' x2='191.29' y2='404.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='404.87' x2='191.29' y2='408.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='421.69' x2='260.98' y2='418.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='418.13' x2='260.98' y2='421.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='400.02' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.80' x2='260.98' y2='398.24' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='398.24' x2='260.98' y2='401.80' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='405.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='407.33' x2='330.67' y2='403.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='403.76' x2='330.67' y2='407.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.33' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='405.12' x2='330.67' y2='401.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='401.55' x2='330.67' y2='405.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.02 55.81,509.88 57.09,507.64 61.50,500.29 66.38,492.79 67.19,491.61 72.87,483.76 78.56,476.64 82.64,471.95 84.25,470.18 89.94,464.33 95.63,459.00 101.32,454.17 107.01,449.76 112.70,445.76 115.16,444.13 118.39,442.10 124.08,438.77 129.77,435.73 135.46,432.96 141.15,430.42 146.83,428.10 152.52,425.98 158.21,424.03 163.90,422.26 169.59,420.63 175.28,419.13 180.97,417.77 186.66,416.51 189.50,415.93 192.35,415.37 198.04,414.31 203.73,413.35 209.42,412.47 215.11,411.67 220.79,410.93 226.48,410.26 232.17,409.65 237.86,409.10 243.55,408.60 249.24,408.15 254.93,407.74 259.20,407.46 260.62,407.38 266.31,407.05 272.00,406.76 277.69,406.51 283.38,406.29 289.07,406.10 294.76,405.94 300.44,405.81 306.13,405.71 311.82,405.63 317.51,405.57 323.20,405.54 328.89,405.52 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.44 54.22,516.00 50.66,516.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,509.86 54.22,513.43 50.66,513.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,497.34 58.87,500.90 55.30,500.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='497.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,498.81 58.87,502.37 55.30,502.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='498.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,485.18 68.16,488.74 64.60,488.74 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='485.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,471.92 68.16,475.48 64.60,475.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='471.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,446.87 84.42,450.43 80.86,450.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='446.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,451.29 84.42,454.85 80.86,454.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='451.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,431.02 116.95,434.59 113.38,434.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='431.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,421.08 116.95,424.64 113.38,424.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='421.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,397.50 191.29,401.06 187.72,401.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='397.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,386.82 191.29,390.38 187.72,390.38 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='386.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,399.34 260.98,402.91 257.42,402.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='399.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,383.87 260.98,387.43 257.42,387.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='383.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,396.03 330.67,399.59 327.11,399.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='396.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,392.34 330.67,395.91 327.11,395.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,513.91 55.81,505.05 57.09,501.87 61.50,491.67 66.38,481.59 67.19,480.04 72.87,469.92 78.56,461.10 82.64,455.47 84.25,453.39 89.94,446.63 95.63,440.70 101.32,435.48 107.01,430.87 112.70,426.79 115.16,425.17 118.39,423.17 124.08,419.95 129.77,417.07 135.46,414.50 141.15,412.18 146.83,410.10 152.52,408.23 158.21,406.53 163.90,404.99 169.59,403.59 175.28,402.31 180.97,401.15 186.66,400.09 189.50,399.59 192.35,399.12 198.04,398.23 203.73,397.41 209.42,396.66 215.11,395.98 220.79,395.35 226.48,394.77 232.17,394.25 237.86,393.77 243.55,393.33 249.24,392.93 254.93,392.57 259.20,392.32 260.62,392.24 266.31,391.95 272.00,391.68 277.69,391.45 283.38,391.25 289.07,391.07 294.76,390.92 300.44,390.79 306.13,390.69 311.82,390.61 317.51,390.55 323.20,390.51 328.89,390.49 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,513.06 54.22,513.06 54.22,509.49 50.66,509.49 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,514.90 54.22,514.90 54.22,511.34 50.66,511.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,501.64 58.87,501.64 58.87,498.07 55.30,498.07 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,499.43 58.87,499.43 58.87,495.86 55.30,495.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,486.90 68.16,486.90 68.16,483.34 64.60,483.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,472.90 68.16,472.90 68.16,469.34 64.60,469.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,462.22 84.42,462.22 84.42,458.65 80.86,458.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,455.22 84.42,455.22 84.42,451.65 80.86,451.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,427.59 116.95,427.59 116.95,424.02 113.38,424.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,428.33 116.95,428.33 116.95,424.76 113.38,424.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,400.33 191.29,400.33 191.29,396.76 187.72,396.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,399.96 191.29,399.96 191.29,396.39 187.72,396.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,390.38 260.98,390.38 260.98,386.82 257.42,386.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,396.27 260.98,396.27 260.98,392.71 257.42,392.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,383.38 330.67,383.38 330.67,379.82 327.11,379.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,402.54 330.67,402.54 330.67,398.97 327.11,398.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.79 55.81,502.60 57.09,499.00 61.50,487.65 66.38,476.77 67.19,475.12 72.87,464.59 78.56,455.70 82.64,450.18 84.25,448.17 89.94,441.77 95.63,436.31 101.32,431.61 107.01,427.56 112.70,424.05 115.16,422.67 118.39,420.99 124.08,418.30 129.77,415.93 135.46,413.82 141.15,411.94 146.83,410.25 152.52,408.72 158.21,407.34 163.90,406.07 169.59,404.92 175.28,403.86 180.97,402.88 186.66,401.97 189.50,401.54 192.35,401.13 198.04,400.35 203.73,399.62 209.42,398.95 215.11,398.31 220.79,397.72 226.48,397.17 232.17,396.66 237.86,396.18 243.55,395.73 249.24,395.32 254.93,394.93 259.20,394.66 260.62,394.58 266.31,394.25 272.00,393.94 277.69,393.66 283.38,393.41 289.07,393.18 294.76,392.97 300.44,392.78 306.13,392.61 311.82,392.46 317.51,392.33 323.20,392.23 328.89,392.14 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='527.53' x2='656.27' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='527.53' x2='410.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='471.66' y1='527.53' x2='471.66' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='533.20' y1='527.53' x2='533.20' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='594.73' y1='527.53' x2='594.73' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='656.27' y1='527.53' x2='656.27' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='467.27' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='528.81' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='590.34' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='651.88' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<line x1='398.97' y1='509.54' x2='398.97' y2='355.34' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='509.54' x2='394.21' y2='509.54' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='470.99' x2='394.21' y2='470.99' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='432.44' x2='394.21' y2='432.44' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='393.89' x2='394.21' y2='393.89' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='355.34' x2='394.21' y2='355.34' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,513.05) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,474.50) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,434.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,396.08) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,357.53) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,527.53 700.04,527.53 700.04,337.35 398.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5'>
+ <rect x='360.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text x='532.82' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text transform='translate(368.55,470.64) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='432.44' x2='700.04' y2='432.44' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='420.66' cy='427.63' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='420.66' cy='431.13' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='439.74' cy='424.82' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='439.74' cy='435.34' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='471.11' cy='437.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='471.11' cy='445.14' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='509.99' cy='429.84' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='509.99' cy='450.18' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='553.19' cy='430.67' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='553.19' cy='427.17' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='591.18' cy='418.57' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='591.18' cy='447.32' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='605.45' cy='429.22' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='605.45' cy='442.55' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='611.79' cy='411.20' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='611.79' cy='439.96' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.65,437.55 420.05,441.71 415.25,441.71 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.65,424.93 420.05,429.08 415.25,429.08 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='431.73,427.64 434.13,431.80 429.33,431.80 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='431.73,442.37 434.13,446.53 429.33,446.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='456.34,426.23 458.74,430.39 453.94,430.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='456.34,434.65 458.74,438.81 453.94,438.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='490.12,419.15 492.52,423.31 487.72,423.31 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='490.12,433.18 492.52,437.33 487.72,437.33 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='533.47,443.30 535.87,447.46 531.07,447.46 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='533.47,416.65 535.87,420.81 531.07,420.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='574.83,433.63 577.23,437.79 572.43,437.79 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='574.83,439.24 577.23,443.40 572.43,443.40 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='587.40,422.01 589.80,426.17 585.00,426.17 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='587.40,421.31 589.80,425.47 585.00,425.47 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='591.55,445.67 593.95,449.83 589.15,449.83 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='591.55,426.04 593.95,430.19 589.15,430.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.88' y1='427.41' x2='419.92' y2='427.41' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.40' y1='429.93' x2='417.40' y2='424.89' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.78' y1='433.43' x2='433.82' y2='433.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='431.30' y1='435.95' x2='431.30' y2='430.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.78' y1='441.85' x2='433.82' y2='441.85' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='431.30' y1='444.37' x2='431.30' y2='439.33' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.09' y1='415.29' x2='459.13' y2='415.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='456.61' y1='417.81' x2='456.61' y2='412.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.09' y1='421.60' x2='459.13' y2='421.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='456.61' y1='424.12' x2='456.61' y2='419.08' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='491.47' y1='430.53' x2='496.51' y2='430.53' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='493.99' y1='433.05' x2='493.99' y2='428.01' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='491.47' y1='417.91' x2='496.51' y2='417.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='493.99' y1='420.43' x2='493.99' y2='415.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='545.91' y1='432.97' x2='550.95' y2='432.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='548.43' y1='435.49' x2='548.43' y2='430.45' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='545.91' y1='428.06' x2='550.95' y2='428.06' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='548.43' y1='430.58' x2='548.43' y2='425.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='609.82' y1='442.68' x2='614.86' y2='442.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='612.34' y1='445.20' x2='612.34' y2='440.16' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='609.82' y1='410.42' x2='614.86' y2='410.42' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='612.34' y1='412.94' x2='612.34' y2='407.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.33' y1='432.56' x2='637.37' y2='432.56' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='634.85' y1='435.08' x2='634.85' y2='430.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.33' y1='449.40' x2='637.37' y2='449.40' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='634.85' y1='451.92' x2='634.85' y2='446.88' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.91' y1='442.88' x2='643.95' y2='442.88' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='641.43' y1='445.40' x2='641.43' y2='440.36' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.91' y1='425.34' x2='643.95' y2='425.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='641.43' y1='427.86' x2='641.43' y2='422.82' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.68' y1='428.74' x2='421.25' y2='425.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.68' y1='425.18' x2='421.25' y2='428.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.68' y1='420.32' x2='421.25' y2='416.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.68' y1='416.76' x2='421.25' y2='420.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.47' y1='427.27' x2='439.03' y2='423.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.47' y1='423.71' x2='439.03' y2='427.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.47' y1='442.00' x2='439.03' y2='438.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.47' y1='438.43' x2='439.03' y2='442.00' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='467.70' y1='429.64' x2='471.26' y2='426.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='467.70' y1='426.07' x2='471.26' y2='429.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='467.70' y1='431.74' x2='471.26' y2='428.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='467.70' y1='428.18' x2='471.26' y2='431.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.84' y1='423.04' x2='518.40' y2='419.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.84' y1='419.48' x2='518.40' y2='423.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.84' y1='452.50' x2='518.40' y2='448.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.84' y1='448.93' x2='518.40' y2='452.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='582.19' y1='432.48' x2='585.76' y2='428.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='582.19' y1='428.91' x2='585.76' y2='432.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='582.19' y1='438.09' x2='585.76' y2='434.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='582.19' y1='434.52' x2='585.76' y2='438.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='657.73' y1='437.90' x2='661.29' y2='434.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='657.73' y1='434.34' x2='661.29' y2='437.90' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='657.73' y1='425.98' x2='661.29' y2='422.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='657.73' y1='422.42' x2='661.29' y2='425.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.83' y1='438.72' x2='685.39' y2='435.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.83' y1='435.16' x2='685.39' y2='438.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.83' y1='426.80' x2='685.39' y2='423.24' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.83' y1='423.24' x2='685.39' y2='426.80' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.05' y1='437.66' x2='690.62' y2='434.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.05' y1='434.10' x2='690.62' y2='437.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.05' y1='419.43' x2='690.62' y2='415.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='687.05' y1='415.87' x2='690.62' y2='419.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='420.16,436.94 422.69,434.42 425.21,436.94 422.69,439.46 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='420.16,431.33 422.69,428.81 425.21,431.33 422.69,433.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.69,436.23 444.21,433.71 446.73,436.23 444.21,438.75 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.69,432.72 444.21,430.20 446.73,432.72 444.21,435.24 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='473.63,440.36 476.15,437.84 478.67,440.36 476.15,442.88 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='473.63,435.45 476.15,432.93 478.67,435.45 476.15,437.97 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='507.28,426.82 509.80,424.30 512.32,426.82 509.80,429.34 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='507.28,440.84 509.80,438.32 512.32,440.84 509.80,443.36 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='538.23,433.33 540.75,430.81 543.27,433.33 540.75,435.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='538.23,429.83 540.75,427.31 543.27,429.83 540.75,432.35 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='565.62,426.68 568.14,424.16 570.66,426.68 568.14,429.20 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='565.62,424.57 568.14,422.05 570.66,424.57 568.14,427.09 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='577.28,436.46 579.80,433.94 582.32,436.46 579.80,438.98 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='577.28,428.04 579.80,425.52 582.32,428.04 579.80,430.56 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='581.91,425.60 584.43,423.08 586.95,425.60 584.43,428.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='581.91,460.67 584.43,458.15 586.95,460.67 584.43,463.19 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.05,423.47 419.45,419.31 414.65,419.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.05,422.07 419.45,417.91 414.65,417.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.90,435.31 432.30,431.15 427.50,431.15 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.90,450.04 432.30,445.88 427.50,445.88 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='452.02,430.37 454.42,426.21 449.62,426.21 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='452.02,436.68 454.42,432.52 449.62,432.52 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='481.62,421.32 484.02,417.16 479.22,417.16 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='481.62,433.94 484.02,429.79 479.22,429.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.15,428.58 520.55,424.42 515.75,424.42 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.15,432.08 520.55,427.93 515.75,427.93 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='551.97,446.08 554.37,441.92 549.57,441.92 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='551.97,439.07 554.37,434.91 549.57,434.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.20,433.63 565.60,429.48 560.80,429.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.20,428.02 565.60,423.87 560.80,423.87 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.98,446.10 570.38,441.94 565.58,441.94 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.98,448.91 570.38,444.75 565.58,444.75 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.64' y='433.90' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.64' y1='437.46' x2='425.21' y2='433.90' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.64' y1='433.90' x2='425.21' y2='437.46' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.64' y='419.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.64' y1='423.44' x2='425.21' y2='419.87' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.64' y1='419.87' x2='425.21' y2='423.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='445.79' y='422.84' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.79' y1='426.40' x2='449.35' y2='422.84' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.79' y1='422.84' x2='449.35' y2='426.40' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='445.79' y='437.57' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.79' y1='441.13' x2='449.35' y2='437.57' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.79' y1='437.57' x2='449.35' y2='441.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='485.65' y='423.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.65' y1='426.95' x2='489.22' y2='423.39' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.65' y1='423.39' x2='489.22' y2='426.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='485.65' y='420.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.65' y1='424.15' x2='489.22' y2='420.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.65' y1='420.58' x2='489.22' y2='424.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='535.24' y='409.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.24' y1='412.64' x2='538.81' y2='409.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.24' y1='409.07' x2='538.81' y2='412.64' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='535.24' y='445.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.24' y1='449.10' x2='538.81' y2='445.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.24' y1='445.54' x2='538.81' y2='449.10' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='589.37' y='412.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='589.37' y1='416.11' x2='592.93' y2='412.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='589.37' y1='412.54' x2='592.93' y2='416.11' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='589.37' y='422.36' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='589.37' y1='425.93' x2='592.93' y2='422.36' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='589.37' y1='422.36' x2='592.93' y2='425.93' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='629.45' y='437.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.45' y1='440.74' x2='633.01' y2='437.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.45' y1='437.18' x2='633.01' y2='440.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='629.45' y='432.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.45' y1='435.83' x2='633.01' y2='432.27' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.45' y1='432.27' x2='633.01' y2='435.83' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='636.93' y='456.93' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.93' y1='460.49' x2='640.49' y2='456.93' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.93' y1='456.93' x2='640.49' y2='460.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='636.93' y='421.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.93' y1='425.43' x2='640.49' y2='421.86' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.93' y1='421.86' x2='640.49' y2='425.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='635.06' y='454.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.06' y1='458.36' x2='638.62' y2='454.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.06' y1='454.80' x2='638.62' y2='458.36' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='635.06' y='413.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.06' y1='416.98' x2='638.62' y2='413.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.06' y1='413.42' x2='638.62' y2='416.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='439.98' x2='432.34' y2='436.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='436.41' x2='432.34' y2='439.98' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='438.20' x2='433.07' y2='438.20' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='430.55' y1='440.72' x2='430.55' y2='435.68' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='433.67' x2='432.34' y2='430.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='430.10' x2='432.34' y2='433.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='431.88' x2='433.07' y2='431.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='430.55' y1='434.40' x2='430.55' y2='429.36' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.52' y1='443.11' x2='467.08' y2='439.54' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.52' y1='439.54' x2='467.08' y2='443.11' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='462.78' y1='441.32' x2='467.82' y2='441.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='465.30' y1='443.84' x2='465.30' y2='438.80' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.52' y1='432.59' x2='467.08' y2='429.02' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.52' y1='429.02' x2='467.08' y2='432.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='462.78' y1='430.80' x2='467.82' y2='430.80' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='465.30' y1='433.32' x2='465.30' y2='428.28' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.10' y1='435.53' x2='517.66' y2='431.96' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.10' y1='431.96' x2='517.66' y2='435.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.36' y1='433.74' x2='518.40' y2='433.74' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='515.88' y1='436.26' x2='515.88' y2='431.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.10' y1='436.93' x2='517.66' y2='433.36' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.10' y1='433.36' x2='517.66' y2='436.93' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.36' y1='435.15' x2='518.40' y2='435.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='515.88' y1='437.67' x2='515.88' y2='432.63' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.74' y1='437.84' x2='568.30' y2='434.27' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.74' y1='434.27' x2='568.30' y2='437.84' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.00' y1='436.05' x2='569.04' y2='436.05' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='566.52' y1='438.57' x2='566.52' y2='433.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.74' y1='458.17' x2='568.30' y2='454.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.74' y1='454.61' x2='568.30' y2='458.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='564.00' y1='456.39' x2='569.04' y2='456.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='566.52' y1='458.91' x2='566.52' y2='453.87' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.63' y1='419.47' x2='608.19' y2='415.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.63' y1='415.91' x2='608.19' y2='419.47' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.89' y1='417.69' x2='608.93' y2='417.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='606.41' y1='420.21' x2='606.41' y2='415.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.63' y1='408.95' x2='608.19' y2='405.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='604.63' y1='405.39' x2='608.19' y2='408.95' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.89' y1='407.17' x2='608.93' y2='407.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='606.41' y1='409.69' x2='606.41' y2='404.65' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.00' y1='409.37' x2='632.56' y2='405.81' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.00' y1='405.81' x2='632.56' y2='409.37' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.26' y1='407.59' x2='633.30' y2='407.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.78' y1='410.11' x2='630.78' y2='405.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.00' y1='451.45' x2='632.56' y2='447.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.00' y1='447.89' x2='632.56' y2='451.45' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.26' y1='449.67' x2='633.30' y2='449.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.78' y1='452.19' x2='630.78' y2='447.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.73' y1='428.71' x2='640.30' y2='425.14' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.73' y1='425.14' x2='640.30' y2='428.71' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.99' y1='426.93' x2='641.03' y2='426.93' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.51' y1='429.45' x2='638.51' y2='424.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.73' y1='454.66' x2='640.30' y2='451.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.73' y1='451.09' x2='640.30' y2='454.66' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.99' y1='452.88' x2='641.03' y2='452.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.51' y1='455.40' x2='638.51' y2='450.36' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.32' y1='415.79' x2='641.89' y2='412.23' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.32' y1='412.23' x2='641.89' y2='415.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.58' y1='414.01' x2='642.62' y2='414.01' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='640.10' y1='416.53' x2='640.10' y2='411.49' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.32' y1='451.56' x2='641.89' y2='448.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.32' y1='448.00' x2='641.89' y2='451.56' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.58' y1='449.78' x2='642.62' y2='449.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='640.10' y1='452.30' x2='640.10' y2='447.26' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='423.11' y1='421.36' x2='428.15' y2='421.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='425.63' y1='423.88' x2='425.63' y2='418.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='423.11,421.36 425.63,418.84 428.15,421.36 425.63,423.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='423.11' y1='428.38' x2='428.15' y2='428.38' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='425.63' y1='430.90' x2='425.63' y2='425.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='423.11,428.38 425.63,425.86 428.15,428.38 425.63,430.90 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.22' y1='419.74' x2='456.26' y2='419.74' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='453.74' y1='422.26' x2='453.74' y2='417.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='451.22,419.74 453.74,417.22 456.26,419.74 453.74,422.26 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.22' y1='430.26' x2='456.26' y2='430.26' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='453.74' y1='432.78' x2='453.74' y2='427.74' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='451.22,430.26 453.74,427.74 456.26,430.26 453.74,432.78 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='497.57' y1='422.06' x2='502.61' y2='422.06' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='500.09' y1='424.58' x2='500.09' y2='419.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='497.57,422.06 500.09,419.54 502.61,422.06 500.09,424.58 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='497.57' y1='437.49' x2='502.61' y2='437.49' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='500.09' y1='440.01' x2='500.09' y2='434.96' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='497.57,437.49 500.09,434.96 502.61,437.49 500.09,440.01 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='555.14' y1='426.66' x2='560.18' y2='426.66' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='557.66' y1='429.18' x2='557.66' y2='424.14' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='555.14,426.66 557.66,424.14 560.18,426.66 557.66,429.18 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='555.14' y1='428.06' x2='560.18' y2='428.06' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='557.66' y1='430.58' x2='557.66' y2='425.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='555.14,428.06 557.66,425.54 560.18,428.06 557.66,430.58 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='618.43' y1='427.95' x2='623.47' y2='427.95' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='620.95' y1='430.47' x2='620.95' y2='425.43' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.43,427.95 620.95,425.43 623.47,427.95 620.95,430.47 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='618.43' y1='452.50' x2='623.47' y2='452.50' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='620.95' y1='455.02' x2='620.95' y2='449.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.43,452.50 620.95,449.98 623.47,452.50 620.95,455.02 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='669.13' y1='428.22' x2='674.17' y2='428.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='671.65' y1='430.74' x2='671.65' y2='425.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='669.13,428.22 671.65,425.70 674.17,428.22 671.65,430.74 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='669.13' y1='416.30' x2='674.17' y2='416.30' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='671.65' y1='418.82' x2='671.65' y2='413.78' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='669.13,416.30 671.65,413.78 674.17,416.30 671.65,418.82 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='683.36' y1='444.44' x2='688.40' y2='444.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='685.88' y1='446.96' x2='685.88' y2='441.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='683.36,444.44 685.88,441.92 688.40,444.44 685.88,446.96 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='683.36' y1='438.83' x2='688.40' y2='438.83' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='685.88' y1='441.35' x2='685.88' y2='436.31' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='683.36,438.83 685.88,436.31 688.40,438.83 685.88,441.35 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.33' y1='414.86' x2='691.37' y2='414.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='688.85' y1='417.38' x2='688.85' y2='412.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='686.33,414.86 688.85,412.34 691.37,414.86 688.85,417.38 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.33' y1='431.70' x2='691.37' y2='431.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='688.85' y1='434.22' x2='688.85' y2='429.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='686.33,431.70 688.85,429.18 691.37,431.70 688.85,434.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.41' cy='431.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.63' y1='431.81' x2='421.19' y2='431.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.41' y1='433.59' x2='419.41' y2='430.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.41' cy='436.71' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.63' y1='436.71' x2='421.19' y2='436.71' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.41' y1='438.50' x2='419.41' y2='434.93' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='436.99' cy='437.82' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.21' y1='437.82' x2='438.77' y2='437.82' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='436.99' y1='439.60' x2='436.99' y2='436.03' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='436.99' cy='431.50' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.21' y1='431.50' x2='438.77' y2='431.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='436.99' y1='433.29' x2='436.99' y2='429.72' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='468.51' cy='428.15' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.73' y1='428.15' x2='470.29' y2='428.15' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.51' y1='429.94' x2='468.51' y2='426.37' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='468.51' cy='421.84' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.73' y1='421.84' x2='470.29' y2='421.84' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.51' y1='423.62' x2='468.51' y2='420.06' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='513.80' cy='427.86' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.01' y1='427.86' x2='515.58' y2='427.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.80' y1='429.64' x2='513.80' y2='426.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='513.80' cy='431.37' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.01' y1='431.37' x2='515.58' y2='431.37' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.80' y1='433.15' x2='513.80' y2='429.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='576.82' cy='424.64' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='575.03' y1='424.64' x2='578.60' y2='424.64' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='576.82' y1='426.42' x2='576.82' y2='422.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='576.82' cy='426.04' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='575.03' y1='426.04' x2='578.60' y2='426.04' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='576.82' y1='427.83' x2='576.82' y2='424.26' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='646.12' cy='441.21' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='644.34' y1='441.21' x2='647.91' y2='441.21' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='646.12' y1='442.99' x2='646.12' y2='439.43' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='646.12' cy='455.24' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='644.34' y1='455.24' x2='647.91' y2='455.24' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='646.12' y1='457.02' x2='646.12' y2='453.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='669.94' cy='438.90' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='668.16' y1='438.90' x2='671.72' y2='438.90' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='669.94' y1='440.68' x2='669.94' y2='437.12' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='669.94' cy='425.57' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='668.16' y1='425.57' x2='671.72' y2='425.57' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='669.94' y1='427.35' x2='669.94' y2='423.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='677.62' cy='422.40' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.84' y1='422.40' x2='679.41' y2='422.40' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='677.62' y1='424.19' x2='677.62' y2='420.62' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='677.62' cy='411.88' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.84' y1='411.88' x2='679.41' y2='411.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='677.62' y1='413.67' x2='677.62' y2='410.10' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.94,432.02 418.34,427.17 413.54,427.17 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.94,426.48 418.34,431.33 413.54,431.33 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.94,430.62 418.34,425.77 413.54,425.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.94,425.08 418.34,429.93 413.54,429.93 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.01,442.53 429.41,437.68 424.61,437.68 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.01,436.99 429.41,441.84 424.61,441.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.01,429.21 429.41,424.36 424.61,424.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.01,423.67 429.41,428.52 424.61,428.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.04,435.91 449.44,431.06 444.64,431.06 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.04,430.36 449.44,435.21 444.64,435.21 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.04,439.41 449.44,434.56 444.64,434.56 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.04,433.87 449.44,438.72 444.64,438.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.30,429.98 478.70,425.13 473.90,425.13 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.30,424.44 478.70,429.29 473.90,429.29 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.30,442.60 478.70,437.75 473.90,437.75 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.30,437.06 478.70,441.91 473.90,441.91 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.24,441.31 520.64,436.46 515.84,436.46 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.24,435.77 520.64,440.62 515.84,440.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.24,417.47 520.64,412.62 515.84,412.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.24,411.92 520.64,416.77 515.84,416.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.12,421.27 569.52,416.42 564.72,416.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.12,415.73 569.52,420.58 564.72,420.58 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.12,436.00 569.52,431.15 564.72,431.15 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='567.12,430.46 569.52,435.31 564.72,435.31 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='585.87,449.65 588.27,444.80 583.47,444.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='585.87,444.11 588.27,448.96 583.47,448.96 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='585.87,451.05 588.27,446.20 583.47,446.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='585.87,445.51 588.27,450.36 583.47,450.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.71,427.73 596.11,422.88 591.31,422.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.71,422.19 596.11,427.04 591.31,427.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.71,435.45 596.11,430.60 591.31,430.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.71,429.91 596.11,434.76 591.31,434.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.11' y1='438.05' x2='418.67' y2='438.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.89' y1='439.84' x2='416.89' y2='436.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='415.11' y='436.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.11' y1='422.63' x2='418.67' y2='422.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.89' y1='424.41' x2='416.89' y2='420.84' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='415.11' y='420.84' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.93' y1='428.82' x2='431.49' y2='428.82' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.71' y1='430.60' x2='429.71' y2='427.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='427.93' y='427.04' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.93' y1='426.72' x2='431.49' y2='426.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.71' y1='428.50' x2='429.71' y2='424.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='427.93' y='424.93' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='450.91' y1='431.87' x2='454.48' y2='431.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.70' y1='433.65' x2='452.70' y2='430.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='450.91' y='430.09' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='450.91' y1='436.78' x2='454.48' y2='436.78' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.70' y1='438.56' x2='452.70' y2='435.00' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='450.91' y='435.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='483.92' y1='433.72' x2='487.48' y2='433.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.70' y1='435.50' x2='485.70' y2='431.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='483.92' y='431.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='483.92' y1='438.63' x2='487.48' y2='438.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='485.70' y1='440.41' x2='485.70' y2='436.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='483.92' y='436.85' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='529.78' y1='443.20' x2='533.34' y2='443.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='531.56' y1='444.98' x2='531.56' y2='441.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='529.78' y='441.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='529.78' y1='443.90' x2='533.34' y2='443.90' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='531.56' y1='445.68' x2='531.56' y2='442.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='529.78' y='442.12' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='579.77' y1='427.94' x2='583.34' y2='427.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='581.55' y1='429.72' x2='581.55' y2='426.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='579.77' y='426.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='579.77' y1='439.86' x2='583.34' y2='439.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='581.55' y1='441.64' x2='581.55' y2='438.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='579.77' y='438.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='596.44' y1='420.99' x2='600.01' y2='420.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='598.23' y1='422.77' x2='598.23' y2='419.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='596.44' y='419.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='596.44' y1='444.83' x2='600.01' y2='444.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='598.23' y1='446.61' x2='598.23' y2='443.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='596.44' y='443.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='601.39' y1='411.89' x2='604.95' y2='411.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.17' y1='413.68' x2='603.17' y2='410.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='601.39' y='410.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='601.39' y1='440.65' x2='604.95' y2='440.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='603.17' y1='442.43' x2='603.17' y2='438.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='601.39' y='438.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='417.57' cy='434.62' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.79' y1='436.40' x2='419.35' y2='432.84' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.79' y1='432.84' x2='419.35' y2='436.40' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='417.57' cy='440.23' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.79' y1='442.01' x2='419.35' y2='438.45' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.79' y1='438.45' x2='419.35' y2='442.01' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='431.58' cy='431.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.80' y1='433.43' x2='433.36' y2='429.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.80' y1='429.87' x2='433.36' y2='433.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='431.58' cy='421.83' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.80' y1='423.61' x2='433.36' y2='420.05' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.80' y1='420.05' x2='433.36' y2='423.61' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='456.38' cy='431.86' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.60' y1='433.64' x2='458.16' y2='430.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.60' y1='430.08' x2='458.16' y2='433.64' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='456.38' cy='439.57' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.60' y1='441.36' x2='458.16' y2='437.79' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.60' y1='437.79' x2='458.16' y2='441.36' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='491.19' cy='443.48' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='489.41' y1='445.26' x2='492.97' y2='441.70' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='489.41' y1='441.70' x2='492.97' y2='445.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='491.19' cy='433.66' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='489.41' y1='435.44' x2='492.97' y2='431.88' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='489.41' y1='431.88' x2='492.97' y2='435.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='537.66' cy='431.22' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.88' y1='433.00' x2='539.45' y2='429.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.88' y1='429.44' x2='539.45' y2='433.00' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='537.66' cy='446.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.88' y1='448.43' x2='539.45' y2='444.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='535.88' y1='444.87' x2='539.45' y2='448.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='584.78' cy='439.32' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.00' y1='441.11' x2='586.56' y2='437.54' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.00' y1='437.54' x2='586.56' y2='441.11' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='584.78' cy='414.78' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.00' y1='416.56' x2='586.56' y2='413.00' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.00' y1='413.00' x2='586.56' y2='416.56' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='598.92' cy='456.14' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.13' y1='457.92' x2='600.70' y2='454.36' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.13' y1='454.36' x2='600.70' y2='457.92' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='598.92' cy='418.27' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.13' y1='420.05' x2='600.70' y2='416.48' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.13' y1='416.48' x2='600.70' y2='420.05' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='602.16' cy='432.48' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.38' y1='434.26' x2='603.94' y2='430.70' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.38' y1='430.70' x2='603.94' y2='434.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='602.16' cy='428.27' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.38' y1='430.06' x2='603.94' y2='426.49' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.38' y1='426.49' x2='603.94' y2='430.06' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.09,431.24 422.88,434.81 419.31,434.81 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='419.31' y='431.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.09,426.33 422.88,429.90 419.31,429.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='419.31' y='426.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.21,425.42 442.99,428.98 439.43,428.98 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='439.43' y='425.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.21,428.22 442.99,431.79 439.43,431.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='439.43' y='428.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='475.09,440.88 476.87,444.44 473.31,444.44 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='473.31' y='440.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='475.09,415.63 476.87,419.20 473.31,419.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='473.31' y='415.63' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.72,417.67 520.50,421.23 516.94,421.23 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='516.94' y='417.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='518.72,426.08 520.50,429.65 516.94,429.65 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='516.94' y='426.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='569.34,445.19 571.12,448.76 567.56,448.76 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='567.56' y='445.19' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='569.34,426.26 571.12,429.82 567.56,429.82 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='567.56' y='426.26' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.06,430.06 613.84,433.63 610.28,433.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='610.28' y='430.06' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.06,409.72 613.84,413.29 610.28,413.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='610.28' y='409.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='624.21,447.42 625.99,450.98 622.43,450.98 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='622.43' y='447.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='624.21,417.96 625.99,421.53 622.43,421.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='622.43' y='417.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='627.26,444.58 629.05,448.15 625.48,448.15 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='625.48' y='444.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='627.26,437.57 629.05,441.13 625.48,441.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='625.48' y='437.57' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.19,431.34 424.75,431.34 424.75,427.77 421.19,427.77 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.19,434.84 424.75,434.84 424.75,431.28 421.19,431.28 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='444.23,435.85 447.79,435.85 447.79,432.28 444.23,432.28 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='444.23,431.64 447.79,431.64 447.79,428.08 444.23,428.08 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='481.37,450.12 484.93,450.12 484.93,446.56 481.37,446.56 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='481.37,423.47 484.93,423.47 484.93,419.91 481.37,419.91 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='525.77,453.74 529.34,453.74 529.34,450.18 525.77,450.18 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='525.77,440.42 529.34,440.42 529.34,436.85 525.77,436.85 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.72,440.18 575.29,440.18 575.29,436.62 571.72,436.62 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.72,441.59 575.29,441.59 575.29,438.02 571.72,438.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='607.02,428.51 610.59,428.51 610.59,424.95 607.02,424.95 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='607.02,427.81 610.59,427.81 610.59,424.25 607.02,424.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.51,422.67 622.08,422.67 622.08,419.11 618.51,419.11 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.51,433.89 622.08,433.89 622.08,430.33 618.51,430.33 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='622.74,414.16 626.30,414.16 626.30,410.60 622.74,410.60 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='622.74,450.63 626.30,450.63 626.30,447.07 622.74,447.07 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+</svg>
diff --git a/tests/figs/plotting/mixed-model-fit-for-saem-object-with-mkin-transformations.svg b/tests/figs/plotting/mixed-model-fit-for-saem-object-with-mkin-transformations.svg
new file mode 100644
index 00000000..a75094a5
--- /dev/null
+++ b/tests/figs/plotting/mixed-model-fit-for-saem-object-with-mkin-transformations.svg
@@ -0,0 +1,2482 @@
+<?xml version='1.0' encoding='UTF-8' ?>
+<svg xmlns='http://www.w3.org/2000/svg' xmlns:xlink='http://www.w3.org/1999/xlink' viewBox='0 0 720.00 576.00'>
+<defs>
+ <style type='text/css'><![CDATA[
+ line, polyline, polygon, path, rect, circle {
+ fill: none;
+ stroke: #000000;
+ stroke-linecap: round;
+ stroke-linejoin: round;
+ stroke-miterlimit: 10.00;
+ }
+ ]]></style>
+</defs>
+<rect width='100%' height='100%' style='stroke: none; fill: #FFFFFF;'/>
+<defs>
+ <clipPath id='cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA='>
+ <rect x='19.96' y='5.70' width='680.08' height='75.63' />
+ </clipPath>
+</defs>
+<line x1='238.69' y1='29.26' x2='252.94' y2='29.26' style='stroke-width: 1.50;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='38.77' x2='252.94' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='48.27' x2='252.94' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='57.77' x2='252.94' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='29.26' x2='313.78' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='38.77' x2='313.78' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='48.27' x2='313.78' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='57.77' x2='313.78' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='29.26' x2='374.61' y2='29.26' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='38.77' x2='374.61' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='48.27' x2='374.61' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='57.77' x2='374.61' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='29.26' x2='435.45' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='38.77' x2='435.45' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='48.27' x2='435.45' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='57.77' x2='435.45' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='245.81' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='245.81,45.50 248.21,49.66 243.41,49.66 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='243.29' y1='57.77' x2='248.33' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='245.81' y1='60.29' x2='245.81' y2='55.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='31.04' x2='308.43' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='27.48' x2='308.43' y2='31.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='304.13,38.77 306.65,36.25 309.17,38.77 306.65,41.29 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='306.65,51.04 309.05,46.89 304.25,46.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='304.87' y='55.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='59.56' x2='308.43' y2='55.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='55.99' x2='308.43' y2='59.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='31.04' x2='369.27' y2='27.48' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='27.48' x2='369.27' y2='31.04' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='29.26' x2='370.00' y2='29.26' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='31.78' x2='367.48' y2='26.74' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='38.77' x2='370.00' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='41.29' x2='367.48' y2='36.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='364.96,38.77 367.48,36.25 370.00,38.77 367.48,41.29 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='367.48' cy='48.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='48.27' x2='369.27' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='50.05' x2='367.48' y2='46.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,60.55 369.88,55.70 365.08,55.70 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,55.00 369.88,59.85 365.08,59.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='29.26' x2='430.10' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='428.32' y1='31.04' x2='428.32' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='27.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='428.32' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='40.55' x2='430.10' y2='36.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='36.98' x2='430.10' y2='40.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='428.32,46.49 430.10,50.05 426.54,50.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='46.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='426.54,59.56 430.10,59.56 430.10,55.99 426.54,55.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='37.31px' lengthAdjust='spacingAndGlyphs'>Population</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>1</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>3</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>5</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>6</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>7</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>8</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>9</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.19px' lengthAdjust='spacingAndGlyphs'>11</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>12</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>13</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>14</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>15</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<polyline points='50.12,124.70 52.44,128.56 55.81,133.99 57.09,136.01 61.50,142.74 66.38,149.83 67.19,150.96 72.87,158.69 78.56,165.97 82.64,170.92 84.25,172.81 89.94,179.25 95.63,185.30 101.32,191.00 107.01,196.36 112.70,201.40 115.16,203.49 118.39,206.14 124.08,210.60 129.77,214.80 135.46,218.75 141.15,222.46 146.83,225.96 152.52,229.25 158.21,232.34 163.90,235.25 169.59,237.99 175.28,240.57 180.97,243.00 186.66,245.28 189.50,246.37 192.35,247.43 198.04,249.45 203.73,251.35 209.42,253.14 215.11,254.83 220.79,256.41 226.48,257.91 232.17,259.31 237.86,260.63 243.55,261.88 249.24,263.05 254.93,264.15 259.20,264.94 260.62,265.19 266.31,266.17 272.00,267.09 277.69,267.96 283.38,268.77 289.07,269.54 294.76,270.26 300.44,270.94 306.13,271.58 311.82,272.19 317.51,272.75 323.20,273.29 328.89,273.79 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='288.88' x2='328.89' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='288.88' x2='50.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='288.88' x2='96.58' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='288.88' x2='143.04' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='288.88' x2='189.50' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='288.88' x2='235.97' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='288.88' x2='282.43' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='288.88' x2='328.89' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='281.96' x2='38.97' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='281.96' x2='34.21' y2='281.96' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='250.60' x2='34.21' y2='250.60' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='219.24' x2='34.21' y2='219.24' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='187.88' x2='34.21' y2='187.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='156.51' x2='34.21' y2='156.51' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='125.15' x2='34.21' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,284.16) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,254.99) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,223.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,192.27) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,160.90) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,131.74) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<polygon points='38.97,288.88 340.04,288.88 340.04,102.24 38.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5'>
+ <rect x='0.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text x='180.87' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text transform='translate(8.55,206.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='22.41px' lengthAdjust='spacingAndGlyphs'>parent</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<circle cx='50.12' cy='117.47' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='130.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='129.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='142.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='156.51' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='131.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='160.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='166.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='174.55' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='183.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='203.87' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='200.58' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.16' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.00' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='246.99' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='247.46' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='253.27' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='254.68' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.60 52.44,132.10 55.81,139.49 57.09,142.13 61.50,150.58 66.38,158.89 67.19,160.16 72.87,168.47 78.56,175.70 82.64,180.31 84.25,182.02 89.94,187.58 95.63,192.49 101.32,196.85 107.01,200.74 112.70,204.24 115.16,205.64 118.39,207.39 124.08,210.26 129.77,212.88 135.46,215.29 141.15,217.52 146.83,219.59 152.52,221.52 158.21,223.33 163.90,225.03 169.59,226.65 175.28,228.18 180.97,229.64 186.66,231.03 189.50,231.70 192.35,232.36 198.04,233.65 203.73,234.88 209.42,236.07 215.11,237.22 220.79,238.33 226.48,239.40 232.17,240.44 237.86,241.46 243.55,242.44 249.24,243.39 254.93,244.32 259.20,245.00 260.62,245.23 266.31,246.10 272.00,246.96 277.69,247.80 283.38,248.61 289.07,249.40 294.76,250.18 300.44,250.93 306.13,251.67 311.82,252.38 317.51,253.08 323.20,253.77 328.89,254.43 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,120.34 52.52,124.50 47.72,124.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.01 52.52,127.16 47.72,127.16 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,130.38 54.84,134.53 50.04,134.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,128.65 54.84,132.81 50.04,132.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.43 59.49,141.59 54.69,141.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.51 59.49,145.67 54.69,145.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,141.67 68.78,145.82 63.98,145.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.23 68.78,155.39 63.98,155.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,169.27 85.04,173.42 80.24,173.42 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,161.43 85.04,165.58 80.24,165.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,202.51 117.56,206.67 112.76,206.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,205.49 117.56,209.65 112.76,209.65 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,232.46 191.90,236.62 187.10,236.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.23 191.90,232.39 187.10,232.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.42 261.60,242.58 256.80,242.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.46 261.60,244.62 256.80,244.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,248.46 331.29,252.61 326.49,252.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.44 331.29,255.59 326.49,255.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.46 52.44,129.87 55.81,135.94 57.09,138.15 61.50,145.40 66.38,152.79 67.19,153.95 72.87,161.68 78.56,168.69 82.64,173.31 84.25,175.05 89.94,180.83 95.63,186.09 101.32,190.89 107.01,195.27 112.70,199.28 115.16,200.91 118.39,202.95 124.08,206.33 129.77,209.44 135.46,212.30 141.15,214.95 146.83,217.41 152.52,219.69 158.21,221.81 163.90,223.80 169.59,225.65 175.28,227.39 180.97,229.02 186.66,230.55 189.50,231.29 192.35,232.00 198.04,233.38 203.73,234.68 209.42,235.91 215.11,237.09 220.79,238.21 226.48,239.28 232.17,240.31 237.86,241.29 243.55,242.24 249.24,243.15 254.93,244.02 259.20,244.66 260.62,244.87 266.31,245.69 272.00,246.47 277.69,247.24 283.38,247.98 289.07,248.70 294.76,249.39 300.44,250.07 306.13,250.73 311.82,251.37 317.51,252.00 323.20,252.61 328.89,253.20 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='141.15' x2='52.64' y2='141.15' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='143.67' x2='50.12' y2='138.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='127.97' x2='52.64' y2='127.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='130.49' x2='50.12' y2='125.45' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='126.25' x2='54.96' y2='126.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='128.77' x2='52.44' y2='123.73' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='129.86' x2='59.61' y2='129.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='132.38' x2='57.09' y2='127.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.68' x2='59.61' y2='140.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.20' x2='57.09' y2='138.16' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='150.55' x2='68.90' y2='150.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='153.07' x2='66.38' y2='148.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='152.12' x2='68.90' y2='152.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='154.64' x2='66.38' y2='149.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='164.04' x2='85.16' y2='164.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.56' x2='82.64' y2='161.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='175.49' x2='85.16' y2='175.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='178.01' x2='82.64' y2='172.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='193.84' x2='117.68' y2='193.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='196.36' x2='115.16' y2='191.31' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='196.81' x2='117.68' y2='196.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='199.33' x2='115.16' y2='194.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='234.29' x2='192.02' y2='234.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='236.81' x2='189.50' y2='231.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='237.43' x2='192.02' y2='237.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='239.95' x2='189.50' y2='234.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='267.54' x2='331.41' y2='267.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.06' x2='328.89' y2='265.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='263.77' x2='331.41' y2='263.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='266.29' x2='328.89' y2='261.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.43 52.44,130.05 55.81,135.11 57.09,136.98 61.50,143.20 66.38,149.71 67.19,150.75 72.87,157.81 78.56,164.40 82.64,168.87 84.25,170.57 89.94,176.34 95.63,181.75 101.32,186.82 107.01,191.57 112.70,196.02 115.16,197.87 118.39,200.21 124.08,204.14 129.77,207.83 135.46,211.31 141.15,214.59 146.83,217.67 152.52,220.58 158.21,223.32 163.90,225.91 169.59,228.36 175.28,230.68 180.97,232.87 186.66,234.94 189.50,235.94 192.35,236.91 198.04,238.77 203.73,240.54 209.42,242.21 215.11,243.81 220.79,245.32 226.48,246.76 232.17,248.14 237.86,249.44 243.55,250.69 249.24,251.88 254.93,253.01 259.20,253.83 260.62,254.09 266.31,255.13 272.00,256.11 277.69,257.06 283.38,257.96 289.07,258.83 294.76,259.65 300.44,260.45 306.13,261.21 311.82,261.94 317.51,262.64 323.20,263.31 328.89,263.96 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='124.58' x2='51.90' y2='121.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='121.02' x2='51.90' y2='124.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.17' x2='51.90' y2='119.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='119.61' x2='51.90' y2='123.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='121.92' x2='54.22' y2='118.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='118.35' x2='54.22' y2='121.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.14' x2='54.22' y2='138.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='138.58' x2='54.22' y2='142.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.71' x2='58.87' y2='140.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.15' x2='58.87' y2='143.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.87' x2='58.87' y2='140.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.30' x2='58.87' y2='143.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.57' x2='68.16' y2='145.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.01' x2='68.16' y2='148.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='164.10' x2='68.16' y2='160.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.53' x2='68.16' y2='164.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='176.49' x2='84.42' y2='172.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='172.92' x2='84.42' y2='176.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='167.55' x2='84.42' y2='163.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='163.98' x2='84.42' y2='167.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.83' x2='116.95' y2='199.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.27' x2='116.95' y2='202.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.18' x2='116.95' y2='201.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.62' x2='116.95' y2='205.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.31' x2='191.29' y2='236.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.74' x2='191.29' y2='240.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.15' x2='191.29' y2='236.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.59' x2='191.29' y2='240.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.50' x2='260.98' y2='254.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='254.93' x2='260.98' y2='258.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.97' x2='260.98' y2='255.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.41' x2='260.98' y2='258.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='269.32' x2='330.67' y2='265.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='265.75' x2='330.67' y2='269.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.57' x2='330.67' y2='267.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.01' x2='330.67' y2='270.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.45 52.44,129.51 55.81,135.16 57.09,137.25 61.50,144.15 66.38,151.32 67.19,152.46 72.87,160.17 78.56,167.31 82.64,172.11 84.25,173.93 89.94,180.09 95.63,185.81 101.32,191.13 107.01,196.08 112.70,200.70 115.16,202.60 118.39,205.00 124.08,209.02 129.77,212.78 135.46,216.29 141.15,219.58 146.83,222.66 152.52,225.55 158.21,228.26 163.90,230.81 169.59,233.21 175.28,235.46 180.97,237.59 186.66,239.59 189.50,240.55 192.35,241.48 198.04,243.27 203.73,244.96 209.42,246.56 215.11,248.07 220.79,249.51 226.48,250.87 232.17,252.16 237.86,253.38 243.55,254.55 249.24,255.66 254.93,256.72 259.20,257.47 260.62,257.72 266.31,258.68 272.00,259.59 277.69,260.47 283.38,261.30 289.07,262.09 294.76,262.85 300.44,263.58 306.13,264.28 311.82,264.94 317.51,265.58 323.20,266.19 328.89,266.78 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.86 50.12,111.34 52.64,113.86 50.12,116.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.39 50.12,110.87 52.64,113.39 50.12,115.91 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,133.31 52.44,130.79 54.96,133.31 52.44,135.83 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,145.85 52.44,143.33 54.96,145.85 52.44,148.37 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.91 57.09,142.39 59.61,144.91 57.09,147.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.44 57.09,141.92 59.61,144.44 57.09,146.96 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.67 66.38,162.15 68.90,164.67 66.38,167.19 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,168.75 66.38,166.22 68.90,168.75 66.38,171.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,193.21 82.64,190.69 85.16,193.21 82.64,195.73 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,190.86 82.64,188.34 85.16,190.86 82.64,193.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,207.95 115.16,205.43 117.68,207.95 115.16,210.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,206.69 115.16,204.17 117.68,206.69 115.16,209.21 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,239.00 189.50,236.48 192.02,239.00 189.50,241.52 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,234.29 189.50,231.77 192.02,234.29 189.50,236.81 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,251.70 259.20,249.18 261.72,251.70 259.20,254.22 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,250.60 259.20,248.08 261.72,250.60 259.20,253.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,260.48 328.89,257.96 331.41,260.48 328.89,263.00 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,261.26 328.89,258.74 331.41,261.26 328.89,263.78 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.27 52.44,131.52 55.81,142.08 57.09,145.71 61.50,156.80 66.38,166.95 67.19,168.44 72.87,177.75 78.56,185.29 82.64,189.85 84.25,191.49 89.94,196.67 95.63,201.06 101.32,204.84 107.01,208.16 112.70,211.12 115.16,212.31 118.39,213.79 124.08,216.23 129.77,218.49 135.46,220.59 141.15,222.57 146.83,224.45 152.52,226.23 158.21,227.94 163.90,229.58 169.59,231.15 175.28,232.66 180.97,234.13 186.66,235.54 189.50,236.23 192.35,236.91 198.04,238.23 203.73,239.51 209.42,240.76 215.11,241.96 220.79,243.13 226.48,244.27 232.17,245.37 237.86,246.44 243.55,247.47 249.24,248.48 254.93,249.45 259.20,250.17 260.62,250.40 266.31,251.32 272.00,252.22 277.69,253.08 283.38,253.93 289.07,254.74 294.76,255.54 300.44,256.31 306.13,257.05 311.82,257.78 317.51,258.49 323.20,259.17 328.89,259.83 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.69 52.52,119.53 47.72,119.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.06 52.52,118.90 47.72,118.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,138.12 54.84,133.96 50.04,133.96 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,143.45 54.84,139.29 50.04,139.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.80 59.49,133.64 54.69,133.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.39 59.49,140.23 54.69,140.23 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.29 68.78,147.13 63.98,147.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,150.66 68.78,146.50 63.98,146.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.14 85.04,167.99 80.24,167.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.88 85.04,182.73 80.24,182.73 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,191.27 117.56,187.12 112.76,187.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.29 117.56,200.13 112.76,200.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.75 191.90,224.60 187.10,224.60 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,230.79 191.90,226.63 187.10,226.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.36 261.60,236.20 256.80,236.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,241.30 261.60,237.14 256.80,237.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,250.08 331.29,245.92 326.49,245.92 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,253.37 331.29,249.22 326.49,249.22 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.48 52.44,129.93 55.81,136.02 57.09,138.22 61.50,145.41 66.38,152.68 67.19,153.81 72.87,161.33 78.56,168.07 82.64,172.48 84.25,174.14 89.94,179.60 95.63,184.53 101.32,188.99 107.01,193.04 112.70,196.72 115.16,198.22 118.39,200.09 124.08,203.16 129.77,205.99 135.46,208.59 141.15,210.99 146.83,213.21 152.52,215.28 158.21,217.21 163.90,219.02 169.59,220.71 175.28,222.30 180.97,223.80 186.66,225.23 189.50,225.91 192.35,226.58 198.04,227.86 203.73,229.09 209.42,230.26 215.11,231.38 220.79,232.46 226.48,233.50 232.17,234.50 237.86,235.46 243.55,236.40 249.24,237.30 254.93,238.18 259.20,238.82 260.62,239.03 266.31,239.86 272.00,240.67 277.69,241.45 283.38,242.22 289.07,242.96 294.76,243.69 300.44,244.40 306.13,245.10 311.82,245.78 317.51,246.44 323.20,247.09 328.89,247.73 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='130.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='133.83' x2='51.90' y2='130.27' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.27' x2='51.90' y2='133.83' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='115.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='118.78' x2='51.90' y2='115.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.22' x2='51.90' y2='118.78' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='127.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='130.70' x2='54.22' y2='127.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.13' x2='54.22' y2='130.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='137.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='140.89' x2='54.22' y2='137.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='137.33' x2='54.22' y2='140.89' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='159.59' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='163.16' x2='58.87' y2='159.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='159.59' x2='58.87' y2='163.16' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='142.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='146.53' x2='58.87' y2='142.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='142.97' x2='58.87' y2='146.53' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='173.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='177.43' x2='68.16' y2='173.86' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.86' x2='68.16' y2='177.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='154.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='157.98' x2='68.16' y2='154.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.42' x2='68.16' y2='157.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='190.44' x2='84.42' y2='186.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='186.88' x2='84.42' y2='190.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='191.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='195.15' x2='84.42' y2='191.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='191.58' x2='84.42' y2='195.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='225.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='229.49' x2='116.95' y2='225.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.92' x2='116.95' y2='229.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='224.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='227.76' x2='116.95' y2='224.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.20' x2='116.95' y2='227.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='258.97' x2='191.29' y2='255.41' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.41' x2='191.29' y2='258.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='259.44' x2='191.29' y2='255.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.88' x2='191.29' y2='259.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='264.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='267.59' x2='260.98' y2='264.03' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='264.03' x2='260.98' y2='267.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='265.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='268.85' x2='260.98' y2='265.28' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='265.28' x2='260.98' y2='268.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='270.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='274.18' x2='330.67' y2='270.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.62' x2='330.67' y2='274.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='267.95' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='271.51' x2='330.67' y2='267.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.95' x2='330.67' y2='271.51' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.83 52.44,133.03 55.81,142.67 57.09,146.10 61.50,157.07 66.38,167.79 67.19,169.43 72.87,180.09 78.56,189.30 82.64,195.14 84.25,197.30 89.94,204.27 95.63,210.38 101.32,215.76 107.01,220.51 112.70,224.73 115.16,226.42 118.39,228.50 124.08,231.89 129.77,234.94 135.46,237.70 141.15,240.22 146.83,242.52 152.52,244.63 158.21,246.58 163.90,248.38 169.59,250.05 175.28,251.61 180.97,253.07 186.66,254.43 189.50,255.09 192.35,255.72 198.04,256.92 203.73,258.06 209.42,259.14 215.11,260.16 220.79,261.13 226.48,262.05 232.17,262.92 237.86,263.75 243.55,264.54 249.24,265.29 254.93,266.01 259.20,266.52 260.62,266.69 266.31,267.35 272.00,267.97 277.69,268.57 283.38,269.14 289.07,269.68 294.76,270.20 300.44,270.70 306.13,271.18 311.82,271.63 317.51,272.07 323.20,272.49 328.89,272.89 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='131.48' x2='51.90' y2='127.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.92' x2='51.90' y2='131.48' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='129.70' x2='52.64' y2='129.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='132.22' x2='50.12' y2='127.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.17' x2='51.90' y2='111.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='111.61' x2='51.90' y2='115.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='113.39' x2='52.64' y2='113.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='115.91' x2='50.12' y2='110.87' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='129.76' x2='54.22' y2='126.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.19' x2='54.22' y2='129.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.97' x2='54.96' y2='127.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='130.49' x2='52.44' y2='125.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='145.59' x2='54.22' y2='142.03' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.03' x2='54.22' y2='145.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='143.81' x2='54.96' y2='143.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='146.33' x2='52.44' y2='141.29' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='149.36' x2='58.87' y2='145.79' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='145.79' x2='58.87' y2='149.36' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='147.58' x2='59.61' y2='147.58' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='150.10' x2='57.09' y2='145.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='165.51' x2='58.87' y2='161.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='161.95' x2='58.87' y2='165.51' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='163.73' x2='59.61' y2='163.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='166.25' x2='57.09' y2='161.21' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.98' x2='68.16' y2='170.41' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='170.41' x2='68.16' y2='173.98' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='172.19' x2='68.90' y2='172.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='174.72' x2='66.38' y2='169.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='179.15' x2='68.16' y2='175.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='175.59' x2='68.16' y2='179.15' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='177.37' x2='68.90' y2='177.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='179.89' x2='66.38' y2='174.85' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='209.73' x2='84.42' y2='206.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='206.17' x2='84.42' y2='209.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='207.95' x2='85.16' y2='207.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='210.47' x2='82.64' y2='205.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='204.24' x2='84.42' y2='200.68' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='200.68' x2='84.42' y2='204.24' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='202.46' x2='85.16' y2='202.46' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='204.98' x2='82.64' y2='199.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='228.39' x2='116.95' y2='224.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.83' x2='116.95' y2='228.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='226.61' x2='117.68' y2='226.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='229.13' x2='115.16' y2='224.09' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.72' x2='116.95' y2='222.16' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='222.16' x2='116.95' y2='225.72' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='223.94' x2='117.68' y2='223.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='226.46' x2='115.16' y2='221.42' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='247.05' x2='191.29' y2='243.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='243.49' x2='191.29' y2='247.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='245.27' x2='192.02' y2='245.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='247.79' x2='189.50' y2='242.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='246.11' x2='191.29' y2='242.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.55' x2='191.29' y2='246.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.33' x2='192.02' y2='244.33' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.85' x2='189.50' y2='241.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.52' x2='260.98' y2='251.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='251.96' x2='260.98' y2='255.52' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.83' x2='260.98' y2='252.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='252.27' x2='260.98' y2='255.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='254.05' x2='261.72' y2='254.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.57' x2='259.20' y2='251.53' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='263.67' x2='330.67' y2='260.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.11' x2='330.67' y2='263.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='261.89' x2='331.41' y2='261.89' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.41' x2='328.89' y2='259.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.73' x2='330.67' y2='259.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.17' x2='330.67' y2='262.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='260.95' x2='331.41' y2='260.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.47' x2='328.89' y2='258.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,124.59 52.44,134.65 55.81,147.47 57.09,151.86 61.50,165.21 66.38,177.29 67.19,179.05 72.87,189.90 78.56,198.49 82.64,203.55 84.25,205.35 89.94,210.89 95.63,215.42 101.32,219.17 107.01,222.33 112.70,225.03 115.16,226.09 118.39,227.38 124.08,229.44 129.77,231.29 135.46,232.96 141.15,234.50 146.83,235.93 152.52,237.26 158.21,238.52 163.90,239.72 169.59,240.86 175.28,241.96 180.97,243.01 186.66,244.03 189.50,244.52 192.35,245.01 198.04,245.96 203.73,246.89 209.42,247.78 215.11,248.65 220.79,249.50 226.48,250.33 232.17,251.13 237.86,251.91 243.55,252.67 249.24,253.41 254.93,254.13 259.20,254.66 260.62,254.84 266.31,255.52 272.00,256.19 277.69,256.84 283.38,257.48 289.07,258.10 294.76,258.70 300.44,259.29 306.13,259.86 311.82,260.42 317.51,260.96 323.20,261.49 328.89,262.01 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='109.16' x2='52.64' y2='109.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='111.68' x2='50.12' y2='106.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,109.16 50.12,106.64 52.64,109.16 50.12,111.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='139.11' x2='52.64' y2='139.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='141.63' x2='50.12' y2='136.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,139.11 50.12,136.59 52.64,139.11 50.12,141.63 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,127.19 52.44,124.67 54.96,127.19 52.44,129.71 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='118.25' x2='54.96' y2='118.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='120.77' x2='52.44' y2='115.73' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,118.25 52.44,115.73 54.96,118.25 52.44,120.77 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='149.61' x2='59.61' y2='149.61' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='152.13' x2='57.09' y2='147.09' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,149.61 57.09,147.09 59.61,149.61 57.09,152.13 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.52' x2='59.61' y2='140.52' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.04' x2='57.09' y2='138.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,140.52 57.09,138.00 59.61,140.52 57.09,143.04 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='158.55' x2='68.90' y2='158.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.07' x2='66.38' y2='156.03' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,158.55 66.38,156.03 68.90,158.55 66.38,161.07 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='164.98' x2='68.90' y2='164.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='167.50' x2='66.38' y2='162.46' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.98 66.38,162.46 68.90,164.98 66.38,167.50 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='192.27' x2='85.16' y2='192.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='194.79' x2='82.64' y2='189.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,192.27 82.64,189.75 85.16,192.27 82.64,194.79 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='183.80' x2='85.16' y2='183.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='186.32' x2='82.64' y2='181.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,183.80 82.64,181.28 85.16,183.80 82.64,186.32 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='215.32' x2='117.68' y2='215.32' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='217.84' x2='115.16' y2='212.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,215.32 115.16,212.80 117.68,215.32 115.16,217.84 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='211.08' x2='117.68' y2='211.08' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='213.60' x2='115.16' y2='208.56' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,211.08 115.16,208.56 117.68,211.08 115.16,213.60 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.17' x2='192.02' y2='244.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.69' x2='189.50' y2='241.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,244.17 189.50,241.65 192.02,244.17 189.50,246.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='242.76' x2='192.02' y2='242.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='245.28' x2='189.50' y2='240.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,242.76 189.50,240.24 192.02,242.76 189.50,245.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,253.74 259.20,251.22 261.72,253.74 259.20,256.26 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='258.28' x2='261.72' y2='258.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='260.80' x2='259.20' y2='255.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,258.28 259.20,255.76 261.72,258.28 259.20,260.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='268.16' x2='331.41' y2='268.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.68' x2='328.89' y2='265.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,268.16 328.89,265.64 331.41,268.16 328.89,270.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='262.36' x2='331.41' y2='262.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.88' x2='328.89' y2='259.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,262.36 328.89,259.84 331.41,262.36 328.89,264.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.38 52.44,129.69 55.81,138.21 57.09,141.26 61.50,151.05 66.38,160.72 67.19,162.21 72.87,171.93 78.56,180.41 82.64,185.85 84.25,187.86 89.94,194.41 95.63,200.19 101.32,205.33 107.01,209.90 112.70,213.99 115.16,215.63 118.39,217.67 124.08,220.98 129.77,224.00 135.46,226.74 141.15,229.25 146.83,231.56 152.52,233.69 158.21,235.67 163.90,237.51 169.59,239.23 175.28,240.84 180.97,242.36 186.66,243.79 189.50,244.47 192.35,245.14 198.04,246.43 203.73,247.65 209.42,248.81 215.11,249.92 220.79,250.99 226.48,252.00 232.17,252.98 237.86,253.92 243.55,254.82 249.24,255.69 254.93,256.52 259.20,257.13 260.62,257.33 266.31,258.11 272.00,258.86 277.69,259.58 283.38,260.28 289.07,260.96 294.76,261.61 300.44,262.25 306.13,262.86 311.82,263.45 317.51,264.02 323.20,264.58 328.89,265.12 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='122.80' x2='51.90' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.58' x2='50.12' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='123.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.09' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.09' x2='54.22' y2='126.09' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='127.87' x2='52.44' y2='124.31' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='122.80' x2='54.22' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='124.58' x2='52.44' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='136.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.28' x2='58.87' y2='136.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='138.07' x2='57.09' y2='134.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='139.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.11' x2='58.87' y2='139.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='140.89' x2='57.09' y2='137.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='159.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='159.81' x2='68.16' y2='159.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.59' x2='66.38' y2='158.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='147.58' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='147.58' x2='68.16' y2='147.58' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='149.36' x2='66.38' y2='145.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.14' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.14' x2='84.42' y2='165.14' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.92' x2='82.64' y2='163.36' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.61' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.61' x2='84.42' y2='165.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='167.39' x2='82.64' y2='163.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='202.62' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.62' x2='116.95' y2='202.62' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='204.40' x2='115.16' y2='200.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='191.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='191.17' x2='116.95' y2='191.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='192.95' x2='115.16' y2='189.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.39' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.39' x2='191.29' y2='235.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.17' x2='189.50' y2='233.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.23' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.23' x2='191.29' y2='235.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.02' x2='189.50' y2='233.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='245.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='245.27' x2='260.98' y2='245.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='247.05' x2='259.20' y2='243.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='249.66' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.66' x2='260.98' y2='249.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='251.44' x2='259.20' y2='247.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.73' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.73' x2='330.67' y2='261.73' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.52' x2='328.89' y2='259.95' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='259.38' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.38' x2='330.67' y2='259.38' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='261.16' x2='328.89' y2='257.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.80 52.44,127.80 55.81,133.35 57.09,135.39 61.50,142.13 66.38,149.10 67.19,150.21 72.87,157.65 78.56,164.52 82.64,169.12 84.25,170.86 89.94,176.73 95.63,182.15 101.32,187.18 107.01,191.85 112.70,196.19 115.16,197.97 118.39,200.22 124.08,203.98 129.77,207.49 135.46,210.77 141.15,213.83 146.83,216.70 152.52,219.39 158.21,221.92 163.90,224.30 169.59,226.54 175.28,228.66 180.97,230.65 186.66,232.54 189.50,233.45 192.35,234.33 198.04,236.02 203.73,237.63 209.42,239.16 215.11,240.62 220.79,242.01 226.48,243.33 232.17,244.59 237.86,245.80 243.55,246.95 249.24,248.06 254.93,249.12 259.20,249.89 260.62,250.14 266.31,251.11 272.00,252.05 277.69,252.95 283.38,253.82 289.07,254.66 294.76,255.46 300.44,256.24 306.13,256.99 311.82,257.72 317.51,258.42 323.20,259.09 328.89,259.74 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,131.06 52.52,126.21 47.72,126.21 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,125.52 52.52,130.37 47.72,130.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,129.65 52.52,124.80 47.72,124.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,124.10 52.52,128.95 47.72,128.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,135.45 54.84,130.60 50.04,130.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,129.91 54.84,134.76 50.04,134.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,117.57 54.84,112.72 50.04,112.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,112.03 54.84,116.88 50.04,116.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,140.47 59.49,135.62 54.69,135.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,134.92 59.49,139.77 54.69,139.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.54 59.49,139.69 54.69,139.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,139.00 59.49,143.85 54.69,143.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,142.66 68.78,137.81 63.98,137.81 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,137.12 68.78,141.97 63.98,141.97 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,157.87 68.78,153.02 63.98,153.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,152.33 68.78,157.18 63.98,157.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,168.54 85.04,163.69 80.24,163.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,162.99 85.04,167.84 80.24,167.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.77 85.04,167.92 80.24,167.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,167.23 85.04,172.08 80.24,172.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,188.30 117.56,183.45 112.76,183.45 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,182.75 117.56,187.60 112.76,187.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,183.59 117.56,178.74 112.76,178.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,178.05 117.56,182.90 112.76,182.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,224.21 191.90,219.36 187.10,219.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,218.66 191.90,223.51 187.10,223.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,225.77 191.90,220.92 187.10,220.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,220.23 191.90,225.08 187.10,225.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,244.12 261.60,239.27 256.80,239.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.58 261.60,243.43 256.80,243.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,237.69 261.60,232.84 256.80,232.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,232.15 261.60,237.00 256.80,237.00 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,252.12 331.29,247.27 326.49,247.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.58 331.29,251.42 326.49,251.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.96 331.29,247.11 326.49,247.11 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.42 331.29,251.27 326.49,251.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.73 52.44,128.98 55.81,133.52 57.09,135.19 61.50,140.74 66.38,146.54 67.19,147.46 72.87,153.72 78.56,159.54 82.64,163.46 84.25,164.96 89.94,170.02 95.63,174.74 101.32,179.16 107.01,183.28 112.70,187.15 115.16,188.75 118.39,190.77 124.08,194.18 129.77,197.37 135.46,200.37 141.15,203.20 146.83,205.87 152.52,208.38 158.21,210.76 163.90,213.01 169.59,215.14 175.28,217.16 180.97,219.07 186.66,220.89 189.50,221.77 192.35,222.63 198.04,224.28 203.73,225.85 209.42,227.35 215.11,228.79 220.79,230.16 226.48,231.48 232.17,232.74 237.86,233.96 243.55,235.12 249.24,236.24 254.93,237.32 259.20,238.10 260.62,238.36 266.31,239.36 272.00,240.33 277.69,241.27 283.38,242.17 289.07,243.05 294.76,243.90 300.44,244.72 306.13,245.52 311.82,246.29 317.51,247.04 323.20,247.77 328.89,248.48 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='137.70' x2='51.90' y2='137.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='139.48' x2='50.12' y2='135.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='135.91' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='121.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.50' x2='54.22' y2='127.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.29' x2='52.44' y2='125.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='125.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='132.99' x2='54.22' y2='132.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='134.77' x2='52.44' y2='131.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='131.21' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='120.76' x2='58.87' y2='120.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='122.54' x2='57.09' y2='118.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='118.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.89' x2='58.87' y2='139.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='141.67' x2='57.09' y2='138.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='138.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.28' x2='68.16' y2='160.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='162.06' x2='66.38' y2='158.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='158.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.54' x2='68.16' y2='145.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='147.32' x2='66.38' y2='143.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='143.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='174.23' x2='84.42' y2='174.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='176.02' x2='82.64' y2='172.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='172.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.57' x2='84.42' y2='171.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='173.35' x2='82.64' y2='169.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='169.79' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.52' x2='116.95' y2='201.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='203.30' x2='115.16' y2='199.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='199.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.64' x2='116.95' y2='199.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='201.42' x2='115.16' y2='197.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='197.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.17' x2='191.29' y2='236.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.96' x2='189.50' y2='234.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.49' x2='191.29' y2='236.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='238.27' x2='189.50' y2='234.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.74' x2='260.98' y2='253.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.52' x2='259.20' y2='251.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='251.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.19' x2='260.98' y2='249.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='250.97' x2='259.20' y2='247.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='247.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.32' x2='330.67' y2='260.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='262.11' x2='328.89' y2='258.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='258.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.26' x2='330.67' y2='261.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.05' x2='328.89' y2='259.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='259.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.76 52.44,129.74 55.81,135.27 57.09,137.30 61.50,144.03 66.38,151.00 67.19,152.10 72.87,159.55 78.56,166.42 82.64,171.02 84.25,172.78 89.94,178.66 95.63,184.10 101.32,189.15 107.01,193.84 112.70,198.20 115.16,199.99 118.39,202.26 124.08,206.04 129.77,209.56 135.46,212.85 141.15,215.93 146.83,218.81 152.52,221.51 158.21,224.05 163.90,226.43 169.59,228.68 175.28,230.79 180.97,232.78 186.66,234.67 189.50,235.57 192.35,236.45 198.04,238.13 203.73,239.73 209.42,241.25 215.11,242.69 220.79,244.06 226.48,245.37 232.17,246.61 237.86,247.80 243.55,248.93 249.24,250.02 254.93,251.06 259.20,251.81 260.62,252.05 266.31,253.00 272.00,253.92 277.69,254.79 283.38,255.64 289.07,256.45 294.76,257.23 300.44,257.98 306.13,258.70 311.82,259.40 317.51,260.07 323.20,260.72 328.89,261.34 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='125.31' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.09' x2='51.90' y2='123.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.53' x2='51.90' y2='127.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='128.60' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.38' x2='51.90' y2='126.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='126.82' x2='51.90' y2='130.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.88' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='128.66' x2='54.22' y2='125.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='125.09' x2='54.22' y2='128.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='115.74' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='117.52' x2='54.22' y2='113.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='113.96' x2='54.22' y2='117.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='138.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.42' x2='58.87' y2='136.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.86' x2='58.87' y2='140.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='126.41' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='128.19' x2='58.87' y2='124.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='124.62' x2='58.87' y2='128.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='152.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.69' x2='68.16' y2='151.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.13' x2='68.16' y2='154.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='150.08' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.87' x2='68.16' y2='148.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.30' x2='68.16' y2='151.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='173.61' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='175.39' x2='84.42' y2='171.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.82' x2='84.42' y2='175.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='180.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='181.97' x2='84.42' y2='178.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='178.41' x2='84.42' y2='181.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='205.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='207.53' x2='116.95' y2='203.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='203.97' x2='116.95' y2='207.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='204.03' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.81' x2='116.95' y2='202.25' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.25' x2='116.95' y2='205.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='243.86' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='245.64' x2='191.29' y2='242.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.08' x2='191.29' y2='245.64' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='239.94' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='241.72' x2='191.29' y2='238.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='238.16' x2='191.29' y2='241.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='258.44' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='260.22' x2='260.98' y2='256.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='256.66' x2='260.98' y2='260.22' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='252.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.95' x2='260.98' y2='250.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='250.39' x2='260.98' y2='253.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='262.52' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='264.30' x2='330.67' y2='260.74' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.74' x2='330.67' y2='264.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.11' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.89' x2='330.67' y2='259.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.33' x2='330.67' y2='262.89' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.10 52.44,127.71 55.81,134.08 57.09,136.40 61.50,144.06 66.38,151.92 67.19,153.16 72.87,161.45 78.56,169.03 82.64,174.06 84.25,175.96 89.94,182.31 95.63,188.13 101.32,193.48 107.01,198.40 112.70,202.93 115.16,204.78 118.39,207.11 124.08,210.97 129.77,214.55 135.46,217.87 141.15,220.95 146.83,223.81 152.52,226.48 158.21,228.98 163.90,231.31 169.59,233.49 175.28,235.53 180.97,237.46 186.66,239.27 189.50,240.13 192.35,240.97 198.04,242.58 203.73,244.10 209.42,245.54 215.11,246.91 220.79,248.20 226.48,249.43 232.17,250.60 237.86,251.72 243.55,252.78 249.24,253.80 254.93,254.77 259.20,255.47 260.62,255.70 266.31,256.59 272.00,257.44 277.69,258.25 283.38,259.04 289.07,259.79 294.76,260.52 300.44,261.21 306.13,261.88 311.82,262.53 317.51,263.15 323.20,263.75 328.89,264.32 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,116.00 51.90,119.56 48.34,119.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='116.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,122.43 51.90,125.99 48.34,125.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='122.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,126.35 54.22,129.91 50.66,129.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='126.35' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,116.31 54.22,119.88 50.66,119.88 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='116.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.56 58.87,145.12 55.30,145.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='141.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,145.64 58.87,149.20 55.30,149.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='145.64' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,156.61 68.16,160.18 64.60,160.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='156.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,155.67 68.16,159.24 64.60,159.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='155.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.72 84.42,190.29 80.86,190.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,177.94 84.42,181.50 80.86,181.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='177.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,207.11 116.95,210.67 113.38,210.67 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='207.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.28 116.95,207.85 113.38,207.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='204.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,238.94 191.29,242.50 187.72,242.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='238.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,239.72 191.29,243.29 187.72,243.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='239.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,253.05 260.98,256.62 257.42,256.62 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='253.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,249.76 260.98,253.32 257.42,253.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='249.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,262.15 330.67,265.71 327.11,265.71 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='262.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,261.83 330.67,265.40 327.11,265.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='261.83' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,122.84 52.44,128.81 55.81,136.88 57.09,139.77 61.50,149.08 66.38,158.29 67.19,159.71 72.87,169.01 78.56,177.16 82.64,182.39 84.25,184.34 89.94,190.67 95.63,196.29 101.32,201.28 107.01,205.75 112.70,209.76 115.16,211.37 118.39,213.37 124.08,216.65 129.77,219.63 135.46,222.35 141.15,224.84 146.83,227.15 152.52,229.28 158.21,231.26 163.90,233.11 169.59,234.85 175.28,236.48 180.97,238.02 186.66,239.47 189.50,240.17 192.35,240.85 198.04,242.16 203.73,243.41 209.42,244.61 215.11,245.75 220.79,246.85 226.48,247.91 232.17,248.92 237.86,249.89 243.55,250.84 249.24,251.74 254.93,252.62 259.20,253.26 260.62,253.47 266.31,254.29 272.00,255.08 277.69,255.85 283.38,256.59 289.07,257.32 294.76,258.01 300.44,258.69 306.13,259.35 311.82,259.99 317.51,260.61 323.20,261.21 328.89,261.80 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,118.94 51.90,118.94 51.90,115.37 48.34,115.37 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,117.21 51.90,117.21 51.90,113.65 48.34,113.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,128.19 54.22,128.19 54.22,124.62 50.66,124.62 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,130.85 54.22,130.85 54.22,127.29 50.66,127.29 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,146.38 58.87,146.38 58.87,142.81 55.30,142.81 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,140.42 58.87,140.42 58.87,136.86 55.30,136.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,162.53 68.16,162.53 68.16,158.97 64.60,158.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,164.57 68.16,164.57 68.16,161.00 64.60,161.00 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,186.37 84.42,186.37 84.42,182.80 80.86,182.80 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,193.11 84.42,193.11 84.42,189.54 80.86,189.54 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,213.81 116.95,213.81 116.95,210.24 113.38,210.24 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,210.36 116.95,210.36 116.95,206.79 113.38,206.79 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,237.96 191.29,237.96 191.29,234.39 187.72,234.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,238.27 191.29,238.27 191.29,234.71 187.72,234.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,250.81 260.98,250.81 260.98,247.25 257.42,247.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,249.40 260.98,249.40 260.98,245.84 257.42,245.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,259.91 330.67,259.91 330.67,256.35 327.11,256.35 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,255.05 330.67,255.05 330.67,251.48 327.11,251.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,122.25 52.44,128.96 55.81,137.89 57.09,141.05 61.50,151.08 66.38,160.77 67.19,162.24 72.87,171.73 78.56,179.84 82.64,184.92 84.25,186.79 89.94,192.79 95.63,197.99 101.32,202.54 107.01,206.53 112.70,210.07 115.16,211.48 118.39,213.22 124.08,216.05 129.77,218.60 135.46,220.93 141.15,223.06 146.83,225.03 152.52,226.86 158.21,228.56 163.90,230.16 169.59,231.67 175.28,233.10 180.97,234.46 186.66,235.76 189.50,236.38 192.35,237.00 198.04,238.19 203.73,239.33 209.42,240.44 215.11,241.50 220.79,242.53 226.48,243.53 232.17,244.50 237.86,245.44 243.55,246.35 249.24,247.23 254.93,248.09 259.20,248.73 260.62,248.93 266.31,249.75 272.00,250.54 277.69,251.32 283.38,252.07 289.07,252.80 294.76,253.52 300.44,254.22 306.13,254.89 311.82,255.56 317.51,256.20 323.20,256.83 328.89,257.45 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='288.88' x2='683.82' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='288.88' x2='410.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='464.86' y1='288.88' x2='464.86' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='519.60' y1='288.88' x2='519.60' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='574.34' y1='288.88' x2='574.34' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='629.08' y1='288.88' x2='629.08' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='683.82' y1='288.88' x2='683.82' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='460.47' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='515.21' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='569.95' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='624.69' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='677.24' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<line x1='398.97' y1='270.66' x2='398.97' y2='120.46' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='270.66' x2='394.21' y2='270.66' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='233.11' x2='394.21' y2='233.11' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='195.56' x2='394.21' y2='195.56' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='158.01' x2='394.21' y2='158.01' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='120.46' x2='394.21' y2='120.46' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,274.17) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,236.62) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,197.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,160.21) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,122.66) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,288.88 700.04,288.88 700.04,102.24 398.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk='>
+ <rect x='360.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text x='532.82' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text transform='translate(368.55,233.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='195.56' x2='700.04' y2='195.56' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='681.29' cy='235.31' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='681.29' cy='176.62' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='671.69' cy='205.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='671.69' cy='150.73' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='654.19' cy='132.96' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='654.19' cy='242.15' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='624.94' cy='188.14' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='624.94' cy='163.57' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='587.54' cy='220.66' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='587.54' cy='182.44' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='543.33' cy='203.27' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='543.33' cy='217.60' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='497.84' cy='197.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='497.84' cy='198.63' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='474.63' cy='186.89' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='474.63' cy='184.84' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='458.17' cy='200.64' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='458.17' cy='194.49' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.28,203.02 685.68,207.18 680.88,207.18 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.28,191.42 685.68,195.58 680.88,195.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.58,178.53 677.98,182.69 673.18,182.69 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.58,186.04 677.98,190.20 673.18,190.20 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.13,183.86 663.53,188.02 658.73,188.02 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.13,166.12 663.53,170.28 658.73,170.28 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.58,229.13 637.98,233.28 633.18,233.28 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.58,187.50 637.98,191.65 633.18,191.65 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='599.76,198.33 602.16,202.48 597.36,202.48 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='599.76,232.45 602.16,236.61 597.36,236.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='551.59,173.75 553.99,177.91 549.19,177.91 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='551.59,160.78 553.99,164.94 549.19,164.94 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='498.56,175.63 500.96,179.78 496.16,179.78 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='498.56,194.05 500.96,198.21 496.16,198.21 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.23,207.88 477.63,212.04 472.83,212.04 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.23,199.01 477.63,203.17 472.83,203.17 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.32,201.37 462.72,205.53 457.92,205.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.32,188.41 462.72,192.56 457.92,192.56 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.06' y1='131.53' x2='684.10' y2='131.53' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.58' y1='134.06' x2='681.58' y2='129.01' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.06' y1='188.86' x2='684.10' y2='188.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.58' y1='191.38' x2='681.58' y2='186.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.75' y1='212.10' x2='677.79' y2='212.10' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.27' y1='214.62' x2='675.27' y2='209.58' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='672.75' y1='208.00' x2='677.79' y2='208.00' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.27' y1='210.52' x2='675.27' y2='205.48' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.66' y1='226.55' x2='665.70' y2='226.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.18' y1='229.07' x2='663.18' y2='224.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.66' y1='179.46' x2='665.70' y2='179.46' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.18' y1='181.98' x2='663.18' y2='176.94' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.43' y1='191.90' x2='643.47' y2='191.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.95' y1='194.42' x2='640.95' y2='189.38' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.43' y1='185.08' x2='643.47' y2='185.08' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.95' y1='187.60' x2='640.95' y2='182.56' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.00' y1='216.56' x2='610.04' y2='216.56' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.52' y1='219.08' x2='607.52' y2='214.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.00' y1='166.74' x2='610.04' y2='166.74' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.52' y1='169.26' x2='607.52' y2='164.22' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.38' y1='213.11' x2='559.42' y2='213.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.90' y1='215.63' x2='556.90' y2='210.59' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.38' y1='200.14' x2='559.42' y2='200.14' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.90' y1='202.66' x2='556.90' y2='197.62' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='487.93' y1='202.72' x2='492.97' y2='202.72' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.45' y1='205.24' x2='490.45' y2='200.20' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='487.93' y1='189.07' x2='492.97' y2='189.07' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.45' y1='191.59' x2='490.45' y2='186.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.71' y1='199.36' x2='461.75' y2='199.36' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.23' y1='201.88' x2='459.23' y2='196.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.71' y1='199.36' x2='461.75' y2='199.36' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.23' y1='201.88' x2='459.23' y2='196.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.03' y1='179.98' x2='444.07' y2='179.98' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.55' y1='182.50' x2='441.55' y2='177.46' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.03' y1='196.36' x2='444.07' y2='196.36' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.55' y1='198.88' x2='441.55' y2='193.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.51' y1='208.89' x2='685.08' y2='205.33' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.51' y1='205.33' x2='685.08' y2='208.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.51' y1='215.03' x2='685.08' y2='211.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.51' y1='211.47' x2='685.08' y2='215.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.43' y1='238.15' x2='677.99' y2='234.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.43' y1='234.59' x2='677.99' y2='238.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.43' y1='150.12' x2='677.99' y2='146.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.43' y1='146.55' x2='677.99' y2='150.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.93' y1='176.96' x2='664.49' y2='173.40' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.93' y1='173.40' x2='664.49' y2='176.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.93' y1='176.28' x2='664.49' y2='172.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.93' y1='172.72' x2='664.49' y2='176.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.36' y1='217.07' x2='639.92' y2='213.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.36' y1='213.50' x2='639.92' y2='217.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.36' y1='149.50' x2='639.92' y2='145.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.36' y1='145.94' x2='639.92' y2='149.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.08' y1='186.03' x2='603.65' y2='182.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.08' y1='182.47' x2='603.65' y2='186.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.08' y1='224.93' x2='603.65' y2='221.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.08' y1='221.37' x2='603.65' y2='224.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.86' y1='204.08' x2='550.43' y2='200.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.86' y1='200.52' x2='550.43' y2='204.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.86' y1='193.85' x2='550.43' y2='190.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.86' y1='190.28' x2='550.43' y2='193.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.62' y1='206.15' x2='484.18' y2='202.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.62' y1='202.59' x2='484.18' y2='206.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.62' y1='206.84' x2='484.18' y2='203.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='480.62' y1='203.27' x2='484.18' y2='206.84' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.08' y1='200.64' x2='454.64' y2='197.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.08' y1='197.07' x2='454.64' y2='200.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.08' y1='198.59' x2='454.64' y2='195.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.08' y1='195.03' x2='454.64' y2='198.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.84' y1='194.03' x2='438.41' y2='190.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.84' y1='190.47' x2='438.41' y2='194.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.84' y1='188.57' x2='438.41' y2='185.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='434.84' y1='185.01' x2='438.41' y2='188.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.59,236.49 687.11,233.97 689.63,236.49 687.11,239.01 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.59,238.54 687.11,236.02 689.63,238.54 687.11,241.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.19,187.78 672.71,185.26 675.23,187.78 672.71,190.30 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.19,133.18 672.71,130.66 675.23,133.18 672.71,135.70 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='645.42,199.03 647.95,196.51 650.47,199.03 647.95,201.55 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='645.42,201.07 647.95,198.55 650.47,201.07 647.95,203.59 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='608.34,205.50 610.86,202.97 613.38,205.50 610.86,208.02 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='608.34,187.75 610.86,185.23 613.38,187.75 610.86,190.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='568.37,180.95 570.89,178.43 573.41,180.95 570.89,183.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='568.37,191.19 570.89,188.67 573.41,191.19 570.89,193.71 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='529.17,214.54 531.69,212.02 534.21,214.54 531.69,217.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='529.17,220.00 531.69,217.48 534.21,220.00 531.69,222.52 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.42,183.51 489.94,180.99 492.46,183.51 489.94,186.03 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.42,203.99 489.94,201.47 492.46,203.99 489.94,206.51 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='463.09,188.90 465.61,186.38 468.13,188.90 465.61,191.42 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='463.09,193.68 465.61,191.16 468.13,193.68 465.61,196.20 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='446.22,192.75 448.74,190.23 451.26,192.75 448.74,195.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='446.22,189.33 448.74,186.81 451.26,189.33 448.74,191.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.24,218.20 685.64,214.04 680.84,214.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.24,220.93 685.64,216.77 680.84,216.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.48,174.77 677.88,170.61 673.08,170.61 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.48,151.56 677.88,147.41 673.08,147.41 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.01,212.23 663.41,208.07 658.61,208.07 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.01,183.56 663.41,179.41 658.61,179.41 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.78,216.44 638.18,212.28 633.38,212.28 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.78,219.17 638.18,215.01 633.38,215.01 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.21,211.87 603.61,207.71 598.81,207.71 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.21,147.72 603.61,143.56 598.81,143.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='556.29,240.61 558.69,236.45 553.89,236.45 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='556.29,183.97 558.69,179.81 553.89,179.81 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='507.96,198.01 510.36,193.86 505.56,193.86 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='507.96,189.14 510.36,184.99 505.56,184.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.42,203.71 487.82,199.55 483.02,199.55 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.42,199.62 487.82,195.46 483.02,195.46 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='469.87,200.18 472.27,196.02 467.47,196.02 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='469.87,185.85 472.27,181.69 467.47,181.69 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='680.85' y='166.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.85' y1='170.28' x2='684.41' y2='166.72' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.85' y1='166.72' x2='684.41' y2='170.28' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='680.85' y='232.23' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.85' y1='235.80' x2='684.41' y2='232.23' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.85' y1='232.23' x2='684.41' y2='235.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='668.29' y='211.68' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.29' y1='215.24' x2='671.86' y2='211.68' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.29' y1='211.68' x2='671.86' y2='215.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='668.29' y='167.32' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.29' y1='170.88' x2='671.86' y2='167.32' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.29' y1='167.32' x2='671.86' y2='170.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='645.47' y='127.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.47' y1='130.88' x2='649.03' y2='127.31' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.47' y1='127.31' x2='649.03' y2='130.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='645.47' y='199.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.47' y1='203.22' x2='649.03' y2='199.65' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.47' y1='199.65' x2='649.03' y2='203.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='607.61' y='159.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.61' y1='163.17' x2='611.17' y2='159.61' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.61' y1='159.61' x2='611.17' y2='163.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='607.61' y='244.23' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.61' y1='247.80' x2='611.17' y2='244.23' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.61' y1='244.23' x2='611.17' y2='247.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='559.87' y='221.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='559.87' y1='225.56' x2='563.44' y2='221.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='559.87' y1='221.99' x2='563.44' y2='225.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='559.87' y='201.52' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='559.87' y1='205.08' x2='563.44' y2='201.52' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='559.87' y1='201.52' x2='563.44' y2='205.08' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='505.29' y='188.17' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.29' y1='191.74' x2='508.85' y2='188.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.29' y1='188.17' x2='508.85' y2='191.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='505.29' y='195.68' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.29' y1='199.24' x2='508.85' y2='195.68' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.29' y1='195.68' x2='508.85' y2='199.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='455.25' y='184.63' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.25' y1='188.20' x2='458.81' y2='184.63' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.25' y1='184.63' x2='458.81' y2='188.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='455.25' y='182.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.25' y1='186.15' x2='458.81' y2='182.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.25' y1='182.58' x2='458.81' y2='186.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.28' y='196.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.28' y1='200.44' x2='438.85' y2='196.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.28' y1='196.88' x2='438.85' y2='200.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.28' y='191.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.28' y1='194.98' x2='438.85' y2='191.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.28' y1='191.42' x2='438.85' y2='194.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='424.18' y='195.90' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.18' y1='199.47' x2='427.74' y2='195.90' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.18' y1='195.90' x2='427.74' y2='199.47' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='424.18' y='207.51' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.18' y1='211.07' x2='427.74' y2='207.51' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.18' y1='207.51' x2='427.74' y2='211.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.01' y1='175.12' x2='686.58' y2='171.56' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.01' y1='171.56' x2='686.58' y2='175.12' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.28' y1='173.34' x2='687.32' y2='173.34' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.80' y1='175.86' x2='684.80' y2='170.82' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.01' y1='246.10' x2='686.58' y2='242.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.01' y1='242.53' x2='686.58' y2='246.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.28' y1='244.32' x2='687.32' y2='244.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.80' y1='246.84' x2='684.80' y2='241.80' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.46' y1='226.40' x2='669.02' y2='222.84' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.46' y1='222.84' x2='669.02' y2='226.40' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.72' y1='224.62' x2='669.76' y2='224.62' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.24' y1='227.14' x2='667.24' y2='222.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.46' y1='157.47' x2='669.02' y2='153.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.46' y1='153.91' x2='669.02' y2='157.47' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.72' y1='155.69' x2='669.76' y2='155.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.24' y1='158.21' x2='667.24' y2='153.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.41' y1='216.01' x2='638.98' y2='212.45' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.41' y1='212.45' x2='638.98' y2='216.01' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='634.68' y1='214.23' x2='639.72' y2='214.23' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.20' y1='216.75' x2='637.20' y2='211.71' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.41' y1='145.72' x2='638.98' y2='142.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.41' y1='142.15' x2='638.98' y2='145.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='634.68' y1='143.93' x2='639.72' y2='143.93' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.20' y1='146.45' x2='637.20' y2='141.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.04' y1='219.50' x2='594.61' y2='215.93' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.04' y1='215.93' x2='594.61' y2='219.50' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='590.30' y1='217.72' x2='595.35' y2='217.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='592.83' y1='220.24' x2='592.83' y2='215.20' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.04' y1='196.98' x2='594.61' y2='193.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.04' y1='193.41' x2='594.61' y2='196.98' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='590.30' y1='195.19' x2='595.35' y2='195.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='592.83' y1='197.71' x2='592.83' y2='192.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.19' y1='178.22' x2='548.76' y2='174.65' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.19' y1='174.65' x2='548.76' y2='178.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='544.46' y1='176.44' x2='549.50' y2='176.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.98' y1='178.96' x2='546.98' y2='173.92' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.19' y1='202.10' x2='548.76' y2='198.54' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.19' y1='198.54' x2='548.76' y2='202.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='544.46' y1='200.32' x2='549.50' y2='200.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.98' y1='202.84' x2='546.98' y2='197.80' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.86' y1='195.07' x2='509.43' y2='191.50' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.86' y1='191.50' x2='509.43' y2='195.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.13' y1='193.29' x2='510.17' y2='193.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='507.65' y1='195.81' x2='507.65' y2='190.77' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.86' y1='206.67' x2='509.43' y2='203.11' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.86' y1='203.11' x2='509.43' y2='206.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.13' y1='204.89' x2='510.17' y2='204.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='507.65' y1='207.41' x2='507.65' y2='202.37' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.69' y1='194.09' x2='477.25' y2='190.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.69' y1='190.53' x2='477.25' y2='194.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='472.95' y1='192.31' x2='477.99' y2='192.31' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.47' y1='194.83' x2='475.47' y2='189.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.69' y1='198.19' x2='477.25' y2='194.62' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.69' y1='194.62' x2='477.25' y2='198.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='472.95' y1='196.40' x2='477.99' y2='196.40' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.47' y1='198.92' x2='475.47' y2='193.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.99' y1='201.37' x2='459.55' y2='197.81' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.99' y1='197.81' x2='459.55' y2='201.37' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.25' y1='199.59' x2='460.29' y2='199.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.77' y1='202.11' x2='457.77' y2='197.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.99' y1='200.01' x2='459.55' y2='196.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.99' y1='196.44' x2='459.55' y2='200.01' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.25' y1='198.22' x2='460.29' y2='198.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.77' y1='200.74' x2='457.77' y2='195.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.17' y1='197.85' x2='446.73' y2='194.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.17' y1='194.29' x2='446.73' y2='197.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.43' y1='196.07' x2='447.47' y2='196.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.95' y1='198.59' x2='444.95' y2='193.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.17' y1='201.95' x2='446.73' y2='198.38' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='443.17' y1='198.38' x2='446.73' y2='201.95' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.43' y1='200.16' x2='447.47' y2='200.16' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.95' y1='202.68' x2='444.95' y2='197.64' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.40' y1='257.45' x2='689.44' y2='257.45' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.92' y1='259.97' x2='686.92' y2='254.93' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.40,257.45 686.92,254.93 689.44,257.45 686.92,259.97 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.40' y1='127.10' x2='689.44' y2='127.10' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.92' y1='129.62' x2='686.92' y2='124.58' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='684.40,127.10 686.92,124.58 689.44,127.10 686.92,129.62 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.37' y1='206.46' x2='678.41' y2='206.46' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.89' y1='208.98' x2='675.89' y2='203.94' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.37,206.46 675.89,203.94 678.41,206.46 675.89,208.98 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.37' y1='245.36' x2='678.41' y2='245.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.89' y1='247.88' x2='675.89' y2='242.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.37,245.36 675.89,242.84 678.41,245.36 675.89,247.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='653.18' y1='159.21' x2='658.22' y2='159.21' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.70' y1='161.73' x2='655.70' y2='156.69' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='653.18,159.21 655.70,156.69 658.22,159.21 655.70,161.73 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='653.18' y1='198.79' x2='658.22' y2='198.79' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.70' y1='201.31' x2='655.70' y2='196.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='653.18,198.79 655.70,196.27 658.22,198.79 655.70,201.31 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='619.22' y1='205.00' x2='624.26' y2='205.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='621.74' y1='207.52' x2='621.74' y2='202.48' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.22,205.00 621.74,202.48 624.26,205.00 621.74,207.52 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='619.22' y1='177.02' x2='624.26' y2='177.02' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='621.74' y1='179.54' x2='621.74' y2='174.50' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.22,177.02 621.74,174.50 624.26,177.02 621.74,179.54 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='575.36' y1='167.62' x2='580.40' y2='167.62' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='577.88' y1='170.14' x2='577.88' y2='165.10' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='575.36,167.62 577.88,165.10 580.40,167.62 577.88,170.14 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='575.36' y1='204.47' x2='580.40' y2='204.47' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='577.88' y1='206.99' x2='577.88' y2='201.95' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='575.36,204.47 577.88,201.95 580.40,204.47 577.88,206.99 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.38' y1='196.91' x2='528.42' y2='196.91' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='525.90' y1='199.43' x2='525.90' y2='194.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.38,196.91 525.90,194.39 528.42,196.91 525.90,199.43 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.38' y1='215.34' x2='528.42' y2='215.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='525.90' y1='217.86' x2='525.90' y2='212.82' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.38,215.34 525.90,212.82 528.42,215.34 525.90,217.86 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.03' y1='196.87' x2='478.07' y2='196.87' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.55' y1='199.39' x2='475.55' y2='194.35' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='473.03,196.87 475.55,194.35 478.07,196.87 475.55,199.39 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.03' y1='203.01' x2='478.07' y2='203.01' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.55' y1='205.53' x2='475.55' y2='200.49' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='473.03,203.01 475.55,200.49 478.07,203.01 475.55,205.53 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='450.94' y1='210.33' x2='455.98' y2='210.33' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.46' y1='212.85' x2='453.46' y2='207.81' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='450.94,210.33 453.46,207.81 455.98,210.33 453.46,212.85 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='450.94' y1='190.54' x2='455.98' y2='190.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='453.46' y1='193.06' x2='453.46' y2='188.02' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='450.94,190.54 453.46,188.02 455.98,190.54 453.46,193.06 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='437.00' y1='182.30' x2='442.04' y2='182.30' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.52' y1='184.82' x2='439.52' y2='179.78' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='437.00,182.30 439.52,179.78 442.04,182.30 439.52,184.82 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='437.00' y1='207.55' x2='442.04' y2='207.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.52' y1='210.07' x2='439.52' y2='205.03' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='437.00,207.55 439.52,205.03 442.04,207.55 439.52,210.07 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='686.18' cy='199.92' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.40' y1='199.92' x2='687.96' y2='199.92' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.18' y1='201.70' x2='686.18' y2='198.14' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='686.18' cy='198.55' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.40' y1='198.55' x2='687.96' y2='198.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.18' y1='200.34' x2='686.18' y2='196.77' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.20' cy='202.98' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.42' y1='202.98' x2='680.99' y2='202.98' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.20' y1='204.76' x2='679.20' y2='201.20' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.20' cy='217.31' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.42' y1='217.31' x2='680.99' y2='217.31' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.20' y1='219.09' x2='679.20' y2='215.53' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='665.95' cy='191.66' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.17' y1='191.66' x2='667.74' y2='191.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.95' y1='193.44' x2='665.95' y2='189.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='665.95' cy='179.37' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.17' y1='179.37' x2='667.74' y2='179.37' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.95' y1='181.16' x2='665.95' y2='177.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='642.02' cy='148.98' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.23' y1='148.98' x2='643.80' y2='148.98' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='642.02' y1='150.76' x2='642.02' y2='147.20' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='642.02' cy='202.21' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.23' y1='202.21' x2='643.80' y2='202.21' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='642.02' y1='203.99' x2='642.02' y2='200.43' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='607.08' cy='212.87' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.30' y1='212.87' x2='608.87' y2='212.87' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.08' y1='214.66' x2='607.08' y2='211.09' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='607.08' cy='210.83' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.30' y1='210.83' x2='608.87' y2='210.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.08' y1='212.61' x2='607.08' y2='209.04' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='556.72' cy='175.35' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.94' y1='175.35' x2='558.50' y2='175.35' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.72' y1='177.13' x2='556.72' y2='173.57' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='556.72' cy='225.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.94' y1='225.17' x2='558.50' y2='225.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='556.72' y1='226.95' x2='556.72' y2='223.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='494.80' cy='187.10' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.02' y1='187.10' x2='496.58' y2='187.10' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='494.80' y1='188.89' x2='494.80' y2='185.32' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='494.80' cy='187.79' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.02' y1='187.79' x2='496.58' y2='187.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='494.80' y1='189.57' x2='494.80' y2='186.01' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='466.11' cy='215.65' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.32' y1='215.65' x2='467.89' y2='215.65' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='466.11' y1='217.43' x2='466.11' y2='213.87' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='466.11' cy='196.54' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.32' y1='196.54' x2='467.89' y2='196.54' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='466.11' y1='198.32' x2='466.11' y2='194.76' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='448.90' cy='186.90' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='447.12' y1='186.90' x2='450.68' y2='186.90' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.90' y1='188.68' x2='448.90' y2='185.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='448.90' cy='197.13' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='447.12' y1='197.13' x2='450.68' y2='197.13' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.90' y1='198.92' x2='448.90' y2='195.35' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='682.81,187.22 685.21,182.37 680.41,182.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='682.81,181.67 685.21,186.52 680.41,186.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='682.81,193.36 685.21,188.51 680.41,188.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='682.81,187.82 685.21,192.67 680.41,192.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.14,182.24 679.54,177.39 674.74,177.39 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.14,176.70 679.54,181.55 674.74,181.55 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.14,260.04 679.54,255.19 674.74,255.19 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.14,254.50 679.54,259.35 674.74,259.35 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.30,187.42 668.70,182.57 663.90,182.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.30,181.88 668.70,186.73 663.90,186.73 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.30,169.68 668.70,164.83 663.90,164.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.30,164.13 668.70,168.98 663.90,168.98 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.49,227.27 648.89,222.42 644.09,222.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.49,221.73 648.89,226.58 644.09,226.58 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.49,161.07 648.89,156.22 644.09,156.22 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.49,155.53 648.89,160.38 644.09,160.38 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='616.96,188.30 619.36,183.45 614.56,183.45 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='616.96,182.76 619.36,187.61 614.56,187.61 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='616.96,169.87 619.36,165.02 614.56,165.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='616.96,164.33 619.36,169.18 614.56,169.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.82,212.37 575.22,207.52 570.42,207.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.82,206.83 575.22,211.68 570.42,211.68 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.82,232.84 575.22,227.99 570.42,227.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='572.82,227.30 575.22,232.15 570.42,232.15 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.18,199.79 517.58,194.95 512.78,194.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.18,194.25 517.58,199.10 512.78,199.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.18,192.97 517.58,188.12 512.78,188.12 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.18,187.43 517.58,192.28 512.78,192.28 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.67,184.21 489.07,179.36 484.27,179.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.67,178.67 489.07,183.52 484.27,183.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.67,212.19 489.07,207.34 484.27,207.34 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.67,206.65 489.07,211.50 484.27,211.50 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.55,194.57 470.95,189.72 466.15,189.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.55,189.03 470.95,193.88 466.15,193.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.55,195.26 470.95,190.41 466.15,190.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.55,189.71 470.95,194.56 466.15,194.56 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.98' y1='143.61' x2='684.54' y2='143.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.76' y1='145.40' x2='682.76' y2='141.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='680.98' y='141.83' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='680.98' y1='207.08' x2='684.54' y2='207.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.76' y1='208.87' x2='682.76' y2='205.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='680.98' y='205.30' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.03' y1='205.29' x2='677.60' y2='205.29' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.81' y1='207.07' x2='675.81' y2='203.51' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='674.03' y='203.51' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.03' y1='181.41' x2='677.60' y2='181.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.81' y1='183.19' x2='675.81' y2='179.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='674.03' y='179.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.83' y1='267.56' x2='664.39' y2='267.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.61' y1='269.34' x2='662.61' y2='265.78' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='660.83' y='265.78' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='660.83' y1='184.30' x2='664.39' y2='184.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.61' y1='186.08' x2='662.61' y2='182.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='660.83' y='182.52' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.93' y1='155.17' x2='640.49' y2='155.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.71' y1='156.95' x2='638.71' y2='153.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='636.93' y='153.38' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.93' y1='219.32' x2='640.49' y2='219.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.71' y1='221.10' x2='638.71' y2='217.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='636.93' y='217.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.97' y1='181.60' x2='605.53' y2='181.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='603.75' y1='183.38' x2='603.75' y2='179.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='601.97' y='179.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='601.97' y1='193.20' x2='605.53' y2='193.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='603.75' y1='194.98' x2='603.75' y2='191.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='601.97' y='191.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='551.41' y1='188.92' x2='554.97' y2='188.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.19' y1='190.71' x2='553.19' y2='187.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='551.41' y='187.14' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='551.41' y1='197.11' x2='554.97' y2='197.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.19' y1='198.90' x2='553.19' y2='195.33' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='551.41' y='195.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='489.31' y1='192.93' x2='492.88' y2='192.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='491.09' y1='194.71' x2='491.09' y2='191.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='489.31' y='191.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='489.31' y1='191.56' x2='492.88' y2='191.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='491.09' y1='193.35' x2='491.09' y2='189.78' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='489.31' y='189.78' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='460.97' y1='187.15' x2='464.54' y2='187.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='462.76' y1='188.94' x2='462.76' y2='185.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='460.97' y='185.37' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='460.97' y1='206.94' x2='464.54' y2='206.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='462.76' y1='208.73' x2='462.76' y2='205.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='460.97' y='205.16' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.32' y1='200.00' x2='447.89' y2='200.00' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.11' y1='201.78' x2='446.11' y2='198.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.32' y='198.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.32' y1='195.91' x2='447.89' y2='195.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.11' y1='197.69' x2='446.11' y2='194.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.32' y='194.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='687.39' cy='185.97' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.61' y1='187.75' x2='689.18' y2='184.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.61' y1='184.19' x2='689.18' y2='187.75' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='687.39' cy='171.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.61' y1='173.42' x2='689.18' y2='169.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.61' y1='169.86' x2='689.18' y2='173.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.35' cy='199.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.57' y1='200.97' x2='681.14' y2='197.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.57' y1='197.41' x2='681.14' y2='200.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.35' cy='247.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.57' y1='249.43' x2='681.14' y2='245.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.57' y1='245.86' x2='681.14' y2='249.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='664.18' cy='185.84' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.40' y1='187.62' x2='665.96' y2='184.06' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.40' y1='184.06' x2='665.96' y2='187.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='664.18' cy='239.07' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.40' y1='240.86' x2='665.96' y2='237.29' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.40' y1='237.29' x2='665.96' y2='240.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='637.10' cy='191.25' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.32' y1='193.03' x2='638.89' y2='189.47' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.32' y1='189.47' x2='638.89' y2='193.03' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='637.10' cy='203.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.32' y1='205.32' x2='638.89' y2='201.75' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.32' y1='201.75' x2='638.89' y2='205.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='598.45' cy='197.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.67' y1='199.32' x2='600.24' y2='195.75' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.67' y1='195.75' x2='600.24' y2='199.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='598.45' cy='168.87' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.67' y1='170.66' x2='600.24' y2='167.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='596.67' y1='167.09' x2='600.24' y2='170.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='544.83' cy='191.33' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.05' y1='193.12' x2='546.61' y2='189.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.05' y1='189.55' x2='546.61' y2='193.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='544.83' cy='198.84' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.05' y1='200.62' x2='546.61' y2='197.06' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.05' y1='197.06' x2='546.61' y2='200.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='483.13' cy='179.34' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.35' y1='181.12' x2='484.91' y2='177.56' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.35' y1='177.56' x2='484.91' y2='181.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='483.13' cy='196.40' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.35' y1='198.18' x2='484.91' y2='194.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.35' y1='194.62' x2='484.91' y2='198.18' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='456.36' cy='182.62' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.58' y1='184.41' x2='458.14' y2='180.84' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.58' y1='180.84' x2='458.14' y2='184.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='456.36' cy='209.92' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.58' y1='211.70' x2='458.14' y2='208.14' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.58' y1='208.14' x2='458.14' y2='211.70' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='440.91' cy='203.41' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.12' y1='205.20' x2='442.69' y2='201.63' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.12' y1='201.63' x2='442.69' y2='205.20' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='440.91' cy='209.56' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.12' y1='211.34' x2='442.69' y2='207.78' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.12' y1='207.78' x2='442.69' y2='211.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.85,215.80 689.64,219.37 686.07,219.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='686.07' y='215.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.85,187.82 689.64,191.39 686.07,191.39 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='686.07' y='187.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.43,196.75 679.21,200.31 675.65,200.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.65' y='196.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.43,240.43 679.21,243.99 675.65,243.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.65' y='240.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='658.30,178.24 660.08,181.81 656.52,181.81 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='656.52' y='178.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='658.30,160.50 660.08,164.06 656.52,164.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='656.52' y='160.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='625.98,193.33 627.76,196.90 624.19,196.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='624.19' y='193.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='625.98,197.43 627.76,200.99 624.19,200.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='624.19' y='197.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='583.91,167.19 585.69,170.76 582.13,170.76 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='582.13' y='167.19' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='583.91,205.41 585.69,208.97 582.13,208.97 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='582.13' y='205.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='533.33,204.58 535.11,208.14 531.55,208.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='531.55' y='204.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='533.33,216.86 535.11,220.43 531.55,220.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='531.55' y='216.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='483.07,191.37 484.85,194.94 481.28,194.94 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='481.28' y='191.37' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='483.07,187.96 484.85,191.52 481.28,191.52 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='481.28' y='187.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.22,186.92 462.00,190.48 458.44,190.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='458.44' y='186.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.22,201.25 462.00,204.81 458.44,204.81 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='458.44' y='201.25' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='445.32,184.49 447.10,188.05 443.54,188.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='443.54' y='184.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='445.32,185.85 447.10,189.42 443.54,189.42 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='443.54' y='185.85' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,219.51 690.67,219.51 690.67,215.95 687.11,215.95 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,227.02 690.67,227.02 690.67,223.45 687.11,223.45 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.39,208.46 678.96,208.46 678.96,204.89 675.39,204.89 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.39,196.85 678.96,196.85 678.96,193.29 675.39,193.29 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.29,181.91 657.85,181.91 657.85,178.35 654.29,178.35 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.29,207.85 657.85,207.85 657.85,204.28 654.29,204.28 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.87,197.44 623.43,197.44 623.43,193.88 619.87,193.88 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.87,188.57 623.43,188.57 623.43,185.01 619.87,185.01 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='577.71,198.82 581.28,198.82 581.28,195.26 577.71,195.26 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='577.71,169.48 581.28,169.48 581.28,165.91 577.71,165.91 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.37,194.95 534.93,194.95 534.93,191.38 531.37,191.38 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.37,209.96 534.93,209.96 534.93,206.40 531.37,206.40 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.89,198.25 491.46,198.25 491.46,194.69 487.89,194.69 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='487.89,196.89 491.46,196.89 491.46,193.32 487.89,193.32 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='466.35,196.00 469.91,196.00 469.91,192.44 466.35,192.44 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='466.35,202.15 469.91,202.15 469.91,198.58 466.35,198.58 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.12,194.38 454.69,194.38 454.69,190.82 451.12,190.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='451.12,215.54 454.69,215.54 454.69,211.98 451.12,211.98 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<polyline points='50.12,520.49 52.44,516.12 55.81,510.01 57.09,507.74 61.50,500.20 66.38,492.29 67.19,491.03 72.87,482.45 78.56,474.43 82.64,469.00 84.25,466.93 89.94,459.93 95.63,453.39 101.32,447.29 107.01,441.60 112.70,436.29 115.16,434.10 118.39,431.34 124.08,426.74 129.77,422.45 135.46,418.47 141.15,414.76 146.83,411.32 152.52,408.14 158.21,405.18 163.90,402.45 169.59,399.92 175.28,397.58 180.97,395.43 186.66,393.45 189.50,392.53 192.35,391.64 198.04,389.97 203.73,388.44 209.42,387.05 215.11,385.79 220.79,384.64 226.48,383.60 232.17,382.67 237.86,381.83 243.55,381.09 249.24,380.43 254.93,379.85 259.20,379.47 260.62,379.35 266.31,378.92 272.00,378.55 277.69,378.25 283.38,378.01 289.07,377.82 294.76,377.68 300.44,377.59 306.13,377.55 311.82,377.55 317.51,377.59 323.20,377.66 328.89,377.78 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='527.53' x2='328.89' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='527.53' x2='50.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='527.53' x2='96.58' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='527.53' x2='143.04' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='527.53' x2='189.50' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='527.53' x2='235.97' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='527.53' x2='282.43' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='527.53' x2='328.89' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='520.49' x2='38.97' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='520.49' x2='34.21' y2='520.49' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='483.65' x2='34.21' y2='483.65' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='446.81' x2='34.21' y2='446.81' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='409.97' x2='34.21' y2='409.97' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='373.13' x2='34.21' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,522.68) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,488.04) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,451.20) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,414.36) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,377.52) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<polygon points='38.97,527.53 340.04,527.53 340.04,337.35 38.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ=='>
+ <rect x='0.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text x='180.87' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text transform='translate(8.55,437.93) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='10.98px' lengthAdjust='spacingAndGlyphs'>m1</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<circle cx='52.44' cy='511.64' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='513.49' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='498.75' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='504.28' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='486.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='490.65' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='459.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='470.01' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='433.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='432.07' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='404.81' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='401.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='408.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='388.60' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.70' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.35 55.81,506.14 57.09,503.21 61.50,493.85 66.38,484.71 67.19,483.31 72.87,474.23 78.56,466.40 82.64,461.43 84.25,459.60 89.94,453.70 95.63,448.54 101.32,444.02 107.01,440.04 112.70,436.51 115.16,435.11 118.39,433.38 124.08,430.59 129.77,428.09 135.46,425.83 141.15,423.79 146.83,421.93 152.52,420.23 158.21,418.68 163.90,417.25 169.59,415.93 175.28,414.70 180.97,413.57 186.66,412.51 189.50,412.00 192.35,411.52 198.04,410.59 203.73,409.73 209.42,408.91 215.11,408.15 220.79,407.43 226.48,406.75 232.17,406.11 237.86,405.51 243.55,404.95 249.24,404.42 254.93,403.92 259.20,403.56 260.62,403.45 266.31,403.01 272.00,402.60 277.69,402.21 283.38,401.85 289.07,401.51 294.76,401.20 300.44,400.91 306.13,400.64 311.82,400.39 317.51,400.16 323.20,399.96 328.89,399.77 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.35 54.84,521.50 50.04,521.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,510.71 54.84,514.87 50.04,514.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,503.72 59.49,507.87 54.69,507.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,515.61 54.69,515.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,488.24 68.78,492.40 63.98,492.40 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,492.66 68.78,496.82 63.98,496.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,464.30 85.04,468.45 80.24,468.45 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,471.66 85.04,475.82 80.24,475.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,451.03 117.56,455.19 112.76,455.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,437.03 117.56,441.19 112.76,441.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.19 191.90,425.35 187.10,425.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.30 187.10,428.30 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.56 261.60,411.72 256.80,411.72 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.19 261.60,411.35 256.80,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,417.51 331.29,421.67 326.49,421.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.19 331.29,411.35 326.49,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.03 55.81,509.92 57.09,507.69 61.50,500.43 66.38,493.05 67.19,491.90 72.87,484.23 78.56,477.34 82.64,472.83 84.25,471.13 89.94,465.54 95.63,460.50 101.32,455.96 107.01,451.85 112.70,448.14 115.16,446.64 118.39,444.78 124.08,441.74 129.77,438.99 135.46,436.49 141.15,434.23 146.83,432.17 152.52,430.29 158.21,428.59 163.90,427.04 169.59,425.62 175.28,424.33 180.97,423.15 186.66,422.07 189.50,421.57 192.35,421.08 198.04,420.18 203.73,419.36 209.42,418.60 215.11,417.91 220.79,417.28 226.48,416.69 232.17,416.16 237.86,415.68 243.55,415.23 249.24,414.83 254.93,414.45 259.20,414.20 260.62,414.12 266.31,413.81 272.00,413.53 277.69,413.28 283.38,413.05 289.07,412.85 294.76,412.67 300.44,412.51 306.13,412.37 311.82,412.24 317.51,412.14 323.20,412.05 328.89,411.98 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='513.49' x2='54.96' y2='513.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.01' x2='52.44' y2='510.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='508.33' x2='59.61' y2='508.33' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='510.85' x2='57.09' y2='505.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='512.75' x2='59.61' y2='512.75' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='515.27' x2='57.09' y2='510.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='483.65' x2='68.90' y2='483.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='486.17' x2='66.38' y2='481.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='486.96' x2='68.90' y2='486.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='489.48' x2='66.38' y2='484.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='469.28' x2='85.16' y2='469.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='471.80' x2='82.64' y2='466.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='462.65' x2='85.16' y2='462.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='465.17' x2='82.64' y2='460.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='437.96' x2='117.68' y2='437.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='440.48' x2='115.16' y2='435.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='435.39' x2='117.68' y2='435.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='437.91' x2='115.16' y2='432.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='404.81' x2='192.02' y2='404.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='407.33' x2='189.50' y2='402.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='387.86' x2='192.02' y2='387.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='390.38' x2='189.50' y2='385.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='386.02' x2='261.72' y2='386.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='388.54' x2='259.20' y2='383.50' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.86' x2='261.72' y2='394.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.38' x2='259.20' y2='392.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='387.49' x2='331.41' y2='387.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='390.01' x2='328.89' y2='384.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='378.28' x2='331.41' y2='378.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='380.80' x2='328.89' y2='375.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.17 55.81,510.16 57.09,507.94 61.50,500.57 66.38,492.90 67.19,491.68 72.87,483.42 78.56,475.75 82.64,470.59 84.25,468.63 89.94,462.01 95.63,455.86 101.32,450.15 107.01,444.85 112.70,439.92 115.16,437.89 118.39,435.34 124.08,431.08 129.77,427.12 135.46,423.45 141.15,420.03 146.83,416.86 152.52,413.91 158.21,411.17 163.90,408.63 169.59,406.27 175.28,404.09 180.97,402.06 186.66,400.18 189.50,399.29 192.35,398.44 198.04,396.83 203.73,395.34 209.42,393.97 215.11,392.70 220.79,391.53 226.48,390.46 232.17,389.47 237.86,388.57 243.55,387.74 249.24,386.99 254.93,386.30 259.20,385.83 260.62,385.68 266.31,385.12 272.00,384.62 277.69,384.17 283.38,383.78 289.07,383.43 294.76,383.12 300.44,382.86 306.13,382.64 311.82,382.46 317.51,382.31 323.20,382.20 328.89,382.12 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.79' x2='54.22' y2='510.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='510.23' x2='54.22' y2='513.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.37' x2='54.22' y2='505.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.81' x2='54.22' y2='509.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='502.37' x2='58.87' y2='498.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='498.81' x2='58.87' y2='502.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='510.11' x2='58.87' y2='506.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.55' x2='58.87' y2='510.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='484.32' x2='68.16' y2='480.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='480.76' x2='68.16' y2='484.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='485.43' x2='68.16' y2='481.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='481.86' x2='68.16' y2='485.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='452.64' x2='84.42' y2='449.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='449.08' x2='84.42' y2='452.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='468.11' x2='84.42' y2='464.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='464.55' x2='84.42' y2='468.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.27' x2='116.95' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='413.71' x2='116.95' y2='417.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='420.22' x2='116.95' y2='416.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.66' x2='116.95' y2='420.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='374.91' x2='191.29' y2='371.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='371.34' x2='191.29' y2='374.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='368.64' x2='191.29' y2='365.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='365.08' x2='191.29' y2='368.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='360.91' x2='260.98' y2='357.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='357.34' x2='260.98' y2='360.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='354.65' x2='260.98' y2='351.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='351.08' x2='260.98' y2='354.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='357.22' x2='330.67' y2='353.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='353.66' x2='330.67' y2='357.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='347.65' x2='330.67' y2='344.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='344.08' x2='330.67' y2='347.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.87 55.81,507.07 57.09,504.20 61.50,494.72 66.38,484.90 67.19,483.35 72.87,472.87 78.56,463.22 82.64,456.77 84.25,454.32 89.94,446.11 95.63,438.54 101.32,431.55 107.01,425.11 112.70,419.15 115.16,416.72 118.39,413.66 124.08,408.58 129.77,403.89 135.46,399.55 141.15,395.55 146.83,391.85 152.52,388.43 158.21,385.27 163.90,382.35 169.59,379.65 175.28,377.16 180.97,374.86 186.66,372.74 189.50,371.74 192.35,370.78 198.04,368.98 203.73,367.32 209.42,365.79 215.11,364.38 220.79,363.10 226.48,361.92 232.17,360.84 237.86,359.85 243.55,358.96 249.24,358.14 254.93,357.40 259.20,356.90 260.62,356.74 266.31,356.14 272.00,355.61 277.69,355.14 283.38,354.72 289.07,354.36 294.76,354.05 300.44,353.79 306.13,353.57 311.82,353.39 317.51,353.25 323.20,353.15 328.89,353.08 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,515.33 52.44,512.81 54.96,515.33 52.44,517.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,512.38 52.44,509.86 54.96,512.38 52.44,514.90 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,502.07 57.09,499.55 59.61,502.07 57.09,504.59 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,500.22 57.09,497.70 59.61,500.22 57.09,502.74 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,485.12 66.38,482.60 68.90,485.12 66.38,487.64 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,482.54 66.38,480.02 68.90,482.54 66.38,485.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,457.86 82.64,455.34 85.16,457.86 82.64,460.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,465.23 82.64,462.71 85.16,465.23 82.64,467.75 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,442.75 115.16,440.23 117.68,442.75 115.16,445.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,440.91 115.16,438.39 117.68,440.91 115.16,443.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,422.86 189.50,420.34 192.02,422.86 189.50,425.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,421.75 189.50,419.23 192.02,421.75 189.50,424.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,421.02 259.20,418.50 261.72,421.02 259.20,423.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,416.60 259.20,414.08 261.72,416.60 259.20,419.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,412.54 328.89,410.02 331.41,412.54 328.89,415.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,430.96 328.89,428.44 331.41,430.96 328.89,433.48 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.92 55.81,503.28 57.09,499.97 61.50,489.89 66.38,480.73 67.19,479.39 72.87,471.08 78.56,464.43 82.64,460.46 84.25,459.04 89.94,454.62 95.63,450.93 101.32,447.81 107.01,445.14 112.70,442.81 115.16,441.89 118.39,440.76 124.08,438.93 129.77,437.27 135.46,435.77 141.15,434.38 146.83,433.10 152.52,431.90 158.21,430.79 163.90,429.74 169.59,428.76 175.28,427.83 180.97,426.96 186.66,426.14 189.50,425.74 192.35,425.36 198.04,424.63 203.73,423.94 209.42,423.28 215.11,422.67 220.79,422.09 226.48,421.55 232.17,421.04 237.86,420.56 243.55,420.12 249.24,419.70 254.93,419.31 259.20,419.04 260.62,418.95 266.31,418.62 272.00,418.32 277.69,418.04 283.38,417.78 289.07,417.55 294.76,417.34 300.44,417.16 306.13,416.99 311.82,416.85 317.51,416.72 323.20,416.62 328.89,416.53 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.94 54.84,508.78 50.04,508.78 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.20 54.84,508.05 50.04,508.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.47 59.49,507.31 54.69,507.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,519.20 59.49,515.05 54.69,515.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.63 68.78,491.47 63.98,491.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,498.94 68.78,494.79 63.98,494.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,473.15 85.04,469.00 80.24,469.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,479.79 85.04,475.63 80.24,475.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,455.10 117.56,450.95 112.76,450.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.94 117.56,452.79 112.76,452.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,444.05 191.90,439.89 187.10,439.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,440.37 191.90,436.21 187.10,436.21 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,430.79 261.60,426.63 256.80,426.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,427.84 261.60,423.68 256.80,423.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,434.47 331.29,430.32 326.49,430.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,435.95 331.29,431.79 326.49,431.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.38 55.81,510.77 57.09,508.74 61.50,502.15 66.38,495.52 67.19,494.49 72.87,487.69 78.56,481.63 82.64,477.71 84.25,476.24 89.94,471.43 95.63,467.13 101.32,463.29 107.01,459.85 112.70,456.76 115.16,455.52 118.39,453.99 124.08,451.49 129.77,449.24 135.46,447.21 141.15,445.37 146.83,443.71 152.52,442.19 158.21,440.82 163.90,439.57 169.59,438.42 175.28,437.38 180.97,436.42 186.66,435.54 189.50,435.13 192.35,434.73 198.04,433.99 203.73,433.30 209.42,432.67 215.11,432.09 220.79,431.55 226.48,431.05 232.17,430.59 237.86,430.16 243.55,429.76 249.24,429.40 254.93,429.06 259.20,428.82 260.62,428.74 266.31,428.45 272.00,428.18 277.69,427.93 283.38,427.70 289.07,427.49 294.76,427.30 300.44,427.12 306.13,426.96 311.82,426.82 317.51,426.69 323.20,426.57 328.89,426.47 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='516.00' x2='54.22' y2='512.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='512.44' x2='54.22' y2='516.00' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='508.64' x2='54.22' y2='505.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.07' x2='54.22' y2='508.64' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='492.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='495.74' x2='58.87' y2='492.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='492.18' x2='58.87' y2='495.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='499.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.48' x2='58.87' y2='499.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='499.92' x2='58.87' y2='503.48' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='468.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='472.17' x2='68.16' y2='468.60' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='468.60' x2='68.16' y2='472.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='467.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='470.69' x2='68.16' y2='467.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='467.13' x2='68.16' y2='470.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='431.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='434.96' x2='84.42' y2='431.39' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='431.39' x2='84.42' y2='434.96' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='450.55' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='454.11' x2='84.42' y2='450.55' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='450.55' x2='84.42' y2='454.11' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='400.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='404.38' x2='116.95' y2='400.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='400.82' x2='116.95' y2='404.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='405.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='409.54' x2='116.95' y2='405.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='405.97' x2='116.95' y2='409.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='389.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='393.33' x2='191.29' y2='389.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='389.76' x2='191.29' y2='393.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='387.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='390.75' x2='191.29' y2='387.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='387.18' x2='191.29' y2='390.75' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='399.22' x2='260.98' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='395.66' x2='260.98' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='377.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='380.80' x2='260.98' y2='377.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='377.24' x2='260.98' y2='380.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='399.22' x2='330.67' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='395.66' x2='330.67' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='373.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='377.49' x2='330.67' y2='373.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='373.92' x2='330.67' y2='377.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.42 55.81,501.65 57.09,497.82 61.50,485.63 66.38,473.78 67.19,471.98 72.87,460.31 78.56,450.31 82.64,444.03 84.25,441.73 89.94,434.34 95.63,427.95 101.32,422.42 107.01,417.61 112.70,413.42 115.16,411.77 118.39,409.76 124.08,406.55 129.77,403.73 135.46,401.25 141.15,399.05 146.83,397.11 152.52,395.39 158.21,393.86 163.90,392.51 169.59,391.30 175.28,390.23 180.97,389.28 186.66,388.43 189.50,388.05 192.35,387.69 198.04,387.03 203.73,386.45 209.42,385.94 215.11,385.50 220.79,385.12 226.48,384.80 232.17,384.53 237.86,384.31 243.55,384.14 249.24,384.01 254.93,383.91 259.20,383.87 260.62,383.86 266.31,383.84 272.00,383.85 277.69,383.90 283.38,383.97 289.07,384.07 294.76,384.20 300.44,384.35 306.13,384.53 311.82,384.73 317.51,384.95 323.20,385.19 328.89,385.44 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.06' x2='54.22' y2='509.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.49' x2='54.22' y2='513.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='511.28' x2='54.96' y2='511.28' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.80' x2='52.44' y2='508.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.74' x2='54.22' y2='506.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='506.18' x2='54.22' y2='509.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='507.96' x2='54.96' y2='507.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='510.48' x2='52.44' y2='505.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='493.90' x2='58.87' y2='490.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='490.34' x2='58.87' y2='493.90' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='492.12' x2='59.61' y2='492.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='494.64' x2='57.09' y2='489.60' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='488.37' x2='58.87' y2='484.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='484.81' x2='58.87' y2='488.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='486.59' x2='59.61' y2='486.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='489.11' x2='57.09' y2='484.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='459.64' x2='68.16' y2='456.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.08' x2='68.16' y2='459.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='457.86' x2='68.90' y2='457.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='460.38' x2='66.38' y2='455.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='460.38' x2='68.16' y2='456.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.81' x2='68.16' y2='460.38' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='458.59' x2='68.90' y2='458.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='461.11' x2='66.38' y2='456.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='430.54' x2='84.42' y2='426.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='426.97' x2='84.42' y2='430.54' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='428.75' x2='85.16' y2='428.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.27' x2='82.64' y2='426.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='441.22' x2='84.42' y2='437.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='437.66' x2='84.42' y2='441.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='439.44' x2='85.16' y2='439.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='441.96' x2='82.64' y2='436.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='397.01' x2='116.95' y2='393.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='393.45' x2='116.95' y2='397.01' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='395.23' x2='117.68' y2='395.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='397.75' x2='115.16' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='391.49' x2='116.95' y2='387.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='387.92' x2='116.95' y2='391.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='389.70' x2='117.68' y2='389.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='392.22' x2='115.16' y2='387.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='377.12' x2='191.29' y2='373.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='373.55' x2='191.29' y2='377.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='375.34' x2='192.02' y2='375.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='377.86' x2='189.50' y2='372.82' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='399.22' x2='191.29' y2='395.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='395.66' x2='191.29' y2='399.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='397.44' x2='192.02' y2='397.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='399.96' x2='189.50' y2='394.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='382.64' x2='260.98' y2='379.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='379.08' x2='260.98' y2='382.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='380.86' x2='261.72' y2='380.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='383.38' x2='259.20' y2='378.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='396.27' x2='260.98' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='392.71' x2='260.98' y2='396.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.49' x2='261.72' y2='394.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.01' x2='259.20' y2='391.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='374.91' x2='330.67' y2='371.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='371.34' x2='330.67' y2='374.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='373.13' x2='331.41' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='375.65' x2='328.89' y2='370.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='393.70' x2='330.67' y2='390.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='390.13' x2='330.67' y2='393.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='391.91' x2='331.41' y2='391.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='394.43' x2='328.89' y2='389.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,508.40 55.81,493.03 57.09,487.78 61.50,471.87 66.38,457.58 67.19,455.50 72.87,442.78 78.56,432.84 82.64,427.06 84.25,425.03 89.94,418.83 95.63,413.87 101.32,409.87 107.01,406.60 112.70,403.90 115.16,402.87 118.39,401.63 124.08,399.71 129.77,398.07 135.46,396.63 141.15,395.37 146.83,394.25 152.52,393.24 158.21,392.33 163.90,391.50 169.59,390.74 175.28,390.04 180.97,389.39 186.66,388.78 189.50,388.50 192.35,388.23 198.04,387.71 203.73,387.22 209.42,386.78 215.11,386.36 220.79,385.98 226.48,385.62 232.17,385.29 237.86,384.99 243.55,384.72 249.24,384.47 254.93,384.25 259.20,384.09 260.62,384.04 266.31,383.86 272.00,383.71 277.69,383.57 283.38,383.45 289.07,383.36 294.76,383.28 300.44,383.22 306.13,383.18 311.82,383.16 317.51,383.15 323.20,383.17 328.89,383.19 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='505.38' x2='54.96' y2='505.38' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='507.90' x2='52.44' y2='502.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,505.38 52.44,502.86 54.96,505.38 52.44,507.90 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='509.07' x2='54.96' y2='509.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='511.59' x2='52.44' y2='506.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,509.07 52.44,506.55 54.96,509.07 52.44,511.59 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='487.70' x2='59.61' y2='487.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='490.22' x2='57.09' y2='485.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,487.70 57.09,485.18 59.61,487.70 57.09,490.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='493.22' x2='59.61' y2='493.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='495.74' x2='57.09' y2='490.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,493.22 57.09,490.70 59.61,493.22 57.09,495.74 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='461.17' x2='68.90' y2='461.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='463.69' x2='66.38' y2='458.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,461.17 66.38,458.65 68.90,461.17 66.38,463.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='469.28' x2='68.90' y2='469.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='471.80' x2='66.38' y2='466.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,469.28 66.38,466.76 68.90,469.28 66.38,471.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.12' x2='85.16' y2='429.12' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.64' x2='82.64' y2='426.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.12 82.64,426.60 85.16,429.12 82.64,431.64 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.86' x2='85.16' y2='429.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='432.38' x2='82.64' y2='427.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.86 82.64,427.34 85.16,429.86 82.64,432.38 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='391.91' x2='117.68' y2='391.91' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='394.43' x2='115.16' y2='389.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,391.91 115.16,389.39 117.68,391.91 115.16,394.43 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='404.81' x2='117.68' y2='404.81' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='407.33' x2='115.16' y2='402.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,404.81 115.16,402.29 117.68,404.81 115.16,407.33 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='361.70' x2='192.02' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='364.22' x2='189.50' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,361.70 189.50,359.18 192.02,361.70 189.50,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='355.44' x2='192.02' y2='355.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='357.96' x2='189.50' y2='352.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,355.44 189.50,352.92 192.02,355.44 189.50,357.96 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='361.70' x2='261.72' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='364.22' x2='259.20' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,361.70 259.20,359.18 261.72,361.70 259.20,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='358.76' x2='261.72' y2='358.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='361.28' x2='259.20' y2='356.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,358.76 259.20,356.24 261.72,358.76 259.20,361.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='344.39' x2='331.41' y2='344.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='346.91' x2='328.89' y2='341.87' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,344.39 328.89,341.87 331.41,344.39 328.89,346.91 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='353.23' x2='331.41' y2='353.23' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='355.75' x2='328.89' y2='350.71' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,353.23 328.89,350.71 331.41,353.23 328.89,355.75 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,511.65 55.81,499.76 57.09,495.51 61.50,481.89 66.38,468.51 67.19,466.46 72.87,453.10 78.56,441.51 82.64,434.14 84.25,431.43 89.94,422.63 95.63,414.94 101.32,408.19 107.01,402.25 112.70,397.01 115.16,394.93 118.39,392.36 124.08,388.24 129.77,384.56 135.46,381.27 141.15,378.32 146.83,375.66 152.52,373.26 158.21,371.09 163.90,369.12 169.59,367.32 175.28,365.68 180.97,364.18 186.66,362.81 189.50,362.17 192.35,361.55 198.04,360.39 203.73,359.32 209.42,358.34 215.11,357.44 220.79,356.61 226.48,355.84 232.17,355.13 237.86,354.48 243.55,353.89 249.24,353.34 254.93,352.84 259.20,352.50 260.62,352.39 266.31,351.97 272.00,351.60 277.69,351.26 283.38,350.96 289.07,350.70 294.76,350.46 300.44,350.26 306.13,350.08 311.82,349.94 317.51,349.82 323.20,349.73 328.89,349.66 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='514.59' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='514.59' x2='54.22' y2='514.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.37' x2='52.44' y2='512.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='517.17' x2='54.22' y2='517.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='518.95' x2='52.44' y2='515.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='507.22' x2='58.87' y2='507.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='509.01' x2='57.09' y2='505.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='503.91' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.91' x2='58.87' y2='503.91' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='505.69' x2='57.09' y2='502.13' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='483.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='483.28' x2='68.16' y2='483.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='485.06' x2='66.38' y2='481.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='479.96' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='479.96' x2='68.16' y2='479.96' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='481.74' x2='66.38' y2='478.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='456.02' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='456.02' x2='84.42' y2='456.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='457.80' x2='82.64' y2='454.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='457.86' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='457.86' x2='84.42' y2='457.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='459.64' x2='82.64' y2='456.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='416.60' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.60' x2='116.95' y2='416.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='418.38' x2='115.16' y2='414.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='417.33' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.33' x2='116.95' y2='417.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='419.12' x2='115.16' y2='415.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='383.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='383.81' x2='191.29' y2='383.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='385.59' x2='189.50' y2='382.03' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='391.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='391.18' x2='191.29' y2='391.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='392.96' x2='189.50' y2='389.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='368.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='368.34' x2='260.98' y2='368.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='370.12' x2='259.20' y2='366.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='361.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='361.34' x2='260.98' y2='361.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='363.12' x2='259.20' y2='359.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='355.07' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='355.07' x2='330.67' y2='355.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='356.86' x2='328.89' y2='353.29' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='349.55' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='349.55' x2='330.67' y2='349.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='351.33' x2='328.89' y2='347.77' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.99 55.81,507.37 57.09,504.58 61.50,495.37 66.38,485.88 67.19,484.38 72.87,474.31 78.56,465.08 82.64,458.93 84.25,456.60 89.94,448.83 95.63,441.68 101.32,435.12 107.01,429.07 112.70,423.51 115.16,421.24 118.39,418.39 124.08,413.67 129.77,409.31 135.46,405.30 141.15,401.58 146.83,398.16 152.52,394.99 158.21,392.06 163.90,389.34 169.59,386.83 175.28,384.51 180.97,382.36 186.66,380.36 189.50,379.42 192.35,378.51 198.04,376.80 203.73,375.21 209.42,373.74 215.11,372.37 220.79,371.11 226.48,369.94 232.17,368.86 237.86,367.86 243.55,366.93 249.24,366.08 254.93,365.29 259.20,364.74 260.62,364.57 266.31,363.90 272.00,363.29 277.69,362.73 283.38,362.22 289.07,361.76 294.76,361.34 300.44,360.96 306.13,360.62 311.82,360.32 317.51,360.05 323.20,359.82 328.89,359.61 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,518.10 54.84,513.25 50.04,513.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.56 54.84,517.41 50.04,517.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.36 54.84,512.51 50.04,512.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,511.82 54.84,516.67 50.04,516.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,516.99 59.49,512.14 54.69,512.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,516.30 54.69,516.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,509.99 59.49,505.14 54.69,505.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,504.45 59.49,509.30 54.69,509.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,501.52 68.78,496.67 63.98,496.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.98 68.78,500.83 63.98,500.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,503.36 68.78,498.51 63.98,498.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,497.82 68.78,502.67 63.98,502.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,480.89 85.04,476.04 80.24,476.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,475.35 85.04,480.20 80.24,480.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,487.52 85.04,482.67 80.24,482.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,481.98 85.04,486.83 80.24,486.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,461.73 117.56,456.88 112.76,456.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.19 117.56,461.04 112.76,461.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,449.21 117.56,444.36 112.76,444.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,443.67 117.56,448.52 112.76,448.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.95 191.90,417.10 187.10,417.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,416.40 191.90,421.25 187.10,421.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,429.68 191.90,424.83 187.10,424.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.99 187.10,428.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,425.63 261.60,420.78 256.80,420.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.09 261.60,424.94 256.80,424.94 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,426.37 261.60,421.52 256.80,421.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.83 261.60,425.67 256.80,425.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,409.42 331.29,404.57 326.49,404.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,403.88 331.29,408.73 326.49,408.73 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,413.47 331.29,408.62 326.49,408.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.93 331.29,412.78 326.49,412.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,517.06 55.81,512.29 57.09,510.53 61.50,504.72 66.38,498.68 67.19,497.72 72.87,491.24 78.56,485.26 82.64,481.24 84.25,479.72 89.94,474.59 95.63,469.84 101.32,465.43 107.01,461.35 112.70,457.57 115.16,456.02 118.39,454.06 124.08,450.80 129.77,447.78 135.46,444.97 141.15,442.35 146.83,439.93 152.52,437.67 158.21,435.57 163.90,433.61 169.59,431.79 175.28,430.10 180.97,428.52 186.66,427.05 189.50,426.35 192.35,425.68 198.04,424.40 203.73,423.21 209.42,422.11 215.11,421.07 220.79,420.11 226.48,419.21 232.17,418.37 237.86,417.59 243.55,416.86 249.24,416.19 254.93,415.56 259.20,415.12 260.62,414.98 266.31,414.43 272.00,413.93 277.69,413.46 283.38,413.03 289.07,412.63 294.76,412.26 300.44,411.92 306.13,411.61 311.82,411.32 317.51,411.06 323.20,410.83 328.89,410.61 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='519.38' x2='54.22' y2='519.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='521.16' x2='52.44' y2='517.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='517.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='511.28' x2='54.22' y2='511.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.06' x2='52.44' y2='509.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.85' x2='58.87' y2='506.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='508.64' x2='57.09' y2='505.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.75' x2='58.87' y2='505.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='507.53' x2='57.09' y2='503.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='503.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.70' x2='68.16' y2='494.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='496.48' x2='66.38' y2='492.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='492.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='497.28' x2='68.16' y2='497.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='499.06' x2='66.38' y2='495.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='495.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.91' x2='84.42' y2='475.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='477.69' x2='82.64' y2='474.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='474.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='478.49' x2='84.42' y2='478.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='480.27' x2='82.64' y2='476.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='476.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.44' x2='116.95' y2='453.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.22' x2='115.16' y2='451.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='451.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.81' x2='116.95' y2='453.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.59' x2='115.16' y2='452.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='452.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='415.49' x2='191.29' y2='415.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='417.27' x2='189.50' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='413.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.75' x2='191.29' y2='421.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='423.54' x2='189.50' y2='419.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='419.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.86' x2='260.98' y2='401.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='403.64' x2='259.20' y2='400.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='400.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='414.39' x2='260.98' y2='414.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='416.17' x2='259.20' y2='412.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='412.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='394.12' x2='330.67' y2='394.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='395.91' x2='328.89' y2='392.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='409.23' x2='330.67' y2='409.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='411.01' x2='328.89' y2='407.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='407.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.49 55.81,510.94 57.09,508.90 61.50,502.19 66.38,495.27 67.19,494.17 72.87,486.82 78.56,480.08 82.64,475.59 84.25,473.88 89.94,468.20 95.63,462.97 101.32,458.17 107.01,453.75 112.70,449.68 115.16,448.02 118.39,445.94 124.08,442.49 129.77,439.31 135.46,436.38 141.15,433.68 146.83,431.19 152.52,428.89 158.21,426.77 163.90,424.81 169.59,423.00 175.28,421.33 180.97,419.79 186.66,418.36 189.50,417.69 192.35,417.04 198.04,415.83 203.73,414.71 209.42,413.67 215.11,412.72 220.79,411.84 226.48,411.04 232.17,410.29 237.86,409.61 243.55,408.98 249.24,408.41 254.93,407.89 259.20,407.52 260.62,407.41 266.31,406.98 272.00,406.58 277.69,406.23 283.38,405.91 289.07,405.63 294.76,405.38 300.44,405.15 306.13,404.96 311.82,404.80 317.51,404.66 323.20,404.54 328.89,404.45 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.95' x2='54.22' y2='515.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='515.39' x2='54.22' y2='518.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='520.12' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='521.90' x2='54.22' y2='518.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.34' x2='54.22' y2='521.90' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='509.01' x2='58.87' y2='505.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.44' x2='58.87' y2='509.01' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='502.07' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.85' x2='58.87' y2='500.28' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='500.28' x2='58.87' y2='503.85' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='492.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.27' x2='68.16' y2='490.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='490.71' x2='68.16' y2='494.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='496.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='498.32' x2='68.16' y2='494.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.76' x2='68.16' y2='498.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='477.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='479.53' x2='84.42' y2='475.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.97' x2='84.42' y2='479.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='472.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='474.38' x2='84.42' y2='470.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='470.81' x2='84.42' y2='474.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='443.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='445.27' x2='116.95' y2='441.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='441.71' x2='116.95' y2='445.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='451.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.38' x2='116.95' y2='449.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='449.81' x2='116.95' y2='453.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.33' x2='191.29' y2='417.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='417.76' x2='191.29' y2='421.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='406.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='408.43' x2='191.29' y2='404.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='404.87' x2='191.29' y2='408.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='421.69' x2='260.98' y2='418.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='418.13' x2='260.98' y2='421.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='400.02' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.80' x2='260.98' y2='398.24' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='398.24' x2='260.98' y2='401.80' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='405.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='407.33' x2='330.67' y2='403.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='403.76' x2='330.67' y2='407.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.33' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='405.12' x2='330.67' y2='401.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='401.55' x2='330.67' y2='405.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.04 55.81,509.92 57.09,507.68 61.50,500.35 66.38,492.86 67.19,491.69 72.87,483.83 78.56,476.71 82.64,472.01 84.25,470.24 89.94,464.37 95.63,459.03 101.32,454.17 107.01,449.75 112.70,445.72 115.16,444.09 118.39,442.06 124.08,438.71 129.77,435.65 135.46,432.87 141.15,430.32 146.83,427.99 152.52,425.86 158.21,423.91 163.90,422.13 169.59,420.50 175.28,419.01 180.97,417.64 186.66,416.39 189.50,415.80 192.35,415.24 198.04,414.20 203.73,413.24 209.42,412.37 215.11,411.57 220.79,410.84 226.48,410.18 232.17,409.58 237.86,409.04 243.55,408.55 249.24,408.10 254.93,407.71 259.20,407.44 260.62,407.35 266.31,407.04 272.00,406.76 277.69,406.52 283.38,406.31 289.07,406.13 294.76,405.98 300.44,405.86 306.13,405.76 311.82,405.69 317.51,405.64 323.20,405.61 328.89,405.61 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.44 54.22,516.00 50.66,516.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,509.86 54.22,513.43 50.66,513.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,497.34 58.87,500.90 55.30,500.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='497.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,498.81 58.87,502.37 55.30,502.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='498.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,485.18 68.16,488.74 64.60,488.74 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='485.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,471.92 68.16,475.48 64.60,475.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='471.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,446.87 84.42,450.43 80.86,450.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='446.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,451.29 84.42,454.85 80.86,454.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='451.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,431.02 116.95,434.59 113.38,434.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='431.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,421.08 116.95,424.64 113.38,424.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='421.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,397.50 191.29,401.06 187.72,401.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='397.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,386.82 191.29,390.38 187.72,390.38 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='386.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,399.34 260.98,402.91 257.42,402.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='399.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,383.87 260.98,387.43 257.42,387.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='383.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,396.03 330.67,399.59 327.11,399.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='396.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,392.34 330.67,395.91 327.11,395.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,513.77 55.81,504.72 57.09,501.48 61.50,491.10 66.38,480.88 67.19,479.31 72.87,469.08 78.56,460.19 82.64,454.53 84.25,452.44 89.94,445.68 95.63,439.76 101.32,434.57 107.01,430.00 112.70,425.96 115.16,424.36 118.39,422.40 124.08,419.23 129.77,416.41 135.46,413.89 141.15,411.64 146.83,409.62 152.52,407.80 158.21,406.16 163.90,404.67 169.59,403.32 175.28,402.10 180.97,400.99 186.66,399.98 189.50,399.50 192.35,399.05 198.04,398.21 203.73,397.44 209.42,396.73 215.11,396.09 220.79,395.50 226.48,394.97 232.17,394.48 237.86,394.04 243.55,393.64 249.24,393.28 254.93,392.95 259.20,392.73 260.62,392.67 266.31,392.41 272.00,392.18 277.69,391.98 283.38,391.82 289.07,391.67 294.76,391.56 300.44,391.46 306.13,391.40 311.82,391.35 317.51,391.32 323.20,391.32 328.89,391.33 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,513.06 54.22,513.06 54.22,509.49 50.66,509.49 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,514.90 54.22,514.90 54.22,511.34 50.66,511.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,501.64 58.87,501.64 58.87,498.07 55.30,498.07 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,499.43 58.87,499.43 58.87,495.86 55.30,495.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,486.90 68.16,486.90 68.16,483.34 64.60,483.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,472.90 68.16,472.90 68.16,469.34 64.60,469.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,462.22 84.42,462.22 84.42,458.65 80.86,458.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,455.22 84.42,455.22 84.42,451.65 80.86,451.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,427.59 116.95,427.59 116.95,424.02 113.38,424.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,428.33 116.95,428.33 116.95,424.76 113.38,424.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,400.33 191.29,400.33 191.29,396.76 187.72,396.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,399.96 191.29,399.96 191.29,396.39 187.72,396.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,390.38 260.98,390.38 260.98,386.82 257.42,386.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,396.27 260.98,396.27 260.98,392.71 257.42,392.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,383.38 330.67,383.38 330.67,379.82 327.11,379.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,402.54 330.67,402.54 330.67,398.97 327.11,398.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.96 55.81,502.98 57.09,499.45 61.50,488.29 66.38,477.56 67.19,475.93 72.87,465.51 78.56,456.68 82.64,451.18 84.25,449.18 89.94,442.78 95.63,437.29 101.32,432.57 107.01,428.49 112.70,424.94 115.16,423.54 118.39,421.83 124.08,419.10 129.77,416.68 135.46,414.54 141.15,412.62 146.83,410.89 152.52,409.33 158.21,407.91 163.90,406.61 169.59,405.43 175.28,404.33 180.97,403.32 186.66,402.39 189.50,401.95 192.35,401.52 198.04,400.71 203.73,399.96 209.42,399.26 215.11,398.60 220.79,397.98 226.48,397.41 232.17,396.87 237.86,396.36 243.55,395.89 249.24,395.45 254.93,395.03 259.20,394.74 260.62,394.65 266.31,394.29 272.00,393.96 277.69,393.65 283.38,393.37 289.07,393.11 294.76,392.87 300.44,392.65 306.13,392.45 311.82,392.27 317.51,392.12 323.20,391.98 328.89,391.86 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='527.53' x2='650.60' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='527.53' x2='410.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='470.24' y1='527.53' x2='470.24' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='530.36' y1='527.53' x2='530.36' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='590.48' y1='527.53' x2='590.48' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='650.60' y1='527.53' x2='650.60' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='465.85' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='525.97' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='586.09' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='646.21' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<line x1='398.97' y1='508.97' x2='398.97' y2='355.91' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='508.97' x2='394.21' y2='508.97' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='470.70' x2='394.21' y2='470.70' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='432.44' x2='394.21' y2='432.44' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='394.17' x2='394.21' y2='394.17' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='355.91' x2='394.21' y2='355.91' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,512.48) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,474.22) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,434.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,396.37) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,358.11) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,527.53 700.04,527.53 700.04,337.35 398.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5'>
+ <rect x='360.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text x='532.82' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text transform='translate(368.55,470.64) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='432.44' x2='700.04' y2='432.44' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='420.12' cy='437.55' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='420.12' cy='434.08' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='438.32' cy='440.85' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='438.32' cy='430.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='468.50' cy='428.88' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='468.50' cy='421.23' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='506.49' cy='436.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='506.49' cy='416.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='549.44' cy='434.71' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='549.44' cy='438.18' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='587.15' cy='446.02' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='587.15' cy='417.51' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='600.93' cy='435.65' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='600.93' cy='422.44' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='607.12' cy='453.53' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='607.12' cy='425.01' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.39,421.95 419.79,426.11 414.99,426.11 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.39,434.47 419.79,438.63 414.99,438.63 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='431.00,431.94 433.40,436.10 428.60,436.10 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='431.00,417.34 433.40,421.49 428.60,421.49 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='454.89,433.52 457.29,437.67 452.49,437.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='454.89,425.17 457.29,429.33 452.49,429.33 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='487.89,440.54 490.29,444.70 485.49,444.70 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='487.89,426.63 490.29,430.79 485.49,430.79 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='530.62,416.14 533.02,420.30 528.22,420.30 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='530.62,442.57 533.02,446.73 528.22,446.73 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.55,425.14 573.95,429.30 569.15,429.30 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.55,419.58 573.95,423.73 569.15,423.73 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='583.57,436.96 585.97,441.12 581.17,441.12 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='583.57,437.66 585.97,441.81 581.17,441.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='587.20,413.99 589.60,418.15 584.80,418.15 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='587.20,433.46 589.60,437.62 584.80,437.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.63' y1='437.51' x2='419.67' y2='437.51' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.15' y1='440.03' x2='417.15' y2='434.99' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.07' y1='431.70' x2='433.11' y2='431.70' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='430.59' y1='434.22' x2='430.59' y2='429.18' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.07' y1='423.36' x2='433.11' y2='423.36' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='430.59' y1='425.88' x2='430.59' y2='420.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.62' y1='449.90' x2='457.66' y2='449.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.14' y1='452.42' x2='455.14' y2='447.38' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.62' y1='443.64' x2='457.66' y2='443.64' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.14' y1='446.16' x2='455.14' y2='441.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='489.02' y1='434.92' x2='494.06' y2='434.92' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='491.54' y1='437.44' x2='491.54' y2='432.40' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='489.02' y1='447.43' x2='494.06' y2='447.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='491.54' y1='449.95' x2='491.54' y2='444.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='542.38' y1='432.30' x2='547.42' y2='432.30' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='544.90' y1='434.82' x2='544.90' y2='429.78' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='542.38' y1='437.17' x2='547.42' y2='437.17' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='544.90' y1='439.69' x2='544.90' y2='434.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='605.38' y1='422.03' x2='610.42' y2='422.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='607.90' y1='424.55' x2='607.90' y2='419.51' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='605.38' y1='454.02' x2='610.42' y2='454.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='607.90' y1='456.54' x2='607.90' y2='451.50' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.34' y1='432.09' x2='632.38' y2='432.09' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.86' y1='434.61' x2='629.86' y2='429.56' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='627.34' y1='415.39' x2='632.38' y2='415.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.86' y1='417.91' x2='629.86' y2='412.87' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.40' y1='422.30' x2='638.44' y2='422.30' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.92' y1='424.82' x2='635.92' y2='419.78' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.40' y1='439.69' x2='638.44' y2='439.69' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.92' y1='442.21' x2='635.92' y2='437.17' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.50' y1='439.62' x2='421.06' y2='436.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.50' y1='436.05' x2='421.06' y2='439.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.50' y1='447.96' x2='421.06' y2='444.40' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.50' y1='444.40' x2='421.06' y2='447.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='434.91' y1='441.03' x2='438.48' y2='437.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='434.91' y1='437.47' x2='438.48' y2='441.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='434.91' y1='426.43' x2='438.48' y2='422.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='434.91' y1='422.86' x2='438.48' y2='426.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.41' y1='438.67' x2='469.97' y2='435.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.41' y1='435.11' x2='469.97' y2='438.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.41' y1='436.59' x2='469.97' y2='433.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.41' y1='433.02' x2='469.97' y2='436.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.32' y1='445.37' x2='515.89' y2='441.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.32' y1='441.81' x2='515.89' y2='445.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.32' y1='416.16' x2='515.89' y2='412.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.32' y1='412.60' x2='515.89' y2='416.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.68' y1='436.54' x2='581.24' y2='432.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.68' y1='432.97' x2='581.24' y2='436.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.68' y1='430.97' x2='581.24' y2='427.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.68' y1='427.41' x2='581.24' y2='430.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='651.08' y1='431.60' x2='654.65' y2='428.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='651.08' y1='428.04' x2='654.65' y2='431.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='651.08' y1='443.42' x2='654.65' y2='439.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='651.08' y1='439.86' x2='654.65' y2='443.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.30' y1='430.02' x2='678.86' y2='426.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.30' y1='426.45' x2='678.86' y2='430.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.30' y1='441.84' x2='678.86' y2='438.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.30' y1='438.28' x2='678.86' y2='441.84' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.52' y1='429.77' x2='685.09' y2='426.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.52' y1='426.20' x2='685.09' y2='429.77' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.52' y1='447.85' x2='685.09' y2='444.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.52' y1='444.28' x2='685.09' y2='447.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='419.94,427.90 422.46,425.38 424.98,427.90 422.46,430.42 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='419.94,433.46 422.46,430.94 424.98,433.46 422.46,435.98 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.08,428.48 443.60,425.96 446.12,428.48 443.60,431.00 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.08,431.95 443.60,429.43 446.12,431.95 443.60,434.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='472.47,424.16 474.99,421.64 477.51,424.16 474.99,426.68 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='472.47,429.02 474.99,426.50 477.51,429.02 474.99,431.55 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='505.56,437.35 508.08,434.83 510.60,437.35 508.08,439.87 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='505.56,423.44 508.08,420.92 510.60,423.44 508.08,425.96 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='535.85,430.82 538.37,428.30 540.89,430.82 538.37,433.34 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='535.85,434.30 538.37,431.78 540.89,434.30 538.37,436.82 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='562.21,437.88 564.73,435.36 567.25,437.88 564.73,440.41 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='562.21,439.97 564.73,437.45 567.25,439.97 564.73,442.49 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='573.15,428.71 575.67,426.19 578.19,428.71 575.67,431.23 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='573.15,437.05 575.67,434.53 578.19,437.05 575.67,439.57 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='577.24,439.97 579.76,437.45 582.28,439.97 579.76,442.49 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='577.24,405.19 579.76,402.67 582.28,405.19 579.76,407.71 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.83,446.92 419.22,442.77 414.43,442.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='416.83,448.31 419.22,444.16 414.43,444.16 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.29,435.28 431.69,431.13 426.89,431.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.29,420.68 431.69,416.52 426.89,416.52 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='450.86,440.24 453.26,436.08 448.46,436.08 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='450.86,433.98 453.26,429.83 448.46,429.83 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='479.93,449.03 482.33,444.88 477.53,444.88 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='479.93,436.52 482.33,432.36 477.53,432.36 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='516.13,441.24 518.53,437.08 513.73,437.08 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='516.13,437.76 518.53,433.60 513.73,433.60 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='549.42,423.59 551.82,419.44 547.02,419.44 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='549.42,430.55 551.82,426.39 547.02,426.39 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='559.71,436.72 562.11,432.56 557.31,432.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='559.71,442.28 562.11,438.13 557.31,438.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.55,425.33 565.95,421.17 561.15,421.17 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.55,422.55 565.95,418.39 561.15,418.39 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.49' y='427.26' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.49' y1='430.82' x2='425.06' y2='427.26' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.49' y1='427.26' x2='425.06' y2='430.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.49' y='441.17' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.49' y1='444.73' x2='425.06' y2='441.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.49' y1='441.17' x2='425.06' y2='444.73' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='445.33' y='437.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.33' y1='441.50' x2='448.89' y2='437.94' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.33' y1='437.94' x2='448.89' y2='441.50' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='445.33' y='423.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.33' y1='426.90' x2='448.89' y2='423.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='445.33' y1='423.33' x2='448.89' y2='426.90' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='484.55' y='437.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.55' y1='440.64' x2='488.12' y2='437.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.55' y1='437.07' x2='488.12' y2='440.64' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='484.55' y='439.85' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.55' y1='443.42' x2='488.12' y2='439.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.55' y1='439.85' x2='488.12' y2='443.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='533.10' y='451.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.10' y1='454.72' x2='536.67' y2='451.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.10' y1='451.15' x2='536.67' y2='454.72' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='533.10' y='414.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.10' y1='418.55' x2='536.67' y2='414.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.10' y1='414.99' x2='536.67' y2='418.55' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='585.75' y='447.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='585.75' y1='451.54' x2='589.31' y2='447.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='585.75' y1='447.98' x2='589.31' y2='451.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='585.75' y='438.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='585.75' y1='441.81' x2='589.31' y2='438.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='585.75' y1='438.24' x2='589.31' y2='441.81' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='624.46' y='424.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='624.46' y1='427.62' x2='628.03' y2='424.05' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='624.46' y1='424.05' x2='628.03' y2='427.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='624.46' y='428.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='624.46' y1='432.49' x2='628.03' y2='428.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='624.46' y1='428.92' x2='628.03' y2='432.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='631.28' y='405.04' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.28' y1='408.60' x2='634.85' y2='405.04' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.28' y1='405.04' x2='634.85' y2='408.60' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='631.28' y='439.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.28' y1='443.38' x2='634.85' y2='439.81' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.28' y1='439.81' x2='634.85' y2='443.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='628.71' y='408.01' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.71' y1='411.58' x2='632.28' y2='408.01' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.71' y1='408.01' x2='632.28' y2='411.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='628.71' y='449.04' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.71' y1='452.61' x2='632.28' y2='449.04' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='628.71' y1='449.04' x2='632.28' y2='452.61' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.06' y1='428.79' x2='431.63' y2='425.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.06' y1='425.22' x2='431.63' y2='428.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.32' y1='427.01' x2='432.36' y2='427.01' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.84' y1='429.53' x2='429.84' y2='424.49' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.06' y1='435.05' x2='431.63' y2='431.48' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.06' y1='431.48' x2='431.63' y2='435.05' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.32' y1='433.27' x2='432.36' y2='433.27' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.84' y1='435.79' x2='429.84' y2='430.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.71' y1='426.03' x2='465.27' y2='422.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.71' y1='422.46' x2='465.27' y2='426.03' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='460.97' y1='424.25' x2='466.01' y2='424.25' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.49' y1='426.77' x2='463.49' y2='421.73' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.71' y1='436.46' x2='465.27' y2='432.90' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='461.71' y1='432.90' x2='465.27' y2='436.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='460.97' y1='434.68' x2='466.01' y2='434.68' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.49' y1='437.20' x2='463.49' y2='432.16' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.00' y1='433.69' x2='514.56' y2='430.13' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.00' y1='430.13' x2='514.56' y2='433.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.26' y1='431.91' x2='515.30' y2='431.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.78' y1='434.43' x2='512.78' y2='429.39' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.00' y1='432.30' x2='514.56' y2='428.74' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='511.00' y1='428.74' x2='514.56' y2='432.30' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.26' y1='430.52' x2='515.30' y2='430.52' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.78' y1='433.04' x2='512.78' y2='428.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='560.80' y1='431.02' x2='564.37' y2='427.45' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='560.80' y1='427.45' x2='564.37' y2='431.02' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='560.07' y1='429.24' x2='565.11' y2='429.24' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='562.59' y1='431.76' x2='562.59' y2='426.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='560.80' y1='410.85' x2='564.37' y2='407.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='560.80' y1='407.29' x2='564.37' y2='410.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='560.07' y1='409.07' x2='565.11' y2='409.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='562.59' y1='411.59' x2='562.59' y2='406.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.28' y1='448.64' x2='603.84' y2='445.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.28' y1='445.07' x2='603.84' y2='448.64' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.54' y1='446.86' x2='604.58' y2='446.86' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.06' y1='449.38' x2='602.06' y2='444.34' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.28' y1='459.07' x2='603.84' y2='455.51' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.28' y1='455.51' x2='603.84' y2='459.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.54' y1='457.29' x2='604.58' y2='457.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.06' y1='459.81' x2='602.06' y2='454.77' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='623.73' y1='459.07' x2='627.29' y2='455.51' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='623.73' y1='455.51' x2='627.29' y2='459.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='622.99' y1='457.29' x2='628.03' y2='457.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='625.51' y1='459.81' x2='625.51' y2='454.77' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='623.73' y1='417.34' x2='627.29' y2='413.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='623.73' y1='413.78' x2='627.29' y2='417.34' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='622.99' y1='415.56' x2='628.03' y2='415.56' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='625.51' y1='418.08' x2='625.51' y2='413.04' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.92' y1='440.32' x2='634.48' y2='436.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.92' y1='436.75' x2='634.48' y2='440.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.18' y1='438.54' x2='635.22' y2='438.54' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.70' y1='441.06' x2='632.70' y2='436.02' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.92' y1='414.59' x2='634.48' y2='411.02' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.92' y1='411.02' x2='634.48' y2='414.59' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.18' y1='412.80' x2='635.22' y2='412.80' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.70' y1='415.32' x2='632.70' y2='410.28' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.39' y1='453.22' x2='635.95' y2='449.66' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.39' y1='449.66' x2='635.95' y2='453.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.65' y1='451.44' x2='636.69' y2='451.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='634.17' y1='453.96' x2='634.17' y2='448.92' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.39' y1='417.76' x2='635.95' y2='414.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='632.39' y1='414.19' x2='635.95' y2='417.76' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.65' y1='415.97' x2='636.69' y2='415.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='634.17' y1='418.49' x2='634.17' y2='413.45' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='422.02' y1='444.27' x2='427.06' y2='444.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='424.54' y1='446.79' x2='424.54' y2='441.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='422.02,444.27 424.54,441.75 427.06,444.27 424.54,446.79 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='422.02' y1='437.31' x2='427.06' y2='437.31' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='424.54' y1='439.83' x2='424.54' y2='434.79' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='422.02,437.31 424.54,434.79 427.06,437.31 424.54,439.83 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='448.36' y1='447.18' x2='453.40' y2='447.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='450.88' y1='449.70' x2='450.88' y2='444.66' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='448.36,447.18 450.88,444.66 453.40,447.18 450.88,449.70 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='448.36' y1='436.75' x2='453.40' y2='436.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='450.88' y1='439.27' x2='450.88' y2='434.23' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='448.36,436.75 450.88,434.23 453.40,436.75 450.88,439.27 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='492.41' y1='446.30' x2='497.45' y2='446.30' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='494.93' y1='448.82' x2='494.93' y2='443.78' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='492.41,446.30 494.93,443.78 497.45,446.30 494.93,448.82 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='492.41' y1='431.00' x2='497.45' y2='431.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='494.93' y1='433.52' x2='494.93' y2='428.48' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='492.41,431.00 494.93,428.48 497.45,431.00 494.93,433.52 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='548.50' y1='441.92' x2='553.54' y2='441.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='551.02' y1='444.44' x2='551.02' y2='439.40' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='548.50,441.92 551.02,439.40 553.54,441.92 551.02,444.44 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='548.50' y1='440.53' x2='553.54' y2='440.53' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='551.02' y1='443.05' x2='551.02' y2='438.01' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='548.50,440.53 551.02,438.01 553.54,440.53 551.02,443.05 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='612.50' y1='438.12' x2='617.54' y2='438.12' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='615.02' y1='440.64' x2='615.02' y2='435.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.50,438.12 615.02,435.60 617.54,438.12 615.02,440.64 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='612.50' y1='413.78' x2='617.54' y2='413.78' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='615.02' y1='416.30' x2='615.02' y2='411.26' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.50,413.78 615.02,411.26 617.54,413.78 615.02,416.30 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='665.96' y1='433.31' x2='671.00' y2='433.31' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='668.48' y1='435.83' x2='668.48' y2='430.79' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='665.96,433.31 668.48,430.79 671.00,433.31 668.48,435.83 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='665.96' y1='445.13' x2='671.00' y2='445.13' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='668.48' y1='447.65' x2='668.48' y2='442.61' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='665.96,445.13 668.48,442.61 671.00,445.13 668.48,447.65 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.74' y1='415.06' x2='686.78' y2='415.06' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='684.26' y1='417.58' x2='684.26' y2='412.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='681.74,415.06 684.26,412.54 686.78,415.06 684.26,417.58 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='681.74' y1='420.62' x2='686.78' y2='420.62' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='684.26' y1='423.14' x2='684.26' y2='418.10' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='681.74,420.62 684.26,418.10 686.78,420.62 684.26,423.14 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.37' y1='442.39' x2='691.41' y2='442.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='688.89' y1='444.91' x2='688.89' y2='439.87' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='686.37,442.39 688.89,439.87 691.41,442.39 688.89,444.91 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.37' y1='425.70' x2='691.41' y2='425.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='688.89' y1='428.22' x2='688.89' y2='423.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='686.37,425.70 688.89,423.18 691.41,425.70 688.89,428.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.09' cy='433.19' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.31' y1='433.19' x2='420.87' y2='433.19' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.09' y1='434.97' x2='419.09' y2='431.41' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.09' cy='428.32' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.31' y1='428.32' x2='420.87' y2='428.32' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.09' y1='430.10' x2='419.09' y2='426.54' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='436.08' cy='427.44' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='434.30' y1='427.44' x2='437.86' y2='427.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='436.08' y1='429.23' x2='436.08' y2='425.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='436.08' cy='433.70' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='434.30' y1='433.70' x2='437.86' y2='433.70' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='436.08' y1='435.48' x2='436.08' y2='431.92' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='466.59' cy='437.35' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='464.81' y1='437.35' x2='468.38' y2='437.35' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.59' y1='439.13' x2='466.59' y2='435.57' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='466.59' cy='443.61' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='464.81' y1='443.61' x2='468.38' y2='443.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.59' y1='445.39' x2='466.59' y2='441.82' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='510.57' cy='437.94' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='508.79' y1='437.94' x2='512.35' y2='437.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.57' y1='439.72' x2='510.57' y2='436.16' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='510.57' cy='434.47' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='508.79' y1='434.47' x2='512.35' y2='434.47' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='510.57' y1='436.25' x2='510.57' y2='432.68' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='572.08' cy='441.20' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='570.30' y1='441.20' x2='573.86' y2='441.20' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='572.08' y1='442.99' x2='572.08' y2='439.42' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='572.08' cy='439.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='570.30' y1='439.81' x2='573.86' y2='439.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='572.08' y1='441.60' x2='572.08' y2='438.03' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='640.33' cy='424.15' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.55' y1='424.15' x2='642.11' y2='424.15' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='640.33' y1='425.93' x2='640.33' y2='422.37' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='640.33' cy='410.24' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.55' y1='410.24' x2='642.11' y2='410.24' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='640.33' y1='412.02' x2='640.33' y2='408.46' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='664.28' cy='425.65' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='662.50' y1='425.65' x2='666.06' y2='425.65' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='664.28' y1='427.43' x2='664.28' y2='423.87' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='664.28' cy='438.86' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='662.50' y1='438.86' x2='666.06' y2='438.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='664.28' y1='440.65' x2='664.28' y2='437.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='672.65' cy='441.01' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='670.87' y1='441.01' x2='674.43' y2='441.01' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='672.65' y1='442.79' x2='672.65' y2='439.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='672.65' cy='451.44' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='670.87' y1='451.44' x2='674.43' y2='451.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='672.65' y1='453.22' x2='672.65' y2='449.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.71,438.48 418.11,433.63 413.31,433.63 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.71,432.94 418.11,437.79 413.31,437.79 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.71,439.87 418.11,435.02 413.31,435.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.71,434.33 418.11,439.18 413.31,439.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='426.36,428.24 428.76,423.39 423.96,423.39 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='426.36,422.70 428.76,427.55 423.96,427.55 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='426.36,441.46 428.76,436.61 423.96,436.61 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='426.36,435.91 428.76,440.76 423.96,440.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='445.71,435.07 448.11,430.22 443.31,430.22 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='445.71,429.53 448.11,434.38 443.31,434.38 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='445.71,431.59 448.11,426.74 443.31,426.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='445.71,426.05 448.11,430.90 443.31,430.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='474.16,441.11 476.56,436.26 471.76,436.26 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='474.16,435.56 476.56,440.41 471.76,440.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='474.16,428.59 476.56,423.74 471.76,423.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='474.16,423.04 476.56,427.89 471.76,427.89 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='515.33,429.65 517.73,424.80 512.93,424.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='515.33,424.10 517.73,428.95 512.93,428.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='515.33,453.29 517.73,448.44 512.93,448.44 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='515.33,447.75 517.73,452.60 512.93,452.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.73,448.76 566.13,443.91 561.33,443.91 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.73,443.22 566.13,448.07 561.33,448.07 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.73,434.16 566.13,429.31 561.33,429.31 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.73,428.62 566.13,433.46 561.33,433.46 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='582.07,420.59 584.47,415.74 579.67,415.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='582.07,415.05 584.47,419.90 579.67,419.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='582.07,419.20 584.47,414.35 579.67,414.35 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='582.07,413.66 584.47,418.51 579.67,418.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='589.42,442.69 591.82,437.84 587.02,437.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='589.42,437.15 591.82,442.00 587.02,442.00 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='589.42,435.04 591.82,430.19 587.02,430.19 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='589.42,429.50 591.82,434.35 587.02,434.35 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.86' y1='426.97' x2='418.43' y2='426.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.65' y1='428.76' x2='416.65' y2='425.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='414.86' y='425.19' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.86' y1='442.27' x2='418.43' y2='442.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.65' y1='444.06' x2='416.65' y2='440.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='414.86' y='440.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.24' y1='436.30' x2='430.80' y2='436.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.02' y1='438.09' x2='429.02' y2='434.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='427.24' y='434.52' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.24' y1='438.39' x2='430.80' y2='438.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.02' y1='440.17' x2='429.02' y2='436.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='427.24' y='436.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='449.49' y1='433.52' x2='453.05' y2='433.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.27' y1='435.30' x2='451.27' y2='431.73' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='449.49' y='431.73' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='449.49' y1='428.65' x2='453.05' y2='428.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.27' y1='430.43' x2='451.27' y2='426.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='449.49' y='426.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='481.61' y1='431.83' x2='485.17' y2='431.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='483.39' y1='433.61' x2='483.39' y2='430.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='481.61' y='430.04' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='481.61' y1='426.96' x2='485.17' y2='426.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='483.39' y1='428.74' x2='483.39' y2='425.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='481.61' y='425.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='526.59' y1='422.21' x2='530.16' y2='422.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='528.38' y1='424.00' x2='528.38' y2='420.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='526.59' y='420.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='526.59' y1='421.52' x2='530.16' y2='421.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='528.38' y1='423.30' x2='528.38' y2='419.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='526.59' y='419.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='576.09' y1='436.59' x2='579.66' y2='436.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.87' y1='438.37' x2='577.87' y2='434.80' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='576.09' y='434.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='576.09' y1='424.76' x2='579.66' y2='424.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.87' y1='426.55' x2='577.87' y2='422.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='576.09' y='422.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.68' y1='443.13' x2='596.24' y2='443.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='594.46' y1='444.91' x2='594.46' y2='441.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='592.68' y='441.35' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.68' y1='419.48' x2='596.24' y2='419.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='594.46' y1='421.27' x2='594.46' y2='417.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='592.68' y='417.70' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.70' y1='451.93' x2='601.26' y2='451.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.48' y1='453.71' x2='599.48' y2='450.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='597.70' y='450.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.70' y1='423.41' x2='601.26' y2='423.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.48' y1='425.20' x2='599.48' y2='421.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='597.70' y='421.63' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='417.37' cy='430.31' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.59' y1='432.09' x2='419.15' y2='428.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.59' y1='428.53' x2='419.15' y2='432.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='417.37' cy='424.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.59' y1='426.53' x2='419.15' y2='422.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.59' y1='422.96' x2='419.15' y2='426.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='431.01' cy='433.30' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.23' y1='435.09' x2='432.79' y2='431.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.23' y1='431.52' x2='432.79' y2='435.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='431.01' cy='443.04' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.23' y1='444.82' x2='432.79' y2='441.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.23' y1='441.26' x2='432.79' y2='444.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='455.19' cy='433.15' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='453.41' y1='434.93' x2='456.98' y2='431.37' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='453.41' y1='431.37' x2='456.98' y2='434.93' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='455.19' cy='425.50' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='453.41' y1='427.28' x2='456.98' y2='423.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='453.41' y1='423.72' x2='456.98' y2='427.28' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='489.23' cy='421.60' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.44' y1='423.38' x2='491.01' y2='419.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.44' y1='419.82' x2='491.01' y2='423.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='489.23' cy='431.34' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.44' y1='433.12' x2='491.01' y2='429.56' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.44' y1='429.56' x2='491.01' y2='433.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='534.79' cy='433.58' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.00' y1='435.36' x2='536.57' y2='431.79' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.00' y1='431.79' x2='536.57' y2='435.36' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='534.79' cy='418.28' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.00' y1='420.06' x2='536.57' y2='416.49' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='533.00' y1='416.49' x2='536.57' y2='420.06' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='580.95' cy='425.38' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='579.17' y1='427.16' x2='582.73' y2='423.60' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='579.17' y1='423.60' x2='582.73' y2='427.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='580.95' cy='449.72' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='579.17' y1='451.50' x2='582.73' y2='447.94' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='579.17' y1='447.94' x2='582.73' y2='451.50' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='594.60' cy='408.89' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.82' y1='410.67' x2='596.39' y2='407.11' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.82' y1='407.11' x2='596.39' y2='410.67' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='594.60' cy='446.44' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.82' y1='448.23' x2='596.39' y2='444.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='592.82' y1='444.66' x2='596.39' y2='448.23' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='597.59' cy='432.55' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='595.81' y1='434.33' x2='599.38' y2='430.77' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='595.81' y1='430.77' x2='599.38' y2='434.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='597.59' cy='436.72' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='595.81' y1='438.51' x2='599.38' y2='434.94' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='595.81' y1='434.94' x2='599.38' y2='438.51' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.08,429.80 422.86,433.36 419.30,433.36 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='419.30' y='429.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.08,434.66 422.86,438.23 419.30,438.23 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='419.30' y='434.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.13,435.12 442.91,438.68 439.35,438.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='439.35' y='435.12' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='441.13,432.33 442.91,435.90 439.35,435.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='439.35' y='432.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='474.76,419.17 476.54,422.73 472.98,422.73 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='472.98' y='419.17' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='474.76,444.20 476.54,447.77 472.98,447.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='472.98' y='444.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='517.75,441.76 519.53,445.33 515.97,445.33 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='515.97' y='441.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='517.75,433.42 519.53,436.98 515.97,436.98 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='515.97' y='433.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='566.98,414.72 568.76,418.28 565.20,418.28 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='565.20' y='414.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='566.98,433.50 568.76,437.06 565.20,437.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='565.20' y='433.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='607.55,431.07 609.33,434.64 605.77,434.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='605.77' y='431.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='607.55,451.24 609.33,454.81 605.77,454.81 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='605.77' y='451.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.60,414.82 620.38,418.38 616.82,418.38 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='616.82' y='414.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.60,444.03 620.38,447.59 616.82,447.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='616.82' y='444.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='620.89,418.43 622.67,422.00 619.10,422.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='619.10' y='418.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='620.89,425.39 622.67,428.95 619.10,428.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='619.10' y='425.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='420.61,437.40 424.18,437.40 424.18,433.84 420.61,433.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='420.61,433.93 424.18,433.93 424.18,430.36 420.61,430.36 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='442.67,433.45 446.23,433.45 446.23,429.89 442.67,429.89 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='442.67,437.62 446.23,437.62 446.23,434.06 442.67,434.06 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='478.39,419.95 481.95,419.95 481.95,416.38 478.39,416.38 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='478.39,446.37 481.95,446.37 481.95,442.81 478.39,442.81 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='521.44,416.75 525.00,416.75 525.00,413.18 521.44,413.18 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='521.44,429.96 525.00,429.96 525.00,426.40 521.44,426.40 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='566.54,429.94 570.11,429.94 570.11,426.38 566.54,426.38 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='566.54,428.55 570.11,428.55 570.11,424.99 566.54,424.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='601.78,440.64 605.34,440.64 605.34,437.08 601.78,437.08 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='601.78,441.34 605.34,441.34 605.34,437.78 601.78,437.78 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='613.54,445.82 617.10,445.82 617.10,442.25 613.54,442.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='613.54,434.69 617.10,434.69 617.10,431.13 613.54,431.13 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.25,453.58 621.81,453.58 621.81,450.02 618.25,450.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.25,417.42 621.81,417.42 621.81,413.86 618.25,413.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+</svg>
diff --git a/tests/figs/plotting/mixed-model-fit-for-saem-object-with-saemix-transformations.svg b/tests/figs/plotting/mixed-model-fit-for-saem-object-with-saemix-transformations.svg
new file mode 100644
index 00000000..40320ec8
--- /dev/null
+++ b/tests/figs/plotting/mixed-model-fit-for-saem-object-with-saemix-transformations.svg
@@ -0,0 +1,2482 @@
+<?xml version='1.0' encoding='UTF-8' ?>
+<svg xmlns='http://www.w3.org/2000/svg' xmlns:xlink='http://www.w3.org/1999/xlink' viewBox='0 0 720.00 576.00'>
+<defs>
+ <style type='text/css'><![CDATA[
+ line, polyline, polygon, path, rect, circle {
+ fill: none;
+ stroke: #000000;
+ stroke-linecap: round;
+ stroke-linejoin: round;
+ stroke-miterlimit: 10.00;
+ }
+ ]]></style>
+</defs>
+<rect width='100%' height='100%' style='stroke: none; fill: #FFFFFF;'/>
+<defs>
+ <clipPath id='cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA='>
+ <rect x='19.96' y='5.70' width='680.08' height='75.63' />
+ </clipPath>
+</defs>
+<line x1='238.69' y1='29.26' x2='252.94' y2='29.26' style='stroke-width: 1.50;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='38.77' x2='252.94' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='48.27' x2='252.94' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='238.69' y1='57.77' x2='252.94' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='29.26' x2='313.78' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='38.77' x2='313.78' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='48.27' x2='313.78' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='299.52' y1='57.77' x2='313.78' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='29.26' x2='374.61' y2='29.26' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='38.77' x2='374.61' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='48.27' x2='374.61' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='360.36' y1='57.77' x2='374.61' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='29.26' x2='435.45' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='38.77' x2='435.45' y2='38.77' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='48.27' x2='435.45' y2='48.27' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='421.19' y1='57.77' x2='435.45' y2='57.77' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='245.81' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='245.81,45.50 248.21,49.66 243.41,49.66 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='243.29' y1='57.77' x2='248.33' y2='57.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='245.81' y1='60.29' x2='245.81' y2='55.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='31.04' x2='308.43' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='27.48' x2='308.43' y2='31.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='304.13,38.77 306.65,36.25 309.17,38.77 306.65,41.29 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='306.65,51.04 309.05,46.89 304.25,46.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='304.87' y='55.99' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='59.56' x2='308.43' y2='55.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='304.87' y1='55.99' x2='308.43' y2='59.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='31.04' x2='369.27' y2='27.48' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='27.48' x2='369.27' y2='31.04' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='29.26' x2='370.00' y2='29.26' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='31.78' x2='367.48' y2='26.74' style='stroke-width: 0.75;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='364.96' y1='38.77' x2='370.00' y2='38.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='41.29' x2='367.48' y2='36.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='364.96,38.77 367.48,36.25 370.00,38.77 367.48,41.29 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='367.48' cy='48.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='365.70' y1='48.27' x2='369.27' y2='48.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='367.48' y1='50.05' x2='367.48' y2='46.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,60.55 369.88,55.70 365.08,55.70 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='367.48,55.00 369.88,59.85 365.08,59.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='29.26' x2='430.10' y2='29.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='428.32' y1='31.04' x2='428.32' y2='27.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='27.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<circle cx='428.32' cy='38.77' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='40.55' x2='430.10' y2='36.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<line x1='426.54' y1='36.98' x2='430.10' y2='40.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='428.32,46.49 430.10,50.05 426.54,50.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<rect x='426.54' y='46.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<polygon points='426.54,59.56 430.10,59.56 430.10,55.99 426.54,55.99 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)' />
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='37.31px' lengthAdjust='spacingAndGlyphs'>Population</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>1</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='260.07' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>3</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>5</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>6</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='320.91' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>7</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>8</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>9</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='381.74' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.19px' lengthAdjust='spacingAndGlyphs'>11</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='31.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>12</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='41.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>13</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='50.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>14</text></g>
+<g clip-path='url(#cpMTkuOTZ8NzAwLjA0fDgxLjM0fDUuNzA=)'><text x='442.58' y='60.49' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>15</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<polyline points='50.12,124.87 52.44,129.15 55.81,135.09 57.09,137.28 61.50,144.53 66.38,152.04 67.19,153.23 72.87,161.28 78.56,168.71 82.64,173.70 84.25,175.59 89.94,181.96 95.63,187.87 101.32,193.35 107.01,198.44 112.70,203.17 115.16,205.11 118.39,207.57 124.08,211.66 129.77,215.48 135.46,219.04 141.15,222.36 146.83,225.47 152.52,228.38 158.21,231.10 163.90,233.65 169.59,236.04 175.28,238.28 180.97,240.39 186.66,242.38 189.50,243.33 192.35,244.25 198.04,246.01 203.73,247.67 209.42,249.24 215.11,250.72 220.79,252.12 226.48,253.44 232.17,254.70 237.86,255.88 243.55,257.01 249.24,258.08 254.93,259.09 259.20,259.82 260.62,260.06 266.31,260.98 272.00,261.85 277.69,262.68 283.38,263.47 289.07,264.23 294.76,264.95 300.44,265.63 306.13,266.29 311.82,266.91 317.51,267.51 323.20,268.08 328.89,268.63 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='288.88' x2='328.89' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='288.88' x2='50.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='288.88' x2='96.58' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='288.88' x2='143.04' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='288.88' x2='189.50' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='288.88' x2='235.97' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='288.88' x2='282.43' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='288.88' x2='328.89' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='281.96' x2='38.97' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='281.96' x2='34.21' y2='281.96' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='250.60' x2='34.21' y2='250.60' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='219.24' x2='34.21' y2='219.24' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='187.88' x2='34.21' y2='187.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='156.51' x2='34.21' y2='156.51' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='125.15' x2='34.21' y2='125.15' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,284.16) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,254.99) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,223.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,192.27) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,160.90) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,131.74) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<polygon points='38.97,288.88 340.04,288.88 340.04,102.24 38.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5'>
+ <rect x='0.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text x='180.87' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8MzE3LjM5fDgyLjI5)'><text transform='translate(8.55,206.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='22.41px' lengthAdjust='spacingAndGlyphs'>parent</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ='>
+ <rect x='38.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<circle cx='50.12' cy='117.47' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='130.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='129.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='142.40' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='156.51' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='131.42' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='160.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='166.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='174.55' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='183.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='203.87' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='200.58' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.16' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='231.00' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='246.99' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='247.46' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='253.27' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='254.68' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.71 52.44,132.14 55.81,139.46 57.09,142.07 61.50,150.47 66.38,158.74 67.19,160.01 72.87,168.31 78.56,175.55 82.64,180.18 84.25,181.90 89.94,187.49 95.63,192.44 101.32,196.84 107.01,200.77 112.70,204.30 115.16,205.72 118.39,207.49 124.08,210.38 129.77,213.03 135.46,215.46 141.15,217.70 146.83,219.78 152.52,221.72 158.21,223.53 163.90,225.24 169.59,226.85 175.28,228.38 180.97,229.83 186.66,231.22 189.50,231.89 192.35,232.55 198.04,233.82 203.73,235.04 209.42,236.22 215.11,237.35 220.79,238.45 226.48,239.51 232.17,240.54 237.86,241.54 243.55,242.51 249.24,243.45 254.93,244.37 259.20,245.04 260.62,245.26 266.31,246.13 272.00,246.97 277.69,247.79 283.38,248.60 289.07,249.38 294.76,250.14 300.44,250.89 306.13,251.61 311.82,252.32 317.51,253.01 323.20,253.68 328.89,254.34 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,120.34 52.52,124.50 47.72,124.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.01 52.52,127.16 47.72,127.16 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,130.38 54.84,134.53 50.04,134.53 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,128.65 54.84,132.81 50.04,132.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.43 59.49,141.59 54.69,141.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.51 59.49,145.67 54.69,145.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,141.67 68.78,145.82 63.98,145.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.23 68.78,155.39 63.98,155.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,169.27 85.04,173.42 80.24,173.42 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,161.43 85.04,165.58 80.24,165.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,202.51 117.56,206.67 112.76,206.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,205.49 117.56,209.65 112.76,209.65 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,232.46 191.90,236.62 187.10,236.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.23 191.90,232.39 187.10,232.39 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.42 261.60,242.58 256.80,242.58 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.46 261.60,244.62 256.80,244.62 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,248.46 331.29,252.61 326.49,252.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.44 331.29,255.59 326.49,255.59 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.50 52.44,129.92 55.81,135.99 57.09,138.21 61.50,145.46 66.38,152.85 67.19,154.01 72.87,161.74 78.56,168.75 82.64,173.36 84.25,175.10 89.94,180.88 95.63,186.13 101.32,190.92 107.01,195.29 112.70,199.29 115.16,200.92 118.39,202.95 124.08,206.32 129.77,209.42 135.46,212.28 141.15,214.93 146.83,217.38 152.52,219.65 158.21,221.77 163.90,223.75 169.59,225.60 175.28,227.33 180.97,228.96 186.66,230.50 189.50,231.23 192.35,231.95 198.04,233.32 203.73,234.62 209.42,235.86 215.11,237.03 220.79,238.16 226.48,239.23 232.17,240.26 237.86,241.24 243.55,242.19 249.24,243.10 254.93,243.98 259.20,244.62 260.62,244.83 266.31,245.65 272.00,246.44 277.69,247.20 283.38,247.95 289.07,248.67 294.76,249.37 300.44,250.05 306.13,250.71 311.82,251.36 317.51,251.98 323.20,252.60 328.89,253.19 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='141.15' x2='52.64' y2='141.15' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='143.67' x2='50.12' y2='138.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='127.97' x2='52.64' y2='127.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='130.49' x2='50.12' y2='125.45' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='126.25' x2='54.96' y2='126.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='128.77' x2='52.44' y2='123.73' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='129.86' x2='59.61' y2='129.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='132.38' x2='57.09' y2='127.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.68' x2='59.61' y2='140.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.20' x2='57.09' y2='138.16' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='150.55' x2='68.90' y2='150.55' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='153.07' x2='66.38' y2='148.03' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='152.12' x2='68.90' y2='152.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='154.64' x2='66.38' y2='149.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='164.04' x2='85.16' y2='164.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.56' x2='82.64' y2='161.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='175.49' x2='85.16' y2='175.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='178.01' x2='82.64' y2='172.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='193.84' x2='117.68' y2='193.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='196.36' x2='115.16' y2='191.31' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='196.81' x2='117.68' y2='196.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='199.33' x2='115.16' y2='194.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='234.29' x2='192.02' y2='234.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='236.81' x2='189.50' y2='231.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='237.43' x2='192.02' y2='237.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='239.95' x2='189.50' y2='234.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='252.95' x2='261.72' y2='252.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.47' x2='259.20' y2='250.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='267.54' x2='331.41' y2='267.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.06' x2='328.89' y2='265.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='263.77' x2='331.41' y2='263.77' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='266.29' x2='328.89' y2='261.25' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,126.41 52.44,130.03 55.81,135.10 57.09,136.97 61.50,143.20 66.38,149.72 67.19,150.76 72.87,157.82 78.56,164.42 82.64,168.88 84.25,170.59 89.94,176.36 95.63,181.76 101.32,186.83 107.01,191.57 112.70,196.03 115.16,197.87 118.39,200.21 124.08,204.14 129.77,207.83 135.46,211.30 141.15,214.57 146.83,217.65 152.52,220.55 158.21,223.29 163.90,225.88 169.59,228.32 175.28,230.64 180.97,232.82 186.66,234.89 189.50,235.88 192.35,236.85 198.04,238.71 203.73,240.47 209.42,242.15 215.11,243.74 220.79,245.25 226.48,246.69 232.17,248.06 237.86,249.36 243.55,250.61 249.24,251.79 254.93,252.93 259.20,253.74 260.62,254.01 266.31,255.04 272.00,256.02 277.69,256.97 283.38,257.87 289.07,258.73 294.76,259.56 300.44,260.36 306.13,261.12 311.82,261.85 317.51,262.55 323.20,263.22 328.89,263.86 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='124.58' x2='51.90' y2='121.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='121.02' x2='51.90' y2='124.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.17' x2='51.90' y2='119.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='119.61' x2='51.90' y2='123.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='121.92' x2='54.22' y2='118.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='118.35' x2='54.22' y2='121.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.14' x2='54.22' y2='138.58' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='138.58' x2='54.22' y2='142.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.71' x2='58.87' y2='140.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.15' x2='58.87' y2='143.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='143.87' x2='58.87' y2='140.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.30' x2='58.87' y2='143.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.57' x2='68.16' y2='145.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.01' x2='68.16' y2='148.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='164.10' x2='68.16' y2='160.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.53' x2='68.16' y2='164.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='176.49' x2='84.42' y2='172.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='172.92' x2='84.42' y2='176.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='167.55' x2='84.42' y2='163.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='163.98' x2='84.42' y2='167.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.83' x2='116.95' y2='199.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.27' x2='116.95' y2='202.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.18' x2='116.95' y2='201.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.62' x2='116.95' y2='205.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.31' x2='191.29' y2='236.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.74' x2='191.29' y2='240.31' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='240.15' x2='191.29' y2='236.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.59' x2='191.29' y2='240.15' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.50' x2='260.98' y2='254.93' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='254.93' x2='260.98' y2='258.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='258.97' x2='260.98' y2='255.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.41' x2='260.98' y2='258.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='269.32' x2='330.67' y2='265.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='265.75' x2='330.67' y2='269.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.57' x2='330.67' y2='267.01' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.01' x2='330.67' y2='270.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.54 52.44,129.58 55.81,135.20 57.09,137.28 61.50,144.15 66.38,151.29 67.19,152.43 72.87,160.10 78.56,167.22 82.64,172.00 84.25,173.83 89.94,179.97 95.63,185.67 101.32,190.98 107.01,195.93 112.70,200.54 115.16,202.44 118.39,204.85 124.08,208.86 129.77,212.62 135.46,216.13 141.15,219.42 146.83,222.50 152.52,225.40 158.21,228.11 163.90,230.66 169.59,233.06 175.28,235.32 180.97,237.45 186.66,239.46 189.50,240.42 192.35,241.35 198.04,243.14 203.73,244.84 209.42,246.44 215.11,247.96 220.79,249.39 226.48,250.76 232.17,252.05 237.86,253.28 243.55,254.45 249.24,255.56 254.93,256.62 259.20,257.38 260.62,257.62 266.31,258.59 272.00,259.50 277.69,260.37 283.38,261.21 289.07,262.01 294.76,262.77 300.44,263.50 306.13,264.19 311.82,264.86 317.51,265.50 323.20,266.11 328.89,266.70 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.86 50.12,111.34 52.64,113.86 50.12,116.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,113.39 50.12,110.87 52.64,113.39 50.12,115.91 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,133.31 52.44,130.79 54.96,133.31 52.44,135.83 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,145.85 52.44,143.33 54.96,145.85 52.44,148.37 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.91 57.09,142.39 59.61,144.91 57.09,147.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,144.44 57.09,141.92 59.61,144.44 57.09,146.96 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.67 66.38,162.15 68.90,164.67 66.38,167.19 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,168.75 66.38,166.22 68.90,168.75 66.38,171.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,193.21 82.64,190.69 85.16,193.21 82.64,195.73 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,190.86 82.64,188.34 85.16,190.86 82.64,193.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,207.95 115.16,205.43 117.68,207.95 115.16,210.47 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,206.69 115.16,204.17 117.68,206.69 115.16,209.21 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,239.00 189.50,236.48 192.02,239.00 189.50,241.52 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,234.29 189.50,231.77 192.02,234.29 189.50,236.81 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,251.70 259.20,249.18 261.72,251.70 259.20,254.22 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,250.60 259.20,248.08 261.72,250.60 259.20,253.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,260.48 328.89,257.96 331.41,260.48 328.89,263.00 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,261.26 328.89,258.74 331.41,261.26 328.89,263.78 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,124.21 52.44,131.50 55.81,141.05 57.09,144.40 61.50,154.85 66.38,164.73 67.19,166.21 72.87,175.63 78.56,183.50 82.64,188.35 84.25,190.12 89.94,195.74 95.63,200.55 101.32,204.72 107.01,208.36 112.70,211.57 115.16,212.86 118.39,214.44 124.08,217.03 129.77,219.38 135.46,221.54 141.15,223.54 146.83,225.40 152.52,227.15 158.21,228.80 163.90,230.36 169.59,231.85 175.28,233.28 180.97,234.64 186.66,235.95 189.50,236.59 192.35,237.22 198.04,238.44 203.73,239.62 209.42,240.76 215.11,241.87 220.79,242.94 226.48,243.99 232.17,245.00 237.86,245.98 243.55,246.94 249.24,247.87 254.93,248.77 259.20,249.43 260.62,249.65 266.31,250.50 272.00,251.34 277.69,252.15 283.38,252.93 289.07,253.70 294.76,254.45 300.44,255.17 306.13,255.88 311.82,256.57 317.51,257.24 323.20,257.89 328.89,258.53 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.69 52.52,119.53 47.72,119.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,123.06 52.52,118.90 47.72,118.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,138.12 54.84,133.96 50.04,133.96 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,143.45 54.84,139.29 50.04,139.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,137.80 59.49,133.64 54.69,133.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.39 59.49,140.23 54.69,140.23 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,151.29 68.78,147.13 63.98,147.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,150.66 68.78,146.50 63.98,146.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.14 85.04,167.99 80.24,167.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.88 85.04,182.73 80.24,182.73 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,191.27 117.56,187.12 112.76,187.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.29 117.56,200.13 112.76,200.13 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,228.75 191.90,224.60 187.10,224.60 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,230.79 191.90,226.63 187.10,226.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,240.36 261.60,236.20 256.80,236.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,241.30 261.60,237.14 256.80,237.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,250.08 331.29,245.92 326.49,245.92 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,253.37 331.29,249.22 326.49,249.22 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.44 52.44,129.88 55.81,135.97 57.09,138.18 61.50,145.38 66.38,152.66 67.19,153.80 72.87,161.33 78.56,168.10 82.64,172.52 84.25,174.18 89.94,179.66 95.63,184.61 101.32,189.09 107.01,193.15 112.70,196.85 115.16,198.35 118.39,200.22 124.08,203.31 129.77,206.14 135.46,208.74 141.15,211.15 146.83,213.38 152.52,215.44 158.21,217.37 163.90,219.17 169.59,220.86 175.28,222.44 180.97,223.94 186.66,225.35 189.50,226.03 192.35,226.70 198.04,227.97 203.73,229.19 209.42,230.35 215.11,231.46 220.79,232.53 226.48,233.55 232.17,234.54 237.86,235.50 243.55,236.42 249.24,237.31 254.93,238.18 259.20,238.81 260.62,239.02 266.31,239.83 272.00,240.63 277.69,241.40 283.38,242.16 289.07,242.89 294.76,243.61 300.44,244.31 306.13,244.99 311.82,245.66 317.51,246.32 323.20,246.96 328.89,247.59 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='130.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='133.83' x2='51.90' y2='130.27' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.27' x2='51.90' y2='133.83' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='115.22' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='118.78' x2='51.90' y2='115.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.22' x2='51.90' y2='118.78' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='127.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='130.70' x2='54.22' y2='127.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.13' x2='54.22' y2='130.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='137.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='140.89' x2='54.22' y2='137.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='137.33' x2='54.22' y2='140.89' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='159.59' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='163.16' x2='58.87' y2='159.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='159.59' x2='58.87' y2='163.16' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='142.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='146.53' x2='58.87' y2='142.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='142.97' x2='58.87' y2='146.53' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='173.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='177.43' x2='68.16' y2='173.86' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.86' x2='68.16' y2='177.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='154.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='157.98' x2='68.16' y2='154.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.42' x2='68.16' y2='157.98' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='190.44' x2='84.42' y2='186.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='186.88' x2='84.42' y2='190.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='191.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='195.15' x2='84.42' y2='191.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='191.58' x2='84.42' y2='195.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='225.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='229.49' x2='116.95' y2='225.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.92' x2='116.95' y2='229.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='224.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='227.76' x2='116.95' y2='224.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.20' x2='116.95' y2='227.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='258.97' x2='191.29' y2='255.41' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.41' x2='191.29' y2='258.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='255.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='259.44' x2='191.29' y2='255.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='255.88' x2='191.29' y2='259.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='264.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='267.59' x2='260.98' y2='264.03' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='264.03' x2='260.98' y2='267.59' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='265.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='268.85' x2='260.98' y2='265.28' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='265.28' x2='260.98' y2='268.85' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='270.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='274.18' x2='330.67' y2='270.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='270.62' x2='330.67' y2='274.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='267.95' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='271.51' x2='330.67' y2='267.95' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='267.95' x2='330.67' y2='271.51' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.87 52.44,133.05 55.81,142.67 57.09,146.10 61.50,157.05 66.38,167.75 67.19,169.39 72.87,180.03 78.56,189.23 82.64,195.07 84.25,197.22 89.94,204.19 95.63,210.30 101.32,215.67 107.01,220.42 112.70,224.65 115.16,226.33 118.39,228.42 124.08,231.80 129.77,234.85 135.46,237.62 141.15,240.14 146.83,242.44 152.52,244.55 158.21,246.50 163.90,248.31 169.59,249.98 175.28,251.54 180.97,253.00 186.66,254.37 189.50,255.02 192.35,255.65 198.04,256.86 203.73,258.01 209.42,259.08 215.11,260.11 220.79,261.07 226.48,261.99 232.17,262.87 237.86,263.70 243.55,264.49 249.24,265.24 254.93,265.96 259.20,266.48 260.62,266.65 266.31,267.30 272.00,267.93 277.69,268.53 283.38,269.10 289.07,269.64 294.76,270.16 300.44,270.66 306.13,271.14 311.82,271.60 317.51,272.04 323.20,272.46 328.89,272.86 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='131.48' x2='51.90' y2='127.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.92' x2='51.90' y2='131.48' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='129.70' x2='52.64' y2='129.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='132.22' x2='50.12' y2='127.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='115.17' x2='51.90' y2='111.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='111.61' x2='51.90' y2='115.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='113.39' x2='52.64' y2='113.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='115.91' x2='50.12' y2='110.87' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='129.76' x2='54.22' y2='126.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.19' x2='54.22' y2='129.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.97' x2='54.96' y2='127.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='130.49' x2='52.44' y2='125.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='145.59' x2='54.22' y2='142.03' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='142.03' x2='54.22' y2='145.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='143.81' x2='54.96' y2='143.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='146.33' x2='52.44' y2='141.29' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='149.36' x2='58.87' y2='145.79' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='145.79' x2='58.87' y2='149.36' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='147.58' x2='59.61' y2='147.58' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='150.10' x2='57.09' y2='145.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='165.51' x2='58.87' y2='161.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='161.95' x2='58.87' y2='165.51' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='163.73' x2='59.61' y2='163.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='166.25' x2='57.09' y2='161.21' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='173.98' x2='68.16' y2='170.41' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='170.41' x2='68.16' y2='173.98' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='172.19' x2='68.90' y2='172.19' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='174.72' x2='66.38' y2='169.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='179.15' x2='68.16' y2='175.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='175.59' x2='68.16' y2='179.15' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='177.37' x2='68.90' y2='177.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='179.89' x2='66.38' y2='174.85' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='209.73' x2='84.42' y2='206.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='206.17' x2='84.42' y2='209.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='207.95' x2='85.16' y2='207.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='210.47' x2='82.64' y2='205.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='204.24' x2='84.42' y2='200.68' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='200.68' x2='84.42' y2='204.24' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='202.46' x2='85.16' y2='202.46' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='204.98' x2='82.64' y2='199.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='228.39' x2='116.95' y2='224.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='224.83' x2='116.95' y2='228.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='226.61' x2='117.68' y2='226.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='229.13' x2='115.16' y2='224.09' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='225.72' x2='116.95' y2='222.16' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='222.16' x2='116.95' y2='225.72' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='223.94' x2='117.68' y2='223.94' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='226.46' x2='115.16' y2='221.42' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='247.05' x2='191.29' y2='243.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='243.49' x2='191.29' y2='247.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='245.27' x2='192.02' y2='245.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='247.79' x2='189.50' y2='242.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='246.11' x2='191.29' y2='242.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.55' x2='191.29' y2='246.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.33' x2='192.02' y2='244.33' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.85' x2='189.50' y2='241.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.52' x2='260.98' y2='251.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='251.96' x2='260.98' y2='255.52' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='255.83' x2='260.98' y2='252.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='252.27' x2='260.98' y2='255.83' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='254.05' x2='261.72' y2='254.05' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.57' x2='259.20' y2='251.53' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='263.67' x2='330.67' y2='260.11' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.11' x2='330.67' y2='263.67' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='261.89' x2='331.41' y2='261.89' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.41' x2='328.89' y2='259.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.73' x2='330.67' y2='259.17' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.17' x2='330.67' y2='262.73' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='260.95' x2='331.41' y2='260.95' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.47' x2='328.89' y2='258.43' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,124.84 52.44,134.83 55.81,147.56 57.09,151.92 61.50,165.16 66.38,177.12 67.19,178.87 72.87,189.63 78.56,198.14 82.64,203.17 84.25,204.95 89.94,210.46 95.63,214.97 101.32,218.72 107.01,221.88 112.70,224.60 115.16,225.66 118.39,226.96 124.08,229.05 129.77,230.93 135.46,232.63 141.15,234.20 146.83,235.66 152.52,237.03 158.21,238.32 163.90,239.55 169.59,240.73 175.28,241.86 180.97,242.94 186.66,243.99 189.50,244.50 192.35,245.00 198.04,245.98 203.73,246.93 209.42,247.85 215.11,248.75 220.79,249.62 226.48,250.47 232.17,251.29 237.86,252.09 243.55,252.87 249.24,253.63 254.93,254.37 259.20,254.91 260.62,255.09 266.31,255.79 272.00,256.47 277.69,257.14 283.38,257.78 289.07,258.41 294.76,259.03 300.44,259.62 306.13,260.21 311.82,260.77 317.51,261.32 323.20,261.86 328.89,262.39 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='109.16' x2='52.64' y2='109.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='111.68' x2='50.12' y2='106.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,109.16 50.12,106.64 52.64,109.16 50.12,111.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='47.60' y1='139.11' x2='52.64' y2='139.11' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='141.63' x2='50.12' y2='136.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='47.60,139.11 50.12,136.59 52.64,139.11 50.12,141.63 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='127.19' x2='54.96' y2='127.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.71' x2='52.44' y2='124.67' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,127.19 52.44,124.67 54.96,127.19 52.44,129.71 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='49.92' y1='118.25' x2='54.96' y2='118.25' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='120.77' x2='52.44' y2='115.73' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='49.92,118.25 52.44,115.73 54.96,118.25 52.44,120.77 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='149.61' x2='59.61' y2='149.61' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='152.13' x2='57.09' y2='147.09' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,149.61 57.09,147.09 59.61,149.61 57.09,152.13 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='54.57' y1='140.52' x2='59.61' y2='140.52' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='143.04' x2='57.09' y2='138.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='54.57,140.52 57.09,138.00 59.61,140.52 57.09,143.04 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='158.55' x2='68.90' y2='158.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.07' x2='66.38' y2='156.03' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,158.55 66.38,156.03 68.90,158.55 66.38,161.07 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='63.86' y1='164.98' x2='68.90' y2='164.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='167.50' x2='66.38' y2='162.46' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='63.86,164.98 66.38,162.46 68.90,164.98 66.38,167.50 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='192.27' x2='85.16' y2='192.27' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='194.79' x2='82.64' y2='189.75' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,192.27 82.64,189.75 85.16,192.27 82.64,194.79 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.12' y1='183.80' x2='85.16' y2='183.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='186.32' x2='82.64' y2='181.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.12,183.80 82.64,181.28 85.16,183.80 82.64,186.32 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='215.32' x2='117.68' y2='215.32' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='217.84' x2='115.16' y2='212.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,215.32 115.16,212.80 117.68,215.32 115.16,217.84 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='112.64' y1='211.08' x2='117.68' y2='211.08' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='213.60' x2='115.16' y2='208.56' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='112.64,211.08 115.16,208.56 117.68,211.08 115.16,213.60 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='244.17' x2='192.02' y2='244.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='246.69' x2='189.50' y2='241.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,244.17 189.50,241.65 192.02,244.17 189.50,246.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='186.98' y1='242.76' x2='192.02' y2='242.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='245.28' x2='189.50' y2='240.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='186.98,242.76 189.50,240.24 192.02,242.76 189.50,245.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='253.74' x2='261.72' y2='253.74' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='256.26' x2='259.20' y2='251.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,253.74 259.20,251.22 261.72,253.74 259.20,256.26 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='256.68' y1='258.28' x2='261.72' y2='258.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='260.80' x2='259.20' y2='255.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='256.68,258.28 259.20,255.76 261.72,258.28 259.20,260.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='268.16' x2='331.41' y2='268.16' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='270.68' x2='328.89' y2='265.64' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,268.16 328.89,265.64 331.41,268.16 328.89,270.68 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='326.37' y1='262.36' x2='331.41' y2='262.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='264.88' x2='328.89' y2='259.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='326.37,262.36 328.89,259.84 331.41,262.36 328.89,264.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.17 52.44,129.83 55.81,138.72 57.09,141.89 61.50,151.99 66.38,161.84 67.19,163.34 72.87,173.10 78.56,181.53 82.64,186.87 84.25,188.84 89.94,195.22 95.63,200.81 101.32,205.73 107.01,210.10 112.70,214.00 115.16,215.56 118.39,217.50 124.08,220.65 129.77,223.52 135.46,226.14 141.15,228.54 146.83,230.76 152.52,232.82 158.21,234.74 163.90,236.54 169.59,238.23 175.28,239.82 180.97,241.32 186.66,242.75 189.50,243.44 192.35,244.11 198.04,245.41 203.73,246.65 209.42,247.83 215.11,248.97 220.79,250.06 226.48,251.11 232.17,252.12 237.86,253.09 243.55,254.02 249.24,254.93 254.93,255.80 259.20,256.43 260.62,256.64 266.31,257.45 272.00,258.23 277.69,258.99 283.38,259.73 289.07,260.43 294.76,261.12 300.44,261.78 306.13,262.42 311.82,263.04 317.51,263.65 323.20,264.23 328.89,264.79 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='122.80' x2='51.90' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.58' x2='50.12' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='123.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.09' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='126.09' x2='54.22' y2='126.09' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='127.87' x2='52.44' y2='124.31' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='122.80' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='122.80' x2='54.22' y2='122.80' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='124.58' x2='52.44' y2='121.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='136.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.28' x2='58.87' y2='136.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='138.07' x2='57.09' y2='134.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='139.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.11' x2='58.87' y2='139.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='140.89' x2='57.09' y2='137.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='159.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='159.81' x2='68.16' y2='159.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='161.59' x2='66.38' y2='158.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='147.58' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='147.58' x2='68.16' y2='147.58' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='149.36' x2='66.38' y2='145.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.14' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.14' x2='84.42' y2='165.14' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='166.92' x2='82.64' y2='163.36' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='165.61' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='165.61' x2='84.42' y2='165.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='167.39' x2='82.64' y2='163.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='202.62' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.62' x2='116.95' y2='202.62' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='204.40' x2='115.16' y2='200.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='191.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='191.17' x2='116.95' y2='191.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='192.95' x2='115.16' y2='189.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.39' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.39' x2='191.29' y2='235.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.17' x2='189.50' y2='233.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='235.23' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='235.23' x2='191.29' y2='235.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.02' x2='189.50' y2='233.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='245.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='245.27' x2='260.98' y2='245.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='247.05' x2='259.20' y2='243.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='249.66' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.66' x2='260.98' y2='249.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='251.44' x2='259.20' y2='247.88' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.73' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.73' x2='330.67' y2='261.73' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.52' x2='328.89' y2='259.95' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='259.38' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.38' x2='330.67' y2='259.38' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='261.16' x2='328.89' y2='257.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.98 52.44,127.93 55.81,133.44 57.09,135.46 61.50,142.14 66.38,149.07 67.19,150.17 72.87,157.57 78.56,164.41 82.64,168.99 84.25,170.73 89.94,176.58 95.63,181.99 101.32,187.02 107.01,191.69 112.70,196.03 115.16,197.82 118.39,200.07 124.08,203.84 129.77,207.36 135.46,210.64 141.15,213.72 146.83,216.60 152.52,219.31 158.21,221.85 163.90,224.24 169.59,226.49 175.28,228.62 180.97,230.63 186.66,232.52 189.50,233.44 192.35,234.32 198.04,236.03 203.73,237.64 209.42,239.18 215.11,240.65 220.79,242.04 226.48,243.37 232.17,244.64 237.86,245.85 243.55,247.01 249.24,248.12 254.93,249.18 259.20,249.95 260.62,250.20 266.31,251.18 272.00,252.12 277.69,253.03 283.38,253.90 289.07,254.74 294.76,255.55 300.44,256.32 306.13,257.07 311.82,257.80 317.51,258.50 323.20,259.17 328.89,259.83 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,131.06 52.52,126.21 47.72,126.21 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,125.52 52.52,130.37 47.72,130.37 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,129.65 52.52,124.80 47.72,124.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,124.10 52.52,128.95 47.72,128.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,135.45 54.84,130.60 50.04,130.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,129.91 54.84,134.76 50.04,134.76 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,117.57 54.84,112.72 50.04,112.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,112.03 54.84,116.88 50.04,116.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,140.47 59.49,135.62 54.69,135.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,134.92 59.49,139.77 54.69,139.77 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,144.54 59.49,139.69 54.69,139.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,139.00 59.49,143.85 54.69,143.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,142.66 68.78,137.81 63.98,137.81 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,137.12 68.78,141.97 63.98,141.97 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,157.87 68.78,153.02 63.98,153.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,152.33 68.78,157.18 63.98,157.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,168.54 85.04,163.69 80.24,163.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,162.99 85.04,167.84 80.24,167.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,172.77 85.04,167.92 80.24,167.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,167.23 85.04,172.08 80.24,172.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,188.30 117.56,183.45 112.76,183.45 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,182.75 117.56,187.60 112.76,187.60 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,183.59 117.56,178.74 112.76,178.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,178.05 117.56,182.90 112.76,182.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,224.21 191.90,219.36 187.10,219.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,218.66 191.90,223.51 187.10,223.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,225.77 191.90,220.92 187.10,220.92 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,220.23 191.90,225.08 187.10,225.08 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,244.12 261.60,239.27 256.80,239.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,238.58 261.60,243.43 256.80,243.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,237.69 261.60,232.84 256.80,232.84 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,232.15 261.60,237.00 256.80,237.00 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,252.12 331.29,247.27 326.49,247.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.58 331.29,251.42 326.49,251.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,251.96 331.29,247.11 326.49,247.11 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,246.42 331.29,251.27 326.49,251.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.76 52.44,129.01 55.81,133.54 57.09,135.22 61.50,140.77 66.38,146.57 67.19,147.49 72.87,153.75 78.56,159.57 82.64,163.49 84.25,164.99 89.94,170.05 95.63,174.77 101.32,179.19 107.01,183.32 112.70,187.18 115.16,188.78 118.39,190.80 124.08,194.20 129.77,197.40 135.46,200.40 141.15,203.23 146.83,205.89 152.52,208.41 158.21,210.78 163.90,213.03 169.59,215.16 175.28,217.18 180.97,219.09 186.66,220.91 189.50,221.79 192.35,222.64 198.04,224.29 203.73,225.87 209.42,227.37 215.11,228.81 220.79,230.18 226.48,231.50 232.17,232.76 237.86,233.97 243.55,235.13 249.24,236.25 254.93,237.33 259.20,238.12 260.62,238.37 266.31,239.38 272.00,240.34 277.69,241.28 283.38,242.18 289.07,243.06 294.76,243.91 300.44,244.73 306.13,245.53 311.82,246.30 317.51,247.05 323.20,247.78 328.89,248.49 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='137.70' x2='51.90' y2='137.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='139.48' x2='50.12' y2='135.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='135.91' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.11' x2='51.90' y2='123.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.12' y1='124.89' x2='50.12' y2='121.33' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='121.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='127.50' x2='54.22' y2='127.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='129.29' x2='52.44' y2='125.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='125.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='132.99' x2='54.22' y2='132.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='52.44' y1='134.77' x2='52.44' y2='131.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='131.21' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='120.76' x2='58.87' y2='120.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='122.54' x2='57.09' y2='118.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='118.98' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='139.89' x2='58.87' y2='139.89' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='57.09' y1='141.67' x2='57.09' y2='138.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='138.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='160.28' x2='68.16' y2='160.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='162.06' x2='66.38' y2='158.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='158.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='145.54' x2='68.16' y2='145.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='66.38' y1='147.32' x2='66.38' y2='143.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='143.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='174.23' x2='84.42' y2='174.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='176.02' x2='82.64' y2='172.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='172.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.57' x2='84.42' y2='171.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='82.64' y1='173.35' x2='82.64' y2='169.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='169.79' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='201.52' x2='116.95' y2='201.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='203.30' x2='115.16' y2='199.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='199.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='199.64' x2='116.95' y2='199.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='115.16' y1='201.42' x2='115.16' y2='197.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='197.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.17' x2='191.29' y2='236.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='237.96' x2='189.50' y2='234.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='236.49' x2='191.29' y2='236.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='189.50' y1='238.27' x2='189.50' y2='234.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='234.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.74' x2='260.98' y2='253.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='255.52' x2='259.20' y2='251.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='251.96' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='249.19' x2='260.98' y2='249.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='259.20' y1='250.97' x2='259.20' y2='247.41' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='247.41' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.32' x2='330.67' y2='260.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='262.11' x2='328.89' y2='258.54' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='258.54' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='261.26' x2='330.67' y2='261.26' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='328.89' y1='263.05' x2='328.89' y2='259.48' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='259.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,125.62 52.44,129.62 55.81,135.18 57.09,137.22 61.50,143.97 66.38,150.97 67.19,152.08 72.87,159.55 78.56,166.44 82.64,171.06 84.25,172.82 89.94,178.71 95.63,184.17 101.32,189.23 107.01,193.93 112.70,198.29 115.16,200.09 118.39,202.35 124.08,206.13 129.77,209.66 135.46,212.95 141.15,216.03 146.83,218.92 152.52,221.62 158.21,224.15 163.90,226.54 169.59,228.78 175.28,230.89 180.97,232.89 186.66,234.77 189.50,235.67 192.35,236.55 198.04,238.23 203.73,239.83 209.42,241.35 215.11,242.79 220.79,244.16 226.48,245.46 232.17,246.71 237.86,247.89 243.55,249.03 249.24,250.11 254.93,251.15 259.20,251.90 260.62,252.14 266.31,253.09 272.00,254.01 277.69,254.88 283.38,255.72 289.07,256.53 294.76,257.31 300.44,258.06 306.13,258.79 311.82,259.48 317.51,260.16 323.20,260.80 328.89,261.43 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='125.31' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='127.09' x2='51.90' y2='123.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='123.53' x2='51.90' y2='127.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='50.12' cy='128.60' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='130.38' x2='51.90' y2='126.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='48.34' y1='126.82' x2='51.90' y2='130.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='126.88' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='128.66' x2='54.22' y2='125.09' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='125.09' x2='54.22' y2='128.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='52.44' cy='115.74' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='117.52' x2='54.22' y2='113.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='50.66' y1='113.96' x2='54.22' y2='117.52' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='138.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='140.42' x2='58.87' y2='136.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='136.86' x2='58.87' y2='140.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='57.09' cy='126.41' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='128.19' x2='58.87' y2='124.62' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='55.30' y1='124.62' x2='58.87' y2='128.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='152.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='154.69' x2='68.16' y2='151.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.13' x2='68.16' y2='154.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='66.38' cy='150.08' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='151.87' x2='68.16' y2='148.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='64.60' y1='148.30' x2='68.16' y2='151.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='173.61' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='175.39' x2='84.42' y2='171.82' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='171.82' x2='84.42' y2='175.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='82.64' cy='180.19' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='181.97' x2='84.42' y2='178.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='80.86' y1='178.41' x2='84.42' y2='181.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='205.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='207.53' x2='116.95' y2='203.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='203.97' x2='116.95' y2='207.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='115.16' cy='204.03' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='205.81' x2='116.95' y2='202.25' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='113.38' y1='202.25' x2='116.95' y2='205.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='243.86' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='245.64' x2='191.29' y2='242.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='242.08' x2='191.29' y2='245.64' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='189.50' cy='239.94' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='241.72' x2='191.29' y2='238.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='187.72' y1='238.16' x2='191.29' y2='241.72' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='258.44' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='260.22' x2='260.98' y2='256.66' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='256.66' x2='260.98' y2='260.22' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='259.20' cy='252.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='253.95' x2='260.98' y2='250.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='257.42' y1='250.39' x2='260.98' y2='253.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='262.52' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='264.30' x2='330.67' y2='260.74' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='260.74' x2='330.67' y2='264.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<circle cx='328.89' cy='261.11' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='262.89' x2='330.67' y2='259.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<line x1='327.11' y1='259.33' x2='330.67' y2='262.89' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.25 52.44,127.84 55.81,134.17 57.09,136.49 61.50,144.12 66.38,151.95 67.19,153.18 72.87,161.45 78.56,169.01 82.64,174.02 84.25,175.92 89.94,182.25 95.63,188.06 101.32,193.39 107.01,198.30 112.70,202.82 115.16,204.67 118.39,207.00 124.08,210.85 129.77,214.42 135.46,217.73 141.15,220.81 146.83,223.67 152.52,226.33 158.21,228.82 163.90,231.15 169.59,233.33 175.28,235.37 180.97,237.29 186.66,239.09 189.50,239.96 192.35,240.79 198.04,242.40 203.73,243.92 209.42,245.35 215.11,246.72 220.79,248.01 226.48,249.23 232.17,250.40 237.86,251.52 243.55,252.58 249.24,253.59 254.93,254.56 259.20,255.26 260.62,255.48 266.31,256.37 272.00,257.22 277.69,258.04 283.38,258.82 289.07,259.57 294.76,260.29 300.44,260.99 306.13,261.66 311.82,262.30 317.51,262.92 323.20,263.52 328.89,264.10 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,116.00 51.90,119.56 48.34,119.56 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='116.00' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.12,122.43 51.90,125.99 48.34,125.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='48.34' y='122.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,126.35 54.22,129.91 50.66,129.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='126.35' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='52.44,116.31 54.22,119.88 50.66,119.88 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='50.66' y='116.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,141.56 58.87,145.12 55.30,145.12 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='141.56' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='57.09,145.64 58.87,149.20 55.30,149.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='55.30' y='145.64' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,156.61 68.16,160.18 64.60,160.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='156.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='66.38,155.67 68.16,159.24 64.60,159.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='64.60' y='155.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,186.72 84.42,190.29 80.86,190.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='186.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='82.64,177.94 84.42,181.50 80.86,181.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='80.86' y='177.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,207.11 116.95,210.67 113.38,210.67 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='207.11' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='115.16,204.28 116.95,207.85 113.38,207.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='113.38' y='204.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,238.94 191.29,242.50 187.72,242.50 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='238.94' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='189.50,239.72 191.29,243.29 187.72,243.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='187.72' y='239.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,253.05 260.98,256.62 257.42,256.62 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='253.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='259.20,249.76 260.98,253.32 257.42,253.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='257.42' y='249.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,262.15 330.67,265.71 327.11,265.71 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='262.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='328.89,261.83 330.67,265.40 327.11,265.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<rect x='327.11' y='261.83' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,123.22 52.44,129.16 55.81,137.19 57.09,140.07 61.50,149.32 66.38,158.49 67.19,159.90 72.87,169.14 78.56,177.25 82.64,182.46 84.25,184.39 89.94,190.69 95.63,196.29 101.32,201.27 107.01,205.73 112.70,209.73 115.16,211.35 118.39,213.35 124.08,216.63 129.77,219.62 135.46,222.35 141.15,224.87 146.83,227.19 152.52,229.34 158.21,231.35 163.90,233.22 169.59,234.98 175.28,236.63 180.97,238.19 186.66,239.67 189.50,240.38 192.35,241.07 198.04,242.41 203.73,243.69 209.42,244.90 215.11,246.07 220.79,247.19 226.48,248.26 232.17,249.29 237.86,250.29 243.55,251.25 249.24,252.17 254.93,253.06 259.20,253.71 260.62,253.93 266.31,254.76 272.00,255.57 277.69,256.35 283.38,257.10 289.07,257.83 294.76,258.54 300.44,259.23 306.13,259.89 311.82,260.54 317.51,261.16 323.20,261.77 328.89,262.36 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,118.94 51.90,118.94 51.90,115.37 48.34,115.37 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='48.34,117.21 51.90,117.21 51.90,113.65 48.34,113.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,128.19 54.22,128.19 54.22,124.62 50.66,124.62 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='50.66,130.85 54.22,130.85 54.22,127.29 50.66,127.29 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,146.38 58.87,146.38 58.87,142.81 55.30,142.81 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='55.30,140.42 58.87,140.42 58.87,136.86 55.30,136.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,162.53 68.16,162.53 68.16,158.97 64.60,158.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='64.60,164.57 68.16,164.57 68.16,161.00 64.60,161.00 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,186.37 84.42,186.37 84.42,182.80 80.86,182.80 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='80.86,193.11 84.42,193.11 84.42,189.54 80.86,189.54 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,213.81 116.95,213.81 116.95,210.24 113.38,210.24 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='113.38,210.36 116.95,210.36 116.95,206.79 113.38,206.79 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,237.96 191.29,237.96 191.29,234.39 187.72,234.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='187.72,238.27 191.29,238.27 191.29,234.71 187.72,234.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,250.81 260.98,250.81 260.98,247.25 257.42,247.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='257.42,249.40 260.98,249.40 260.98,245.84 257.42,245.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,259.91 330.67,259.91 330.67,256.35 327.11,256.35 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polygon points='327.11,255.05 330.67,255.05 330.67,251.48 327.11,251.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<polyline points='50.12,122.60 52.44,129.27 55.81,138.16 57.09,141.31 61.50,151.30 66.38,160.97 67.19,162.44 72.87,171.91 78.56,180.00 82.64,185.08 84.25,186.95 89.94,192.94 95.63,198.14 101.32,202.67 107.01,206.66 112.70,210.18 115.16,211.58 118.39,213.32 124.08,216.13 129.77,218.66 135.46,220.97 141.15,223.08 146.83,225.02 152.52,226.82 158.21,228.50 163.90,230.07 169.59,231.55 175.28,232.95 180.97,234.29 186.66,235.55 189.50,236.17 192.35,236.77 198.04,237.93 203.73,239.05 209.42,240.13 215.11,241.17 220.79,242.18 226.48,243.15 232.17,244.10 237.86,245.02 243.55,245.91 249.24,246.78 254.93,247.62 259.20,248.24 260.62,248.44 266.31,249.24 272.00,250.02 277.69,250.78 283.38,251.52 289.07,252.24 294.76,252.95 300.44,253.63 306.13,254.30 311.82,254.96 317.51,255.59 323.20,256.22 328.89,256.82 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDI4OC44OHwxMDIuMjQ=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='288.88' x2='684.43' y2='288.88' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='288.88' x2='410.12' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='464.98' y1='288.88' x2='464.98' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='519.84' y1='288.88' x2='519.84' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='574.70' y1='288.88' x2='574.70' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='629.56' y1='288.88' x2='629.56' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='684.43' y1='288.88' x2='684.43' y2='293.63' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='460.59' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='515.45' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='570.31' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='625.17' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='677.84' y='305.98' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<line x1='398.97' y1='270.98' x2='398.97' y2='120.14' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='270.98' x2='394.21' y2='270.98' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='233.27' x2='394.21' y2='233.27' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='195.56' x2='394.21' y2='195.56' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='157.85' x2='394.21' y2='157.85' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='120.14' x2='394.21' y2='120.14' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,274.50) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,236.79) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,197.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,160.04) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,122.33) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,288.88 700.04,288.88 700.04,102.24 398.97,102.24 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk='>
+ <rect x='360.00' y='82.29' width='360.00' height='235.10' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text x='532.82' y='324.99' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHwzMTcuMzl8ODIuMjk=)'><text transform='translate(368.55,233.76) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0'>
+ <rect x='398.97' y='102.24' width='301.08' height='186.63' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='195.56' x2='700.04' y2='195.56' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='681.70' cy='235.99' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='681.70' cy='176.99' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='672.20' cy='205.56' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='672.20' cy='150.69' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='654.82' cy='132.39' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='654.82' cy='242.15' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='625.68' cy='187.45' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='625.68' cy='162.75' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='588.16' cy='220.21' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='588.16' cy='181.80' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='543.49' cy='203.63' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='543.49' cy='218.04' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='497.71' cy='198.77' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='497.71' cy='199.45' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='474.71' cy='187.01' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='474.71' cy='184.95' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='458.43' cy='200.26' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='458.43' cy='194.09' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.81,203.24 686.21,207.40 681.41,207.40 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.81,191.58 686.21,195.74 681.41,195.74 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.09,178.65 678.49,182.81 673.69,182.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.09,186.20 678.49,190.36 673.69,190.36 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.59,184.05 663.99,188.21 659.19,188.21 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.59,166.22 663.99,170.37 659.19,170.37 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.97,229.58 638.37,233.74 633.57,233.74 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='635.97,187.74 638.37,191.90 633.57,191.90 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='600.09,198.59 602.49,202.75 597.69,202.75 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='600.09,232.89 602.49,237.05 597.69,237.05 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='551.89,173.68 554.29,177.84 549.49,177.84 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='551.89,160.65 554.29,164.81 549.49,164.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='498.86,175.29 501.26,179.45 496.46,179.45 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='498.86,193.81 501.26,197.97 496.46,197.97 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.45,207.77 477.85,211.93 473.05,211.93 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='475.45,198.86 477.85,203.01 473.05,203.01 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.45,201.38 462.85,205.54 458.05,205.54 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='460.45,188.35 462.85,192.50 458.05,192.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.70' y1='131.11' x2='684.74' y2='131.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.22' y1='133.63' x2='682.22' y2='128.59' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.70' y1='188.74' x2='684.74' y2='188.74' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.22' y1='191.26' x2='682.22' y2='186.22' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.36' y1='212.12' x2='678.41' y2='212.12' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.88' y1='214.64' x2='675.88' y2='209.60' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.36' y1='208.00' x2='678.41' y2='208.00' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='675.88' y1='210.52' x2='675.88' y2='205.48' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.23' y1='226.68' x2='666.27' y2='226.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.75' y1='229.20' x2='663.75' y2='224.16' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.23' y1='179.35' x2='666.27' y2='179.35' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.75' y1='181.87' x2='663.75' y2='176.83' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.93' y1='191.91' x2='643.97' y2='191.91' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='641.45' y1='194.43' x2='641.45' y2='189.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='638.93' y1='185.05' x2='643.97' y2='185.05' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='641.45' y1='187.57' x2='641.45' y2='182.53' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.41' y1='216.73' x2='610.45' y2='216.73' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.93' y1='219.25' x2='607.93' y2='214.21' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.41' y1='166.66' x2='610.45' y2='166.66' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.93' y1='169.18' x2='607.93' y2='164.14' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.70' y1='213.22' x2='559.74' y2='213.22' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.22' y1='215.74' x2='557.22' y2='210.70' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='554.70' y1='200.18' x2='559.74' y2='200.18' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.22' y1='202.70' x2='557.22' y2='197.66' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.20' y1='202.52' x2='493.24' y2='202.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.72' y1='205.04' x2='490.72' y2='200.00' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='488.20' y1='188.80' x2='493.24' y2='188.80' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='490.72' y1='191.32' x2='490.72' y2='186.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.97' y1='199.00' x2='462.01' y2='199.00' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.49' y1='201.52' x2='459.49' y2='196.48' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='456.97' y1='199.00' x2='462.01' y2='199.00' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='459.49' y1='201.52' x2='459.49' y2='196.48' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.26' y1='179.49' x2='444.30' y2='179.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.78' y1='182.01' x2='441.78' y2='176.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.26' y1='195.95' x2='444.30' y2='195.95' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.78' y1='198.47' x2='441.78' y2='193.43' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.96' y1='209.34' x2='685.52' y2='205.78' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.96' y1='205.78' x2='685.52' y2='209.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.96' y1='215.52' x2='685.52' y2='211.95' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.96' y1='211.95' x2='685.52' y2='215.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.90' y1='238.66' x2='678.46' y2='235.10' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.90' y1='235.10' x2='678.46' y2='238.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.90' y1='150.17' x2='678.46' y2='146.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.90' y1='146.61' x2='678.46' y2='150.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.43' y1='176.99' x2='665.00' y2='173.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.43' y1='173.42' x2='665.00' y2='176.99' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.43' y1='176.30' x2='665.00' y2='172.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.43' y1='172.74' x2='665.00' y2='176.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.92' y1='217.03' x2='640.48' y2='213.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.92' y1='213.47' x2='640.48' y2='217.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.92' y1='149.12' x2='640.48' y2='145.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='636.92' y1='145.55' x2='640.48' y2='149.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.68' y1='185.53' x2='604.25' y2='181.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.68' y1='181.97' x2='604.25' y2='185.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.68' y1='224.63' x2='604.25' y2='221.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='600.68' y1='221.07' x2='604.25' y2='224.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.44' y1='203.45' x2='551.00' y2='199.88' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.44' y1='199.88' x2='551.00' y2='203.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.44' y1='193.16' x2='551.00' y2='189.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.44' y1='189.59' x2='551.00' y2='193.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.00' y1='205.63' x2='484.57' y2='202.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.00' y1='202.07' x2='484.57' y2='205.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.00' y1='206.32' x2='484.57' y2='202.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.00' y1='202.75' x2='484.57' y2='206.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.34' y1='200.23' x2='454.91' y2='196.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.34' y1='196.67' x2='454.91' y2='200.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.34' y1='198.17' x2='454.91' y2='194.61' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='451.34' y1='194.61' x2='454.91' y2='198.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.04' y1='193.68' x2='438.60' y2='190.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.04' y1='190.11' x2='438.60' y2='193.68' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.04' y1='188.19' x2='438.60' y2='184.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.04' y1='184.63' x2='438.60' y2='188.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.56,240.82 686.08,238.30 688.60,240.82 686.08,243.34 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.56,242.88 686.08,240.36 688.60,242.88 686.08,245.40 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.80,187.66 673.32,185.14 675.84,187.66 673.32,190.18 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='670.80,132.78 673.32,130.26 675.84,132.78 673.32,135.30 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='648.24,193.33 650.76,190.81 653.28,193.33 650.76,195.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='648.24,195.39 650.76,192.87 653.28,195.39 650.76,197.91 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='612.67,195.85 615.19,193.33 617.71,195.85 615.19,198.37 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='612.67,178.01 615.19,175.49 617.71,178.01 615.19,180.53 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='571.35,174.32 573.87,171.80 576.39,174.32 573.87,176.84 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='571.35,184.61 573.87,182.09 576.39,184.61 573.87,187.13 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='528.49,217.03 531.01,214.51 533.53,217.03 531.01,219.55 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='528.49,222.52 531.01,220.00 533.53,222.52 531.01,225.04 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.96,185.04 489.48,182.52 492.00,185.04 489.48,187.56 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.96,205.62 489.48,203.10 492.00,205.62 489.48,208.14 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='464.50,185.65 467.02,183.13 469.54,185.65 467.02,188.17 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='464.50,190.45 467.02,187.93 469.54,190.45 467.02,192.97 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='448.59,187.02 451.11,184.50 453.63,187.02 451.11,189.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='448.59,183.59 451.11,181.07 453.63,183.59 451.11,186.11 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.93,218.09 686.33,213.94 681.53,213.94 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.93,220.84 686.33,216.68 681.53,216.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.15,174.45 678.55,170.29 673.75,170.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='676.15,151.12 678.55,146.97 673.75,146.97 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.63,212.13 664.03,207.97 659.23,207.97 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='661.63,183.32 664.03,179.16 659.23,179.16 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='636.30,216.47 638.70,212.31 633.90,212.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='636.30,219.21 638.70,215.05 633.90,215.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.56,212.11 603.96,207.95 599.16,207.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='601.56,147.62 603.96,143.47 599.16,143.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='556.38,241.40 558.78,237.24 553.98,237.24 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='556.38,184.46 558.78,180.30 553.98,180.30 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='507.95,198.56 510.35,194.40 505.55,194.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='507.95,189.64 510.35,185.49 505.55,185.49 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.60,203.69 488.00,199.53 483.20,199.53 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='485.60,199.57 488.00,195.42 483.20,195.42 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='470.25,199.56 472.65,195.40 467.85,195.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='470.25,185.15 472.65,180.99 467.85,180.99 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='681.38' y='166.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.38' y1='170.32' x2='684.94' y2='166.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.38' y1='166.76' x2='684.94' y2='170.32' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='681.38' y='232.61' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.38' y1='236.18' x2='684.94' y2='232.61' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.38' y1='232.61' x2='684.94' y2='236.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='668.82' y='211.88' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.82' y1='215.45' x2='672.38' y2='211.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.82' y1='211.88' x2='672.38' y2='215.45' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='668.82' y='167.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.82' y1='170.86' x2='672.38' y2='167.29' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='668.82' y1='167.29' x2='672.38' y2='170.86' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='645.99' y='126.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.99' y1='130.53' x2='649.56' y2='126.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.99' y1='126.97' x2='649.56' y2='130.53' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='645.99' y='199.68' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.99' y1='203.25' x2='649.56' y2='199.68' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='645.99' y1='199.68' x2='649.56' y2='203.25' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='608.12' y='159.26' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.12' y1='162.83' x2='611.68' y2='159.26' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.12' y1='159.26' x2='611.68' y2='162.83' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='608.12' y='244.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.12' y1='247.89' x2='611.68' y2='244.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='608.12' y1='244.33' x2='611.68' y2='247.89' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='560.34' y='221.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.34' y1='225.38' x2='563.90' y2='221.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.34' y1='221.82' x2='563.90' y2='225.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='560.34' y='201.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.34' y1='204.80' x2='563.90' y2='201.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='560.34' y1='201.24' x2='563.90' y2='204.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='505.65' y='187.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.65' y1='191.33' x2='509.21' y2='187.77' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.65' y1='187.77' x2='509.21' y2='191.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='505.65' y='195.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.65' y1='198.88' x2='509.21' y2='195.31' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='505.65' y1='195.31' x2='509.21' y2='198.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='455.46' y='184.31' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.46' y1='187.87' x2='459.03' y2='184.31' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.46' y1='184.31' x2='459.03' y2='187.87' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='455.46' y='182.25' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.46' y1='185.81' x2='459.03' y2='182.25' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.46' y1='182.25' x2='459.03' y2='185.81' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.42' y='196.70' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.42' y1='200.26' x2='438.99' y2='196.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.42' y1='196.70' x2='438.99' y2='200.26' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='435.42' y='191.21' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.42' y1='194.77' x2='438.99' y2='191.21' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='435.42' y1='191.21' x2='438.99' y2='194.77' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='424.27' y='195.78' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.27' y1='199.35' x2='427.83' y2='195.78' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.27' y1='195.78' x2='427.83' y2='199.35' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='424.27' y='207.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.27' y1='211.01' x2='427.83' y2='207.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='424.27' y1='207.44' x2='427.83' y2='211.01' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.18' y1='176.10' x2='686.75' y2='172.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.18' y1='172.53' x2='686.75' y2='176.10' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.45' y1='174.31' x2='687.49' y2='174.31' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.97' y1='176.83' x2='684.97' y2='171.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.18' y1='247.44' x2='686.75' y2='243.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.18' y1='243.88' x2='686.75' y2='247.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='682.45' y1='245.66' x2='687.49' y2='245.66' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.97' y1='248.18' x2='684.97' y2='243.14' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.71' y1='227.34' x2='669.27' y2='223.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.71' y1='223.78' x2='669.27' y2='227.34' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.97' y1='225.56' x2='670.01' y2='225.56' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.49' y1='228.08' x2='667.49' y2='223.04' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.71' y1='158.06' x2='669.27' y2='154.49' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='665.71' y1='154.49' x2='669.27' y2='158.06' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.97' y1='156.28' x2='670.01' y2='156.28' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='667.49' y1='158.80' x2='667.49' y2='153.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.82' y1='216.33' x2='639.39' y2='212.77' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.82' y1='212.77' x2='639.39' y2='216.33' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.09' y1='214.55' x2='640.13' y2='214.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.61' y1='217.07' x2='637.61' y2='212.03' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.82' y1='145.68' x2='639.39' y2='142.11' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.82' y1='142.11' x2='639.39' y2='145.68' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.09' y1='143.89' x2='640.13' y2='143.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.61' y1='146.41' x2='637.61' y2='141.37' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.73' y1='218.91' x2='595.29' y2='215.34' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.73' y1='215.34' x2='595.29' y2='218.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='590.99' y1='217.12' x2='596.03' y2='217.12' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='593.51' y1='219.64' x2='593.51' y2='214.60' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.73' y1='196.27' x2='595.29' y2='192.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='591.73' y1='192.70' x2='595.29' y2='196.27' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='590.99' y1='194.49' x2='596.03' y2='194.49' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='593.51' y1='197.01' x2='593.51' y2='191.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.17' y1='176.44' x2='549.73' y2='172.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.17' y1='172.88' x2='549.73' y2='176.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.43' y1='174.66' x2='550.47' y2='174.66' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.95' y1='177.18' x2='547.95' y2='172.14' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.17' y1='200.45' x2='549.73' y2='196.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='546.17' y1='196.89' x2='549.73' y2='200.45' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='545.43' y1='198.67' x2='550.47' y2='198.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='547.95' y1='201.19' x2='547.95' y2='196.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.83' y1='193.19' x2='510.39' y2='189.62' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.83' y1='189.62' x2='510.39' y2='193.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.09' y1='191.40' x2='511.13' y2='191.40' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='508.61' y1='193.93' x2='508.61' y2='188.88' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.83' y1='204.85' x2='510.39' y2='201.28' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.83' y1='201.28' x2='510.39' y2='204.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='506.09' y1='203.07' x2='511.13' y2='203.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='508.61' y1='205.59' x2='508.61' y2='200.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.87' y1='193.97' x2='477.43' y2='190.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.87' y1='190.41' x2='477.43' y2='193.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.13' y1='192.19' x2='478.17' y2='192.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.65' y1='194.71' x2='475.65' y2='189.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.87' y1='198.09' x2='477.43' y2='194.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.87' y1='194.53' x2='477.43' y2='198.09' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='473.13' y1='196.31' x2='478.17' y2='196.31' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='475.65' y1='198.83' x2='475.65' y2='193.79' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.66' y1='202.48' x2='459.22' y2='198.92' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.66' y1='198.92' x2='459.22' y2='202.48' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.92' y1='200.70' x2='459.96' y2='200.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.44' y1='203.22' x2='457.44' y2='198.18' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.66' y1='201.11' x2='459.22' y2='197.54' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.66' y1='197.54' x2='459.22' y2='201.11' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.92' y1='199.33' x2='459.96' y2='199.33' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='457.44' y1='201.85' x2='457.44' y2='196.81' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.58' y1='199.50' x2='446.15' y2='195.94' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.58' y1='195.94' x2='446.15' y2='199.50' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.84' y1='197.72' x2='446.88' y2='197.72' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.36' y1='200.24' x2='444.36' y2='195.20' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.58' y1='203.62' x2='446.15' y2='200.06' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='442.58' y1='200.06' x2='446.15' y2='203.62' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='441.84' y1='201.84' x2='446.88' y2='201.84' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.36' y1='204.36' x2='444.36' y2='199.32' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.36' y1='256.88' x2='690.40' y2='256.88' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='687.88' y1='259.40' x2='687.88' y2='254.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='685.36,256.88 687.88,254.36 690.40,256.88 687.88,259.40 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.36' y1='125.86' x2='690.40' y2='125.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='687.88' y1='128.38' x2='687.88' y2='123.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='685.36,125.86 687.88,123.34 690.40,125.86 687.88,128.38 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.73' y1='207.09' x2='678.77' y2='207.09' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.25' y1='209.61' x2='676.25' y2='204.57' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.73,207.09 676.25,204.57 678.77,207.09 676.25,209.61 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='673.73' y1='246.20' x2='678.77' y2='246.20' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.25' y1='248.72' x2='676.25' y2='243.68' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='673.73,246.20 676.25,243.68 678.77,246.20 676.25,248.72 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='652.62' y1='161.78' x2='657.66' y2='161.78' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.14' y1='164.30' x2='655.14' y2='159.26' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='652.62,161.78 655.14,159.26 657.66,161.78 655.14,164.30 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='652.62' y1='201.57' x2='657.66' y2='201.57' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='655.14' y1='204.09' x2='655.14' y2='199.05' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='652.62,201.57 655.14,199.05 657.66,201.57 655.14,204.09 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='617.74' y1='209.92' x2='622.78' y2='209.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='620.26' y1='212.44' x2='620.26' y2='207.40' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.74,209.92 620.26,207.40 622.78,209.92 620.26,212.44 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='617.74' y1='181.80' x2='622.78' y2='181.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='620.26' y1='184.32' x2='620.26' y2='179.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.74,181.80 620.26,179.28 622.78,181.80 620.26,184.32 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='573.94' y1='171.96' x2='578.98' y2='171.96' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='576.46' y1='174.48' x2='576.46' y2='169.43' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='573.94,171.96 576.46,169.43 578.98,171.96 576.46,174.48 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='573.94' y1='209.00' x2='578.98' y2='209.00' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='576.46' y1='211.52' x2='576.46' y2='206.48' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='573.94,209.00 576.46,206.48 578.98,209.00 576.46,211.52 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.75' y1='196.62' x2='528.80' y2='196.62' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='526.27' y1='199.14' x2='526.27' y2='194.10' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.75,196.62 526.27,194.10 528.80,196.62 526.27,199.14 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='523.75' y1='215.14' x2='528.80' y2='215.14' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='526.27' y1='217.66' x2='526.27' y2='212.62' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='523.75,215.14 526.27,212.62 528.80,215.14 526.27,217.66 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.98' y1='192.36' x2='480.02' y2='192.36' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='477.50' y1='194.88' x2='477.50' y2='189.84' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='474.98,192.36 477.50,189.84 480.02,192.36 477.50,194.88 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='474.98' y1='198.54' x2='480.02' y2='198.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='477.50' y1='201.06' x2='477.50' y2='196.01' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='474.98,198.54 477.50,196.01 480.02,198.54 477.50,201.06 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='452.26' y1='207.34' x2='457.30' y2='207.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.78' y1='209.86' x2='454.78' y2='204.82' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='452.26,207.34 454.78,204.82 457.30,207.34 454.78,209.86 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='452.26' y1='187.45' x2='457.30' y2='187.45' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='454.78' y1='189.97' x2='454.78' y2='184.93' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='452.26,187.45 454.78,184.93 457.30,187.45 454.78,189.97 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='437.64' y1='180.80' x2='442.68' y2='180.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='440.16' y1='183.32' x2='440.16' y2='178.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='437.64,180.80 440.16,178.28 442.68,180.80 440.16,183.32 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='437.64' y1='206.18' x2='442.68' y2='206.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='440.16' y1='208.70' x2='440.16' y2='203.66' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='437.64,206.18 440.16,203.66 442.68,206.18 440.16,208.70 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='686.48' cy='200.71' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.70' y1='200.71' x2='688.27' y2='200.71' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.48' y1='202.49' x2='686.48' y2='198.92' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='686.48' cy='199.33' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='684.70' y1='199.33' x2='688.27' y2='199.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='686.48' y1='201.12' x2='686.48' y2='197.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.56' cy='203.61' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.78' y1='203.61' x2='681.34' y2='203.61' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.56' y1='205.40' x2='679.56' y2='201.83' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.56' cy='218.02' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.78' y1='218.02' x2='681.34' y2='218.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='679.56' y1='219.80' x2='679.56' y2='216.24' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='666.40' cy='191.94' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.61' y1='191.94' x2='668.18' y2='191.94' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='666.40' y1='193.72' x2='666.40' y2='190.16' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='666.40' cy='179.59' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='664.61' y1='179.59' x2='668.18' y2='179.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='666.40' y1='181.38' x2='666.40' y2='177.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='642.58' cy='148.60' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.80' y1='148.60' x2='644.36' y2='148.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='642.58' y1='150.38' x2='642.58' y2='146.82' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='642.58' cy='202.11' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='640.80' y1='202.11' x2='644.36' y2='202.11' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='642.58' y1='203.89' x2='642.58' y2='200.32' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='607.74' cy='212.40' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.96' y1='212.40' x2='609.53' y2='212.40' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.74' y1='214.18' x2='607.74' y2='210.62' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='607.74' cy='210.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='605.96' y1='210.34' x2='609.53' y2='210.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='607.74' y1='212.12' x2='607.74' y2='208.56' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='557.31' cy='174.56' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='555.53' y1='174.56' x2='559.10' y2='174.56' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.31' y1='176.34' x2='557.31' y2='172.78' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='557.31' cy='224.64' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='555.53' y1='224.64' x2='559.10' y2='224.64' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='557.31' y1='226.42' x2='557.31' y2='222.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='495.01' cy='187.01' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.22' y1='187.01' x2='496.79' y2='187.01' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='495.01' y1='188.79' x2='495.01' y2='185.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='495.01' cy='187.69' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='493.22' y1='187.69' x2='496.79' y2='187.69' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='495.01' y1='189.48' x2='495.01' y2='185.91' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='466.11' cy='216.05' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.33' y1='216.05' x2='467.89' y2='216.05' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='466.11' y1='217.83' x2='466.11' y2='214.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='466.11' cy='196.84' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='464.33' y1='196.84' x2='467.89' y2='196.84' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='466.11' y1='198.62' x2='466.11' y2='195.06' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='448.84' cy='187.21' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='447.06' y1='187.21' x2='450.62' y2='187.21' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.84' y1='189.00' x2='448.84' y2='185.43' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='448.84' cy='197.50' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='447.06' y1='197.50' x2='450.62' y2='197.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='448.84' y1='199.29' x2='448.84' y2='195.72' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.37,187.26 685.77,182.41 680.97,182.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.37,181.72 685.77,186.57 680.97,186.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.37,193.44 685.77,188.59 680.97,188.59 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='683.37,187.89 685.77,192.74 680.97,192.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.68,182.27 680.08,177.42 675.28,177.42 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.68,176.72 680.08,181.57 675.28,181.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.68,260.47 680.08,255.62 675.28,255.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.68,254.93 680.08,259.78 675.28,259.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.82,187.48 669.22,182.63 664.42,182.63 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.82,181.94 669.22,186.79 664.42,186.79 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.82,169.64 669.22,164.80 664.42,164.80 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='666.82,164.10 669.22,168.95 664.42,168.95 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.96,227.55 649.36,222.70 644.56,222.70 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.96,222.01 649.36,226.86 644.56,226.86 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.96,161.01 649.36,156.16 644.56,156.16 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='646.96,155.47 649.36,160.32 644.56,160.32 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.36,188.39 619.76,183.54 614.96,183.54 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.36,182.84 619.76,187.69 614.96,187.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.36,169.87 619.76,165.02 614.96,165.02 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='617.36,164.32 619.76,169.17 614.96,169.17 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='573.12,212.57 575.52,207.72 570.72,207.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='573.12,207.03 575.52,211.88 570.72,211.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='573.12,233.15 575.52,228.30 570.72,228.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='573.12,227.61 575.52,232.46 570.72,232.46 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.38,199.89 517.78,195.04 512.98,195.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.38,194.34 517.78,199.19 512.98,199.19 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.38,193.03 517.78,188.18 512.98,188.18 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='515.38,187.48 517.78,192.33 512.98,192.33 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.82,184.19 489.22,179.34 484.42,179.34 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.82,178.65 489.22,183.50 484.42,183.50 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.82,212.32 489.22,207.47 484.42,207.47 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='486.82,206.77 489.22,211.62 484.42,211.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.67,194.59 471.07,189.74 466.27,189.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.67,189.05 471.07,193.90 466.27,193.90 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.67,195.28 471.07,190.43 466.27,190.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='468.67,189.74 471.07,194.59 466.27,194.59 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.82' y1='142.74' x2='685.39' y2='142.74' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.60' y1='144.52' x2='683.60' y2='140.95' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='681.82' y='140.95' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='681.82' y1='206.53' x2='685.39' y2='206.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='683.60' y1='208.31' x2='683.60' y2='204.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='681.82' y='204.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.83' y1='204.82' x2='678.39' y2='204.82' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.61' y1='206.60' x2='676.61' y2='203.04' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='674.83' y='203.04' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='674.83' y1='180.81' x2='678.39' y2='180.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='676.61' y1='182.59' x2='676.61' y2='179.03' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='674.83' y='179.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.53' y1='267.56' x2='665.10' y2='267.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.31' y1='269.34' x2='663.31' y2='265.78' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='661.53' y='265.78' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='661.53' y1='183.87' x2='665.10' y2='183.87' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='663.31' y1='185.65' x2='663.31' y2='182.09' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='661.53' y='182.09' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.48' y1='154.83' x2='641.05' y2='154.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.27' y1='156.61' x2='639.27' y2='153.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='637.48' y='153.05' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='637.48' y1='219.32' x2='641.05' y2='219.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='639.27' y1='221.10' x2='639.27' y2='217.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='637.48' y='217.53' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='602.33' y1='181.69' x2='605.90' y2='181.69' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='604.11' y1='183.47' x2='604.11' y2='179.90' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='602.33' y='179.90' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='602.33' y1='193.35' x2='605.90' y2='193.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='604.11' y1='195.13' x2='604.11' y2='191.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='602.33' y='191.57' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='551.56' y1='189.30' x2='555.12' y2='189.30' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.34' y1='191.08' x2='553.34' y2='187.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='551.56' y='187.52' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='551.56' y1='197.53' x2='555.12' y2='197.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='553.34' y1='199.31' x2='553.34' y2='195.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='551.56' y='195.75' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='489.32' y1='193.35' x2='492.88' y2='193.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='491.10' y1='195.13' x2='491.10' y2='191.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='489.32' y='191.57' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='489.32' y1='191.98' x2='492.88' y2='191.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='491.10' y1='193.76' x2='491.10' y2='190.20' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='489.32' y='190.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='460.93' y1='187.50' x2='464.50' y2='187.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='462.71' y1='189.29' x2='462.71' y2='185.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='460.93' y='185.72' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='460.93' y1='207.40' x2='464.50' y2='207.40' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='462.71' y1='209.18' x2='462.71' y2='205.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='460.93' y='205.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.26' y1='200.40' x2='447.82' y2='200.40' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.04' y1='202.18' x2='446.04' y2='198.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.26' y='198.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='444.26' y1='196.28' x2='447.82' y2='196.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='446.04' y1='198.06' x2='446.04' y2='194.50' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='444.26' y='194.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='687.75' cy='186.56' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.97' y1='188.34' x2='689.53' y2='184.78' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.97' y1='184.78' x2='689.53' y2='188.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='687.75' cy='172.15' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.97' y1='173.94' x2='689.53' y2='170.37' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='685.97' y1='170.37' x2='689.53' y2='173.94' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.73' cy='199.76' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.95' y1='201.54' x2='681.51' y2='197.98' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.95' y1='197.98' x2='681.51' y2='201.54' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='679.73' cy='248.46' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.95' y1='250.25' x2='681.51' y2='246.68' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='677.95' y1='246.68' x2='681.51' y2='250.25' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='664.59' cy='186.18' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.80' y1='187.96' x2='666.37' y2='184.40' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.80' y1='184.40' x2='666.37' y2='187.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='664.59' cy='239.69' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.80' y1='241.47' x2='666.37' y2='237.90' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='662.80' y1='237.90' x2='666.37' y2='241.47' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='637.55' cy='191.36' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.77' y1='193.14' x2='639.34' y2='189.58' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.77' y1='189.58' x2='639.34' y2='193.14' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='637.55' cy='203.70' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.77' y1='205.49' x2='639.34' y2='201.92' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='635.77' y1='201.92' x2='639.34' y2='205.49' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='598.94' cy='197.37' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='597.16' y1='199.15' x2='600.72' y2='195.59' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='597.16' y1='195.59' x2='600.72' y2='199.15' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='598.94' cy='168.56' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='597.16' y1='170.34' x2='600.72' y2='166.78' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='597.16' y1='166.78' x2='600.72' y2='170.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='545.32' cy='190.83' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='192.61' x2='547.10' y2='189.05' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='189.05' x2='547.10' y2='192.61' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='545.32' cy='198.38' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='200.16' x2='547.10' y2='196.60' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='543.54' y1='196.60' x2='547.10' y2='200.16' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='483.60' cy='178.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.82' y1='180.27' x2='485.38' y2='176.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.82' y1='176.71' x2='485.38' y2='180.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='483.60' cy='195.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.82' y1='197.42' x2='485.38' y2='193.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='481.82' y1='193.86' x2='485.38' y2='197.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='456.83' cy='181.63' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.05' y1='183.41' x2='458.62' y2='179.85' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.05' y1='179.85' x2='458.62' y2='183.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='456.83' cy='209.07' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.05' y1='210.85' x2='458.62' y2='207.29' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='455.05' y1='207.29' x2='458.62' y2='210.85' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='441.37' cy='202.47' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.59' y1='204.25' x2='443.15' y2='200.68' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.59' y1='200.68' x2='443.15' y2='204.25' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<circle cx='441.37' cy='208.64' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.59' y1='210.42' x2='443.15' y2='206.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<line x1='439.59' y1='206.86' x2='443.15' y2='210.42' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.80,217.58 689.58,221.14 686.02,221.14 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='686.02' y='217.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.80,189.45 689.58,193.01 686.02,193.01 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='686.02' y='189.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.41,198.30 679.19,201.86 675.62,201.86 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.62' y='198.30' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='677.41,242.20 679.19,245.77 675.62,245.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='675.62' y='242.20' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='658.33,179.46 660.12,183.02 656.55,183.02 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='656.55' y='179.46' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='658.33,161.62 660.12,165.18 656.55,165.18 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='656.55' y='161.62' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='626.11,194.18 627.89,197.74 624.33,197.74 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='624.33' y='194.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='626.11,198.30 627.89,201.86 624.33,201.86 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='624.33' y='198.30' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='584.18,167.33 585.96,170.89 582.40,170.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='582.40' y='167.33' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='584.18,205.74 585.96,209.31 582.40,209.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='582.40' y='205.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='533.65,204.52 535.43,208.09 531.87,208.09 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='531.87' y='204.52' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='533.65,216.87 535.43,220.44 531.87,220.44 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='531.87' y='216.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='482.86,192.29 484.64,195.86 481.07,195.86 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='481.07' y='192.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='482.86,188.86 484.64,192.43 481.07,192.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='481.07' y='188.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='459.54,188.87 461.32,192.43 457.75,192.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='457.75' y='188.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='459.54,203.28 461.32,206.84 457.75,206.84 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='457.75' y='203.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='444.41,186.90 446.19,190.47 442.63,190.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='442.63' y='186.90' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='444.41,188.28 446.19,191.84 442.63,191.84 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<rect x='442.63' y='188.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,221.16 690.67,221.16 690.67,217.60 687.11,217.60 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='687.11,228.71 690.67,228.71 690.67,225.14 687.11,225.14 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.43,209.89 678.99,209.89 678.99,206.33 675.43,206.33 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='675.43,198.23 678.99,198.23 678.99,194.67 675.43,194.67 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.38,182.97 657.94,182.97 657.94,179.41 654.38,179.41 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='654.38,209.04 657.94,209.04 657.94,205.48 654.38,205.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.99,198.30 623.55,198.30 623.55,194.74 619.99,194.74 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='619.99,189.39 623.55,189.39 623.55,185.82 619.99,185.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='577.80,199.53 581.37,199.53 581.37,195.97 577.80,195.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='577.80,170.04 581.37,170.04 581.37,166.47 577.80,166.47 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.45,195.41 535.01,195.41 535.01,191.84 531.45,191.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='531.45,210.50 535.01,210.50 535.01,206.94 531.45,206.94 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='488.44,197.32 492.01,197.32 492.01,193.75 488.44,193.75 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='488.44,195.94 492.01,195.94 492.01,192.38 488.44,192.38 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='467.33,193.87 470.89,193.87 470.89,190.30 467.33,190.30 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='467.33,200.04 470.89,200.04 470.89,196.48 467.33,196.48 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='452.31,191.64 455.88,191.64 455.88,188.07 452.31,188.07 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<polygon points='452.31,212.90 455.88,212.90 455.88,209.34 452.31,209.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHwyODguODh8MTAyLjI0)' />
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<polyline points='50.12,520.49 52.44,515.59 55.81,508.79 57.09,506.29 61.50,498.06 66.38,489.56 67.19,488.22 72.87,479.19 78.56,470.90 82.64,465.38 84.25,463.29 89.94,456.31 95.63,449.89 101.32,444.00 107.01,438.58 112.70,433.61 115.16,431.58 118.39,429.04 124.08,424.84 129.77,420.99 135.46,417.44 141.15,414.19 146.83,411.20 152.52,408.46 158.21,405.94 163.90,403.64 169.59,401.52 175.28,399.59 180.97,397.82 186.66,396.20 189.50,395.44 192.35,394.72 198.04,393.38 203.73,392.16 209.42,391.05 215.11,390.04 220.79,389.14 226.48,388.32 232.17,387.59 237.86,386.94 243.55,386.36 249.24,385.85 254.93,385.41 259.20,385.12 260.62,385.03 266.31,384.70 272.00,384.42 277.69,384.20 283.38,384.02 289.07,383.88 294.76,383.79 300.44,383.73 306.13,383.71 311.82,383.72 317.51,383.77 323.20,383.84 328.89,383.94 ' style='stroke-width: 1.50;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='50.12' y1='527.53' x2='328.89' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='50.12' y1='527.53' x2='50.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='96.58' y1='527.53' x2='96.58' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='143.04' y1='527.53' x2='143.04' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='189.50' y1='527.53' x2='189.50' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='235.97' y1='527.53' x2='235.97' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='282.43' y1='527.53' x2='282.43' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='328.89' y1='527.53' x2='328.89' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='47.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='92.19' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='138.65' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='185.11' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>60</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='231.58' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>80</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='275.84' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>100</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='322.30' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='13.17px' lengthAdjust='spacingAndGlyphs'>120</text></g>
+<line x1='38.97' y1='520.49' x2='38.97' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='520.49' x2='34.21' y2='520.49' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='483.65' x2='34.21' y2='483.65' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='446.81' x2='34.21' y2='446.81' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='409.97' x2='34.21' y2='409.97' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='38.97' y1='373.13' x2='34.21' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,522.68) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,488.04) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,451.20) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,414.36) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(27.56,377.52) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<polygon points='38.97,527.53 340.04,527.53 340.04,337.35 38.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ=='>
+ <rect x='0.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text x='180.87' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='17.27px' lengthAdjust='spacingAndGlyphs'>Time</text></g>
+<g clip-path='url(#cpMC4wMHwzNjAuMDB8NTc2LjAwfDMxNy4zOQ==)'><text transform='translate(8.55,437.93) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='10.98px' lengthAdjust='spacingAndGlyphs'>m1</text></g>
+<defs>
+ <clipPath id='cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU='>
+ <rect x='38.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<circle cx='52.44' cy='511.64' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='513.49' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='498.75' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='504.28' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='486.59' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='490.65' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='459.33' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='470.01' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='433.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='432.07' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='404.81' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='401.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='408.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='388.60' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.70' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.33 55.81,506.07 57.09,503.12 61.50,493.69 66.38,484.45 67.19,483.04 72.87,473.85 78.56,465.90 82.64,460.86 84.25,459.00 89.94,453.00 95.63,447.76 101.32,443.16 107.01,439.12 112.70,435.55 115.16,434.14 118.39,432.39 124.08,429.57 129.77,427.06 135.46,424.80 141.15,422.76 146.83,420.92 152.52,419.24 158.21,417.72 163.90,416.32 169.59,415.04 175.28,413.87 180.97,412.78 186.66,411.77 189.50,411.30 192.35,410.84 198.04,409.97 203.73,409.17 209.42,408.42 215.11,407.72 220.79,407.06 226.48,406.45 232.17,405.88 237.86,405.35 243.55,404.86 249.24,404.39 254.93,403.96 259.20,403.66 260.62,403.57 266.31,403.19 272.00,402.85 277.69,402.53 283.38,402.24 289.07,401.98 294.76,401.73 300.44,401.51 306.13,401.31 311.82,401.13 317.51,400.97 323.20,400.83 328.89,400.71 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.35 54.84,521.50 50.04,521.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,510.71 54.84,514.87 50.04,514.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,503.72 59.49,507.87 54.69,507.87 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,515.61 54.69,515.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,488.24 68.78,492.40 63.98,492.40 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,492.66 68.78,496.82 63.98,496.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,464.30 85.04,468.45 80.24,468.45 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,471.66 85.04,475.82 80.24,475.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,451.03 117.56,455.19 112.76,455.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,437.03 117.56,441.19 112.76,441.19 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.19 191.90,425.35 187.10,425.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.30 187.10,428.30 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.56 261.60,411.72 256.80,411.72 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,407.19 261.60,411.35 256.80,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,417.51 331.29,421.67 326.49,421.67 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.19 331.29,411.35 326.49,411.35 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,515.97 55.81,509.78 57.09,507.53 61.50,500.18 66.38,492.72 67.19,491.56 72.87,483.82 78.56,476.87 82.64,472.32 84.25,470.62 89.94,465.00 95.63,459.93 101.32,455.37 107.01,451.26 112.70,447.55 115.16,446.06 118.39,444.20 124.08,441.17 129.77,438.44 135.46,435.96 141.15,433.71 146.83,431.68 152.52,429.83 158.21,428.16 163.90,426.64 169.59,425.25 175.28,423.99 180.97,422.85 186.66,421.81 189.50,421.32 192.35,420.86 198.04,419.99 203.73,419.20 209.42,418.49 215.11,417.83 220.79,417.24 226.48,416.70 232.17,416.21 237.86,415.76 243.55,415.36 249.24,414.99 254.93,414.66 259.20,414.44 260.62,414.37 266.31,414.10 272.00,413.86 277.69,413.65 283.38,413.47 289.07,413.31 294.76,413.17 300.44,413.05 306.13,412.95 311.82,412.87 317.51,412.81 323.20,412.76 328.89,412.73 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='513.49' x2='54.96' y2='513.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.01' x2='52.44' y2='510.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='508.33' x2='59.61' y2='508.33' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='510.85' x2='57.09' y2='505.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='512.75' x2='59.61' y2='512.75' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='515.27' x2='57.09' y2='510.23' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='483.65' x2='68.90' y2='483.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='486.17' x2='66.38' y2='481.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='486.96' x2='68.90' y2='486.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='489.48' x2='66.38' y2='484.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='469.28' x2='85.16' y2='469.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='471.80' x2='82.64' y2='466.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='462.65' x2='85.16' y2='462.65' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='465.17' x2='82.64' y2='460.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='437.96' x2='117.68' y2='437.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='440.48' x2='115.16' y2='435.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='435.39' x2='117.68' y2='435.39' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='437.91' x2='115.16' y2='432.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='404.81' x2='192.02' y2='404.81' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='407.33' x2='189.50' y2='402.29' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='387.86' x2='192.02' y2='387.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='390.38' x2='189.50' y2='385.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='386.02' x2='261.72' y2='386.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='388.54' x2='259.20' y2='383.50' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.86' x2='261.72' y2='394.86' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.38' x2='259.20' y2='392.34' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='387.49' x2='331.41' y2='387.49' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='390.01' x2='328.89' y2='384.97' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='378.28' x2='331.41' y2='378.28' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='380.80' x2='328.89' y2='375.76' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.12 55.81,510.04 57.09,507.79 61.50,500.35 66.38,492.60 67.19,491.36 72.87,483.03 78.56,475.29 82.64,470.10 84.25,468.12 89.94,461.46 95.63,455.28 101.32,449.54 107.01,444.21 112.70,439.27 115.16,437.24 118.39,434.68 124.08,430.42 129.77,426.47 135.46,422.80 141.15,419.40 146.83,416.24 152.52,413.31 158.21,410.60 163.90,408.08 169.59,405.75 175.28,403.59 180.97,401.60 186.66,399.75 189.50,398.89 192.35,398.05 198.04,396.48 203.73,395.03 209.42,393.70 215.11,392.47 220.79,391.34 226.48,390.31 232.17,389.37 237.86,388.52 243.55,387.74 249.24,387.03 254.93,386.39 259.20,385.96 260.62,385.82 266.31,385.31 272.00,384.86 277.69,384.46 283.38,384.11 289.07,383.81 294.76,383.55 300.44,383.34 306.13,383.17 311.82,383.04 317.51,382.94 323.20,382.88 328.89,382.85 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.79' x2='54.22' y2='510.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='510.23' x2='54.22' y2='513.79' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.37' x2='54.22' y2='505.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.81' x2='54.22' y2='509.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='502.37' x2='58.87' y2='498.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='498.81' x2='58.87' y2='502.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='510.11' x2='58.87' y2='506.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.55' x2='58.87' y2='510.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='484.32' x2='68.16' y2='480.76' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='480.76' x2='68.16' y2='484.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='485.43' x2='68.16' y2='481.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='481.86' x2='68.16' y2='485.43' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='452.64' x2='84.42' y2='449.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='449.08' x2='84.42' y2='452.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='468.11' x2='84.42' y2='464.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='464.55' x2='84.42' y2='468.11' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.27' x2='116.95' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='413.71' x2='116.95' y2='417.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='420.22' x2='116.95' y2='416.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.66' x2='116.95' y2='420.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='374.91' x2='191.29' y2='371.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='371.34' x2='191.29' y2='374.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='368.64' x2='191.29' y2='365.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='365.08' x2='191.29' y2='368.64' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='360.91' x2='260.98' y2='357.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='357.34' x2='260.98' y2='360.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='354.65' x2='260.98' y2='351.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='351.08' x2='260.98' y2='354.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='357.22' x2='330.67' y2='353.66' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='353.66' x2='330.67' y2='357.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='347.65' x2='330.67' y2='344.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='344.08' x2='330.67' y2='347.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.81 55.81,506.92 57.09,504.02 61.50,494.44 66.38,484.52 67.19,482.95 72.87,472.37 78.56,462.62 82.64,456.11 84.25,453.64 89.94,445.37 95.63,437.74 101.32,430.70 107.01,424.21 112.70,418.23 115.16,415.78 118.39,412.71 124.08,407.62 129.77,402.92 135.46,398.58 141.15,394.59 146.83,390.90 152.52,387.50 158.21,384.36 163.90,381.47 169.59,378.81 175.28,376.35 180.97,374.10 186.66,372.02 189.50,371.05 192.35,370.12 198.04,368.37 203.73,366.76 209.42,365.30 215.11,363.96 220.79,362.73 226.48,361.62 232.17,360.61 237.86,359.70 243.55,358.87 249.24,358.13 254.93,357.47 259.20,357.03 260.62,356.89 266.31,356.37 272.00,355.92 277.69,355.52 283.38,355.19 289.07,354.91 294.76,354.68 300.44,354.50 306.13,354.36 311.82,354.27 317.51,354.22 323.20,354.20 328.89,354.22 ' style='stroke-width: 0.75; stroke: #28E2E5; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,515.33 52.44,512.81 54.96,515.33 52.44,517.85 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,512.38 52.44,509.86 54.96,512.38 52.44,514.90 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,502.07 57.09,499.55 59.61,502.07 57.09,504.59 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,500.22 57.09,497.70 59.61,500.22 57.09,502.74 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,485.12 66.38,482.60 68.90,485.12 66.38,487.64 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,482.54 66.38,480.02 68.90,482.54 66.38,485.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,457.86 82.64,455.34 85.16,457.86 82.64,460.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,465.23 82.64,462.71 85.16,465.23 82.64,467.75 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,442.75 115.16,440.23 117.68,442.75 115.16,445.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,440.91 115.16,438.39 117.68,440.91 115.16,443.43 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,422.86 189.50,420.34 192.02,422.86 189.50,425.38 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,421.75 189.50,419.23 192.02,421.75 189.50,424.27 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,421.02 259.20,418.50 261.72,421.02 259.20,423.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,416.60 259.20,414.08 261.72,416.60 259.20,419.12 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,412.54 328.89,410.02 331.41,412.54 328.89,415.06 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,430.96 328.89,428.44 331.41,430.96 328.89,433.48 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,513.53 55.81,504.43 57.09,501.26 61.50,491.37 66.38,482.08 67.19,480.70 72.87,471.93 78.56,464.70 82.64,460.28 84.25,458.69 89.94,453.66 95.63,449.43 101.32,445.84 107.01,442.77 112.70,440.12 115.16,439.08 118.39,437.81 124.08,435.79 129.77,434.00 135.46,432.40 141.15,430.97 146.83,429.67 152.52,428.49 158.21,427.41 163.90,426.42 169.59,425.50 175.28,424.65 180.97,423.86 186.66,423.12 189.50,422.77 192.35,422.44 198.04,421.80 203.73,421.20 209.42,420.64 215.11,420.12 220.79,419.63 226.48,419.17 232.17,418.75 237.86,418.36 243.55,417.99 249.24,417.65 254.93,417.34 259.20,417.12 260.62,417.05 266.31,416.79 272.00,416.55 277.69,416.33 283.38,416.14 289.07,415.96 294.76,415.81 300.44,415.67 306.13,415.56 311.82,415.46 317.51,415.38 323.20,415.32 328.89,415.28 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.94 54.84,508.78 50.04,508.78 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.20 54.84,508.05 50.04,508.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.47 59.49,507.31 54.69,507.31 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,519.20 59.49,515.05 54.69,515.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.63 68.78,491.47 63.98,491.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,498.94 68.78,494.79 63.98,494.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,473.15 85.04,469.00 80.24,469.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,479.79 85.04,475.63 80.24,475.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,455.10 117.56,450.95 112.76,450.95 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.94 117.56,452.79 112.76,452.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,444.05 191.90,439.89 187.10,439.89 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,440.37 191.90,436.21 187.10,436.21 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,430.79 261.60,426.63 256.80,426.63 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,427.84 261.60,423.68 256.80,423.68 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,434.47 331.29,430.32 326.49,430.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,435.95 331.29,431.79 326.49,431.79 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.36 55.81,510.73 57.09,508.70 61.50,502.08 66.38,495.43 67.19,494.39 72.87,487.56 78.56,481.48 82.64,477.53 84.25,476.06 89.94,471.23 95.63,466.92 101.32,463.07 107.01,459.62 112.70,456.52 115.16,455.28 118.39,453.75 124.08,451.25 129.77,449.01 135.46,446.98 141.15,445.16 146.83,443.50 152.52,442.01 158.21,440.65 163.90,439.42 169.59,438.29 175.28,437.27 180.97,436.34 186.66,435.48 189.50,435.08 192.35,434.70 198.04,433.98 203.73,433.33 209.42,432.73 215.11,432.17 220.79,431.66 226.48,431.19 232.17,430.76 237.86,430.36 243.55,430.00 249.24,429.66 254.93,429.35 259.20,429.14 260.62,429.07 266.31,428.81 272.00,428.57 277.69,428.35 283.38,428.15 289.07,427.97 294.76,427.81 300.44,427.66 306.13,427.53 311.82,427.41 317.51,427.31 323.20,427.22 328.89,427.14 ' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='516.00' x2='54.22' y2='512.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='512.44' x2='54.22' y2='516.00' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='508.64' x2='54.22' y2='505.07' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='505.07' x2='54.22' y2='508.64' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='492.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='495.74' x2='58.87' y2='492.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='492.18' x2='58.87' y2='495.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='499.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.48' x2='58.87' y2='499.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='499.92' x2='58.87' y2='503.48' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='468.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='472.17' x2='68.16' y2='468.60' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='468.60' x2='68.16' y2='472.17' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='467.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='470.69' x2='68.16' y2='467.13' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='467.13' x2='68.16' y2='470.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='431.39' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='434.96' x2='84.42' y2='431.39' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='431.39' x2='84.42' y2='434.96' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='450.55' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='454.11' x2='84.42' y2='450.55' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='450.55' x2='84.42' y2='454.11' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='400.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='404.38' x2='116.95' y2='400.82' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='400.82' x2='116.95' y2='404.38' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='405.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='409.54' x2='116.95' y2='405.97' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='405.97' x2='116.95' y2='409.54' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='389.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='393.33' x2='191.29' y2='389.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='389.76' x2='191.29' y2='393.33' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='387.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='390.75' x2='191.29' y2='387.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='387.18' x2='191.29' y2='390.75' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='399.22' x2='260.98' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='395.66' x2='260.98' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='377.24' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='380.80' x2='260.98' y2='377.24' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='377.24' x2='260.98' y2='380.80' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='395.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='399.22' x2='330.67' y2='395.66' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='395.66' x2='330.67' y2='399.22' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='373.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='377.49' x2='330.67' y2='373.92' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='373.92' x2='330.67' y2='377.49' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.38 55.81,501.55 57.09,497.69 61.50,485.44 66.38,473.53 67.19,471.72 72.87,459.99 78.56,449.96 82.64,443.65 84.25,441.34 89.94,433.92 95.63,427.51 101.32,421.97 107.01,417.16 112.70,412.97 115.16,411.32 118.39,409.31 124.08,406.11 129.77,403.30 135.46,400.83 141.15,398.66 146.83,396.73 152.52,395.04 158.21,393.53 163.90,392.20 169.59,391.02 175.28,389.98 180.97,389.06 186.66,388.24 189.50,387.87 192.35,387.53 198.04,386.90 203.73,386.35 209.42,385.88 215.11,385.47 220.79,385.13 226.48,384.84 232.17,384.60 237.86,384.42 243.55,384.28 249.24,384.18 254.93,384.13 259.20,384.11 260.62,384.11 266.31,384.13 272.00,384.18 277.69,384.26 283.38,384.37 289.07,384.51 294.76,384.67 300.44,384.86 306.13,385.07 311.82,385.30 317.51,385.56 323.20,385.83 328.89,386.13 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='513.06' x2='54.22' y2='509.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.49' x2='54.22' y2='513.06' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='511.28' x2='54.96' y2='511.28' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.80' x2='52.44' y2='508.76' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='509.74' x2='54.22' y2='506.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='506.18' x2='54.22' y2='509.74' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='507.96' x2='54.96' y2='507.96' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='510.48' x2='52.44' y2='505.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='493.90' x2='58.87' y2='490.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='490.34' x2='58.87' y2='493.90' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='492.12' x2='59.61' y2='492.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='494.64' x2='57.09' y2='489.60' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='488.37' x2='58.87' y2='484.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='484.81' x2='58.87' y2='488.37' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='486.59' x2='59.61' y2='486.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='489.11' x2='57.09' y2='484.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='459.64' x2='68.16' y2='456.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.08' x2='68.16' y2='459.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='457.86' x2='68.90' y2='457.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='460.38' x2='66.38' y2='455.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='460.38' x2='68.16' y2='456.81' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='456.81' x2='68.16' y2='460.38' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='458.59' x2='68.90' y2='458.59' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='461.11' x2='66.38' y2='456.07' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='430.54' x2='84.42' y2='426.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='426.97' x2='84.42' y2='430.54' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='428.75' x2='85.16' y2='428.75' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.27' x2='82.64' y2='426.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='441.22' x2='84.42' y2='437.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='437.66' x2='84.42' y2='441.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='439.44' x2='85.16' y2='439.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='441.96' x2='82.64' y2='436.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='397.01' x2='116.95' y2='393.45' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='393.45' x2='116.95' y2='397.01' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='395.23' x2='117.68' y2='395.23' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='397.75' x2='115.16' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='391.49' x2='116.95' y2='387.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='387.92' x2='116.95' y2='391.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='389.70' x2='117.68' y2='389.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='392.22' x2='115.16' y2='387.18' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='377.12' x2='191.29' y2='373.55' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='373.55' x2='191.29' y2='377.12' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='375.34' x2='192.02' y2='375.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='377.86' x2='189.50' y2='372.82' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='399.22' x2='191.29' y2='395.66' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='395.66' x2='191.29' y2='399.22' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='397.44' x2='192.02' y2='397.44' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='399.96' x2='189.50' y2='394.92' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='382.64' x2='260.98' y2='379.08' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='379.08' x2='260.98' y2='382.64' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='380.86' x2='261.72' y2='380.86' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='383.38' x2='259.20' y2='378.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='396.27' x2='260.98' y2='392.71' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='392.71' x2='260.98' y2='396.27' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='394.49' x2='261.72' y2='394.49' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='397.01' x2='259.20' y2='391.97' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='374.91' x2='330.67' y2='371.34' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='371.34' x2='330.67' y2='374.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='373.13' x2='331.41' y2='373.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='375.65' x2='328.89' y2='370.61' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='393.70' x2='330.67' y2='390.13' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='390.13' x2='330.67' y2='393.70' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='391.91' x2='331.41' y2='391.91' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='394.43' x2='328.89' y2='389.39' style='stroke-width: 0.75;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,508.29 55.81,492.80 57.09,487.51 61.50,471.50 66.38,457.14 67.19,455.05 72.87,442.29 78.56,432.33 82.64,426.53 84.25,424.50 89.94,418.29 95.63,413.34 101.32,409.33 107.01,406.07 112.70,403.37 115.16,402.34 118.39,401.11 124.08,399.19 129.77,397.55 135.46,396.12 141.15,394.86 146.83,393.75 152.52,392.75 158.21,391.85 163.90,391.03 169.59,390.29 175.28,389.60 180.97,388.97 186.66,388.39 189.50,388.12 192.35,387.86 198.04,387.37 203.73,386.91 209.42,386.49 215.11,386.11 220.79,385.76 226.48,385.44 232.17,385.15 237.86,384.89 243.55,384.66 249.24,384.46 254.93,384.28 259.20,384.16 260.62,384.12 266.31,383.99 272.00,383.88 277.69,383.79 283.38,383.73 289.07,383.68 294.76,383.66 300.44,383.66 306.13,383.67 311.82,383.71 317.51,383.76 323.20,383.83 328.89,383.91 ' style='stroke-width: 0.75; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='505.38' x2='54.96' y2='505.38' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='507.90' x2='52.44' y2='502.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,505.38 52.44,502.86 54.96,505.38 52.44,507.90 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='49.92' y1='509.07' x2='54.96' y2='509.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='511.59' x2='52.44' y2='506.55' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='49.92,509.07 52.44,506.55 54.96,509.07 52.44,511.59 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='487.70' x2='59.61' y2='487.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='490.22' x2='57.09' y2='485.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,487.70 57.09,485.18 59.61,487.70 57.09,490.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='54.57' y1='493.22' x2='59.61' y2='493.22' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='495.74' x2='57.09' y2='490.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='54.57,493.22 57.09,490.70 59.61,493.22 57.09,495.74 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='461.17' x2='68.90' y2='461.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='463.69' x2='66.38' y2='458.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,461.17 66.38,458.65 68.90,461.17 66.38,463.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='63.86' y1='469.28' x2='68.90' y2='469.28' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='471.80' x2='66.38' y2='466.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='63.86,469.28 66.38,466.76 68.90,469.28 66.38,471.80 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.12' x2='85.16' y2='429.12' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='431.64' x2='82.64' y2='426.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.12 82.64,426.60 85.16,429.12 82.64,431.64 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.12' y1='429.86' x2='85.16' y2='429.86' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='432.38' x2='82.64' y2='427.34' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.12,429.86 82.64,427.34 85.16,429.86 82.64,432.38 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='391.91' x2='117.68' y2='391.91' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='394.43' x2='115.16' y2='389.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,391.91 115.16,389.39 117.68,391.91 115.16,394.43 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='112.64' y1='404.81' x2='117.68' y2='404.81' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='407.33' x2='115.16' y2='402.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='112.64,404.81 115.16,402.29 117.68,404.81 115.16,407.33 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='361.70' x2='192.02' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='364.22' x2='189.50' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,361.70 189.50,359.18 192.02,361.70 189.50,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='186.98' y1='355.44' x2='192.02' y2='355.44' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='357.96' x2='189.50' y2='352.92' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='186.98,355.44 189.50,352.92 192.02,355.44 189.50,357.96 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='361.70' x2='261.72' y2='361.70' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='364.22' x2='259.20' y2='359.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,361.70 259.20,359.18 261.72,361.70 259.20,364.22 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='256.68' y1='358.76' x2='261.72' y2='358.76' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='361.28' x2='259.20' y2='356.24' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='256.68,358.76 259.20,356.24 261.72,358.76 259.20,361.28 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='344.39' x2='331.41' y2='344.39' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='346.91' x2='328.89' y2='341.87' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,344.39 328.89,341.87 331.41,344.39 328.89,346.91 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='326.37' y1='353.23' x2='331.41' y2='353.23' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='355.75' x2='328.89' y2='350.71' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='326.37,353.23 328.89,350.71 331.41,353.23 328.89,355.75 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,511.04 55.81,498.44 57.09,493.96 61.50,479.74 66.38,465.95 67.19,463.85 72.87,450.30 78.56,438.71 82.64,431.42 84.25,428.76 89.94,420.18 95.63,412.77 101.32,406.34 107.01,400.73 112.70,395.81 115.16,393.87 118.39,391.49 124.08,387.67 129.77,384.29 135.46,381.27 141.15,378.58 146.83,376.16 152.52,373.98 158.21,372.01 163.90,370.22 169.59,368.60 175.28,367.12 180.97,365.77 186.66,364.53 189.50,363.96 192.35,363.40 198.04,362.37 203.73,361.42 209.42,360.56 215.11,359.77 220.79,359.04 226.48,358.38 232.17,357.78 237.86,357.24 243.55,356.75 249.24,356.31 254.93,355.91 259.20,355.65 260.62,355.56 266.31,355.26 272.00,354.99 277.69,354.76 283.38,354.57 289.07,354.42 294.76,354.30 300.44,354.21 306.13,354.15 311.82,354.12 317.51,354.12 323.20,354.15 328.89,354.21 ' style='stroke-width: 0.75; stroke: #DF536B; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='514.59' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='514.59' x2='54.22' y2='514.59' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='516.37' x2='52.44' y2='512.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='517.17' x2='54.22' y2='517.17' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='518.95' x2='52.44' y2='515.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='507.22' x2='58.87' y2='507.22' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='509.01' x2='57.09' y2='505.44' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='503.91' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.91' x2='58.87' y2='503.91' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='505.69' x2='57.09' y2='502.13' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='483.28' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='483.28' x2='68.16' y2='483.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='485.06' x2='66.38' y2='481.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='479.96' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='479.96' x2='68.16' y2='479.96' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='481.74' x2='66.38' y2='478.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='456.02' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='456.02' x2='84.42' y2='456.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='457.80' x2='82.64' y2='454.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='457.86' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='457.86' x2='84.42' y2='457.86' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='459.64' x2='82.64' y2='456.08' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='416.60' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='416.60' x2='116.95' y2='416.60' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='418.38' x2='115.16' y2='414.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='417.33' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='417.33' x2='116.95' y2='417.33' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='419.12' x2='115.16' y2='415.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='383.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='383.81' x2='191.29' y2='383.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='385.59' x2='189.50' y2='382.03' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='391.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='391.18' x2='191.29' y2='391.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='392.96' x2='189.50' y2='389.39' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='368.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='368.34' x2='260.98' y2='368.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='370.12' x2='259.20' y2='366.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='361.34' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='361.34' x2='260.98' y2='361.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='363.12' x2='259.20' y2='359.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='355.07' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='355.07' x2='330.67' y2='355.07' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='356.86' x2='328.89' y2='353.29' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='349.55' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='349.55' x2='330.67' y2='349.55' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='351.33' x2='328.89' y2='347.77' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,514.95 55.81,507.28 57.09,504.46 61.50,495.19 66.38,485.62 67.19,484.11 72.87,473.96 78.56,464.65 82.64,458.45 84.25,456.11 89.94,448.27 95.63,441.06 101.32,434.45 107.01,428.36 112.70,422.76 115.16,420.48 118.39,417.61 124.08,412.87 129.77,408.50 135.46,404.48 141.15,400.76 146.83,397.34 152.52,394.18 158.21,391.27 163.90,388.58 169.59,386.10 175.28,383.80 180.97,381.69 186.66,379.74 189.50,378.82 192.35,377.93 198.04,376.27 203.73,374.73 209.42,373.32 215.11,372.02 220.79,370.82 226.48,369.71 232.17,368.70 237.86,367.77 243.55,366.92 249.24,366.14 254.93,365.43 259.20,364.94 260.62,364.78 266.31,364.20 272.00,363.67 277.69,363.19 283.38,362.77 289.07,362.39 294.76,362.06 300.44,361.77 306.13,361.52 311.82,361.30 317.51,361.13 323.20,360.99 328.89,360.87 ' style='stroke-width: 0.75; stroke: #61D04F; stroke-dasharray: 7.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,518.10 54.84,513.25 50.04,513.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.56 54.84,517.41 50.04,517.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,517.36 54.84,512.51 50.04,512.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,511.82 54.84,516.67 50.04,516.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,516.99 59.49,512.14 54.69,512.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,511.45 59.49,516.30 54.69,516.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,509.99 59.49,505.14 54.69,505.14 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,504.45 59.49,509.30 54.69,509.30 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,501.52 68.78,496.67 63.98,496.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,495.98 68.78,500.83 63.98,500.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,503.36 68.78,498.51 63.98,498.51 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,497.82 68.78,502.67 63.98,502.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,480.89 85.04,476.04 80.24,476.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,475.35 85.04,480.20 80.24,480.20 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,487.52 85.04,482.67 80.24,482.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,481.98 85.04,486.83 80.24,486.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,461.73 117.56,456.88 112.76,456.88 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,456.19 117.56,461.04 112.76,461.04 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,449.21 117.56,444.36 112.76,444.36 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,443.67 117.56,448.52 112.76,448.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,421.95 191.90,417.10 187.10,417.10 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,416.40 191.90,421.25 187.10,421.25 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,429.68 191.90,424.83 187.10,424.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,424.14 191.90,428.99 187.10,428.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,425.63 261.60,420.78 256.80,420.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.09 261.60,424.94 256.80,424.94 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,426.37 261.60,421.52 256.80,421.52 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,420.83 261.60,425.67 256.80,425.67 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,409.42 331.29,404.57 326.49,404.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,403.88 331.29,408.73 326.49,408.73 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,413.47 331.29,408.62 326.49,408.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,407.93 331.29,412.78 326.49,412.78 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,517.02 55.81,512.19 57.09,510.41 61.50,504.53 66.38,498.42 67.19,497.45 72.87,490.92 78.56,484.87 82.64,480.82 84.25,479.28 89.94,474.12 95.63,469.33 101.32,464.90 107.01,460.81 112.70,457.01 115.16,455.45 118.39,453.49 124.08,450.23 129.77,447.20 135.46,444.40 141.15,441.79 146.83,439.38 152.52,437.14 158.21,435.05 163.90,433.12 169.59,431.32 175.28,429.65 180.97,428.10 186.66,426.66 189.50,425.98 192.35,425.32 198.04,424.08 203.73,422.92 209.42,421.84 215.11,420.85 220.79,419.92 226.48,419.06 232.17,418.26 237.86,417.52 243.55,416.83 249.24,416.20 254.93,415.61 259.20,415.20 260.62,415.07 266.31,414.57 272.00,414.11 277.69,413.69 283.38,413.30 289.07,412.94 294.76,412.62 300.44,412.32 306.13,412.06 311.82,411.82 317.51,411.60 323.20,411.41 328.89,411.24 ' style='stroke-width: 0.75; stroke: #2297E6; stroke-dasharray: 2.00,2.00,6.00,2.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='519.38' x2='54.22' y2='519.38' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='521.16' x2='52.44' y2='517.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='517.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='511.28' x2='54.22' y2='511.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='52.44' y1='513.06' x2='52.44' y2='509.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='506.85' x2='58.87' y2='506.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='508.64' x2='57.09' y2='505.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='505.07' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.75' x2='58.87' y2='505.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='57.09' y1='507.53' x2='57.09' y2='503.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='503.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.70' x2='68.16' y2='494.70' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='496.48' x2='66.38' y2='492.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='492.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='497.28' x2='68.16' y2='497.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='66.38' y1='499.06' x2='66.38' y2='495.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='495.49' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.91' x2='84.42' y2='475.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='477.69' x2='82.64' y2='474.13' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='474.13' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='478.49' x2='84.42' y2='478.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='82.64' y1='480.27' x2='82.64' y2='476.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='476.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.44' x2='116.95' y2='453.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.22' x2='115.16' y2='451.65' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='451.65' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.81' x2='116.95' y2='453.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='115.16' y1='455.59' x2='115.16' y2='452.02' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='452.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='415.49' x2='191.29' y2='415.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='417.27' x2='189.50' y2='413.71' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='413.71' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.75' x2='191.29' y2='421.75' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='189.50' y1='423.54' x2='189.50' y2='419.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='419.97' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.86' x2='260.98' y2='401.86' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='403.64' x2='259.20' y2='400.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='400.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='414.39' x2='260.98' y2='414.39' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='259.20' y1='416.17' x2='259.20' y2='412.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='412.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='394.12' x2='330.67' y2='394.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='395.91' x2='328.89' y2='392.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='409.23' x2='330.67' y2='409.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='328.89' y1='411.01' x2='328.89' y2='407.45' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='407.45' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.43 55.81,510.82 57.09,508.76 61.50,501.97 66.38,494.97 67.19,493.87 72.87,486.45 78.56,479.65 82.64,475.12 84.25,473.41 89.94,467.70 95.63,462.45 101.32,457.63 107.01,453.21 112.70,449.15 115.16,447.49 118.39,445.41 124.08,441.98 129.77,438.82 135.46,435.92 141.15,433.25 146.83,430.79 152.52,428.53 158.21,426.44 163.90,424.52 169.59,422.76 175.28,421.13 180.97,419.64 186.66,418.26 189.50,417.62 192.35,417.00 198.04,415.83 203.73,414.77 209.42,413.79 215.11,412.89 220.79,412.07 226.48,411.32 232.17,410.63 237.86,410.00 243.55,409.44 249.24,408.92 254.93,408.46 259.20,408.14 260.62,408.04 266.31,407.67 272.00,407.34 277.69,407.04 283.38,406.78 289.07,406.56 294.76,406.37 300.44,406.21 306.13,406.08 311.82,405.97 317.51,405.89 323.20,405.84 328.89,405.81 ' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='517.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.95' x2='54.22' y2='515.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='515.39' x2='54.22' y2='518.95' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='52.44' cy='520.12' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='521.90' x2='54.22' y2='518.34' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='50.66' y1='518.34' x2='54.22' y2='521.90' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='507.22' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='509.01' x2='58.87' y2='505.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='505.44' x2='58.87' y2='509.01' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='57.09' cy='502.07' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='503.85' x2='58.87' y2='500.28' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='55.30' y1='500.28' x2='58.87' y2='503.85' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='492.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.27' x2='68.16' y2='490.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='490.71' x2='68.16' y2='494.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='66.38' cy='496.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='498.32' x2='68.16' y2='494.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='64.60' y1='494.76' x2='68.16' y2='498.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='477.75' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='479.53' x2='84.42' y2='475.97' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='475.97' x2='84.42' y2='479.53' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='82.64' cy='472.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='474.38' x2='84.42' y2='470.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='80.86' y1='470.81' x2='84.42' y2='474.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='443.49' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='445.27' x2='116.95' y2='441.71' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='441.71' x2='116.95' y2='445.27' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='115.16' cy='451.59' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='453.38' x2='116.95' y2='449.81' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='113.38' y1='449.81' x2='116.95' y2='453.38' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='419.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='421.33' x2='191.29' y2='417.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='417.76' x2='191.29' y2='421.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='189.50' cy='406.65' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='408.43' x2='191.29' y2='404.87' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='187.72' y1='404.87' x2='191.29' y2='408.43' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='419.91' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='421.69' x2='260.98' y2='418.13' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='418.13' x2='260.98' y2='421.69' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='259.20' cy='400.02' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='401.80' x2='260.98' y2='398.24' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='257.42' y1='398.24' x2='260.98' y2='401.80' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='405.54' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='407.33' x2='330.67' y2='403.76' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='403.76' x2='330.67' y2='407.33' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<circle cx='328.89' cy='403.33' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='405.12' x2='330.67' y2='401.55' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<line x1='327.11' y1='401.55' x2='330.67' y2='405.12' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,516.00 55.81,509.82 57.09,507.56 61.50,500.16 66.38,492.60 67.19,491.42 72.87,483.50 78.56,476.31 82.64,471.58 84.25,469.80 89.94,463.88 95.63,458.51 101.32,453.63 107.01,449.19 112.70,445.15 115.16,443.51 118.39,441.47 124.08,438.12 129.77,435.07 135.46,432.29 141.15,429.76 146.83,427.44 152.52,425.33 158.21,423.41 163.90,421.65 169.59,420.05 175.28,418.59 180.97,417.25 186.66,416.04 189.50,415.47 192.35,414.93 198.04,413.92 203.73,413.00 209.42,412.17 215.11,411.42 220.79,410.73 226.48,410.12 232.17,409.56 237.86,409.06 243.55,408.62 249.24,408.22 254.93,407.87 259.20,407.63 260.62,407.56 266.31,407.29 272.00,407.07 277.69,406.87 283.38,406.71 289.07,406.58 294.76,406.48 300.44,406.40 306.13,406.35 311.82,406.33 317.51,406.33 323.20,406.35 328.89,406.39 ' style='stroke-width: 0.75; stroke: #CD0BBC; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,512.44 54.22,516.00 50.66,516.00 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='512.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='52.44,509.86 54.22,513.43 50.66,513.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='50.66' y='509.86' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,497.34 58.87,500.90 55.30,500.90 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='497.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='57.09,498.81 58.87,502.37 55.30,502.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='55.30' y='498.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,485.18 68.16,488.74 64.60,488.74 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='485.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='66.38,471.92 68.16,475.48 64.60,475.48 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='64.60' y='471.92' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,446.87 84.42,450.43 80.86,450.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='446.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='82.64,451.29 84.42,454.85 80.86,454.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='80.86' y='451.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,431.02 116.95,434.59 113.38,434.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='431.02' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='115.16,421.08 116.95,424.64 113.38,424.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='113.38' y='421.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,397.50 191.29,401.06 187.72,401.06 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='397.50' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='189.50,386.82 191.29,390.38 187.72,390.38 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='187.72' y='386.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,399.34 260.98,402.91 257.42,402.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='399.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='259.20,383.87 260.98,387.43 257.42,387.43 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='257.42' y='383.87' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,396.03 330.67,399.59 327.11,399.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='396.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='328.89,392.34 330.67,395.91 327.11,395.91 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<rect x='327.11' y='392.34' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,513.75 55.81,504.69 57.09,501.45 61.50,491.06 66.38,480.83 67.19,479.26 72.87,469.04 78.56,460.15 82.64,454.50 84.25,452.41 89.94,445.66 95.63,439.74 101.32,434.55 107.01,429.98 112.70,425.95 115.16,424.35 118.39,422.38 124.08,419.21 129.77,416.38 135.46,413.86 141.15,411.60 146.83,409.57 152.52,407.74 158.21,406.10 163.90,404.60 169.59,403.25 175.28,402.02 180.97,400.91 186.66,399.89 189.50,399.42 192.35,398.96 198.04,398.12 203.73,397.35 209.42,396.64 215.11,396.00 220.79,395.42 226.48,394.89 232.17,394.41 237.86,393.98 243.55,393.59 249.24,393.24 254.93,392.93 259.20,392.71 260.62,392.65 266.31,392.41 272.00,392.20 277.69,392.02 283.38,391.87 289.07,391.74 294.76,391.65 300.44,391.58 306.13,391.53 311.82,391.51 317.51,391.51 323.20,391.53 328.89,391.57 ' style='stroke-width: 0.75; stroke: #F5C710; stroke-dasharray: 1.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,513.06 54.22,513.06 54.22,509.49 50.66,509.49 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='50.66,514.90 54.22,514.90 54.22,511.34 50.66,511.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,501.64 58.87,501.64 58.87,498.07 55.30,498.07 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='55.30,499.43 58.87,499.43 58.87,495.86 55.30,495.86 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,486.90 68.16,486.90 68.16,483.34 64.60,483.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='64.60,472.90 68.16,472.90 68.16,469.34 64.60,469.34 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,462.22 84.42,462.22 84.42,458.65 80.86,458.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='80.86,455.22 84.42,455.22 84.42,451.65 80.86,451.65 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,427.59 116.95,427.59 116.95,424.02 113.38,424.02 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='113.38,428.33 116.95,428.33 116.95,424.76 113.38,424.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,400.33 191.29,400.33 191.29,396.76 187.72,396.76 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='187.72,399.96 191.29,399.96 191.29,396.39 187.72,396.39 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,390.38 260.98,390.38 260.98,386.82 257.42,386.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='257.42,396.27 260.98,396.27 260.98,392.71 257.42,392.71 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,383.38 330.67,383.38 330.67,379.82 327.11,379.82 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polygon points='327.11,402.54 330.67,402.54 330.67,398.97 327.11,398.97 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<polyline points='50.12,520.49 52.44,512.82 55.81,502.64 57.09,499.04 61.50,487.66 66.38,476.72 67.19,475.06 72.87,464.43 78.56,455.44 82.64,449.85 84.25,447.81 89.94,441.31 95.63,435.75 101.32,430.99 107.01,426.88 112.70,423.32 115.16,421.92 118.39,420.22 124.08,417.51 129.77,415.13 135.46,413.02 141.15,411.15 146.83,409.49 152.52,407.99 158.21,406.64 163.90,405.42 169.59,404.31 175.28,403.30 180.97,402.37 186.66,401.52 189.50,401.13 192.35,400.74 198.04,400.02 203.73,399.35 209.42,398.74 215.11,398.17 220.79,397.64 226.48,397.15 232.17,396.70 237.86,396.28 243.55,395.89 249.24,395.54 254.93,395.21 259.20,394.98 260.62,394.91 266.31,394.64 272.00,394.39 277.69,394.16 283.38,393.96 289.07,393.78 294.76,393.62 300.44,393.49 306.13,393.37 311.82,393.27 317.51,393.19 323.20,393.13 328.89,393.08 ' style='stroke-width: 0.75; stroke: #9E9E9E; stroke-dasharray: 1.00,3.00,4.00,3.00;' clip-path='url(#cpMzguOTd8MzQwLjA0fDUyNy41M3wzMzcuMzU=)' />
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<defs>
+ <clipPath id='cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA='>
+ <rect x='0.00' y='0.00' width='720.00' height='576.00' />
+ </clipPath>
+</defs>
+<line x1='410.12' y1='527.53' x2='657.05' y2='527.53' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='410.12' y1='527.53' x2='410.12' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='471.85' y1='527.53' x2='471.85' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='533.58' y1='527.53' x2='533.58' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='595.32' y1='527.53' x2='595.32' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='657.05' y1='527.53' x2='657.05' y2='532.28' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='407.92' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='467.46' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>10</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='529.19' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>20</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='590.93' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>30</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text x='652.66' y='544.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='8.78px' lengthAdjust='spacingAndGlyphs'>40</text></g>
+<line x1='398.97' y1='509.30' x2='398.97' y2='355.58' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='509.30' x2='394.21' y2='509.30' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='470.87' x2='394.21' y2='470.87' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='432.44' x2='394.21' y2='432.44' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='394.01' x2='394.21' y2='394.01' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<line x1='398.97' y1='355.58' x2='394.21' y2='355.58' style='stroke-width: 0.75;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,512.81) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-4</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,474.38) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='7.03px' lengthAdjust='spacingAndGlyphs'>-2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,434.63) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>0</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,396.20) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>2</text></g>
+<g clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)'><text transform='translate(387.56,357.77) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='4.39px' lengthAdjust='spacingAndGlyphs'>4</text></g>
+<polygon points='398.97,527.53 700.04,527.53 700.04,337.35 398.97,337.35 ' style='stroke-width: 0.75; fill: none;' clip-path='url(#cpMC4wMHw3MjAuMDB8NTc2LjAwfDAuMDA=)' />
+<defs>
+ <clipPath id='cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5'>
+ <rect x='360.00' y='317.39' width='360.00' height='258.61' />
+ </clipPath>
+</defs>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text x='532.82' y='563.64' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='33.38px' lengthAdjust='spacingAndGlyphs'>Predicted</text></g>
+<g clip-path='url(#cpMzYwLjAwfDcyMC4wMHw1NzYuMDB8MzE3LjM5)'><text transform='translate(368.55,470.64) rotate(-90)' style='font-size: 7.92px; font-family: Liberation Sans;' textLength='76.41px' lengthAdjust='spacingAndGlyphs'>Standardized residual</text></g>
+<defs>
+ <clipPath id='cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1'>
+ <rect x='398.97' y='337.35' width='301.08' height='190.18' />
+ </clipPath>
+</defs>
+<line x1='398.97' y1='432.44' x2='700.04' y2='432.44' style='stroke-width: 0.75; stroke-dasharray: 4.00,4.00;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='420.43' cy='437.53' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='420.43' cy='434.04' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='439.22' cy='440.73' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='439.22' cy='430.24' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='470.50' cy='428.38' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='470.50' cy='420.69' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='510.03' cy='435.34' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='510.03' cy='415.07' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='554.81' cy='432.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='554.81' cy='436.36' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='593.08' cy='444.75' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='593.08' cy='416.09' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='605.88' cy='435.86' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='605.88' cy='422.57' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='610.82' cy='455.43' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='610.82' cy='426.77' r='1.78pt' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.68,421.80 420.08,425.96 415.28,425.96 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.68,434.38 420.08,438.54 415.28,438.54 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='431.83,431.64 434.23,435.80 429.43,435.80 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='431.83,416.96 434.23,421.12 429.43,421.12 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='456.64,432.91 459.04,437.07 454.24,437.07 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='456.64,424.52 459.04,428.68 454.24,428.68 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='490.82,439.64 493.22,443.80 488.42,443.80 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='490.82,425.66 493.22,429.82 488.42,429.82 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='534.84,414.97 537.24,419.12 532.44,419.12 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='534.84,441.53 537.24,445.69 532.44,445.69 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='576.29,424.65 578.69,428.81 573.89,428.81 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='576.29,419.06 578.69,423.21 573.89,423.21 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='587.82,437.45 590.22,441.61 585.42,441.61 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='587.82,438.15 590.22,442.31 585.42,442.31 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='590.68,415.34 593.08,419.50 588.28,419.50 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='590.68,434.92 593.08,439.07 588.28,439.07 ' style='stroke-width: 0.75; stroke: #61D04F; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='414.91' y1='437.44' x2='419.95' y2='437.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.43' y1='439.96' x2='417.43' y2='434.92' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.86' y1='431.42' x2='433.90' y2='431.42' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='431.38' y1='433.94' x2='431.38' y2='428.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.86' y1='423.04' x2='433.90' y2='423.04' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='431.38' y1='425.56' x2='431.38' y2='420.52' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.33' y1='449.42' x2='459.37' y2='449.42' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='456.85' y1='451.94' x2='456.85' y2='446.90' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.33' y1='443.13' x2='459.37' y2='443.13' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='456.85' y1='445.65' x2='456.85' y2='440.61' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='492.03' y1='433.99' x2='497.07' y2='433.99' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='494.55' y1='436.51' x2='494.55' y2='431.47' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='492.03' y1='446.57' x2='497.07' y2='446.57' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='494.55' y1='449.09' x2='494.55' y2='444.05' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='547.09' y1='431.06' x2='552.13' y2='431.06' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='549.61' y1='433.58' x2='549.61' y2='428.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='547.09' y1='435.96' x2='552.13' y2='435.96' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='549.61' y1='438.48' x2='549.61' y2='433.44' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='611.36' y1='421.20' x2='616.40' y2='421.20' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='613.88' y1='423.72' x2='613.88' y2='418.68' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='611.36' y1='453.36' x2='616.40' y2='453.36' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='613.88' y1='455.88' x2='613.88' y2='450.84' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.03' y1='432.32' x2='638.07' y2='432.32' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.55' y1='434.84' x2='635.55' y2='429.80' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.03' y1='415.54' x2='638.07' y2='415.54' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='635.55' y1='418.06' x2='635.55' y2='413.02' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.23' y1='423.63' x2='643.27' y2='423.63' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='640.75' y1='426.15' x2='640.75' y2='421.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.23' y1='441.11' x2='643.27' y2='441.11' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='640.75' y1='443.63' x2='640.75' y2='438.59' style='stroke-width: 0.75; stroke: #2297E6;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.84' y1='439.53' x2='421.41' y2='435.97' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.84' y1='435.97' x2='421.41' y2='439.53' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.84' y1='447.92' x2='421.41' y2='444.35' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.84' y1='444.35' x2='421.41' y2='447.92' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.92' y1='440.73' x2='439.48' y2='437.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.92' y1='437.17' x2='439.48' y2='440.73' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.92' y1='426.05' x2='439.48' y2='422.49' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.92' y1='422.49' x2='439.48' y2='426.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.60' y1='437.98' x2='472.16' y2='434.42' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.60' y1='434.42' x2='472.16' y2='437.98' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.60' y1='435.88' x2='472.16' y2='432.32' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.60' y1='432.32' x2='472.16' y2='435.88' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='516.20' y1='444.19' x2='519.77' y2='440.63' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='516.20' y1='440.63' x2='519.77' y2='444.19' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='516.20' y1='414.83' x2='519.77' y2='411.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='516.20' y1='411.27' x2='519.77' y2='414.83' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.79' y1='434.77' x2='587.35' y2='431.21' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.79' y1='431.21' x2='587.35' y2='434.77' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.79' y1='429.18' x2='587.35' y2='425.62' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='583.79' y1='425.62' x2='587.35' y2='429.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='658.75' y1='430.28' x2='662.31' y2='426.72' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='658.75' y1='426.72' x2='662.31' y2='430.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='658.75' y1='442.16' x2='662.31' y2='438.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='658.75' y1='438.60' x2='662.31' y2='442.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='682.25' y1='430.23' x2='685.81' y2='426.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='682.25' y1='426.67' x2='685.81' y2='430.23' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='682.25' y1='442.12' x2='685.81' y2='438.55' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='682.25' y1='438.55' x2='685.81' y2='442.12' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.94' y1='431.91' x2='690.50' y2='428.34' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.94' y1='428.34' x2='690.50' y2='431.91' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.94' y1='450.08' x2='690.50' y2='446.52' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.94' y1='446.52' x2='690.50' y2='450.08' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='419.26,429.02 421.78,426.50 424.30,429.02 421.78,431.54 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='419.26,434.61 421.78,432.09 424.30,434.61 421.78,437.13 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='439.82,430.90 442.34,428.38 444.86,430.90 442.34,433.42 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='439.82,434.40 442.34,431.88 444.86,434.40 442.34,436.92 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='471.95,426.68 474.47,424.16 476.99,426.68 474.47,429.20 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='471.95,431.57 474.47,429.05 476.99,431.57 474.47,434.09 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='508.48,437.04 511.00,434.52 513.52,437.04 511.00,439.56 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='508.48,423.06 511.00,420.54 513.52,423.06 511.00,425.58 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='544.00,425.47 546.52,422.95 549.05,425.47 546.52,427.99 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='544.00,428.97 546.52,426.45 549.05,428.97 546.52,431.49 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.33,432.28 573.85,429.76 576.37,432.28 573.85,434.80 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.33,434.37 573.85,431.85 576.37,434.37 573.85,436.89 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='580.81,425.04 583.33,422.52 585.85,425.04 583.33,427.56 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='580.81,433.43 583.33,430.91 585.85,433.43 583.33,435.95 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='583.89,437.63 586.41,435.11 588.93,437.63 586.41,440.15 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='583.89,402.68 586.41,400.15 588.93,402.68 586.41,405.20 ' style='stroke-width: 0.75; stroke: #CD0BBC; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.03,446.96 419.43,442.80 414.63,442.80 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='417.03,448.36 419.43,444.20 414.63,444.20 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.87,435.21 432.27,431.05 427.47,431.05 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='429.87,420.53 432.27,416.37 427.47,416.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='452.11,440.09 454.51,435.93 449.71,435.93 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='452.11,433.80 454.51,429.64 449.71,429.64 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='482.09,448.78 484.49,444.62 479.69,444.62 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='482.09,436.20 484.49,432.04 479.69,432.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.38,440.81 521.78,436.65 516.98,436.65 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.38,437.32 521.78,433.16 516.98,433.16 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='553.23,423.45 555.63,419.29 550.83,419.29 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='553.23,430.44 555.63,426.28 550.83,426.28 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.19,437.33 565.59,433.17 560.79,433.17 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='563.19,442.92 565.59,438.77 560.79,438.77 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='566.53,426.56 568.93,422.40 564.13,422.40 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='566.53,423.76 568.93,419.61 564.13,419.61 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.92' y='427.15' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.92' y1='430.72' x2='425.49' y2='427.15' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.92' y1='427.15' x2='425.49' y2='430.72' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='421.92' y='441.14' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.92' y1='444.70' x2='425.49' y2='441.14' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='421.92' y1='441.14' x2='425.49' y2='444.70' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='446.53' y='437.74' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='446.53' y1='441.30' x2='450.09' y2='437.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='446.53' y1='437.74' x2='450.09' y2='441.30' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='446.53' y='423.06' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='446.53' y1='426.62' x2='450.09' y2='423.06' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='446.53' y1='423.06' x2='450.09' y2='426.62' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='487.01' y='436.63' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.01' y1='440.20' x2='490.58' y2='436.63' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.01' y1='436.63' x2='490.58' y2='440.20' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='487.01' y='439.43' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.01' y1='442.99' x2='490.58' y2='439.43' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='487.01' y1='439.43' x2='490.58' y2='442.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='537.09' y='450.53' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.09' y1='454.09' x2='540.66' y2='450.53' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.09' y1='450.53' x2='540.66' y2='454.09' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='537.09' y='414.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.09' y1='417.74' x2='540.66' y2='414.18' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.09' y1='414.18' x2='540.66' y2='417.74' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='591.26' y='447.21' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='591.26' y1='450.77' x2='594.83' y2='447.21' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='591.26' y1='447.21' x2='594.83' y2='450.77' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='591.26' y='437.42' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='591.26' y1='440.99' x2='594.83' y2='437.42' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='591.26' y1='437.42' x2='594.83' y2='440.99' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='630.56' y='423.69' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.56' y1='427.25' x2='634.12' y2='423.69' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.56' y1='423.69' x2='634.12' y2='427.25' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='630.56' y='428.58' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.56' y1='432.14' x2='634.12' y2='428.58' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.56' y1='428.58' x2='634.12' y2='432.14' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='636.86' y='405.36' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.86' y1='408.93' x2='640.42' y2='405.36' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.86' y1='405.36' x2='640.42' y2='408.93' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='636.86' y='440.32' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.86' y1='443.88' x2='640.42' y2='440.32' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.86' y1='440.32' x2='640.42' y2='443.88' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='633.48' y='409.19' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.48' y1='412.76' x2='637.04' y2='409.19' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.48' y1='409.19' x2='637.04' y2='412.76' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='633.48' y='450.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.48' y1='454.00' x2='637.04' y2='450.44' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='633.48' y1='450.44' x2='637.04' y2='454.00' style='stroke-width: 0.75; stroke: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='428.56' x2='432.33' y2='424.99' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='424.99' x2='432.33' y2='428.56' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='426.78' x2='433.07' y2='426.78' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='430.55' y1='429.30' x2='430.55' y2='424.26' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='434.85' x2='432.33' y2='431.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.77' y1='431.29' x2='432.33' y2='434.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='428.03' y1='433.07' x2='433.07' y2='433.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='430.55' y1='435.59' x2='430.55' y2='430.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.59' y1='425.48' x2='467.15' y2='421.92' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.59' y1='421.92' x2='467.15' y2='425.48' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='462.85' y1='423.70' x2='467.89' y2='423.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='465.37' y1='426.22' x2='465.37' y2='421.18' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.59' y1='435.97' x2='467.15' y2='432.40' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='463.59' y1='432.40' x2='467.15' y2='435.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='462.85' y1='434.19' x2='467.89' y2='434.19' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='465.37' y1='436.71' x2='465.37' y2='431.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.49' y1='432.85' x2='518.05' y2='429.29' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.49' y1='429.29' x2='518.05' y2='432.85' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.75' y1='431.07' x2='518.79' y2='431.07' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='516.27' y1='433.59' x2='516.27' y2='428.55' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.49' y1='431.46' x2='518.05' y2='427.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.49' y1='427.89' x2='518.05' y2='431.46' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='513.75' y1='429.67' x2='518.79' y2='429.67' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='516.27' y1='432.19' x2='516.27' y2='427.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='565.78' y1='430.00' x2='569.34' y2='426.44' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='565.78' y1='426.44' x2='569.34' y2='430.00' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='565.04' y1='428.22' x2='570.08' y2='428.22' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='567.56' y1='430.74' x2='567.56' y2='425.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='565.78' y1='409.73' x2='569.34' y2='406.16' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='565.78' y1='406.16' x2='569.34' y2='409.73' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='565.04' y1='407.95' x2='570.08' y2='407.95' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='567.56' y1='410.47' x2='567.56' y2='405.43' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='606.31' y1='447.71' x2='609.88' y2='444.15' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='606.31' y1='444.15' x2='609.88' y2='447.71' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='605.58' y1='445.93' x2='610.62' y2='445.93' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='608.10' y1='448.45' x2='608.10' y2='443.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='606.31' y1='458.20' x2='609.88' y2='454.63' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='606.31' y1='454.63' x2='609.88' y2='458.20' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='605.58' y1='456.41' x2='610.62' y2='456.41' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='608.10' y1='458.93' x2='608.10' y2='453.89' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.14' y1='458.48' x2='633.70' y2='454.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.14' y1='454.91' x2='633.70' y2='458.48' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.40' y1='456.70' x2='634.44' y2='456.70' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.92' y1='459.22' x2='631.92' y2='454.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.14' y1='416.53' x2='633.70' y2='412.97' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='630.14' y1='412.97' x2='633.70' y2='416.53' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='629.40' y1='414.75' x2='634.44' y2='414.75' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='631.92' y1='417.27' x2='631.92' y2='412.23' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.78' y1='440.47' x2='640.35' y2='436.91' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.78' y1='436.91' x2='640.35' y2='440.47' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.04' y1='438.69' x2='641.08' y2='438.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.56' y1='441.21' x2='638.56' y2='436.17' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.78' y1='414.61' x2='640.35' y2='411.04' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.78' y1='411.04' x2='640.35' y2='414.61' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.04' y1='412.82' x2='641.08' y2='412.82' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.56' y1='415.34' x2='638.56' y2='410.30' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.19' y1='454.69' x2='640.76' y2='451.12' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.19' y1='451.12' x2='640.76' y2='454.69' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.45' y1='452.90' x2='641.49' y2='452.90' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.97' y1='455.42' x2='638.97' y2='450.38' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.19' y1='419.04' x2='640.76' y2='415.47' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='637.19' y1='415.47' x2='640.76' y2='419.04' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='636.45' y1='417.25' x2='641.49' y2='417.25' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='638.97' y1='419.77' x2='638.97' y2='414.73' style='stroke-width: 0.75;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='423.43' y1='443.17' x2='428.47' y2='443.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='425.95' y1='445.69' x2='425.95' y2='440.65' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='423.43,443.17 425.95,440.65 428.47,443.17 425.95,445.69 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='423.43' y1='436.18' x2='428.47' y2='436.18' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='425.95' y1='438.70' x2='425.95' y2='433.66' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='423.43,436.18 425.95,433.66 428.47,436.18 425.95,438.70 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.05' y1='444.32' x2='457.09' y2='444.32' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.57' y1='446.84' x2='454.57' y2='441.80' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='452.05,444.32 454.57,441.80 457.09,444.32 454.57,446.84 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.05' y1='433.83' x2='457.09' y2='433.83' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='454.57' y1='436.35' x2='454.57' y2='431.31' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='452.05,433.83 454.57,431.31 457.09,433.83 454.57,436.35 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='498.99' y1='441.50' x2='504.03' y2='441.50' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='501.51' y1='444.02' x2='501.51' y2='438.98' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='498.99,441.50 501.51,438.98 504.03,441.50 501.51,444.02 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='498.99' y1='426.12' x2='504.03' y2='426.12' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='501.51' y1='428.64' x2='501.51' y2='423.60' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='498.99,426.12 501.51,423.60 504.03,426.12 501.51,428.64 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='556.84' y1='436.81' x2='561.88' y2='436.81' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='559.36' y1='439.33' x2='559.36' y2='434.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='556.84,436.81 559.36,434.29 561.88,436.81 559.36,439.33 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='556.84' y1='435.41' x2='561.88' y2='435.41' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='559.36' y1='437.93' x2='559.36' y2='432.89' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='556.84,435.41 559.36,432.89 561.88,435.41 559.36,437.93 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='619.76' y1='436.15' x2='624.80' y2='436.15' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='622.28' y1='438.67' x2='622.28' y2='433.63' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='619.76,436.15 622.28,433.63 624.80,436.15 622.28,438.67 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='619.76' y1='411.69' x2='624.80' y2='411.69' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='622.28' y1='414.21' x2='622.28' y2='409.17' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='619.76,411.69 622.28,409.17 624.80,411.69 622.28,414.21 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='669.89' y1='436.71' x2='674.93' y2='436.71' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='672.41' y1='439.23' x2='672.41' y2='434.19' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='669.89,436.71 672.41,434.19 674.93,436.71 672.41,439.23 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='669.89' y1='448.59' x2='674.93' y2='448.59' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='672.41' y1='451.11' x2='672.41' y2='446.07' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='669.89,448.59 672.41,446.07 674.93,448.59 672.41,451.11 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='683.82' y1='420.94' x2='688.86' y2='420.94' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.34' y1='423.46' x2='686.34' y2='418.42' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='683.82,420.94 686.34,418.42 688.86,420.94 686.34,423.46 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='683.82' y1='426.54' x2='688.86' y2='426.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.34' y1='429.06' x2='686.34' y2='424.02' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='683.82,426.54 686.34,424.02 688.86,426.54 686.34,429.06 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.23' y1='451.06' x2='691.27' y2='451.06' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='688.75' y1='453.58' x2='688.75' y2='448.54' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='686.23,451.06 688.75,448.54 691.27,451.06 688.75,453.58 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='686.23' y1='434.29' x2='691.27' y2='434.29' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='688.75' y1='436.81' x2='688.75' y2='431.77' style='stroke-width: 0.75; stroke: #DF536B;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='686.23,434.29 688.75,431.77 691.27,434.29 688.75,436.81 ' style='stroke-width: 0.75; stroke: #DF536B; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.39' cy='433.12' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.61' y1='433.12' x2='421.17' y2='433.12' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.39' y1='434.90' x2='419.39' y2='431.34' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='419.39' cy='428.23' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='417.61' y1='428.23' x2='421.17' y2='428.23' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='419.39' y1='430.01' x2='419.39' y2='426.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='436.96' cy='427.20' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.18' y1='427.20' x2='438.75' y2='427.20' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='436.96' y1='428.99' x2='436.96' y2='425.42' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='436.96' cy='433.50' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='435.18' y1='433.50' x2='438.75' y2='433.50' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='436.96' y1='435.28' x2='436.96' y2='431.71' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='468.54' cy='436.89' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.76' y1='436.89' x2='470.32' y2='436.89' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.54' y1='438.67' x2='468.54' y2='435.10' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='468.54' cy='443.18' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='466.76' y1='443.18' x2='470.32' y2='443.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='468.54' y1='444.96' x2='468.54' y2='441.40' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='514.07' cy='437.06' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.28' y1='437.06' x2='515.85' y2='437.06' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.07' y1='438.84' x2='514.07' y2='435.28' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='514.07' cy='433.57' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='512.28' y1='433.57' x2='515.85' y2='433.57' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='514.07' y1='435.35' x2='514.07' y2='431.79' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='577.70' cy='439.81' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='575.91' y1='439.81' x2='579.48' y2='439.81' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.70' y1='441.59' x2='577.70' y2='438.02' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='577.70' cy='438.41' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='575.91' y1='438.41' x2='579.48' y2='438.41' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='577.70' y1='440.19' x2='577.70' y2='436.63' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='647.51' cy='422.96' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='645.73' y1='422.96' x2='649.30' y2='422.96' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='647.51' y1='424.74' x2='647.51' y2='421.18' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='647.51' cy='408.98' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='645.73' y1='408.98' x2='649.30' y2='408.98' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='647.51' y1='410.76' x2='647.51' y2='407.20' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='670.77' cy='425.99' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='668.99' y1='425.99' x2='672.55' y2='425.99' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='670.77' y1='427.77' x2='670.77' y2='424.21' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='670.77' cy='439.27' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='668.99' y1='439.27' x2='672.55' y2='439.27' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='670.77' y1='441.05' x2='670.77' y2='437.49' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='677.58' cy='443.45' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.79' y1='443.45' x2='679.36' y2='443.45' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='677.58' y1='445.23' x2='677.58' y2='441.66' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='677.58' cy='453.93' r='1.78pt' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='675.79' y1='453.93' x2='679.36' y2='453.93' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='677.58' y1='455.71' x2='677.58' y2='452.15' style='stroke-width: 0.75; stroke: #61D04F;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.93,438.42 418.33,433.57 413.53,433.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.93,432.87 418.33,437.72 413.53,437.72 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.93,439.81 418.33,434.96 413.53,434.96 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='415.93,434.27 418.33,439.12 413.53,439.12 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.00,427.98 429.40,423.13 424.60,423.13 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.00,422.44 429.40,427.29 424.60,427.29 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.00,441.26 429.40,436.41 424.60,436.41 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='427.00,435.72 429.40,440.57 424.60,440.57 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.09,434.59 449.49,429.74 444.69,429.74 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.09,429.04 449.49,433.89 444.69,433.89 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.09,431.09 449.49,426.24 444.69,426.24 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='447.09,425.55 449.49,430.40 444.69,430.40 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.58,440.34 478.98,435.49 474.18,435.49 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.58,434.80 478.98,439.65 474.18,439.65 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.58,427.76 478.98,422.91 474.18,422.91 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.58,422.21 478.98,427.06 474.18,427.06 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.10,428.54 521.50,423.69 516.70,423.69 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.10,423.00 521.50,427.85 516.70,427.85 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.10,452.31 521.50,447.46 516.70,447.46 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='519.10,446.77 521.50,451.62 516.70,451.62 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='568.48,448.12 570.88,443.27 566.08,443.27 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='568.48,442.58 570.88,447.43 566.08,447.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='568.48,433.44 570.88,428.59 566.08,428.59 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='568.48,427.90 570.88,432.75 566.08,432.75 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='586.54,420.68 588.94,415.83 584.14,415.83 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='586.54,415.14 588.94,419.99 584.14,419.99 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='586.54,419.28 588.94,414.43 584.14,414.43 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='586.54,413.74 588.94,418.59 584.14,418.59 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.18,443.92 595.58,439.07 590.78,439.07 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.18,438.38 595.58,443.23 590.78,443.23 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.18,436.23 595.58,431.39 590.78,431.39 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='593.18,430.69 595.58,435.54 590.78,435.54 ' style='stroke-width: 0.75; stroke: #2297E6; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.13' y1='426.85' x2='418.69' y2='426.85' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.91' y1='428.63' x2='416.91' y2='425.06' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='415.13' y='425.06' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.13' y1='442.22' x2='418.69' y2='442.22' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='416.91' y1='444.01' x2='416.91' y2='440.44' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='415.13' y='440.44' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.99' y1='436.05' x2='431.55' y2='436.05' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.77' y1='437.83' x2='429.77' y2='434.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='427.99' y='434.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='427.99' y1='438.14' x2='431.55' y2='438.14' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.77' y1='439.93' x2='429.77' y2='436.36' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='427.99' y='436.36' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.09' y1='432.96' x2='454.65' y2='432.96' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.87' y1='434.74' x2='452.87' y2='431.18' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='451.09' y='431.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='451.09' y1='428.07' x2='454.65' y2='428.07' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='452.87' y1='429.85' x2='452.87' y2='426.28' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='451.09' y='426.28' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.35' y1='430.95' x2='487.91' y2='430.95' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='486.13' y1='432.73' x2='486.13' y2='429.17' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='484.35' y='429.17' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='484.35' y1='426.06' x2='487.91' y2='426.06' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='486.13' y1='427.84' x2='486.13' y2='424.27' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='484.35' y='424.27' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='530.65' y1='421.16' x2='534.22' y2='421.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='532.43' y1='422.94' x2='532.43' y2='419.37' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='530.65' y='419.37' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='530.65' y1='420.46' x2='534.22' y2='420.46' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='532.43' y1='422.24' x2='532.43' y2='418.67' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='530.65' y='418.67' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='580.71' y1='436.47' x2='584.28' y2='436.47' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='582.49' y1='438.25' x2='582.49' y2='434.69' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='580.71' y='434.69' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='580.71' y1='424.59' x2='584.28' y2='424.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='582.49' y1='426.37' x2='582.49' y2='422.80' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='580.71' y='422.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='596.59' y1='444.36' x2='600.15' y2='444.36' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='598.37' y1='446.14' x2='598.37' y2='442.57' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='596.59' y='442.57' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='596.59' y1='420.59' x2='600.15' y2='420.59' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='598.37' y1='422.37' x2='598.37' y2='418.81' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='596.59' y='418.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.50' y1='454.60' x2='604.07' y2='454.60' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.29' y1='456.39' x2='602.29' y2='452.82' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='600.50' y='452.82' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='600.50' y1='425.94' x2='604.07' y2='425.94' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='602.29' y1='427.72' x2='602.29' y2='424.16' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='600.50' y='424.16' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #28E2E5;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='417.63' cy='430.22' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.85' y1='432.00' x2='419.42' y2='428.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.85' y1='428.44' x2='419.42' y2='432.00' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='417.63' cy='424.63' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.85' y1='426.41' x2='419.42' y2='422.84' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='415.85' y1='422.84' x2='419.42' y2='426.41' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='431.78' cy='433.08' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.99' y1='434.86' x2='433.56' y2='431.30' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.99' y1='431.30' x2='433.56' y2='434.86' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='431.78' cy='442.86' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.99' y1='444.65' x2='433.56' y2='441.08' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='429.99' y1='441.08' x2='433.56' y2='444.65' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='456.84' cy='432.66' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.06' y1='434.44' x2='458.62' y2='430.88' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.06' y1='430.88' x2='458.62' y2='434.44' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='456.84' cy='424.97' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.06' y1='426.75' x2='458.62' y2='423.19' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='455.06' y1='423.19' x2='458.62' y2='426.75' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='492.07' cy='420.72' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='490.29' y1='422.51' x2='493.85' y2='418.94' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='490.29' y1='418.94' x2='493.85' y2='422.51' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='492.07' cy='430.51' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='490.29' y1='432.29' x2='493.85' y2='428.73' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='490.29' y1='428.73' x2='493.85' y2='432.29' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='539.10' cy='432.48' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.32' y1='434.26' x2='540.88' y2='430.70' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.32' y1='430.70' x2='540.88' y2='434.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='539.10' cy='417.10' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.32' y1='418.88' x2='540.88' y2='415.32' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='537.32' y1='415.32' x2='540.88' y2='418.88' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='586.09' cy='424.71' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='584.31' y1='426.49' x2='587.87' y2='422.93' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='584.31' y1='422.93' x2='587.87' y2='426.49' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='586.09' cy='449.17' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='584.31' y1='450.96' x2='587.87' y2='447.39' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='584.31' y1='447.39' x2='587.87' y2='450.96' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='599.22' cy='409.14' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.44' y1='410.92' x2='601.00' y2='407.36' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.44' y1='407.36' x2='601.00' y2='410.92' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='599.22' cy='446.89' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.44' y1='448.67' x2='601.00' y2='445.11' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='597.44' y1='445.11' x2='601.00' y2='448.67' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='601.30' cy='434.05' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.52' y1='435.83' x2='603.09' y2='432.26' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.52' y1='432.26' x2='603.09' y2='435.83' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<circle cx='601.30' cy='438.24' r='1.78pt' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.52' y1='440.02' x2='603.09' y2='436.46' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<line x1='599.52' y1='436.46' x2='603.09' y2='440.02' style='stroke-width: 0.75; stroke: #CD0BBC;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.40,429.77 423.18,433.33 419.61,433.33 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='419.61' y='429.77' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.40,434.66 423.18,438.22 419.61,438.22 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='419.61' y='434.66' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='442.01,435.08 443.80,438.65 440.23,438.65 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='440.23' y='435.08' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='442.01,432.29 443.80,435.85 440.23,435.85 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='440.23' y='432.29' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.56,419.03 478.34,422.59 474.78,422.59 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='474.78' y='419.03' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='476.56,444.19 478.34,447.76 474.78,447.76 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='474.78' y='444.19' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='520.69,441.76 522.47,445.32 518.91,445.32 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='518.91' y='441.76' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='520.69,433.37 522.47,436.93 518.91,436.93 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='518.91' y='433.37' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.22,414.60 573.00,418.17 569.43,418.17 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='569.43' y='414.60' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='571.22,433.48 573.00,437.04 569.43,437.04 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='569.43' y='433.48' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.99,430.91 614.78,434.47 611.21,434.47 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='611.21' y='430.91' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='612.99,451.18 614.78,454.75 611.21,454.75 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='611.21' y='451.18' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='624.22,414.70 626.00,418.26 622.44,418.26 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='622.44' y='414.70' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='624.22,444.06 626.00,447.62 622.44,447.62 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='622.44' y='444.06' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='626.15,418.81 627.93,422.38 624.36,422.38 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='624.36' y='418.81' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='626.15,425.80 627.93,429.37 624.36,429.37 ' style='stroke-width: 0.75; stroke: #F5C710; fill: none;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<rect x='624.36' y='425.80' width='3.56' height='3.56' style='stroke-width: 0.75; stroke: #F5C710;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.18,437.15 424.75,437.15 424.75,433.58 421.18,433.58 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='421.18,433.65 424.75,433.65 424.75,430.09 421.18,430.09 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='444.27,432.67 447.83,432.67 447.83,429.11 444.27,429.11 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='444.27,436.87 447.83,436.87 447.83,433.31 444.27,433.31 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='481.68,418.28 485.24,418.28 485.24,414.72 481.68,414.72 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='481.68,444.84 485.24,444.84 485.24,441.28 481.68,441.28 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='526.71,414.12 530.27,414.12 530.27,410.56 526.71,410.56 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='526.71,427.41 530.27,427.41 530.27,423.84 526.71,423.84 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='573.50,426.85 577.06,426.85 577.06,423.28 573.50,423.28 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='573.50,425.45 577.06,425.45 577.06,421.88 573.50,421.88 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='608.35,439.12 611.91,439.12 611.91,435.55 608.35,435.55 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='608.35,439.82 611.91,439.82 611.91,436.25 608.35,436.25 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.64,446.33 622.21,446.33 622.21,442.77 618.64,442.77 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='618.64,435.15 622.21,435.15 622.21,431.58 618.64,431.58 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='621.82,456.01 625.39,456.01 625.39,452.45 621.82,452.45 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+<polygon points='621.82,419.66 625.39,419.66 625.39,416.10 621.82,416.10 ' style='stroke-width: 0.75; stroke: none; fill: #9E9E9E;' clip-path='url(#cpMzk4Ljk3fDcwMC4wNHw1MjcuNTN8MzM3LjM1)' />
+</svg>
diff --git a/tests/testthat/setup_script.R b/tests/testthat/setup_script.R
index 8d8ba3e9..9ec91425 100644
--- a/tests/testthat/setup_script.R
+++ b/tests/testthat/setup_script.R
@@ -100,3 +100,67 @@ fit_obs_1 <- mkinfit(m_synth_SFO_lin, SFO_lin_a, error_model = "obs", quiet = TR
# We know threestep is OK, and threestep (and IRLS) is faster here
fit_tc_1 <- mkinfit(m_synth_SFO_lin, SFO_lin_a, error_model = "tc", quiet = TRUE,
error_model_algorithm = "threestep")
+
+# Mixed models data
+set.seed(123456)
+sampling_times = c(0, 1, 3, 7, 14, 28, 60, 90, 120)
+n <- n_biphasic <- 15
+log_sd <- 0.3
+err_1 = list(const = 1, prop = 0.05)
+tc <- function(value) sigma_twocomp(value, err_1$const, err_1$prop)
+const <- function(value) 2
+
+SFO <- mkinmod(parent = mkinsub("SFO"))
+k_parent = rlnorm(n, log(0.03), log_sd)
+ds_sfo <- lapply(1:n, function(i) {
+ ds_mean <- mkinpredict(SFO, c(k_parent = k_parent[i]),
+ c(parent = 100), sampling_times)
+ add_err(ds_mean, tc, n = 1)[[1]]
+})
+
+DFOP <- mkinmod(parent = mkinsub("DFOP"))
+dfop_pop <- list(parent_0 = 100, k1 = 0.06, k2 = 0.015, g = 0.4)
+dfop_parms <- as.matrix(data.frame(
+ k1 = rlnorm(n, log(dfop_pop$k1), log_sd),
+ k2 = rlnorm(n, log(dfop_pop$k2), log_sd),
+ g = plogis(rnorm(n, qlogis(dfop_pop$g), log_sd))))
+ds_dfop <- lapply(1:n, function(i) {
+ ds_mean <- mkinpredict(DFOP, dfop_parms[i, ],
+ c(parent = dfop_pop$parent_0), sampling_times)
+ add_err(ds_mean, const, n = 1)[[1]]
+})
+
+set.seed(123456)
+DFOP_SFO <- mkinmod(
+ parent = mkinsub("DFOP", "m1"),
+ m1 = mkinsub("SFO"),
+ quiet = TRUE)
+dfop_sfo_pop <- list(parent_0 = 100,
+ k_m1 = 0.002, f_parent_to_m1 = 0.5,
+ k1 = 0.05, k2 = 0.01, g = 0.5)
+syn_biphasic_parms <- as.matrix(data.frame(
+ k1 = rlnorm(n_biphasic, log(dfop_sfo_pop$k1), log_sd),
+ k2 = rlnorm(n_biphasic, log(dfop_sfo_pop$k2), log_sd),
+ g = plogis(rnorm(n_biphasic, qlogis(dfop_sfo_pop$g), log_sd)),
+ f_parent_to_m1 = plogis(rnorm(n_biphasic,
+ qlogis(dfop_sfo_pop$f_parent_to_m1), log_sd)),
+ k_m1 = rlnorm(n_biphasic, log(dfop_sfo_pop$k_m1), log_sd)))
+ds_biphasic_mean <- lapply(1:n_biphasic,
+ function(i) {
+ mkinpredict(DFOP_SFO, syn_biphasic_parms[i, ],
+ c(parent = 100, m1 = 0), sampling_times)
+ }
+)
+ds_biphasic <- lapply(ds_biphasic_mean, function(ds) {
+ add_err(ds,
+ sdfunc = function(value) sqrt(err_1$const^2 + value^2 * err_1$prop^2),
+ n = 1, secondary = "m1")[[1]]
+})
+
+# Mixed model fits
+mmkin_sfo_1 <- mmkin("SFO", ds_sfo, quiet = TRUE, error_model = "tc")
+sfo_saemix_1 <- saem(mmkin_sfo_1, quiet = TRUE, transformations = "saemix")
+mmkin_biphasic <- mmkin(list("DFOP-SFO" = DFOP_SFO), ds_biphasic, quiet = TRUE)
+nlme_biphasic <- nlme(mmkin_biphasic)
+saem_biphasic_m <- saem(mmkin_biphasic, transformations = "mkin", quiet = TRUE)
+saem_biphasic_s <- saem(mmkin_biphasic, transformations = "saemix", quiet = TRUE)
diff --git a/tests/testthat/test_AIC.R b/tests/testthat/test_AIC.R
index e9698f7c..57b9a673 100644
--- a/tests/testthat/test_AIC.R
+++ b/tests/testthat/test_AIC.R
@@ -6,6 +6,7 @@ test_that("The AIC is reproducible", {
data.frame(df = c(3, 4, 5, 5), AIC = c(59.3, 44.7, 29.0, 39.2)),
scale = 1, tolerance = 0.1)
expect_error(AIC(fits["SFO", ]), "column object")
+ expect_error(BIC(fits["SFO", ]), "column object")
expect_equivalent(BIC(fits[, "FOCUS_C"]),
data.frame(df = c(3, 4, 5, 5), AIC = c(59.9, 45.5, 30.0, 40.2)),
scale = 1, tolerance = 0.1)
diff --git a/tests/testthat/test_confidence.R b/tests/testthat/test_confidence.R
index 3fdd3f2c..54be675c 100644
--- a/tests/testthat/test_confidence.R
+++ b/tests/testthat/test_confidence.R
@@ -1,7 +1,20 @@
context("Confidence intervals and p-values")
+test_that("Some special cases of confidence interval calculation work", {
+
+ tmp <- expect_warning(mkinfit("FOMC", FOCUS_2006_A, quiet = TRUE), "not converge")
+
+ expect_equivalent(
+ confint(tmp, transform = FALSE),
+ matrix(rep(NA, 8), nrow = 4))
+})
+
test_that("The confint method 'quadratic' is consistent with the summary", {
expect_equivalent(
+ confint(fit_nw_1, parm = "parent_0", method = "quadratic"),
+ summary(fit_nw_1)$bpar["parent_0", c("Lower", "Upper")])
+
+ expect_equivalent(
confint(fit_nw_1, method = "quadratic"),
summary(fit_nw_1)$bpar[, c("Lower", "Upper")])
@@ -74,8 +87,8 @@ test_that("Likelihood profile based confidence intervals work", {
}
f_mle <- stats4::mle(f_nll, start = as.list(parms(f)), nobs = nrow(FOCUS_2006_C))
- ci_mkin_1_p_0.95 <- confint(f, method = "profile", level = 0.95,
- cores = n_cores, quiet = TRUE)
+ ci_mkin_1_p_0.95 <- expect_message(confint(f, method = "profile", level = 0.95,
+ cores = n_cores, quiet = FALSE), "Profiling the likelihood")
# Magically, we get very similar boundaries as stats4::mle
# (we need to capture the output to avoid printing this while testing as
diff --git a/tests/testthat/test_mixed.R b/tests/testthat/test_mixed.R
new file mode 100644
index 00000000..2d69e13e
--- /dev/null
+++ b/tests/testthat/test_mixed.R
@@ -0,0 +1,35 @@
+context("Fitting of nonlinear mixed effects models")
+
+sampling_times = c(0, 1, 3, 7, 14, 28, 60, 90, 120)
+n_biphasic <- 8
+err_1 = list(const = 1, prop = 0.07)
+
+DFOP_SFO <- mkinmod(
+ parent = mkinsub("DFOP", "m1"),
+ m1 = mkinsub("SFO"),
+ quiet = TRUE)
+
+set.seed(123456)
+log_sd <- 0.3
+syn_biphasic_parms <- as.matrix(data.frame(
+ k1 = rlnorm(n_biphasic, log(0.05), log_sd),
+ k2 = rlnorm(n_biphasic, log(0.01), log_sd),
+ g = plogis(rnorm(n_biphasic, 0, log_sd)),
+ f_parent_to_m1 = plogis(rnorm(n_biphasic, 0, log_sd)),
+ k_m1 = rlnorm(n_biphasic, log(0.002), log_sd)))
+
+ds_biphasic_mean <- lapply(1:n_biphasic,
+ function(i) {
+ mkinpredict(DFOP_SFO, syn_biphasic_parms[i, ],
+ c(parent = 100, m1 = 0), sampling_times)
+ }
+)
+
+set.seed(123456L)
+ds_biphasic <- lapply(ds_biphasic_mean, function(ds) {
+ add_err(ds,
+ sdfunc = function(value) sqrt(err_1$const^2 + value^2 * err_1$prop^2),
+ n = 1, secondary = "m1")[[1]]
+})
+
+f_mmkin <- mmkin(list("DFOP-SFO" = DFOP_SFO), ds_biphasic, quiet = TRUE)
diff --git a/tests/testthat/test_nafta.R b/tests/testthat/test_nafta.R
index fcab4ffb..62c88983 100644
--- a/tests/testthat/test_nafta.R
+++ b/tests/testthat/test_nafta.R
@@ -20,7 +20,6 @@ test_that("Test data from Appendix B are correctly evaluated", {
expect_known_output(print(res), "NAFTA_SOP_Appendix_B.txt")
- skip_on_travis()
plot_nafta <- function() plot(res)
if(requireNamespace("vdiffr", quietly = TRUE)) {
skip_if(getRversion() < "4.1.0")
@@ -49,7 +48,6 @@ test_that("Test data from Appendix D are correctly evaluated", {
expect_known_output(print(res), "NAFTA_SOP_Appendix_D.txt")
- skip_on_travis()
plot_nafta <- function() plot(res)
if(requireNamespace("vdiffr", quietly = TRUE)) {
skip_if(getRversion() < "4.1.0")
diff --git a/tests/testthat/test_plot.R b/tests/testthat/test_plot.R
index 587ec02e..72f1020c 100644
--- a/tests/testthat/test_plot.R
+++ b/tests/testthat/test_plot.R
@@ -2,7 +2,6 @@ context("Plotting")
test_that("Plotting mkinfit and mmkin objects is reproducible", {
skip_on_cran()
- skip_on_travis()
plot_default_FOCUS_C_SFO <- function() plot(fits[["SFO", "FOCUS_C"]])
plot_res_FOCUS_C_SFO <- function() plot(fits[["SFO", "FOCUS_C"]], show_residuals = TRUE)
plot_res_FOCUS_C_SFO_2 <- function() plot_res(fits[["SFO", "FOCUS_C"]])
@@ -17,6 +16,11 @@ test_that("Plotting mkinfit and mmkin objects is reproducible", {
plot_errmod_fit_D_obs_eigen <- function() plot_err(fit_D_obs_eigen, sep_obs = FALSE)
plot_errmod_fit_C_tc <- function() plot_err(fit_C_tc)
+ plot_biphasic_mmkin <- function() plot(mixed(mmkin_biphasic))
+ plot_biphasic_nlme <- function() plot(nlme_biphasic)
+ plot_biphasic_saem_s <- function() plot(saem_biphasic_s)
+ plot_biphasic_saem_m <- function() plot(saem_biphasic_m)
+
plot_res_sfo_sfo <- function() plot_res(f_sfo_sfo_desolve)
plot_err_sfo_sfo <- function() plot_err(f_sfo_sfo_desolve)
plot_errmod_fit_obs_1 <- function() plot_err(fit_obs_1, sep_obs = FALSE)
@@ -32,6 +36,10 @@ test_that("Plotting mkinfit and mmkin objects is reproducible", {
vdiffr::expect_doppelganger("mmkin plot for FOCUS C", mmkin_FOCUS_C)
vdiffr::expect_doppelganger("mmkin plot for SFO (FOCUS C and D)", mmkin_SFO)
vdiffr::expect_doppelganger("plot_errmod with FOCUS C tc", plot_errmod_fit_C_tc)
+ vdiffr::expect_doppelganger("mixed model fit for mmkin object", plot_biphasic_mmkin)
+ vdiffr::expect_doppelganger("mixed model fit for nlme object", plot_biphasic_nlme)
+ vdiffr::expect_doppelganger("mixed model fit for saem object with saemix transformations", plot_biphasic_saem_s)
+ vdiffr::expect_doppelganger("mixed model fit for saem object with mkin transformations", plot_biphasic_saem_m)
skip_on_travis() # Still not working on Travis, maybe because of deSolve producing
# different results when not working with a compiled model or eigenvalues
vdiffr::expect_doppelganger("plot_errmod with FOCUS D obs eigen", plot_errmod_fit_D_obs_eigen)
diff --git a/tests/testthat/test_saem.R b/tests/testthat/test_saem.R
new file mode 100644
index 00000000..0b6d4531
--- /dev/null
+++ b/tests/testthat/test_saem.R
@@ -0,0 +1,118 @@
+context("Nonlinear mixed effects models fitted with SAEM from saemix")
+
+set.seed(123456)
+sampling_times = c(0, 1, 3, 7, 14, 28, 60, 90, 120)
+n <- n_biphasic <- 15
+log_sd <- 0.3
+err_1 = list(const = 1, prop = 0.05)
+tc <- function(value) sigma_twocomp(value, err_1$const, err_1$prop)
+const <- function(value) 2
+
+SFO <- mkinmod(parent = mkinsub("SFO"))
+k_parent = rlnorm(n, log(0.03), log_sd)
+ds_sfo <- lapply(1:n, function(i) {
+ ds_mean <- mkinpredict(SFO, c(k_parent = k_parent[i]),
+ c(parent = 100), sampling_times)
+ add_err(ds_mean, tc, n = 1)[[1]]
+})
+
+DFOP <- mkinmod(parent = mkinsub("DFOP"))
+dfop_pop <- list(parent_0 = 100, k1 = 0.06, k2 = 0.015, g = 0.4)
+dfop_parms <- as.matrix(data.frame(
+ k1 = rlnorm(n, log(dfop_pop$k1), log_sd),
+ k2 = rlnorm(n, log(dfop_pop$k2), log_sd),
+ g = plogis(rnorm(n, qlogis(dfop_pop$g), log_sd))))
+ds_dfop <- lapply(1:n, function(i) {
+ ds_mean <- mkinpredict(DFOP, dfop_parms[i, ],
+ c(parent = dfop_pop$parent_0), sampling_times)
+ add_err(ds_mean, const, n = 1)[[1]]
+})
+
+set.seed(123456)
+DFOP_SFO <- mkinmod(
+ parent = mkinsub("DFOP", "m1"),
+ m1 = mkinsub("SFO"),
+ quiet = TRUE)
+syn_biphasic_parms <- as.matrix(data.frame(
+ k1 = rlnorm(n_biphasic, log(0.05), log_sd),
+ k2 = rlnorm(n_biphasic, log(0.01), log_sd),
+ g = plogis(rnorm(n_biphasic, 0, log_sd)),
+ f_parent_to_m1 = plogis(rnorm(n_biphasic, 0, log_sd)),
+ k_m1 = rlnorm(n_biphasic, log(0.002), log_sd)))
+ds_biphasic_mean <- lapply(1:n_biphasic,
+ function(i) {
+ mkinpredict(DFOP_SFO, syn_biphasic_parms[i, ],
+ c(parent = 100, m1 = 0), sampling_times)
+ }
+)
+ds_biphasic <- lapply(ds_biphasic_mean, function(ds) {
+ add_err(ds,
+ sdfunc = function(value) sqrt(err_1$const^2 + value^2 * err_1$prop^2),
+ n = 1, secondary = "m1")[[1]]
+})
+
+test_that("Parent only models can be fitted with saemix", {
+ # Some fits were done in the setup script
+ mmkin_sfo_2 <- mmkin("SFO", ds_sfo, fixed_initials = c(parent = 100), quiet = TRUE)
+
+ sfo_saemix_2 <- saem(mmkin_sfo_1, quiet = TRUE, transformations = "mkin")
+ sfo_saemix_3 <- expect_error(saem(mmkin_sfo_2, quiet = TRUE), "at least two parameters")
+ s_sfo_s1 <- summary(sfo_saemix_1)
+ s_sfo_s2 <- summary(sfo_saemix_2)
+
+ sfo_nlme_1 <- expect_warning(nlme(mmkin_sfo_1), "not converge")
+ s_sfo_n <- summary(sfo_nlme_1)
+
+ # Compare with input
+ expect_equal(round(s_sfo_s2$confint_ranef["SD.log_k_parent", "est."], 1), 0.3)
+ # k_parent is a bit different from input 0.03 here
+ expect_equal(round(s_sfo_s1$confint_back["k_parent", "est."], 3), 0.035)
+ expect_equal(round(s_sfo_s2$confint_back["k_parent", "est."], 3), 0.035)
+
+ # But the result is pretty unanimous between methods
+ expect_equal(round(s_sfo_s1$confint_back["k_parent", "est."], 3),
+ round(s_sfo_s2$confint_back["k_parent", "est."], 3))
+ expect_equal(round(s_sfo_s1$confint_back["k_parent", "est."], 3),
+ round(s_sfo_n$confint_back["k_parent", "est."], 3))
+
+ mmkin_dfop_1 <- mmkin("DFOP", ds_dfop, quiet = TRUE)
+
+ dfop_saemix_1 <- saem(mmkin_dfop_1, quiet = TRUE, transformations = "mkin")
+ dfop_saemix_2 <- saem(mmkin_dfop_1, quiet = TRUE, transformations = "saemix")
+ dfop_nlme_1 <- nlme(mmkin_dfop_1)
+ s_dfop_s1 <- summary(dfop_saemix_1)
+ s_dfop_s2 <- summary(dfop_saemix_2)
+ s_dfop_n <- summary(dfop_nlme_1)
+
+ dfop_pop <- as.numeric(dfop_pop)
+ expect_true(all(s_dfop_s1$confint_back[, "lower"] < dfop_pop))
+ expect_true(all(s_dfop_s1$confint_back[, "upper"] > dfop_pop))
+ expect_true(all(s_dfop_s2$confint_back[, "lower"] < dfop_pop))
+ expect_true(all(s_dfop_s2$confint_back[, "upper"] > dfop_pop))
+
+
+ # We get < 20% deviations with transformations made in mkin
+ rel_diff_1 <- (s_dfop_s1$confint_back[, "est."] - dfop_pop) / dfop_pop
+ expect_true(all(rel_diff_1 < 0.2))
+
+ # We get < 8% deviations with transformations made in saemix
+ rel_diff_2 <- (s_dfop_s2$confint_back[, "est."] - dfop_pop) / dfop_pop
+ expect_true(all(rel_diff_2 < 0.08))
+})
+
+test_that("Simple models with metabolite can be fitted with saemix", {
+
+ dfop_sfo_pop <- as.numeric(dfop_sfo_pop)
+ ci_dfop_sfo_s_s <- summary(saem_biphasic_s)$confint_back
+ expect_true(all(ci_dfop_sfo_s_s[, "lower"] < dfop_sfo_pop))
+ expect_true(all(ci_dfop_sfo_s_s[, "upper"] > dfop_sfo_pop))
+
+ # The following does not work, the k1 and k2 are not fitted well
+ ci_dfop_sfo_s_m <- summary(saem_biphasic_m)$confint_back
+ # expect_true(all(ci_dfop_sfo_s_m[, "lower"] < dfop_sfo_pop))
+ #expect_true(all(ci_dfop_sfo_s_m[, "upper"] > dfop_sfo_pop))
+
+ # Somehow this does not work at the moment. But it took forever (~ 10 min) anyways...
+ #saem_biphasic_2 <- saem(mmkin_biphasic, solution_type = "deSolve", quiet = TRUE)
+
+})

Contact - Imprint