diff --git a/+nf/extract.m b/+nf/extract.m index c1b4062..8475d72 100644 --- a/+nf/extract.m +++ b/+nf/extract.m @@ -1,9 +1,9 @@ -%% Extract a specific subset of data from a neurofield output struct. +%% Extract a specific subset of data from a nftsim output struct. % % The subset can be specified in terms of: traces; times; and nodes. % % ARGUMENTS: -% obj -- A neurofield output struct (a Matlab struct containing data +% obj -- A nftsim output struct (a Matlab struct containing data % from a simulation). % traces -- A cell array or a comma separated string of the traces % you want to extract, e.g. 'Propagator.2.phi, Coupling.2.nu'. @@ -35,7 +35,7 @@ % If no nodes are provided, output all nodes if ~isstruct(obj) || ~isfield(obj, 'data') error(['nf:' mfilename ':BadArgument'], ... - 'The first argument must be a neurofield output struct.'); + 'The first argument must be a nftsim output struct.'); end if nargin < 4 || isempty(nodes) diff --git a/+nf/get_frequencies.m b/+nf/get_frequencies.m index 228a3d3..e2ef0c1 100644 --- a/+nf/get_frequencies.m +++ b/+nf/get_frequencies.m @@ -2,20 +2,20 @@ % Return corresponding grids of frequencies and positions % % ARGUMENTS: -% data -- . -% fs -- . -% Lx -- . -% Ly -- . +% data -- an 1D or 3D array of size space points along x, space points along y, tim points, +% fs -- sampling temporal frequency in [Hz] +% Lx -- physical size of the spatial domain along x in [m] +% Ly -- physical size of the spatial domain along y in [m] % % OUTPUT: -% f -- . -% Kx -- . -% Ky -- . -% x -- . -% y -- . -% df -- . -% dk -- . -% dx -- . +% f -- vector of (positives) frequencies in [Hz] +% Kx -- vector of angular wavenumbers in [rad/m] +% Ky -- vector of angular wavenumbers in [rad/m] +% x -- vector with spatial coordinates in [m] +% y -- vector with spatial coordinates in [m] +% df -- temporal frequency resolution in [Hz] +% dk -- radial spatial frequency resolution in [rad/m] +% dx -- spatial resolution in [m] % % REQUIRES: % -- @@ -38,16 +38,19 @@ x = []; y = []; + % This is the single positive sided frequency vector if isvector(data) - f = (0:(fs / length(data)):(fs / 2)).'; % This is the single sided frequency + f = (0:(fs / length(data)):(fs / 2)).'; return end - f = (0:(fs / size(data, 3)):(fs / 2)).'; % This is the single sided frequency + % This is the single positive sided frequency + f = (0:(fs / size(data, 3)):(fs / 2)).'; df = fs / size(data, 3); - - Kx = 2*pi*(0:1/Lx:size(data, 1)/Lx/2); % This is the single sided frequency - Ky = 2*pi*(0:1/Ly:size(data, 2)/Ly/2); % This is the single sided frequency + + % Wavenumbers / single sided and positive + Kx = 2*pi*(0:1/Lx:size(data, 1)/Lx/2); + Ky = 2*pi*(0:1/Ly:size(data, 2)/Ly/2); if mod(size(data, 1), 2) % If there is NO nyquist frequency component Kx = [-Kx(end:-1:2) Kx]; @@ -60,13 +63,24 @@ else Ky = [-Ky(end:-1:2) Ky(1:end-1)]; end + [Kx, Ky] = meshgrid(Kx, Ky); + + % Smallest wavenumber - resolution in k-space (angular spatial frequency) + % This is assuming the spatial domain is square (Lx=Ly) + dk = 2 * pi / Lx; + + % dx and dy should be the same + dx = Lx / size(data, 1); % [m] + dy = Ly / size(data, 1); % [m] + + % the stencil in NFTsim assumes the coordinates of a parcel of the discretized domain + % is at the centre of the parcel, thus the first coordinate is at (dx/2; dy/2) + + x = dx * (0:size(data, 1)) + dx/2; + y = dy * (0:size(data, 1)) + dx/2; - dx = Lx / size(data, 1); % Metres per pixel - x = dx * (0:size(data, 1)-1); - dy = Ly / size(data, 1); - y = dy * (0:size(data, 1)-1); [x, y] = meshgrid(x, y); end %function get_frequencies() diff --git a/+nf/grid.m b/+nf/grid.m index 7df682f..242d388 100644 --- a/+nf/grid.m +++ b/+nf/grid.m @@ -8,7 +8,7 @@ % output all nodes), or the number of nodes is not a perfect square.. % % ARGUMENTS: -% obj -- A neurofield output struct (a Matlab struct containing data +% obj -- A nftsim output struct (a Matlab struct containing data % from a simulation). % trace -- A string with the name of the array to reshape. % @@ -35,7 +35,7 @@ if output_nodes ~= obj.input_nodes error(['nf:' mfilename ':IncompatibleOutput'], ... - 'Output from NeuroField must be for all nodes') + 'Output from NFTsim must be for all nodes') end data = nf.extract(obj, trace); @@ -48,7 +48,7 @@ longside_nodes = obj.longside_nodes; shortside_nodes = obj.input_nodes / obj.longside_nodes; end - %Reshape to an array of (n,m,tpts) + %Reshape to an array of (nx,ny,tpts) %data = reshape(data, grid_edge, grid_edge, obj.npoints); diff --git a/+nf/plot_timeseries.m b/+nf/plot_timeseries.m index 436a88f..97ede2b 100644 --- a/+nf/plot_timeseries.m +++ b/+nf/plot_timeseries.m @@ -12,12 +12,14 @@ % node_idx -- cell array with vectors of node indices, one per trace. % reref -- boolean, true: removes spatial average at each time-step, % this is equivalent to the "grand-average" often used in EEG. +% rm_linear_trend -- boolean, true: remove any linear trend from data before +% plotting. Disable to view non-stationary time-series. % % OUTPUT: (Generates a time-series figure for each trace.) % figure_handles -- cell array of figure handles. % % REQUIRES: -% nf.extract() -- Extract a specific subset of data from a neurofield +% nf.extract() -- Extract a specific subset of data from a nftsim % output struct. % % AUTHOR: @@ -28,7 +30,7 @@ %{ %Either run a simulation: nf_obj = nf.run('./configs/eirs-corticothalamic.conf') - %Or load some neurofield output data + %Or load some nftsim output data nf_obj = nf.read('./configs/eirs-corticothalamic.output') %Plot every fourth node for the trace 'Propagator.1.phi'. @@ -38,7 +40,7 @@ close([figure_handles{:}]) %} -function figure_handles = plot_timeseries(obj, traces, node_idx, reref) +function figure_handles = plot_timeseries(obj, traces, node_idx, reref, rm_linear_trend) % Default to plotting all fields. if nargin < 2 || isempty(traces) traces = obj.fields; @@ -54,6 +56,10 @@ if nargin < 4 reref = true; end + % Default to linear detrend of data before plot. + if nargin < 5 + rm_linear_trend = true; + end % Get some size info about data num_figs = length(traces); time = obj.time; @@ -63,15 +69,21 @@ for nof=1:num_figs num_nodes = length(node_idx{nof}); labels = cell(1, num_nodes); + node_data_index = nan(1, num_nodes); for k = 1:num_nodes - labels{k} = num2str(node_idx{nof}(k)); + labels{k} = num2str(node_idx{nof}(k)); + node_data_index(k) = find(obj.nodes{nof} == node_idx{nof}(k)); end %index labels figure_handles{nof} = figure; fig_title = [traces{nof}]; - % Get fata to plot + % Get data to plot data = nf.extract(obj, traces{nof}); - data = detrend(data); + + % Remove any linear trend from individual time-series. + if rm_linear_trend + data = detrend(data); + end % Rescale data to the range [0, 1] data = data - min(data(:)); @@ -88,7 +100,7 @@ separate_by = 0.33*(max(data(:)) - min(data(:))); nodes_by_timestepsize = repmat((1:num_nodes), [time_steps,1]); - plot(time, data(:, node_idx{nof}) + separate_by*nodes_by_timestepsize, ... + plot(time, data(:, node_data_index) + separate_by*nodes_by_timestepsize, ... 'color', [0.42, 0.42, 0.42]); title(fig_title, 'interpreter', 'none'); diff --git a/+nf/read.m b/+nf/read.m index ce4814f..46f8f6b 100644 --- a/+nf/read.m +++ b/+nf/read.m @@ -1,11 +1,11 @@ -%% Read a neurofield output file and return a neurofield output struct. +%% Read a nftsim output file and return a nftsim output struct. % % ARGUMENTS: -% fname -- The name of the neurofield output file to read (absolute +% fname -- The name of the nftsim output file to read (absolute % or relative path). % % OUTPUT: -% obj -- A neurofield output struct. A Matlab struct containing data +% obj -- A nftsim output struct. A Matlab struct containing data % and parameters from a simulation. % % AUTHOR: @@ -20,7 +20,11 @@ function [obj] = read(fname) % Check that our input arg is actually a file. - if ~exist(fname, 'file') + if endsWith(fname,'.conf') + error(['nf:' mfilename ':BadArgument'], ... + 'The file provided is a configuration file: "%s".', fname) + end + if ~exist(fname, 'file') % Try appending .output to the name we were provided. if ~exist([fname, '.output'], 'file') error(['nf:' mfilename ':FileDoesNotExist'], ... @@ -42,7 +46,7 @@ while isempty(strfind(buffer, '=======================')) - % TODO: consider cleaning up this part. + % TODO: CLEAN UP - this part refers to EEGCODE. if ~isempty(strfind(buffer, 'Time |')) error(['nf:' mfilename ':OldStyleOutput'], ... 'Did you try and open and old-style output file? Found a | that looked like a delimiter.') diff --git a/+nf/report.m b/+nf/report.m index 53772dd..816c7fd 100644 --- a/+nf/report.m +++ b/+nf/report.m @@ -1,7 +1,7 @@ -%% Given a neurofield output struct, print some information about it. +%% Given a nftsim output struct, print some information about it. % % ARGUMENTS: -% obj -- A neurofield output struct (a Matlab struct containing data +% obj -- A nftsim output struct (a Matlab struct containing data % from a simulation). % % OUTPUT: Prints to terminal. @@ -16,7 +16,7 @@ %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% function report(obj) - fprintf(1, 'Output for: neurofield -i "%s"\n', obj.conf_file) + fprintf(1, 'Output for: nftsim -i "%s"\n', obj.conf_file) fprintf(1, 'Traces: '); for j = 1:length(obj.fields) fprintf(1, '%s ', obj.fields{j}); diff --git a/+nf/rfft.m b/+nf/rfft.m index 0888642..6e13bae 100644 --- a/+nf/rfft.m +++ b/+nf/rfft.m @@ -21,6 +21,7 @@ % http://www.brain-dynamics.net/~chris_rennie/fourier.pdf % % AUTHOR: +% Original: Chris Rennie circa 2000 % Romesh Abeysuriya (2012-03-22). % % USAGE: @@ -75,9 +76,10 @@ P(2:(end - 1), :) = P(2:(end - 1), :) .* 2.0; end + % TODO: check normalizations % P now contains properly normalized spectral power %f = fs / 2 * linspace(0, 1, NFFT / 2 + 1)'; - f = 0:(fs / NFFT):(fs / 2); % I think this is more correct + f = 0:(fs / NFFT):(fs / 2); % I think this is more correct P = mean(P, 2); P = P ./ f(2); % Divide by frequency bin size to get power density diff --git a/+nf/run.m b/+nf/run.m index 1d794d3..c598b7e 100644 --- a/+nf/run.m +++ b/+nf/run.m @@ -1,9 +1,9 @@ -%% Function to run neurofield and return a neurofield output struct. +%% Function to run nftsim and return a nftsim output struct. % -% Provided a configuration file-name (fname.conf), run the neurofield +% Provided a configuration file-name (fname.conf), run the nftsim % executable, generating an output file (fname.output). Optionally, if an % output argument is provided then, parse the output file and return a -% neurofield output struct containing the simulation results. +% nftsim output struct containing the simulation results. % % % ARGUMENTS: @@ -11,15 +11,15 @@ % the .conf extension. % time_stamp -- boolean flag to use a time_stamp YYYY-MM-DDTHHMMSS % in the output file name. -% neurofield_path -- neurofield executable (full or relative path). +% nftsim_path -- nftsim executable (full or relative path). % % OUTPUT: Writes a .output file in the same location as the .conf file. -% obj -- A neurofield output struct (a Matlab struct containing +% obj -- A nftsim output struct (a Matlab struct containing % data from a simulation). % % REQUIRES: -% neurofield -- The neurofield executable, must be in your path. -% nf.read -- Read a neurofield output file and return a neurofield +% nftsim -- The nftsim executable, must be in your path. +% nf.read -- Read a nftsim output file and return a nftsim % output struct. % % AUTHOR: @@ -27,12 +27,12 @@ % % USAGE: %{ - %At a matlab command promt, from neurofield's main directory: + %At a matlab command promt, from nftsim's main directory: nf_obj = nf.run('./configs/eirs-corticothalamic.conf') %} %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%% -function obj = run(fname, time_stamp, neurofield_path) +function obj = run(fname, time_stamp, nftsim_path) % tic; fname = strrep(fname, '.conf', ''); %Strip any .conf suffix. @@ -41,39 +41,39 @@ if nargin < 2 time_stamp = false; end - % If we were not provided a path to neurofield, try to determine one. - if nargin < 3 || isempty(neurofield_path) + % If we were not provided a path to nftsim, try to determine one. + if nargin < 3 || isempty(nftsim_path) % Check typical locations, the first path that exists will be selected. - locations = {'neurofield', ... - './bin/neurofield', ... - './neurofield/bin/neurofield', ... - 'neurofield.exe'}; + locations = {'nftsim', ... + './bin/nftsim', ... + './nftsim/bin/nftsim', ... + 'nftsim.exe'}; selected_path = find(cellfun(@(name) exist(name, 'file')==2, locations), 1, 'first'); if ~isempty(selected_path) - neurofield_path = locations{selected_path}; + nftsim_path = locations{selected_path}; else error(['nf:' mfilename ':BadPath'], ... - 'neurofield not found. Either change into the neurofield base directory or make a symlink to neurofield in the current directory.'); + 'nftsim not found. Either change into the nftsim base directory or make a symlink to nftsim in the current directory.'); end % If we were provided a path, check that it is valid. - elseif ~exist(neurofield_path, 'file') + elseif ~exist(nftsim_path, 'file') error(['nf:' mfilename ':BadPath'], ... - 'The neurofield_path you provided is incorrect:"%s".',neurofield_path); + 'The nftsim_path you provided is incorrect:"%s".',nftsim_path); end if ~time_stamp - neurofield_cmd = sprintf('%s -i %s.conf -o %s.output', neurofield_path, fname, fname); + nftsim_cmd = sprintf('%s -i %s.conf -o %s.output', nftsim_path, fname, fname); else - neurofield_cmd = sprintf('%s -i %s.conf -t', neurofield_path, fname); + nftsim_cmd = sprintf('%s -i %s.conf -t', nftsim_path, fname); end fprintf('INFO: Executing command:\n') - fprintf('%s\n', neurofield_cmd); - [status, cmdout] = system(neurofield_cmd); + fprintf('%s\n', nftsim_cmd); + [status, cmdout] = system(nftsim_cmd); string(cmdout) if status ~= 0 - error(['nf:' mfilename ':NeurofieldError'], ... - 'An error occurred while running neurofield!'); + error(['nf:' mfilename ':NFTsimError'], ... + 'An error occurred while running nftsim!'); end fprintf(1, 'INFO: tic-toc: Took about %.3f seconds\n', toc); diff --git a/+nf/spatial_spectrum.m b/+nf/spatial_spectrum.m index ab93e83..92ee7d0 100644 --- a/+nf/spatial_spectrum.m +++ b/+nf/spatial_spectrum.m @@ -10,19 +10,19 @@ % spatial_filter -- set to 1 to enable the usual exponential k filter % % OUTPUT: -% f -- . -% P -- . -% Kx -- . -% Ky -- . -% Pkf -- . -% x -- . -% y -- . -% Prf -- . +% f -- vector of temporal frequencies in [Hz] +% P -- power spectral density in [au / Hz ???]???? +% Kx -- vector with angular wavenumbers in [rad/m] +% Ky -- vector with angular wavenumbers in [rad/m] +% Pkf -- power spectral density? array in [units?????] +% x -- array of spatial coordinates along x [m] +% y -- array of spatial coordinates along y [m] +% Prf --power spectral density ? in space frequency [units?????] % % REQUIRES: -% nf.get_frequencies() -- -% nf.grid() -- -% nf.partition() -- +% nf.get_frequencies() +% nf.grid() +% nf.partition() % % REFERENCES: % @@ -119,9 +119,9 @@ function [Pkf, Prf] = get_spectrum(data, k_mask, k_filter, Lx, fs) - df = fs / (size(data, 3)); - dk = 2 * pi / Lx; - dx = Lx / size(data, 1); % Metres per pixel + df = fs / (size(data, 3)); % [Hz] + dk = 2 * pi / Lx; % spatial frequency resolution in [rad/m] -- smallest nonzero wavenumber + dx = Lx / size(data, 1); % [m] % First, get the 3D FFT and apply volume conduction P = fftshift(fftn(data)); @@ -155,7 +155,7 @@ Prf(:, :, 2:(end - 1)) = Prf(:, :, 2:(end - 1)) * 2; end - % Divide by N, dx and dx so that integration gives the correct power + % Divide by N, dx and dx so that integration gives the correct power or PSD????? % Division by N on the grounds that energy in real space is given by summing abs(x)^2/N % So we could call the power P=abs(x)^2/N so that sum(P) gives the correct power % And then division by dx*dx means that integral(P) over position gives the right answer diff --git a/+nf/spectrum.m b/+nf/spectrum.m index ded0d64..949e7c9 100644 --- a/+nf/spectrum.m +++ b/+nf/spectrum.m @@ -1,7 +1,7 @@ -%% Return the frequency and frequency spectrum of given neurofield output. +%% Return the frequency and frequency spectrum of given nftsim output. % % ARGUMENTS: -% obj -- A neurofield output struct (a Matlab struct containing data +% obj -- A nftsim output struct (a Matlab struct containing data % from a simulation). % traces -- traces to use % n_windows -- number of windows (Default=8). @@ -12,7 +12,7 @@ % % REQUIRES: % nf.partition() -- Partition a list of n items into m groups. -% nf.extract() -- Extract a specific subset of data from a neurofield output struct. +% nf.extract() -- Extract a specific subset of data from a nftsim output struct. % nf.rfft() -- Fourier transform. % % REFERENCES: @@ -22,7 +22,7 @@ % % USAGE: %{ - %Load some neurofield output data. + %Load some nftsim output data. obj = nf.read('./configs/example.output') %Calculate the mean power spectrum. [f, P] = nf.spectrum(obj, 'Propagator.1.phi', [], true, true); @@ -36,7 +36,7 @@ function [f, P] = spectrum(obj, traces, n_windows, windowed, detrended) if ~isstruct(obj) error(['nf:' mfilename ':BadArgument'], ... - 'The first argument must be a neurofield simulation struct.') + 'The first argument must be a nftsim simulation struct.') end if nargin < 2 || isempty(traces) @@ -68,9 +68,9 @@ % Partition the extracted data into epochs of time. frac_overlap = 0.5; - evenlength = true; - same_size = true; - window_idx = nf.partition(size(data, 1), n_windows, [], frac_overlap, evenlength, same_size); + evenlength = true; + same_size = true; + window_idx = nf.partition(size(data, 1), n_windows, [], frac_overlap, evenlength, same_size); window_length = window_idx(1, 2) - window_idx(1, 1) + 1; % Calculate mean power spectrum for each epoch of time. diff --git a/.gitattributes b/.gitattributes index 23f9482..9db3506 100644 --- a/.gitattributes +++ b/.gitattributes @@ -15,7 +15,7 @@ Makefile text # The executable. -neurofield binary +nftsim binary #Configuration files *.conf text diff --git a/.gitignore b/.gitignore index 2192ddf..5a39f60 100644 --- a/.gitignore +++ b/.gitignore @@ -7,7 +7,7 @@ dep/ doc/html/ doc/latex/ -# Ignore NeuroField output files +# Ignore NFTsim output files *.output *.mat diff --git a/Doxyfile b/Doxyfile index 6ae5cae..78b252c 100644 --- a/Doxyfile +++ b/Doxyfile @@ -33,7 +33,7 @@ DOXYFILE_ENCODING = UTF-8 # title of most generated pages and in a few other places. # The default value is: My Project. -PROJECT_NAME = "Neurofield" +PROJECT_NAME = "NFTsim" # The PROJECT_NUMBER tag can be used to enter a project or revision number. This # could be handy for archiving the generated documentation or if some version diff --git a/Makefile b/Makefile index 33ea3f4..b9dfbc1 100644 --- a/Makefile +++ b/Makefile @@ -1,4 +1,4 @@ -#Makefile for neurofield +#Makefile for nftsim # # Type 'make help' for a list of possible targets with brief descriptions. # If you're having problems, the Makefile itself can be debugged using the @@ -14,7 +14,7 @@ DOCDIR := doc/ DEPDIR := dep/ #Default to *nix, suffix-less, binary. -BIN := neurofield +BIN := nftsim #User-manual files USER_MANUAL := NFTsimManual.pdf @@ -58,18 +58,18 @@ NO_DEPS += clean-user-manual clean-reference-manual clean-docs clean-deps clean- # Define our suffix list .SUFFIXES: .o .d .cpp .h .tex -.PHONY: neurofield debug all clang make_bin_dir make_obj_dir make_dep_dir help help-dev info docs user-manual reference-manual \ +.PHONY: nftsim debug all clang make_bin_dir make_obj_dir make_dep_dir help help-dev info docs user-manual reference-manual \ clean-user-manual clean-reference-manual clean-docs clean-deps clean-objs clean-bin clean clean-all -# target: neurofield - Compile neurofield placing the executable in the bin directory. -neurofield: $(BINDIR)$(BIN) +# target: nftsim - Compile nftsim placing the executable in the bin directory. +nftsim: $(BINDIR)$(BIN) -# target: debug - Compile neurofield with debugging enabled. +# target: debug - Compile nftsim with debugging enabled. debug: CXXFLAGS := $(DEBUG) -debug: neurofield +debug: nftsim -# target: all - Compile neurofield and build all documentation. -all: neurofield docs +# target: all - Compile nftsim and build all documentation. +all: nftsim docs # target: gcc - Build using gcc, unnecessary on Linux as gcc is default. ifeq ($(MAKECMDGOALS), gcc) @@ -80,7 +80,7 @@ ifeq ($(MAKECMDGOALS), gcc) CXXFLAGS := -std=c++11 -lm -Wall -Wextra -pedantic -msse -msse2 -msse3 -mfpmath=sse -march=native -mtune=native -funroll-loops -flto -O3 DEPFLAGS = -std=c++11 -MM -MP -MT $(OBJDIR)$*.o endif -gcc: neurofield +gcc: nftsim # target: clang - Build using clang++, unnecessary on MacOS unless you want extra warnings as clang++ is default. ifeq ($(MAKECMDGOALS), clang) @@ -91,7 +91,7 @@ ifeq ($(MAKECMDGOALS), clang) CXXFLAGS := -std=c++11 -Weverything -Wno-padded -Wno-c++98-compat -Wno-c++98-compat-pedantic -fdiagnostics-fixit-info -Wdocumentation -march=native -funroll-loops -flto -O3 DEPFLAGS = -std=c++11 -MM -MP -MT $(OBJDIR)$*.o endif -clang: neurofield +clang: nftsim # target: intel - Build using intel C++ compiler. ifeq ($(MAKECMDGOALS), intel) @@ -104,13 +104,13 @@ ifeq ($(MAKECMDGOALS), intel) CXXFLAGS := -std=c++11 -Wall -Wremarks -Wchecks -Weffec++ -xHost -funroll-loops -ipo -O3 DEPFLAGS = -std=c++11 -MM -MP -MT $(OBJDIR)$*.o endif -intel: neurofield +intel: nftsim # target: $(BINDIR)$(BIN) - Main target for the final build, linking objects into an executable. $(BINDIR)$(BIN): $(OBJ) | make_bin_dir $(CXX) $(CXXFLAGS) $(OBJ) -o $@ @$(CAT) conditions.txt - @echo "USE OF NEUROFIELD CONSTITUTES ACCEPTANCE OF THE APACHE 2.0 LICENSE" + @echo "USE OF NFTSIM CONSTITUTES ACCEPTANCE OF THE APACHE 2.0 LICENSE" # target: make_bin_dir - Create the directory $BINDIR if it doesn't already exist. make_bin_dir: diff --git a/README.md b/README.md index 93b743c..d9a3552 100644 --- a/README.md +++ b/README.md @@ -36,7 +36,7 @@ To build the executable on Linux or MacOS, open a terminal in the `nftsim` direc make -this produces the executable `bin/neurofield` and autogenerates the documentation. +this produces the executable `bin/nftsim` and autogenerates the documentation. To build only the reference manual type: @@ -57,7 +57,7 @@ Example configurations including examples for published results are available in To run the basic example type - ./bin/neurofield -i ./configs/eirs-corticothalamic.conf -o eirs-corticothalamic.output + ./bin/nftsim -i ./configs/eirs-corticothalamic.conf -o eirs-corticothalamic.output ## Troubleshooting @@ -65,7 +65,7 @@ Problems compiling? First check [the following page](https://github.com/BrainDyn ## How to contribute code -If you intend to contribute to NFTsim development, please make a private fork of this repository and follow the [instructions for contributors.](https://github.com/BrainDynamicsUSYD/nftsim/wiki/How-to-contribute-code-to-NeuroField) +If you intend to contribute to NFTsim development, please make a private fork of this repository and follow the [instructions for contributors.](https://github.com/BrainDynamicsUSYD/nftsim/wiki/Dev:-How-to-contribute-code-to-NFTsim) ## How to cite `NFTsim` @@ -79,6 +79,8 @@ Please cite us as follows: _NFTsim: Theory and Simulation of Multiscale Neural Field Dynamics_ - submitted to PLoS Computational Biology (2017) + Submitted to PLoS Computational Biology (2017). + Download the [preprint from bioaRiv](https://www.biorxiv.org/content/early/2018/02/01/237032). + diff --git a/benchmarks/eirs-default.conf b/benchmarks/eirs-default.conf index 15649be..34ccb7d 100644 --- a/benchmarks/eirs-default.conf +++ b/benchmarks/eirs-default.conf @@ -56,7 +56,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/benchmarks/eirs-nodes-1024.conf b/benchmarks/eirs-nodes-1024.conf index a26bf28..8c8d8ef 100644 --- a/benchmarks/eirs-nodes-1024.conf +++ b/benchmarks/eirs-nodes-1024.conf @@ -56,7 +56,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/benchmarks/eirs-time-150.conf b/benchmarks/eirs-time-150.conf index 01e8e0e..5989f35 100644 --- a/benchmarks/eirs-time-150.conf +++ b/benchmarks/eirs-time-150.conf @@ -56,7 +56,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/benchmarks/eirs-traces-8.conf b/benchmarks/eirs-traces-8.conf index f325d73..8dc5f63 100644 --- a/benchmarks/eirs-traces-8.conf +++ b/benchmarks/eirs-traces-8.conf @@ -57,7 +57,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/benchmarks/eirs-wavepropagators-11.conf b/benchmarks/eirs-wavepropagators-11.conf index de6fd1d..715d21c 100644 --- a/benchmarks/eirs-wavepropagators-11.conf +++ b/benchmarks/eirs-wavepropagators-11.conf @@ -57,7 +57,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Wave - Tau: 0 Range: 0.086 gamma: 116 diff --git a/benchmarks/nf_benchmarks b/benchmarks/nf_benchmarks index ec04ca3..09f4fac 100755 --- a/benchmarks/nf_benchmarks +++ b/benchmarks/nf_benchmarks @@ -1,7 +1,7 @@ #!/usr/bin/env bash # nf_benchmarks: -# A script for benchmarking neurofield and storing the results. +# A script for benchmarking nftsim and storing the results. # #USAGE: # #Show this header message: @@ -51,9 +51,9 @@ # + ./benchmarks/results/code_info.csv # + ./benchmarks/results/system_info.csv # The script expects/requires: -# + to be run from a clean clone of neurofield's repository +# + to be run from a clean clone of nftsim's repository # (clean here means no uncommitted changes in the working directory); -# + neurofield to be building and running properly; and +# + nftsim to be building and running properly; and # + valid configuration files as input. # # Authors: Paula Sanz-Leon; Stuart A. Knock; @@ -72,8 +72,8 @@ TMP_DIR='/tmp' MEM_DIR='/dev/shm' SCRIPT_PATH="$( cd "$(dirname "${BASH_SOURCE[0]}")" || exit 1 ; pwd -P )" RESULTS_DIR="${SCRIPT_PATH}/results" -NEUROFIELD_DIR="$( cd "$SCRIPT_PATH" || exit 1; cd ../ || exit 1; pwd -P )" -NEUROFIELD="$NEUROFIELD_DIR/bin/neurofield" +NFTSIM_DIR="$( cd "$SCRIPT_PATH" || exit 1; cd ../ || exit 1; pwd -P )" +NFTSIM="$NFTSIM_DIR/bin/nftsim" TODAY="$(date +%F)" #Date in IEEE standard format, ie YYYY-mm-dd FILE_NAME_NOW="$(date +%FT%H%M%S)" #ISO 8601: YYYY-mm-ddThhMMSS @@ -174,13 +174,13 @@ delete_entries(){ fi } #delete_entries -#Rebuild neurofield from scratch to make sure the executable matches current code. +#Rebuild nftsim from scratch to make sure the executable matches current code. fresh_build(){ #Use a subshell to: ( - #Change into neurofield's base directory. - if ! cd "$NEUROFIELD_DIR"; then - printf 'ERROR: %s\n' "Failed to change to neurofield directory: '$NEUROFIELD_DIR'" + #Change into nftsim's base directory. + if ! cd "$NFTSIM_DIR"; then + printf 'ERROR: %s\n' "Failed to change to nftsim directory: '$NFTSIM_DIR'" return 1 fi #Ensure we are actually running the current version of the code. @@ -464,7 +464,7 @@ else fi if [[ "${DEBUG,,}" = 'true' ]]; then - printf '%s\n' "NEUROFIELD: '$NEUROFIELD'" + printf '%s\n' "NFTSIM: '$NFTSIM'" printf '%s\n' "CONFIG_FILE: '$CONFIG_FILE'" printf '%s\n' "OUTPUT_FILE: '$OUTPUT_FILE'" printf '%s\n' "TIMING_FILE: '$TIMING_FILE'" @@ -477,7 +477,7 @@ if ! gather_system_info; then exit 1; fi if ! gather_code_info; then exit 1; fi if ! gather_conf_info; then exit 1; fi -#Unless we have explicitly been told not to, rebuild neurofield. +#Unless we have explicitly been told not to, rebuild nftsim. [[ "${NF_BENCH_NO_MAKE,,}" = 'true' ]] || if ! fresh_build; then exit 1; fi if ! TMP_TIMING_FILE="$(mktemp "$TMP_DIR"/nf_timing-XXXX)"; then @@ -487,7 +487,7 @@ fi for (( j = 0; j < NF_BENCH_NUMBER_OF_TRIALS; j++ )); do #Finally, do the actual benchmark run: - /usr/bin/time -v "$NEUROFIELD" -i "$CONFIG_FILE" -o "$OUTPUT_FILE" 2> "$TMP_TIMING_FILE" + /usr/bin/time -v "$NFTSIM" -i "$CONFIG_FILE" -o "$OUTPUT_FILE" 2> "$TMP_TIMING_FILE" #Collect important resource usage info into variables file_size="$(wc --bytes < "$OUTPUT_FILE")" diff --git a/conditions.txt b/conditions.txt index f4a921d..0e588d5 100644 --- a/conditions.txt +++ b/conditions.txt @@ -1,5 +1,5 @@ ============================================================================== -= NEUROFIELD is licensed under the Apache 2.0 License = += NFTSIM is licensed under the Apache 2.0 License = ============================================================================== (c) Copyright @@ -7,14 +7,20 @@ School of Physics University of Sydney - Please cite Neurofield as follows: + Please cite NFTsim as follows: Sanz-Leon, P., Robinson, PA., Knock, SA., Drysdale, PM., Fung, PK., Abeysuriya, GM., Rennie, CJ and Zhao, XL. - "NeuroField: Theory and Simulation of Multiscale Neural Field Dynamics" - presubmitted to PLoS Computational Biology + "NFTsim: Theory and Simulation of Multiscale Neural Field Dynamics" + Submitted to PLoS Computational Biology (2017) + Download the preprint from here: + https://www.biorxiv.org/content/early/2018/02/01/237032 + -Feedback, bug reports, patches and contributions are welcome at -https://github.com/BrainDynamicsUSYD/neurofield/issues +Feedback, bug reports, patches and contributions are welcome at: +https://github.com/BrainDynamicsUSYD/nftsim/issues + +Read online documentation at: +https://github.com/BrainDynamicsUSYD/nftsim/wiki ============================================================================== diff --git a/configs/Plasticity/bcm.conf b/configs/Plasticity/bcm.conf index 3a590d3..c0faf45 100644 --- a/configs/Plasticity/bcm.conf +++ b/configs/Plasticity/bcm.conf @@ -9,7 +9,7 @@ To 2: 1 2 Population 1: Stimulation Length: 0.5 - Stimulus: Pulse - Onset: .2 Amplitude: 9 Width: .5e-3 Frequency: 1 Pulses: 30 + Stimulus: PulseRect - Onset: .2 Amplitude: 9 Width: .5e-3 Frequency: 1 Pulses: 30 Population 2: Excitatory neurons Length: 0.5 diff --git a/configs/Plasticity/eirs-bcm.conf b/configs/Plasticity/eirs-bcm.conf index 1f654f0..245903b 100644 --- a/configs/Plasticity/eirs-bcm.conf +++ b/configs/Plasticity/eirs-bcm.conf @@ -44,8 +44,8 @@ Length: 0.05 Population 5: Stimulation Length: 0.5 Stimulus: Superimpose: 2 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-5 - Stimulus: White - Onset: 2 Mean: .5 Psd: 1e-5 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-5 + Stimulus: White - Onset: 2 Mean: .5 PSD: 1e-5 Propagator 1: Wave - Tau: 0 Range: 86e-3 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/Plasticity/network.conf b/configs/Plasticity/network.conf index bf535fb..3067e70 100644 --- a/configs/Plasticity/network.conf +++ b/configs/Plasticity/network.conf @@ -9,7 +9,7 @@ To 2: 1 2 Population 1: Stimulation Length: 0.001 - Stimulus: Pulse - Onset: 0 Node: 4 5 Amplitude: .1 Width: 1e-0 + Stimulus: PulseRect - Onset: 0 Node: 4 5 Amplitude: .1 Width: 1e-0 Population 2: Excitatory neurons Length: 0.001 diff --git a/configs/Plasticity/plasticity.conf b/configs/Plasticity/plasticity.conf index 46b7026..f227173 100644 --- a/configs/Plasticity/plasticity.conf +++ b/configs/Plasticity/plasticity.conf @@ -9,7 +9,7 @@ To 2: 1 2 Population 1: Stimulation Length: 0.01 - Stimulus: White - Onset: 0 Node: 3 6 Mean: .1 Psd: 0 + Stimulus: White - Onset: 0 Node: 3 6 Mean: .1 PSD: 0 Population 2: Excitatory neurons Length: 0.01 diff --git a/configs/Plasticity/rtms.conf b/configs/Plasticity/rtms.conf index ce68c96..236d38b 100644 --- a/configs/Plasticity/rtms.conf +++ b/configs/Plasticity/rtms.conf @@ -9,7 +9,7 @@ To 2: 1 2 Population 1: Stimulation Length: .5 - Stimulus: Pulse - Onset: 5 Duration: 100 Amplitude: 10 Width: .5e-3 Frequency: 15 Pulses: -1 + Stimulus: PulseRect - Onset: 5 Duration: 100 Amplitude: 10 Width: .5e-3 Frequency: 15 Pulses: -1 Population 2: Excitatory neurons Length: .5 diff --git a/configs/Published/Abeysuriya_2014/figure_1.conf b/configs/Published/Abeysuriya_2014/figure_1.conf index baac7e8..341239b 100644 --- a/configs/Published/Abeysuriya_2014/figure_1.conf +++ b/configs/Published/Abeysuriya_2014/figure_1.conf @@ -55,7 +55,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0001 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0001 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/Published/Abeysuriya_2014/figure_2.conf b/configs/Published/Abeysuriya_2014/figure_2.conf index a438090..052e51c 100644 --- a/configs/Published/Abeysuriya_2014/figure_2.conf +++ b/configs/Published/Abeysuriya_2014/figure_2.conf @@ -55,7 +55,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0001 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0001 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/Published/Abeysuriya_2014/readme.txt b/configs/Published/Abeysuriya_2014/readme.txt index 6ebfccf..ddd394b 100644 --- a/configs/Published/Abeysuriya_2014/readme.txt +++ b/configs/Published/Abeysuriya_2014/readme.txt @@ -18,8 +18,8 @@ directory (in dispersion_calc.m). However, this code has not been prepared for general use yet and is essentially undocumented. The remaining figures in the paper use the same model parameters, with -different noise powers. These can be set by changing the Psd quantity of the +different noise powers. These can be set by changing the PSD quantity of the stimulus in the configuration file to match the quantity in the paper. For -example, Figure 2 is generated using mu = 1e-4, and figure_2.conf has "Psd: -0.0001". To generate Figure 5, simply change Psd to each of the specified mu +example, Figure 2 is generated using mu = 1e-4, and figure_2.conf has "PSD: +0.0001". To generate Figure 5, simply change PSD to each of the specified mu values in the figure caption. diff --git a/configs/Published/van-Albada_2009/eirs-bg.conf b/configs/Published/van-Albada_2009/eirs-bg.conf index 959bd68..83cea84 100644 --- a/configs/Published/van-Albada_2009/eirs-bg.conf +++ b/configs/Published/van-Albada_2009/eirs-bg.conf @@ -121,7 +121,7 @@ Firing: Function: Sigmoid Theta: 0.01 Sigma: 0.0033 Qmax: 500 Population 10: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.08 gamma: 125 Propagator 2: Map - Tau: 0 diff --git a/configs/TMS/teps-bi.conf b/configs/TMS/teps-bi.conf index e8da8be..e5d34b0 100644 --- a/configs/TMS/teps-bi.conf +++ b/configs/TMS/teps-bi.conf @@ -57,18 +57,18 @@ Population 5: Relay Population 6: Stimulation Length: .5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0001 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0001 Population 7: TMS Length: .5 Stimulus: Superimpose: 4 - Stimulus: Sine - Onset: 2.0 Duration: 1e-3 - Amp: 1000 Width: 2.0e-3 Phase: 270 - Stimulus: Pulse - Onset: 2.001 Amplitude:-300 Width: 1.25e-3 - Stimulus: Sine - Onset: 2.001 Duration: 1.25e-3 - Amp: 600 Width: 2.0e-3 Phase: 90 - Stimulus: Sine - Onset: 2.00225 Duration: 5e-3 - Amp: 300 Width: 20.e-3 Phase: 270 + Stimulus: PulseSine - Onset: 2.0 Duration: 1e-3 + Amplitude: 1000 Width: 2.0e-3 Phase: 270 + Stimulus: PulseRect - Onset: 2.001 Amplitude:-300 Width: 1.25e-3 + Stimulus: PulseSine - Onset: 2.001 Duration: 1.25e-3 + Amplitude: 600 Width: 2.0e-3 Phase: 90 + Stimulus: PulseSine - Onset: 2.00225 Duration: 5e-3 + Amplitude: 300 Width: 20.e-3 Phase: 270 Propagator 1: Wave - Range: 86e-3 gamma: 116 Propagator 2: Map - diff --git a/configs/TMS/teps-gabab.conf b/configs/TMS/teps-gabab.conf index e2c2ccc..28ad122 100644 --- a/configs/TMS/teps-gabab.conf +++ b/configs/TMS/teps-gabab.conf @@ -58,16 +58,16 @@ Population 5: Relay Population 6: Stimulation Length: .5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0001 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0001 Population 7: TMS Length: .5 Stimulus: Superimpose: 3 - Stimulus: Sine - Onset: 2.0 Duration: 1e-3 - Amp: 1000 Width: 2.0e-3 Phase: 270 - Stimulus: Pulse - Onset: 2.0 Amplitude: 700 Width: 1e-3 - Stimulus: Sine - Onset: 2.001 Duration: 4.0e-3 - Amp:-300 Width: 20.0e-3 Phase: 270 + Stimulus: PulseSine - Onset: 2.0 Duration: 1e-3 + Amplitude: 1000 Width: 2.0e-3 Phase: 270 + Stimulus: PulseRect - Onset: 2.0 Amplitude: 700 Width: 1e-3 + Stimulus: PulseSine - Onset: 2.001 Duration: 4.0e-3 + Amplitude:-300 Width: 20.0e-3 Phase: 270 Propagator 1: Wave - Range: 86e-3 gamma: 116 Propagator 2: Map - diff --git a/configs/TMS/teps-mono.conf b/configs/TMS/teps-mono.conf index 08bd35d..7df6eb4 100644 --- a/configs/TMS/teps-mono.conf +++ b/configs/TMS/teps-mono.conf @@ -57,16 +57,16 @@ Population 5: Relay Population 6: Stimulation Length: .5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0001 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0001 Population 7: TMS Length: .5 Stimulus: Superimpose: 3 - Stimulus: Sine - Onset: 2.0 Duration: 1e-3 - Amp: 1000 Width: 2.0e-3 Phase: 270 - Stimulus: Pulse - Onset: 2.0 Amplitude: 700 Width: 1e-3 - Stimulus: Sine - Onset: 2.001 Duration: 4.0e-3 - Amp:-300 Width: 20.0e-3 Phase: 270 + Stimulus: PulseSine - Onset: 2.0 Duration: 1e-3 + Amplitude: 1000 Width: 2.0e-3 Phase: 270 + Stimulus: PulseRect - Onset: 2.0 Amplitude: 700 Width: 1e-3 + Stimulus: PulseSine - Onset: 2.001 Duration: 4.0e-3 + Amplitude:-300 Width: 20.0e-3 Phase: 270 Propagator 1: Wave - Range: 86e-3 gamma: 116 Propagator 2: Map - diff --git a/configs/e-cortical.conf b/configs/e-cortical.conf index d9b698e..d862887 100644 --- a/configs/e-cortical.conf +++ b/configs/e-cortical.conf @@ -20,7 +20,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 2: Stimulation Length: 0.5 - Stimulus: Pulse - Onset: 0 Node: 465 Amplitude: 1 Width: 1e-3 + Stimulus: PulseRect - Onset: 0 Node: 465 Amplitude: 1 Width: 1e-3 Propagator 1: Wave - Tau: 0 Range: 0.2 gamma: 30 Propagator 2: Map - diff --git a/configs/e-coupling-matrix.conf b/configs/e-coupling-matrix.conf index 0bac5eb..3ee69ab 100644 --- a/configs/e-coupling-matrix.conf +++ b/configs/e-coupling-matrix.conf @@ -9,7 +9,7 @@ To 2: 1 2 Population 1: Stimulation Length: 0.5 - Stimulus: Pulse - Onset: .1 Duration: 1 Amplitude: 10 Width: .5e-3 Frequency: 15 Pulses: 1000 + Stimulus: PulseRect - Onset: .1 Duration: 1 Amplitude: 10 Width: .5e-3 Frequency: 15 Pulses: 1000 Population 2: Excitatory neurons Length: 0.5 diff --git a/configs/eirs-aerp.conf b/configs/eirs-aerp.conf index 2bb891c..a9882ea 100644 --- a/configs/eirs-aerp.conf +++ b/configs/eirs-aerp.conf @@ -56,7 +56,7 @@ Population 4: Relay Population 5: Stimulation Length: .5 - Stimulus: Pulse - Onset: 9. Amplitude: 50 Width: .5e-3 + Stimulus: PulseRect - Onset: 9. Amplitude: 50 Width: .5e-3 Propagator 1: Wave - Range: 0.086 gamma: 200 Propagator 2: Map - diff --git a/configs/eirs-burst.conf b/configs/eirs-burst.conf index 43ea53e..e980344 100644 --- a/configs/eirs-burst.conf +++ b/configs/eirs-burst.conf @@ -44,7 +44,7 @@ Population 4: Relay Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 86e-3 gamma: 100 Propagator 2: Map - Tau: 0 diff --git a/configs/eirs-corticothalamic.conf b/configs/eirs-corticothalamic.conf index c06d12e..a77b82a 100644 --- a/configs/eirs-corticothalamic.conf +++ b/configs/eirs-corticothalamic.conf @@ -56,7 +56,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/eirs-coupling-diffarctan.conf b/configs/eirs-coupling-diffarctan.conf index 3b185e5..77829ae 100644 --- a/configs/eirs-coupling-diffarctan.conf +++ b/configs/eirs-coupling-diffarctan.conf @@ -56,7 +56,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/eirs-coupling-ramp.conf b/configs/eirs-coupling-ramp.conf index fb774c3..8045c87 100644 --- a/configs/eirs-coupling-ramp.conf +++ b/configs/eirs-coupling-ramp.conf @@ -64,7 +64,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/eirs-dendrite-integral.conf b/configs/eirs-dendrite-integral.conf index 0b3751c..642c32c 100644 --- a/configs/eirs-dendrite-integral.conf +++ b/configs/eirs-dendrite-integral.conf @@ -56,7 +56,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 1e-05 + Stimulus: White - Onset: 0 Mean: 1 PSD: 1e-05 Propagator 1: Wave - Tau: 0 Range: 0.086 gamma: 116 Propagator 2: Map - Tau: 0 diff --git a/configs/eirs-tms.conf b/configs/eirs-tms.conf index 69d1be9..807fb5a 100644 --- a/configs/eirs-tms.conf +++ b/configs/eirs-tms.conf @@ -45,11 +45,11 @@ Population 4: Relay Population 5: Stimulation Length: 0.5 - Stimulus: White - Onset: 0 Mean: 1.1 Psd: 1e-5 + Stimulus: White - Onset: 0 Mean: 1.1 PSD: 1e-5 Population 6: TMS Length: 0.5 - Stimulus: Pulse - Onset: 10 Amplitude: 0 Width: .5e-3 Frequency: 5 Pulses: 1000 + Stimulus: PulseRect - Onset: 10 Amplitude: 0 Width: .5e-3 Frequency: 5 Pulses: 1000 Propagator 1: Wave - Tau: 0.000000 Range: 0.086000 gamma: 116.000000 Propagator 2: Map - Tau: 0.000000 diff --git a/doc/NFTsimManual.pdf b/doc/NFTsimManual.pdf index 5f10f78..a8e93b6 100644 Binary files a/doc/NFTsimManual.pdf and b/doc/NFTsimManual.pdf differ diff --git a/doc/NFTsimManual.tex b/doc/NFTsimManual.tex index 2f68a5e..c899ab1 100644 --- a/doc/NFTsimManual.tex +++ b/doc/NFTsimManual.tex @@ -1,6 +1,6 @@ \documentclass[12pt,a4paper]{article} -\title{NeuroField User Manual} +\title{NFTsim User Manual} \author{Complex Systems\\School of Physics\\University of Sydney} \date{\today} @@ -25,7 +25,7 @@ \parindent=0.0cm \parskip=0.5cm \fancyhf{} -\lhead{{\em NeuroField} User Guide} +\lhead{{\em NFTsim} User Guide} \rfoot{\thepage} \lfoot{{\scriptsize \textcopyright\ Brain Dynamics Group, University of Sydney 2015}} @@ -43,7 +43,7 @@ \newcommand{\type}[1]{{\small\small\tt #1} } -\newcommand{\NF}[0]{\type{NeuroField}} +\newcommand{\NF}[0]{\type{NFTsim}} \graphicspath{{Figure/}} @@ -61,7 +61,7 @@ \begin{document} -\section*{NeuroField User Guide} +\section*{NFTsim User Guide} \NF is a \type{C++} program developed by the Brain Dynamics Group at the University of Sydney, which solves the neural field model of Robinson et al. It is one of a core group of software analysis packages we have developed for our research. @@ -99,31 +99,31 @@ \subsection*{Assumed knowledge} %\pagebreak %\tableofcontents -\section{Obtaining and setting up NeuroField} +\section{Obtaining and setting up NFTsim} \label{sec:obtain} -\subsection{Obtaining NeuroField} +\subsection{Obtaining NFTsim} -\NF can be obtained from our website, \url{http://sydney.edu.au/science/physics/research/complex-systems/brain-dynamics/software.shtml}. As per the license agreement, users are not permitted to redistribute this program to other individuals or organizations - they should download NeuroField directly so as to have the most recent version, including any corrections. +\NF can be obtained from our website, \url{http://sydney.edu.au/science/physics/research/complex-systems/brain-dynamics/software.shtml}. As per the license agreement, users are not permitted to redistribute this program to other individuals or organizations - they should download NFTsim directly so as to have the most recent version, including any corrections. \subsection{Directory layout} -All of the files associated with \NF are contained in a directory called \type{neurofield}. This directory is referred to as the `root directory', and it contains the following: +All of the files associated with \NF are contained in a directory called \type{nftsim}. This directory is referred to as the `root directory', and it contains the following: \begin{tabular}{l p{13cm}} \type{src/}& \type{C++} source code.\\ \type{(obj/)}& This directory is created during compilation and stores intermediate object code.\\ \type{(dep/)}& This directory is created during compilation and stores dependency information.\\ -\type{(bin/)}& The compiled binary \type{neurofield} is created here.\\ +\type{(bin/)}& The compiled binary \type{nftsim} is created here.\\ \type{configs/}& Stores example configuration files for \NF.\\ \type{doc/}& Contains this manual and the reference manual once it's built.\\ \type{+nf/}& Matlab package directory containing \NF helper scripts.\\ \type{test/}& Directory for development testing and is irrelevant for users.\\ \end{tabular} -\subsection{Compiling NeuroField} +\subsection{Compiling NFTsim} \label{sec:compiling} -You can compile NeuroField simply by running +You can compile NFTsim simply by running \begin{lstlisting} make @@ -150,30 +150,30 @@ \subsection{Compiling NeuroField} make help \end{lstlisting} -\section{Running NeuroField} +\section{Running NFTsim} \label{sec:running} You can run \NF directly using \begin{lstlisting} -./bin/neurofield +./bin/nftsim \end{lstlisting} -from the main \NF directory. For ease of use, you may consider adding the \type{neurofield} binary to your system path. +from the main \NF directory. For ease of use, you may consider adding the \type{nftsim} binary to your system path. -By default, \NF will check if a configuration file called \type{neurofield.conf} exists in the current directory. If this file exists, \NF will run it and write output to the file \type{neurofield.output} in the current directory. When these default files are used, a warning is displayed: +By default, \NF will check if a configuration file called \type{nftsim.conf} exists in the current directory. If this file exists, \NF will run it and write output to the file \type{nftsim.output} in the current directory. When these default files are used, a warning is displayed: \begin{lstlisting} -romesha@romeshalt: neurofield > ./bin/neurofield -Warning: Using neurofield.conf for input by default -Warning: Using neurofield.output for output by default +romesha@romeshalt: nftsim > ./bin/nftsim +Warning: Using nftsim.conf for input by default +Warning: Using nftsim.output for output by default \end{lstlisting} -Note that NeuroField will overwrite the output file if it exists, so it is not a good idea to use \type{neurofield.output} for your work. +Note that NFTsim will overwrite the output file if it exists, so it is not a good idea to use \type{nftsim.output} for your work. You can optionally provide an input file using the \type{-i} switch. For example, \begin{lstlisting} -./bin/neurofield -i configs/example.conf +./bin/nftsim -i configs/example.conf \end{lstlisting} will use the configuration file \type{example.conf} within the \type{configs} directory, and will write output to \type{example.output} also in the \type{configs} directory. The output file name is generated by replacing the input file's suffix (\type{.conf}) with \type{.output}. @@ -181,12 +181,12 @@ \section{Running NeuroField} Or you can also specify an output file, using the \type{-o} switch. For example, if you want your configuration files and output data to be in different directories, \begin{lstlisting} -./bin/neurofield -i configs/example.conf -o example.output +./bin/nftsim -i configs/example.conf -o example.output \end{lstlisting} will use the configuration file \type{example.conf} within the \type{configs} directory, and will write output to \type{example.output} in the current directory. -A list of available switches can be displayed by using the \type{-h} or \type{--help} option i.e., \type{./bin/neurofield -h} +A list of available switches can be displayed by using the \type{-h} or \type{--help} option i.e., \type{./bin/nftsim -h} \subsection{Writing a configuration file} \label{sec:config} @@ -220,14 +220,14 @@ \subsection{Writing a configuration file} \item The ordering of the parameters are important. Wrong parameter ordering results in \NF terminating with an error message. \item The configuration file is white-space independent, e.g., there can be either no spaces, many spaces, or new lines between parameters. \item For readability, users are encouraged to arrange parameter entries for different objects (via new lines and indentations) and aligning corresponding parameters between different objects. - \item Tip for \type{vi} users: \type{./Helper\_scripts/neurofield.vim} implements syntax highlighting for configuration files in \type{vi}. See comments within for installation instructions. + \item Tip for \type{vi} users: \type{./Helper\_scripts/nftsim.vim} implements syntax highlighting for configuration files in \type{vi}. See comments within for installation instructions. \end{enumerate} \subsubsection{Example configuration} The remainder of this section refers to an example configuration for the illustrative example system shown in Fig.~\ref{fig:cortical}. The corresponding configuration file is also shown below. This configuration file is included in the repository as \type{configs/cortex.conf} and can be run from the \NF repository root using \begin{lstlisting} -./bin/neurofield -i configs/cortex.conf -o cortex.output +./bin/nftsim -i configs/cortex.conf -o cortex.output \end{lstlisting} {\em It is recommended that you open \type{configs/cortex.conf} to read in conjunction with this section of the manual.} @@ -328,7 +328,7 @@ \subsubsection{Population data} \begin{lstlisting} Length: .5 \end{lstlisting} - The physical edge length of the population (which is a 2D sheet), in metres. This is used in \type{Wave} propagators and the \type{Psd} of \type{White} stimulus. + The physical edge length of the population (which is a 2D sheet), in metres. This is used in \type{Wave} propagators and the \type{PSD} of \type{White} stimulus. \item \begin{lstlisting} Stimulus: Const - Onset: 0 @@ -337,9 +337,9 @@ \subsubsection{Population data} This is followed by the type of stimulus, to be further elaborated below. - Optional parameter \type{Onset} specifies the time onset for the stimulus to begin. If unspecified, stimulus starts at time 0. + Optional parameter \type{Onset} specifies the time [s] from the start of the simulation for the stimulus to begin. If unspecified, stimulus starts at time 0. - Either \type{Cease} or \type{Duration} can be an optional parameter to specify the end time of the stimulus. If unspecified, stimulus ends at 1000 seconds. + Optional parameter \type{Duration} can be used to specify the length of time [s] that the stimulus is active. If unspecified the stimulus continues for the entire simulation. If optional parameter \type{Node} is specified, only the specified node indices will receive stimulation. @@ -352,9 +352,21 @@ \subsubsection{Population data} \end{lstlisting} \vspace{5mm} - \textbf{Pulse} + \textbf{PulseRect} \begin{lstlisting} -Pulse - Amplitude: 1 Width: 2e-2 Frequency: 1 Pulses: 1 +PulseRect - Amplitude: 1 Width: 2e-2 Frequency: 1 Pulses: 1 + \end{lstlisting} + + \vspace{5mm} + \textbf{PulseSigmoid} + \begin{lstlisting} +PulseSigmoid - Amplitude: 1 Width: 2e-2 Frequency: 1 Pulses: 1 + \end{lstlisting} + + \vspace{5mm} + \textbf{Sine} + \begin{lstlisting} +Sine - Amplitude: 1.0 Frequency: 2.0 \end{lstlisting} \vspace{5mm} @@ -362,15 +374,15 @@ \subsubsection{Population data} Gaussian noise, characterized by the mean and standard deviation: \begin{lstlisting} -White - Mean: 1 Std: 20 Ranseed: 10 +White - Mean: 1 StdDev: 20 Ranseed: 10 \end{lstlisting} - Alternatively, the power spectral density (PSD) may be specified instead of the standard deviation. The advantage is that the PSD is invariant to change in \type{Deltat}, population \type{Length} and spatial \type{Nodes}. Given the PSD, \NF correctly calculates the standard deviation: + Alternatively, the power spectral density (PSD) may be specified instead of the standard deviation (StdDev). The advantage is that the PSD is invariant to change in \type{Deltat}, population \type{Length} and spatial \type{Nodes}. Given the PSD, \NF correctly calculates the standard deviation: \begin{lstlisting} -White - Mean: 1 Psd: 20 Ranseed: 10 +White - Mean: 1 PSD: 20 Ranseed: 10 \end{lstlisting} - In general, it is preferable to specify the noise using PSD rather than Std. The magnitude of nonlinear effects and the total power in the spectrum both depend on the PSD rather than the Std. + In general, it is preferable to specify the noise using \texttt{PSD} rather than \texttt{StdDev}. The random number generator may be specified in \type{Ranseed}. If a seed is not specified, an automatically-incremented seed will be used instead, so that multiple stimulus populations will have independent sequences. In general it is not necessary to set the seed manually unless different random numbers are required for otherwise identical runs. @@ -380,9 +392,69 @@ \subsubsection{Population data} To superimpose 2 or more stimuli, begin with the keyword \type{Superimpose}, followed by the number of stimuli. Then list all the stimulus patterns and their parameters, with each stimulus pattern preceded by the keyword \type{Stimulus}. \begin{lstlisting} Stimulus: Superimpose: 2 - Stimulus: White - Mean: 1 Psd: 1 - Stimulus: Pulse - Onset: 0.5 Width: 2e-2 Frequency 1 Pulses: 1 + Stimulus: White - Mean: 1 PSD: 1 + Stimulus: PulseRect - Onset: 0.5 Width: 2e-2 Frequency 1 Pulses: 1 + \end{lstlisting} + + \vspace{5mm} + \textbf{Example stimuli-only.conf} + + \begin{lstlisting} +Time: 12 Deltat: 9.765625e-04 +Nodes: 144 + + Connection matrix: +From: 1 +To 1: 0 + + +Population 1: Stimulation +Length: 0.5 + Stimulus: Superimpose: 2 + Stimulus: PulseRect - Onset: 2 Node: 62 Amplitude: 1.0 Width: 1.0 Period: 3 Pulses: 3 + Stimulus: PulseSigmoid - Onset: 2 Node: 42 Amplitude: 1.0 Width: 1.0 Period: 3 Pulses: 3 Sigma: 0.03125 + +Output: Node: 33 42 62 77 Start: 0 +Population: 1 +Dendrite: +Propagator: +Coupling: + \end{lstlisting} +\begin{figure}[h] +\begin{center} + \includegraphics[width=\textwidth]{img/compare_pulsesigmoid_pulserect.eps} + \caption{Note than in this example, the parameter \texttt{Onset} of \texttt{PulseSigmoid} is the time at which the sigmoid pulse reaches half of its range.} +\end{center} +\end{figure} + + \begin{lstlisting} +Time: 5 Deltat: 9.765625e-04 +Nodes: 144 + + Connection matrix: +From: 1 +To 1: 0 + + +Population 1: Stimulation +Length: 0.5 + Stimulus: Superimpose: 4 + Stimulus: Sine - Onset: 1 Duration: 4 Node: 62 Amplitude: 1.0 Frequency: 0.5 + Stimulus: Sine - Onset: 2 Duration: 2 Node: 42 Amplitude: 1.0 Frequency: 2.0 + Stimulus: Sine - Onset: 1 Duration: 4 Node: 33 Amplitude: 1.0 Frequency: 0.5 + Stimulus: Sine - Onset: 2 Duration: 2 Node: 33 Amplitude: 1.0 Frequency: 2.0 + +Output: Node: 33 42 62 Start: 0 +Population: 1 +Dendrite: +Propagator: +Coupling: \end{lstlisting} +\begin{figure}[h] +\begin{center} + \includegraphics[width=\textwidth]{img/stimulus_sine.eps} +\end{center} +\end{figure} \end{itemize} \item[Ordinary populations]\ \\ @@ -519,7 +591,7 @@ \subsubsection{Coupling Classes} %\] %The neuromodulator's concentration is in turn given by a user chosen stimulus form analogous to stimulus populations. - %The remainder of the input form is specification of the output for $\nu$. This takes an analogous form to the usual output data lines. The $\nu$ data is output to a file with filename \type{neurofield.synaptout.xx} where xx is an index number of the coupling. + %The remainder of the input form is specification of the output for $\nu$. This takes an analogous form to the usual output data lines. The $\nu$ data is output to a file with filename \type{nftsim.synaptout.xx} where xx is an index number of the coupling. %An example Modcouple input form is given by %\begin{lstlisting} @@ -611,7 +683,7 @@ \subsubsection{Output data} \section{Analysis} \label{sec:analysis} -\NF produces a single output file, unless a different name is manually specified this file's name is the same as the input file but with the suffix replaced by \type{.output}. The output file starts with a copy of the input file, to enable the output file to serve as a complete representation of the simulation. The simulation results follow a series of `\type{=}' characters. Example content in \type{neurofield.output} is +\NF produces a single output file, unless a different name is manually specified this file's name is the same as the input file but with the suffix replaced by \type{.output}. The output file starts with a copy of the input file, to enable the output file to serve as a complete representation of the simulation. The simulation results follow a series of `\type{=}' characters. Example content in \type{nftsim.output} is \begin{lstlisting} ============================================= Time Propagator.2.phi @@ -671,18 +743,18 @@ \subsection{Matlab} There are two ways to create the \type{nf} object. You can read the output file directly after executing \NF elsewhere \begin{lstlisting} -obj = nf.read('neurofield.output') +obj = nf.read('nftsim.output') \end{lstlisting} or you can use the \type{nf.run} helper script to run the config file using \NF and automatically parse the output \begin{lstlisting} -obj = nf.run('neurofield.conf') +obj = nf.run('nftsim.conf') \end{lstlisting} %Using \type{nf\_run} means you will need to add \NF to your shell search path. -Several helper files are provided to manipulate the \type{nf} object. The two most important helpers are \type{nf.extract} and \type{nf.grid}. Often you want to extract a particular field from the \type{nf} object, for example, to examine the output from \type{Propagator.3.phi}. To do this directly with the neurofield struct, you would need to check the \type{fields} variable to find the index of the trace you wanted, and then extract it from the \type{data} field. In the previous example, \type{Propagator.3.phi} is the second trace. These expressions are identical: +Several helper files are provided to manipulate the \type{nf} object. The two most important helpers are \type{nf.extract} and \type{nf.grid}. Often you want to extract a particular field from the \type{nf} object, for example, to examine the output from \type{Propagator.3.phi}. To do this directly with the nftsim struct, you would need to check the \type{fields} variable to find the index of the trace you wanted, and then extract it from the \type{data} field. In the previous example, \type{Propagator.3.phi} is the second trace. These expressions are identical: \begin{lstlisting} trace = obj.data{2}; trace = nf.extract(obj,'Propagator.3.phi') @@ -749,7 +821,7 @@ \subsubsection{Coding style} using std::vector; \end{lstlisting} -\subsection{Extending NeuroField via inheritance} +\subsection{Extending NFTsim via inheritance} \label{sec:extension} Most new functionalities may be introduced by inheriting existing classes and overloading appropriate functions, where the core classes are: @@ -777,7 +849,7 @@ \subsection{Extending NeuroField via inheritance} \end{tabular} \subsubsection{Class hierarchy} -The diagram in Figure \ref{fig:classes} shows the inheritance hierarchy for the base NeuroField objects. Note that the \type{Array} class is a container object, and it is not necessary to interact with it directly. See Sec.~\ref{sec:array} for details. +The diagram in Figure \ref{fig:classes} shows the inheritance hierarchy for the base NFTsim objects. Note that the \type{Array} class is a container object, and it is not necessary to interact with it directly. See Sec.~\ref{sec:array} for details. \begin{figure}[h] \label{fig:classes} @@ -857,9 +929,9 @@ \subsubsection{Procedure for implementing a new class} \item Write a configuration file that uses the new class. Or if the object may exhibit different types of behaviour under different parameter values, having one configuration file for each type of behaviour may be advantageous. Make sure that the configuration file has an appropriate comment. \end{enumerate} -\subsection{NeuroField classes} +\subsection{NFTsim classes} -This section contains an overview of all of the base classes in NeuroField. +This section contains an overview of all of the base classes in NFTsim. \subsubsection{Class NF} \label{sec:nf} @@ -1248,7 +1320,7 @@ \subsubsection{Object-oriented programming} \item To summarize, some features brought forth are code structure and protection, code reuse and extension, dynamic allocation of object type, and (if applicable) coding-level object hierarchy. \end{enumerate} -\subsubsection{NeuroField} +\subsubsection{NFTsim} \begin{enumerate} \item \NF is naturally object oriented: firing response, propagators, couplings, dendrites naturally arise and form a network, where each class/object influences other ones. diff --git a/doc/img/compare_pulsesigmoid_pulserect.eps b/doc/img/compare_pulsesigmoid_pulserect.eps new file mode 100644 index 0000000..b43ef50 --- /dev/null +++ b/doc/img/compare_pulsesigmoid_pulserect.eps @@ -0,0 +1,21774 @@ +%!PS-Adobe-3.0 EPSF-3.0 +%%Creator: (MATLAB, The Mathworks, Inc. Version 9.1.0.441655 \(R2016b\). Operating System: Linux) +%%Title: /suphys/akno9866/GitHub/neurofield/doc/img/compare_pulsesigmoid_pulserect.eps +%%CreationDate: 2018-02-13T16:16:10 +%%Pages: (atend) +%%BoundingBox: 0 0 771 359 +%%LanguageLevel: 3 +%%EndComments +%%BeginProlog +%%BeginResource: procset (Apache XML Graphics Std ProcSet) 1.2 0 +%%Version: 1.2 0 +%%Copyright: (Copyright 2001-2003,2010 The Apache Software Foundation. License terms: http://www.apache.org/licenses/LICENSE-2.0) +/bd{bind def}bind def +/ld{load def}bd +/GR/grestore ld +/M/moveto ld +/LJ/setlinejoin ld +/C/curveto ld +/f/fill ld +/LW/setlinewidth ld +/GC/setgray ld +/t/show ld +/N/newpath ld +/CT/concat ld +/cp/closepath ld +/S/stroke ld +/L/lineto ld +/CC/setcmykcolor ld +/A/ashow ld +/GS/gsave ld +/RC/setrgbcolor ld +/RM/rmoveto ld +/ML/setmiterlimit ld +/re {4 2 roll M +1 index 0 rlineto +0 exch rlineto +neg 0 rlineto +cp } bd +/_ctm matrix def +/_tm matrix def +/BT { _ctm currentmatrix pop matrix _tm copy pop 0 0 moveto } bd +/ET { _ctm setmatrix } bd +/iTm { _ctm setmatrix _tm concat } bd +/Tm { _tm astore pop iTm 0 0 moveto } bd +/ux 0.0 def +/uy 0.0 def +/F { + /Tp exch def + /Tf exch def + Tf findfont Tp scalefont setfont + /cf Tf def /cs Tp def +} bd +/ULS {currentpoint /uy exch def /ux exch def} bd +/ULE { + /Tcx currentpoint pop def + gsave + newpath + cf findfont cs scalefont dup + /FontMatrix get 0 get /Ts exch def /FontInfo get dup + /UnderlinePosition get Ts mul /To exch def + /UnderlineThickness get Ts mul /Tt exch def + ux uy To add moveto Tcx uy To add lineto + Tt setlinewidth stroke + grestore +} bd +/OLE { + /Tcx currentpoint pop def + gsave + newpath + cf findfont cs scalefont dup + /FontMatrix get 0 get /Ts exch def /FontInfo get dup + /UnderlinePosition get Ts mul /To exch def + /UnderlineThickness get Ts mul /Tt exch def + ux uy To add cs add moveto Tcx uy To add cs add lineto + Tt setlinewidth stroke + grestore +} bd +/SOE { + /Tcx currentpoint pop def + gsave + newpath + cf findfont cs scalefont dup + /FontMatrix get 0 get /Ts exch def /FontInfo get dup + /UnderlinePosition get Ts mul /To exch def + /UnderlineThickness get Ts mul /Tt exch def + ux uy To add cs 10 mul 26 idiv add moveto Tcx uy To add cs 10 mul 26 idiv add lineto + Tt setlinewidth stroke + grestore +} bd +/QT { +/Y22 exch store +/X22 exch store +/Y21 exch store +/X21 exch store +currentpoint +/Y21 load 2 mul add 3 div exch +/X21 load 2 mul add 3 div exch +/X21 load 2 mul /X22 load add 3 div +/Y21 load 2 mul /Y22 load add 3 div +/X22 load /Y22 load curveto +} bd +/SSPD { +dup length /d exch dict def +{ +/v exch def +/k exch def +currentpagedevice k known { +/cpdv currentpagedevice k get def +v cpdv ne { +/upd false def +/nullv v type /nulltype eq def +/nullcpdv cpdv type /nulltype eq def +nullv nullcpdv or +{ +/upd true def +} { +/sametype v type cpdv type eq def +sametype { +v type /arraytype eq { +/vlen v length def +/cpdvlen cpdv length def +vlen cpdvlen eq { +0 1 vlen 1 sub { +/i exch def +/obj v i get def +/cpdobj cpdv i get def +obj cpdobj ne { +/upd true def +exit +} if +} for +} { +/upd true def +} ifelse +} { +v type /dicttype eq { +v { +/dv exch def +/dk exch def +/cpddv cpdv dk get def +dv cpddv ne { +/upd true def +exit +} if +} forall +} { +/upd true def +} ifelse +} ifelse +} if +} ifelse +upd true eq { +d k v put +} if +} if +} if +} forall +d length 0 gt { +d setpagedevice +} if +} bd +/RE { % /NewFontName [NewEncodingArray] /FontName RE - + findfont dup length dict begin + { + 1 index /FID ne + {def} {pop pop} ifelse + } forall + /Encoding exch def + /FontName 1 index def + currentdict definefont pop + end +} bind def +%%EndResource +%%BeginResource: procset (Apache XML Graphics EPS ProcSet) 1.0 0 +%%Version: 1.0 0 +%%Copyright: (Copyright 2002-2003 The Apache Software Foundation. License terms: http://www.apache.org/licenses/LICENSE-2.0) +/BeginEPSF { %def +/b4_Inc_state save def % Save state for cleanup +/dict_count countdictstack def % Count objects on dict stack +/op_count count 1 sub def % Count objects on operand stack +userdict begin % Push userdict on dict stack +/showpage { } def % Redefine showpage, { } = null proc +0 setgray 0 setlinecap % Prepare graphics state +1 setlinewidth 0 setlinejoin +10 setmiterlimit [ ] 0 setdash newpath +/languagelevel where % If level not equal to 1 then +{pop languagelevel % set strokeadjust and +1 ne % overprint to their defaults. +{false setstrokeadjust false setoverprint +} if +} if +} bd +/EndEPSF { %def +count op_count sub {pop} repeat % Clean up stacks +countdictstack dict_count sub {end} repeat +b4_Inc_state restore +} bd +%%EndResource +%FOPBeginFontDict +%%IncludeResource: font Courier-Bold +%%IncludeResource: font Helvetica +%%IncludeResource: font Courier-BoldOblique +%%IncludeResource: font Courier-Oblique +%%IncludeResource: font Times-Roman +%%IncludeResource: font Helvetica-BoldOblique +%%IncludeResource: font Helvetica-Bold +%%IncludeResource: font Helvetica-Oblique +%%IncludeResource: font Times-BoldItalic +%%IncludeResource: font Courier +%%IncludeResource: font Times-Italic +%%IncludeResource: font Times-Bold +%%IncludeResource: font Symbol +%%IncludeResource: font ZapfDingbats +%FOPEndFontDict +%%BeginResource: encoding WinAnsiEncoding +/WinAnsiEncoding [ +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /space /exclam /quotedbl +/numbersign /dollar /percent /ampersand /quotesingle +/parenleft /parenright /asterisk /plus /comma +/hyphen /period /slash /zero /one +/two /three /four /five /six +/seven /eight /nine /colon /semicolon +/less /equal /greater /question /at +/A /B /C /D /E +/F /G /H /I /J +/K /L /M /N /O +/P /Q /R /S /T +/U /V /W /X /Y +/Z /bracketleft /backslash /bracketright /asciicircum +/underscore /quoteleft /a /b /c +/d /e /f /g /h +/i /j /k /l /m +/n /o /p /q /r +/s /t /u /v /w +/x /y /z /braceleft /bar +/braceright /asciitilde /bullet /Euro /bullet +/quotesinglbase /florin /quotedblbase /ellipsis /dagger +/daggerdbl /circumflex /perthousand /Scaron /guilsinglleft +/OE /bullet /Zcaron /bullet /bullet +/quoteleft /quoteright /quotedblleft /quotedblright /bullet +/endash /emdash /asciitilde /trademark /scaron +/guilsinglright /oe /bullet /zcaron /Ydieresis +/space /exclamdown /cent /sterling /currency +/yen /brokenbar /section /dieresis /copyright +/ordfeminine /guillemotleft /logicalnot /sfthyphen /registered +/macron /degree /plusminus /twosuperior /threesuperior +/acute /mu /paragraph /middot /cedilla +/onesuperior /ordmasculine /guillemotright /onequarter /onehalf +/threequarters /questiondown /Agrave /Aacute /Acircumflex +/Atilde /Adieresis /Aring /AE /Ccedilla +/Egrave /Eacute /Ecircumflex /Edieresis /Igrave +/Iacute /Icircumflex /Idieresis /Eth /Ntilde +/Ograve /Oacute /Ocircumflex /Otilde /Odieresis +/multiply /Oslash /Ugrave /Uacute /Ucircumflex +/Udieresis /Yacute /Thorn /germandbls /agrave +/aacute /acircumflex /atilde /adieresis /aring +/ae /ccedilla /egrave /eacute /ecircumflex +/edieresis /igrave /iacute /icircumflex /idieresis +/eth /ntilde /ograve /oacute /ocircumflex +/otilde /odieresis /divide /oslash /ugrave +/uacute /ucircumflex /udieresis /yacute /thorn +/ydieresis +] def +%%EndResource +%FOPBeginFontReencode +/Courier-Bold findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier-Bold exch definefont pop +/Helvetica findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica exch definefont pop +/Courier-BoldOblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier-BoldOblique exch definefont pop +/Courier-Oblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier-Oblique exch definefont pop +/Times-Roman findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-Roman exch definefont pop +/Helvetica-BoldOblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica-BoldOblique exch definefont pop +/Helvetica-Bold findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica-Bold exch definefont pop +/Helvetica-Oblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica-Oblique exch definefont pop +/Times-BoldItalic findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-BoldItalic exch definefont pop +/Courier findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier exch definefont pop +/Times-Italic findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-Italic exch definefont pop +/Times-Bold findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-Bold exch definefont pop +%FOPEndFontReencode +%%EndProlog +%%Page: 1 1 +%%PageBoundingBox: 0 0 771 359 +%%BeginPageSetup +[1 0 0 -1 0 359] CT +%%EndPageSetup +GS +[0.75 0 0 0.75 0 0.5] CT +N +0 0 M +1028 0 L +1028 478 L +0 478 L +0 0 L +cp +clip +1 GC +N +0 0 1028 478 re +f +GR +GS +[0.75 0 0 0.75 0 0.5] CT +1 GC +N +0 0 1028 478 re +f +GR +GS +[0.75 0 0 0.75 0 0.5] CT +1 GC +N +134 425 M +930 425 L +930 36 L +134 36 L +cp +f +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +930 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 36 M +930 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +134 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +213.6 425 M +213.6 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +293.2 425 M +293.2 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +372.8 425 M +372.8 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +452.4 425 M +452.4 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +532 425 M +532 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +611.6 425 M +611.6 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +691.2 425 M +691.2 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +770.8 425 M +770.8 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +850.4 425 M +850.4 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 425 M +930 417.04 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 36 M +134 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +213.6 36 M +213.6 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +293.2 36 M +293.2 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +372.8 36 M +372.8 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +452.4 36 M +452.4 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +532 36 M +532 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +611.6 36 M +611.6 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +691.2 36 M +691.2 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +770.8 36 M +770.8 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +850.4 36 M +850.4 43.96 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 36 M +930 43.96 L +S +GR +GS +[0.75 0 0 0.75 100.5 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(0) t +GR +GR +GS +[0.75 0 0 0.75 160.2 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(1) t +GR +GR +GS +[0.75 0 0 0.75 219.90001 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(2) t +GR +GR +GS +[0.75 0 0 0.75 279.59999 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(3) t +GR +GR +GS +[0.75 0 0 0.75 339.3 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(4) t +GR +GR +GS +[0.75 0 0 0.75 399 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(5) t +GR +GR +GS +[0.75 0 0 0.75 458.69998 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(6) t +GR +GR +GS +[0.75 0 0 0.75 518.40001 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(7) t +GR +GR +GS +[0.75 0 0 0.75 578.09999 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(8) t +GR +GR +GS +[0.75 0 0 0.75 637.80002 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(9) t +GR +GR +GS +[0.75 0 0 0.75 697.5 323.65] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-10.5 15 moveto +1 -1 scale +(10) t +GR +GR +GS +[0.75 0 0 0.75 399.00027 338.90001] CT +0.149 GC +/Helvetica 21.333 F +GS +[1 0 0 1 0 0] CT +-43.5 20 moveto +1 -1 scale +(Time [s]) t +GR +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +134 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 425 M +930 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +141.96 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 386.1 M +141.96 386.1 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 347.2 M +141.96 347.2 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 308.3 M +141.96 308.3 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 269.4 M +141.96 269.4 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 230.5 M +141.96 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 191.6 M +141.96 191.6 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 152.7 M +141.96 152.7 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 113.8 M +141.96 113.8 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 74.9 M +141.96 74.9 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 36 M +141.96 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 425 M +922.04 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 386.1 M +922.04 386.1 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 347.2 M +922.04 347.2 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 308.3 M +922.04 308.3 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 269.4 M +922.04 269.4 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 230.5 M +922.04 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 191.6 M +922.04 191.6 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 152.7 M +922.04 152.7 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 113.8 M +922.04 113.8 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 74.9 M +922.04 74.9 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +930 36 M +922.04 36 L +S +GR +GS +[0.75 0 0 0.75 96.1 319.25] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-11 5.5 moveto +1 -1 scale +(0) t +GR +GR +GS +[0.75 0 0 0.75 96.1 290.075] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.1) t +GR +GR +GS +[0.75 0 0 0.75 96.1 260.90001] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.2) t +GR +GR +GS +[0.75 0 0 0.75 96.1 231.72499] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.3) t +GR +GR +GS +[0.75 0 0 0.75 96.1 202.55] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.4) t +GR +GR +GS +[0.75 0 0 0.75 96.1 173.375] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.5) t +GR +GR +GS +[0.75 0 0 0.75 96.1 144.19999] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.6) t +GR +GR +GS +[0.75 0 0 0.75 96.1 115.02501] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.7) t +GR +GR +GS +[0.75 0 0 0.75 96.1 85.85] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.8) t +GR +GR +GS +[0.75 0 0 0.75 96.1 56.67501] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.9) t +GR +GR +GS +[0.75 0 0 0.75 96.1 27.5] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-11 5.5 moveto +1 -1 scale +(1) t +GR +GR +GS +[0 -0.75 0.75 0 73.6 173.37486] CT +0.149 GC +/Helvetica 21.333 F +GS +[1 0 0 1 0 0] CT +-54 -5 moveto +1 -1 scale +(Amplitude) t +GR +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0 0.447 0.741 RC +1 LJ +2.667 LW +N +134.078 425 M +134.155 425 L +134.233 425 L +134.311 425 L +134.389 425 L +134.466 425 L +134.544 425 L +134.622 425 L +134.7 425 L +134.777 425 L +134.855 425 L +134.933 425 L +135.011 425 L +135.088 425 L +135.166 425 L +135.244 425 L +135.321 425 L +135.399 425 L +135.477 425 L +135.555 425 L +135.632 425 L +135.71 425 L +135.788 425 L +135.866 425 L +135.943 425 L +136.021 425 L +136.099 425 L +136.177 425 L +136.254 425 L +136.332 425 L +136.41 425 L +136.488 425 L +136.565 425 L +136.643 425 L +136.721 425 L +136.798 425 L +136.876 425 L +136.954 425 L +137.032 425 L +137.109 425 L +137.187 425 L +137.265 425 L +137.343 425 L +137.42 425 L +137.498 425 L +137.576 425 L +137.654 425 L +137.731 425 L +137.809 425 L +137.887 425 L +137.964 425 L +138.042 425 L +138.12 425 L +138.198 425 L +138.275 425 L +138.353 425 L +138.431 425 L +138.509 425 L +138.586 425 L +138.664 425 L +138.742 425 L +138.82 425 L +138.897 425 L +138.975 425 L +139.053 425 L +139.13 425 L +139.208 425 L +139.286 425 L +139.364 425 L +139.441 425 L +139.519 425 L +139.597 425 L +139.675 425 L +139.752 425 L +139.83 425 L +139.908 425 L +139.986 425 L +140.063 425 L +140.141 425 L +140.219 425 L +140.296 425 L +140.374 425 L +140.452 425 L +140.53 425 L +140.607 425 L +140.685 425 L +140.763 425 L +140.841 425 L +140.918 425 L +140.996 425 L +141.074 425 L +141.152 425 L +141.229 425 L +141.307 425 L +141.385 425 L +141.462 425 L +141.54 425 L +141.618 425 L +141.696 425 L +141.773 425 L +141.851 425 L +141.929 425 L +142.007 425 L +142.084 425 L +142.162 425 L +142.24 425 L +142.318 425 L +142.395 425 L +142.473 425 L +142.551 425 L +142.629 425 L +142.706 425 L +142.784 425 L +142.862 425 L +142.939 425 L +143.017 425 L +143.095 425 L +143.173 425 L +143.25 425 L +143.328 425 L +143.406 425 L +143.484 425 L +143.561 425 L +143.639 425 L +143.717 425 L +143.795 425 L +143.872 425 L +143.95 425 L +144.028 425 L +144.105 425 L +144.183 425 L +144.261 425 L +144.339 425 L +144.416 425 L +144.494 425 L +144.572 425 L +144.65 425 L +144.727 425 L +144.805 425 L +144.883 425 L +144.961 425 L +145.038 425 L +145.116 425 L +145.194 425 L +145.271 425 L +145.349 425 L +145.427 425 L +145.505 425 L +145.582 425 L +145.66 425 L +145.738 425 L +145.816 425 L +145.893 425 L +145.971 425 L +146.049 425 L +146.127 425 L +146.204 425 L +146.282 425 L +146.36 425 L +146.438 425 L +146.515 425 L +146.593 425 L +146.671 425 L +146.748 425 L +146.826 425 L +146.904 425 L +146.982 425 L +147.059 425 L +147.137 425 L +147.215 425 L +147.293 425 L +147.37 425 L +147.448 425 L +147.526 425 L +147.604 425 L +147.681 425 L +147.759 425 L +147.837 425 L +147.914 425 L +147.992 425 L +148.07 425 L +148.148 425 L +148.225 425 L +148.303 425 L +148.381 425 L +148.459 425 L +148.536 425 L +148.614 425 L +148.692 425 L +148.77 425 L +148.847 425 L +148.925 425 L +149.003 425 L +149.08 425 L +149.158 425 L +149.236 425 L +149.314 425 L +149.391 425 L +149.469 425 L +149.547 425 L +149.625 425 L +149.702 425 L +149.78 425 L +149.858 425 L +149.936 425 L +150.013 425 L +150.091 425 L +150.169 425 L +150.246 425 L +150.324 425 L +150.402 425 L +150.48 425 L +150.557 425 L +150.635 425 L +150.713 425 L +150.791 425 L +150.868 425 L +150.946 425 L +151.024 425 L +151.102 425 L +151.179 425 L +151.257 425 L +151.335 425 L +151.413 425 L +151.49 425 L +151.568 425 L +151.646 425 L +151.723 425 L +151.801 425 L +151.879 425 L +151.957 425 L +152.034 425 L +152.112 425 L +152.19 425 L +152.268 425 L +152.345 425 L +152.423 425 L +152.501 425 L +152.579 425 L +152.656 425 L +152.734 425 L +152.812 425 L +152.889 425 L +152.967 425 L +153.045 425 L +153.123 425 L +153.2 425 L +153.278 425 L +153.356 425 L +153.434 425 L +153.511 425 L +153.589 425 L +153.667 425 L +153.745 425 L +153.822 425 L +153.9 425 L +153.978 425 L +154.055 425 L +154.133 425 L +154.211 425 L +154.289 425 L +154.366 425 L +154.444 425 L +154.522 425 L +154.6 425 L +154.677 425 L +154.755 425 L +154.833 425 L +154.911 425 L +154.988 425 L +155.066 425 L +155.144 425 L +155.221 425 L +155.299 425 L +155.377 425 L +155.455 425 L +155.532 425 L +155.61 425 L +155.688 425 L +155.766 425 L +155.843 425 L +155.921 425 L +155.999 425 L +156.077 425 L +156.154 425 L +156.232 425 L +156.31 425 L +156.387 425 L +156.465 425 L +156.543 425 L +156.621 425 L +156.698 425 L +156.776 425 L +156.854 425 L +156.932 425 L +157.009 425 L +157.087 425 L +157.165 425 L +157.243 425 L +157.32 425 L +157.398 425 L +157.476 425 L +157.554 425 L +157.631 425 L +157.709 425 L +157.787 425 L +157.864 425 L +157.942 425 L +158.02 425 L +158.098 425 L +158.175 425 L +158.253 425 L +158.331 425 L +158.409 425 L +158.486 425 L +158.564 425 L +158.642 425 L +158.72 425 L +158.797 425 L +158.875 425 L +158.953 425 L +159.03 425 L +159.108 425 L +159.186 425 L +159.264 425 L +159.341 425 L +159.419 425 L +159.497 425 L +159.575 425 L +159.652 425 L +159.73 425 L +159.808 425 L +159.886 425 L +159.963 425 L +160.041 425 L +160.119 425 L +160.196 425 L +160.274 425 L +160.352 425 L +160.43 425 L +160.507 425 L +160.585 425 L +160.663 425 L +160.741 425 L +160.818 425 L +160.896 425 L +160.974 425 L +161.052 425 L +161.129 425 L +161.207 425 L +161.285 425 L +161.363 425 L +161.44 425 L +161.518 425 L +161.596 425 L +161.673 425 L +161.751 425 L +161.829 425 L +161.907 425 L +161.984 425 L +162.062 425 L +162.14 425 L +162.218 425 L +162.295 425 L +162.373 425 L +162.451 425 L +162.529 425 L +162.606 425 L +162.684 425 L +162.762 425 L +162.839 425 L +162.917 425 L +162.995 425 L +163.073 425 L +163.15 425 L +163.228 425 L +163.306 425 L +163.384 425 L +163.461 425 L +163.539 425 L +163.617 425 L +163.695 425 L +163.772 425 L +163.85 425 L +163.928 425 L +164.005 425 L +164.083 425 L +164.161 425 L +164.239 425 L +164.316 425 L +164.394 425 L +164.472 425 L +164.55 425 L +164.627 425 L +164.705 425 L +164.783 425 L +164.861 425 L +164.938 425 L +165.016 425 L +165.094 425 L +165.171 425 L +165.249 425 L +165.327 425 L +165.405 425 L +165.482 425 L +165.56 425 L +165.638 425 L +165.716 425 L +165.793 425 L +165.871 425 L +165.949 425 L +166.027 425 L +166.104 425 L +166.182 425 L +166.26 425 L +166.337 425 L +166.415 425 L +166.493 425 L +166.571 425 L +166.648 425 L +166.726 425 L +166.804 425 L +166.882 425 L +166.959 425 L +167.037 425 L +167.115 425 L +167.193 425 L +167.27 425 L +167.348 425 L +167.426 425 L +167.504 425 L +167.581 425 L +167.659 425 L +167.737 425 L +167.814 425 L +167.892 425 L +167.97 425 L +168.048 425 L +168.125 425 L +168.203 425 L +168.281 425 L +168.359 425 L +168.436 425 L +168.514 425 L +168.592 425 L +168.67 425 L +168.747 425 L +168.825 425 L +168.903 425 L +168.98 425 L +169.058 425 L +169.136 425 L +169.214 425 L +169.291 425 L +169.369 425 L +169.447 425 L +169.525 425 L +169.602 425 L +169.68 425 L +169.758 425 L +169.836 425 L +169.913 425 L +169.991 425 L +170.069 425 L +170.146 425 L +170.224 425 L +170.302 425 L +170.38 425 L +170.457 425 L +170.535 425 L +170.613 425 L +170.691 425 L +170.768 425 L +170.846 425 L +170.924 425 L +171.002 425 L +171.079 425 L +171.157 425 L +171.235 425 L +171.313 425 L +171.39 425 L +171.468 425 L +171.546 425 L +171.623 425 L +171.701 425 L +171.779 425 L +171.857 425 L +171.934 425 L +172.012 425 L +172.09 425 L +172.168 425 L +172.245 425 L +172.323 425 L +172.401 425 L +172.479 425 L +172.556 425 L +172.634 425 L +172.712 425 L +172.789 425 L +172.867 425 L +172.945 425 L +173.023 425 L +173.1 425 L +173.178 425 L +173.256 425 L +173.334 425 L +173.411 425 L +173.489 425 L +173.567 425 L +173.645 425 L +173.722 425 L +173.8 425 L +173.878 425 L +173.955 425 L +174.033 425 L +174.111 425 L +174.189 425 L +174.266 425 L +174.344 425 L +174.422 425 L +174.5 425 L +174.577 425 L +174.655 425 L +174.733 425 L +174.811 425 L +174.888 425 L +174.966 425 L +175.044 425 L +175.121 425 L +175.199 425 L +175.277 425 L +175.355 425 L +175.432 425 L +175.51 425 L +175.588 425 L +175.666 425 L +175.743 425 L +175.821 425 L +175.899 425 L +175.977 425 L +176.054 425 L +176.132 425 L +176.21 425 L +176.288 425 L +176.365 425 L +176.443 425 L +176.521 425 L +176.598 425 L +176.676 425 L +176.754 425 L +176.832 425 L +176.909 425 L +176.987 425 L +177.065 425 L +177.143 425 L +177.22 425 L +177.298 425 L +177.376 425 L +177.454 425 L +177.531 425 L +177.609 425 L +177.687 425 L +177.764 425 L +177.842 425 L +177.92 425 L +177.998 425 L +178.075 425 L +178.153 425 L +178.231 425 L +178.309 425 L +178.386 425 L +178.464 425 L +178.542 425 L +178.62 425 L +178.697 425 L +178.775 425 L +178.853 425 L +178.93 425 L +179.008 425 L +179.086 425 L +179.164 425 L +179.241 425 L +179.319 425 L +179.397 425 L +179.475 425 L +179.552 425 L +179.63 425 L +179.708 425 L +179.786 425 L +179.863 425 L +179.941 425 L +180.019 425 L +180.096 425 L +180.174 425 L +180.252 425 L +180.33 425 L +180.407 425 L +180.485 425 L +180.563 425 L +180.641 425 L +180.718 425 L +180.796 425 L +180.874 425 L +180.952 425 L +181.029 425 L +181.107 425 L +181.185 425 L +181.262 425 L +181.34 425 L +181.418 425 L +181.496 425 L +181.573 425 L +181.651 425 L +181.729 425 L +181.807 425 L +181.884 425 L +181.962 425 L +182.04 425 L +182.118 425 L +182.195 425 L +182.273 425 L +182.351 425 L +182.429 425 L +182.506 425 L +182.584 425 L +182.662 425 L +182.739 425 L +182.817 425 L +182.895 425 L +182.973 425 L +183.05 425 L +183.128 425 L +183.206 425 L +183.284 425 L +183.361 425 L +183.439 425 L +183.517 425 L +183.595 425 L +183.672 425 L +183.75 425 L +183.828 425 L +183.905 425 L +183.983 425 L +184.061 425 L +184.139 425 L +184.216 425 L +184.294 425 L +184.372 425 L +184.45 425 L +184.527 425 L +184.605 425 L +184.683 425 L +184.761 425 L +184.838 425 L +184.916 425 L +184.994 425 L +185.071 425 L +185.149 425 L +185.227 425 L +185.305 425 L +185.382 425 L +185.46 425 L +185.538 425 L +185.616 425 L +185.693 425 L +185.771 425 L +185.849 425 L +185.927 425 L +186.004 425 L +186.082 425 L +186.16 425 L +186.238 425 L +186.315 425 L +186.393 425 L +186.471 425 L +186.548 425 L +186.626 425 L +186.704 425 L +186.782 425 L +186.859 425 L +186.937 425 L +187.015 425 L +187.093 425 L +187.17 425 L +187.248 425 L +187.326 425 L +187.404 425 L +187.481 425 L +187.559 425 L +187.637 425 L +187.714 425 L +187.792 425 L +187.87 425 L +187.948 425 L +188.025 425 L +188.103 425 L +188.181 425 L +188.259 425 L +188.336 425 L +188.414 425 L +188.492 425 L +188.57 425 L +188.647 425 L +188.725 425 L +188.803 425 L +188.88 425 L +188.958 425 L +189.036 425 L +189.114 425 L +189.191 425 L +189.269 425 L +189.347 425 L +189.425 425 L +189.502 425 L +189.58 425 L +189.658 425 L +189.736 425 L +189.813 425 L +189.891 425 L +189.969 425 L +190.046 425 L +190.124 425 L +190.202 425 L +190.28 425 L +190.357 425 L +190.435 425 L +190.513 425 L +190.591 425 L +190.668 425 L +190.746 425 L +190.824 425 L +190.902 425 L +190.979 425 L +191.057 425 L +191.135 425 L +191.212 425 L +191.29 425 L +191.368 425 L +191.446 425 L +191.523 425 L +191.601 425 L +191.679 425 L +191.757 425 L +191.834 425 L +191.912 425 L +191.99 425 L +192.068 425 L +192.145 425 L +192.223 425 L +192.301 425 L +192.379 425 L +192.456 425 L +192.534 425 L +192.612 425 L +192.689 425 L +192.767 425 L +192.845 425 L +192.923 425 L +193 425 L +193.078 425 L +193.156 425 L +193.234 425 L +193.311 425 L +193.389 425 L +193.467 425 L +193.545 425 L +193.622 425 L +193.7 425 L +193.778 425 L +193.855 425 L +193.933 425 L +194.011 425 L +194.089 425 L +194.166 425 L +194.244 425 L +194.322 425 L +194.4 425 L +194.477 425 L +194.555 425 L +194.633 425 L +194.711 425 L +194.788 425 L +194.866 425 L +194.944 425 L +195.021 425 L +195.099 425 L +195.177 425 L +195.255 425 L +195.332 425 L +195.41 425 L +195.488 425 L +195.566 425 L +195.643 425 L +195.721 425 L +195.799 425 L +195.877 425 L +195.954 425 L +196.032 425 L +196.11 425 L +196.188 425 L +196.265 425 L +196.343 425 L +196.421 425 L +196.498 425 L +196.576 425 L +196.654 425 L +196.732 425 L +196.809 425 L +196.887 425 L +196.965 425 L +197.043 425 L +197.12 425 L +197.198 425 L +197.276 425 L +197.354 425 L +197.431 425 L +197.509 425 L +197.587 425 L +197.664 425 L +197.742 425 L +197.82 425 L +197.898 425 L +197.975 425 L +198.053 425 L +198.131 425 L +198.209 425 L +198.286 425 L +198.364 425 L +198.442 425 L +198.52 425 L +198.597 425 L +198.675 425 L +198.753 425 L +198.83 425 L +198.908 425 L +198.986 425 L +199.064 425 L +199.141 425 L +199.219 425 L +199.297 425 L +199.375 425 L +199.452 425 L +199.53 425 L +199.608 425 L +199.686 425 L +199.763 425 L +199.841 425 L +199.919 425 L +199.996 425 L +200.074 425 L +200.152 425 L +200.23 425 L +200.307 425 L +200.385 425 L +200.463 425 L +200.541 425 L +200.618 425 L +200.696 425 L +200.774 425 L +200.852 425 L +200.929 425 L +201.007 425 L +201.085 425 L +201.163 425 L +201.24 425 L +201.318 425 L +201.396 425 L +201.473 425 L +201.551 425 L +201.629 425 L +201.707 425 L +201.784 425 L +201.862 425 L +201.94 425 L +202.018 425 L +202.095 425 L +202.173 425 L +202.251 425 L +202.329 425 L +202.406 425 L +202.484 425 L +202.562 425 L +202.639 425 L +202.717 425 L +202.795 425 L +202.873 425 L +202.95 425 L +203.028 425 L +203.106 425 L +203.184 425 L +203.261 425 L +203.339 425 L +203.417 425 L +203.495 425 L +203.572 425 L +203.65 425 L +203.728 425 L +203.805 425 L +203.883 425 L +203.961 425 L +204.039 425 L +204.116 425 L +204.194 425 L +204.272 425 L +204.35 425 L +204.427 425 L +204.505 425 L +204.583 425 L +204.661 425 L +204.738 425 L +204.816 425 L +204.894 425 L +204.971 425 L +205.049 425 L +205.127 425 L +205.205 425 L +205.282 425 L +205.36 425 L +205.438 425 L +205.516 425 L +205.593 425 L +205.671 425 L +205.749 425 L +205.827 425 L +205.904 425 L +205.982 425 L +206.06 425 L +206.137 425 L +206.215 425 L +206.293 425 L +206.371 425 L +206.448 425 L +206.526 425 L +206.604 425 L +206.682 425 L +206.759 425 L +206.837 425 L +206.915 425 L +206.993 425 L +207.07 425 L +207.148 425 L +207.226 425 L +207.304 425 L +207.381 425 L +207.459 425 L +207.537 425 L +207.614 425 L +207.692 425 L +207.77 425 L +207.848 425 L +207.925 425 L +208.003 425 L +208.081 425 L +208.159 425 L +208.236 425 L +208.314 425 L +208.392 425 L +208.47 425 L +208.547 425 L +208.625 425 L +208.703 425 L +208.78 425 L +208.858 425 L +208.936 425 L +209.014 425 L +209.091 425 L +209.169 425 L +209.247 425 L +209.325 425 L +209.402 425 L +209.48 425 L +209.558 425 L +209.636 425 L +209.713 425 L +209.791 425 L +209.869 425 L +209.946 425 L +210.024 425 L +210.102 425 L +210.18 425 L +210.257 425 L +210.335 425 L +210.413 425 L +210.491 425 L +210.568 425 L +210.646 425 L +210.724 425 L +210.802 425 L +210.879 425 L +210.957 425 L +211.035 425 L +211.113 425 L +211.19 425 L +211.268 425 L +211.346 425 L +211.423 425 L +211.501 425 L +211.579 425 L +211.657 425 L +211.734 425 L +211.812 425 L +211.89 425 L +211.968 425 L +212.045 425 L +212.123 425 L +212.201 425 L +212.279 425 L +212.356 425 L +212.434 425 L +212.512 425 L +212.589 425 L +212.667 425 L +212.745 425 L +212.823 425 L +212.9 425 L +212.978 425 L +213.056 425 L +213.134 425 L +213.211 425 L +213.289 425 L +213.367 425 L +213.445 425 L +213.522 425 L +213.6 425 L +213.678 425 L +213.755 425 L +213.833 425 L +213.911 425 L +213.989 425 L +214.066 425 L +214.144 425 L +214.222 425 L +214.3 425 L +214.377 425 L +214.455 425 L +214.533 425 L +214.611 425 L +214.688 425 L +214.766 425 L +214.844 425 L +214.921 425 L +214.999 425 L +215.077 425 L +215.155 425 L +215.232 425 L +215.31 425 L +215.388 425 L +215.466 425 L +215.543 425 L +215.621 425 L +215.699 425 L +215.777 425 L +215.854 425 L +215.932 425 L +216.01 425 L +216.087 425 L +216.165 425 L +216.243 425 L +216.321 425 L +216.398 425 L +216.476 425 L +216.554 425 L +216.632 425 L +216.709 425 L +216.787 425 L +216.865 425 L +216.943 425 L +217.02 425 L +217.098 425 L +217.176 425 L +217.254 425 L +217.331 425 L +217.409 425 L +217.487 425 L +217.564 425 L +217.642 425 L +217.72 425 L +217.798 425 L +217.875 425 L +217.953 425 L +218.031 425 L +218.109 425 L +218.186 425 L +218.264 425 L +218.342 425 L +218.42 425 L +218.497 425 L +218.575 425 L +218.653 425 L +218.73 425 L +218.808 425 L +218.886 425 L +218.964 425 L +219.041 425 L +219.119 425 L +219.197 425 L +219.275 425 L +219.352 425 L +219.43 425 L +219.508 425 L +219.586 425 L +219.663 425 L +219.741 425 L +219.819 425 L +219.896 425 L +219.974 425 L +220.052 425 L +220.13 425 L +220.207 425 L +220.285 425 L +220.363 425 L +220.441 425 L +220.518 425 L +220.596 425 L +220.674 425 L +220.752 425 L +220.829 425 L +220.907 425 L +220.985 425 L +221.063 425 L +221.14 425 L +221.218 425 L +221.296 425 L +221.373 425 L +221.451 425 L +221.529 425 L +221.607 425 L +221.684 425 L +221.762 425 L +221.84 425 L +221.918 425 L +221.995 425 L +222.073 425 L +222.151 425 L +222.229 425 L +222.306 425 L +222.384 425 L +222.462 425 L +222.539 425 L +222.617 425 L +222.695 425 L +222.773 425 L +222.85 425 L +222.928 425 L +223.006 425 L +223.084 425 L +223.161 425 L +223.239 425 L +223.317 425 L +223.395 425 L +223.472 425 L +223.55 425 L +223.628 425 L +223.705 425 L +223.783 425 L +223.861 425 L +223.939 425 L +224.016 425 L +224.094 425 L +224.172 425 L +224.25 425 L +224.327 425 L +224.405 425 L +224.483 425 L +224.561 425 L +224.638 425 L +224.716 425 L +224.794 425 L +224.871 425 L +224.949 425 L +225.027 425 L +225.105 425 L +225.182 425 L +225.26 425 L +225.338 425 L +225.416 425 L +225.493 425 L +225.571 425 L +225.649 425 L +225.727 425 L +225.804 425 L +225.882 425 L +225.96 425 L +226.038 425 L +226.115 425 L +226.193 425 L +226.271 425 L +226.348 425 L +226.426 425 L +226.504 425 L +226.582 425 L +226.659 425 L +226.737 425 L +226.815 425 L +226.893 425 L +226.97 425 L +227.048 425 L +227.126 425 L +227.204 425 L +227.281 425 L +227.359 425 L +227.437 425 L +227.514 425 L +227.592 425 L +227.67 425 L +227.748 425 L +227.825 425 L +227.903 425 L +227.981 425 L +228.059 425 L +228.136 425 L +228.214 425 L +228.292 425 L +228.37 425 L +228.447 425 L +228.525 425 L +228.603 425 L +228.68 425 L +228.758 425 L +228.836 425 L +228.914 425 L +228.991 425 L +229.069 425 L +229.147 425 L +229.225 425 L +229.302 425 L +229.38 425 L +229.458 425 L +229.536 425 L +229.613 425 L +229.691 425 L +229.769 425 L +229.846 425 L +229.924 425 L +230.002 425 L +230.08 425 L +230.157 425 L +230.235 425 L +230.313 425 L +230.391 425 L +230.468 425 L +230.546 425 L +230.624 425 L +230.702 425 L +230.779 425 L +230.857 425 L +230.935 425 L +231.012 425 L +231.09 425 L +231.168 425 L +231.246 425 L +231.323 425 L +231.401 425 L +231.479 425 L +231.557 425 L +231.634 425 L +231.712 425 L +231.79 425 L +231.868 425 L +231.945 425 L +232.023 425 L +232.101 425 L +232.179 425 L +232.256 425 L +232.334 425 L +232.412 425 L +232.489 425 L +232.567 425 L +232.645 425 L +232.723 425 L +232.8 425 L +232.878 425 L +232.956 425 L +233.034 425 L +233.111 425 L +233.189 425 L +233.267 425 L +233.345 425 L +233.422 425 L +233.5 425 L +233.578 425 L +233.655 425 L +233.733 425 L +233.811 425 L +233.889 425 L +233.966 425 L +234.044 425 L +234.122 425 L +234.2 425 L +234.277 425 L +234.355 425 L +234.433 425 L +234.511 425 L +234.588 425 L +234.666 425 L +234.744 425 L +234.821 425 L +234.899 425 L +234.977 425 L +235.055 425 L +235.132 425 L +235.21 425 L +235.288 425 L +235.366 425 L +235.443 425 L +235.521 425 L +235.599 425 L +235.677 425 L +235.754 425 L +235.832 425 L +235.91 425 L +235.988 425 L +236.065 425 L +236.143 425 L +236.221 425 L +236.298 425 L +236.376 425 L +236.454 425 L +236.532 425 L +236.609 425 L +236.687 425 L +236.765 425 L +236.843 425 L +236.92 425 L +236.998 425 L +237.076 425 L +237.154 425 L +237.231 425 L +237.309 425 L +237.387 425 L +237.464 425 L +237.542 425 L +237.62 425 L +237.698 425 L +237.775 425 L +237.853 425 L +237.931 425 L +238.009 425 L +238.086 425 L +238.164 425 L +238.242 425 L +238.32 425 L +238.397 425 L +238.475 425 L +238.553 425 L +238.63 425 L +238.708 425 L +238.786 425 L +238.864 425 L +238.941 425 L +239.019 425 L +239.097 425 L +239.175 425 L +239.252 425 L +239.33 425 L +239.408 425 L +239.486 425 L +239.563 425 L +239.641 425 L +239.719 425 L +239.796 425 L +239.874 425 L +239.952 425 L +240.03 425 L +240.107 425 L +240.185 425 L +240.263 425 L +240.341 425 L +240.418 425 L +240.496 425 L +240.574 425 L +240.652 425 L +240.729 425 L +240.807 425 L +240.885 425 L +240.962 425 L +241.04 425 L +241.118 425 L +241.196 425 L +241.273 425 L +241.351 425 L +241.429 425 L +241.507 425 L +241.584 425 L +241.662 425 L +241.74 425 L +241.818 425 L +241.895 425 L +241.973 425 L +242.051 425 L +242.129 425 L +242.206 425 L +242.284 425 L +242.362 425 L +242.439 425 L +242.517 425 L +242.595 425 L +242.673 425 L +242.75 425 L +242.828 425 L +242.906 425 L +242.984 425 L +243.061 425 L +243.139 425 L +243.217 425 L +243.295 425 L +243.372 425 L +243.45 425 L +243.528 425 L +243.605 425 L +243.683 425 L +243.761 425 L +243.839 425 L +243.916 425 L +243.994 425 L +244.072 425 L +244.15 425 L +244.227 425 L +244.305 425 L +244.383 425 L +244.461 425 L +244.538 425 L +244.616 425 L +244.694 425 L +244.771 425 L +244.849 425 L +244.927 425 L +245.005 425 L +245.082 425 L +245.16 425 L +245.238 425 L +245.316 425 L +245.393 425 L +245.471 425 L +245.549 425 L +245.627 425 L +245.704 425 L +245.782 425 L +245.86 425 L +245.938 425 L +246.015 425 L +246.093 425 L +246.171 425 L +246.248 425 L +246.326 425 L +246.404 425 L +246.482 425 L +246.559 425 L +246.637 425 L +246.715 425 L +246.793 425 L +246.87 425 L +246.948 425 L +247.026 425 L +247.104 425 L +247.181 425 L +247.259 425 L +247.337 425 L +247.414 425 L +247.492 425 L +247.57 425 L +247.648 425 L +247.725 425 L +247.803 425 L +247.881 425 L +247.959 425 L +248.036 425 L +248.114 425 L +248.192 425 L +248.27 425 L +248.347 425 L +248.425 425 L +248.503 425 L +248.58 425 L +248.658 425 L +248.736 425 L +248.814 425 L +248.891 425 L +248.969 425 L +249.047 425 L +249.125 425 L +249.202 425 L +249.28 425 L +249.358 425 L +249.436 425 L +249.513 425 L +249.591 425 L +249.669 425 L +249.746 425 L +249.824 425 L +249.902 425 L +249.98 425 L +250.057 425 L +250.135 425 L +250.213 425 L +250.291 425 L +250.368 425 L +250.446 425 L +250.524 425 L +250.602 425 L +250.679 425 L +250.757 425 L +250.835 425 L +250.913 425 L +250.99 425 L +251.068 425 L +251.146 425 L +251.223 425 L +251.301 425 L +251.379 425 L +251.457 425 L +251.534 425 L +251.612 425 L +251.69 425 L +251.768 425 L +251.845 425 L +251.923 425 L +252.001 425 L +252.079 425 L +252.156 425 L +252.234 425 L +252.312 425 L +252.389 425 L +252.467 425 L +252.545 425 L +252.623 425 L +252.7 425 L +252.778 425 L +252.856 425 L +252.934 425 L +253.011 425 L +253.089 425 L +253.167 425 L +253.245 425 L +253.322 425 L +253.4 425 L +253.478 425 L +253.555 425 L +253.633 425 L +253.711 425 L +253.789 425 L +253.866 425 L +253.944 425 L +254.022 425 L +254.1 425 L +254.177 425 L +254.255 425 L +254.333 425 L +254.411 425 L +254.488 425 L +254.566 425 L +254.644 425 L +254.721 425 L +254.799 425 L +254.877 425 L +254.955 425 L +255.032 425 L +255.11 425 L +255.188 425 L +255.266 425 L +255.343 425 L +255.421 425 L +255.499 425 L +255.577 425 L +255.654 425 L +255.732 425 L +255.81 425 L +255.887 425 L +255.965 425 L +256.043 425 L +256.121 425 L +256.198 425 L +256.276 425 L +256.354 425 L +256.432 425 L +256.509 425 L +256.587 425 L +256.665 425 L +256.743 425 L +256.82 425 L +256.898 425 L +256.976 425 L +257.054 425 L +257.131 425 L +257.209 425 L +257.287 425 L +257.364 425 L +257.442 425 L +257.52 425 L +257.598 425 L +257.675 425 L +257.753 425 L +257.831 425 L +257.909 425 L +257.986 425 L +258.064 425 L +258.142 425 L +258.22 425 L +258.297 425 L +258.375 425 L +258.453 425 L +258.53 425 L +258.608 425 L +258.686 425 L +258.764 425 L +258.841 425 L +258.919 425 L +258.997 425 L +259.075 425 L +259.152 425 L +259.23 425 L +259.308 425 L +259.386 425 L +259.463 425 L +259.541 425 L +259.619 425 L +259.696 425 L +259.774 425 L +259.852 425 L +259.93 425 L +260.007 425 L +260.085 425 L +260.163 425 L +260.241 425 L +260.318 425 L +260.396 425 L +260.474 425 L +260.552 425 L +260.629 425 L +260.707 425 L +260.785 425 L +260.862 425 L +260.94 425 L +261.018 425 L +261.096 425 L +261.173 425 L +261.251 425 L +261.329 425 L +261.407 425 L +261.484 425 L +261.562 425 L +261.64 425 L +261.718 425 L +261.795 425 L +261.873 425 L +261.951 425 L +262.029 425 L +262.106 425 L +262.184 425 L +262.262 425 L +262.339 425 L +262.417 425 L +262.495 425 L +262.573 425 L +262.65 425 L +262.728 425 L +262.806 425 L +262.884 425 L +262.961 425 L +263.039 425 L +263.117 425 L +263.195 425 L +263.272 425 L +263.35 425 L +263.428 425 L +263.505 425 L +263.583 425 L +263.661 425 L +263.739 425 L +263.816 425 L +263.894 425 L +263.972 425 L +264.05 425 L +264.127 425 L +264.205 425 L +264.283 425 L +264.361 425 L +264.438 425 L +264.516 425 L +264.594 425 L +264.671 425 L +264.749 425 L +264.827 425 L +264.905 425 L +264.982 425 L +265.06 425 L +265.138 425 L +265.216 425 L +265.293 425 L +265.371 425 L +265.449 425 L +265.527 425 L +265.604 425 L +265.682 425 L +265.76 425 L +265.837 425 L +265.915 425 L +265.993 425 L +266.071 425 L +266.148 425 L +266.226 425 L +266.304 425 L +266.382 425 L +266.459 425 L +266.537 425 L +266.615 425 L +266.693 425 L +266.77 425 L +266.848 425 L +266.926 425 L +267.004 425 L +267.081 425 L +267.159 425 L +267.237 425 L +267.314 425 L +267.392 425 L +267.47 425 L +267.548 425 L +267.625 425 L +267.703 425 L +267.781 425 L +267.859 425 L +267.936 425 L +268.014 425 L +268.092 425 L +268.17 425 L +268.247 425 L +268.325 425 L +268.403 425 L +268.48 425 L +268.558 425 L +268.636 425 L +268.714 425 L +268.791 425 L +268.869 425 L +268.947 425 L +269.025 425 L +269.102 425 L +269.18 425 L +269.258 425 L +269.336 425 L +269.413 425 L +269.491 425 L +269.569 425 L +269.646 425 L +269.724 425 L +269.802 425 L +269.88 425 L +269.957 425 L +270.035 425 L +270.113 425 L +270.191 425 L +270.268 425 L +270.346 425 L +270.424 425 L +270.502 425 L +270.579 425 L +270.657 425 L +270.735 425 L +270.813 425 L +270.89 425 L +270.968 425 L +271.046 425 L +271.123 425 L +271.201 425 L +271.279 425 L +271.357 425 L +271.434 425 L +271.512 425 L +271.59 425 L +271.668 425 L +271.745 425 L +271.823 425 L +271.901 425 L +271.979 425 L +272.056 425 L +272.134 425 L +272.212 425 L +272.289 425 L +272.367 425 L +272.445 425 L +272.523 425 L +272.6 425 L +272.678 425 L +272.756 425 L +272.834 425 L +272.911 425 L +272.989 425 L +273.067 425 L +273.145 425 L +273.222 425 L +273.3 425 L +273.378 425 L +273.455 425 L +273.533 425 L +273.611 425 L +273.689 425 L +273.766 425 L +273.844 425 L +273.922 425 L +274 425 L +274.077 425 L +274.155 425 L +274.233 425 L +274.311 425 L +274.388 425 L +274.466 425 L +274.544 425 L +274.621 424.999 L +274.699 424.999 L +274.777 424.999 L +274.855 424.999 L +274.932 424.999 L +275.01 424.999 L +275.088 424.999 L +275.166 424.999 L +275.243 424.999 L +275.321 424.999 L +275.399 424.999 L +275.477 424.999 L +275.554 424.999 L +275.632 424.999 L +275.71 424.999 L +275.788 424.999 L +275.865 424.999 L +275.943 424.999 L +276.021 424.999 L +276.098 424.999 L +276.176 424.998 L +276.254 424.998 L +276.332 424.998 L +276.409 424.998 L +276.487 424.998 L +276.565 424.998 L +276.643 424.998 L +276.72 424.998 L +276.798 424.997 L +276.876 424.997 L +276.954 424.997 L +277.031 424.997 L +277.109 424.997 L +277.187 424.997 L +277.264 424.996 L +277.342 424.996 L +277.42 424.996 L +277.498 424.996 L +277.575 424.996 L +277.653 424.995 L +277.731 424.995 L +277.809 424.995 L +277.886 424.995 L +277.964 424.994 L +278.042 424.994 L +278.12 424.993 L +278.197 424.993 L +278.275 424.993 L +278.353 424.992 L +278.43 424.992 L +278.508 424.991 L +278.586 424.991 L +278.664 424.99 L +278.741 424.99 L +278.819 424.989 L +278.897 424.988 L +278.975 424.988 L +279.052 424.987 L +279.13 424.986 L +279.208 424.986 L +279.286 424.985 L +279.363 424.984 L +279.441 424.983 L +279.519 424.982 L +279.596 424.981 L +279.674 424.98 L +279.752 424.979 L +279.83 424.977 L +279.907 424.976 L +279.985 424.975 L +280.063 424.973 L +280.141 424.972 L +280.218 424.97 L +280.296 424.968 L +280.374 424.966 L +280.452 424.964 L +280.529 424.962 L +280.607 424.96 L +280.685 424.958 L +280.763 424.955 L +280.84 424.953 L +280.918 424.95 L +280.996 424.947 L +281.073 424.944 L +281.151 424.941 L +281.229 424.937 L +281.307 424.933 L +281.384 424.93 L +281.462 424.925 L +281.54 424.921 L +281.618 424.916 L +281.695 424.912 L +281.773 424.906 L +281.851 424.901 L +281.929 424.895 L +282.006 424.889 L +282.084 424.883 L +282.162 424.876 L +282.239 424.868 L +282.317 424.861 L +282.395 424.853 L +282.473 424.844 L +282.55 424.835 L +282.628 424.825 L +282.706 424.815 L +282.784 424.805 L +282.861 424.793 L +282.939 424.781 L +283.017 424.768 L +283.095 424.755 L +283.172 424.74 L +283.25 424.725 L +283.328 424.709 L +283.405 424.692 L +283.483 424.674 L +283.561 424.656 L +283.639 424.635 L +283.716 424.614 L +283.794 424.592 L +283.872 424.568 L +283.95 424.543 L +284.027 424.516 L +284.105 424.488 L +284.183 424.458 L +284.261 424.427 L +284.338 424.393 L +284.416 424.358 L +284.494 424.321 L +284.571 424.281 L +284.649 424.239 L +284.727 424.195 L +284.805 424.148 L +284.882 424.098 L +284.96 424.046 L +285.038 423.991 L +285.116 423.932 L +285.193 423.87 L +285.271 423.804 L +285.349 423.734 L +285.427 423.661 L +285.504 423.583 L +285.582 423.501 L +285.66 423.414 L +285.737 423.322 L +285.815 423.224 L +285.893 423.121 L +285.971 423.012 L +286.048 422.897 L +286.126 422.775 L +286.204 422.646 L +286.282 422.509 L +286.359 422.365 L +286.437 422.213 L +286.515 422.051 L +286.593 421.881 L +286.67 421.7 L +286.748 421.51 L +286.826 421.308 L +286.904 421.095 L +286.981 420.869 L +287.059 420.631 L +287.137 420.38 L +287.214 420.113 L +287.292 419.832 L +287.37 419.535 L +287.448 419.221 L +287.525 418.889 L +287.603 418.539 L +287.681 418.169 L +287.759 417.778 L +287.836 417.365 L +287.914 416.929 L +287.992 416.469 L +288.07 415.983 L +288.147 415.47 L +288.225 414.928 L +288.303 414.357 L +288.38 413.754 L +288.458 413.118 L +288.536 412.448 L +288.614 411.741 L +288.691 410.995 L +288.769 410.21 L +288.847 409.382 L +288.925 408.509 L +289.002 407.591 L +289.08 406.623 L +289.158 405.605 L +289.236 404.534 L +289.313 403.406 L +289.391 402.221 L +289.469 400.974 L +289.546 399.664 L +289.624 398.288 L +289.702 396.843 L +289.78 395.326 L +289.857 393.735 L +289.935 392.066 L +290.013 390.317 L +290.091 388.484 L +290.168 386.565 L +290.246 384.556 L +290.324 382.456 L +290.402 380.26 L +290.479 377.966 L +290.557 375.572 L +290.635 373.074 L +290.712 370.47 L +290.79 367.758 L +290.868 364.935 L +290.946 362 L +291.023 358.949 L +291.101 355.783 L +291.179 352.499 L +291.257 349.095 L +291.334 345.573 L +291.412 341.93 L +291.49 338.167 L +291.568 334.284 L +291.645 330.281 L +291.723 326.161 L +291.801 321.924 L +291.879 317.573 L +291.956 313.11 L +292.034 308.538 L +292.112 303.862 L +292.189 299.084 L +292.267 294.21 L +292.345 289.244 L +292.423 284.193 L +292.5 279.062 L +292.578 273.858 L +292.656 268.587 L +292.734 263.258 L +292.811 257.878 L +292.889 252.455 L +292.967 246.997 L +293.045 241.513 L +293.122 236.011 L +293.2 230.5 L +293.278 224.989 L +293.355 219.487 L +293.433 214.003 L +293.511 208.545 L +293.589 203.122 L +293.666 197.742 L +293.744 192.413 L +293.822 187.142 L +293.9 181.938 L +293.977 176.807 L +294.055 171.756 L +294.133 166.79 L +294.211 161.916 L +294.288 157.138 L +294.366 152.462 L +294.444 147.89 L +294.521 143.427 L +294.599 139.076 L +294.677 134.839 L +294.755 130.719 L +294.832 126.716 L +294.91 122.833 L +294.988 119.07 L +295.066 115.427 L +295.143 111.905 L +295.221 108.501 L +295.299 105.217 L +295.377 102.051 L +295.454 99 L +295.532 96.065 L +295.61 93.242 L +295.688 90.53 L +295.765 87.926 L +295.843 85.428 L +295.921 83.034 L +295.998 80.74 L +296.076 78.544 L +296.154 76.444 L +296.232 74.435 L +296.309 72.516 L +296.387 70.683 L +296.465 68.934 L +296.543 67.265 L +296.62 65.674 L +296.698 64.157 L +296.776 62.712 L +296.854 61.336 L +296.931 60.026 L +297.009 58.779 L +297.087 57.594 L +297.164 56.466 L +297.242 55.395 L +297.32 54.377 L +297.398 53.409 L +297.475 52.491 L +297.553 51.618 L +297.631 50.791 L +297.709 50.005 L +297.786 49.259 L +297.864 48.552 L +297.942 47.882 L +298.02 47.246 L +298.097 46.643 L +298.175 46.072 L +298.253 45.53 L +298.33 45.017 L +298.408 44.531 L +298.486 44.071 L +298.564 43.635 L +298.641 43.222 L +298.719 42.831 L +298.797 42.461 L +298.875 42.111 L +298.952 41.779 L +299.03 41.465 L +299.108 41.168 L +299.186 40.887 L +299.263 40.62 L +299.341 40.369 L +299.419 40.131 L +299.496 39.905 L +299.574 39.692 L +299.652 39.49 L +299.73 39.3 L +299.807 39.119 L +299.885 38.949 L +299.963 38.787 L +300.041 38.635 L +300.118 38.491 L +300.196 38.354 L +300.274 38.225 L +300.352 38.103 L +300.429 37.988 L +300.507 37.879 L +300.585 37.776 L +300.663 37.678 L +300.74 37.586 L +300.818 37.499 L +300.896 37.417 L +300.973 37.339 L +301.051 37.266 L +301.129 37.196 L +301.207 37.13 L +301.284 37.068 L +301.362 37.01 L +301.44 36.954 L +301.518 36.902 L +301.595 36.852 L +301.673 36.805 L +301.751 36.761 L +301.829 36.719 L +301.906 36.679 L +301.984 36.642 L +302.062 36.607 L +302.139 36.573 L +302.217 36.542 L +302.295 36.512 L +302.373 36.484 L +302.45 36.457 L +302.528 36.432 L +302.606 36.408 L +302.684 36.386 L +302.761 36.365 L +302.839 36.344 L +302.917 36.325 L +302.995 36.308 L +303.072 36.291 L +303.15 36.275 L +303.228 36.259 L +303.305 36.245 L +303.383 36.232 L +303.461 36.219 L +303.539 36.207 L +303.616 36.196 L +303.694 36.185 L +303.772 36.175 L +303.85 36.165 L +303.927 36.156 L +304.005 36.147 L +304.083 36.139 L +304.161 36.131 L +304.238 36.124 L +304.316 36.117 L +304.394 36.111 L +304.471 36.105 L +304.549 36.099 L +304.627 36.094 L +304.705 36.088 L +304.782 36.084 L +304.86 36.079 L +304.938 36.075 L +305.016 36.071 L +305.093 36.067 L +305.171 36.063 L +305.249 36.059 L +305.327 36.056 L +305.404 36.053 L +305.482 36.05 L +305.56 36.047 L +305.638 36.045 L +305.715 36.042 L +305.793 36.04 L +305.871 36.038 L +305.948 36.036 L +306.026 36.034 L +306.104 36.032 L +306.182 36.03 L +306.259 36.028 L +306.337 36.027 L +306.415 36.025 L +306.493 36.024 L +306.57 36.023 L +306.648 36.021 L +306.726 36.02 L +306.804 36.019 L +306.881 36.018 L +306.959 36.017 L +307.037 36.016 L +307.114 36.015 L +307.192 36.014 L +307.27 36.014 L +307.348 36.013 L +307.425 36.012 L +307.503 36.012 L +307.581 36.011 L +307.659 36.01 L +307.736 36.01 L +307.814 36.009 L +307.892 36.009 L +307.97 36.008 L +308.047 36.008 L +308.125 36.007 L +308.203 36.007 L +308.28 36.007 L +308.358 36.006 L +308.436 36.006 L +308.514 36.005 L +308.591 36.005 L +308.669 36.005 L +308.747 36.005 L +308.825 36.004 L +308.902 36.004 L +308.98 36.004 L +309.058 36.004 L +309.136 36.004 L +309.213 36.003 L +309.291 36.003 L +309.369 36.003 L +309.446 36.003 L +309.524 36.003 L +309.602 36.002 L +309.68 36.002 L +309.757 36.002 L +309.835 36.002 L +309.913 36.002 L +309.991 36.002 L +310.068 36.002 L +310.146 36.002 L +310.224 36.002 L +310.302 36.001 L +310.379 36.001 L +310.457 36.001 L +310.535 36.001 L +310.612 36.001 L +310.69 36.001 L +310.768 36.001 L +310.846 36.001 L +310.923 36.001 L +311.001 36.001 L +311.079 36.001 L +311.157 36.001 L +311.234 36.001 L +311.312 36.001 L +311.39 36.001 L +311.468 36.001 L +311.545 36.001 L +311.623 36.001 L +311.701 36.001 L +311.779 36.001 L +311.856 36 L +311.934 36 L +312.012 36 L +312.089 36 L +312.167 36 L +312.245 36 L +312.323 36 L +312.4 36 L +312.478 36 L +312.556 36 L +312.634 36 L +312.711 36 L +312.789 36 L +312.867 36 L +312.945 36 L +313.022 36 L +313.1 36 L +313.178 36 L +313.255 36 L +313.333 36 L +313.411 36 L +313.489 36 L +313.566 36 L +313.644 36 L +313.722 36 L +313.8 36 L +313.877 36 L +313.955 36 L +314.033 36 L +314.111 36 L +314.188 36 L +314.266 36 L +314.344 36 L +314.421 36 L +314.499 36 L +314.577 36 L +314.655 36 L +314.732 36 L +314.81 36 L +314.888 36 L +314.966 36 L +315.043 36 L +315.121 36 L +315.199 36 L +315.277 36 L +315.354 36 L +315.432 36 L +315.51 36 L +315.587 36 L +315.665 36 L +315.743 36 L +315.821 36 L +315.898 36 L +315.976 36 L +316.054 36 L +316.132 36 L +316.209 36 L +316.287 36 L +316.365 36 L +316.443 36 L +316.52 36 L +316.598 36 L +316.676 36 L +316.754 36 L +316.831 36 L +316.909 36 L +316.987 36 L +317.064 36 L +317.142 36 L +317.22 36 L +317.298 36 L +317.375 36 L +317.453 36 L +317.531 36 L +317.609 36 L +317.686 36 L +317.764 36 L +317.842 36 L +317.92 36 L +317.997 36 L +318.075 36 L +318.153 36 L +318.23 36 L +318.308 36 L +318.386 36 L +318.464 36 L +318.541 36 L +318.619 36 L +318.697 36 L +318.775 36 L +318.852 36 L +318.93 36 L +319.008 36 L +319.086 36 L +319.163 36 L +319.241 36 L +319.319 36 L +319.396 36 L +319.474 36 L +319.552 36 L +319.63 36 L +319.707 36 L +319.785 36 L +319.863 36 L +319.941 36 L +320.018 36 L +320.096 36 L +320.174 36 L +320.252 36 L +320.329 36 L +320.407 36 L +320.485 36 L +320.563 36 L +320.64 36 L +320.718 36 L +320.796 36 L +320.873 36 L +320.951 36 L +321.029 36 L +321.107 36 L +321.184 36 L +321.262 36 L +321.34 36 L +321.418 36 L +321.495 36 L +321.573 36 L +321.651 36 L +321.729 36 L +321.806 36 L +321.884 36 L +321.962 36 L +322.039 36 L +322.117 36 L +322.195 36 L +322.273 36 L +322.35 36 L +322.428 36 L +322.506 36 L +322.584 36 L +322.661 36 L +322.739 36 L +322.817 36 L +322.895 36 L +322.972 36 L +323.05 36 L +323.128 36 L +323.205 36 L +323.283 36 L +323.361 36 L +323.439 36 L +323.516 36 L +323.594 36 L +323.672 36 L +323.75 36 L +323.827 36 L +323.905 36 L +323.983 36 L +324.061 36 L +324.138 36 L +324.216 36 L +324.294 36 L +324.371 36 L +324.449 36 L +324.527 36 L +324.605 36 L +324.682 36 L +324.76 36 L +324.838 36 L +324.916 36 L +324.993 36 L +325.071 36 L +325.149 36 L +325.227 36 L +325.304 36 L +325.382 36 L +325.46 36 L +325.538 36 L +325.615 36 L +325.693 36 L +325.771 36 L +325.848 36 L +325.926 36 L +326.004 36 L +326.082 36 L +326.159 36 L +326.237 36 L +326.315 36 L +326.393 36 L +326.47 36 L +326.548 36 L +326.626 36 L +326.704 36 L +326.781 36 L +326.859 36 L +326.937 36 L +327.014 36 L +327.092 36 L +327.17 36 L +327.248 36 L +327.325 36 L +327.403 36 L +327.481 36 L +327.559 36 L +327.636 36 L +327.714 36 L +327.792 36 L +327.87 36 L +327.947 36 L +328.025 36 L +328.103 36 L +328.18 36 L +328.258 36 L +328.336 36 L +328.414 36 L +328.491 36 L +328.569 36 L +328.647 36 L +328.725 36 L +328.802 36 L +328.88 36 L +328.958 36 L +329.036 36 L +329.113 36 L +329.191 36 L +329.269 36 L +329.346 36 L +329.424 36 L +329.502 36 L +329.58 36 L +329.657 36 L +329.735 36 L +329.813 36 L +329.891 36 L +329.968 36 L +330.046 36 L +330.124 36 L +330.202 36 L +330.279 36 L +330.357 36 L +330.435 36 L +330.513 36 L +330.59 36 L +330.668 36 L +330.746 36 L +330.823 36 L +330.901 36 L +330.979 36 L +331.057 36 L +331.134 36 L +331.212 36 L +331.29 36 L +331.368 36 L +331.445 36 L +331.523 36 L +331.601 36 L +331.679 36 L +331.756 36 L +331.834 36 L +331.912 36 L +331.989 36 L +332.067 36 L +332.145 36 L +332.223 36 L +332.3 36 L +332.378 36 L +332.456 36 L +332.534 36 L +332.611 36 L +332.689 36 L +332.767 36 L +332.845 36 L +332.922 36 L +333 36 L +333.078 36 L +333.155 36 L +333.233 36 L +333.311 36 L +333.389 36 L +333.466 36 L +333.544 36 L +333.622 36 L +333.7 36 L +333.777 36 L +333.855 36 L +333.933 36 L +334.011 36 L +334.088 36 L +334.166 36 L +334.244 36 L +334.321 36 L +334.399 36 L +334.477 36 L +334.555 36 L +334.632 36 L +334.71 36 L +334.788 36 L +334.866 36 L +334.943 36 L +335.021 36 L +335.099 36 L +335.177 36 L +335.254 36 L +335.332 36 L +335.41 36 L +335.487 36 L +335.565 36 L +335.643 36 L +335.721 36 L +335.798 36 L +335.876 36 L +335.954 36 L +336.032 36 L +336.109 36 L +336.187 36 L +336.265 36 L +336.343 36 L +336.42 36 L +336.498 36 L +336.576 36 L +336.654 36 L +336.731 36 L +336.809 36 L +336.887 36 L +336.964 36 L +337.042 36 L +337.12 36 L +337.198 36 L +337.275 36 L +337.353 36 L +337.431 36 L +337.509 36 L +337.586 36 L +337.664 36 L +337.742 36 L +337.82 36 L +337.897 36 L +337.975 36 L +338.053 36 L +338.13 36 L +338.208 36 L +338.286 36 L +338.364 36 L +338.441 36 L +338.519 36 L +338.597 36 L +338.675 36 L +338.752 36 L +338.83 36 L +338.908 36 L +338.986 36 L +339.063 36 L +339.141 36 L +339.219 36 L +339.296 36 L +339.374 36 L +339.452 36 L +339.53 36 L +339.607 36 L +339.685 36 L +339.763 36 L +339.841 36 L +339.918 36 L +339.996 36 L +340.074 36 L +340.152 36 L +340.229 36 L +340.307 36 L +340.385 36 L +340.462 36 L +340.54 36 L +340.618 36 L +340.696 36 L +340.773 36 L +340.851 36 L +340.929 36 L +341.007 36 L +341.084 36 L +341.162 36 L +341.24 36 L +341.318 36 L +341.395 36 L +341.473 36 L +341.551 36 L +341.629 36 L +341.706 36 L +341.784 36 L +341.862 36 L +341.939 36 L +342.017 36 L +342.095 36 L +342.173 36 L +342.25 36 L +342.328 36 L +342.406 36 L +342.484 36 L +342.561 36 L +342.639 36 L +342.717 36 L +342.795 36 L +342.872 36 L +342.95 36 L +343.028 36 L +343.105 36 L +343.183 36 L +343.261 36 L +343.339 36 L +343.416 36 L +343.494 36 L +343.572 36 L +343.65 36 L +343.727 36 L +343.805 36 L +343.883 36 L +343.961 36 L +344.038 36 L +344.116 36 L +344.194 36 L +344.271 36 L +344.349 36 L +344.427 36 L +344.505 36 L +344.582 36 L +344.66 36 L +344.738 36 L +344.816 36 L +344.893 36 L +344.971 36 L +345.049 36 L +345.127 36 L +345.204 36 L +345.282 36 L +345.36 36 L +345.438 36 L +345.515 36 L +345.593 36 L +345.671 36 L +345.748 36 L +345.826 36 L +345.904 36 L +345.982 36 L +346.059 36 L +346.137 36 L +346.215 36 L +346.293 36 L +346.37 36 L +346.448 36 L +346.526 36 L +346.604 36 L +346.681 36 L +346.759 36 L +346.837 36 L +346.914 36 L +346.992 36 L +347.07 36 L +347.148 36 L +347.225 36 L +347.303 36 L +347.381 36 L +347.459 36 L +347.536 36 L +347.614 36 L +347.692 36 L +347.77 36 L +347.847 36 L +347.925 36 L +348.003 36 L +348.08 36 L +348.158 36 L +348.236 36 L +348.314 36 L +348.391 36 L +348.469 36 L +348.547 36 L +348.625 36 L +348.702 36 L +348.78 36 L +348.858 36 L +348.936 36 L +349.013 36 L +349.091 36 L +349.169 36 L +349.246 36 L +349.324 36 L +349.402 36 L +349.48 36 L +349.557 36 L +349.635 36 L +349.713 36 L +349.791 36 L +349.868 36 L +349.946 36 L +350.024 36 L +350.102 36 L +350.179 36 L +350.257 36 L +350.335 36 L +350.413 36 L +350.49 36 L +350.568 36 L +350.646 36 L +350.723 36 L +350.801 36 L +350.879 36 L +350.957 36 L +351.034 36 L +351.112 36 L +351.19 36 L +351.268 36 L +351.345 36 L +351.423 36 L +351.501 36 L +351.579 36 L +351.656 36 L +351.734 36 L +351.812 36 L +351.889 36 L +351.967 36 L +352.045 36 L +352.123 36 L +352.2 36 L +352.278 36 L +352.356 36 L +352.434 36 L +352.511 36 L +352.589 36 L +352.667 36 L +352.745 36 L +352.822 36 L +352.9 36 L +352.978 36 L +353.055 36 L +353.133 36 L +353.211 36 L +353.289 36 L +353.366 36 L +353.444 36 L +353.522 36 L +353.6 36 L +353.677 36 L +353.755 36 L +353.833 36 L +353.911 36 L +353.988 36 L +354.066 36 L +354.144 36 L +354.221 36.001 L +354.299 36.001 L +354.377 36.001 L +354.455 36.001 L +354.532 36.001 L +354.61 36.001 L +354.688 36.001 L +354.766 36.001 L +354.843 36.001 L +354.921 36.001 L +354.999 36.001 L +355.077 36.001 L +355.154 36.001 L +355.232 36.001 L +355.31 36.001 L +355.388 36.001 L +355.465 36.001 L +355.543 36.001 L +355.621 36.001 L +355.698 36.001 L +355.776 36.002 L +355.854 36.002 L +355.932 36.002 L +356.009 36.002 L +356.087 36.002 L +356.165 36.002 L +356.243 36.002 L +356.32 36.002 L +356.398 36.002 L +356.476 36.003 L +356.554 36.003 L +356.631 36.003 L +356.709 36.003 L +356.787 36.003 L +356.864 36.004 L +356.942 36.004 L +357.02 36.004 L +357.098 36.004 L +357.175 36.004 L +357.253 36.005 L +357.331 36.005 L +357.409 36.005 L +357.486 36.005 L +357.564 36.006 L +357.642 36.006 L +357.72 36.007 L +357.797 36.007 L +357.875 36.007 L +357.953 36.008 L +358.03 36.008 L +358.108 36.009 L +358.186 36.009 L +358.264 36.01 L +358.341 36.01 L +358.419 36.011 L +358.497 36.012 L +358.575 36.012 L +358.652 36.013 L +358.73 36.014 L +358.808 36.014 L +358.886 36.015 L +358.963 36.016 L +359.041 36.017 L +359.119 36.018 L +359.196 36.019 L +359.274 36.02 L +359.352 36.021 L +359.43 36.023 L +359.507 36.024 L +359.585 36.025 L +359.663 36.027 L +359.741 36.028 L +359.818 36.03 L +359.896 36.032 L +359.974 36.034 L +360.052 36.036 L +360.129 36.038 L +360.207 36.04 L +360.285 36.042 L +360.362 36.045 L +360.44 36.047 L +360.518 36.05 L +360.596 36.053 L +360.673 36.056 L +360.751 36.059 L +360.829 36.063 L +360.907 36.067 L +360.984 36.071 L +361.062 36.075 L +361.14 36.079 L +361.218 36.084 L +361.295 36.088 L +361.373 36.094 L +361.451 36.099 L +361.529 36.105 L +361.606 36.111 L +361.684 36.117 L +361.762 36.124 L +361.839 36.131 L +361.917 36.139 L +361.995 36.147 L +362.073 36.156 L +362.15 36.165 L +362.228 36.175 L +362.306 36.185 L +362.384 36.196 L +362.461 36.207 L +362.539 36.219 L +362.617 36.232 L +362.695 36.245 L +362.772 36.259 L +362.85 36.275 L +362.928 36.291 L +363.005 36.308 L +363.083 36.325 L +363.161 36.344 L +363.239 36.365 L +363.316 36.386 L +363.394 36.408 L +363.472 36.432 L +363.55 36.457 L +363.627 36.484 L +363.705 36.512 L +363.783 36.542 L +363.861 36.573 L +363.938 36.607 L +364.016 36.642 L +364.094 36.679 L +364.171 36.719 L +364.249 36.761 L +364.327 36.805 L +364.405 36.852 L +364.482 36.902 L +364.56 36.954 L +364.638 37.01 L +364.716 37.068 L +364.793 37.13 L +364.871 37.196 L +364.949 37.266 L +365.027 37.339 L +365.104 37.417 L +365.182 37.499 L +365.26 37.586 L +365.337 37.678 L +365.415 37.776 L +365.493 37.879 L +365.571 37.988 L +365.648 38.103 L +365.726 38.225 L +365.804 38.354 L +365.882 38.491 L +365.959 38.635 L +366.037 38.787 L +366.115 38.949 L +366.193 39.119 L +366.27 39.3 L +366.348 39.49 L +366.426 39.692 L +366.504 39.905 L +366.581 40.131 L +366.659 40.369 L +366.737 40.62 L +366.814 40.887 L +366.892 41.168 L +366.97 41.465 L +367.048 41.779 L +367.125 42.111 L +367.203 42.461 L +367.281 42.831 L +367.359 43.222 L +367.436 43.635 L +367.514 44.071 L +367.592 44.531 L +367.67 45.017 L +367.747 45.53 L +367.825 46.072 L +367.903 46.643 L +367.98 47.246 L +368.058 47.882 L +368.136 48.552 L +368.214 49.259 L +368.291 50.005 L +368.369 50.791 L +368.447 51.618 L +368.525 52.491 L +368.602 53.409 L +368.68 54.377 L +368.758 55.395 L +368.836 56.466 L +368.913 57.594 L +368.991 58.779 L +369.069 60.026 L +369.146 61.336 L +369.224 62.712 L +369.302 64.157 L +369.38 65.674 L +369.457 67.265 L +369.535 68.934 L +369.613 70.683 L +369.691 72.516 L +369.768 74.435 L +369.846 76.444 L +369.924 78.544 L +370.002 80.74 L +370.079 83.034 L +370.157 85.428 L +370.235 87.926 L +370.313 90.53 L +370.39 93.242 L +370.468 96.065 L +370.546 99 L +370.623 102.051 L +370.701 105.217 L +370.779 108.501 L +370.857 111.905 L +370.934 115.427 L +371.012 119.07 L +371.09 122.833 L +371.168 126.716 L +371.245 130.719 L +371.323 134.839 L +371.401 139.076 L +371.479 143.427 L +371.556 147.89 L +371.634 152.462 L +371.712 157.138 L +371.789 161.916 L +371.867 166.79 L +371.945 171.756 L +372.023 176.807 L +372.1 181.938 L +372.178 187.142 L +372.256 192.413 L +372.334 197.742 L +372.411 203.122 L +372.489 208.545 L +372.567 214.003 L +372.645 219.487 L +372.722 224.989 L +372.8 230.5 L +372.878 236.011 L +372.955 241.513 L +373.033 246.997 L +373.111 252.455 L +373.189 257.878 L +373.266 263.258 L +373.344 268.587 L +373.422 273.858 L +373.5 279.062 L +373.577 284.193 L +373.655 289.244 L +373.733 294.21 L +373.811 299.084 L +373.888 303.862 L +373.966 308.538 L +374.044 313.11 L +374.121 317.573 L +374.199 321.924 L +374.277 326.161 L +374.355 330.281 L +374.432 334.284 L +374.51 338.167 L +374.588 341.93 L +374.666 345.573 L +374.743 349.095 L +374.821 352.499 L +374.899 355.783 L +374.977 358.949 L +375.054 362 L +375.132 364.935 L +375.21 367.758 L +375.288 370.47 L +375.365 373.074 L +375.443 375.572 L +375.521 377.966 L +375.598 380.26 L +375.676 382.456 L +375.754 384.556 L +375.832 386.565 L +375.909 388.484 L +375.987 390.317 L +376.065 392.066 L +376.143 393.735 L +376.22 395.326 L +376.298 396.843 L +376.376 398.288 L +376.454 399.664 L +376.531 400.974 L +376.609 402.221 L +376.687 403.406 L +376.764 404.534 L +376.842 405.605 L +376.92 406.623 L +376.998 407.591 L +377.075 408.509 L +377.153 409.382 L +377.231 410.21 L +377.309 410.995 L +377.386 411.741 L +377.464 412.448 L +377.542 413.118 L +377.62 413.754 L +377.697 414.357 L +377.775 414.928 L +377.853 415.47 L +377.93 415.983 L +378.008 416.469 L +378.086 416.929 L +378.164 417.365 L +378.241 417.778 L +378.319 418.169 L +378.397 418.539 L +378.475 418.889 L +378.552 419.221 L +378.63 419.535 L +378.708 419.832 L +378.786 420.113 L +378.863 420.38 L +378.941 420.631 L +379.019 420.869 L +379.096 421.095 L +379.174 421.308 L +379.252 421.51 L +379.33 421.7 L +379.407 421.881 L +379.485 422.051 L +379.563 422.213 L +379.641 422.365 L +379.718 422.509 L +379.796 422.646 L +379.874 422.775 L +379.952 422.897 L +380.029 423.012 L +380.107 423.121 L +380.185 423.224 L +380.263 423.322 L +380.34 423.414 L +380.418 423.501 L +380.496 423.583 L +380.573 423.661 L +380.651 423.734 L +380.729 423.804 L +380.807 423.87 L +380.884 423.932 L +380.962 423.991 L +381.04 424.046 L +381.118 424.098 L +381.195 424.148 L +381.273 424.195 L +381.351 424.239 L +381.429 424.281 L +381.506 424.321 L +381.584 424.358 L +381.662 424.393 L +381.739 424.427 L +381.817 424.458 L +381.895 424.488 L +381.973 424.516 L +382.05 424.543 L +382.128 424.568 L +382.206 424.592 L +382.284 424.614 L +382.361 424.635 L +382.439 424.656 L +382.517 424.674 L +382.595 424.692 L +382.672 424.709 L +382.75 424.725 L +382.828 424.74 L +382.905 424.755 L +382.983 424.768 L +383.061 424.781 L +383.139 424.793 L +383.216 424.805 L +383.294 424.815 L +383.372 424.825 L +383.45 424.835 L +383.527 424.844 L +383.605 424.853 L +383.683 424.861 L +383.761 424.868 L +383.838 424.876 L +383.916 424.883 L +383.994 424.889 L +384.071 424.895 L +384.149 424.901 L +384.227 424.906 L +384.305 424.912 L +384.382 424.916 L +384.46 424.921 L +384.538 424.925 L +384.616 424.93 L +384.693 424.933 L +384.771 424.937 L +384.849 424.941 L +384.927 424.944 L +385.004 424.947 L +385.082 424.95 L +385.16 424.953 L +385.237 424.955 L +385.315 424.958 L +385.393 424.96 L +385.471 424.962 L +385.548 424.964 L +385.626 424.966 L +385.704 424.968 L +385.782 424.97 L +385.859 424.972 L +385.937 424.973 L +386.015 424.975 L +386.093 424.976 L +386.17 424.977 L +386.248 424.979 L +386.326 424.98 L +386.404 424.981 L +386.481 424.982 L +386.559 424.983 L +386.637 424.984 L +386.714 424.985 L +386.792 424.986 L +386.87 424.986 L +386.948 424.987 L +387.025 424.988 L +387.103 424.988 L +387.181 424.989 L +387.259 424.99 L +387.336 424.99 L +387.414 424.991 L +387.492 424.991 L +387.57 424.992 L +387.647 424.992 L +387.725 424.993 L +387.803 424.993 L +387.88 424.993 L +387.958 424.994 L +388.036 424.994 L +388.114 424.995 L +388.191 424.995 L +388.269 424.995 L +388.347 424.995 L +388.425 424.996 L +388.502 424.996 L +388.58 424.996 L +388.658 424.996 L +388.736 424.996 L +388.813 424.997 L +388.891 424.997 L +388.969 424.997 L +389.046 424.997 L +389.124 424.997 L +389.202 424.997 L +389.28 424.998 L +389.357 424.998 L +389.435 424.998 L +389.513 424.998 L +389.591 424.998 L +389.668 424.998 L +389.746 424.998 L +389.824 424.998 L +389.902 424.999 L +389.979 424.999 L +390.057 424.999 L +390.135 424.999 L +390.212 424.999 L +390.29 424.999 L +390.368 424.999 L +390.446 424.999 L +390.523 424.999 L +390.601 424.999 L +390.679 424.999 L +390.757 424.999 L +390.834 424.999 L +390.912 424.999 L +390.99 424.999 L +391.068 424.999 L +391.145 424.999 L +391.223 424.999 L +391.301 424.999 L +391.379 424.999 L +391.456 425 L +391.534 425 L +391.612 425 L +391.689 425 L +391.767 425 L +391.845 425 L +391.923 425 L +392 425 L +392.078 425 L +392.156 425 L +392.234 425 L +392.311 425 L +392.389 425 L +392.467 425 L +392.545 425 L +392.622 425 L +392.7 425 L +392.778 425 L +392.855 425 L +392.933 425 L +393.011 425 L +393.089 425 L +393.166 425 L +393.244 425 L +393.322 425 L +393.4 425 L +393.477 425 L +393.555 425 L +393.633 425 L +393.711 425 L +393.788 425 L +393.866 425 L +393.944 425 L +394.021 425 L +394.099 425 L +394.177 425 L +394.255 425 L +394.332 425 L +394.41 425 L +394.488 425 L +394.566 425 L +394.643 425 L +394.721 425 L +394.799 425 L +394.877 425 L +394.954 425 L +395.032 425 L +395.11 425 L +395.188 425 L +395.265 425 L +395.343 425 L +395.421 425 L +395.498 425 L +395.576 425 L +395.654 425 L +395.732 425 L +395.809 425 L +395.887 425 L +395.965 425 L +396.043 425 L +396.12 425 L +396.198 425 L +396.276 425 L +396.354 425 L +396.431 425 L +396.509 425 L +396.587 425 L +396.664 425 L +396.742 425 L +396.82 425 L +396.898 425 L +396.975 425 L +397.053 425 L +397.131 425 L +397.209 425 L +397.286 425 L +397.364 425 L +397.442 425 L +397.52 425 L +397.597 425 L +397.675 425 L +397.753 425 L +397.83 425 L +397.908 425 L +397.986 425 L +398.064 425 L +398.141 425 L +398.219 425 L +398.297 425 L +398.375 425 L +398.452 425 L +398.53 425 L +398.608 425 L +398.686 425 L +398.763 425 L +398.841 425 L +398.919 425 L +398.996 425 L +399.074 425 L +399.152 425 L +399.23 425 L +399.307 425 L +399.385 425 L +399.463 425 L +399.541 425 L +399.618 425 L +399.696 425 L +399.774 425 L +399.852 425 L +399.929 425 L +400.007 425 L +400.085 425 L +400.163 425 L +400.24 425 L +400.318 425 L +400.396 425 L +400.473 425 L +400.551 425 L +400.629 425 L +400.707 425 L +400.784 425 L +400.862 425 L +400.94 425 L +401.018 425 L +401.095 425 L +401.173 425 L +401.251 425 L +401.329 425 L +401.406 425 L +401.484 425 L +401.562 425 L +401.639 425 L +401.717 425 L +401.795 425 L +401.873 425 L +401.95 425 L +402.028 425 L +402.106 425 L +402.184 425 L +402.261 425 L +402.339 425 L +402.417 425 L +402.495 425 L +402.572 425 L +402.65 425 L +402.728 425 L +402.805 425 L +402.883 425 L +402.961 425 L +403.039 425 L +403.116 425 L +403.194 425 L +403.272 425 L +403.35 425 L +403.427 425 L +403.505 425 L +403.583 425 L +403.661 425 L +403.738 425 L +403.816 425 L +403.894 425 L +403.971 425 L +404.049 425 L +404.127 425 L +404.205 425 L +404.282 425 L +404.36 425 L +404.438 425 L +404.516 425 L +404.593 425 L +404.671 425 L +404.749 425 L +404.827 425 L +404.904 425 L +404.982 425 L +405.06 425 L +405.138 425 L +405.215 425 L +405.293 425 L +405.371 425 L +405.448 425 L +405.526 425 L +405.604 425 L +405.682 425 L +405.759 425 L +405.837 425 L +405.915 425 L +405.993 425 L +406.07 425 L +406.148 425 L +406.226 425 L +406.304 425 L +406.381 425 L +406.459 425 L +406.537 425 L +406.614 425 L +406.692 425 L +406.77 425 L +406.848 425 L +406.925 425 L +407.003 425 L +407.081 425 L +407.159 425 L +407.236 425 L +407.314 425 L +407.392 425 L +407.47 425 L +407.547 425 L +407.625 425 L +407.703 425 L +407.78 425 L +407.858 425 L +407.936 425 L +408.014 425 L +408.091 425 L +408.169 425 L +408.247 425 L +408.325 425 L +408.402 425 L +408.48 425 L +408.558 425 L +408.636 425 L +408.713 425 L +408.791 425 L +408.869 425 L +408.946 425 L +409.024 425 L +409.102 425 L +409.18 425 L +409.257 425 L +409.335 425 L +409.413 425 L +409.491 425 L +409.568 425 L +409.646 425 L +409.724 425 L +409.802 425 L +409.879 425 L +409.957 425 L +410.035 425 L +410.112 425 L +410.19 425 L +410.268 425 L +410.346 425 L +410.423 425 L +410.501 425 L +410.579 425 L +410.657 425 L +410.734 425 L +410.812 425 L +410.89 425 L +410.968 425 L +411.045 425 L +411.123 425 L +411.201 425 L +411.279 425 L +411.356 425 L +411.434 425 L +411.512 425 L +411.589 425 L +411.667 425 L +411.745 425 L +411.823 425 L +411.9 425 L +411.978 425 L +412.056 425 L +412.134 425 L +412.211 425 L +412.289 425 L +412.367 425 L +412.445 425 L +412.522 425 L +412.6 425 L +412.678 425 L +412.755 425 L +412.833 425 L +412.911 425 L +412.989 425 L +413.066 425 L +413.144 425 L +413.222 425 L +413.3 425 L +413.377 425 L +413.455 425 L +413.533 425 L +413.611 425 L +413.688 425 L +413.766 425 L +413.844 425 L +413.921 425 L +413.999 425 L +414.077 425 L +414.155 425 L +414.232 425 L +414.31 425 L +414.388 425 L +414.466 425 L +414.543 425 L +414.621 425 L +414.699 425 L +414.777 425 L +414.854 425 L +414.932 425 L +415.01 425 L +415.087 425 L +415.165 425 L +415.243 425 L +415.321 425 L +415.398 425 L +415.476 425 L +415.554 425 L +415.632 425 L +415.709 425 L +415.787 425 L +415.865 425 L +415.943 425 L +416.02 425 L +416.098 425 L +416.176 425 L +416.254 425 L +416.331 425 L +416.409 425 L +416.487 425 L +416.564 425 L +416.642 425 L +416.72 425 L +416.798 425 L +416.875 425 L +416.953 425 L +417.031 425 L +417.109 425 L +417.186 425 L +417.264 425 L +417.342 425 L +417.42 425 L +417.497 425 L +417.575 425 L +417.653 425 L +417.73 425 L +417.808 425 L +417.886 425 L +417.964 425 L +418.041 425 L +418.119 425 L +418.197 425 L +418.275 425 L +418.352 425 L +418.43 425 L +418.508 425 L +418.586 425 L +418.663 425 L +418.741 425 L +418.819 425 L +418.896 425 L +418.974 425 L +419.052 425 L +419.13 425 L +419.207 425 L +419.285 425 L +419.363 425 L +419.441 425 L +419.518 425 L +419.596 425 L +419.674 425 L +419.752 425 L +419.829 425 L +419.907 425 L +419.985 425 L +420.063 425 L +420.14 425 L +420.218 425 L +420.296 425 L +420.373 425 L +420.451 425 L +420.529 425 L +420.607 425 L +420.684 425 L +420.762 425 L +420.84 425 L +420.918 425 L +420.995 425 L +421.073 425 L +421.151 425 L +421.229 425 L +421.306 425 L +421.384 425 L +421.462 425 L +421.539 425 L +421.617 425 L +421.695 425 L +421.773 425 L +421.85 425 L +421.928 425 L +422.006 425 L +422.084 425 L +422.161 425 L +422.239 425 L +422.317 425 L +422.395 425 L +422.472 425 L +422.55 425 L +422.628 425 L +422.705 425 L +422.783 425 L +422.861 425 L +422.939 425 L +423.016 425 L +423.094 425 L +423.172 425 L +423.25 425 L +423.327 425 L +423.405 425 L +423.483 425 L +423.561 425 L +423.638 425 L +423.716 425 L +423.794 425 L +423.871 425 L +423.949 425 L +424.027 425 L +424.105 425 L +424.182 425 L +424.26 425 L +424.338 425 L +424.416 425 L +424.493 425 L +424.571 425 L +424.649 425 L +424.727 425 L +424.804 425 L +424.882 425 L +424.96 425 L +425.038 425 L +425.115 425 L +425.193 425 L +425.271 425 L +425.348 425 L +425.426 425 L +425.504 425 L +425.582 425 L +425.659 425 L +425.737 425 L +425.815 425 L +425.893 425 L +425.97 425 L +426.048 425 L +426.126 425 L +426.204 425 L +426.281 425 L +426.359 425 L +426.437 425 L +426.514 425 L +426.592 425 L +426.67 425 L +426.748 425 L +426.825 425 L +426.903 425 L +426.981 425 L +427.059 425 L +427.136 425 L +427.214 425 L +427.292 425 L +427.37 425 L +427.447 425 L +427.525 425 L +427.603 425 L +427.68 425 L +427.758 425 L +427.836 425 L +427.914 425 L +427.991 425 L +428.069 425 L +428.147 425 L +428.225 425 L +428.302 425 L +428.38 425 L +428.458 425 L +428.536 425 L +428.613 425 L +428.691 425 L +428.769 425 L +428.846 425 L +428.924 425 L +429.002 425 L +429.08 425 L +429.157 425 L +429.235 425 L +429.313 425 L +429.391 425 L +429.468 425 L +429.546 425 L +429.624 425 L +429.702 425 L +429.779 425 L +429.857 425 L +429.935 425 L +430.013 425 L +430.09 425 L +430.168 425 L +430.246 425 L +430.323 425 L +430.401 425 L +430.479 425 L +430.557 425 L +430.634 425 L +430.712 425 L +430.79 425 L +430.868 425 L +430.945 425 L +431.023 425 L +431.101 425 L +431.179 425 L +431.256 425 L +431.334 425 L +431.412 425 L +431.489 425 L +431.567 425 L +431.645 425 L +431.723 425 L +431.8 425 L +431.878 425 L +431.956 425 L +432.034 425 L +432.111 425 L +432.189 425 L +432.267 425 L +432.345 425 L +432.422 425 L +432.5 425 L +432.578 425 L +432.655 425 L +432.733 425 L +432.811 425 L +432.889 425 L +432.966 425 L +433.044 425 L +433.122 425 L +433.2 425 L +433.277 425 L +433.355 425 L +433.433 425 L +433.511 425 L +433.588 425 L +433.666 425 L +433.744 425 L +433.821 425 L +433.899 425 L +433.977 425 L +434.055 425 L +434.132 425 L +434.21 425 L +434.288 425 L +434.366 425 L +434.443 425 L +434.521 425 L +434.599 425 L +434.677 425 L +434.754 425 L +434.832 425 L +434.91 425 L +434.987 425 L +435.065 425 L +435.143 425 L +435.221 425 L +435.298 425 L +435.376 425 L +435.454 425 L +435.532 425 L +435.609 425 L +435.687 425 L +435.765 425 L +435.843 425 L +435.92 425 L +435.998 425 L +436.076 425 L +436.154 425 L +436.231 425 L +436.309 425 L +436.387 425 L +436.464 425 L +436.542 425 L +436.62 425 L +436.698 425 L +436.775 425 L +436.853 425 L +436.931 425 L +437.009 425 L +437.086 425 L +437.164 425 L +437.242 425 L +437.32 425 L +437.397 425 L +437.475 425 L +437.553 425 L +437.63 425 L +437.708 425 L +437.786 425 L +437.864 425 L +437.941 425 L +438.019 425 L +438.097 425 L +438.175 425 L +438.252 425 L +438.33 425 L +438.408 425 L +438.486 425 L +438.563 425 L +438.641 425 L +438.719 425 L +438.796 425 L +438.874 425 L +438.952 425 L +439.03 425 L +439.107 425 L +439.185 425 L +439.263 425 L +439.341 425 L +439.418 425 L +439.496 425 L +439.574 425 L +439.652 425 L +439.729 425 L +439.807 425 L +439.885 425 L +439.962 425 L +440.04 425 L +440.118 425 L +440.196 425 L +440.273 425 L +440.351 425 L +440.429 425 L +440.507 425 L +440.584 425 L +440.662 425 L +440.74 425 L +440.818 425 L +440.895 425 L +440.973 425 L +441.051 425 L +441.129 425 L +441.206 425 L +441.284 425 L +441.362 425 L +441.439 425 L +441.517 425 L +441.595 425 L +441.673 425 L +441.75 425 L +441.828 425 L +441.906 425 L +441.984 425 L +442.061 425 L +442.139 425 L +442.217 425 L +442.295 425 L +442.372 425 L +442.45 425 L +442.528 425 L +442.605 425 L +442.683 425 L +442.761 425 L +442.839 425 L +442.916 425 L +442.994 425 L +443.072 425 L +443.15 425 L +443.227 425 L +443.305 425 L +443.383 425 L +443.461 425 L +443.538 425 L +443.616 425 L +443.694 425 L +443.771 425 L +443.849 425 L +443.927 425 L +444.005 425 L +444.082 425 L +444.16 425 L +444.238 425 L +444.316 425 L +444.393 425 L +444.471 425 L +444.549 425 L +444.627 425 L +444.704 425 L +444.782 425 L +444.86 425 L +444.938 425 L +445.015 425 L +445.093 425 L +445.171 425 L +445.248 425 L +445.326 425 L +445.404 425 L +445.482 425 L +445.559 425 L +445.637 425 L +445.715 425 L +445.793 425 L +445.87 425 L +445.948 425 L +446.026 425 L +446.104 425 L +446.181 425 L +446.259 425 L +446.337 425 L +446.414 425 L +446.492 425 L +446.57 425 L +446.648 425 L +446.725 425 L +446.803 425 L +446.881 425 L +446.959 425 L +447.036 425 L +447.114 425 L +447.192 425 L +447.27 425 L +447.347 425 L +447.425 425 L +447.503 425 L +447.58 425 L +447.658 425 L +447.736 425 L +447.814 425 L +447.891 425 L +447.969 425 L +448.047 425 L +448.125 425 L +448.202 425 L +448.28 425 L +448.358 425 L +448.436 425 L +448.513 425 L +448.591 425 L +448.669 425 L +448.746 425 L +448.824 425 L +448.902 425 L +448.98 425 L +449.057 425 L +449.135 425 L +449.213 425 L +449.291 425 L +449.368 425 L +449.446 425 L +449.524 425 L +449.602 425 L +449.679 425 L +449.757 425 L +449.835 425 L +449.913 425 L +449.99 425 L +450.068 425 L +450.146 425 L +450.223 425 L +450.301 425 L +450.379 425 L +450.457 425 L +450.534 425 L +450.612 425 L +450.69 425 L +450.768 425 L +450.845 425 L +450.923 425 L +451.001 425 L +451.079 425 L +451.156 425 L +451.234 425 L +451.312 425 L +451.389 425 L +451.467 425 L +451.545 425 L +451.623 425 L +451.7 425 L +451.778 425 L +451.856 425 L +451.934 425 L +452.011 425 L +452.089 425 L +452.167 425 L +452.245 425 L +452.322 425 L +452.4 425 L +452.478 425 L +452.555 425 L +452.633 425 L +452.711 425 L +452.789 425 L +452.866 425 L +452.944 425 L +453.022 425 L +453.1 425 L +453.177 425 L +453.255 425 L +453.333 425 L +453.411 425 L +453.488 425 L +453.566 425 L +453.644 425 L +453.721 425 L +453.799 425 L +453.877 425 L +453.955 425 L +454.032 425 L +454.11 425 L +454.188 425 L +454.266 425 L +454.343 425 L +454.421 425 L +454.499 425 L +454.577 425 L +454.654 425 L +454.732 425 L +454.81 425 L +454.888 425 L +454.965 425 L +455.043 425 L +455.121 425 L +455.198 425 L +455.276 425 L +455.354 425 L +455.432 425 L +455.509 425 L +455.587 425 L +455.665 425 L +455.743 425 L +455.82 425 L +455.898 425 L +455.976 425 L +456.054 425 L +456.131 425 L +456.209 425 L +456.287 425 L +456.364 425 L +456.442 425 L +456.52 425 L +456.598 425 L +456.675 425 L +456.753 425 L +456.831 425 L +456.909 425 L +456.986 425 L +457.064 425 L +457.142 425 L +457.22 425 L +457.297 425 L +457.375 425 L +457.453 425 L +457.53 425 L +457.608 425 L +457.686 425 L +457.764 425 L +457.841 425 L +457.919 425 L +457.997 425 L +458.075 425 L +458.152 425 L +458.23 425 L +458.308 425 L +458.386 425 L +458.463 425 L +458.541 425 L +458.619 425 L +458.696 425 L +458.774 425 L +458.852 425 L +458.93 425 L +459.007 425 L +459.085 425 L +459.163 425 L +459.241 425 L +459.318 425 L +459.396 425 L +459.474 425 L +459.552 425 L +459.629 425 L +459.707 425 L +459.785 425 L +459.862 425 L +459.94 425 L +460.018 425 L +460.096 425 L +460.173 425 L +460.251 425 L +460.329 425 L +460.407 425 L +460.484 425 L +460.562 425 L +460.64 425 L +460.718 425 L +460.795 425 L +460.873 425 L +460.951 425 L +461.029 425 L +461.106 425 L +461.184 425 L +461.262 425 L +461.339 425 L +461.417 425 L +461.495 425 L +461.573 425 L +461.65 425 L +461.728 425 L +461.806 425 L +461.884 425 L +461.961 425 L +462.039 425 L +462.117 425 L +462.195 425 L +462.272 425 L +462.35 425 L +462.428 425 L +462.505 425 L +462.583 425 L +462.661 425 L +462.739 425 L +462.816 425 L +462.894 425 L +462.972 425 L +463.05 425 L +463.127 425 L +463.205 425 L +463.283 425 L +463.361 425 L +463.438 425 L +463.516 425 L +463.594 425 L +463.671 425 L +463.749 425 L +463.827 425 L +463.905 425 L +463.982 425 L +464.06 425 L +464.138 425 L +464.216 425 L +464.293 425 L +464.371 425 L +464.449 425 L +464.527 425 L +464.604 425 L +464.682 425 L +464.76 425 L +464.837 425 L +464.915 425 L +464.993 425 L +465.071 425 L +465.148 425 L +465.226 425 L +465.304 425 L +465.382 425 L +465.459 425 L +465.537 425 L +465.615 425 L +465.693 425 L +465.77 425 L +465.848 425 L +465.926 425 L +466.004 425 L +466.081 425 L +466.159 425 L +466.237 425 L +466.314 425 L +466.392 425 L +466.47 425 L +466.548 425 L +466.625 425 L +466.703 425 L +466.781 425 L +466.859 425 L +466.936 425 L +467.014 425 L +467.092 425 L +467.17 425 L +467.247 425 L +467.325 425 L +467.403 425 L +467.48 425 L +467.558 425 L +467.636 425 L +467.714 425 L +467.791 425 L +467.869 425 L +467.947 425 L +468.025 425 L +468.102 425 L +468.18 425 L +468.258 425 L +468.336 425 L +468.413 425 L +468.491 425 L +468.569 425 L +468.646 425 L +468.724 425 L +468.802 425 L +468.88 425 L +468.957 425 L +469.035 425 L +469.113 425 L +469.191 425 L +469.268 425 L +469.346 425 L +469.424 425 L +469.502 425 L +469.579 425 L +469.657 425 L +469.735 425 L +469.813 425 L +469.89 425 L +469.968 425 L +470.046 425 L +470.123 425 L +470.201 425 L +470.279 425 L +470.357 425 L +470.434 425 L +470.512 425 L +470.59 425 L +470.668 425 L +470.745 425 L +470.823 425 L +470.901 425 L +470.979 425 L +471.056 425 L +471.134 425 L +471.212 425 L +471.289 425 L +471.367 425 L +471.445 425 L +471.523 425 L +471.6 425 L +471.678 425 L +471.756 425 L +471.834 425 L +471.911 425 L +471.989 425 L +472.067 425 L +472.145 425 L +472.222 425 L +472.3 425 L +472.378 425 L +472.455 425 L +472.533 425 L +472.611 425 L +472.689 425 L +472.766 425 L +472.844 425 L +472.922 425 L +473 425 L +473.077 425 L +473.155 425 L +473.233 425 L +473.311 425 L +473.388 425 L +473.466 425 L +473.544 425 L +473.621 425 L +473.699 425 L +473.777 425 L +473.855 425 L +473.932 425 L +474.01 425 L +474.088 425 L +474.166 425 L +474.243 425 L +474.321 425 L +474.399 425 L +474.477 425 L +474.554 425 L +474.632 425 L +474.71 425 L +474.788 425 L +474.865 425 L +474.943 425 L +475.021 425 L +475.098 425 L +475.176 425 L +475.254 425 L +475.332 425 L +475.409 425 L +475.487 425 L +475.565 425 L +475.643 425 L +475.72 425 L +475.798 425 L +475.876 425 L +475.954 425 L +476.031 425 L +476.109 425 L +476.187 425 L +476.264 425 L +476.342 425 L +476.42 425 L +476.498 425 L +476.575 425 L +476.653 425 L +476.731 425 L +476.809 425 L +476.886 425 L +476.964 425 L +477.042 425 L +477.12 425 L +477.197 425 L +477.275 425 L +477.353 425 L +477.43 425 L +477.508 425 L +477.586 425 L +477.664 425 L +477.741 425 L +477.819 425 L +477.897 425 L +477.975 425 L +478.052 425 L +478.13 425 L +478.208 425 L +478.286 425 L +478.363 425 L +478.441 425 L +478.519 425 L +478.596 425 L +478.674 425 L +478.752 425 L +478.83 425 L +478.907 425 L +478.985 425 L +479.063 425 L +479.141 425 L +479.218 425 L +479.296 425 L +479.374 425 L +479.452 425 L +479.529 425 L +479.607 425 L +479.685 425 L +479.763 425 L +479.84 425 L +479.918 425 L +479.996 425 L +480.073 425 L +480.151 425 L +480.229 425 L +480.307 425 L +480.384 425 L +480.462 425 L +480.54 425 L +480.618 425 L +480.695 425 L +480.773 425 L +480.851 425 L +480.929 425 L +481.006 425 L +481.084 425 L +481.162 425 L +481.239 425 L +481.317 425 L +481.395 425 L +481.473 425 L +481.55 425 L +481.628 425 L +481.706 425 L +481.784 425 L +481.861 425 L +481.939 425 L +482.017 425 L +482.095 425 L +482.172 425 L +482.25 425 L +482.328 425 L +482.405 425 L +482.483 425 L +482.561 425 L +482.639 425 L +482.716 425 L +482.794 425 L +482.872 425 L +482.95 425 L +483.027 425 L +483.105 425 L +483.183 425 L +483.261 425 L +483.338 425 L +483.416 425 L +483.494 425 L +483.571 425 L +483.649 425 L +483.727 425 L +483.805 425 L +483.882 425 L +483.96 425 L +484.038 425 L +484.116 425 L +484.193 425 L +484.271 425 L +484.349 425 L +484.427 425 L +484.504 425 L +484.582 425 L +484.66 425 L +484.737 425 L +484.815 425 L +484.893 425 L +484.971 425 L +485.048 425 L +485.126 425 L +485.204 425 L +485.282 425 L +485.359 425 L +485.437 425 L +485.515 425 L +485.593 425 L +485.67 425 L +485.748 425 L +485.826 425 L +485.904 425 L +485.981 425 L +486.059 425 L +486.137 425 L +486.214 425 L +486.292 425 L +486.37 425 L +486.448 425 L +486.525 425 L +486.603 425 L +486.681 425 L +486.759 425 L +486.836 425 L +486.914 425 L +486.992 425 L +487.07 425 L +487.147 425 L +487.225 425 L +487.303 425 L +487.38 425 L +487.458 425 L +487.536 425 L +487.614 425 L +487.691 425 L +487.769 425 L +487.847 425 L +487.925 425 L +488.002 425 L +488.08 425 L +488.158 425 L +488.236 425 L +488.313 425 L +488.391 425 L +488.469 425 L +488.546 425 L +488.624 425 L +488.702 425 L +488.78 425 L +488.857 425 L +488.935 425 L +489.013 425 L +489.091 425 L +489.168 425 L +489.246 425 L +489.324 425 L +489.402 425 L +489.479 425 L +489.557 425 L +489.635 425 L +489.712 425 L +489.79 425 L +489.868 425 L +489.946 425 L +490.023 425 L +490.101 425 L +490.179 425 L +490.257 425 L +490.334 425 L +490.412 425 L +490.49 425 L +490.568 425 L +490.645 425 L +490.723 425 L +490.801 425 L +490.879 425 L +490.956 425 L +491.034 425 L +491.112 425 L +491.189 425 L +491.267 425 L +491.345 425 L +491.423 425 L +491.5 425 L +491.578 425 L +491.656 425 L +491.734 425 L +491.811 425 L +491.889 425 L +491.967 425 L +492.045 425 L +492.122 425 L +492.2 425 L +492.278 425 L +492.355 425 L +492.433 425 L +492.511 425 L +492.589 425 L +492.666 425 L +492.744 425 L +492.822 425 L +492.9 425 L +492.977 425 L +493.055 425 L +493.133 425 L +493.211 425 L +493.288 425 L +493.366 425 L +493.444 425 L +493.521 425 L +493.599 425 L +493.677 425 L +493.755 425 L +493.832 425 L +493.91 425 L +493.988 425 L +494.066 425 L +494.143 425 L +494.221 425 L +494.299 425 L +494.377 425 L +494.454 425 L +494.532 425 L +494.61 425 L +494.688 425 L +494.765 425 L +494.843 425 L +494.921 425 L +494.998 425 L +495.076 425 L +495.154 425 L +495.232 425 L +495.309 425 L +495.387 425 L +495.465 425 L +495.543 425 L +495.62 425 L +495.698 425 L +495.776 425 L +495.854 425 L +495.931 425 L +496.009 425 L +496.087 425 L +496.164 425 L +496.242 425 L +496.32 425 L +496.398 425 L +496.475 425 L +496.553 425 L +496.631 425 L +496.709 425 L +496.786 425 L +496.864 425 L +496.942 425 L +497.02 425 L +497.097 425 L +497.175 425 L +497.253 425 L +497.33 425 L +497.408 425 L +497.486 425 L +497.564 425 L +497.641 425 L +497.719 425 L +497.797 425 L +497.875 425 L +497.952 425 L +498.03 425 L +498.108 425 L +498.186 425 L +498.263 425 L +498.341 425 L +498.419 425 L +498.496 425 L +498.574 425 L +498.652 425 L +498.73 425 L +498.807 425 L +498.885 425 L +498.963 425 L +499.041 425 L +499.118 425 L +499.196 425 L +499.274 425 L +499.352 425 L +499.429 425 L +499.507 425 L +499.585 425 L +499.663 425 L +499.74 425 L +499.818 425 L +499.896 425 L +499.973 425 L +500.051 425 L +500.129 425 L +500.207 425 L +500.284 425 L +500.362 425 L +500.44 425 L +500.518 425 L +500.595 425 L +500.673 425 L +500.751 425 L +500.829 425 L +500.906 425 L +500.984 425 L +501.062 425 L +501.139 425 L +501.217 425 L +501.295 425 L +501.373 425 L +501.45 425 L +501.528 425 L +501.606 425 L +501.684 425 L +501.761 425 L +501.839 425 L +501.917 425 L +501.995 425 L +502.072 425 L +502.15 425 L +502.228 425 L +502.305 425 L +502.383 425 L +502.461 425 L +502.539 425 L +502.616 425 L +502.694 425 L +502.772 425 L +502.85 425 L +502.927 425 L +503.005 425 L +503.083 425 L +503.161 425 L +503.238 425 L +503.316 425 L +503.394 425 L +503.471 425 L +503.549 425 L +503.627 425 L +503.705 425 L +503.782 425 L +503.86 425 L +503.938 425 L +504.016 425 L +504.093 425 L +504.171 425 L +504.249 425 L +504.327 425 L +504.404 425 L +504.482 425 L +504.56 425 L +504.638 425 L +504.715 425 L +504.793 425 L +504.871 425 L +504.948 425 L +505.026 425 L +505.104 425 L +505.182 425 L +505.259 425 L +505.337 425 L +505.415 425 L +505.493 425 L +505.57 425 L +505.648 425 L +505.726 425 L +505.804 425 L +505.881 425 L +505.959 425 L +506.037 425 L +506.114 425 L +506.192 425 L +506.27 425 L +506.348 425 L +506.425 425 L +506.503 425 L +506.581 425 L +506.659 425 L +506.736 425 L +506.814 425 L +506.892 425 L +506.97 425 L +507.047 425 L +507.125 425 L +507.203 425 L +507.28 425 L +507.358 425 L +507.436 425 L +507.514 425 L +507.591 425 L +507.669 425 L +507.747 425 L +507.825 425 L +507.902 425 L +507.98 425 L +508.058 425 L +508.136 425 L +508.213 425 L +508.291 425 L +508.369 425 L +508.446 425 L +508.524 425 L +508.602 425 L +508.68 425 L +508.757 425 L +508.835 425 L +508.913 425 L +508.991 425 L +509.068 425 L +509.146 425 L +509.224 425 L +509.302 425 L +509.379 425 L +509.457 425 L +509.535 425 L +509.612 425 L +509.69 425 L +509.768 425 L +509.846 425 L +509.923 425 L +510.001 425 L +510.079 425 L +510.157 425 L +510.234 425 L +510.312 425 L +510.39 425 L +510.468 425 L +510.545 425 L +510.623 425 L +510.701 425 L +510.779 425 L +510.856 425 L +510.934 425 L +511.012 425 L +511.089 425 L +511.167 425 L +511.245 425 L +511.323 425 L +511.4 425 L +511.478 425 L +511.556 425 L +511.634 425 L +511.711 425 L +511.789 425 L +511.867 425 L +511.945 425 L +512.022 425 L +512.1 425 L +512.178 425 L +512.255 425 L +512.333 425 L +512.411 425 L +512.489 425 L +512.566 425 L +512.644 425 L +512.722 425 L +512.8 425 L +512.877 425 L +512.955 425 L +513.033 425 L +513.111 425 L +513.188 425 L +513.266 425 L +513.344 425 L +513.422 424.999 L +513.499 424.999 L +513.577 424.999 L +513.655 424.999 L +513.732 424.999 L +513.81 424.999 L +513.888 424.999 L +513.966 424.999 L +514.043 424.999 L +514.121 424.999 L +514.199 424.999 L +514.277 424.999 L +514.354 424.999 L +514.432 424.999 L +514.51 424.999 L +514.588 424.999 L +514.665 424.999 L +514.743 424.999 L +514.821 424.999 L +514.898 424.999 L +514.976 424.998 L +515.054 424.998 L +515.132 424.998 L +515.209 424.998 L +515.287 424.998 L +515.365 424.998 L +515.443 424.998 L +515.52 424.998 L +515.598 424.997 L +515.676 424.997 L +515.754 424.997 L +515.831 424.997 L +515.909 424.997 L +515.987 424.997 L +516.064 424.996 L +516.142 424.996 L +516.22 424.996 L +516.298 424.996 L +516.375 424.996 L +516.453 424.995 L +516.531 424.995 L +516.609 424.995 L +516.686 424.995 L +516.764 424.994 L +516.842 424.994 L +516.92 424.993 L +516.997 424.993 L +517.075 424.993 L +517.153 424.992 L +517.23 424.992 L +517.308 424.991 L +517.386 424.991 L +517.464 424.99 L +517.541 424.99 L +517.619 424.989 L +517.697 424.988 L +517.775 424.988 L +517.852 424.987 L +517.93 424.986 L +518.008 424.986 L +518.086 424.985 L +518.163 424.984 L +518.241 424.983 L +518.319 424.982 L +518.396 424.981 L +518.474 424.98 L +518.552 424.979 L +518.63 424.977 L +518.707 424.976 L +518.785 424.975 L +518.863 424.973 L +518.941 424.972 L +519.018 424.97 L +519.096 424.968 L +519.174 424.966 L +519.252 424.964 L +519.329 424.962 L +519.407 424.96 L +519.485 424.958 L +519.563 424.955 L +519.64 424.953 L +519.718 424.95 L +519.796 424.947 L +519.873 424.944 L +519.951 424.941 L +520.029 424.937 L +520.107 424.933 L +520.184 424.93 L +520.262 424.925 L +520.34 424.921 L +520.418 424.916 L +520.495 424.912 L +520.573 424.906 L +520.651 424.901 L +520.729 424.895 L +520.806 424.889 L +520.884 424.883 L +520.962 424.876 L +521.039 424.868 L +521.117 424.861 L +521.195 424.853 L +521.273 424.844 L +521.35 424.835 L +521.428 424.825 L +521.506 424.815 L +521.584 424.805 L +521.661 424.793 L +521.739 424.781 L +521.817 424.768 L +521.895 424.755 L +521.972 424.74 L +522.05 424.725 L +522.128 424.709 L +522.205 424.692 L +522.283 424.674 L +522.361 424.656 L +522.439 424.635 L +522.516 424.614 L +522.594 424.592 L +522.672 424.568 L +522.75 424.543 L +522.827 424.516 L +522.905 424.488 L +522.983 424.458 L +523.061 424.427 L +523.138 424.393 L +523.216 424.358 L +523.294 424.321 L +523.371 424.281 L +523.449 424.239 L +523.527 424.195 L +523.605 424.148 L +523.682 424.098 L +523.76 424.046 L +523.838 423.991 L +523.916 423.932 L +523.993 423.87 L +524.071 423.804 L +524.149 423.734 L +524.227 423.661 L +524.304 423.583 L +524.382 423.501 L +524.46 423.414 L +524.537 423.322 L +524.615 423.224 L +524.693 423.121 L +524.771 423.012 L +524.848 422.897 L +524.926 422.775 L +525.004 422.646 L +525.082 422.509 L +525.159 422.365 L +525.237 422.213 L +525.315 422.051 L +525.393 421.881 L +525.47 421.7 L +525.548 421.51 L +525.626 421.308 L +525.703 421.095 L +525.781 420.869 L +525.859 420.631 L +525.937 420.38 L +526.014 420.113 L +526.092 419.832 L +526.17 419.535 L +526.248 419.221 L +526.325 418.889 L +526.403 418.539 L +526.481 418.169 L +526.559 417.778 L +526.636 417.365 L +526.714 416.929 L +526.792 416.469 L +526.87 415.983 L +526.947 415.47 L +527.025 414.928 L +527.103 414.357 L +527.18 413.754 L +527.258 413.118 L +527.336 412.448 L +527.414 411.741 L +527.491 410.995 L +527.569 410.21 L +527.647 409.382 L +527.725 408.509 L +527.802 407.591 L +527.88 406.623 L +527.958 405.605 L +528.036 404.534 L +528.113 403.406 L +528.191 402.221 L +528.269 400.974 L +528.346 399.664 L +528.424 398.288 L +528.502 396.843 L +528.58 395.326 L +528.657 393.735 L +528.735 392.066 L +528.813 390.317 L +528.891 388.484 L +528.968 386.565 L +529.046 384.556 L +529.124 382.456 L +529.202 380.26 L +529.279 377.966 L +529.357 375.572 L +529.435 373.074 L +529.513 370.47 L +529.59 367.758 L +529.668 364.935 L +529.746 362 L +529.823 358.949 L +529.901 355.783 L +529.979 352.499 L +530.057 349.095 L +530.134 345.573 L +530.212 341.93 L +530.29 338.167 L +530.368 334.284 L +530.445 330.281 L +530.523 326.161 L +530.601 321.924 L +530.679 317.573 L +530.756 313.11 L +530.834 308.538 L +530.912 303.862 L +530.989 299.084 L +531.067 294.21 L +531.145 289.244 L +531.223 284.193 L +531.3 279.062 L +531.378 273.858 L +531.456 268.587 L +531.534 263.258 L +531.611 257.878 L +531.689 252.455 L +531.767 246.997 L +531.845 241.513 L +531.922 236.011 L +532 230.5 L +532.078 224.989 L +532.155 219.487 L +532.233 214.003 L +532.311 208.545 L +532.389 203.122 L +532.466 197.742 L +532.544 192.413 L +532.622 187.142 L +532.7 181.938 L +532.777 176.807 L +532.855 171.756 L +532.933 166.79 L +533.011 161.916 L +533.088 157.138 L +533.166 152.462 L +533.244 147.89 L +533.321 143.427 L +533.399 139.076 L +533.477 134.839 L +533.555 130.719 L +533.632 126.716 L +533.71 122.833 L +533.788 119.07 L +533.866 115.427 L +533.943 111.905 L +534.021 108.501 L +534.099 105.217 L +534.177 102.051 L +534.254 99 L +534.332 96.065 L +534.41 93.242 L +534.487 90.53 L +534.565 87.926 L +534.643 85.428 L +534.721 83.034 L +534.798 80.74 L +534.876 78.544 L +534.954 76.444 L +535.032 74.435 L +535.109 72.516 L +535.187 70.683 L +535.265 68.934 L +535.343 67.265 L +535.42 65.674 L +535.498 64.157 L +535.576 62.712 L +535.654 61.336 L +535.731 60.026 L +535.809 58.779 L +535.887 57.594 L +535.964 56.466 L +536.042 55.395 L +536.12 54.377 L +536.198 53.409 L +536.275 52.491 L +536.353 51.618 L +536.431 50.791 L +536.509 50.005 L +536.586 49.259 L +536.664 48.552 L +536.742 47.882 L +536.82 47.246 L +536.897 46.643 L +536.975 46.072 L +537.053 45.53 L +537.13 45.017 L +537.208 44.531 L +537.286 44.071 L +537.364 43.635 L +537.441 43.222 L +537.519 42.831 L +537.597 42.461 L +537.675 42.111 L +537.752 41.779 L +537.83 41.465 L +537.908 41.168 L +537.986 40.887 L +538.063 40.62 L +538.141 40.369 L +538.219 40.131 L +538.297 39.905 L +538.374 39.692 L +538.452 39.49 L +538.53 39.3 L +538.607 39.119 L +538.685 38.949 L +538.763 38.787 L +538.841 38.635 L +538.918 38.491 L +538.996 38.354 L +539.074 38.225 L +539.152 38.103 L +539.229 37.988 L +539.307 37.879 L +539.385 37.776 L +539.463 37.678 L +539.54 37.586 L +539.618 37.499 L +539.696 37.417 L +539.773 37.339 L +539.851 37.266 L +539.929 37.196 L +540.007 37.13 L +540.084 37.068 L +540.162 37.01 L +540.24 36.954 L +540.318 36.902 L +540.395 36.852 L +540.473 36.805 L +540.551 36.761 L +540.629 36.719 L +540.706 36.679 L +540.784 36.642 L +540.862 36.607 L +540.939 36.573 L +541.017 36.542 L +541.095 36.512 L +541.173 36.484 L +541.25 36.457 L +541.328 36.432 L +541.406 36.408 L +541.484 36.386 L +541.561 36.365 L +541.639 36.344 L +541.717 36.325 L +541.795 36.308 L +541.872 36.291 L +541.95 36.275 L +542.028 36.259 L +542.105 36.245 L +542.183 36.232 L +542.261 36.219 L +542.339 36.207 L +542.416 36.196 L +542.494 36.185 L +542.572 36.175 L +542.65 36.165 L +542.727 36.156 L +542.805 36.147 L +542.883 36.139 L +542.961 36.131 L +543.038 36.124 L +543.116 36.117 L +543.194 36.111 L +543.271 36.105 L +543.349 36.099 L +543.427 36.094 L +543.505 36.088 L +543.582 36.084 L +543.66 36.079 L +543.738 36.075 L +543.816 36.071 L +543.893 36.067 L +543.971 36.063 L +544.049 36.059 L +544.127 36.056 L +544.204 36.053 L +544.282 36.05 L +544.36 36.047 L +544.438 36.045 L +544.515 36.042 L +544.593 36.04 L +544.671 36.038 L +544.748 36.036 L +544.826 36.034 L +544.904 36.032 L +544.982 36.03 L +545.059 36.028 L +545.137 36.027 L +545.215 36.025 L +545.293 36.024 L +545.37 36.023 L +545.448 36.021 L +545.526 36.02 L +545.604 36.019 L +545.681 36.018 L +545.759 36.017 L +545.837 36.016 L +545.914 36.015 L +545.992 36.014 L +546.07 36.014 L +546.148 36.013 L +546.225 36.012 L +546.303 36.012 L +546.381 36.011 L +546.459 36.01 L +546.536 36.01 L +546.614 36.009 L +546.692 36.009 L +546.77 36.008 L +546.847 36.008 L +546.925 36.007 L +547.003 36.007 L +547.08 36.007 L +547.158 36.006 L +547.236 36.006 L +547.314 36.005 L +547.391 36.005 L +547.469 36.005 L +547.547 36.005 L +547.625 36.004 L +547.702 36.004 L +547.78 36.004 L +547.858 36.004 L +547.936 36.004 L +548.013 36.003 L +548.091 36.003 L +548.169 36.003 L +548.246 36.003 L +548.324 36.003 L +548.402 36.002 L +548.48 36.002 L +548.557 36.002 L +548.635 36.002 L +548.713 36.002 L +548.791 36.002 L +548.868 36.002 L +548.946 36.002 L +549.024 36.002 L +549.102 36.001 L +549.179 36.001 L +549.257 36.001 L +549.335 36.001 L +549.412 36.001 L +549.49 36.001 L +549.568 36.001 L +549.646 36.001 L +549.723 36.001 L +549.801 36.001 L +549.879 36.001 L +549.957 36.001 L +550.034 36.001 L +550.112 36.001 L +550.19 36.001 L +550.268 36.001 L +550.345 36.001 L +550.423 36.001 L +550.501 36.001 L +550.578 36.001 L +550.656 36 L +550.734 36 L +550.812 36 L +550.889 36 L +550.967 36 L +551.045 36 L +551.123 36 L +551.2 36 L +551.278 36 L +551.356 36 L +551.434 36 L +551.511 36 L +551.589 36 L +551.667 36 L +551.745 36 L +551.822 36 L +551.9 36 L +551.978 36 L +552.055 36 L +552.133 36 L +552.211 36 L +552.289 36 L +552.366 36 L +552.444 36 L +552.522 36 L +552.6 36 L +552.677 36 L +552.755 36 L +552.833 36 L +552.911 36 L +552.988 36 L +553.066 36 L +553.144 36 L +553.221 36 L +553.299 36 L +553.377 36 L +553.455 36 L +553.532 36 L +553.61 36 L +553.688 36 L +553.766 36 L +553.843 36 L +553.921 36 L +553.999 36 L +554.077 36 L +554.154 36 L +554.232 36 L +554.31 36 L +554.388 36 L +554.465 36 L +554.543 36 L +554.621 36 L +554.698 36 L +554.776 36 L +554.854 36 L +554.932 36 L +555.009 36 L +555.087 36 L +555.165 36 L +555.243 36 L +555.32 36 L +555.398 36 L +555.476 36 L +555.554 36 L +555.631 36 L +555.709 36 L +555.787 36 L +555.864 36 L +555.942 36 L +556.02 36 L +556.098 36 L +556.175 36 L +556.253 36 L +556.331 36 L +556.409 36 L +556.486 36 L +556.564 36 L +556.642 36 L +556.72 36 L +556.797 36 L +556.875 36 L +556.953 36 L +557.03 36 L +557.108 36 L +557.186 36 L +557.264 36 L +557.341 36 L +557.419 36 L +557.497 36 L +557.575 36 L +557.652 36 L +557.73 36 L +557.808 36 L +557.886 36 L +557.963 36 L +558.041 36 L +558.119 36 L +558.196 36 L +558.274 36 L +558.352 36 L +558.43 36 L +558.507 36 L +558.585 36 L +558.663 36 L +558.741 36 L +558.818 36 L +558.896 36 L +558.974 36 L +559.052 36 L +559.129 36 L +559.207 36 L +559.285 36 L +559.362 36 L +559.44 36 L +559.518 36 L +559.596 36 L +559.673 36 L +559.751 36 L +559.829 36 L +559.907 36 L +559.984 36 L +560.062 36 L +560.14 36 L +560.218 36 L +560.295 36 L +560.373 36 L +560.451 36 L +560.529 36 L +560.606 36 L +560.684 36 L +560.762 36 L +560.839 36 L +560.917 36 L +560.995 36 L +561.073 36 L +561.15 36 L +561.228 36 L +561.306 36 L +561.384 36 L +561.461 36 L +561.539 36 L +561.617 36 L +561.695 36 L +561.772 36 L +561.85 36 L +561.928 36 L +562.005 36 L +562.083 36 L +562.161 36 L +562.239 36 L +562.316 36 L +562.394 36 L +562.472 36 L +562.55 36 L +562.627 36 L +562.705 36 L +562.783 36 L +562.861 36 L +562.938 36 L +563.016 36 L +563.094 36 L +563.172 36 L +563.249 36 L +563.327 36 L +563.405 36 L +563.482 36 L +563.56 36 L +563.638 36 L +563.716 36 L +563.793 36 L +563.871 36 L +563.949 36 L +564.027 36 L +564.104 36 L +564.182 36 L +564.26 36 L +564.338 36 L +564.415 36 L +564.493 36 L +564.571 36 L +564.648 36 L +564.726 36 L +564.804 36 L +564.882 36 L +564.959 36 L +565.037 36 L +565.115 36 L +565.193 36 L +565.27 36 L +565.348 36 L +565.426 36 L +565.504 36 L +565.581 36 L +565.659 36 L +565.737 36 L +565.814 36 L +565.892 36 L +565.97 36 L +566.048 36 L +566.125 36 L +566.203 36 L +566.281 36 L +566.359 36 L +566.436 36 L +566.514 36 L +566.592 36 L +566.67 36 L +566.747 36 L +566.825 36 L +566.903 36 L +566.98 36 L +567.058 36 L +567.136 36 L +567.214 36 L +567.291 36 L +567.369 36 L +567.447 36 L +567.525 36 L +567.602 36 L +567.68 36 L +567.758 36 L +567.836 36 L +567.913 36 L +567.991 36 L +568.069 36 L +568.146 36 L +568.224 36 L +568.302 36 L +568.38 36 L +568.457 36 L +568.535 36 L +568.613 36 L +568.691 36 L +568.768 36 L +568.846 36 L +568.924 36 L +569.002 36 L +569.079 36 L +569.157 36 L +569.235 36 L +569.313 36 L +569.39 36 L +569.468 36 L +569.546 36 L +569.623 36 L +569.701 36 L +569.779 36 L +569.857 36 L +569.934 36 L +570.012 36 L +570.09 36 L +570.168 36 L +570.245 36 L +570.323 36 L +570.401 36 L +570.479 36 L +570.556 36 L +570.634 36 L +570.712 36 L +570.789 36 L +570.867 36 L +570.945 36 L +571.023 36 L +571.1 36 L +571.178 36 L +571.256 36 L +571.334 36 L +571.411 36 L +571.489 36 L +571.567 36 L +571.645 36 L +571.722 36 L +571.8 36 L +571.878 36 L +571.955 36 L +572.033 36 L +572.111 36 L +572.189 36 L +572.266 36 L +572.344 36 L +572.422 36 L +572.5 36 L +572.577 36 L +572.655 36 L +572.733 36 L +572.811 36 L +572.888 36 L +572.966 36 L +573.044 36 L +573.121 36 L +573.199 36 L +573.277 36 L +573.355 36 L +573.432 36 L +573.51 36 L +573.588 36 L +573.666 36 L +573.743 36 L +573.821 36 L +573.899 36 L +573.977 36 L +574.054 36 L +574.132 36 L +574.21 36 L +574.287 36 L +574.365 36 L +574.443 36 L +574.521 36 L +574.598 36 L +574.676 36 L +574.754 36 L +574.832 36 L +574.909 36 L +574.987 36 L +575.065 36 L +575.143 36 L +575.22 36 L +575.298 36 L +575.376 36 L +575.453 36 L +575.531 36 L +575.609 36 L +575.687 36 L +575.764 36 L +575.842 36 L +575.92 36 L +575.998 36 L +576.075 36 L +576.153 36 L +576.231 36 L +576.309 36 L +576.386 36 L +576.464 36 L +576.542 36 L +576.62 36 L +576.697 36 L +576.775 36 L +576.853 36 L +576.93 36 L +577.008 36 L +577.086 36 L +577.164 36 L +577.241 36 L +577.319 36 L +577.397 36 L +577.475 36 L +577.552 36 L +577.63 36 L +577.708 36 L +577.786 36 L +577.863 36 L +577.941 36 L +578.019 36 L +578.096 36 L +578.174 36 L +578.252 36 L +578.33 36 L +578.407 36 L +578.485 36 L +578.563 36 L +578.641 36 L +578.718 36 L +578.796 36 L +578.874 36 L +578.952 36 L +579.029 36 L +579.107 36 L +579.185 36 L +579.263 36 L +579.34 36 L +579.418 36 L +579.496 36 L +579.573 36 L +579.651 36 L +579.729 36 L +579.807 36 L +579.884 36 L +579.962 36 L +580.04 36 L +580.118 36 L +580.195 36 L +580.273 36 L +580.351 36 L +580.429 36 L +580.506 36 L +580.584 36 L +580.662 36 L +580.739 36 L +580.817 36 L +580.895 36 L +580.973 36 L +581.05 36 L +581.128 36 L +581.206 36 L +581.284 36 L +581.361 36 L +581.439 36 L +581.517 36 L +581.595 36 L +581.672 36 L +581.75 36 L +581.828 36 L +581.905 36 L +581.983 36 L +582.061 36 L +582.139 36 L +582.216 36 L +582.294 36 L +582.372 36 L +582.45 36 L +582.527 36 L +582.605 36 L +582.683 36 L +582.761 36 L +582.838 36 L +582.916 36 L +582.994 36 L +583.071 36 L +583.149 36 L +583.227 36 L +583.305 36 L +583.382 36 L +583.46 36 L +583.538 36 L +583.616 36 L +583.693 36 L +583.771 36 L +583.849 36 L +583.927 36 L +584.004 36 L +584.082 36 L +584.16 36 L +584.237 36 L +584.315 36 L +584.393 36 L +584.471 36 L +584.548 36 L +584.626 36 L +584.704 36 L +584.782 36 L +584.859 36 L +584.937 36 L +585.015 36 L +585.093 36 L +585.17 36 L +585.248 36 L +585.326 36 L +585.404 36 L +585.481 36 L +585.559 36 L +585.637 36 L +585.714 36 L +585.792 36 L +585.87 36 L +585.948 36 L +586.025 36 L +586.103 36 L +586.181 36 L +586.259 36 L +586.336 36 L +586.414 36 L +586.492 36 L +586.57 36 L +586.647 36 L +586.725 36 L +586.803 36 L +586.88 36 L +586.958 36 L +587.036 36 L +587.114 36 L +587.191 36 L +587.269 36 L +587.347 36 L +587.425 36 L +587.502 36 L +587.58 36 L +587.658 36 L +587.736 36 L +587.813 36 L +587.891 36 L +587.969 36 L +588.047 36 L +588.124 36 L +588.202 36 L +588.28 36 L +588.357 36 L +588.435 36 L +588.513 36 L +588.591 36 L +588.668 36 L +588.746 36 L +588.824 36 L +588.902 36 L +588.979 36 L +589.057 36 L +589.135 36 L +589.213 36 L +589.29 36 L +589.368 36 L +589.446 36 L +589.523 36 L +589.601 36 L +589.679 36 L +589.757 36 L +589.834 36 L +589.912 36 L +589.99 36 L +590.068 36 L +590.145 36 L +590.223 36 L +590.301 36 L +590.379 36 L +590.456 36 L +590.534 36 L +590.612 36 L +590.689 36 L +590.767 36 L +590.845 36 L +590.923 36 L +591 36 L +591.078 36 L +591.156 36 L +591.234 36 L +591.311 36 L +591.389 36 L +591.467 36 L +591.545 36 L +591.622 36 L +591.7 36 L +591.778 36 L +591.855 36 L +591.933 36 L +592.011 36 L +592.089 36 L +592.166 36 L +592.244 36 L +592.322 36 L +592.4 36 L +592.477 36 L +592.555 36 L +592.633 36 L +592.711 36 L +592.788 36 L +592.866 36 L +592.944 36 L +593.021 36.001 L +593.099 36.001 L +593.177 36.001 L +593.255 36.001 L +593.332 36.001 L +593.41 36.001 L +593.488 36.001 L +593.566 36.001 L +593.643 36.001 L +593.721 36.001 L +593.799 36.001 L +593.877 36.001 L +593.954 36.001 L +594.032 36.001 L +594.11 36.001 L +594.188 36.001 L +594.265 36.001 L +594.343 36.001 L +594.421 36.001 L +594.498 36.001 L +594.576 36.002 L +594.654 36.002 L +594.732 36.002 L +594.809 36.002 L +594.887 36.002 L +594.965 36.002 L +595.043 36.002 L +595.12 36.002 L +595.198 36.002 L +595.276 36.003 L +595.354 36.003 L +595.431 36.003 L +595.509 36.003 L +595.587 36.003 L +595.664 36.004 L +595.742 36.004 L +595.82 36.004 L +595.898 36.004 L +595.975 36.004 L +596.053 36.005 L +596.131 36.005 L +596.209 36.005 L +596.286 36.005 L +596.364 36.006 L +596.442 36.006 L +596.52 36.007 L +596.597 36.007 L +596.675 36.007 L +596.753 36.008 L +596.83 36.008 L +596.908 36.009 L +596.986 36.009 L +597.064 36.01 L +597.141 36.01 L +597.219 36.011 L +597.297 36.012 L +597.375 36.012 L +597.452 36.013 L +597.53 36.014 L +597.608 36.014 L +597.686 36.015 L +597.763 36.016 L +597.841 36.017 L +597.919 36.018 L +597.996 36.019 L +598.074 36.02 L +598.152 36.021 L +598.23 36.023 L +598.307 36.024 L +598.385 36.025 L +598.463 36.027 L +598.541 36.028 L +598.618 36.03 L +598.696 36.032 L +598.774 36.034 L +598.852 36.036 L +598.929 36.038 L +599.007 36.04 L +599.085 36.042 L +599.162 36.045 L +599.24 36.047 L +599.318 36.05 L +599.396 36.053 L +599.473 36.056 L +599.551 36.059 L +599.629 36.063 L +599.707 36.067 L +599.784 36.071 L +599.862 36.075 L +599.94 36.079 L +600.018 36.084 L +600.095 36.088 L +600.173 36.094 L +600.251 36.099 L +600.328 36.105 L +600.406 36.111 L +600.484 36.117 L +600.562 36.124 L +600.639 36.131 L +600.717 36.139 L +600.795 36.147 L +600.873 36.156 L +600.95 36.165 L +601.028 36.175 L +601.106 36.185 L +601.184 36.196 L +601.261 36.207 L +601.339 36.219 L +601.417 36.232 L +601.495 36.245 L +601.572 36.259 L +601.65 36.275 L +601.728 36.291 L +601.805 36.308 L +601.883 36.325 L +601.961 36.344 L +602.039 36.365 L +602.116 36.386 L +602.194 36.408 L +602.272 36.432 L +602.35 36.457 L +602.427 36.484 L +602.505 36.512 L +602.583 36.542 L +602.661 36.573 L +602.738 36.607 L +602.816 36.642 L +602.894 36.679 L +602.971 36.719 L +603.049 36.761 L +603.127 36.805 L +603.205 36.852 L +603.282 36.902 L +603.36 36.954 L +603.438 37.01 L +603.516 37.068 L +603.593 37.13 L +603.671 37.196 L +603.749 37.266 L +603.827 37.339 L +603.904 37.417 L +603.982 37.499 L +604.06 37.586 L +604.138 37.678 L +604.215 37.776 L +604.293 37.879 L +604.371 37.988 L +604.448 38.103 L +604.526 38.225 L +604.604 38.354 L +604.682 38.491 L +604.759 38.635 L +604.837 38.787 L +604.915 38.949 L +604.993 39.119 L +605.07 39.3 L +605.148 39.49 L +605.226 39.692 L +605.304 39.905 L +605.381 40.131 L +605.459 40.369 L +605.537 40.62 L +605.614 40.887 L +605.692 41.168 L +605.77 41.465 L +605.848 41.779 L +605.925 42.111 L +606.003 42.461 L +606.081 42.831 L +606.159 43.222 L +606.236 43.635 L +606.314 44.071 L +606.392 44.531 L +606.47 45.017 L +606.547 45.53 L +606.625 46.072 L +606.703 46.643 L +606.78 47.246 L +606.858 47.882 L +606.936 48.552 L +607.014 49.259 L +607.091 50.005 L +607.169 50.791 L +607.247 51.618 L +607.325 52.491 L +607.402 53.409 L +607.48 54.377 L +607.558 55.395 L +607.636 56.466 L +607.713 57.594 L +607.791 58.779 L +607.869 60.026 L +607.946 61.336 L +608.024 62.712 L +608.102 64.157 L +608.18 65.674 L +608.257 67.265 L +608.335 68.934 L +608.413 70.683 L +608.491 72.516 L +608.568 74.435 L +608.646 76.444 L +608.724 78.544 L +608.802 80.74 L +608.879 83.034 L +608.957 85.428 L +609.035 87.926 L +609.112 90.53 L +609.19 93.242 L +609.268 96.065 L +609.346 99 L +609.423 102.051 L +609.501 105.217 L +609.579 108.501 L +609.657 111.905 L +609.734 115.427 L +609.812 119.07 L +609.89 122.833 L +609.968 126.716 L +610.045 130.719 L +610.123 134.839 L +610.201 139.076 L +610.279 143.427 L +610.356 147.89 L +610.434 152.462 L +610.512 157.138 L +610.589 161.916 L +610.667 166.79 L +610.745 171.756 L +610.823 176.807 L +610.9 181.938 L +610.978 187.142 L +611.056 192.413 L +611.134 197.742 L +611.211 203.122 L +611.289 208.545 L +611.367 214.003 L +611.445 219.487 L +611.522 224.989 L +611.6 230.5 L +611.678 236.011 L +611.755 241.513 L +611.833 246.997 L +611.911 252.455 L +611.989 257.878 L +612.066 263.258 L +612.144 268.587 L +612.222 273.858 L +612.3 279.062 L +612.377 284.193 L +612.455 289.244 L +612.533 294.21 L +612.611 299.084 L +612.688 303.862 L +612.766 308.538 L +612.844 313.11 L +612.922 317.573 L +612.999 321.924 L +613.077 326.161 L +613.155 330.281 L +613.232 334.284 L +613.31 338.167 L +613.388 341.93 L +613.466 345.573 L +613.543 349.095 L +613.621 352.499 L +613.699 355.783 L +613.777 358.949 L +613.854 362 L +613.932 364.935 L +614.01 367.758 L +614.088 370.47 L +614.165 373.074 L +614.243 375.572 L +614.321 377.966 L +614.398 380.26 L +614.476 382.456 L +614.554 384.556 L +614.632 386.565 L +614.709 388.484 L +614.787 390.317 L +614.865 392.066 L +614.943 393.735 L +615.02 395.326 L +615.098 396.843 L +615.176 398.288 L +615.254 399.664 L +615.331 400.974 L +615.409 402.221 L +615.487 403.406 L +615.564 404.534 L +615.642 405.605 L +615.72 406.623 L +615.798 407.591 L +615.875 408.509 L +615.953 409.382 L +616.031 410.21 L +616.109 410.995 L +616.186 411.741 L +616.264 412.448 L +616.342 413.118 L +616.42 413.754 L +616.497 414.357 L +616.575 414.928 L +616.653 415.47 L +616.73 415.983 L +616.808 416.469 L +616.886 416.929 L +616.964 417.365 L +617.041 417.778 L +617.119 418.169 L +617.197 418.539 L +617.275 418.889 L +617.352 419.221 L +617.43 419.535 L +617.508 419.832 L +617.586 420.113 L +617.663 420.38 L +617.741 420.631 L +617.819 420.869 L +617.896 421.095 L +617.974 421.308 L +618.052 421.51 L +618.13 421.7 L +618.207 421.881 L +618.285 422.051 L +618.363 422.213 L +618.441 422.365 L +618.518 422.509 L +618.596 422.646 L +618.674 422.775 L +618.752 422.897 L +618.829 423.012 L +618.907 423.121 L +618.985 423.224 L +619.063 423.322 L +619.14 423.414 L +619.218 423.501 L +619.296 423.583 L +619.373 423.661 L +619.451 423.734 L +619.529 423.804 L +619.607 423.87 L +619.684 423.932 L +619.762 423.991 L +619.84 424.046 L +619.918 424.098 L +619.995 424.148 L +620.073 424.195 L +620.151 424.239 L +620.229 424.281 L +620.306 424.321 L +620.384 424.358 L +620.462 424.393 L +620.539 424.427 L +620.617 424.458 L +620.695 424.488 L +620.773 424.516 L +620.85 424.543 L +620.928 424.568 L +621.006 424.592 L +621.084 424.614 L +621.161 424.635 L +621.239 424.656 L +621.317 424.674 L +621.395 424.692 L +621.472 424.709 L +621.55 424.725 L +621.628 424.74 L +621.705 424.755 L +621.783 424.768 L +621.861 424.781 L +621.939 424.793 L +622.016 424.805 L +622.094 424.815 L +622.172 424.825 L +622.25 424.835 L +622.327 424.844 L +622.405 424.853 L +622.483 424.861 L +622.561 424.868 L +622.638 424.876 L +622.716 424.883 L +622.794 424.889 L +622.871 424.895 L +622.949 424.901 L +623.027 424.906 L +623.105 424.912 L +623.182 424.916 L +623.26 424.921 L +623.338 424.925 L +623.416 424.93 L +623.493 424.933 L +623.571 424.937 L +623.649 424.941 L +623.727 424.944 L +623.804 424.947 L +623.882 424.95 L +623.96 424.953 L +624.037 424.955 L +624.115 424.958 L +624.193 424.96 L +624.271 424.962 L +624.348 424.964 L +624.426 424.966 L +624.504 424.968 L +624.582 424.97 L +624.659 424.972 L +624.737 424.973 L +624.815 424.975 L +624.893 424.976 L +624.97 424.977 L +625.048 424.979 L +625.126 424.98 L +625.203 424.981 L +625.281 424.982 L +625.359 424.983 L +625.437 424.984 L +625.514 424.985 L +625.592 424.986 L +625.67 424.986 L +625.748 424.987 L +625.825 424.988 L +625.903 424.988 L +625.981 424.989 L +626.059 424.99 L +626.136 424.99 L +626.214 424.991 L +626.292 424.991 L +626.37 424.992 L +626.447 424.992 L +626.525 424.993 L +626.603 424.993 L +626.68 424.993 L +626.758 424.994 L +626.836 424.994 L +626.914 424.995 L +626.991 424.995 L +627.069 424.995 L +627.147 424.995 L +627.225 424.996 L +627.302 424.996 L +627.38 424.996 L +627.458 424.996 L +627.536 424.996 L +627.613 424.997 L +627.691 424.997 L +627.769 424.997 L +627.846 424.997 L +627.924 424.997 L +628.002 424.997 L +628.08 424.998 L +628.157 424.998 L +628.235 424.998 L +628.313 424.998 L +628.391 424.998 L +628.468 424.998 L +628.546 424.998 L +628.624 424.998 L +628.702 424.999 L +628.779 424.999 L +628.857 424.999 L +628.935 424.999 L +629.013 424.999 L +629.09 424.999 L +629.168 424.999 L +629.246 424.999 L +629.323 424.999 L +629.401 424.999 L +629.479 424.999 L +629.557 424.999 L +629.634 424.999 L +629.712 424.999 L +629.79 424.999 L +629.868 424.999 L +629.945 424.999 L +630.023 424.999 L +630.101 424.999 L +630.179 424.999 L +630.256 425 L +630.334 425 L +630.412 425 L +630.489 425 L +630.567 425 L +630.645 425 L +630.723 425 L +630.8 425 L +630.878 425 L +630.956 425 L +631.034 425 L +631.111 425 L +631.189 425 L +631.267 425 L +631.345 425 L +631.422 425 L +631.5 425 L +631.578 425 L +631.655 425 L +631.733 425 L +631.811 425 L +631.889 425 L +631.966 425 L +632.044 425 L +632.122 425 L +632.2 425 L +632.277 425 L +632.355 425 L +632.433 425 L +632.511 425 L +632.588 425 L +632.666 425 L +632.744 425 L +632.821 425 L +632.899 425 L +632.977 425 L +633.055 425 L +633.132 425 L +633.21 425 L +633.288 425 L +633.366 425 L +633.443 425 L +633.521 425 L +633.599 425 L +633.677 425 L +633.754 425 L +633.832 425 L +633.91 425 L +633.987 425 L +634.065 425 L +634.143 425 L +634.221 425 L +634.298 425 L +634.376 425 L +634.454 425 L +634.532 425 L +634.609 425 L +634.687 425 L +634.765 425 L +634.843 425 L +634.92 425 L +634.998 425 L +635.076 425 L +635.154 425 L +635.231 425 L +635.309 425 L +635.387 425 L +635.464 425 L +635.542 425 L +635.62 425 L +635.698 425 L +635.775 425 L +635.853 425 L +635.931 425 L +636.009 425 L +636.086 425 L +636.164 425 L +636.242 425 L +636.32 425 L +636.397 425 L +636.475 425 L +636.553 425 L +636.63 425 L +636.708 425 L +636.786 425 L +636.864 425 L +636.941 425 L +637.019 425 L +637.097 425 L +637.175 425 L +637.252 425 L +637.33 425 L +637.408 425 L +637.486 425 L +637.563 425 L +637.641 425 L +637.719 425 L +637.797 425 L +637.874 425 L +637.952 425 L +638.03 425 L +638.107 425 L +638.185 425 L +638.263 425 L +638.341 425 L +638.418 425 L +638.496 425 L +638.574 425 L +638.652 425 L +638.729 425 L +638.807 425 L +638.885 425 L +638.963 425 L +639.04 425 L +639.118 425 L +639.196 425 L +639.273 425 L +639.351 425 L +639.429 425 L +639.507 425 L +639.584 425 L +639.662 425 L +639.74 425 L +639.818 425 L +639.895 425 L +639.973 425 L +640.051 425 L +640.129 425 L +640.206 425 L +640.284 425 L +640.362 425 L +640.439 425 L +640.517 425 L +640.595 425 L +640.673 425 L +640.75 425 L +640.828 425 L +640.906 425 L +640.984 425 L +641.061 425 L +641.139 425 L +641.217 425 L +641.295 425 L +641.372 425 L +641.45 425 L +641.528 425 L +641.605 425 L +641.683 425 L +641.761 425 L +641.839 425 L +641.916 425 L +641.994 425 L +642.072 425 L +642.15 425 L +642.227 425 L +642.305 425 L +642.383 425 L +642.461 425 L +642.538 425 L +642.616 425 L +642.694 425 L +642.771 425 L +642.849 425 L +642.927 425 L +643.005 425 L +643.082 425 L +643.16 425 L +643.238 425 L +643.316 425 L +643.393 425 L +643.471 425 L +643.549 425 L +643.627 425 L +643.704 425 L +643.782 425 L +643.86 425 L +643.938 425 L +644.015 425 L +644.093 425 L +644.171 425 L +644.248 425 L +644.326 425 L +644.404 425 L +644.482 425 L +644.559 425 L +644.637 425 L +644.715 425 L +644.793 425 L +644.87 425 L +644.948 425 L +645.026 425 L +645.104 425 L +645.181 425 L +645.259 425 L +645.337 425 L +645.414 425 L +645.492 425 L +645.57 425 L +645.648 425 L +645.725 425 L +645.803 425 L +645.881 425 L +645.959 425 L +646.036 425 L +646.114 425 L +646.192 425 L +646.27 425 L +646.347 425 L +646.425 425 L +646.503 425 L +646.58 425 L +646.658 425 L +646.736 425 L +646.814 425 L +646.891 425 L +646.969 425 L +647.047 425 L +647.125 425 L +647.202 425 L +647.28 425 L +647.358 425 L +647.436 425 L +647.513 425 L +647.591 425 L +647.669 425 L +647.746 425 L +647.824 425 L +647.902 425 L +647.98 425 L +648.057 425 L +648.135 425 L +648.213 425 L +648.291 425 L +648.368 425 L +648.446 425 L +648.524 425 L +648.602 425 L +648.679 425 L +648.757 425 L +648.835 425 L +648.912 425 L +648.99 425 L +649.068 425 L +649.146 425 L +649.223 425 L +649.301 425 L +649.379 425 L +649.457 425 L +649.534 425 L +649.612 425 L +649.69 425 L +649.768 425 L +649.845 425 L +649.923 425 L +650.001 425 L +650.078 425 L +650.156 425 L +650.234 425 L +650.312 425 L +650.389 425 L +650.467 425 L +650.545 425 L +650.623 425 L +650.7 425 L +650.778 425 L +650.856 425 L +650.934 425 L +651.011 425 L +651.089 425 L +651.167 425 L +651.245 425 L +651.322 425 L +651.4 425 L +651.478 425 L +651.555 425 L +651.633 425 L +651.711 425 L +651.789 425 L +651.866 425 L +651.944 425 L +652.022 425 L +652.1 425 L +652.177 425 L +652.255 425 L +652.333 425 L +652.411 425 L +652.488 425 L +652.566 425 L +652.644 425 L +652.721 425 L +652.799 425 L +652.877 425 L +652.955 425 L +653.032 425 L +653.11 425 L +653.188 425 L +653.266 425 L +653.343 425 L +653.421 425 L +653.499 425 L +653.577 425 L +653.654 425 L +653.732 425 L +653.81 425 L +653.888 425 L +653.965 425 L +654.043 425 L +654.121 425 L +654.198 425 L +654.276 425 L +654.354 425 L +654.432 425 L +654.509 425 L +654.587 425 L +654.665 425 L +654.743 425 L +654.82 425 L +654.898 425 L +654.976 425 L +655.054 425 L +655.131 425 L +655.209 425 L +655.287 425 L +655.364 425 L +655.442 425 L +655.52 425 L +655.598 425 L +655.675 425 L +655.753 425 L +655.831 425 L +655.909 425 L +655.986 425 L +656.064 425 L +656.142 425 L +656.22 425 L +656.297 425 L +656.375 425 L +656.453 425 L +656.53 425 L +656.608 425 L +656.686 425 L +656.764 425 L +656.841 425 L +656.919 425 L +656.997 425 L +657.075 425 L +657.152 425 L +657.23 425 L +657.308 425 L +657.386 425 L +657.463 425 L +657.541 425 L +657.619 425 L +657.696 425 L +657.774 425 L +657.852 425 L +657.93 425 L +658.007 425 L +658.085 425 L +658.163 425 L +658.241 425 L +658.318 425 L +658.396 425 L +658.474 425 L +658.552 425 L +658.629 425 L +658.707 425 L +658.785 425 L +658.862 425 L +658.94 425 L +659.018 425 L +659.096 425 L +659.173 425 L +659.251 425 L +659.329 425 L +659.407 425 L +659.484 425 L +659.562 425 L +659.64 425 L +659.718 425 L +659.795 425 L +659.873 425 L +659.951 425 L +660.029 425 L +660.106 425 L +660.184 425 L +660.262 425 L +660.339 425 L +660.417 425 L +660.495 425 L +660.573 425 L +660.65 425 L +660.728 425 L +660.806 425 L +660.884 425 L +660.961 425 L +661.039 425 L +661.117 425 L +661.195 425 L +661.272 425 L +661.35 425 L +661.428 425 L +661.505 425 L +661.583 425 L +661.661 425 L +661.739 425 L +661.816 425 L +661.894 425 L +661.972 425 L +662.05 425 L +662.127 425 L +662.205 425 L +662.283 425 L +662.361 425 L +662.438 425 L +662.516 425 L +662.594 425 L +662.672 425 L +662.749 425 L +662.827 425 L +662.905 425 L +662.982 425 L +663.06 425 L +663.138 425 L +663.216 425 L +663.293 425 L +663.371 425 L +663.449 425 L +663.527 425 L +663.604 425 L +663.682 425 L +663.76 425 L +663.838 425 L +663.915 425 L +663.993 425 L +664.071 425 L +664.148 425 L +664.226 425 L +664.304 425 L +664.382 425 L +664.459 425 L +664.537 425 L +664.615 425 L +664.693 425 L +664.77 425 L +664.848 425 L +664.926 425 L +665.004 425 L +665.081 425 L +665.159 425 L +665.237 425 L +665.314 425 L +665.392 425 L +665.47 425 L +665.548 425 L +665.625 425 L +665.703 425 L +665.781 425 L +665.859 425 L +665.936 425 L +666.014 425 L +666.092 425 L +666.17 425 L +666.247 425 L +666.325 425 L +666.403 425 L +666.48 425 L +666.558 425 L +666.636 425 L +666.714 425 L +666.791 425 L +666.869 425 L +666.947 425 L +667.025 425 L +667.102 425 L +667.18 425 L +667.258 425 L +667.336 425 L +667.413 425 L +667.491 425 L +667.569 425 L +667.646 425 L +667.724 425 L +667.802 425 L +667.88 425 L +667.957 425 L +668.035 425 L +668.113 425 L +668.191 425 L +668.268 425 L +668.346 425 L +668.424 425 L +668.502 425 L +668.579 425 L +668.657 425 L +668.735 425 L +668.813 425 L +668.89 425 L +668.968 425 L +669.046 425 L +669.123 425 L +669.201 425 L +669.279 425 L +669.357 425 L +669.434 425 L +669.512 425 L +669.59 425 L +669.668 425 L +669.745 425 L +669.823 425 L +669.901 425 L +669.979 425 L +670.056 425 L +670.134 425 L +670.212 425 L +670.289 425 L +670.367 425 L +670.445 425 L +670.523 425 L +670.6 425 L +670.678 425 L +670.756 425 L +670.834 425 L +670.911 425 L +670.989 425 L +671.067 425 L +671.145 425 L +671.222 425 L +671.3 425 L +671.378 425 L +671.455 425 L +671.533 425 L +671.611 425 L +671.689 425 L +671.766 425 L +671.844 425 L +671.922 425 L +672 425 L +672.077 425 L +672.155 425 L +672.233 425 L +672.311 425 L +672.388 425 L +672.466 425 L +672.544 425 L +672.621 425 L +672.699 425 L +672.777 425 L +672.855 425 L +672.932 425 L +673.01 425 L +673.088 425 L +673.166 425 L +673.243 425 L +673.321 425 L +673.399 425 L +673.477 425 L +673.554 425 L +673.632 425 L +673.71 425 L +673.787 425 L +673.865 425 L +673.943 425 L +674.021 425 L +674.098 425 L +674.176 425 L +674.254 425 L +674.332 425 L +674.409 425 L +674.487 425 L +674.565 425 L +674.643 425 L +674.72 425 L +674.798 425 L +674.876 425 L +674.953 425 L +675.031 425 L +675.109 425 L +675.187 425 L +675.264 425 L +675.342 425 L +675.42 425 L +675.498 425 L +675.575 425 L +675.653 425 L +675.731 425 L +675.809 425 L +675.886 425 L +675.964 425 L +676.042 425 L +676.12 425 L +676.197 425 L +676.275 425 L +676.353 425 L +676.43 425 L +676.508 425 L +676.586 425 L +676.664 425 L +676.741 425 L +676.819 425 L +676.897 425 L +676.975 425 L +677.052 425 L +677.13 425 L +677.208 425 L +677.286 425 L +677.363 425 L +677.441 425 L +677.519 425 L +677.596 425 L +677.674 425 L +677.752 425 L +677.83 425 L +677.907 425 L +677.985 425 L +678.063 425 L +678.141 425 L +678.218 425 L +678.296 425 L +678.374 425 L +678.452 425 L +678.529 425 L +678.607 425 L +678.685 425 L +678.763 425 L +678.84 425 L +678.918 425 L +678.996 425 L +679.073 425 L +679.151 425 L +679.229 425 L +679.307 425 L +679.384 425 L +679.462 425 L +679.54 425 L +679.618 425 L +679.695 425 L +679.773 425 L +679.851 425 L +679.929 425 L +680.006 425 L +680.084 425 L +680.162 425 L +680.239 425 L +680.317 425 L +680.395 425 L +680.473 425 L +680.55 425 L +680.628 425 L +680.706 425 L +680.784 425 L +680.861 425 L +680.939 425 L +681.017 425 L +681.095 425 L +681.172 425 L +681.25 425 L +681.328 425 L +681.405 425 L +681.483 425 L +681.561 425 L +681.639 425 L +681.716 425 L +681.794 425 L +681.872 425 L +681.95 425 L +682.027 425 L +682.105 425 L +682.183 425 L +682.261 425 L +682.338 425 L +682.416 425 L +682.494 425 L +682.571 425 L +682.649 425 L +682.727 425 L +682.805 425 L +682.882 425 L +682.96 425 L +683.038 425 L +683.116 425 L +683.193 425 L +683.271 425 L +683.349 425 L +683.427 425 L +683.504 425 L +683.582 425 L +683.66 425 L +683.737 425 L +683.815 425 L +683.893 425 L +683.971 425 L +684.048 425 L +684.126 425 L +684.204 425 L +684.282 425 L +684.359 425 L +684.437 425 L +684.515 425 L +684.593 425 L +684.67 425 L +684.748 425 L +684.826 425 L +684.904 425 L +684.981 425 L +685.059 425 L +685.137 425 L +685.214 425 L +685.292 425 L +685.37 425 L +685.448 425 L +685.525 425 L +685.603 425 L +685.681 425 L +685.759 425 L +685.836 425 L +685.914 425 L +685.992 425 L +686.07 425 L +686.147 425 L +686.225 425 L +686.303 425 L +686.38 425 L +686.458 425 L +686.536 425 L +686.614 425 L +686.691 425 L +686.769 425 L +686.847 425 L +686.925 425 L +687.002 425 L +687.08 425 L +687.158 425 L +687.236 425 L +687.313 425 L +687.391 425 L +687.469 425 L +687.547 425 L +687.624 425 L +687.702 425 L +687.78 425 L +687.857 425 L +687.935 425 L +688.013 425 L +688.091 425 L +688.168 425 L +688.246 425 L +688.324 425 L +688.402 425 L +688.479 425 L +688.557 425 L +688.635 425 L +688.713 425 L +688.79 425 L +688.868 425 L +688.946 425 L +689.023 425 L +689.101 425 L +689.179 425 L +689.257 425 L +689.334 425 L +689.412 425 L +689.49 425 L +689.568 425 L +689.645 425 L +689.723 425 L +689.801 425 L +689.879 425 L +689.956 425 L +690.034 425 L +690.112 425 L +690.189 425 L +690.267 425 L +690.345 425 L +690.423 425 L +690.5 425 L +690.578 425 L +690.656 425 L +690.734 425 L +690.811 425 L +690.889 425 L +690.967 425 L +691.045 425 L +691.122 425 L +691.2 425 L +691.278 425 L +691.355 425 L +691.433 425 L +691.511 425 L +691.589 425 L +691.666 425 L +691.744 425 L +691.822 425 L +691.9 425 L +691.977 425 L +692.055 425 L +692.133 425 L +692.211 425 L +692.288 425 L +692.366 425 L +692.444 425 L +692.521 425 L +692.599 425 L +692.677 425 L +692.755 425 L +692.832 425 L +692.91 425 L +692.988 425 L +693.066 425 L +693.143 425 L +693.221 425 L +693.299 425 L +693.377 425 L +693.454 425 L +693.532 425 L +693.61 425 L +693.688 425 L +693.765 425 L +693.843 425 L +693.921 425 L +693.998 425 L +694.076 425 L +694.154 425 L +694.232 425 L +694.309 425 L +694.387 425 L +694.465 425 L +694.543 425 L +694.62 425 L +694.698 425 L +694.776 425 L +694.854 425 L +694.931 425 L +695.009 425 L +695.087 425 L +695.164 425 L +695.242 425 L +695.32 425 L +695.398 425 L +695.475 425 L +695.553 425 L +695.631 425 L +695.709 425 L +695.786 425 L +695.864 425 L +695.942 425 L +696.02 425 L +696.097 425 L +696.175 425 L +696.253 425 L +696.33 425 L +696.408 425 L +696.486 425 L +696.564 425 L +696.641 425 L +696.719 425 L +696.797 425 L +696.875 425 L +696.952 425 L +697.03 425 L +697.108 425 L +697.186 425 L +697.263 425 L +697.341 425 L +697.419 425 L +697.496 425 L +697.574 425 L +697.652 425 L +697.73 425 L +697.807 425 L +697.885 425 L +697.963 425 L +698.041 425 L +698.118 425 L +698.196 425 L +698.274 425 L +698.352 425 L +698.429 425 L +698.507 425 L +698.585 425 L +698.662 425 L +698.74 425 L +698.818 425 L +698.896 425 L +698.973 425 L +699.051 425 L +699.129 425 L +699.207 425 L +699.284 425 L +699.362 425 L +699.44 425 L +699.518 425 L +699.595 425 L +699.673 425 L +699.751 425 L +699.828 425 L +699.906 425 L +699.984 425 L +700.062 425 L +700.139 425 L +700.217 425 L +700.295 425 L +700.373 425 L +700.45 425 L +700.528 425 L +700.606 425 L +700.684 425 L +700.761 425 L +700.839 425 L +700.917 425 L +700.995 425 L +701.072 425 L +701.15 425 L +701.228 425 L +701.305 425 L +701.383 425 L +701.461 425 L +701.539 425 L +701.616 425 L +701.694 425 L +701.772 425 L +701.85 425 L +701.927 425 L +702.005 425 L +702.083 425 L +702.161 425 L +702.238 425 L +702.316 425 L +702.394 425 L +702.471 425 L +702.549 425 L +702.627 425 L +702.705 425 L +702.782 425 L +702.86 425 L +702.938 425 L +703.016 425 L +703.093 425 L +703.171 425 L +703.249 425 L +703.327 425 L +703.404 425 L +703.482 425 L +703.56 425 L +703.638 425 L +703.715 425 L +703.793 425 L +703.871 425 L +703.948 425 L +704.026 425 L +704.104 425 L +704.182 425 L +704.259 425 L +704.337 425 L +704.415 425 L +704.493 425 L +704.57 425 L +704.648 425 L +704.726 425 L +704.804 425 L +704.881 425 L +704.959 425 L +705.037 425 L +705.114 425 L +705.192 425 L +705.27 425 L +705.348 425 L +705.425 425 L +705.503 425 L +705.581 425 L +705.659 425 L +705.736 425 L +705.814 425 L +705.892 425 L +705.97 425 L +706.047 425 L +706.125 425 L +706.203 425 L +706.28 425 L +706.358 425 L +706.436 425 L +706.514 425 L +706.591 425 L +706.669 425 L +706.747 425 L +706.825 425 L +706.902 425 L +706.98 425 L +707.058 425 L +707.136 425 L +707.213 425 L +707.291 425 L +707.369 425 L +707.446 425 L +707.524 425 L +707.602 425 L +707.68 425 L +707.757 425 L +707.835 425 L +707.913 425 L +707.991 425 L +708.068 425 L +708.146 425 L +708.224 425 L +708.302 425 L +708.379 425 L +708.457 425 L +708.535 425 L +708.612 425 L +708.69 425 L +708.768 425 L +708.846 425 L +708.923 425 L +709.001 425 L +709.079 425 L +709.157 425 L +709.234 425 L +709.312 425 L +709.39 425 L +709.468 425 L +709.545 425 L +709.623 425 L +709.701 425 L +709.779 425 L +709.856 425 L +709.934 425 L +710.012 425 L +710.089 425 L +710.167 425 L +710.245 425 L +710.323 425 L +710.4 425 L +710.478 425 L +710.556 425 L +710.634 425 L +710.711 425 L +710.789 425 L +710.867 425 L +710.945 425 L +711.022 425 L +711.1 425 L +711.178 425 L +711.255 425 L +711.333 425 L +711.411 425 L +711.489 425 L +711.566 425 L +711.644 425 L +711.722 425 L +711.8 425 L +711.877 425 L +711.955 425 L +712.033 425 L +712.111 425 L +712.188 425 L +712.266 425 L +712.344 425 L +712.422 425 L +712.499 425 L +712.577 425 L +712.655 425 L +712.732 425 L +712.81 425 L +712.888 425 L +712.966 425 L +713.043 425 L +713.121 425 L +713.199 425 L +713.277 425 L +713.354 425 L +713.432 425 L +713.51 425 L +713.588 425 L +713.665 425 L +713.743 425 L +713.821 425 L +713.898 425 L +713.976 425 L +714.054 425 L +714.132 425 L +714.209 425 L +714.287 425 L +714.365 425 L +714.443 425 L +714.52 425 L +714.598 425 L +714.676 425 L +714.754 425 L +714.831 425 L +714.909 425 L +714.987 425 L +715.064 425 L +715.142 425 L +715.22 425 L +715.298 425 L +715.375 425 L +715.453 425 L +715.531 425 L +715.609 425 L +715.686 425 L +715.764 425 L +715.842 425 L +715.92 425 L +715.997 425 L +716.075 425 L +716.153 425 L +716.23 425 L +716.308 425 L +716.386 425 L +716.464 425 L +716.541 425 L +716.619 425 L +716.697 425 L +716.775 425 L +716.852 425 L +716.93 425 L +717.008 425 L +717.086 425 L +717.163 425 L +717.241 425 L +717.319 425 L +717.396 425 L +717.474 425 L +717.552 425 L +717.63 425 L +717.707 425 L +717.785 425 L +717.863 425 L +717.941 425 L +718.018 425 L +718.096 425 L +718.174 425 L +718.252 425 L +718.329 425 L +718.407 425 L +718.485 425 L +718.563 425 L +718.64 425 L +718.718 425 L +718.796 425 L +718.873 425 L +718.951 425 L +719.029 425 L +719.107 425 L +719.184 425 L +719.262 425 L +719.34 425 L +719.418 425 L +719.495 425 L +719.573 425 L +719.651 425 L +719.729 425 L +719.806 425 L +719.884 425 L +719.962 425 L +720.039 425 L +720.117 425 L +720.195 425 L +720.273 425 L +720.35 425 L +720.428 425 L +720.506 425 L +720.584 425 L +720.661 425 L +720.739 425 L +720.817 425 L +720.895 425 L +720.972 425 L +721.05 425 L +721.128 425 L +721.205 425 L +721.283 425 L +721.361 425 L +721.439 425 L +721.516 425 L +721.594 425 L +721.672 425 L +721.75 425 L +721.827 425 L +721.905 425 L +721.983 425 L +722.061 425 L +722.138 425 L +722.216 425 L +722.294 425 L +722.371 425 L +722.449 425 L +722.527 425 L +722.605 425 L +722.682 425 L +722.76 425 L +722.838 425 L +722.916 425 L +722.993 425 L +723.071 425 L +723.149 425 L +723.227 425 L +723.304 425 L +723.382 425 L +723.46 425 L +723.537 425 L +723.615 425 L +723.693 425 L +723.771 425 L +723.848 425 L +723.926 425 L +724.004 425 L +724.082 425 L +724.159 425 L +724.237 425 L +724.315 425 L +724.393 425 L +724.47 425 L +724.548 425 L +724.626 425 L +724.703 425 L +724.781 425 L +724.859 425 L +724.937 425 L +725.014 425 L +725.092 425 L +725.17 425 L +725.248 425 L +725.325 425 L +725.403 425 L +725.481 425 L +725.559 425 L +725.636 425 L +725.714 425 L +725.792 425 L +725.87 425 L +725.947 425 L +726.025 425 L +726.103 425 L +726.18 425 L +726.258 425 L +726.336 425 L +726.414 425 L +726.491 425 L +726.569 425 L +726.647 425 L +726.725 425 L +726.802 425 L +726.88 425 L +726.958 425 L +727.036 425 L +727.113 425 L +727.191 425 L +727.269 425 L +727.346 425 L +727.424 425 L +727.502 425 L +727.58 425 L +727.657 425 L +727.735 425 L +727.813 425 L +727.891 425 L +727.968 425 L +728.046 425 L +728.124 425 L +728.202 425 L +728.279 425 L +728.357 425 L +728.435 425 L +728.513 425 L +728.59 425 L +728.668 425 L +728.746 425 L +728.823 425 L +728.901 425 L +728.979 425 L +729.057 425 L +729.134 425 L +729.212 425 L +729.29 425 L +729.368 425 L +729.445 425 L +729.523 425 L +729.601 425 L +729.679 425 L +729.756 425 L +729.834 425 L +729.912 425 L +729.989 425 L +730.067 425 L +730.145 425 L +730.223 425 L +730.3 425 L +730.378 425 L +730.456 425 L +730.534 425 L +730.611 425 L +730.689 425 L +730.767 425 L +730.845 425 L +730.922 425 L +731 425 L +731.078 425 L +731.155 425 L +731.233 425 L +731.311 425 L +731.389 425 L +731.466 425 L +731.544 425 L +731.622 425 L +731.7 425 L +731.777 425 L +731.855 425 L +731.933 425 L +732.011 425 L +732.088 425 L +732.166 425 L +732.244 425 L +732.321 425 L +732.399 425 L +732.477 425 L +732.555 425 L +732.632 425 L +732.71 425 L +732.788 425 L +732.866 425 L +732.943 425 L +733.021 425 L +733.099 425 L +733.177 425 L +733.254 425 L +733.332 425 L +733.41 425 L +733.487 425 L +733.565 425 L +733.643 425 L +733.721 425 L +733.798 425 L +733.876 425 L +733.954 425 L +734.032 425 L +734.109 425 L +734.187 425 L +734.265 425 L +734.343 425 L +734.42 425 L +734.498 425 L +734.576 425 L +734.654 425 L +734.731 425 L +734.809 425 L +734.887 425 L +734.964 425 L +735.042 425 L +735.12 425 L +735.198 425 L +735.275 425 L +735.353 425 L +735.431 425 L +735.509 425 L +735.586 425 L +735.664 425 L +735.742 425 L +735.82 425 L +735.897 425 L +735.975 425 L +736.053 425 L +736.13 425 L +736.208 425 L +736.286 425 L +736.364 425 L +736.441 425 L +736.519 425 L +736.597 425 L +736.675 425 L +736.752 425 L +736.83 425 L +736.908 425 L +736.986 425 L +737.063 425 L +737.141 425 L +737.219 425 L +737.297 425 L +737.374 425 L +737.452 425 L +737.53 425 L +737.607 425 L +737.685 425 L +737.763 425 L +737.841 425 L +737.918 425 L +737.996 425 L +738.074 425 L +738.152 425 L +738.229 425 L +738.307 425 L +738.385 425 L +738.463 425 L +738.54 425 L +738.618 425 L +738.696 425 L +738.773 425 L +738.851 425 L +738.929 425 L +739.007 425 L +739.084 425 L +739.162 425 L +739.24 425 L +739.318 425 L +739.395 425 L +739.473 425 L +739.551 425 L +739.629 425 L +739.706 425 L +739.784 425 L +739.862 425 L +739.939 425 L +740.017 425 L +740.095 425 L +740.173 425 L +740.25 425 L +740.328 425 L +740.406 425 L +740.484 425 L +740.561 425 L +740.639 425 L +740.717 425 L +740.795 425 L +740.872 425 L +740.95 425 L +741.028 425 L +741.105 425 L +741.183 425 L +741.261 425 L +741.339 425 L +741.416 425 L +741.494 425 L +741.572 425 L +741.65 425 L +741.727 425 L +741.805 425 L +741.883 425 L +741.961 425 L +742.038 425 L +742.116 425 L +742.194 425 L +742.271 425 L +742.349 425 L +742.427 425 L +742.505 425 L +742.582 425 L +742.66 425 L +742.738 425 L +742.816 425 L +742.893 425 L +742.971 425 L +743.049 425 L +743.127 425 L +743.204 425 L +743.282 425 L +743.36 425 L +743.438 425 L +743.515 425 L +743.593 425 L +743.671 425 L +743.748 425 L +743.826 425 L +743.904 425 L +743.982 425 L +744.059 425 L +744.137 425 L +744.215 425 L +744.293 425 L +744.37 425 L +744.448 425 L +744.526 425 L +744.604 425 L +744.681 425 L +744.759 425 L +744.837 425 L +744.914 425 L +744.992 425 L +745.07 425 L +745.148 425 L +745.225 425 L +745.303 425 L +745.381 425 L +745.459 425 L +745.536 425 L +745.614 425 L +745.692 425 L +745.77 425 L +745.847 425 L +745.925 425 L +746.003 425 L +746.08 425 L +746.158 425 L +746.236 425 L +746.314 425 L +746.391 425 L +746.469 425 L +746.547 425 L +746.625 425 L +746.702 425 L +746.78 425 L +746.858 425 L +746.936 425 L +747.013 425 L +747.091 425 L +747.169 425 L +747.246 425 L +747.324 425 L +747.402 425 L +747.48 425 L +747.557 425 L +747.635 425 L +747.713 425 L +747.791 425 L +747.868 425 L +747.946 425 L +748.024 425 L +748.102 425 L +748.179 425 L +748.257 425 L +748.335 425 L +748.412 425 L +748.49 425 L +748.568 425 L +748.646 425 L +748.723 425 L +748.801 425 L +748.879 425 L +748.957 425 L +749.034 425 L +749.112 425 L +749.19 425 L +749.268 425 L +749.345 425 L +749.423 425 L +749.501 425 L +749.578 425 L +749.656 425 L +749.734 425 L +749.812 425 L +749.889 425 L +749.967 425 L +750.045 425 L +750.123 425 L +750.2 425 L +750.278 425 L +750.356 425 L +750.434 425 L +750.511 425 L +750.589 425 L +750.667 425 L +750.745 425 L +750.822 425 L +750.9 425 L +750.978 425 L +751.055 425 L +751.133 425 L +751.211 425 L +751.289 425 L +751.366 425 L +751.444 425 L +751.522 425 L +751.6 425 L +751.677 425 L +751.755 425 L +751.833 425 L +751.911 425 L +751.988 425 L +752.066 425 L +752.144 425 L +752.221 424.999 L +752.299 424.999 L +752.377 424.999 L +752.455 424.999 L +752.532 424.999 L +752.61 424.999 L +752.688 424.999 L +752.766 424.999 L +752.843 424.999 L +752.921 424.999 L +752.999 424.999 L +753.077 424.999 L +753.154 424.999 L +753.232 424.999 L +753.31 424.999 L +753.388 424.999 L +753.465 424.999 L +753.543 424.999 L +753.621 424.999 L +753.698 424.999 L +753.776 424.998 L +753.854 424.998 L +753.932 424.998 L +754.009 424.998 L +754.087 424.998 L +754.165 424.998 L +754.243 424.998 L +754.32 424.998 L +754.398 424.997 L +754.476 424.997 L +754.554 424.997 L +754.631 424.997 L +754.709 424.997 L +754.787 424.997 L +754.864 424.996 L +754.942 424.996 L +755.02 424.996 L +755.098 424.996 L +755.175 424.996 L +755.253 424.995 L +755.331 424.995 L +755.409 424.995 L +755.486 424.995 L +755.564 424.994 L +755.642 424.994 L +755.72 424.993 L +755.797 424.993 L +755.875 424.993 L +755.953 424.992 L +756.03 424.992 L +756.108 424.991 L +756.186 424.991 L +756.264 424.99 L +756.341 424.99 L +756.419 424.989 L +756.497 424.988 L +756.575 424.988 L +756.652 424.987 L +756.73 424.986 L +756.808 424.986 L +756.886 424.985 L +756.963 424.984 L +757.041 424.983 L +757.119 424.982 L +757.196 424.981 L +757.274 424.98 L +757.352 424.979 L +757.43 424.977 L +757.507 424.976 L +757.585 424.975 L +757.663 424.973 L +757.741 424.972 L +757.818 424.97 L +757.896 424.968 L +757.974 424.966 L +758.052 424.964 L +758.129 424.962 L +758.207 424.96 L +758.285 424.958 L +758.362 424.955 L +758.44 424.953 L +758.518 424.95 L +758.596 424.947 L +758.673 424.944 L +758.751 424.941 L +758.829 424.937 L +758.907 424.933 L +758.984 424.93 L +759.062 424.925 L +759.14 424.921 L +759.218 424.916 L +759.295 424.912 L +759.373 424.906 L +759.451 424.901 L +759.529 424.895 L +759.606 424.889 L +759.684 424.883 L +759.762 424.876 L +759.839 424.868 L +759.917 424.861 L +759.995 424.853 L +760.073 424.844 L +760.15 424.835 L +760.228 424.825 L +760.306 424.815 L +760.384 424.805 L +760.461 424.793 L +760.539 424.781 L +760.617 424.768 L +760.695 424.755 L +760.772 424.74 L +760.85 424.725 L +760.928 424.709 L +761.005 424.692 L +761.083 424.674 L +761.161 424.656 L +761.239 424.635 L +761.316 424.614 L +761.394 424.592 L +761.472 424.568 L +761.55 424.543 L +761.627 424.516 L +761.705 424.488 L +761.783 424.458 L +761.861 424.427 L +761.938 424.393 L +762.016 424.358 L +762.094 424.321 L +762.172 424.281 L +762.249 424.239 L +762.327 424.195 L +762.405 424.148 L +762.482 424.098 L +762.56 424.046 L +762.638 423.991 L +762.716 423.932 L +762.793 423.87 L +762.871 423.804 L +762.949 423.734 L +763.027 423.661 L +763.104 423.583 L +763.182 423.501 L +763.26 423.414 L +763.338 423.322 L +763.415 423.224 L +763.493 423.121 L +763.571 423.012 L +763.648 422.897 L +763.726 422.775 L +763.804 422.646 L +763.882 422.509 L +763.959 422.365 L +764.037 422.213 L +764.115 422.051 L +764.193 421.881 L +764.27 421.7 L +764.348 421.51 L +764.426 421.308 L +764.504 421.095 L +764.581 420.869 L +764.659 420.631 L +764.737 420.38 L +764.814 420.113 L +764.892 419.832 L +764.97 419.535 L +765.048 419.221 L +765.125 418.889 L +765.203 418.539 L +765.281 418.169 L +765.359 417.778 L +765.436 417.365 L +765.514 416.929 L +765.592 416.469 L +765.67 415.983 L +765.747 415.47 L +765.825 414.928 L +765.903 414.357 L +765.98 413.754 L +766.058 413.118 L +766.136 412.448 L +766.214 411.741 L +766.291 410.995 L +766.369 410.21 L +766.447 409.382 L +766.525 408.509 L +766.602 407.591 L +766.68 406.623 L +766.758 405.605 L +766.836 404.534 L +766.913 403.406 L +766.991 402.221 L +767.069 400.974 L +767.146 399.664 L +767.224 398.288 L +767.302 396.843 L +767.38 395.326 L +767.457 393.735 L +767.535 392.066 L +767.613 390.317 L +767.691 388.484 L +767.768 386.565 L +767.846 384.556 L +767.924 382.456 L +768.002 380.26 L +768.079 377.966 L +768.157 375.572 L +768.235 373.074 L +768.313 370.47 L +768.39 367.758 L +768.468 364.935 L +768.546 362 L +768.623 358.949 L +768.701 355.783 L +768.779 352.499 L +768.857 349.095 L +768.934 345.573 L +769.012 341.93 L +769.09 338.167 L +769.168 334.284 L +769.245 330.281 L +769.323 326.161 L +769.401 321.924 L +769.479 317.573 L +769.556 313.11 L +769.634 308.538 L +769.712 303.862 L +769.789 299.084 L +769.867 294.21 L +769.945 289.244 L +770.023 284.193 L +770.1 279.062 L +770.178 273.858 L +770.256 268.587 L +770.334 263.258 L +770.411 257.878 L +770.489 252.455 L +770.567 246.997 L +770.645 241.513 L +770.722 236.011 L +770.8 230.5 L +770.878 224.989 L +770.955 219.487 L +771.033 214.003 L +771.111 208.545 L +771.189 203.122 L +771.266 197.742 L +771.344 192.413 L +771.422 187.142 L +771.5 181.938 L +771.577 176.807 L +771.655 171.756 L +771.733 166.79 L +771.811 161.916 L +771.888 157.138 L +771.966 152.462 L +772.044 147.89 L +772.121 143.427 L +772.199 139.076 L +772.277 134.839 L +772.355 130.719 L +772.432 126.716 L +772.51 122.833 L +772.588 119.07 L +772.666 115.427 L +772.743 111.905 L +772.821 108.501 L +772.899 105.217 L +772.977 102.051 L +773.054 99 L +773.132 96.065 L +773.21 93.242 L +773.287 90.53 L +773.365 87.926 L +773.443 85.428 L +773.521 83.034 L +773.598 80.74 L +773.676 78.544 L +773.754 76.444 L +773.832 74.435 L +773.909 72.516 L +773.987 70.683 L +774.065 68.934 L +774.143 67.265 L +774.22 65.674 L +774.298 64.157 L +774.376 62.712 L +774.453 61.336 L +774.531 60.026 L +774.609 58.779 L +774.687 57.594 L +774.764 56.466 L +774.842 55.395 L +774.92 54.377 L +774.998 53.409 L +775.075 52.491 L +775.153 51.618 L +775.231 50.791 L +775.309 50.005 L +775.386 49.259 L +775.464 48.552 L +775.542 47.882 L +775.62 47.246 L +775.697 46.643 L +775.775 46.072 L +775.853 45.53 L +775.93 45.017 L +776.008 44.531 L +776.086 44.071 L +776.164 43.635 L +776.241 43.222 L +776.319 42.831 L +776.397 42.461 L +776.475 42.111 L +776.552 41.779 L +776.63 41.465 L +776.708 41.168 L +776.786 40.887 L +776.863 40.62 L +776.941 40.369 L +777.019 40.131 L +777.096 39.905 L +777.174 39.692 L +777.252 39.49 L +777.33 39.3 L +777.407 39.119 L +777.485 38.949 L +777.563 38.787 L +777.641 38.635 L +777.718 38.491 L +777.796 38.354 L +777.874 38.225 L +777.952 38.103 L +778.029 37.988 L +778.107 37.879 L +778.185 37.776 L +778.263 37.678 L +778.34 37.586 L +778.418 37.499 L +778.496 37.417 L +778.573 37.339 L +778.651 37.266 L +778.729 37.196 L +778.807 37.13 L +778.884 37.068 L +778.962 37.01 L +779.04 36.954 L +779.118 36.902 L +779.195 36.852 L +779.273 36.805 L +779.351 36.761 L +779.429 36.719 L +779.506 36.679 L +779.584 36.642 L +779.662 36.607 L +779.739 36.573 L +779.817 36.542 L +779.895 36.512 L +779.973 36.484 L +780.05 36.457 L +780.128 36.432 L +780.206 36.408 L +780.284 36.386 L +780.361 36.365 L +780.439 36.344 L +780.517 36.325 L +780.595 36.308 L +780.672 36.291 L +780.75 36.275 L +780.828 36.259 L +780.905 36.245 L +780.983 36.232 L +781.061 36.219 L +781.139 36.207 L +781.216 36.196 L +781.294 36.185 L +781.372 36.175 L +781.45 36.165 L +781.527 36.156 L +781.605 36.147 L +781.683 36.139 L +781.761 36.131 L +781.838 36.124 L +781.916 36.117 L +781.994 36.111 L +782.071 36.105 L +782.149 36.099 L +782.227 36.094 L +782.305 36.088 L +782.382 36.084 L +782.46 36.079 L +782.538 36.075 L +782.616 36.071 L +782.693 36.067 L +782.771 36.063 L +782.849 36.059 L +782.927 36.056 L +783.004 36.053 L +783.082 36.05 L +783.16 36.047 L +783.237 36.045 L +783.315 36.042 L +783.393 36.04 L +783.471 36.038 L +783.548 36.036 L +783.626 36.034 L +783.704 36.032 L +783.782 36.03 L +783.859 36.028 L +783.937 36.027 L +784.015 36.025 L +784.093 36.024 L +784.17 36.023 L +784.248 36.021 L +784.326 36.02 L +784.404 36.019 L +784.481 36.018 L +784.559 36.017 L +784.637 36.016 L +784.714 36.015 L +784.792 36.014 L +784.87 36.014 L +784.948 36.013 L +785.025 36.012 L +785.103 36.012 L +785.181 36.011 L +785.259 36.01 L +785.336 36.01 L +785.414 36.009 L +785.492 36.009 L +785.57 36.008 L +785.647 36.008 L +785.725 36.007 L +785.803 36.007 L +785.88 36.007 L +785.958 36.006 L +786.036 36.006 L +786.114 36.005 L +786.191 36.005 L +786.269 36.005 L +786.347 36.005 L +786.425 36.004 L +786.502 36.004 L +786.58 36.004 L +786.658 36.004 L +786.736 36.004 L +786.813 36.003 L +786.891 36.003 L +786.969 36.003 L +787.047 36.003 L +787.124 36.003 L +787.202 36.002 L +787.28 36.002 L +787.357 36.002 L +787.435 36.002 L +787.513 36.002 L +787.591 36.002 L +787.668 36.002 L +787.746 36.002 L +787.824 36.002 L +787.902 36.001 L +787.979 36.001 L +788.057 36.001 L +788.135 36.001 L +788.213 36.001 L +788.29 36.001 L +788.368 36.001 L +788.446 36.001 L +788.523 36.001 L +788.601 36.001 L +788.679 36.001 L +788.757 36.001 L +788.834 36.001 L +788.912 36.001 L +788.99 36.001 L +789.068 36.001 L +789.145 36.001 L +789.223 36.001 L +789.301 36.001 L +789.379 36.001 L +789.456 36 L +789.534 36 L +789.612 36 L +789.689 36 L +789.767 36 L +789.845 36 L +789.923 36 L +790 36 L +790.078 36 L +790.156 36 L +790.234 36 L +790.311 36 L +790.389 36 L +790.467 36 L +790.545 36 L +790.622 36 L +790.7 36 L +790.778 36 L +790.855 36 L +790.933 36 L +791.011 36 L +791.089 36 L +791.166 36 L +791.244 36 L +791.322 36 L +791.4 36 L +791.477 36 L +791.555 36 L +791.633 36 L +791.711 36 L +791.788 36 L +791.866 36 L +791.944 36 L +792.021 36 L +792.099 36 L +792.177 36 L +792.255 36 L +792.332 36 L +792.41 36 L +792.488 36 L +792.566 36 L +792.643 36 L +792.721 36 L +792.799 36 L +792.877 36 L +792.954 36 L +793.032 36 L +793.11 36 L +793.188 36 L +793.265 36 L +793.343 36 L +793.421 36 L +793.498 36 L +793.576 36 L +793.654 36 L +793.732 36 L +793.809 36 L +793.887 36 L +793.965 36 L +794.043 36 L +794.12 36 L +794.198 36 L +794.276 36 L +794.354 36 L +794.431 36 L +794.509 36 L +794.587 36 L +794.664 36 L +794.742 36 L +794.82 36 L +794.898 36 L +794.975 36 L +795.053 36 L +795.131 36 L +795.209 36 L +795.286 36 L +795.364 36 L +795.442 36 L +795.52 36 L +795.597 36 L +795.675 36 L +795.753 36 L +795.83 36 L +795.908 36 L +795.986 36 L +796.064 36 L +796.141 36 L +796.219 36 L +796.297 36 L +796.375 36 L +796.452 36 L +796.53 36 L +796.608 36 L +796.686 36 L +796.763 36 L +796.841 36 L +796.919 36 L +796.996 36 L +797.074 36 L +797.152 36 L +797.23 36 L +797.307 36 L +797.385 36 L +797.463 36 L +797.541 36 L +797.618 36 L +797.696 36 L +797.774 36 L +797.852 36 L +797.929 36 L +798.007 36 L +798.085 36 L +798.162 36 L +798.24 36 L +798.318 36 L +798.396 36 L +798.473 36 L +798.551 36 L +798.629 36 L +798.707 36 L +798.784 36 L +798.862 36 L +798.94 36 L +799.018 36 L +799.095 36 L +799.173 36 L +799.251 36 L +799.328 36 L +799.406 36 L +799.484 36 L +799.562 36 L +799.639 36 L +799.717 36 L +799.795 36 L +799.873 36 L +799.95 36 L +800.028 36 L +800.106 36 L +800.184 36 L +800.261 36 L +800.339 36 L +800.417 36 L +800.495 36 L +800.572 36 L +800.65 36 L +800.728 36 L +800.805 36 L +800.883 36 L +800.961 36 L +801.039 36 L +801.116 36 L +801.194 36 L +801.272 36 L +801.35 36 L +801.427 36 L +801.505 36 L +801.583 36 L +801.661 36 L +801.738 36 L +801.816 36 L +801.894 36 L +801.971 36 L +802.049 36 L +802.127 36 L +802.205 36 L +802.282 36 L +802.36 36 L +802.438 36 L +802.516 36 L +802.593 36 L +802.671 36 L +802.749 36 L +802.827 36 L +802.904 36 L +802.982 36 L +803.06 36 L +803.138 36 L +803.215 36 L +803.293 36 L +803.371 36 L +803.448 36 L +803.526 36 L +803.604 36 L +803.682 36 L +803.759 36 L +803.837 36 L +803.915 36 L +803.993 36 L +804.07 36 L +804.148 36 L +804.226 36 L +804.304 36 L +804.381 36 L +804.459 36 L +804.537 36 L +804.614 36 L +804.692 36 L +804.77 36 L +804.848 36 L +804.925 36 L +805.003 36 L +805.081 36 L +805.159 36 L +805.236 36 L +805.314 36 L +805.392 36 L +805.47 36 L +805.547 36 L +805.625 36 L +805.703 36 L +805.78 36 L +805.858 36 L +805.936 36 L +806.014 36 L +806.091 36 L +806.169 36 L +806.247 36 L +806.325 36 L +806.402 36 L +806.48 36 L +806.558 36 L +806.636 36 L +806.713 36 L +806.791 36 L +806.869 36 L +806.946 36 L +807.024 36 L +807.102 36 L +807.18 36 L +807.257 36 L +807.335 36 L +807.413 36 L +807.491 36 L +807.568 36 L +807.646 36 L +807.724 36 L +807.802 36 L +807.879 36 L +807.957 36 L +808.035 36 L +808.112 36 L +808.19 36 L +808.268 36 L +808.346 36 L +808.423 36 L +808.501 36 L +808.579 36 L +808.657 36 L +808.734 36 L +808.812 36 L +808.89 36 L +808.968 36 L +809.045 36 L +809.123 36 L +809.201 36 L +809.279 36 L +809.356 36 L +809.434 36 L +809.512 36 L +809.589 36 L +809.667 36 L +809.745 36 L +809.823 36 L +809.9 36 L +809.978 36 L +810.056 36 L +810.134 36 L +810.211 36 L +810.289 36 L +810.367 36 L +810.445 36 L +810.522 36 L +810.6 36 L +810.678 36 L +810.755 36 L +810.833 36 L +810.911 36 L +810.989 36 L +811.066 36 L +811.144 36 L +811.222 36 L +811.3 36 L +811.377 36 L +811.455 36 L +811.533 36 L +811.611 36 L +811.688 36 L +811.766 36 L +811.844 36 L +811.922 36 L +811.999 36 L +812.077 36 L +812.155 36 L +812.232 36 L +812.31 36 L +812.388 36 L +812.466 36 L +812.543 36 L +812.621 36 L +812.699 36 L +812.777 36 L +812.854 36 L +812.932 36 L +813.01 36 L +813.088 36 L +813.165 36 L +813.243 36 L +813.321 36 L +813.398 36 L +813.476 36 L +813.554 36 L +813.632 36 L +813.709 36 L +813.787 36 L +813.865 36 L +813.943 36 L +814.02 36 L +814.098 36 L +814.176 36 L +814.254 36 L +814.331 36 L +814.409 36 L +814.487 36 L +814.564 36 L +814.642 36 L +814.72 36 L +814.798 36 L +814.875 36 L +814.953 36 L +815.031 36 L +815.109 36 L +815.186 36 L +815.264 36 L +815.342 36 L +815.42 36 L +815.497 36 L +815.575 36 L +815.653 36 L +815.73 36 L +815.808 36 L +815.886 36 L +815.964 36 L +816.041 36 L +816.119 36 L +816.197 36 L +816.275 36 L +816.352 36 L +816.43 36 L +816.508 36 L +816.586 36 L +816.663 36 L +816.741 36 L +816.819 36 L +816.896 36 L +816.974 36 L +817.052 36 L +817.13 36 L +817.207 36 L +817.285 36 L +817.363 36 L +817.441 36 L +817.518 36 L +817.596 36 L +817.674 36 L +817.752 36 L +817.829 36 L +817.907 36 L +817.985 36 L +818.063 36 L +818.14 36 L +818.218 36 L +818.296 36 L +818.373 36 L +818.451 36 L +818.529 36 L +818.607 36 L +818.684 36 L +818.762 36 L +818.84 36 L +818.918 36 L +818.995 36 L +819.073 36 L +819.151 36 L +819.229 36 L +819.306 36 L +819.384 36 L +819.462 36 L +819.539 36 L +819.617 36 L +819.695 36 L +819.773 36 L +819.85 36 L +819.928 36 L +820.006 36 L +820.084 36 L +820.161 36 L +820.239 36 L +820.317 36 L +820.395 36 L +820.472 36 L +820.55 36 L +820.628 36 L +820.705 36 L +820.783 36 L +820.861 36 L +820.939 36 L +821.016 36 L +821.094 36 L +821.172 36 L +821.25 36 L +821.327 36 L +821.405 36 L +821.483 36 L +821.561 36 L +821.638 36 L +821.716 36 L +821.794 36 L +821.871 36 L +821.949 36 L +822.027 36 L +822.105 36 L +822.182 36 L +822.26 36 L +822.338 36 L +822.416 36 L +822.493 36 L +822.571 36 L +822.649 36 L +822.727 36 L +822.804 36 L +822.882 36 L +822.96 36 L +823.037 36 L +823.115 36 L +823.193 36 L +823.271 36 L +823.348 36 L +823.426 36 L +823.504 36 L +823.582 36 L +823.659 36 L +823.737 36 L +823.815 36 L +823.893 36 L +823.97 36 L +824.048 36 L +824.126 36 L +824.203 36 L +824.281 36 L +824.359 36 L +824.437 36 L +824.514 36 L +824.592 36 L +824.67 36 L +824.748 36 L +824.825 36 L +824.903 36 L +824.981 36 L +825.059 36 L +825.136 36 L +825.214 36 L +825.292 36 L +825.37 36 L +825.447 36 L +825.525 36 L +825.603 36 L +825.68 36 L +825.758 36 L +825.836 36 L +825.914 36 L +825.991 36 L +826.069 36 L +826.147 36 L +826.225 36 L +826.302 36 L +826.38 36 L +826.458 36 L +826.536 36 L +826.613 36 L +826.691 36 L +826.769 36 L +826.846 36 L +826.924 36 L +827.002 36 L +827.08 36 L +827.157 36 L +827.235 36 L +827.313 36 L +827.391 36 L +827.468 36 L +827.546 36 L +827.624 36 L +827.702 36 L +827.779 36 L +827.857 36 L +827.935 36 L +828.013 36 L +828.09 36 L +828.168 36 L +828.246 36 L +828.323 36 L +828.401 36 L +828.479 36 L +828.557 36 L +828.634 36 L +828.712 36 L +828.79 36 L +828.868 36 L +828.945 36 L +829.023 36 L +829.101 36 L +829.179 36 L +829.256 36 L +829.334 36 L +829.412 36 L +829.489 36 L +829.567 36 L +829.645 36 L +829.723 36 L +829.8 36 L +829.878 36 L +829.956 36 L +830.034 36 L +830.111 36 L +830.189 36 L +830.267 36 L +830.345 36 L +830.422 36 L +830.5 36 L +830.578 36 L +830.655 36 L +830.733 36 L +830.811 36 L +830.889 36 L +830.966 36 L +831.044 36 L +831.122 36 L +831.2 36 L +831.277 36 L +831.355 36 L +831.433 36 L +831.511 36 L +831.588 36 L +831.666 36 L +831.744 36 L +831.821 36.001 L +831.899 36.001 L +831.977 36.001 L +832.055 36.001 L +832.132 36.001 L +832.21 36.001 L +832.288 36.001 L +832.366 36.001 L +832.443 36.001 L +832.521 36.001 L +832.599 36.001 L +832.677 36.001 L +832.754 36.001 L +832.832 36.001 L +832.91 36.001 L +832.987 36.001 L +833.065 36.001 L +833.143 36.001 L +833.221 36.001 L +833.298 36.001 L +833.376 36.002 L +833.454 36.002 L +833.532 36.002 L +833.609 36.002 L +833.687 36.002 L +833.765 36.002 L +833.843 36.002 L +833.92 36.002 L +833.998 36.002 L +834.076 36.003 L +834.154 36.003 L +834.231 36.003 L +834.309 36.003 L +834.387 36.003 L +834.464 36.004 L +834.542 36.004 L +834.62 36.004 L +834.698 36.004 L +834.775 36.004 L +834.853 36.005 L +834.931 36.005 L +835.009 36.005 L +835.086 36.005 L +835.164 36.006 L +835.242 36.006 L +835.32 36.007 L +835.397 36.007 L +835.475 36.007 L +835.553 36.008 L +835.63 36.008 L +835.708 36.009 L +835.786 36.009 L +835.864 36.01 L +835.941 36.01 L +836.019 36.011 L +836.097 36.012 L +836.175 36.012 L +836.252 36.013 L +836.33 36.014 L +836.408 36.014 L +836.486 36.015 L +836.563 36.016 L +836.641 36.017 L +836.719 36.018 L +836.797 36.019 L +836.874 36.02 L +836.952 36.021 L +837.03 36.023 L +837.107 36.024 L +837.185 36.025 L +837.263 36.027 L +837.341 36.028 L +837.418 36.03 L +837.496 36.032 L +837.574 36.034 L +837.652 36.036 L +837.729 36.038 L +837.807 36.04 L +837.885 36.042 L +837.963 36.045 L +838.04 36.047 L +838.118 36.05 L +838.196 36.053 L +838.273 36.056 L +838.351 36.059 L +838.429 36.063 L +838.507 36.067 L +838.584 36.071 L +838.662 36.075 L +838.74 36.079 L +838.818 36.084 L +838.895 36.088 L +838.973 36.094 L +839.051 36.099 L +839.129 36.105 L +839.206 36.111 L +839.284 36.117 L +839.362 36.124 L +839.439 36.131 L +839.517 36.139 L +839.595 36.147 L +839.673 36.156 L +839.75 36.165 L +839.828 36.175 L +839.906 36.185 L +839.984 36.196 L +840.061 36.207 L +840.139 36.219 L +840.217 36.232 L +840.295 36.245 L +840.372 36.259 L +840.45 36.275 L +840.528 36.291 L +840.605 36.308 L +840.683 36.325 L +840.761 36.344 L +840.839 36.365 L +840.916 36.386 L +840.994 36.408 L +841.072 36.432 L +841.15 36.457 L +841.227 36.484 L +841.305 36.512 L +841.383 36.542 L +841.461 36.573 L +841.538 36.607 L +841.616 36.642 L +841.694 36.679 L +841.771 36.719 L +841.849 36.761 L +841.927 36.805 L +842.005 36.852 L +842.082 36.902 L +842.16 36.954 L +842.238 37.01 L +842.316 37.068 L +842.393 37.13 L +842.471 37.196 L +842.549 37.266 L +842.627 37.339 L +842.704 37.417 L +842.782 37.499 L +842.86 37.586 L +842.938 37.678 L +843.015 37.776 L +843.093 37.879 L +843.171 37.988 L +843.248 38.103 L +843.326 38.225 L +843.404 38.354 L +843.482 38.491 L +843.559 38.635 L +843.637 38.787 L +843.715 38.949 L +843.793 39.119 L +843.87 39.3 L +843.948 39.49 L +844.026 39.692 L +844.104 39.905 L +844.181 40.131 L +844.259 40.369 L +844.337 40.62 L +844.414 40.887 L +844.492 41.168 L +844.57 41.465 L +844.648 41.779 L +844.725 42.111 L +844.803 42.461 L +844.881 42.831 L +844.959 43.222 L +845.036 43.635 L +845.114 44.071 L +845.192 44.531 L +845.27 45.017 L +845.347 45.53 L +845.425 46.072 L +845.503 46.643 L +845.58 47.246 L +845.658 47.882 L +845.736 48.552 L +845.814 49.259 L +845.891 50.005 L +845.969 50.791 L +846.047 51.618 L +846.125 52.491 L +846.202 53.409 L +846.28 54.377 L +846.358 55.395 L +846.436 56.466 L +846.513 57.594 L +846.591 58.779 L +846.669 60.026 L +846.746 61.336 L +846.824 62.712 L +846.902 64.157 L +846.98 65.674 L +847.057 67.265 L +847.135 68.934 L +847.213 70.683 L +847.291 72.516 L +847.368 74.435 L +847.446 76.444 L +847.524 78.544 L +847.602 80.74 L +847.679 83.034 L +847.757 85.428 L +847.835 87.926 L +847.912 90.53 L +847.99 93.242 L +848.068 96.065 L +848.146 99 L +848.223 102.051 L +848.301 105.217 L +848.379 108.501 L +848.457 111.905 L +848.534 115.427 L +848.612 119.07 L +848.69 122.833 L +848.768 126.716 L +848.845 130.719 L +848.923 134.839 L +849.001 139.076 L +849.078 143.427 L +849.156 147.89 L +849.234 152.462 L +849.312 157.138 L +849.389 161.916 L +849.467 166.79 L +849.545 171.756 L +849.623 176.807 L +849.7 181.938 L +849.778 187.142 L +849.856 192.413 L +849.934 197.742 L +850.011 203.122 L +850.089 208.545 L +850.167 214.003 L +850.245 219.487 L +850.322 224.989 L +850.4 230.5 L +850.478 236.011 L +850.555 241.513 L +850.633 246.997 L +850.711 252.455 L +850.789 257.878 L +850.866 263.258 L +850.944 268.587 L +851.022 273.858 L +851.1 279.062 L +851.177 284.193 L +851.255 289.244 L +851.333 294.21 L +851.411 299.084 L +851.488 303.862 L +851.566 308.538 L +851.644 313.11 L +851.721 317.573 L +851.799 321.924 L +851.877 326.161 L +851.955 330.281 L +852.032 334.284 L +852.11 338.167 L +852.188 341.93 L +852.266 345.573 L +852.343 349.095 L +852.421 352.499 L +852.499 355.783 L +852.577 358.949 L +852.654 362 L +852.732 364.935 L +852.81 367.758 L +852.888 370.47 L +852.965 373.074 L +853.043 375.572 L +853.121 377.966 L +853.198 380.26 L +853.276 382.456 L +853.354 384.556 L +853.432 386.565 L +853.509 388.484 L +853.587 390.317 L +853.665 392.066 L +853.743 393.735 L +853.82 395.326 L +853.898 396.843 L +853.976 398.288 L +854.054 399.664 L +854.131 400.974 L +854.209 402.221 L +854.287 403.406 L +854.364 404.534 L +854.442 405.605 L +854.52 406.623 L +854.598 407.591 L +854.675 408.509 L +854.753 409.382 L +854.831 410.21 L +854.909 410.995 L +854.986 411.741 L +855.064 412.448 L +855.142 413.118 L +855.22 413.754 L +855.297 414.357 L +855.375 414.928 L +855.453 415.47 L +855.53 415.983 L +855.608 416.469 L +855.686 416.929 L +855.764 417.365 L +855.841 417.778 L +855.919 418.169 L +855.997 418.539 L +856.075 418.889 L +856.152 419.221 L +856.23 419.535 L +856.308 419.832 L +856.386 420.113 L +856.463 420.38 L +856.541 420.631 L +856.619 420.869 L +856.696 421.095 L +856.774 421.308 L +856.852 421.51 L +856.93 421.7 L +857.007 421.881 L +857.085 422.051 L +857.163 422.213 L +857.241 422.365 L +857.318 422.509 L +857.396 422.646 L +857.474 422.775 L +857.552 422.897 L +857.629 423.012 L +857.707 423.121 L +857.785 423.224 L +857.862 423.322 L +857.94 423.414 L +858.018 423.501 L +858.096 423.583 L +858.173 423.661 L +858.251 423.734 L +858.329 423.804 L +858.407 423.87 L +858.484 423.932 L +858.562 423.991 L +858.64 424.046 L +858.718 424.098 L +858.795 424.148 L +858.873 424.195 L +858.951 424.239 L +859.029 424.281 L +859.106 424.321 L +859.184 424.358 L +859.262 424.393 L +859.339 424.427 L +859.417 424.458 L +859.495 424.488 L +859.573 424.516 L +859.65 424.543 L +859.728 424.568 L +859.806 424.592 L +859.884 424.614 L +859.961 424.635 L +860.039 424.656 L +860.117 424.674 L +860.195 424.692 L +860.272 424.709 L +860.35 424.725 L +860.428 424.74 L +860.505 424.755 L +860.583 424.768 L +860.661 424.781 L +860.739 424.793 L +860.816 424.805 L +860.894 424.815 L +860.972 424.825 L +861.05 424.835 L +861.127 424.844 L +861.205 424.853 L +861.283 424.861 L +861.361 424.868 L +861.438 424.876 L +861.516 424.883 L +861.594 424.889 L +861.672 424.895 L +861.749 424.901 L +861.827 424.906 L +861.905 424.912 L +861.982 424.916 L +862.06 424.921 L +862.138 424.925 L +862.216 424.93 L +862.293 424.933 L +862.371 424.937 L +862.449 424.941 L +862.527 424.944 L +862.604 424.947 L +862.682 424.95 L +862.76 424.953 L +862.838 424.955 L +862.915 424.958 L +862.993 424.96 L +863.071 424.962 L +863.148 424.964 L +863.226 424.966 L +863.304 424.968 L +863.382 424.97 L +863.459 424.972 L +863.537 424.973 L +863.615 424.975 L +863.693 424.976 L +863.77 424.977 L +863.848 424.979 L +863.926 424.98 L +864.004 424.981 L +864.081 424.982 L +864.159 424.983 L +864.237 424.984 L +864.314 424.985 L +864.392 424.986 L +864.47 424.986 L +864.548 424.987 L +864.625 424.988 L +864.703 424.988 L +864.781 424.989 L +864.859 424.99 L +864.936 424.99 L +865.014 424.991 L +865.092 424.991 L +865.17 424.992 L +865.247 424.992 L +865.325 424.993 L +865.403 424.993 L +865.48 424.993 L +865.558 424.994 L +865.636 424.994 L +865.714 424.995 L +865.791 424.995 L +865.869 424.995 L +865.947 424.995 L +866.025 424.996 L +866.102 424.996 L +866.18 424.996 L +866.258 424.996 L +866.336 424.996 L +866.413 424.997 L +866.491 424.997 L +866.569 424.997 L +866.646 424.997 L +866.724 424.997 L +866.802 424.997 L +866.88 424.998 L +866.957 424.998 L +867.035 424.998 L +867.113 424.998 L +867.191 424.998 L +867.268 424.998 L +867.346 424.998 L +867.424 424.998 L +867.502 424.999 L +867.579 424.999 L +867.657 424.999 L +867.735 424.999 L +867.813 424.999 L +867.89 424.999 L +867.968 424.999 L +868.046 424.999 L +868.123 424.999 L +868.201 424.999 L +868.279 424.999 L +868.357 424.999 L +868.434 424.999 L +868.512 424.999 L +868.59 424.999 L +868.668 424.999 L +868.745 424.999 L +868.823 424.999 L +868.901 424.999 L +868.979 424.999 L +869.056 425 L +869.134 425 L +869.212 425 L +869.289 425 L +869.367 425 L +869.445 425 L +869.523 425 L +869.6 425 L +869.678 425 L +869.756 425 L +869.834 425 L +869.911 425 L +869.989 425 L +870.067 425 L +870.145 425 L +870.222 425 L +870.3 425 L +870.378 425 L +870.455 425 L +870.533 425 L +870.611 425 L +870.689 425 L +870.766 425 L +870.844 425 L +870.922 425 L +871 425 L +871.077 425 L +871.155 425 L +871.233 425 L +871.311 425 L +871.388 425 L +871.466 425 L +871.544 425 L +871.621 425 L +871.699 425 L +871.777 425 L +871.855 425 L +871.932 425 L +872.01 425 L +872.088 425 L +872.166 425 L +872.243 425 L +872.321 425 L +872.399 425 L +872.477 425 L +872.554 425 L +872.632 425 L +872.71 425 L +872.787 425 L +872.865 425 L +872.943 425 L +873.021 425 L +873.098 425 L +873.176 425 L +873.254 425 L +873.332 425 L +873.409 425 L +873.487 425 L +873.565 425 L +873.643 425 L +873.72 425 L +873.798 425 L +873.876 425 L +873.953 425 L +874.031 425 L +874.109 425 L +874.187 425 L +874.264 425 L +874.342 425 L +874.42 425 L +874.498 425 L +874.575 425 L +874.653 425 L +874.731 425 L +874.809 425 L +874.886 425 L +874.964 425 L +875.042 425 L +875.12 425 L +875.197 425 L +875.275 425 L +875.353 425 L +875.43 425 L +875.508 425 L +875.586 425 L +875.664 425 L +875.741 425 L +875.819 425 L +875.897 425 L +875.975 425 L +876.052 425 L +876.13 425 L +876.208 425 L +876.286 425 L +876.363 425 L +876.441 425 L +876.519 425 L +876.596 425 L +876.674 425 L +876.752 425 L +876.83 425 L +876.907 425 L +876.985 425 L +877.063 425 L +877.141 425 L +877.218 425 L +877.296 425 L +877.374 425 L +877.452 425 L +877.529 425 L +877.607 425 L +877.685 425 L +877.763 425 L +877.84 425 L +877.918 425 L +877.996 425 L +878.073 425 L +878.151 425 L +878.229 425 L +878.307 425 L +878.384 425 L +878.462 425 L +878.54 425 L +878.618 425 L +878.695 425 L +878.773 425 L +878.851 425 L +878.929 425 L +879.006 425 L +879.084 425 L +879.162 425 L +879.239 425 L +879.317 425 L +879.395 425 L +879.473 425 L +879.55 425 L +879.628 425 L +879.706 425 L +879.784 425 L +879.861 425 L +879.939 425 L +880.017 425 L +880.095 425 L +880.172 425 L +880.25 425 L +880.328 425 L +880.405 425 L +880.483 425 L +880.561 425 L +880.639 425 L +880.716 425 L +880.794 425 L +880.872 425 L +880.95 425 L +881.027 425 L +881.105 425 L +881.183 425 L +881.261 425 L +881.338 425 L +881.416 425 L +881.494 425 L +881.571 425 L +881.649 425 L +881.727 425 L +881.805 425 L +881.882 425 L +881.96 425 L +882.038 425 L +882.116 425 L +882.193 425 L +882.271 425 L +882.349 425 L +882.427 425 L +882.504 425 L +882.582 425 L +882.66 425 L +882.737 425 L +882.815 425 L +882.893 425 L +882.971 425 L +883.048 425 L +883.126 425 L +883.204 425 L +883.282 425 L +883.359 425 L +883.437 425 L +883.515 425 L +883.593 425 L +883.67 425 L +883.748 425 L +883.826 425 L +883.904 425 L +883.981 425 L +884.059 425 L +884.137 425 L +884.214 425 L +884.292 425 L +884.37 425 L +884.448 425 L +884.525 425 L +884.603 425 L +884.681 425 L +884.759 425 L +884.836 425 L +884.914 425 L +884.992 425 L +885.07 425 L +885.147 425 L +885.225 425 L +885.303 425 L +885.38 425 L +885.458 425 L +885.536 425 L +885.614 425 L +885.691 425 L +885.769 425 L +885.847 425 L +885.925 425 L +886.002 425 L +886.08 425 L +886.158 425 L +886.236 425 L +886.313 425 L +886.391 425 L +886.469 425 L +886.547 425 L +886.624 425 L +886.702 425 L +886.78 425 L +886.857 425 L +886.935 425 L +887.013 425 L +887.091 425 L +887.168 425 L +887.246 425 L +887.324 425 L +887.402 425 L +887.479 425 L +887.557 425 L +887.635 425 L +887.713 425 L +887.79 425 L +887.868 425 L +887.946 425 L +888.023 425 L +888.101 425 L +888.179 425 L +888.257 425 L +888.334 425 L +888.412 425 L +888.49 425 L +888.568 425 L +888.645 425 L +888.723 425 L +888.801 425 L +888.879 425 L +888.956 425 L +889.034 425 L +889.112 425 L +889.189 425 L +889.267 425 L +889.345 425 L +889.423 425 L +889.5 425 L +889.578 425 L +889.656 425 L +889.734 425 L +889.811 425 L +889.889 425 L +889.967 425 L +890.045 425 L +890.122 425 L +890.2 425 L +890.278 425 L +890.355 425 L +890.433 425 L +890.511 425 L +890.589 425 L +890.666 425 L +890.744 425 L +890.822 425 L +890.9 425 L +890.977 425 L +891.055 425 L +891.133 425 L +891.211 425 L +891.288 425 L +891.366 425 L +891.444 425 L +891.521 425 L +891.599 425 L +891.677 425 L +891.755 425 L +891.832 425 L +891.91 425 L +891.988 425 L +892.066 425 L +892.143 425 L +892.221 425 L +892.299 425 L +892.377 425 L +892.454 425 L +892.532 425 L +892.61 425 L +892.688 425 L +892.765 425 L +892.843 425 L +892.921 425 L +892.998 425 L +893.076 425 L +893.154 425 L +893.232 425 L +893.309 425 L +893.387 425 L +893.465 425 L +893.543 425 L +893.62 425 L +893.698 425 L +893.776 425 L +893.854 425 L +893.931 425 L +894.009 425 L +894.087 425 L +894.164 425 L +894.242 425 L +894.32 425 L +894.398 425 L +894.475 425 L +894.553 425 L +894.631 425 L +894.709 425 L +894.786 425 L +894.864 425 L +894.942 425 L +895.02 425 L +895.097 425 L +895.175 425 L +895.253 425 L +895.33 425 L +895.408 425 L +895.486 425 L +895.564 425 L +895.641 425 L +895.719 425 L +895.797 425 L +895.875 425 L +895.952 425 L +896.03 425 L +896.108 425 L +896.186 425 L +896.263 425 L +896.341 425 L +896.419 425 L +896.496 425 L +896.574 425 L +896.652 425 L +896.73 425 L +896.807 425 L +896.885 425 L +896.963 425 L +897.041 425 L +897.118 425 L +897.196 425 L +897.274 425 L +897.352 425 L +897.429 425 L +897.507 425 L +897.585 425 L +897.662 425 L +897.74 425 L +897.818 425 L +897.896 425 L +897.973 425 L +898.051 425 L +898.129 425 L +898.207 425 L +898.284 425 L +898.362 425 L +898.44 425 L +898.518 425 L +898.595 425 L +898.673 425 L +898.751 425 L +898.828 425 L +898.906 425 L +898.984 425 L +899.062 425 L +899.139 425 L +899.217 425 L +899.295 425 L +899.373 425 L +899.45 425 L +899.528 425 L +899.606 425 L +899.684 425 L +899.761 425 L +899.839 425 L +899.917 425 L +899.995 425 L +900.072 425 L +900.15 425 L +900.228 425 L +900.305 425 L +900.383 425 L +900.461 425 L +900.539 425 L +900.616 425 L +900.694 425 L +900.772 425 L +900.85 425 L +900.927 425 L +901.005 425 L +901.083 425 L +901.161 425 L +901.238 425 L +901.316 425 L +901.394 425 L +901.471 425 L +901.549 425 L +901.627 425 L +901.705 425 L +901.782 425 L +901.86 425 L +901.938 425 L +902.016 425 L +902.093 425 L +902.171 425 L +902.249 425 L +902.327 425 L +902.404 425 L +902.482 425 L +902.56 425 L +902.638 425 L +902.715 425 L +902.793 425 L +902.871 425 L +902.948 425 L +903.026 425 L +903.104 425 L +903.182 425 L +903.259 425 L +903.337 425 L +903.415 425 L +903.493 425 L +903.57 425 L +903.648 425 L +903.726 425 L +903.804 425 L +903.881 425 L +903.959 425 L +904.037 425 L +904.114 425 L +904.192 425 L +904.27 425 L +904.348 425 L +904.425 425 L +904.503 425 L +904.581 425 L +904.659 425 L +904.736 425 L +904.814 425 L +904.892 425 L +904.97 425 L +905.047 425 L +905.125 425 L +905.203 425 L +905.28 425 L +905.358 425 L +905.436 425 L +905.514 425 L +905.591 425 L +905.669 425 L +905.747 425 L +905.825 425 L +905.902 425 L +905.98 425 L +906.058 425 L +906.136 425 L +906.213 425 L +906.291 425 L +906.369 425 L +906.446 425 L +906.524 425 L +906.602 425 L +906.68 425 L +906.757 425 L +906.835 425 L +906.913 425 L +906.991 425 L +907.068 425 L +907.146 425 L +907.224 425 L +907.302 425 L +907.379 425 L +907.457 425 L +907.535 425 L +907.612 425 L +907.69 425 L +907.768 425 L +907.846 425 L +907.923 425 L +908.001 425 L +908.079 425 L +908.157 425 L +908.234 425 L +908.312 425 L +908.39 425 L +908.468 425 L +908.545 425 L +908.623 425 L +908.701 425 L +908.779 425 L +908.856 425 L +908.934 425 L +909.012 425 L +909.089 425 L +909.167 425 L +909.245 425 L +909.323 425 L +909.4 425 L +909.478 425 L +909.556 425 L +909.634 425 L +909.711 425 L +909.789 425 L +909.867 425 L +909.945 425 L +910.022 425 L +910.1 425 L +910.178 425 L +910.255 425 L +910.333 425 L +910.411 425 L +910.489 425 L +910.566 425 L +910.644 425 L +910.722 425 L +910.8 425 L +910.877 425 L +910.955 425 L +911.033 425 L +911.111 425 L +911.188 425 L +911.266 425 L +911.344 425 L +911.422 425 L +911.499 425 L +911.577 425 L +911.655 425 L +911.732 425 L +911.81 425 L +911.888 425 L +911.966 425 L +912.043 425 L +912.121 425 L +912.199 425 L +912.277 425 L +912.354 425 L +912.432 425 L +912.51 425 L +912.588 425 L +912.665 425 L +912.743 425 L +912.821 425 L +912.898 425 L +912.976 425 L +913.054 425 L +913.132 425 L +913.209 425 L +913.287 425 L +913.365 425 L +913.443 425 L +913.52 425 L +913.598 425 L +913.676 425 L +913.754 425 L +913.831 425 L +913.909 425 L +913.987 425 L +914.064 425 L +914.142 425 L +914.22 425 L +914.298 425 L +914.375 425 L +914.453 425 L +914.531 425 L +914.609 425 L +914.686 425 L +914.764 425 L +914.842 425 L +914.92 425 L +914.997 425 L +915.075 425 L +915.153 425 L +915.23 425 L +915.308 425 L +915.386 425 L +915.464 425 L +915.541 425 L +915.619 425 L +915.697 425 L +915.775 425 L +915.852 425 L +915.93 425 L +916.008 425 L +916.086 425 L +916.163 425 L +916.241 425 L +916.319 425 L +916.396 425 L +916.474 425 L +916.552 425 L +916.63 425 L +916.707 425 L +916.785 425 L +916.863 425 L +916.941 425 L +917.018 425 L +917.096 425 L +917.174 425 L +917.252 425 L +917.329 425 L +917.407 425 L +917.485 425 L +917.563 425 L +917.64 425 L +917.718 425 L +917.796 425 L +917.873 425 L +917.951 425 L +918.029 425 L +918.107 425 L +918.184 425 L +918.262 425 L +918.34 425 L +918.418 425 L +918.495 425 L +918.573 425 L +918.651 425 L +918.729 425 L +918.806 425 L +918.884 425 L +918.962 425 L +919.039 425 L +919.117 425 L +919.195 425 L +919.273 425 L +919.35 425 L +919.428 425 L +919.506 425 L +919.584 425 L +919.661 425 L +919.739 425 L +919.817 425 L +919.895 425 L +919.972 425 L +920.05 425 L +920.128 425 L +920.205 425 L +920.283 425 L +920.361 425 L +920.439 425 L +920.516 425 L +920.594 425 L +920.672 425 L +920.75 425 L +920.827 425 L +920.905 425 L +920.983 425 L +921.061 425 L +921.138 425 L +921.216 425 L +921.294 425 L +921.371 425 L +921.449 425 L +921.527 425 L +921.605 425 L +921.682 425 L +921.76 425 L +921.838 425 L +921.916 425 L +921.993 425 L +922.071 425 L +922.149 425 L +922.227 425 L +922.304 425 L +922.382 425 L +922.46 425 L +922.537 425 L +922.615 425 L +922.693 425 L +922.771 425 L +922.848 425 L +922.926 425 L +923.004 425 L +923.082 425 L +923.159 425 L +923.237 425 L +923.315 425 L +923.393 425 L +923.47 425 L +923.548 425 L +923.626 425 L +923.703 425 L +923.781 425 L +923.859 425 L +923.937 425 L +924.014 425 L +924.092 425 L +924.17 425 L +924.248 425 L +924.325 425 L +924.403 425 L +924.481 425 L +924.559 425 L +924.636 425 L +924.714 425 L +924.792 425 L +924.87 425 L +924.947 425 L +925.025 425 L +925.103 425 L +925.18 425 L +925.258 425 L +925.336 425 L +925.414 425 L +925.491 425 L +925.569 425 L +925.647 425 L +925.725 425 L +925.802 425 L +925.88 425 L +925.958 425 L +926.036 425 L +926.113 425 L +926.191 425 L +926.269 425 L +926.346 425 L +926.424 425 L +926.502 425 L +926.58 425 L +926.657 425 L +926.735 425 L +926.813 425 L +926.891 425 L +926.968 425 L +927.046 425 L +927.124 425 L +927.202 425 L +927.279 425 L +927.357 425 L +927.435 425 L +927.513 425 L +927.59 425 L +927.668 425 L +927.746 425 L +927.823 425 L +927.901 425 L +927.979 425 L +928.057 425 L +928.134 425 L +928.212 425 L +928.29 425 L +928.368 425 L +928.445 425 L +928.523 425 L +928.601 425 L +928.679 425 L +928.756 425 L +928.834 425 L +928.912 425 L +928.989 425 L +929.067 425 L +929.145 425 L +929.223 425 L +929.3 425 L +929.378 425 L +929.456 425 L +929.534 425 L +929.611 425 L +929.689 425 L +929.767 425 L +929.845 425 L +929.922 425 L +930 425 L +930.078 425 L +930.095 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.851 0.325 0.098 RC +1 LJ +2.667 LW +N +134.078 425 M +134.155 425 L +134.233 425 L +134.311 425 L +134.389 425 L +134.466 425 L +134.544 425 L +134.622 425 L +134.7 425 L +134.777 425 L +134.855 425 L +134.933 425 L +135.011 425 L +135.088 425 L +135.166 425 L +135.244 425 L +135.321 425 L +135.399 425 L +135.477 425 L +135.555 425 L +135.632 425 L +135.71 425 L +135.788 425 L +135.866 425 L +135.943 425 L +136.021 425 L +136.099 425 L +136.177 425 L +136.254 425 L +136.332 425 L +136.41 425 L +136.488 425 L +136.565 425 L +136.643 425 L +136.721 425 L +136.798 425 L +136.876 425 L +136.954 425 L +137.032 425 L +137.109 425 L +137.187 425 L +137.265 425 L +137.343 425 L +137.42 425 L +137.498 425 L +137.576 425 L +137.654 425 L +137.731 425 L +137.809 425 L +137.887 425 L +137.964 425 L +138.042 425 L +138.12 425 L +138.198 425 L +138.275 425 L +138.353 425 L +138.431 425 L +138.509 425 L +138.586 425 L +138.664 425 L +138.742 425 L +138.82 425 L +138.897 425 L +138.975 425 L +139.053 425 L +139.13 425 L +139.208 425 L +139.286 425 L +139.364 425 L +139.441 425 L +139.519 425 L +139.597 425 L +139.675 425 L +139.752 425 L +139.83 425 L +139.908 425 L +139.986 425 L +140.063 425 L +140.141 425 L +140.219 425 L +140.296 425 L +140.374 425 L +140.452 425 L +140.53 425 L +140.607 425 L +140.685 425 L +140.763 425 L +140.841 425 L +140.918 425 L +140.996 425 L +141.074 425 L +141.152 425 L +141.229 425 L +141.307 425 L +141.385 425 L +141.462 425 L +141.54 425 L +141.618 425 L +141.696 425 L +141.773 425 L +141.851 425 L +141.929 425 L +142.007 425 L +142.084 425 L +142.162 425 L +142.24 425 L +142.318 425 L +142.395 425 L +142.473 425 L +142.551 425 L +142.629 425 L +142.706 425 L +142.784 425 L +142.862 425 L +142.939 425 L +143.017 425 L +143.095 425 L +143.173 425 L +143.25 425 L +143.328 425 L +143.406 425 L +143.484 425 L +143.561 425 L +143.639 425 L +143.717 425 L +143.795 425 L +143.872 425 L +143.95 425 L +144.028 425 L +144.105 425 L +144.183 425 L +144.261 425 L +144.339 425 L +144.416 425 L +144.494 425 L +144.572 425 L +144.65 425 L +144.727 425 L +144.805 425 L +144.883 425 L +144.961 425 L +145.038 425 L +145.116 425 L +145.194 425 L +145.271 425 L +145.349 425 L +145.427 425 L +145.505 425 L +145.582 425 L +145.66 425 L +145.738 425 L +145.816 425 L +145.893 425 L +145.971 425 L +146.049 425 L +146.127 425 L +146.204 425 L +146.282 425 L +146.36 425 L +146.438 425 L +146.515 425 L +146.593 425 L +146.671 425 L +146.748 425 L +146.826 425 L +146.904 425 L +146.982 425 L +147.059 425 L +147.137 425 L +147.215 425 L +147.293 425 L +147.37 425 L +147.448 425 L +147.526 425 L +147.604 425 L +147.681 425 L +147.759 425 L +147.837 425 L +147.914 425 L +147.992 425 L +148.07 425 L +148.148 425 L +148.225 425 L +148.303 425 L +148.381 425 L +148.459 425 L +148.536 425 L +148.614 425 L +148.692 425 L +148.77 425 L +148.847 425 L +148.925 425 L +149.003 425 L +149.08 425 L +149.158 425 L +149.236 425 L +149.314 425 L +149.391 425 L +149.469 425 L +149.547 425 L +149.625 425 L +149.702 425 L +149.78 425 L +149.858 425 L +149.936 425 L +150.013 425 L +150.091 425 L +150.169 425 L +150.246 425 L +150.324 425 L +150.402 425 L +150.48 425 L +150.557 425 L +150.635 425 L +150.713 425 L +150.791 425 L +150.868 425 L +150.946 425 L +151.024 425 L +151.102 425 L +151.179 425 L +151.257 425 L +151.335 425 L +151.413 425 L +151.49 425 L +151.568 425 L +151.646 425 L +151.723 425 L +151.801 425 L +151.879 425 L +151.957 425 L +152.034 425 L +152.112 425 L +152.19 425 L +152.268 425 L +152.345 425 L +152.423 425 L +152.501 425 L +152.579 425 L +152.656 425 L +152.734 425 L +152.812 425 L +152.889 425 L +152.967 425 L +153.045 425 L +153.123 425 L +153.2 425 L +153.278 425 L +153.356 425 L +153.434 425 L +153.511 425 L +153.589 425 L +153.667 425 L +153.745 425 L +153.822 425 L +153.9 425 L +153.978 425 L +154.055 425 L +154.133 425 L +154.211 425 L +154.289 425 L +154.366 425 L +154.444 425 L +154.522 425 L +154.6 425 L +154.677 425 L +154.755 425 L +154.833 425 L +154.911 425 L +154.988 425 L +155.066 425 L +155.144 425 L +155.221 425 L +155.299 425 L +155.377 425 L +155.455 425 L +155.532 425 L +155.61 425 L +155.688 425 L +155.766 425 L +155.843 425 L +155.921 425 L +155.999 425 L +156.077 425 L +156.154 425 L +156.232 425 L +156.31 425 L +156.387 425 L +156.465 425 L +156.543 425 L +156.621 425 L +156.698 425 L +156.776 425 L +156.854 425 L +156.932 425 L +157.009 425 L +157.087 425 L +157.165 425 L +157.243 425 L +157.32 425 L +157.398 425 L +157.476 425 L +157.554 425 L +157.631 425 L +157.709 425 L +157.787 425 L +157.864 425 L +157.942 425 L +158.02 425 L +158.098 425 L +158.175 425 L +158.253 425 L +158.331 425 L +158.409 425 L +158.486 425 L +158.564 425 L +158.642 425 L +158.72 425 L +158.797 425 L +158.875 425 L +158.953 425 L +159.03 425 L +159.108 425 L +159.186 425 L +159.264 425 L +159.341 425 L +159.419 425 L +159.497 425 L +159.575 425 L +159.652 425 L +159.73 425 L +159.808 425 L +159.886 425 L +159.963 425 L +160.041 425 L +160.119 425 L +160.196 425 L +160.274 425 L +160.352 425 L +160.43 425 L +160.507 425 L +160.585 425 L +160.663 425 L +160.741 425 L +160.818 425 L +160.896 425 L +160.974 425 L +161.052 425 L +161.129 425 L +161.207 425 L +161.285 425 L +161.363 425 L +161.44 425 L +161.518 425 L +161.596 425 L +161.673 425 L +161.751 425 L +161.829 425 L +161.907 425 L +161.984 425 L +162.062 425 L +162.14 425 L +162.218 425 L +162.295 425 L +162.373 425 L +162.451 425 L +162.529 425 L +162.606 425 L +162.684 425 L +162.762 425 L +162.839 425 L +162.917 425 L +162.995 425 L +163.073 425 L +163.15 425 L +163.228 425 L +163.306 425 L +163.384 425 L +163.461 425 L +163.539 425 L +163.617 425 L +163.695 425 L +163.772 425 L +163.85 425 L +163.928 425 L +164.005 425 L +164.083 425 L +164.161 425 L +164.239 425 L +164.316 425 L +164.394 425 L +164.472 425 L +164.55 425 L +164.627 425 L +164.705 425 L +164.783 425 L +164.861 425 L +164.938 425 L +165.016 425 L +165.094 425 L +165.171 425 L +165.249 425 L +165.327 425 L +165.405 425 L +165.482 425 L +165.56 425 L +165.638 425 L +165.716 425 L +165.793 425 L +165.871 425 L +165.949 425 L +166.027 425 L +166.104 425 L +166.182 425 L +166.26 425 L +166.337 425 L +166.415 425 L +166.493 425 L +166.571 425 L +166.648 425 L +166.726 425 L +166.804 425 L +166.882 425 L +166.959 425 L +167.037 425 L +167.115 425 L +167.193 425 L +167.27 425 L +167.348 425 L +167.426 425 L +167.504 425 L +167.581 425 L +167.659 425 L +167.737 425 L +167.814 425 L +167.892 425 L +167.97 425 L +168.048 425 L +168.125 425 L +168.203 425 L +168.281 425 L +168.359 425 L +168.436 425 L +168.514 425 L +168.592 425 L +168.67 425 L +168.747 425 L +168.825 425 L +168.903 425 L +168.98 425 L +169.058 425 L +169.136 425 L +169.214 425 L +169.291 425 L +169.369 425 L +169.447 425 L +169.525 425 L +169.602 425 L +169.68 425 L +169.758 425 L +169.836 425 L +169.913 425 L +169.991 425 L +170.069 425 L +170.146 425 L +170.224 425 L +170.302 425 L +170.38 425 L +170.457 425 L +170.535 425 L +170.613 425 L +170.691 425 L +170.768 425 L +170.846 425 L +170.924 425 L +171.002 425 L +171.079 425 L +171.157 425 L +171.235 425 L +171.313 425 L +171.39 425 L +171.468 425 L +171.546 425 L +171.623 425 L +171.701 425 L +171.779 425 L +171.857 425 L +171.934 425 L +172.012 425 L +172.09 425 L +172.168 425 L +172.245 425 L +172.323 425 L +172.401 425 L +172.479 425 L +172.556 425 L +172.634 425 L +172.712 425 L +172.789 425 L +172.867 425 L +172.945 425 L +173.023 425 L +173.1 425 L +173.178 425 L +173.256 425 L +173.334 425 L +173.411 425 L +173.489 425 L +173.567 425 L +173.645 425 L +173.722 425 L +173.8 425 L +173.878 425 L +173.955 425 L +174.033 425 L +174.111 425 L +174.189 425 L +174.266 425 L +174.344 425 L +174.422 425 L +174.5 425 L +174.577 425 L +174.655 425 L +174.733 425 L +174.811 425 L +174.888 425 L +174.966 425 L +175.044 425 L +175.121 425 L +175.199 425 L +175.277 425 L +175.355 425 L +175.432 425 L +175.51 425 L +175.588 425 L +175.666 425 L +175.743 425 L +175.821 425 L +175.899 425 L +175.977 425 L +176.054 425 L +176.132 425 L +176.21 425 L +176.288 425 L +176.365 425 L +176.443 425 L +176.521 425 L +176.598 425 L +176.676 425 L +176.754 425 L +176.832 425 L +176.909 425 L +176.987 425 L +177.065 425 L +177.143 425 L +177.22 425 L +177.298 425 L +177.376 425 L +177.454 425 L +177.531 425 L +177.609 425 L +177.687 425 L +177.764 425 L +177.842 425 L +177.92 425 L +177.998 425 L +178.075 425 L +178.153 425 L +178.231 425 L +178.309 425 L +178.386 425 L +178.464 425 L +178.542 425 L +178.62 425 L +178.697 425 L +178.775 425 L +178.853 425 L +178.93 425 L +179.008 425 L +179.086 425 L +179.164 425 L +179.241 425 L +179.319 425 L +179.397 425 L +179.475 425 L +179.552 425 L +179.63 425 L +179.708 425 L +179.786 425 L +179.863 425 L +179.941 425 L +180.019 425 L +180.096 425 L +180.174 425 L +180.252 425 L +180.33 425 L +180.407 425 L +180.485 425 L +180.563 425 L +180.641 425 L +180.718 425 L +180.796 425 L +180.874 425 L +180.952 425 L +181.029 425 L +181.107 425 L +181.185 425 L +181.262 425 L +181.34 425 L +181.418 425 L +181.496 425 L +181.573 425 L +181.651 425 L +181.729 425 L +181.807 425 L +181.884 425 L +181.962 425 L +182.04 425 L +182.118 425 L +182.195 425 L +182.273 425 L +182.351 425 L +182.429 425 L +182.506 425 L +182.584 425 L +182.662 425 L +182.739 425 L +182.817 425 L +182.895 425 L +182.973 425 L +183.05 425 L +183.128 425 L +183.206 425 L +183.284 425 L +183.361 425 L +183.439 425 L +183.517 425 L +183.595 425 L +183.672 425 L +183.75 425 L +183.828 425 L +183.905 425 L +183.983 425 L +184.061 425 L +184.139 425 L +184.216 425 L +184.294 425 L +184.372 425 L +184.45 425 L +184.527 425 L +184.605 425 L +184.683 425 L +184.761 425 L +184.838 425 L +184.916 425 L +184.994 425 L +185.071 425 L +185.149 425 L +185.227 425 L +185.305 425 L +185.382 425 L +185.46 425 L +185.538 425 L +185.616 425 L +185.693 425 L +185.771 425 L +185.849 425 L +185.927 425 L +186.004 425 L +186.082 425 L +186.16 425 L +186.238 425 L +186.315 425 L +186.393 425 L +186.471 425 L +186.548 425 L +186.626 425 L +186.704 425 L +186.782 425 L +186.859 425 L +186.937 425 L +187.015 425 L +187.093 425 L +187.17 425 L +187.248 425 L +187.326 425 L +187.404 425 L +187.481 425 L +187.559 425 L +187.637 425 L +187.714 425 L +187.792 425 L +187.87 425 L +187.948 425 L +188.025 425 L +188.103 425 L +188.181 425 L +188.259 425 L +188.336 425 L +188.414 425 L +188.492 425 L +188.57 425 L +188.647 425 L +188.725 425 L +188.803 425 L +188.88 425 L +188.958 425 L +189.036 425 L +189.114 425 L +189.191 425 L +189.269 425 L +189.347 425 L +189.425 425 L +189.502 425 L +189.58 425 L +189.658 425 L +189.736 425 L +189.813 425 L +189.891 425 L +189.969 425 L +190.046 425 L +190.124 425 L +190.202 425 L +190.28 425 L +190.357 425 L +190.435 425 L +190.513 425 L +190.591 425 L +190.668 425 L +190.746 425 L +190.824 425 L +190.902 425 L +190.979 425 L +191.057 425 L +191.135 425 L +191.212 425 L +191.29 425 L +191.368 425 L +191.446 425 L +191.523 425 L +191.601 425 L +191.679 425 L +191.757 425 L +191.834 425 L +191.912 425 L +191.99 425 L +192.068 425 L +192.145 425 L +192.223 425 L +192.301 425 L +192.379 425 L +192.456 425 L +192.534 425 L +192.612 425 L +192.689 425 L +192.767 425 L +192.845 425 L +192.923 425 L +193 425 L +193.078 425 L +193.156 425 L +193.234 425 L +193.311 425 L +193.389 425 L +193.467 425 L +193.545 425 L +193.622 425 L +193.7 425 L +193.778 425 L +193.855 425 L +193.933 425 L +194.011 425 L +194.089 425 L +194.166 425 L +194.244 425 L +194.322 425 L +194.4 425 L +194.477 425 L +194.555 425 L +194.633 425 L +194.711 425 L +194.788 425 L +194.866 425 L +194.944 425 L +195.021 425 L +195.099 425 L +195.177 425 L +195.255 425 L +195.332 425 L +195.41 425 L +195.488 425 L +195.566 425 L +195.643 425 L +195.721 425 L +195.799 425 L +195.877 425 L +195.954 425 L +196.032 425 L +196.11 425 L +196.188 425 L +196.265 425 L +196.343 425 L +196.421 425 L +196.498 425 L +196.576 425 L +196.654 425 L +196.732 425 L +196.809 425 L +196.887 425 L +196.965 425 L +197.043 425 L +197.12 425 L +197.198 425 L +197.276 425 L +197.354 425 L +197.431 425 L +197.509 425 L +197.587 425 L +197.664 425 L +197.742 425 L +197.82 425 L +197.898 425 L +197.975 425 L +198.053 425 L +198.131 425 L +198.209 425 L +198.286 425 L +198.364 425 L +198.442 425 L +198.52 425 L +198.597 425 L +198.675 425 L +198.753 425 L +198.83 425 L +198.908 425 L +198.986 425 L +199.064 425 L +199.141 425 L +199.219 425 L +199.297 425 L +199.375 425 L +199.452 425 L +199.53 425 L +199.608 425 L +199.686 425 L +199.763 425 L +199.841 425 L +199.919 425 L +199.996 425 L +200.074 425 L +200.152 425 L +200.23 425 L +200.307 425 L +200.385 425 L +200.463 425 L +200.541 425 L +200.618 425 L +200.696 425 L +200.774 425 L +200.852 425 L +200.929 425 L +201.007 425 L +201.085 425 L +201.163 425 L +201.24 425 L +201.318 425 L +201.396 425 L +201.473 425 L +201.551 425 L +201.629 425 L +201.707 425 L +201.784 425 L +201.862 425 L +201.94 425 L +202.018 425 L +202.095 425 L +202.173 425 L +202.251 425 L +202.329 425 L +202.406 425 L +202.484 425 L +202.562 425 L +202.639 425 L +202.717 425 L +202.795 425 L +202.873 425 L +202.95 425 L +203.028 425 L +203.106 425 L +203.184 425 L +203.261 425 L +203.339 425 L +203.417 425 L +203.495 425 L +203.572 425 L +203.65 425 L +203.728 425 L +203.805 425 L +203.883 425 L +203.961 425 L +204.039 425 L +204.116 425 L +204.194 425 L +204.272 425 L +204.35 425 L +204.427 425 L +204.505 425 L +204.583 425 L +204.661 425 L +204.738 425 L +204.816 425 L +204.894 425 L +204.971 425 L +205.049 425 L +205.127 425 L +205.205 425 L +205.282 425 L +205.36 425 L +205.438 425 L +205.516 425 L +205.593 425 L +205.671 425 L +205.749 425 L +205.827 425 L +205.904 425 L +205.982 425 L +206.06 425 L +206.137 425 L +206.215 425 L +206.293 425 L +206.371 425 L +206.448 425 L +206.526 425 L +206.604 425 L +206.682 425 L +206.759 425 L +206.837 425 L +206.915 425 L +206.993 425 L +207.07 425 L +207.148 425 L +207.226 425 L +207.304 425 L +207.381 425 L +207.459 425 L +207.537 425 L +207.614 425 L +207.692 425 L +207.77 425 L +207.848 425 L +207.925 425 L +208.003 425 L +208.081 425 L +208.159 425 L +208.236 425 L +208.314 425 L +208.392 425 L +208.47 425 L +208.547 425 L +208.625 425 L +208.703 425 L +208.78 425 L +208.858 425 L +208.936 425 L +209.014 425 L +209.091 425 L +209.169 425 L +209.247 425 L +209.325 425 L +209.402 425 L +209.48 425 L +209.558 425 L +209.636 425 L +209.713 425 L +209.791 425 L +209.869 425 L +209.946 425 L +210.024 425 L +210.102 425 L +210.18 425 L +210.257 425 L +210.335 425 L +210.413 425 L +210.491 425 L +210.568 425 L +210.646 425 L +210.724 425 L +210.802 425 L +210.879 425 L +210.957 425 L +211.035 425 L +211.113 425 L +211.19 425 L +211.268 425 L +211.346 425 L +211.423 425 L +211.501 425 L +211.579 425 L +211.657 425 L +211.734 425 L +211.812 425 L +211.89 425 L +211.968 425 L +212.045 425 L +212.123 425 L +212.201 425 L +212.279 425 L +212.356 425 L +212.434 425 L +212.512 425 L +212.589 425 L +212.667 425 L +212.745 425 L +212.823 425 L +212.9 425 L +212.978 425 L +213.056 425 L +213.134 425 L +213.211 425 L +213.289 425 L +213.367 425 L +213.445 425 L +213.522 425 L +213.6 425 L +213.678 425 L +213.755 425 L +213.833 425 L +213.911 425 L +213.989 425 L +214.066 425 L +214.144 425 L +214.222 425 L +214.3 425 L +214.377 425 L +214.455 425 L +214.533 425 L +214.611 425 L +214.688 425 L +214.766 425 L +214.844 425 L +214.921 425 L +214.999 425 L +215.077 425 L +215.155 425 L +215.232 425 L +215.31 425 L +215.388 425 L +215.466 425 L +215.543 425 L +215.621 425 L +215.699 425 L +215.777 425 L +215.854 425 L +215.932 425 L +216.01 425 L +216.087 425 L +216.165 425 L +216.243 425 L +216.321 425 L +216.398 425 L +216.476 425 L +216.554 425 L +216.632 425 L +216.709 425 L +216.787 425 L +216.865 425 L +216.943 425 L +217.02 425 L +217.098 425 L +217.176 425 L +217.254 425 L +217.331 425 L +217.409 425 L +217.487 425 L +217.564 425 L +217.642 425 L +217.72 425 L +217.798 425 L +217.875 425 L +217.953 425 L +218.031 425 L +218.109 425 L +218.186 425 L +218.264 425 L +218.342 425 L +218.42 425 L +218.497 425 L +218.575 425 L +218.653 425 L +218.73 425 L +218.808 425 L +218.886 425 L +218.964 425 L +219.041 425 L +219.119 425 L +219.197 425 L +219.275 425 L +219.352 425 L +219.43 425 L +219.508 425 L +219.586 425 L +219.663 425 L +219.741 425 L +219.819 425 L +219.896 425 L +219.974 425 L +220.052 425 L +220.13 425 L +220.207 425 L +220.285 425 L +220.363 425 L +220.441 425 L +220.518 425 L +220.596 425 L +220.674 425 L +220.752 425 L +220.829 425 L +220.907 425 L +220.985 425 L +221.063 425 L +221.14 425 L +221.218 425 L +221.296 425 L +221.373 425 L +221.451 425 L +221.529 425 L +221.607 425 L +221.684 425 L +221.762 425 L +221.84 425 L +221.918 425 L +221.995 425 L +222.073 425 L +222.151 425 L +222.229 425 L +222.306 425 L +222.384 425 L +222.462 425 L +222.539 425 L +222.617 425 L +222.695 425 L +222.773 425 L +222.85 425 L +222.928 425 L +223.006 425 L +223.084 425 L +223.161 425 L +223.239 425 L +223.317 425 L +223.395 425 L +223.472 425 L +223.55 425 L +223.628 425 L +223.705 425 L +223.783 425 L +223.861 425 L +223.939 425 L +224.016 425 L +224.094 425 L +224.172 425 L +224.25 425 L +224.327 425 L +224.405 425 L +224.483 425 L +224.561 425 L +224.638 425 L +224.716 425 L +224.794 425 L +224.871 425 L +224.949 425 L +225.027 425 L +225.105 425 L +225.182 425 L +225.26 425 L +225.338 425 L +225.416 425 L +225.493 425 L +225.571 425 L +225.649 425 L +225.727 425 L +225.804 425 L +225.882 425 L +225.96 425 L +226.038 425 L +226.115 425 L +226.193 425 L +226.271 425 L +226.348 425 L +226.426 425 L +226.504 425 L +226.582 425 L +226.659 425 L +226.737 425 L +226.815 425 L +226.893 425 L +226.97 425 L +227.048 425 L +227.126 425 L +227.204 425 L +227.281 425 L +227.359 425 L +227.437 425 L +227.514 425 L +227.592 425 L +227.67 425 L +227.748 425 L +227.825 425 L +227.903 425 L +227.981 425 L +228.059 425 L +228.136 425 L +228.214 425 L +228.292 425 L +228.37 425 L +228.447 425 L +228.525 425 L +228.603 425 L +228.68 425 L +228.758 425 L +228.836 425 L +228.914 425 L +228.991 425 L +229.069 425 L +229.147 425 L +229.225 425 L +229.302 425 L +229.38 425 L +229.458 425 L +229.536 425 L +229.613 425 L +229.691 425 L +229.769 425 L +229.846 425 L +229.924 425 L +230.002 425 L +230.08 425 L +230.157 425 L +230.235 425 L +230.313 425 L +230.391 425 L +230.468 425 L +230.546 425 L +230.624 425 L +230.702 425 L +230.779 425 L +230.857 425 L +230.935 425 L +231.012 425 L +231.09 425 L +231.168 425 L +231.246 425 L +231.323 425 L +231.401 425 L +231.479 425 L +231.557 425 L +231.634 425 L +231.712 425 L +231.79 425 L +231.868 425 L +231.945 425 L +232.023 425 L +232.101 425 L +232.179 425 L +232.256 425 L +232.334 425 L +232.412 425 L +232.489 425 L +232.567 425 L +232.645 425 L +232.723 425 L +232.8 425 L +232.878 425 L +232.956 425 L +233.034 425 L +233.111 425 L +233.189 425 L +233.267 425 L +233.345 425 L +233.422 425 L +233.5 425 L +233.578 425 L +233.655 425 L +233.733 425 L +233.811 425 L +233.889 425 L +233.966 425 L +234.044 425 L +234.122 425 L +234.2 425 L +234.277 425 L +234.355 425 L +234.433 425 L +234.511 425 L +234.588 425 L +234.666 425 L +234.744 425 L +234.821 425 L +234.899 425 L +234.977 425 L +235.055 425 L +235.132 425 L +235.21 425 L +235.288 425 L +235.366 425 L +235.443 425 L +235.521 425 L +235.599 425 L +235.677 425 L +235.754 425 L +235.832 425 L +235.91 425 L +235.988 425 L +236.065 425 L +236.143 425 L +236.221 425 L +236.298 425 L +236.376 425 L +236.454 425 L +236.532 425 L +236.609 425 L +236.687 425 L +236.765 425 L +236.843 425 L +236.92 425 L +236.998 425 L +237.076 425 L +237.154 425 L +237.231 425 L +237.309 425 L +237.387 425 L +237.464 425 L +237.542 425 L +237.62 425 L +237.698 425 L +237.775 425 L +237.853 425 L +237.931 425 L +238.009 425 L +238.086 425 L +238.164 425 L +238.242 425 L +238.32 425 L +238.397 425 L +238.475 425 L +238.553 425 L +238.63 425 L +238.708 425 L +238.786 425 L +238.864 425 L +238.941 425 L +239.019 425 L +239.097 425 L +239.175 425 L +239.252 425 L +239.33 425 L +239.408 425 L +239.486 425 L +239.563 425 L +239.641 425 L +239.719 425 L +239.796 425 L +239.874 425 L +239.952 425 L +240.03 425 L +240.107 425 L +240.185 425 L +240.263 425 L +240.341 425 L +240.418 425 L +240.496 425 L +240.574 425 L +240.652 425 L +240.729 425 L +240.807 425 L +240.885 425 L +240.962 425 L +241.04 425 L +241.118 425 L +241.196 425 L +241.273 425 L +241.351 425 L +241.429 425 L +241.507 425 L +241.584 425 L +241.662 425 L +241.74 425 L +241.818 425 L +241.895 425 L +241.973 425 L +242.051 425 L +242.129 425 L +242.206 425 L +242.284 425 L +242.362 425 L +242.439 425 L +242.517 425 L +242.595 425 L +242.673 425 L +242.75 425 L +242.828 425 L +242.906 425 L +242.984 425 L +243.061 425 L +243.139 425 L +243.217 425 L +243.295 425 L +243.372 425 L +243.45 425 L +243.528 425 L +243.605 425 L +243.683 425 L +243.761 425 L +243.839 425 L +243.916 425 L +243.994 425 L +244.072 425 L +244.15 425 L +244.227 425 L +244.305 425 L +244.383 425 L +244.461 425 L +244.538 425 L +244.616 425 L +244.694 425 L +244.771 425 L +244.849 425 L +244.927 425 L +245.005 425 L +245.082 425 L +245.16 425 L +245.238 425 L +245.316 425 L +245.393 425 L +245.471 425 L +245.549 425 L +245.627 425 L +245.704 425 L +245.782 425 L +245.86 425 L +245.938 425 L +246.015 425 L +246.093 425 L +246.171 425 L +246.248 425 L +246.326 425 L +246.404 425 L +246.482 425 L +246.559 425 L +246.637 425 L +246.715 425 L +246.793 425 L +246.87 425 L +246.948 425 L +247.026 425 L +247.104 425 L +247.181 425 L +247.259 425 L +247.337 425 L +247.414 425 L +247.492 425 L +247.57 425 L +247.648 425 L +247.725 425 L +247.803 425 L +247.881 425 L +247.959 425 L +248.036 425 L +248.114 425 L +248.192 425 L +248.27 425 L +248.347 425 L +248.425 425 L +248.503 425 L +248.58 425 L +248.658 425 L +248.736 425 L +248.814 425 L +248.891 425 L +248.969 425 L +249.047 425 L +249.125 425 L +249.202 425 L +249.28 425 L +249.358 425 L +249.436 425 L +249.513 425 L +249.591 425 L +249.669 425 L +249.746 425 L +249.824 425 L +249.902 425 L +249.98 425 L +250.057 425 L +250.135 425 L +250.213 425 L +250.291 425 L +250.368 425 L +250.446 425 L +250.524 425 L +250.602 425 L +250.679 425 L +250.757 425 L +250.835 425 L +250.913 425 L +250.99 425 L +251.068 425 L +251.146 425 L +251.223 425 L +251.301 425 L +251.379 425 L +251.457 425 L +251.534 425 L +251.612 425 L +251.69 425 L +251.768 425 L +251.845 425 L +251.923 425 L +252.001 425 L +252.079 425 L +252.156 425 L +252.234 425 L +252.312 425 L +252.389 425 L +252.467 425 L +252.545 425 L +252.623 425 L +252.7 425 L +252.778 425 L +252.856 425 L +252.934 425 L +253.011 425 L +253.089 425 L +253.167 425 L +253.245 425 L +253.322 425 L +253.4 425 L +253.478 425 L +253.555 425 L +253.633 425 L +253.711 425 L +253.789 425 L +253.866 425 L +253.944 425 L +254.022 425 L +254.1 425 L +254.177 425 L +254.255 425 L +254.333 425 L +254.411 425 L +254.488 425 L +254.566 425 L +254.644 425 L +254.721 425 L +254.799 425 L +254.877 425 L +254.955 425 L +255.032 425 L +255.11 425 L +255.188 425 L +255.266 425 L +255.343 425 L +255.421 425 L +255.499 425 L +255.577 425 L +255.654 425 L +255.732 425 L +255.81 425 L +255.887 425 L +255.965 425 L +256.043 425 L +256.121 425 L +256.198 425 L +256.276 425 L +256.354 425 L +256.432 425 L +256.509 425 L +256.587 425 L +256.665 425 L +256.743 425 L +256.82 425 L +256.898 425 L +256.976 425 L +257.054 425 L +257.131 425 L +257.209 425 L +257.287 425 L +257.364 425 L +257.442 425 L +257.52 425 L +257.598 425 L +257.675 425 L +257.753 425 L +257.831 425 L +257.909 425 L +257.986 425 L +258.064 425 L +258.142 425 L +258.22 425 L +258.297 425 L +258.375 425 L +258.453 425 L +258.53 425 L +258.608 425 L +258.686 425 L +258.764 425 L +258.841 425 L +258.919 425 L +258.997 425 L +259.075 425 L +259.152 425 L +259.23 425 L +259.308 425 L +259.386 425 L +259.463 425 L +259.541 425 L +259.619 425 L +259.696 425 L +259.774 425 L +259.852 425 L +259.93 425 L +260.007 425 L +260.085 425 L +260.163 425 L +260.241 425 L +260.318 425 L +260.396 425 L +260.474 425 L +260.552 425 L +260.629 425 L +260.707 425 L +260.785 425 L +260.862 425 L +260.94 425 L +261.018 425 L +261.096 425 L +261.173 425 L +261.251 425 L +261.329 425 L +261.407 425 L +261.484 425 L +261.562 425 L +261.64 425 L +261.718 425 L +261.795 425 L +261.873 425 L +261.951 425 L +262.029 425 L +262.106 425 L +262.184 425 L +262.262 425 L +262.339 425 L +262.417 425 L +262.495 425 L +262.573 425 L +262.65 425 L +262.728 425 L +262.806 425 L +262.884 425 L +262.961 425 L +263.039 425 L +263.117 425 L +263.195 425 L +263.272 425 L +263.35 425 L +263.428 425 L +263.505 425 L +263.583 425 L +263.661 425 L +263.739 425 L +263.816 425 L +263.894 425 L +263.972 425 L +264.05 425 L +264.127 425 L +264.205 425 L +264.283 425 L +264.361 425 L +264.438 425 L +264.516 425 L +264.594 425 L +264.671 425 L +264.749 425 L +264.827 425 L +264.905 425 L +264.982 425 L +265.06 425 L +265.138 425 L +265.216 425 L +265.293 425 L +265.371 425 L +265.449 425 L +265.527 425 L +265.604 425 L +265.682 425 L +265.76 425 L +265.837 425 L +265.915 425 L +265.993 425 L +266.071 425 L +266.148 425 L +266.226 425 L +266.304 425 L +266.382 425 L +266.459 425 L +266.537 425 L +266.615 425 L +266.693 425 L +266.77 425 L +266.848 425 L +266.926 425 L +267.004 425 L +267.081 425 L +267.159 425 L +267.237 425 L +267.314 425 L +267.392 425 L +267.47 425 L +267.548 425 L +267.625 425 L +267.703 425 L +267.781 425 L +267.859 425 L +267.936 425 L +268.014 425 L +268.092 425 L +268.17 425 L +268.247 425 L +268.325 425 L +268.403 425 L +268.48 425 L +268.558 425 L +268.636 425 L +268.714 425 L +268.791 425 L +268.869 425 L +268.947 425 L +269.025 425 L +269.102 425 L +269.18 425 L +269.258 425 L +269.336 425 L +269.413 425 L +269.491 425 L +269.569 425 L +269.646 425 L +269.724 425 L +269.802 425 L +269.88 425 L +269.957 425 L +270.035 425 L +270.113 425 L +270.191 425 L +270.268 425 L +270.346 425 L +270.424 425 L +270.502 425 L +270.579 425 L +270.657 425 L +270.735 425 L +270.813 425 L +270.89 425 L +270.968 425 L +271.046 425 L +271.123 425 L +271.201 425 L +271.279 425 L +271.357 425 L +271.434 425 L +271.512 425 L +271.59 425 L +271.668 425 L +271.745 425 L +271.823 425 L +271.901 425 L +271.979 425 L +272.056 425 L +272.134 425 L +272.212 425 L +272.289 425 L +272.367 425 L +272.445 425 L +272.523 425 L +272.6 425 L +272.678 425 L +272.756 425 L +272.834 425 L +272.911 425 L +272.989 425 L +273.067 425 L +273.145 425 L +273.222 425 L +273.3 425 L +273.378 425 L +273.455 425 L +273.533 425 L +273.611 425 L +273.689 425 L +273.766 425 L +273.844 425 L +273.922 425 L +274 425 L +274.077 425 L +274.155 425 L +274.233 425 L +274.311 425 L +274.388 425 L +274.466 425 L +274.544 425 L +274.621 425 L +274.699 425 L +274.777 425 L +274.855 425 L +274.932 425 L +275.01 425 L +275.088 425 L +275.166 425 L +275.243 425 L +275.321 425 L +275.399 425 L +275.477 425 L +275.554 425 L +275.632 425 L +275.71 425 L +275.788 425 L +275.865 425 L +275.943 425 L +276.021 425 L +276.098 425 L +276.176 425 L +276.254 425 L +276.332 425 L +276.409 425 L +276.487 425 L +276.565 425 L +276.643 425 L +276.72 425 L +276.798 425 L +276.876 425 L +276.954 425 L +277.031 425 L +277.109 425 L +277.187 425 L +277.264 425 L +277.342 425 L +277.42 425 L +277.498 425 L +277.575 425 L +277.653 425 L +277.731 425 L +277.809 425 L +277.886 425 L +277.964 425 L +278.042 425 L +278.12 425 L +278.197 425 L +278.275 425 L +278.353 425 L +278.43 425 L +278.508 425 L +278.586 425 L +278.664 425 L +278.741 425 L +278.819 425 L +278.897 425 L +278.975 425 L +279.052 425 L +279.13 425 L +279.208 425 L +279.286 425 L +279.363 425 L +279.441 425 L +279.519 425 L +279.596 425 L +279.674 425 L +279.752 425 L +279.83 425 L +279.907 425 L +279.985 425 L +280.063 425 L +280.141 425 L +280.218 425 L +280.296 425 L +280.374 425 L +280.452 425 L +280.529 425 L +280.607 425 L +280.685 425 L +280.763 425 L +280.84 425 L +280.918 425 L +280.996 425 L +281.073 425 L +281.151 425 L +281.229 425 L +281.307 425 L +281.384 425 L +281.462 425 L +281.54 425 L +281.618 425 L +281.695 425 L +281.773 425 L +281.851 425 L +281.929 425 L +282.006 425 L +282.084 425 L +282.162 425 L +282.239 425 L +282.317 425 L +282.395 425 L +282.473 425 L +282.55 425 L +282.628 425 L +282.706 425 L +282.784 425 L +282.861 425 L +282.939 425 L +283.017 425 L +283.095 425 L +283.172 425 L +283.25 425 L +283.328 425 L +283.405 425 L +283.483 425 L +283.561 425 L +283.639 425 L +283.716 425 L +283.794 425 L +283.872 425 L +283.95 425 L +284.027 425 L +284.105 425 L +284.183 425 L +284.261 425 L +284.338 425 L +284.416 425 L +284.494 425 L +284.571 425 L +284.649 425 L +284.727 425 L +284.805 425 L +284.882 425 L +284.96 425 L +285.038 425 L +285.116 425 L +285.193 425 L +285.271 425 L +285.349 425 L +285.427 425 L +285.504 425 L +285.582 425 L +285.66 425 L +285.737 425 L +285.815 425 L +285.893 425 L +285.971 425 L +286.048 425 L +286.126 425 L +286.204 425 L +286.282 425 L +286.359 425 L +286.437 425 L +286.515 425 L +286.593 425 L +286.67 425 L +286.748 425 L +286.826 425 L +286.904 425 L +286.981 425 L +287.059 425 L +287.137 425 L +287.214 425 L +287.292 425 L +287.37 425 L +287.448 425 L +287.525 425 L +287.603 425 L +287.681 425 L +287.759 425 L +287.836 425 L +287.914 425 L +287.992 425 L +288.07 425 L +288.147 425 L +288.225 425 L +288.303 425 L +288.38 425 L +288.458 425 L +288.536 425 L +288.614 425 L +288.691 425 L +288.769 425 L +288.847 425 L +288.925 425 L +289.002 425 L +289.08 425 L +289.158 425 L +289.236 425 L +289.313 425 L +289.391 425 L +289.469 425 L +289.546 425 L +289.624 425 L +289.702 425 L +289.78 425 L +289.857 425 L +289.935 425 L +290.013 425 L +290.091 425 L +290.168 425 L +290.246 425 L +290.324 425 L +290.402 425 L +290.479 425 L +290.557 425 L +290.635 425 L +290.712 425 L +290.79 425 L +290.868 425 L +290.946 425 L +291.023 425 L +291.101 425 L +291.179 425 L +291.257 425 L +291.334 425 L +291.412 425 L +291.49 425 L +291.568 425 L +291.645 425 L +291.723 425 L +291.801 425 L +291.879 425 L +291.956 425 L +292.034 425 L +292.112 425 L +292.189 425 L +292.267 425 L +292.345 425 L +292.423 425 L +292.5 425 L +292.578 425 L +292.656 425 L +292.734 425 L +292.811 425 L +292.889 425 L +292.967 425 L +293.045 425 L +293.122 425 L +293.2 36 L +293.278 36 L +293.355 36 L +293.433 36 L +293.511 36 L +293.589 36 L +293.666 36 L +293.744 36 L +293.822 36 L +293.9 36 L +293.977 36 L +294.055 36 L +294.133 36 L +294.211 36 L +294.288 36 L +294.366 36 L +294.444 36 L +294.521 36 L +294.599 36 L +294.677 36 L +294.755 36 L +294.832 36 L +294.91 36 L +294.988 36 L +295.066 36 L +295.143 36 L +295.221 36 L +295.299 36 L +295.377 36 L +295.454 36 L +295.532 36 L +295.61 36 L +295.688 36 L +295.765 36 L +295.843 36 L +295.921 36 L +295.998 36 L +296.076 36 L +296.154 36 L +296.232 36 L +296.309 36 L +296.387 36 L +296.465 36 L +296.543 36 L +296.62 36 L +296.698 36 L +296.776 36 L +296.854 36 L +296.931 36 L +297.009 36 L +297.087 36 L +297.164 36 L +297.242 36 L +297.32 36 L +297.398 36 L +297.475 36 L +297.553 36 L +297.631 36 L +297.709 36 L +297.786 36 L +297.864 36 L +297.942 36 L +298.02 36 L +298.097 36 L +298.175 36 L +298.253 36 L +298.33 36 L +298.408 36 L +298.486 36 L +298.564 36 L +298.641 36 L +298.719 36 L +298.797 36 L +298.875 36 L +298.952 36 L +299.03 36 L +299.108 36 L +299.186 36 L +299.263 36 L +299.341 36 L +299.419 36 L +299.496 36 L +299.574 36 L +299.652 36 L +299.73 36 L +299.807 36 L +299.885 36 L +299.963 36 L +300.041 36 L +300.118 36 L +300.196 36 L +300.274 36 L +300.352 36 L +300.429 36 L +300.507 36 L +300.585 36 L +300.663 36 L +300.74 36 L +300.818 36 L +300.896 36 L +300.973 36 L +301.051 36 L +301.129 36 L +301.207 36 L +301.284 36 L +301.362 36 L +301.44 36 L +301.518 36 L +301.595 36 L +301.673 36 L +301.751 36 L +301.829 36 L +301.906 36 L +301.984 36 L +302.062 36 L +302.139 36 L +302.217 36 L +302.295 36 L +302.373 36 L +302.45 36 L +302.528 36 L +302.606 36 L +302.684 36 L +302.761 36 L +302.839 36 L +302.917 36 L +302.995 36 L +303.072 36 L +303.15 36 L +303.228 36 L +303.305 36 L +303.383 36 L +303.461 36 L +303.539 36 L +303.616 36 L +303.694 36 L +303.772 36 L +303.85 36 L +303.927 36 L +304.005 36 L +304.083 36 L +304.161 36 L +304.238 36 L +304.316 36 L +304.394 36 L +304.471 36 L +304.549 36 L +304.627 36 L +304.705 36 L +304.782 36 L +304.86 36 L +304.938 36 L +305.016 36 L +305.093 36 L +305.171 36 L +305.249 36 L +305.327 36 L +305.404 36 L +305.482 36 L +305.56 36 L +305.638 36 L +305.715 36 L +305.793 36 L +305.871 36 L +305.948 36 L +306.026 36 L +306.104 36 L +306.182 36 L +306.259 36 L +306.337 36 L +306.415 36 L +306.493 36 L +306.57 36 L +306.648 36 L +306.726 36 L +306.804 36 L +306.881 36 L +306.959 36 L +307.037 36 L +307.114 36 L +307.192 36 L +307.27 36 L +307.348 36 L +307.425 36 L +307.503 36 L +307.581 36 L +307.659 36 L +307.736 36 L +307.814 36 L +307.892 36 L +307.97 36 L +308.047 36 L +308.125 36 L +308.203 36 L +308.28 36 L +308.358 36 L +308.436 36 L +308.514 36 L +308.591 36 L +308.669 36 L +308.747 36 L +308.825 36 L +308.902 36 L +308.98 36 L +309.058 36 L +309.136 36 L +309.213 36 L +309.291 36 L +309.369 36 L +309.446 36 L +309.524 36 L +309.602 36 L +309.68 36 L +309.757 36 L +309.835 36 L +309.913 36 L +309.991 36 L +310.068 36 L +310.146 36 L +310.224 36 L +310.302 36 L +310.379 36 L +310.457 36 L +310.535 36 L +310.612 36 L +310.69 36 L +310.768 36 L +310.846 36 L +310.923 36 L +311.001 36 L +311.079 36 L +311.157 36 L +311.234 36 L +311.312 36 L +311.39 36 L +311.468 36 L +311.545 36 L +311.623 36 L +311.701 36 L +311.779 36 L +311.856 36 L +311.934 36 L +312.012 36 L +312.089 36 L +312.167 36 L +312.245 36 L +312.323 36 L +312.4 36 L +312.478 36 L +312.556 36 L +312.634 36 L +312.711 36 L +312.789 36 L +312.867 36 L +312.945 36 L +313.022 36 L +313.1 36 L +313.178 36 L +313.255 36 L +313.333 36 L +313.411 36 L +313.489 36 L +313.566 36 L +313.644 36 L +313.722 36 L +313.8 36 L +313.877 36 L +313.955 36 L +314.033 36 L +314.111 36 L +314.188 36 L +314.266 36 L +314.344 36 L +314.421 36 L +314.499 36 L +314.577 36 L +314.655 36 L +314.732 36 L +314.81 36 L +314.888 36 L +314.966 36 L +315.043 36 L +315.121 36 L +315.199 36 L +315.277 36 L +315.354 36 L +315.432 36 L +315.51 36 L +315.587 36 L +315.665 36 L +315.743 36 L +315.821 36 L +315.898 36 L +315.976 36 L +316.054 36 L +316.132 36 L +316.209 36 L +316.287 36 L +316.365 36 L +316.443 36 L +316.52 36 L +316.598 36 L +316.676 36 L +316.754 36 L +316.831 36 L +316.909 36 L +316.987 36 L +317.064 36 L +317.142 36 L +317.22 36 L +317.298 36 L +317.375 36 L +317.453 36 L +317.531 36 L +317.609 36 L +317.686 36 L +317.764 36 L +317.842 36 L +317.92 36 L +317.997 36 L +318.075 36 L +318.153 36 L +318.23 36 L +318.308 36 L +318.386 36 L +318.464 36 L +318.541 36 L +318.619 36 L +318.697 36 L +318.775 36 L +318.852 36 L +318.93 36 L +319.008 36 L +319.086 36 L +319.163 36 L +319.241 36 L +319.319 36 L +319.396 36 L +319.474 36 L +319.552 36 L +319.63 36 L +319.707 36 L +319.785 36 L +319.863 36 L +319.941 36 L +320.018 36 L +320.096 36 L +320.174 36 L +320.252 36 L +320.329 36 L +320.407 36 L +320.485 36 L +320.563 36 L +320.64 36 L +320.718 36 L +320.796 36 L +320.873 36 L +320.951 36 L +321.029 36 L +321.107 36 L +321.184 36 L +321.262 36 L +321.34 36 L +321.418 36 L +321.495 36 L +321.573 36 L +321.651 36 L +321.729 36 L +321.806 36 L +321.884 36 L +321.962 36 L +322.039 36 L +322.117 36 L +322.195 36 L +322.273 36 L +322.35 36 L +322.428 36 L +322.506 36 L +322.584 36 L +322.661 36 L +322.739 36 L +322.817 36 L +322.895 36 L +322.972 36 L +323.05 36 L +323.128 36 L +323.205 36 L +323.283 36 L +323.361 36 L +323.439 36 L +323.516 36 L +323.594 36 L +323.672 36 L +323.75 36 L +323.827 36 L +323.905 36 L +323.983 36 L +324.061 36 L +324.138 36 L +324.216 36 L +324.294 36 L +324.371 36 L +324.449 36 L +324.527 36 L +324.605 36 L +324.682 36 L +324.76 36 L +324.838 36 L +324.916 36 L +324.993 36 L +325.071 36 L +325.149 36 L +325.227 36 L +325.304 36 L +325.382 36 L +325.46 36 L +325.538 36 L +325.615 36 L +325.693 36 L +325.771 36 L +325.848 36 L +325.926 36 L +326.004 36 L +326.082 36 L +326.159 36 L +326.237 36 L +326.315 36 L +326.393 36 L +326.47 36 L +326.548 36 L +326.626 36 L +326.704 36 L +326.781 36 L +326.859 36 L +326.937 36 L +327.014 36 L +327.092 36 L +327.17 36 L +327.248 36 L +327.325 36 L +327.403 36 L +327.481 36 L +327.559 36 L +327.636 36 L +327.714 36 L +327.792 36 L +327.87 36 L +327.947 36 L +328.025 36 L +328.103 36 L +328.18 36 L +328.258 36 L +328.336 36 L +328.414 36 L +328.491 36 L +328.569 36 L +328.647 36 L +328.725 36 L +328.802 36 L +328.88 36 L +328.958 36 L +329.036 36 L +329.113 36 L +329.191 36 L +329.269 36 L +329.346 36 L +329.424 36 L +329.502 36 L +329.58 36 L +329.657 36 L +329.735 36 L +329.813 36 L +329.891 36 L +329.968 36 L +330.046 36 L +330.124 36 L +330.202 36 L +330.279 36 L +330.357 36 L +330.435 36 L +330.513 36 L +330.59 36 L +330.668 36 L +330.746 36 L +330.823 36 L +330.901 36 L +330.979 36 L +331.057 36 L +331.134 36 L +331.212 36 L +331.29 36 L +331.368 36 L +331.445 36 L +331.523 36 L +331.601 36 L +331.679 36 L +331.756 36 L +331.834 36 L +331.912 36 L +331.989 36 L +332.067 36 L +332.145 36 L +332.223 36 L +332.3 36 L +332.378 36 L +332.456 36 L +332.534 36 L +332.611 36 L +332.689 36 L +332.767 36 L +332.845 36 L +332.922 36 L +333 36 L +333.078 36 L +333.155 36 L +333.233 36 L +333.311 36 L +333.389 36 L +333.466 36 L +333.544 36 L +333.622 36 L +333.7 36 L +333.777 36 L +333.855 36 L +333.933 36 L +334.011 36 L +334.088 36 L +334.166 36 L +334.244 36 L +334.321 36 L +334.399 36 L +334.477 36 L +334.555 36 L +334.632 36 L +334.71 36 L +334.788 36 L +334.866 36 L +334.943 36 L +335.021 36 L +335.099 36 L +335.177 36 L +335.254 36 L +335.332 36 L +335.41 36 L +335.487 36 L +335.565 36 L +335.643 36 L +335.721 36 L +335.798 36 L +335.876 36 L +335.954 36 L +336.032 36 L +336.109 36 L +336.187 36 L +336.265 36 L +336.343 36 L +336.42 36 L +336.498 36 L +336.576 36 L +336.654 36 L +336.731 36 L +336.809 36 L +336.887 36 L +336.964 36 L +337.042 36 L +337.12 36 L +337.198 36 L +337.275 36 L +337.353 36 L +337.431 36 L +337.509 36 L +337.586 36 L +337.664 36 L +337.742 36 L +337.82 36 L +337.897 36 L +337.975 36 L +338.053 36 L +338.13 36 L +338.208 36 L +338.286 36 L +338.364 36 L +338.441 36 L +338.519 36 L +338.597 36 L +338.675 36 L +338.752 36 L +338.83 36 L +338.908 36 L +338.986 36 L +339.063 36 L +339.141 36 L +339.219 36 L +339.296 36 L +339.374 36 L +339.452 36 L +339.53 36 L +339.607 36 L +339.685 36 L +339.763 36 L +339.841 36 L +339.918 36 L +339.996 36 L +340.074 36 L +340.152 36 L +340.229 36 L +340.307 36 L +340.385 36 L +340.462 36 L +340.54 36 L +340.618 36 L +340.696 36 L +340.773 36 L +340.851 36 L +340.929 36 L +341.007 36 L +341.084 36 L +341.162 36 L +341.24 36 L +341.318 36 L +341.395 36 L +341.473 36 L +341.551 36 L +341.629 36 L +341.706 36 L +341.784 36 L +341.862 36 L +341.939 36 L +342.017 36 L +342.095 36 L +342.173 36 L +342.25 36 L +342.328 36 L +342.406 36 L +342.484 36 L +342.561 36 L +342.639 36 L +342.717 36 L +342.795 36 L +342.872 36 L +342.95 36 L +343.028 36 L +343.105 36 L +343.183 36 L +343.261 36 L +343.339 36 L +343.416 36 L +343.494 36 L +343.572 36 L +343.65 36 L +343.727 36 L +343.805 36 L +343.883 36 L +343.961 36 L +344.038 36 L +344.116 36 L +344.194 36 L +344.271 36 L +344.349 36 L +344.427 36 L +344.505 36 L +344.582 36 L +344.66 36 L +344.738 36 L +344.816 36 L +344.893 36 L +344.971 36 L +345.049 36 L +345.127 36 L +345.204 36 L +345.282 36 L +345.36 36 L +345.438 36 L +345.515 36 L +345.593 36 L +345.671 36 L +345.748 36 L +345.826 36 L +345.904 36 L +345.982 36 L +346.059 36 L +346.137 36 L +346.215 36 L +346.293 36 L +346.37 36 L +346.448 36 L +346.526 36 L +346.604 36 L +346.681 36 L +346.759 36 L +346.837 36 L +346.914 36 L +346.992 36 L +347.07 36 L +347.148 36 L +347.225 36 L +347.303 36 L +347.381 36 L +347.459 36 L +347.536 36 L +347.614 36 L +347.692 36 L +347.77 36 L +347.847 36 L +347.925 36 L +348.003 36 L +348.08 36 L +348.158 36 L +348.236 36 L +348.314 36 L +348.391 36 L +348.469 36 L +348.547 36 L +348.625 36 L +348.702 36 L +348.78 36 L +348.858 36 L +348.936 36 L +349.013 36 L +349.091 36 L +349.169 36 L +349.246 36 L +349.324 36 L +349.402 36 L +349.48 36 L +349.557 36 L +349.635 36 L +349.713 36 L +349.791 36 L +349.868 36 L +349.946 36 L +350.024 36 L +350.102 36 L +350.179 36 L +350.257 36 L +350.335 36 L +350.413 36 L +350.49 36 L +350.568 36 L +350.646 36 L +350.723 36 L +350.801 36 L +350.879 36 L +350.957 36 L +351.034 36 L +351.112 36 L +351.19 36 L +351.268 36 L +351.345 36 L +351.423 36 L +351.501 36 L +351.579 36 L +351.656 36 L +351.734 36 L +351.812 36 L +351.889 36 L +351.967 36 L +352.045 36 L +352.123 36 L +352.2 36 L +352.278 36 L +352.356 36 L +352.434 36 L +352.511 36 L +352.589 36 L +352.667 36 L +352.745 36 L +352.822 36 L +352.9 36 L +352.978 36 L +353.055 36 L +353.133 36 L +353.211 36 L +353.289 36 L +353.366 36 L +353.444 36 L +353.522 36 L +353.6 36 L +353.677 36 L +353.755 36 L +353.833 36 L +353.911 36 L +353.988 36 L +354.066 36 L +354.144 36 L +354.221 36 L +354.299 36 L +354.377 36 L +354.455 36 L +354.532 36 L +354.61 36 L +354.688 36 L +354.766 36 L +354.843 36 L +354.921 36 L +354.999 36 L +355.077 36 L +355.154 36 L +355.232 36 L +355.31 36 L +355.388 36 L +355.465 36 L +355.543 36 L +355.621 36 L +355.698 36 L +355.776 36 L +355.854 36 L +355.932 36 L +356.009 36 L +356.087 36 L +356.165 36 L +356.243 36 L +356.32 36 L +356.398 36 L +356.476 36 L +356.554 36 L +356.631 36 L +356.709 36 L +356.787 36 L +356.864 36 L +356.942 36 L +357.02 36 L +357.098 36 L +357.175 36 L +357.253 36 L +357.331 36 L +357.409 36 L +357.486 36 L +357.564 36 L +357.642 36 L +357.72 36 L +357.797 36 L +357.875 36 L +357.953 36 L +358.03 36 L +358.108 36 L +358.186 36 L +358.264 36 L +358.341 36 L +358.419 36 L +358.497 36 L +358.575 36 L +358.652 36 L +358.73 36 L +358.808 36 L +358.886 36 L +358.963 36 L +359.041 36 L +359.119 36 L +359.196 36 L +359.274 36 L +359.352 36 L +359.43 36 L +359.507 36 L +359.585 36 L +359.663 36 L +359.741 36 L +359.818 36 L +359.896 36 L +359.974 36 L +360.052 36 L +360.129 36 L +360.207 36 L +360.285 36 L +360.362 36 L +360.44 36 L +360.518 36 L +360.596 36 L +360.673 36 L +360.751 36 L +360.829 36 L +360.907 36 L +360.984 36 L +361.062 36 L +361.14 36 L +361.218 36 L +361.295 36 L +361.373 36 L +361.451 36 L +361.529 36 L +361.606 36 L +361.684 36 L +361.762 36 L +361.839 36 L +361.917 36 L +361.995 36 L +362.073 36 L +362.15 36 L +362.228 36 L +362.306 36 L +362.384 36 L +362.461 36 L +362.539 36 L +362.617 36 L +362.695 36 L +362.772 36 L +362.85 36 L +362.928 36 L +363.005 36 L +363.083 36 L +363.161 36 L +363.239 36 L +363.316 36 L +363.394 36 L +363.472 36 L +363.55 36 L +363.627 36 L +363.705 36 L +363.783 36 L +363.861 36 L +363.938 36 L +364.016 36 L +364.094 36 L +364.171 36 L +364.249 36 L +364.327 36 L +364.405 36 L +364.482 36 L +364.56 36 L +364.638 36 L +364.716 36 L +364.793 36 L +364.871 36 L +364.949 36 L +365.027 36 L +365.104 36 L +365.182 36 L +365.26 36 L +365.337 36 L +365.415 36 L +365.493 36 L +365.571 36 L +365.648 36 L +365.726 36 L +365.804 36 L +365.882 36 L +365.959 36 L +366.037 36 L +366.115 36 L +366.193 36 L +366.27 36 L +366.348 36 L +366.426 36 L +366.504 36 L +366.581 36 L +366.659 36 L +366.737 36 L +366.814 36 L +366.892 36 L +366.97 36 L +367.048 36 L +367.125 36 L +367.203 36 L +367.281 36 L +367.359 36 L +367.436 36 L +367.514 36 L +367.592 36 L +367.67 36 L +367.747 36 L +367.825 36 L +367.903 36 L +367.98 36 L +368.058 36 L +368.136 36 L +368.214 36 L +368.291 36 L +368.369 36 L +368.447 36 L +368.525 36 L +368.602 36 L +368.68 36 L +368.758 36 L +368.836 36 L +368.913 36 L +368.991 36 L +369.069 36 L +369.146 36 L +369.224 36 L +369.302 36 L +369.38 36 L +369.457 36 L +369.535 36 L +369.613 36 L +369.691 36 L +369.768 36 L +369.846 36 L +369.924 36 L +370.002 36 L +370.079 36 L +370.157 36 L +370.235 36 L +370.313 36 L +370.39 36 L +370.468 36 L +370.546 36 L +370.623 36 L +370.701 36 L +370.779 36 L +370.857 36 L +370.934 36 L +371.012 36 L +371.09 36 L +371.168 36 L +371.245 36 L +371.323 36 L +371.401 36 L +371.479 36 L +371.556 36 L +371.634 36 L +371.712 36 L +371.789 36 L +371.867 36 L +371.945 36 L +372.023 36 L +372.1 36 L +372.178 36 L +372.256 36 L +372.334 36 L +372.411 36 L +372.489 36 L +372.567 36 L +372.645 36 L +372.722 36 L +372.8 36 L +372.878 425 L +372.955 425 L +373.033 425 L +373.111 425 L +373.189 425 L +373.266 425 L +373.344 425 L +373.422 425 L +373.5 425 L +373.577 425 L +373.655 425 L +373.733 425 L +373.811 425 L +373.888 425 L +373.966 425 L +374.044 425 L +374.121 425 L +374.199 425 L +374.277 425 L +374.355 425 L +374.432 425 L +374.51 425 L +374.588 425 L +374.666 425 L +374.743 425 L +374.821 425 L +374.899 425 L +374.977 425 L +375.054 425 L +375.132 425 L +375.21 425 L +375.288 425 L +375.365 425 L +375.443 425 L +375.521 425 L +375.598 425 L +375.676 425 L +375.754 425 L +375.832 425 L +375.909 425 L +375.987 425 L +376.065 425 L +376.143 425 L +376.22 425 L +376.298 425 L +376.376 425 L +376.454 425 L +376.531 425 L +376.609 425 L +376.687 425 L +376.764 425 L +376.842 425 L +376.92 425 L +376.998 425 L +377.075 425 L +377.153 425 L +377.231 425 L +377.309 425 L +377.386 425 L +377.464 425 L +377.542 425 L +377.62 425 L +377.697 425 L +377.775 425 L +377.853 425 L +377.93 425 L +378.008 425 L +378.086 425 L +378.164 425 L +378.241 425 L +378.319 425 L +378.397 425 L +378.475 425 L +378.552 425 L +378.63 425 L +378.708 425 L +378.786 425 L +378.863 425 L +378.941 425 L +379.019 425 L +379.096 425 L +379.174 425 L +379.252 425 L +379.33 425 L +379.407 425 L +379.485 425 L +379.563 425 L +379.641 425 L +379.718 425 L +379.796 425 L +379.874 425 L +379.952 425 L +380.029 425 L +380.107 425 L +380.185 425 L +380.263 425 L +380.34 425 L +380.418 425 L +380.496 425 L +380.573 425 L +380.651 425 L +380.729 425 L +380.807 425 L +380.884 425 L +380.962 425 L +381.04 425 L +381.118 425 L +381.195 425 L +381.273 425 L +381.351 425 L +381.429 425 L +381.506 425 L +381.584 425 L +381.662 425 L +381.739 425 L +381.817 425 L +381.895 425 L +381.973 425 L +382.05 425 L +382.128 425 L +382.206 425 L +382.284 425 L +382.361 425 L +382.439 425 L +382.517 425 L +382.595 425 L +382.672 425 L +382.75 425 L +382.828 425 L +382.905 425 L +382.983 425 L +383.061 425 L +383.139 425 L +383.216 425 L +383.294 425 L +383.372 425 L +383.45 425 L +383.527 425 L +383.605 425 L +383.683 425 L +383.761 425 L +383.838 425 L +383.916 425 L +383.994 425 L +384.071 425 L +384.149 425 L +384.227 425 L +384.305 425 L +384.382 425 L +384.46 425 L +384.538 425 L +384.616 425 L +384.693 425 L +384.771 425 L +384.849 425 L +384.927 425 L +385.004 425 L +385.082 425 L +385.16 425 L +385.237 425 L +385.315 425 L +385.393 425 L +385.471 425 L +385.548 425 L +385.626 425 L +385.704 425 L +385.782 425 L +385.859 425 L +385.937 425 L +386.015 425 L +386.093 425 L +386.17 425 L +386.248 425 L +386.326 425 L +386.404 425 L +386.481 425 L +386.559 425 L +386.637 425 L +386.714 425 L +386.792 425 L +386.87 425 L +386.948 425 L +387.025 425 L +387.103 425 L +387.181 425 L +387.259 425 L +387.336 425 L +387.414 425 L +387.492 425 L +387.57 425 L +387.647 425 L +387.725 425 L +387.803 425 L +387.88 425 L +387.958 425 L +388.036 425 L +388.114 425 L +388.191 425 L +388.269 425 L +388.347 425 L +388.425 425 L +388.502 425 L +388.58 425 L +388.658 425 L +388.736 425 L +388.813 425 L +388.891 425 L +388.969 425 L +389.046 425 L +389.124 425 L +389.202 425 L +389.28 425 L +389.357 425 L +389.435 425 L +389.513 425 L +389.591 425 L +389.668 425 L +389.746 425 L +389.824 425 L +389.902 425 L +389.979 425 L +390.057 425 L +390.135 425 L +390.212 425 L +390.29 425 L +390.368 425 L +390.446 425 L +390.523 425 L +390.601 425 L +390.679 425 L +390.757 425 L +390.834 425 L +390.912 425 L +390.99 425 L +391.068 425 L +391.145 425 L +391.223 425 L +391.301 425 L +391.379 425 L +391.456 425 L +391.534 425 L +391.612 425 L +391.689 425 L +391.767 425 L +391.845 425 L +391.923 425 L +392 425 L +392.078 425 L +392.156 425 L +392.234 425 L +392.311 425 L +392.389 425 L +392.467 425 L +392.545 425 L +392.622 425 L +392.7 425 L +392.778 425 L +392.855 425 L +392.933 425 L +393.011 425 L +393.089 425 L +393.166 425 L +393.244 425 L +393.322 425 L +393.4 425 L +393.477 425 L +393.555 425 L +393.633 425 L +393.711 425 L +393.788 425 L +393.866 425 L +393.944 425 L +394.021 425 L +394.099 425 L +394.177 425 L +394.255 425 L +394.332 425 L +394.41 425 L +394.488 425 L +394.566 425 L +394.643 425 L +394.721 425 L +394.799 425 L +394.877 425 L +394.954 425 L +395.032 425 L +395.11 425 L +395.188 425 L +395.265 425 L +395.343 425 L +395.421 425 L +395.498 425 L +395.576 425 L +395.654 425 L +395.732 425 L +395.809 425 L +395.887 425 L +395.965 425 L +396.043 425 L +396.12 425 L +396.198 425 L +396.276 425 L +396.354 425 L +396.431 425 L +396.509 425 L +396.587 425 L +396.664 425 L +396.742 425 L +396.82 425 L +396.898 425 L +396.975 425 L +397.053 425 L +397.131 425 L +397.209 425 L +397.286 425 L +397.364 425 L +397.442 425 L +397.52 425 L +397.597 425 L +397.675 425 L +397.753 425 L +397.83 425 L +397.908 425 L +397.986 425 L +398.064 425 L +398.141 425 L +398.219 425 L +398.297 425 L +398.375 425 L +398.452 425 L +398.53 425 L +398.608 425 L +398.686 425 L +398.763 425 L +398.841 425 L +398.919 425 L +398.996 425 L +399.074 425 L +399.152 425 L +399.23 425 L +399.307 425 L +399.385 425 L +399.463 425 L +399.541 425 L +399.618 425 L +399.696 425 L +399.774 425 L +399.852 425 L +399.929 425 L +400.007 425 L +400.085 425 L +400.163 425 L +400.24 425 L +400.318 425 L +400.396 425 L +400.473 425 L +400.551 425 L +400.629 425 L +400.707 425 L +400.784 425 L +400.862 425 L +400.94 425 L +401.018 425 L +401.095 425 L +401.173 425 L +401.251 425 L +401.329 425 L +401.406 425 L +401.484 425 L +401.562 425 L +401.639 425 L +401.717 425 L +401.795 425 L +401.873 425 L +401.95 425 L +402.028 425 L +402.106 425 L +402.184 425 L +402.261 425 L +402.339 425 L +402.417 425 L +402.495 425 L +402.572 425 L +402.65 425 L +402.728 425 L +402.805 425 L +402.883 425 L +402.961 425 L +403.039 425 L +403.116 425 L +403.194 425 L +403.272 425 L +403.35 425 L +403.427 425 L +403.505 425 L +403.583 425 L +403.661 425 L +403.738 425 L +403.816 425 L +403.894 425 L +403.971 425 L +404.049 425 L +404.127 425 L +404.205 425 L +404.282 425 L +404.36 425 L +404.438 425 L +404.516 425 L +404.593 425 L +404.671 425 L +404.749 425 L +404.827 425 L +404.904 425 L +404.982 425 L +405.06 425 L +405.138 425 L +405.215 425 L +405.293 425 L +405.371 425 L +405.448 425 L +405.526 425 L +405.604 425 L +405.682 425 L +405.759 425 L +405.837 425 L +405.915 425 L +405.993 425 L +406.07 425 L +406.148 425 L +406.226 425 L +406.304 425 L +406.381 425 L +406.459 425 L +406.537 425 L +406.614 425 L +406.692 425 L +406.77 425 L +406.848 425 L +406.925 425 L +407.003 425 L +407.081 425 L +407.159 425 L +407.236 425 L +407.314 425 L +407.392 425 L +407.47 425 L +407.547 425 L +407.625 425 L +407.703 425 L +407.78 425 L +407.858 425 L +407.936 425 L +408.014 425 L +408.091 425 L +408.169 425 L +408.247 425 L +408.325 425 L +408.402 425 L +408.48 425 L +408.558 425 L +408.636 425 L +408.713 425 L +408.791 425 L +408.869 425 L +408.946 425 L +409.024 425 L +409.102 425 L +409.18 425 L +409.257 425 L +409.335 425 L +409.413 425 L +409.491 425 L +409.568 425 L +409.646 425 L +409.724 425 L +409.802 425 L +409.879 425 L +409.957 425 L +410.035 425 L +410.112 425 L +410.19 425 L +410.268 425 L +410.346 425 L +410.423 425 L +410.501 425 L +410.579 425 L +410.657 425 L +410.734 425 L +410.812 425 L +410.89 425 L +410.968 425 L +411.045 425 L +411.123 425 L +411.201 425 L +411.279 425 L +411.356 425 L +411.434 425 L +411.512 425 L +411.589 425 L +411.667 425 L +411.745 425 L +411.823 425 L +411.9 425 L +411.978 425 L +412.056 425 L +412.134 425 L +412.211 425 L +412.289 425 L +412.367 425 L +412.445 425 L +412.522 425 L +412.6 425 L +412.678 425 L +412.755 425 L +412.833 425 L +412.911 425 L +412.989 425 L +413.066 425 L +413.144 425 L +413.222 425 L +413.3 425 L +413.377 425 L +413.455 425 L +413.533 425 L +413.611 425 L +413.688 425 L +413.766 425 L +413.844 425 L +413.921 425 L +413.999 425 L +414.077 425 L +414.155 425 L +414.232 425 L +414.31 425 L +414.388 425 L +414.466 425 L +414.543 425 L +414.621 425 L +414.699 425 L +414.777 425 L +414.854 425 L +414.932 425 L +415.01 425 L +415.087 425 L +415.165 425 L +415.243 425 L +415.321 425 L +415.398 425 L +415.476 425 L +415.554 425 L +415.632 425 L +415.709 425 L +415.787 425 L +415.865 425 L +415.943 425 L +416.02 425 L +416.098 425 L +416.176 425 L +416.254 425 L +416.331 425 L +416.409 425 L +416.487 425 L +416.564 425 L +416.642 425 L +416.72 425 L +416.798 425 L +416.875 425 L +416.953 425 L +417.031 425 L +417.109 425 L +417.186 425 L +417.264 425 L +417.342 425 L +417.42 425 L +417.497 425 L +417.575 425 L +417.653 425 L +417.73 425 L +417.808 425 L +417.886 425 L +417.964 425 L +418.041 425 L +418.119 425 L +418.197 425 L +418.275 425 L +418.352 425 L +418.43 425 L +418.508 425 L +418.586 425 L +418.663 425 L +418.741 425 L +418.819 425 L +418.896 425 L +418.974 425 L +419.052 425 L +419.13 425 L +419.207 425 L +419.285 425 L +419.363 425 L +419.441 425 L +419.518 425 L +419.596 425 L +419.674 425 L +419.752 425 L +419.829 425 L +419.907 425 L +419.985 425 L +420.063 425 L +420.14 425 L +420.218 425 L +420.296 425 L +420.373 425 L +420.451 425 L +420.529 425 L +420.607 425 L +420.684 425 L +420.762 425 L +420.84 425 L +420.918 425 L +420.995 425 L +421.073 425 L +421.151 425 L +421.229 425 L +421.306 425 L +421.384 425 L +421.462 425 L +421.539 425 L +421.617 425 L +421.695 425 L +421.773 425 L +421.85 425 L +421.928 425 L +422.006 425 L +422.084 425 L +422.161 425 L +422.239 425 L +422.317 425 L +422.395 425 L +422.472 425 L +422.55 425 L +422.628 425 L +422.705 425 L +422.783 425 L +422.861 425 L +422.939 425 L +423.016 425 L +423.094 425 L +423.172 425 L +423.25 425 L +423.327 425 L +423.405 425 L +423.483 425 L +423.561 425 L +423.638 425 L +423.716 425 L +423.794 425 L +423.871 425 L +423.949 425 L +424.027 425 L +424.105 425 L +424.182 425 L +424.26 425 L +424.338 425 L +424.416 425 L +424.493 425 L +424.571 425 L +424.649 425 L +424.727 425 L +424.804 425 L +424.882 425 L +424.96 425 L +425.038 425 L +425.115 425 L +425.193 425 L +425.271 425 L +425.348 425 L +425.426 425 L +425.504 425 L +425.582 425 L +425.659 425 L +425.737 425 L +425.815 425 L +425.893 425 L +425.97 425 L +426.048 425 L +426.126 425 L +426.204 425 L +426.281 425 L +426.359 425 L +426.437 425 L +426.514 425 L +426.592 425 L +426.67 425 L +426.748 425 L +426.825 425 L +426.903 425 L +426.981 425 L +427.059 425 L +427.136 425 L +427.214 425 L +427.292 425 L +427.37 425 L +427.447 425 L +427.525 425 L +427.603 425 L +427.68 425 L +427.758 425 L +427.836 425 L +427.914 425 L +427.991 425 L +428.069 425 L +428.147 425 L +428.225 425 L +428.302 425 L +428.38 425 L +428.458 425 L +428.536 425 L +428.613 425 L +428.691 425 L +428.769 425 L +428.846 425 L +428.924 425 L +429.002 425 L +429.08 425 L +429.157 425 L +429.235 425 L +429.313 425 L +429.391 425 L +429.468 425 L +429.546 425 L +429.624 425 L +429.702 425 L +429.779 425 L +429.857 425 L +429.935 425 L +430.013 425 L +430.09 425 L +430.168 425 L +430.246 425 L +430.323 425 L +430.401 425 L +430.479 425 L +430.557 425 L +430.634 425 L +430.712 425 L +430.79 425 L +430.868 425 L +430.945 425 L +431.023 425 L +431.101 425 L +431.179 425 L +431.256 425 L +431.334 425 L +431.412 425 L +431.489 425 L +431.567 425 L +431.645 425 L +431.723 425 L +431.8 425 L +431.878 425 L +431.956 425 L +432.034 425 L +432.111 425 L +432.189 425 L +432.267 425 L +432.345 425 L +432.422 425 L +432.5 425 L +432.578 425 L +432.655 425 L +432.733 425 L +432.811 425 L +432.889 425 L +432.966 425 L +433.044 425 L +433.122 425 L +433.2 425 L +433.277 425 L +433.355 425 L +433.433 425 L +433.511 425 L +433.588 425 L +433.666 425 L +433.744 425 L +433.821 425 L +433.899 425 L +433.977 425 L +434.055 425 L +434.132 425 L +434.21 425 L +434.288 425 L +434.366 425 L +434.443 425 L +434.521 425 L +434.599 425 L +434.677 425 L +434.754 425 L +434.832 425 L +434.91 425 L +434.987 425 L +435.065 425 L +435.143 425 L +435.221 425 L +435.298 425 L +435.376 425 L +435.454 425 L +435.532 425 L +435.609 425 L +435.687 425 L +435.765 425 L +435.843 425 L +435.92 425 L +435.998 425 L +436.076 425 L +436.154 425 L +436.231 425 L +436.309 425 L +436.387 425 L +436.464 425 L +436.542 425 L +436.62 425 L +436.698 425 L +436.775 425 L +436.853 425 L +436.931 425 L +437.009 425 L +437.086 425 L +437.164 425 L +437.242 425 L +437.32 425 L +437.397 425 L +437.475 425 L +437.553 425 L +437.63 425 L +437.708 425 L +437.786 425 L +437.864 425 L +437.941 425 L +438.019 425 L +438.097 425 L +438.175 425 L +438.252 425 L +438.33 425 L +438.408 425 L +438.486 425 L +438.563 425 L +438.641 425 L +438.719 425 L +438.796 425 L +438.874 425 L +438.952 425 L +439.03 425 L +439.107 425 L +439.185 425 L +439.263 425 L +439.341 425 L +439.418 425 L +439.496 425 L +439.574 425 L +439.652 425 L +439.729 425 L +439.807 425 L +439.885 425 L +439.962 425 L +440.04 425 L +440.118 425 L +440.196 425 L +440.273 425 L +440.351 425 L +440.429 425 L +440.507 425 L +440.584 425 L +440.662 425 L +440.74 425 L +440.818 425 L +440.895 425 L +440.973 425 L +441.051 425 L +441.129 425 L +441.206 425 L +441.284 425 L +441.362 425 L +441.439 425 L +441.517 425 L +441.595 425 L +441.673 425 L +441.75 425 L +441.828 425 L +441.906 425 L +441.984 425 L +442.061 425 L +442.139 425 L +442.217 425 L +442.295 425 L +442.372 425 L +442.45 425 L +442.528 425 L +442.605 425 L +442.683 425 L +442.761 425 L +442.839 425 L +442.916 425 L +442.994 425 L +443.072 425 L +443.15 425 L +443.227 425 L +443.305 425 L +443.383 425 L +443.461 425 L +443.538 425 L +443.616 425 L +443.694 425 L +443.771 425 L +443.849 425 L +443.927 425 L +444.005 425 L +444.082 425 L +444.16 425 L +444.238 425 L +444.316 425 L +444.393 425 L +444.471 425 L +444.549 425 L +444.627 425 L +444.704 425 L +444.782 425 L +444.86 425 L +444.938 425 L +445.015 425 L +445.093 425 L +445.171 425 L +445.248 425 L +445.326 425 L +445.404 425 L +445.482 425 L +445.559 425 L +445.637 425 L +445.715 425 L +445.793 425 L +445.87 425 L +445.948 425 L +446.026 425 L +446.104 425 L +446.181 425 L +446.259 425 L +446.337 425 L +446.414 425 L +446.492 425 L +446.57 425 L +446.648 425 L +446.725 425 L +446.803 425 L +446.881 425 L +446.959 425 L +447.036 425 L +447.114 425 L +447.192 425 L +447.27 425 L +447.347 425 L +447.425 425 L +447.503 425 L +447.58 425 L +447.658 425 L +447.736 425 L +447.814 425 L +447.891 425 L +447.969 425 L +448.047 425 L +448.125 425 L +448.202 425 L +448.28 425 L +448.358 425 L +448.436 425 L +448.513 425 L +448.591 425 L +448.669 425 L +448.746 425 L +448.824 425 L +448.902 425 L +448.98 425 L +449.057 425 L +449.135 425 L +449.213 425 L +449.291 425 L +449.368 425 L +449.446 425 L +449.524 425 L +449.602 425 L +449.679 425 L +449.757 425 L +449.835 425 L +449.913 425 L +449.99 425 L +450.068 425 L +450.146 425 L +450.223 425 L +450.301 425 L +450.379 425 L +450.457 425 L +450.534 425 L +450.612 425 L +450.69 425 L +450.768 425 L +450.845 425 L +450.923 425 L +451.001 425 L +451.079 425 L +451.156 425 L +451.234 425 L +451.312 425 L +451.389 425 L +451.467 425 L +451.545 425 L +451.623 425 L +451.7 425 L +451.778 425 L +451.856 425 L +451.934 425 L +452.011 425 L +452.089 425 L +452.167 425 L +452.245 425 L +452.322 425 L +452.4 425 L +452.478 425 L +452.555 425 L +452.633 425 L +452.711 425 L +452.789 425 L +452.866 425 L +452.944 425 L +453.022 425 L +453.1 425 L +453.177 425 L +453.255 425 L +453.333 425 L +453.411 425 L +453.488 425 L +453.566 425 L +453.644 425 L +453.721 425 L +453.799 425 L +453.877 425 L +453.955 425 L +454.032 425 L +454.11 425 L +454.188 425 L +454.266 425 L +454.343 425 L +454.421 425 L +454.499 425 L +454.577 425 L +454.654 425 L +454.732 425 L +454.81 425 L +454.888 425 L +454.965 425 L +455.043 425 L +455.121 425 L +455.198 425 L +455.276 425 L +455.354 425 L +455.432 425 L +455.509 425 L +455.587 425 L +455.665 425 L +455.743 425 L +455.82 425 L +455.898 425 L +455.976 425 L +456.054 425 L +456.131 425 L +456.209 425 L +456.287 425 L +456.364 425 L +456.442 425 L +456.52 425 L +456.598 425 L +456.675 425 L +456.753 425 L +456.831 425 L +456.909 425 L +456.986 425 L +457.064 425 L +457.142 425 L +457.22 425 L +457.297 425 L +457.375 425 L +457.453 425 L +457.53 425 L +457.608 425 L +457.686 425 L +457.764 425 L +457.841 425 L +457.919 425 L +457.997 425 L +458.075 425 L +458.152 425 L +458.23 425 L +458.308 425 L +458.386 425 L +458.463 425 L +458.541 425 L +458.619 425 L +458.696 425 L +458.774 425 L +458.852 425 L +458.93 425 L +459.007 425 L +459.085 425 L +459.163 425 L +459.241 425 L +459.318 425 L +459.396 425 L +459.474 425 L +459.552 425 L +459.629 425 L +459.707 425 L +459.785 425 L +459.862 425 L +459.94 425 L +460.018 425 L +460.096 425 L +460.173 425 L +460.251 425 L +460.329 425 L +460.407 425 L +460.484 425 L +460.562 425 L +460.64 425 L +460.718 425 L +460.795 425 L +460.873 425 L +460.951 425 L +461.029 425 L +461.106 425 L +461.184 425 L +461.262 425 L +461.339 425 L +461.417 425 L +461.495 425 L +461.573 425 L +461.65 425 L +461.728 425 L +461.806 425 L +461.884 425 L +461.961 425 L +462.039 425 L +462.117 425 L +462.195 425 L +462.272 425 L +462.35 425 L +462.428 425 L +462.505 425 L +462.583 425 L +462.661 425 L +462.739 425 L +462.816 425 L +462.894 425 L +462.972 425 L +463.05 425 L +463.127 425 L +463.205 425 L +463.283 425 L +463.361 425 L +463.438 425 L +463.516 425 L +463.594 425 L +463.671 425 L +463.749 425 L +463.827 425 L +463.905 425 L +463.982 425 L +464.06 425 L +464.138 425 L +464.216 425 L +464.293 425 L +464.371 425 L +464.449 425 L +464.527 425 L +464.604 425 L +464.682 425 L +464.76 425 L +464.837 425 L +464.915 425 L +464.993 425 L +465.071 425 L +465.148 425 L +465.226 425 L +465.304 425 L +465.382 425 L +465.459 425 L +465.537 425 L +465.615 425 L +465.693 425 L +465.77 425 L +465.848 425 L +465.926 425 L +466.004 425 L +466.081 425 L +466.159 425 L +466.237 425 L +466.314 425 L +466.392 425 L +466.47 425 L +466.548 425 L +466.625 425 L +466.703 425 L +466.781 425 L +466.859 425 L +466.936 425 L +467.014 425 L +467.092 425 L +467.17 425 L +467.247 425 L +467.325 425 L +467.403 425 L +467.48 425 L +467.558 425 L +467.636 425 L +467.714 425 L +467.791 425 L +467.869 425 L +467.947 425 L +468.025 425 L +468.102 425 L +468.18 425 L +468.258 425 L +468.336 425 L +468.413 425 L +468.491 425 L +468.569 425 L +468.646 425 L +468.724 425 L +468.802 425 L +468.88 425 L +468.957 425 L +469.035 425 L +469.113 425 L +469.191 425 L +469.268 425 L +469.346 425 L +469.424 425 L +469.502 425 L +469.579 425 L +469.657 425 L +469.735 425 L +469.813 425 L +469.89 425 L +469.968 425 L +470.046 425 L +470.123 425 L +470.201 425 L +470.279 425 L +470.357 425 L +470.434 425 L +470.512 425 L +470.59 425 L +470.668 425 L +470.745 425 L +470.823 425 L +470.901 425 L +470.979 425 L +471.056 425 L +471.134 425 L +471.212 425 L +471.289 425 L +471.367 425 L +471.445 425 L +471.523 425 L +471.6 425 L +471.678 425 L +471.756 425 L +471.834 425 L +471.911 425 L +471.989 425 L +472.067 425 L +472.145 425 L +472.222 425 L +472.3 425 L +472.378 425 L +472.455 425 L +472.533 425 L +472.611 425 L +472.689 425 L +472.766 425 L +472.844 425 L +472.922 425 L +473 425 L +473.077 425 L +473.155 425 L +473.233 425 L +473.311 425 L +473.388 425 L +473.466 425 L +473.544 425 L +473.621 425 L +473.699 425 L +473.777 425 L +473.855 425 L +473.932 425 L +474.01 425 L +474.088 425 L +474.166 425 L +474.243 425 L +474.321 425 L +474.399 425 L +474.477 425 L +474.554 425 L +474.632 425 L +474.71 425 L +474.788 425 L +474.865 425 L +474.943 425 L +475.021 425 L +475.098 425 L +475.176 425 L +475.254 425 L +475.332 425 L +475.409 425 L +475.487 425 L +475.565 425 L +475.643 425 L +475.72 425 L +475.798 425 L +475.876 425 L +475.954 425 L +476.031 425 L +476.109 425 L +476.187 425 L +476.264 425 L +476.342 425 L +476.42 425 L +476.498 425 L +476.575 425 L +476.653 425 L +476.731 425 L +476.809 425 L +476.886 425 L +476.964 425 L +477.042 425 L +477.12 425 L +477.197 425 L +477.275 425 L +477.353 425 L +477.43 425 L +477.508 425 L +477.586 425 L +477.664 425 L +477.741 425 L +477.819 425 L +477.897 425 L +477.975 425 L +478.052 425 L +478.13 425 L +478.208 425 L +478.286 425 L +478.363 425 L +478.441 425 L +478.519 425 L +478.596 425 L +478.674 425 L +478.752 425 L +478.83 425 L +478.907 425 L +478.985 425 L +479.063 425 L +479.141 425 L +479.218 425 L +479.296 425 L +479.374 425 L +479.452 425 L +479.529 425 L +479.607 425 L +479.685 425 L +479.763 425 L +479.84 425 L +479.918 425 L +479.996 425 L +480.073 425 L +480.151 425 L +480.229 425 L +480.307 425 L +480.384 425 L +480.462 425 L +480.54 425 L +480.618 425 L +480.695 425 L +480.773 425 L +480.851 425 L +480.929 425 L +481.006 425 L +481.084 425 L +481.162 425 L +481.239 425 L +481.317 425 L +481.395 425 L +481.473 425 L +481.55 425 L +481.628 425 L +481.706 425 L +481.784 425 L +481.861 425 L +481.939 425 L +482.017 425 L +482.095 425 L +482.172 425 L +482.25 425 L +482.328 425 L +482.405 425 L +482.483 425 L +482.561 425 L +482.639 425 L +482.716 425 L +482.794 425 L +482.872 425 L +482.95 425 L +483.027 425 L +483.105 425 L +483.183 425 L +483.261 425 L +483.338 425 L +483.416 425 L +483.494 425 L +483.571 425 L +483.649 425 L +483.727 425 L +483.805 425 L +483.882 425 L +483.96 425 L +484.038 425 L +484.116 425 L +484.193 425 L +484.271 425 L +484.349 425 L +484.427 425 L +484.504 425 L +484.582 425 L +484.66 425 L +484.737 425 L +484.815 425 L +484.893 425 L +484.971 425 L +485.048 425 L +485.126 425 L +485.204 425 L +485.282 425 L +485.359 425 L +485.437 425 L +485.515 425 L +485.593 425 L +485.67 425 L +485.748 425 L +485.826 425 L +485.904 425 L +485.981 425 L +486.059 425 L +486.137 425 L +486.214 425 L +486.292 425 L +486.37 425 L +486.448 425 L +486.525 425 L +486.603 425 L +486.681 425 L +486.759 425 L +486.836 425 L +486.914 425 L +486.992 425 L +487.07 425 L +487.147 425 L +487.225 425 L +487.303 425 L +487.38 425 L +487.458 425 L +487.536 425 L +487.614 425 L +487.691 425 L +487.769 425 L +487.847 425 L +487.925 425 L +488.002 425 L +488.08 425 L +488.158 425 L +488.236 425 L +488.313 425 L +488.391 425 L +488.469 425 L +488.546 425 L +488.624 425 L +488.702 425 L +488.78 425 L +488.857 425 L +488.935 425 L +489.013 425 L +489.091 425 L +489.168 425 L +489.246 425 L +489.324 425 L +489.402 425 L +489.479 425 L +489.557 425 L +489.635 425 L +489.712 425 L +489.79 425 L +489.868 425 L +489.946 425 L +490.023 425 L +490.101 425 L +490.179 425 L +490.257 425 L +490.334 425 L +490.412 425 L +490.49 425 L +490.568 425 L +490.645 425 L +490.723 425 L +490.801 425 L +490.879 425 L +490.956 425 L +491.034 425 L +491.112 425 L +491.189 425 L +491.267 425 L +491.345 425 L +491.423 425 L +491.5 425 L +491.578 425 L +491.656 425 L +491.734 425 L +491.811 425 L +491.889 425 L +491.967 425 L +492.045 425 L +492.122 425 L +492.2 425 L +492.278 425 L +492.355 425 L +492.433 425 L +492.511 425 L +492.589 425 L +492.666 425 L +492.744 425 L +492.822 425 L +492.9 425 L +492.977 425 L +493.055 425 L +493.133 425 L +493.211 425 L +493.288 425 L +493.366 425 L +493.444 425 L +493.521 425 L +493.599 425 L +493.677 425 L +493.755 425 L +493.832 425 L +493.91 425 L +493.988 425 L +494.066 425 L +494.143 425 L +494.221 425 L +494.299 425 L +494.377 425 L +494.454 425 L +494.532 425 L +494.61 425 L +494.688 425 L +494.765 425 L +494.843 425 L +494.921 425 L +494.998 425 L +495.076 425 L +495.154 425 L +495.232 425 L +495.309 425 L +495.387 425 L +495.465 425 L +495.543 425 L +495.62 425 L +495.698 425 L +495.776 425 L +495.854 425 L +495.931 425 L +496.009 425 L +496.087 425 L +496.164 425 L +496.242 425 L +496.32 425 L +496.398 425 L +496.475 425 L +496.553 425 L +496.631 425 L +496.709 425 L +496.786 425 L +496.864 425 L +496.942 425 L +497.02 425 L +497.097 425 L +497.175 425 L +497.253 425 L +497.33 425 L +497.408 425 L +497.486 425 L +497.564 425 L +497.641 425 L +497.719 425 L +497.797 425 L +497.875 425 L +497.952 425 L +498.03 425 L +498.108 425 L +498.186 425 L +498.263 425 L +498.341 425 L +498.419 425 L +498.496 425 L +498.574 425 L +498.652 425 L +498.73 425 L +498.807 425 L +498.885 425 L +498.963 425 L +499.041 425 L +499.118 425 L +499.196 425 L +499.274 425 L +499.352 425 L +499.429 425 L +499.507 425 L +499.585 425 L +499.663 425 L +499.74 425 L +499.818 425 L +499.896 425 L +499.973 425 L +500.051 425 L +500.129 425 L +500.207 425 L +500.284 425 L +500.362 425 L +500.44 425 L +500.518 425 L +500.595 425 L +500.673 425 L +500.751 425 L +500.829 425 L +500.906 425 L +500.984 425 L +501.062 425 L +501.139 425 L +501.217 425 L +501.295 425 L +501.373 425 L +501.45 425 L +501.528 425 L +501.606 425 L +501.684 425 L +501.761 425 L +501.839 425 L +501.917 425 L +501.995 425 L +502.072 425 L +502.15 425 L +502.228 425 L +502.305 425 L +502.383 425 L +502.461 425 L +502.539 425 L +502.616 425 L +502.694 425 L +502.772 425 L +502.85 425 L +502.927 425 L +503.005 425 L +503.083 425 L +503.161 425 L +503.238 425 L +503.316 425 L +503.394 425 L +503.471 425 L +503.549 425 L +503.627 425 L +503.705 425 L +503.782 425 L +503.86 425 L +503.938 425 L +504.016 425 L +504.093 425 L +504.171 425 L +504.249 425 L +504.327 425 L +504.404 425 L +504.482 425 L +504.56 425 L +504.638 425 L +504.715 425 L +504.793 425 L +504.871 425 L +504.948 425 L +505.026 425 L +505.104 425 L +505.182 425 L +505.259 425 L +505.337 425 L +505.415 425 L +505.493 425 L +505.57 425 L +505.648 425 L +505.726 425 L +505.804 425 L +505.881 425 L +505.959 425 L +506.037 425 L +506.114 425 L +506.192 425 L +506.27 425 L +506.348 425 L +506.425 425 L +506.503 425 L +506.581 425 L +506.659 425 L +506.736 425 L +506.814 425 L +506.892 425 L +506.97 425 L +507.047 425 L +507.125 425 L +507.203 425 L +507.28 425 L +507.358 425 L +507.436 425 L +507.514 425 L +507.591 425 L +507.669 425 L +507.747 425 L +507.825 425 L +507.902 425 L +507.98 425 L +508.058 425 L +508.136 425 L +508.213 425 L +508.291 425 L +508.369 425 L +508.446 425 L +508.524 425 L +508.602 425 L +508.68 425 L +508.757 425 L +508.835 425 L +508.913 425 L +508.991 425 L +509.068 425 L +509.146 425 L +509.224 425 L +509.302 425 L +509.379 425 L +509.457 425 L +509.535 425 L +509.612 425 L +509.69 425 L +509.768 425 L +509.846 425 L +509.923 425 L +510.001 425 L +510.079 425 L +510.157 425 L +510.234 425 L +510.312 425 L +510.39 425 L +510.468 425 L +510.545 425 L +510.623 425 L +510.701 425 L +510.779 425 L +510.856 425 L +510.934 425 L +511.012 425 L +511.089 425 L +511.167 425 L +511.245 425 L +511.323 425 L +511.4 425 L +511.478 425 L +511.556 425 L +511.634 425 L +511.711 425 L +511.789 425 L +511.867 425 L +511.945 425 L +512.022 425 L +512.1 425 L +512.178 425 L +512.255 425 L +512.333 425 L +512.411 425 L +512.489 425 L +512.566 425 L +512.644 425 L +512.722 425 L +512.8 425 L +512.877 425 L +512.955 425 L +513.033 425 L +513.111 425 L +513.188 425 L +513.266 425 L +513.344 425 L +513.422 425 L +513.499 425 L +513.577 425 L +513.655 425 L +513.732 425 L +513.81 425 L +513.888 425 L +513.966 425 L +514.043 425 L +514.121 425 L +514.199 425 L +514.277 425 L +514.354 425 L +514.432 425 L +514.51 425 L +514.588 425 L +514.665 425 L +514.743 425 L +514.821 425 L +514.898 425 L +514.976 425 L +515.054 425 L +515.132 425 L +515.209 425 L +515.287 425 L +515.365 425 L +515.443 425 L +515.52 425 L +515.598 425 L +515.676 425 L +515.754 425 L +515.831 425 L +515.909 425 L +515.987 425 L +516.064 425 L +516.142 425 L +516.22 425 L +516.298 425 L +516.375 425 L +516.453 425 L +516.531 425 L +516.609 425 L +516.686 425 L +516.764 425 L +516.842 425 L +516.92 425 L +516.997 425 L +517.075 425 L +517.153 425 L +517.23 425 L +517.308 425 L +517.386 425 L +517.464 425 L +517.541 425 L +517.619 425 L +517.697 425 L +517.775 425 L +517.852 425 L +517.93 425 L +518.008 425 L +518.086 425 L +518.163 425 L +518.241 425 L +518.319 425 L +518.396 425 L +518.474 425 L +518.552 425 L +518.63 425 L +518.707 425 L +518.785 425 L +518.863 425 L +518.941 425 L +519.018 425 L +519.096 425 L +519.174 425 L +519.252 425 L +519.329 425 L +519.407 425 L +519.485 425 L +519.563 425 L +519.64 425 L +519.718 425 L +519.796 425 L +519.873 425 L +519.951 425 L +520.029 425 L +520.107 425 L +520.184 425 L +520.262 425 L +520.34 425 L +520.418 425 L +520.495 425 L +520.573 425 L +520.651 425 L +520.729 425 L +520.806 425 L +520.884 425 L +520.962 425 L +521.039 425 L +521.117 425 L +521.195 425 L +521.273 425 L +521.35 425 L +521.428 425 L +521.506 425 L +521.584 425 L +521.661 425 L +521.739 425 L +521.817 425 L +521.895 425 L +521.972 425 L +522.05 425 L +522.128 425 L +522.205 425 L +522.283 425 L +522.361 425 L +522.439 425 L +522.516 425 L +522.594 425 L +522.672 425 L +522.75 425 L +522.827 425 L +522.905 425 L +522.983 425 L +523.061 425 L +523.138 425 L +523.216 425 L +523.294 425 L +523.371 425 L +523.449 425 L +523.527 425 L +523.605 425 L +523.682 425 L +523.76 425 L +523.838 425 L +523.916 425 L +523.993 425 L +524.071 425 L +524.149 425 L +524.227 425 L +524.304 425 L +524.382 425 L +524.46 425 L +524.537 425 L +524.615 425 L +524.693 425 L +524.771 425 L +524.848 425 L +524.926 425 L +525.004 425 L +525.082 425 L +525.159 425 L +525.237 425 L +525.315 425 L +525.393 425 L +525.47 425 L +525.548 425 L +525.626 425 L +525.703 425 L +525.781 425 L +525.859 425 L +525.937 425 L +526.014 425 L +526.092 425 L +526.17 425 L +526.248 425 L +526.325 425 L +526.403 425 L +526.481 425 L +526.559 425 L +526.636 425 L +526.714 425 L +526.792 425 L +526.87 425 L +526.947 425 L +527.025 425 L +527.103 425 L +527.18 425 L +527.258 425 L +527.336 425 L +527.414 425 L +527.491 425 L +527.569 425 L +527.647 425 L +527.725 425 L +527.802 425 L +527.88 425 L +527.958 425 L +528.036 425 L +528.113 425 L +528.191 425 L +528.269 425 L +528.346 425 L +528.424 425 L +528.502 425 L +528.58 425 L +528.657 425 L +528.735 425 L +528.813 425 L +528.891 425 L +528.968 425 L +529.046 425 L +529.124 425 L +529.202 425 L +529.279 425 L +529.357 425 L +529.435 425 L +529.513 425 L +529.59 425 L +529.668 425 L +529.746 425 L +529.823 425 L +529.901 425 L +529.979 425 L +530.057 425 L +530.134 425 L +530.212 425 L +530.29 425 L +530.368 425 L +530.445 425 L +530.523 425 L +530.601 425 L +530.679 425 L +530.756 425 L +530.834 425 L +530.912 425 L +530.989 425 L +531.067 425 L +531.145 425 L +531.223 425 L +531.3 425 L +531.378 425 L +531.456 425 L +531.534 425 L +531.611 425 L +531.689 425 L +531.767 425 L +531.845 425 L +531.922 425 L +532 36 L +532.078 36 L +532.155 36 L +532.233 36 L +532.311 36 L +532.389 36 L +532.466 36 L +532.544 36 L +532.622 36 L +532.7 36 L +532.777 36 L +532.855 36 L +532.933 36 L +533.011 36 L +533.088 36 L +533.166 36 L +533.244 36 L +533.321 36 L +533.399 36 L +533.477 36 L +533.555 36 L +533.632 36 L +533.71 36 L +533.788 36 L +533.866 36 L +533.943 36 L +534.021 36 L +534.099 36 L +534.177 36 L +534.254 36 L +534.332 36 L +534.41 36 L +534.487 36 L +534.565 36 L +534.643 36 L +534.721 36 L +534.798 36 L +534.876 36 L +534.954 36 L +535.032 36 L +535.109 36 L +535.187 36 L +535.265 36 L +535.343 36 L +535.42 36 L +535.498 36 L +535.576 36 L +535.654 36 L +535.731 36 L +535.809 36 L +535.887 36 L +535.964 36 L +536.042 36 L +536.12 36 L +536.198 36 L +536.275 36 L +536.353 36 L +536.431 36 L +536.509 36 L +536.586 36 L +536.664 36 L +536.742 36 L +536.82 36 L +536.897 36 L +536.975 36 L +537.053 36 L +537.13 36 L +537.208 36 L +537.286 36 L +537.364 36 L +537.441 36 L +537.519 36 L +537.597 36 L +537.675 36 L +537.752 36 L +537.83 36 L +537.908 36 L +537.986 36 L +538.063 36 L +538.141 36 L +538.219 36 L +538.297 36 L +538.374 36 L +538.452 36 L +538.53 36 L +538.607 36 L +538.685 36 L +538.763 36 L +538.841 36 L +538.918 36 L +538.996 36 L +539.074 36 L +539.152 36 L +539.229 36 L +539.307 36 L +539.385 36 L +539.463 36 L +539.54 36 L +539.618 36 L +539.696 36 L +539.773 36 L +539.851 36 L +539.929 36 L +540.007 36 L +540.084 36 L +540.162 36 L +540.24 36 L +540.318 36 L +540.395 36 L +540.473 36 L +540.551 36 L +540.629 36 L +540.706 36 L +540.784 36 L +540.862 36 L +540.939 36 L +541.017 36 L +541.095 36 L +541.173 36 L +541.25 36 L +541.328 36 L +541.406 36 L +541.484 36 L +541.561 36 L +541.639 36 L +541.717 36 L +541.795 36 L +541.872 36 L +541.95 36 L +542.028 36 L +542.105 36 L +542.183 36 L +542.261 36 L +542.339 36 L +542.416 36 L +542.494 36 L +542.572 36 L +542.65 36 L +542.727 36 L +542.805 36 L +542.883 36 L +542.961 36 L +543.038 36 L +543.116 36 L +543.194 36 L +543.271 36 L +543.349 36 L +543.427 36 L +543.505 36 L +543.582 36 L +543.66 36 L +543.738 36 L +543.816 36 L +543.893 36 L +543.971 36 L +544.049 36 L +544.127 36 L +544.204 36 L +544.282 36 L +544.36 36 L +544.438 36 L +544.515 36 L +544.593 36 L +544.671 36 L +544.748 36 L +544.826 36 L +544.904 36 L +544.982 36 L +545.059 36 L +545.137 36 L +545.215 36 L +545.293 36 L +545.37 36 L +545.448 36 L +545.526 36 L +545.604 36 L +545.681 36 L +545.759 36 L +545.837 36 L +545.914 36 L +545.992 36 L +546.07 36 L +546.148 36 L +546.225 36 L +546.303 36 L +546.381 36 L +546.459 36 L +546.536 36 L +546.614 36 L +546.692 36 L +546.77 36 L +546.847 36 L +546.925 36 L +547.003 36 L +547.08 36 L +547.158 36 L +547.236 36 L +547.314 36 L +547.391 36 L +547.469 36 L +547.547 36 L +547.625 36 L +547.702 36 L +547.78 36 L +547.858 36 L +547.936 36 L +548.013 36 L +548.091 36 L +548.169 36 L +548.246 36 L +548.324 36 L +548.402 36 L +548.48 36 L +548.557 36 L +548.635 36 L +548.713 36 L +548.791 36 L +548.868 36 L +548.946 36 L +549.024 36 L +549.102 36 L +549.179 36 L +549.257 36 L +549.335 36 L +549.412 36 L +549.49 36 L +549.568 36 L +549.646 36 L +549.723 36 L +549.801 36 L +549.879 36 L +549.957 36 L +550.034 36 L +550.112 36 L +550.19 36 L +550.268 36 L +550.345 36 L +550.423 36 L +550.501 36 L +550.578 36 L +550.656 36 L +550.734 36 L +550.812 36 L +550.889 36 L +550.967 36 L +551.045 36 L +551.123 36 L +551.2 36 L +551.278 36 L +551.356 36 L +551.434 36 L +551.511 36 L +551.589 36 L +551.667 36 L +551.745 36 L +551.822 36 L +551.9 36 L +551.978 36 L +552.055 36 L +552.133 36 L +552.211 36 L +552.289 36 L +552.366 36 L +552.444 36 L +552.522 36 L +552.6 36 L +552.677 36 L +552.755 36 L +552.833 36 L +552.911 36 L +552.988 36 L +553.066 36 L +553.144 36 L +553.221 36 L +553.299 36 L +553.377 36 L +553.455 36 L +553.532 36 L +553.61 36 L +553.688 36 L +553.766 36 L +553.843 36 L +553.921 36 L +553.999 36 L +554.077 36 L +554.154 36 L +554.232 36 L +554.31 36 L +554.388 36 L +554.465 36 L +554.543 36 L +554.621 36 L +554.698 36 L +554.776 36 L +554.854 36 L +554.932 36 L +555.009 36 L +555.087 36 L +555.165 36 L +555.243 36 L +555.32 36 L +555.398 36 L +555.476 36 L +555.554 36 L +555.631 36 L +555.709 36 L +555.787 36 L +555.864 36 L +555.942 36 L +556.02 36 L +556.098 36 L +556.175 36 L +556.253 36 L +556.331 36 L +556.409 36 L +556.486 36 L +556.564 36 L +556.642 36 L +556.72 36 L +556.797 36 L +556.875 36 L +556.953 36 L +557.03 36 L +557.108 36 L +557.186 36 L +557.264 36 L +557.341 36 L +557.419 36 L +557.497 36 L +557.575 36 L +557.652 36 L +557.73 36 L +557.808 36 L +557.886 36 L +557.963 36 L +558.041 36 L +558.119 36 L +558.196 36 L +558.274 36 L +558.352 36 L +558.43 36 L +558.507 36 L +558.585 36 L +558.663 36 L +558.741 36 L +558.818 36 L +558.896 36 L +558.974 36 L +559.052 36 L +559.129 36 L +559.207 36 L +559.285 36 L +559.362 36 L +559.44 36 L +559.518 36 L +559.596 36 L +559.673 36 L +559.751 36 L +559.829 36 L +559.907 36 L +559.984 36 L +560.062 36 L +560.14 36 L +560.218 36 L +560.295 36 L +560.373 36 L +560.451 36 L +560.529 36 L +560.606 36 L +560.684 36 L +560.762 36 L +560.839 36 L +560.917 36 L +560.995 36 L +561.073 36 L +561.15 36 L +561.228 36 L +561.306 36 L +561.384 36 L +561.461 36 L +561.539 36 L +561.617 36 L +561.695 36 L +561.772 36 L +561.85 36 L +561.928 36 L +562.005 36 L +562.083 36 L +562.161 36 L +562.239 36 L +562.316 36 L +562.394 36 L +562.472 36 L +562.55 36 L +562.627 36 L +562.705 36 L +562.783 36 L +562.861 36 L +562.938 36 L +563.016 36 L +563.094 36 L +563.172 36 L +563.249 36 L +563.327 36 L +563.405 36 L +563.482 36 L +563.56 36 L +563.638 36 L +563.716 36 L +563.793 36 L +563.871 36 L +563.949 36 L +564.027 36 L +564.104 36 L +564.182 36 L +564.26 36 L +564.338 36 L +564.415 36 L +564.493 36 L +564.571 36 L +564.648 36 L +564.726 36 L +564.804 36 L +564.882 36 L +564.959 36 L +565.037 36 L +565.115 36 L +565.193 36 L +565.27 36 L +565.348 36 L +565.426 36 L +565.504 36 L +565.581 36 L +565.659 36 L +565.737 36 L +565.814 36 L +565.892 36 L +565.97 36 L +566.048 36 L +566.125 36 L +566.203 36 L +566.281 36 L +566.359 36 L +566.436 36 L +566.514 36 L +566.592 36 L +566.67 36 L +566.747 36 L +566.825 36 L +566.903 36 L +566.98 36 L +567.058 36 L +567.136 36 L +567.214 36 L +567.291 36 L +567.369 36 L +567.447 36 L +567.525 36 L +567.602 36 L +567.68 36 L +567.758 36 L +567.836 36 L +567.913 36 L +567.991 36 L +568.069 36 L +568.146 36 L +568.224 36 L +568.302 36 L +568.38 36 L +568.457 36 L +568.535 36 L +568.613 36 L +568.691 36 L +568.768 36 L +568.846 36 L +568.924 36 L +569.002 36 L +569.079 36 L +569.157 36 L +569.235 36 L +569.313 36 L +569.39 36 L +569.468 36 L +569.546 36 L +569.623 36 L +569.701 36 L +569.779 36 L +569.857 36 L +569.934 36 L +570.012 36 L +570.09 36 L +570.168 36 L +570.245 36 L +570.323 36 L +570.401 36 L +570.479 36 L +570.556 36 L +570.634 36 L +570.712 36 L +570.789 36 L +570.867 36 L +570.945 36 L +571.023 36 L +571.1 36 L +571.178 36 L +571.256 36 L +571.334 36 L +571.411 36 L +571.489 36 L +571.567 36 L +571.645 36 L +571.722 36 L +571.8 36 L +571.878 36 L +571.955 36 L +572.033 36 L +572.111 36 L +572.189 36 L +572.266 36 L +572.344 36 L +572.422 36 L +572.5 36 L +572.577 36 L +572.655 36 L +572.733 36 L +572.811 36 L +572.888 36 L +572.966 36 L +573.044 36 L +573.121 36 L +573.199 36 L +573.277 36 L +573.355 36 L +573.432 36 L +573.51 36 L +573.588 36 L +573.666 36 L +573.743 36 L +573.821 36 L +573.899 36 L +573.977 36 L +574.054 36 L +574.132 36 L +574.21 36 L +574.287 36 L +574.365 36 L +574.443 36 L +574.521 36 L +574.598 36 L +574.676 36 L +574.754 36 L +574.832 36 L +574.909 36 L +574.987 36 L +575.065 36 L +575.143 36 L +575.22 36 L +575.298 36 L +575.376 36 L +575.453 36 L +575.531 36 L +575.609 36 L +575.687 36 L +575.764 36 L +575.842 36 L +575.92 36 L +575.998 36 L +576.075 36 L +576.153 36 L +576.231 36 L +576.309 36 L +576.386 36 L +576.464 36 L +576.542 36 L +576.62 36 L +576.697 36 L +576.775 36 L +576.853 36 L +576.93 36 L +577.008 36 L +577.086 36 L +577.164 36 L +577.241 36 L +577.319 36 L +577.397 36 L +577.475 36 L +577.552 36 L +577.63 36 L +577.708 36 L +577.786 36 L +577.863 36 L +577.941 36 L +578.019 36 L +578.096 36 L +578.174 36 L +578.252 36 L +578.33 36 L +578.407 36 L +578.485 36 L +578.563 36 L +578.641 36 L +578.718 36 L +578.796 36 L +578.874 36 L +578.952 36 L +579.029 36 L +579.107 36 L +579.185 36 L +579.263 36 L +579.34 36 L +579.418 36 L +579.496 36 L +579.573 36 L +579.651 36 L +579.729 36 L +579.807 36 L +579.884 36 L +579.962 36 L +580.04 36 L +580.118 36 L +580.195 36 L +580.273 36 L +580.351 36 L +580.429 36 L +580.506 36 L +580.584 36 L +580.662 36 L +580.739 36 L +580.817 36 L +580.895 36 L +580.973 36 L +581.05 36 L +581.128 36 L +581.206 36 L +581.284 36 L +581.361 36 L +581.439 36 L +581.517 36 L +581.595 36 L +581.672 36 L +581.75 36 L +581.828 36 L +581.905 36 L +581.983 36 L +582.061 36 L +582.139 36 L +582.216 36 L +582.294 36 L +582.372 36 L +582.45 36 L +582.527 36 L +582.605 36 L +582.683 36 L +582.761 36 L +582.838 36 L +582.916 36 L +582.994 36 L +583.071 36 L +583.149 36 L +583.227 36 L +583.305 36 L +583.382 36 L +583.46 36 L +583.538 36 L +583.616 36 L +583.693 36 L +583.771 36 L +583.849 36 L +583.927 36 L +584.004 36 L +584.082 36 L +584.16 36 L +584.237 36 L +584.315 36 L +584.393 36 L +584.471 36 L +584.548 36 L +584.626 36 L +584.704 36 L +584.782 36 L +584.859 36 L +584.937 36 L +585.015 36 L +585.093 36 L +585.17 36 L +585.248 36 L +585.326 36 L +585.404 36 L +585.481 36 L +585.559 36 L +585.637 36 L +585.714 36 L +585.792 36 L +585.87 36 L +585.948 36 L +586.025 36 L +586.103 36 L +586.181 36 L +586.259 36 L +586.336 36 L +586.414 36 L +586.492 36 L +586.57 36 L +586.647 36 L +586.725 36 L +586.803 36 L +586.88 36 L +586.958 36 L +587.036 36 L +587.114 36 L +587.191 36 L +587.269 36 L +587.347 36 L +587.425 36 L +587.502 36 L +587.58 36 L +587.658 36 L +587.736 36 L +587.813 36 L +587.891 36 L +587.969 36 L +588.047 36 L +588.124 36 L +588.202 36 L +588.28 36 L +588.357 36 L +588.435 36 L +588.513 36 L +588.591 36 L +588.668 36 L +588.746 36 L +588.824 36 L +588.902 36 L +588.979 36 L +589.057 36 L +589.135 36 L +589.213 36 L +589.29 36 L +589.368 36 L +589.446 36 L +589.523 36 L +589.601 36 L +589.679 36 L +589.757 36 L +589.834 36 L +589.912 36 L +589.99 36 L +590.068 36 L +590.145 36 L +590.223 36 L +590.301 36 L +590.379 36 L +590.456 36 L +590.534 36 L +590.612 36 L +590.689 36 L +590.767 36 L +590.845 36 L +590.923 36 L +591 36 L +591.078 36 L +591.156 36 L +591.234 36 L +591.311 36 L +591.389 36 L +591.467 36 L +591.545 36 L +591.622 36 L +591.7 36 L +591.778 36 L +591.855 36 L +591.933 36 L +592.011 36 L +592.089 36 L +592.166 36 L +592.244 36 L +592.322 36 L +592.4 36 L +592.477 36 L +592.555 36 L +592.633 36 L +592.711 36 L +592.788 36 L +592.866 36 L +592.944 36 L +593.021 36 L +593.099 36 L +593.177 36 L +593.255 36 L +593.332 36 L +593.41 36 L +593.488 36 L +593.566 36 L +593.643 36 L +593.721 36 L +593.799 36 L +593.877 36 L +593.954 36 L +594.032 36 L +594.11 36 L +594.188 36 L +594.265 36 L +594.343 36 L +594.421 36 L +594.498 36 L +594.576 36 L +594.654 36 L +594.732 36 L +594.809 36 L +594.887 36 L +594.965 36 L +595.043 36 L +595.12 36 L +595.198 36 L +595.276 36 L +595.354 36 L +595.431 36 L +595.509 36 L +595.587 36 L +595.664 36 L +595.742 36 L +595.82 36 L +595.898 36 L +595.975 36 L +596.053 36 L +596.131 36 L +596.209 36 L +596.286 36 L +596.364 36 L +596.442 36 L +596.52 36 L +596.597 36 L +596.675 36 L +596.753 36 L +596.83 36 L +596.908 36 L +596.986 36 L +597.064 36 L +597.141 36 L +597.219 36 L +597.297 36 L +597.375 36 L +597.452 36 L +597.53 36 L +597.608 36 L +597.686 36 L +597.763 36 L +597.841 36 L +597.919 36 L +597.996 36 L +598.074 36 L +598.152 36 L +598.23 36 L +598.307 36 L +598.385 36 L +598.463 36 L +598.541 36 L +598.618 36 L +598.696 36 L +598.774 36 L +598.852 36 L +598.929 36 L +599.007 36 L +599.085 36 L +599.162 36 L +599.24 36 L +599.318 36 L +599.396 36 L +599.473 36 L +599.551 36 L +599.629 36 L +599.707 36 L +599.784 36 L +599.862 36 L +599.94 36 L +600.018 36 L +600.095 36 L +600.173 36 L +600.251 36 L +600.328 36 L +600.406 36 L +600.484 36 L +600.562 36 L +600.639 36 L +600.717 36 L +600.795 36 L +600.873 36 L +600.95 36 L +601.028 36 L +601.106 36 L +601.184 36 L +601.261 36 L +601.339 36 L +601.417 36 L +601.495 36 L +601.572 36 L +601.65 36 L +601.728 36 L +601.805 36 L +601.883 36 L +601.961 36 L +602.039 36 L +602.116 36 L +602.194 36 L +602.272 36 L +602.35 36 L +602.427 36 L +602.505 36 L +602.583 36 L +602.661 36 L +602.738 36 L +602.816 36 L +602.894 36 L +602.971 36 L +603.049 36 L +603.127 36 L +603.205 36 L +603.282 36 L +603.36 36 L +603.438 36 L +603.516 36 L +603.593 36 L +603.671 36 L +603.749 36 L +603.827 36 L +603.904 36 L +603.982 36 L +604.06 36 L +604.138 36 L +604.215 36 L +604.293 36 L +604.371 36 L +604.448 36 L +604.526 36 L +604.604 36 L +604.682 36 L +604.759 36 L +604.837 36 L +604.915 36 L +604.993 36 L +605.07 36 L +605.148 36 L +605.226 36 L +605.304 36 L +605.381 36 L +605.459 36 L +605.537 36 L +605.614 36 L +605.692 36 L +605.77 36 L +605.848 36 L +605.925 36 L +606.003 36 L +606.081 36 L +606.159 36 L +606.236 36 L +606.314 36 L +606.392 36 L +606.47 36 L +606.547 36 L +606.625 36 L +606.703 36 L +606.78 36 L +606.858 36 L +606.936 36 L +607.014 36 L +607.091 36 L +607.169 36 L +607.247 36 L +607.325 36 L +607.402 36 L +607.48 36 L +607.558 36 L +607.636 36 L +607.713 36 L +607.791 36 L +607.869 36 L +607.946 36 L +608.024 36 L +608.102 36 L +608.18 36 L +608.257 36 L +608.335 36 L +608.413 36 L +608.491 36 L +608.568 36 L +608.646 36 L +608.724 36 L +608.802 36 L +608.879 36 L +608.957 36 L +609.035 36 L +609.112 36 L +609.19 36 L +609.268 36 L +609.346 36 L +609.423 36 L +609.501 36 L +609.579 36 L +609.657 36 L +609.734 36 L +609.812 36 L +609.89 36 L +609.968 36 L +610.045 36 L +610.123 36 L +610.201 36 L +610.279 36 L +610.356 36 L +610.434 36 L +610.512 36 L +610.589 36 L +610.667 36 L +610.745 36 L +610.823 36 L +610.9 36 L +610.978 36 L +611.056 36 L +611.134 36 L +611.211 36 L +611.289 36 L +611.367 36 L +611.445 36 L +611.522 36 L +611.6 36 L +611.678 425 L +611.755 425 L +611.833 425 L +611.911 425 L +611.989 425 L +612.066 425 L +612.144 425 L +612.222 425 L +612.3 425 L +612.377 425 L +612.455 425 L +612.533 425 L +612.611 425 L +612.688 425 L +612.766 425 L +612.844 425 L +612.922 425 L +612.999 425 L +613.077 425 L +613.155 425 L +613.232 425 L +613.31 425 L +613.388 425 L +613.466 425 L +613.543 425 L +613.621 425 L +613.699 425 L +613.777 425 L +613.854 425 L +613.932 425 L +614.01 425 L +614.088 425 L +614.165 425 L +614.243 425 L +614.321 425 L +614.398 425 L +614.476 425 L +614.554 425 L +614.632 425 L +614.709 425 L +614.787 425 L +614.865 425 L +614.943 425 L +615.02 425 L +615.098 425 L +615.176 425 L +615.254 425 L +615.331 425 L +615.409 425 L +615.487 425 L +615.564 425 L +615.642 425 L +615.72 425 L +615.798 425 L +615.875 425 L +615.953 425 L +616.031 425 L +616.109 425 L +616.186 425 L +616.264 425 L +616.342 425 L +616.42 425 L +616.497 425 L +616.575 425 L +616.653 425 L +616.73 425 L +616.808 425 L +616.886 425 L +616.964 425 L +617.041 425 L +617.119 425 L +617.197 425 L +617.275 425 L +617.352 425 L +617.43 425 L +617.508 425 L +617.586 425 L +617.663 425 L +617.741 425 L +617.819 425 L +617.896 425 L +617.974 425 L +618.052 425 L +618.13 425 L +618.207 425 L +618.285 425 L +618.363 425 L +618.441 425 L +618.518 425 L +618.596 425 L +618.674 425 L +618.752 425 L +618.829 425 L +618.907 425 L +618.985 425 L +619.063 425 L +619.14 425 L +619.218 425 L +619.296 425 L +619.373 425 L +619.451 425 L +619.529 425 L +619.607 425 L +619.684 425 L +619.762 425 L +619.84 425 L +619.918 425 L +619.995 425 L +620.073 425 L +620.151 425 L +620.229 425 L +620.306 425 L +620.384 425 L +620.462 425 L +620.539 425 L +620.617 425 L +620.695 425 L +620.773 425 L +620.85 425 L +620.928 425 L +621.006 425 L +621.084 425 L +621.161 425 L +621.239 425 L +621.317 425 L +621.395 425 L +621.472 425 L +621.55 425 L +621.628 425 L +621.705 425 L +621.783 425 L +621.861 425 L +621.939 425 L +622.016 425 L +622.094 425 L +622.172 425 L +622.25 425 L +622.327 425 L +622.405 425 L +622.483 425 L +622.561 425 L +622.638 425 L +622.716 425 L +622.794 425 L +622.871 425 L +622.949 425 L +623.027 425 L +623.105 425 L +623.182 425 L +623.26 425 L +623.338 425 L +623.416 425 L +623.493 425 L +623.571 425 L +623.649 425 L +623.727 425 L +623.804 425 L +623.882 425 L +623.96 425 L +624.037 425 L +624.115 425 L +624.193 425 L +624.271 425 L +624.348 425 L +624.426 425 L +624.504 425 L +624.582 425 L +624.659 425 L +624.737 425 L +624.815 425 L +624.893 425 L +624.97 425 L +625.048 425 L +625.126 425 L +625.203 425 L +625.281 425 L +625.359 425 L +625.437 425 L +625.514 425 L +625.592 425 L +625.67 425 L +625.748 425 L +625.825 425 L +625.903 425 L +625.981 425 L +626.059 425 L +626.136 425 L +626.214 425 L +626.292 425 L +626.37 425 L +626.447 425 L +626.525 425 L +626.603 425 L +626.68 425 L +626.758 425 L +626.836 425 L +626.914 425 L +626.991 425 L +627.069 425 L +627.147 425 L +627.225 425 L +627.302 425 L +627.38 425 L +627.458 425 L +627.536 425 L +627.613 425 L +627.691 425 L +627.769 425 L +627.846 425 L +627.924 425 L +628.002 425 L +628.08 425 L +628.157 425 L +628.235 425 L +628.313 425 L +628.391 425 L +628.468 425 L +628.546 425 L +628.624 425 L +628.702 425 L +628.779 425 L +628.857 425 L +628.935 425 L +629.013 425 L +629.09 425 L +629.168 425 L +629.246 425 L +629.323 425 L +629.401 425 L +629.479 425 L +629.557 425 L +629.634 425 L +629.712 425 L +629.79 425 L +629.868 425 L +629.945 425 L +630.023 425 L +630.101 425 L +630.179 425 L +630.256 425 L +630.334 425 L +630.412 425 L +630.489 425 L +630.567 425 L +630.645 425 L +630.723 425 L +630.8 425 L +630.878 425 L +630.956 425 L +631.034 425 L +631.111 425 L +631.189 425 L +631.267 425 L +631.345 425 L +631.422 425 L +631.5 425 L +631.578 425 L +631.655 425 L +631.733 425 L +631.811 425 L +631.889 425 L +631.966 425 L +632.044 425 L +632.122 425 L +632.2 425 L +632.277 425 L +632.355 425 L +632.433 425 L +632.511 425 L +632.588 425 L +632.666 425 L +632.744 425 L +632.821 425 L +632.899 425 L +632.977 425 L +633.055 425 L +633.132 425 L +633.21 425 L +633.288 425 L +633.366 425 L +633.443 425 L +633.521 425 L +633.599 425 L +633.677 425 L +633.754 425 L +633.832 425 L +633.91 425 L +633.987 425 L +634.065 425 L +634.143 425 L +634.221 425 L +634.298 425 L +634.376 425 L +634.454 425 L +634.532 425 L +634.609 425 L +634.687 425 L +634.765 425 L +634.843 425 L +634.92 425 L +634.998 425 L +635.076 425 L +635.154 425 L +635.231 425 L +635.309 425 L +635.387 425 L +635.464 425 L +635.542 425 L +635.62 425 L +635.698 425 L +635.775 425 L +635.853 425 L +635.931 425 L +636.009 425 L +636.086 425 L +636.164 425 L +636.242 425 L +636.32 425 L +636.397 425 L +636.475 425 L +636.553 425 L +636.63 425 L +636.708 425 L +636.786 425 L +636.864 425 L +636.941 425 L +637.019 425 L +637.097 425 L +637.175 425 L +637.252 425 L +637.33 425 L +637.408 425 L +637.486 425 L +637.563 425 L +637.641 425 L +637.719 425 L +637.797 425 L +637.874 425 L +637.952 425 L +638.03 425 L +638.107 425 L +638.185 425 L +638.263 425 L +638.341 425 L +638.418 425 L +638.496 425 L +638.574 425 L +638.652 425 L +638.729 425 L +638.807 425 L +638.885 425 L +638.963 425 L +639.04 425 L +639.118 425 L +639.196 425 L +639.273 425 L +639.351 425 L +639.429 425 L +639.507 425 L +639.584 425 L +639.662 425 L +639.74 425 L +639.818 425 L +639.895 425 L +639.973 425 L +640.051 425 L +640.129 425 L +640.206 425 L +640.284 425 L +640.362 425 L +640.439 425 L +640.517 425 L +640.595 425 L +640.673 425 L +640.75 425 L +640.828 425 L +640.906 425 L +640.984 425 L +641.061 425 L +641.139 425 L +641.217 425 L +641.295 425 L +641.372 425 L +641.45 425 L +641.528 425 L +641.605 425 L +641.683 425 L +641.761 425 L +641.839 425 L +641.916 425 L +641.994 425 L +642.072 425 L +642.15 425 L +642.227 425 L +642.305 425 L +642.383 425 L +642.461 425 L +642.538 425 L +642.616 425 L +642.694 425 L +642.771 425 L +642.849 425 L +642.927 425 L +643.005 425 L +643.082 425 L +643.16 425 L +643.238 425 L +643.316 425 L +643.393 425 L +643.471 425 L +643.549 425 L +643.627 425 L +643.704 425 L +643.782 425 L +643.86 425 L +643.938 425 L +644.015 425 L +644.093 425 L +644.171 425 L +644.248 425 L +644.326 425 L +644.404 425 L +644.482 425 L +644.559 425 L +644.637 425 L +644.715 425 L +644.793 425 L +644.87 425 L +644.948 425 L +645.026 425 L +645.104 425 L +645.181 425 L +645.259 425 L +645.337 425 L +645.414 425 L +645.492 425 L +645.57 425 L +645.648 425 L +645.725 425 L +645.803 425 L +645.881 425 L +645.959 425 L +646.036 425 L +646.114 425 L +646.192 425 L +646.27 425 L +646.347 425 L +646.425 425 L +646.503 425 L +646.58 425 L +646.658 425 L +646.736 425 L +646.814 425 L +646.891 425 L +646.969 425 L +647.047 425 L +647.125 425 L +647.202 425 L +647.28 425 L +647.358 425 L +647.436 425 L +647.513 425 L +647.591 425 L +647.669 425 L +647.746 425 L +647.824 425 L +647.902 425 L +647.98 425 L +648.057 425 L +648.135 425 L +648.213 425 L +648.291 425 L +648.368 425 L +648.446 425 L +648.524 425 L +648.602 425 L +648.679 425 L +648.757 425 L +648.835 425 L +648.912 425 L +648.99 425 L +649.068 425 L +649.146 425 L +649.223 425 L +649.301 425 L +649.379 425 L +649.457 425 L +649.534 425 L +649.612 425 L +649.69 425 L +649.768 425 L +649.845 425 L +649.923 425 L +650.001 425 L +650.078 425 L +650.156 425 L +650.234 425 L +650.312 425 L +650.389 425 L +650.467 425 L +650.545 425 L +650.623 425 L +650.7 425 L +650.778 425 L +650.856 425 L +650.934 425 L +651.011 425 L +651.089 425 L +651.167 425 L +651.245 425 L +651.322 425 L +651.4 425 L +651.478 425 L +651.555 425 L +651.633 425 L +651.711 425 L +651.789 425 L +651.866 425 L +651.944 425 L +652.022 425 L +652.1 425 L +652.177 425 L +652.255 425 L +652.333 425 L +652.411 425 L +652.488 425 L +652.566 425 L +652.644 425 L +652.721 425 L +652.799 425 L +652.877 425 L +652.955 425 L +653.032 425 L +653.11 425 L +653.188 425 L +653.266 425 L +653.343 425 L +653.421 425 L +653.499 425 L +653.577 425 L +653.654 425 L +653.732 425 L +653.81 425 L +653.888 425 L +653.965 425 L +654.043 425 L +654.121 425 L +654.198 425 L +654.276 425 L +654.354 425 L +654.432 425 L +654.509 425 L +654.587 425 L +654.665 425 L +654.743 425 L +654.82 425 L +654.898 425 L +654.976 425 L +655.054 425 L +655.131 425 L +655.209 425 L +655.287 425 L +655.364 425 L +655.442 425 L +655.52 425 L +655.598 425 L +655.675 425 L +655.753 425 L +655.831 425 L +655.909 425 L +655.986 425 L +656.064 425 L +656.142 425 L +656.22 425 L +656.297 425 L +656.375 425 L +656.453 425 L +656.53 425 L +656.608 425 L +656.686 425 L +656.764 425 L +656.841 425 L +656.919 425 L +656.997 425 L +657.075 425 L +657.152 425 L +657.23 425 L +657.308 425 L +657.386 425 L +657.463 425 L +657.541 425 L +657.619 425 L +657.696 425 L +657.774 425 L +657.852 425 L +657.93 425 L +658.007 425 L +658.085 425 L +658.163 425 L +658.241 425 L +658.318 425 L +658.396 425 L +658.474 425 L +658.552 425 L +658.629 425 L +658.707 425 L +658.785 425 L +658.862 425 L +658.94 425 L +659.018 425 L +659.096 425 L +659.173 425 L +659.251 425 L +659.329 425 L +659.407 425 L +659.484 425 L +659.562 425 L +659.64 425 L +659.718 425 L +659.795 425 L +659.873 425 L +659.951 425 L +660.029 425 L +660.106 425 L +660.184 425 L +660.262 425 L +660.339 425 L +660.417 425 L +660.495 425 L +660.573 425 L +660.65 425 L +660.728 425 L +660.806 425 L +660.884 425 L +660.961 425 L +661.039 425 L +661.117 425 L +661.195 425 L +661.272 425 L +661.35 425 L +661.428 425 L +661.505 425 L +661.583 425 L +661.661 425 L +661.739 425 L +661.816 425 L +661.894 425 L +661.972 425 L +662.05 425 L +662.127 425 L +662.205 425 L +662.283 425 L +662.361 425 L +662.438 425 L +662.516 425 L +662.594 425 L +662.672 425 L +662.749 425 L +662.827 425 L +662.905 425 L +662.982 425 L +663.06 425 L +663.138 425 L +663.216 425 L +663.293 425 L +663.371 425 L +663.449 425 L +663.527 425 L +663.604 425 L +663.682 425 L +663.76 425 L +663.838 425 L +663.915 425 L +663.993 425 L +664.071 425 L +664.148 425 L +664.226 425 L +664.304 425 L +664.382 425 L +664.459 425 L +664.537 425 L +664.615 425 L +664.693 425 L +664.77 425 L +664.848 425 L +664.926 425 L +665.004 425 L +665.081 425 L +665.159 425 L +665.237 425 L +665.314 425 L +665.392 425 L +665.47 425 L +665.548 425 L +665.625 425 L +665.703 425 L +665.781 425 L +665.859 425 L +665.936 425 L +666.014 425 L +666.092 425 L +666.17 425 L +666.247 425 L +666.325 425 L +666.403 425 L +666.48 425 L +666.558 425 L +666.636 425 L +666.714 425 L +666.791 425 L +666.869 425 L +666.947 425 L +667.025 425 L +667.102 425 L +667.18 425 L +667.258 425 L +667.336 425 L +667.413 425 L +667.491 425 L +667.569 425 L +667.646 425 L +667.724 425 L +667.802 425 L +667.88 425 L +667.957 425 L +668.035 425 L +668.113 425 L +668.191 425 L +668.268 425 L +668.346 425 L +668.424 425 L +668.502 425 L +668.579 425 L +668.657 425 L +668.735 425 L +668.813 425 L +668.89 425 L +668.968 425 L +669.046 425 L +669.123 425 L +669.201 425 L +669.279 425 L +669.357 425 L +669.434 425 L +669.512 425 L +669.59 425 L +669.668 425 L +669.745 425 L +669.823 425 L +669.901 425 L +669.979 425 L +670.056 425 L +670.134 425 L +670.212 425 L +670.289 425 L +670.367 425 L +670.445 425 L +670.523 425 L +670.6 425 L +670.678 425 L +670.756 425 L +670.834 425 L +670.911 425 L +670.989 425 L +671.067 425 L +671.145 425 L +671.222 425 L +671.3 425 L +671.378 425 L +671.455 425 L +671.533 425 L +671.611 425 L +671.689 425 L +671.766 425 L +671.844 425 L +671.922 425 L +672 425 L +672.077 425 L +672.155 425 L +672.233 425 L +672.311 425 L +672.388 425 L +672.466 425 L +672.544 425 L +672.621 425 L +672.699 425 L +672.777 425 L +672.855 425 L +672.932 425 L +673.01 425 L +673.088 425 L +673.166 425 L +673.243 425 L +673.321 425 L +673.399 425 L +673.477 425 L +673.554 425 L +673.632 425 L +673.71 425 L +673.787 425 L +673.865 425 L +673.943 425 L +674.021 425 L +674.098 425 L +674.176 425 L +674.254 425 L +674.332 425 L +674.409 425 L +674.487 425 L +674.565 425 L +674.643 425 L +674.72 425 L +674.798 425 L +674.876 425 L +674.953 425 L +675.031 425 L +675.109 425 L +675.187 425 L +675.264 425 L +675.342 425 L +675.42 425 L +675.498 425 L +675.575 425 L +675.653 425 L +675.731 425 L +675.809 425 L +675.886 425 L +675.964 425 L +676.042 425 L +676.12 425 L +676.197 425 L +676.275 425 L +676.353 425 L +676.43 425 L +676.508 425 L +676.586 425 L +676.664 425 L +676.741 425 L +676.819 425 L +676.897 425 L +676.975 425 L +677.052 425 L +677.13 425 L +677.208 425 L +677.286 425 L +677.363 425 L +677.441 425 L +677.519 425 L +677.596 425 L +677.674 425 L +677.752 425 L +677.83 425 L +677.907 425 L +677.985 425 L +678.063 425 L +678.141 425 L +678.218 425 L +678.296 425 L +678.374 425 L +678.452 425 L +678.529 425 L +678.607 425 L +678.685 425 L +678.763 425 L +678.84 425 L +678.918 425 L +678.996 425 L +679.073 425 L +679.151 425 L +679.229 425 L +679.307 425 L +679.384 425 L +679.462 425 L +679.54 425 L +679.618 425 L +679.695 425 L +679.773 425 L +679.851 425 L +679.929 425 L +680.006 425 L +680.084 425 L +680.162 425 L +680.239 425 L +680.317 425 L +680.395 425 L +680.473 425 L +680.55 425 L +680.628 425 L +680.706 425 L +680.784 425 L +680.861 425 L +680.939 425 L +681.017 425 L +681.095 425 L +681.172 425 L +681.25 425 L +681.328 425 L +681.405 425 L +681.483 425 L +681.561 425 L +681.639 425 L +681.716 425 L +681.794 425 L +681.872 425 L +681.95 425 L +682.027 425 L +682.105 425 L +682.183 425 L +682.261 425 L +682.338 425 L +682.416 425 L +682.494 425 L +682.571 425 L +682.649 425 L +682.727 425 L +682.805 425 L +682.882 425 L +682.96 425 L +683.038 425 L +683.116 425 L +683.193 425 L +683.271 425 L +683.349 425 L +683.427 425 L +683.504 425 L +683.582 425 L +683.66 425 L +683.737 425 L +683.815 425 L +683.893 425 L +683.971 425 L +684.048 425 L +684.126 425 L +684.204 425 L +684.282 425 L +684.359 425 L +684.437 425 L +684.515 425 L +684.593 425 L +684.67 425 L +684.748 425 L +684.826 425 L +684.904 425 L +684.981 425 L +685.059 425 L +685.137 425 L +685.214 425 L +685.292 425 L +685.37 425 L +685.448 425 L +685.525 425 L +685.603 425 L +685.681 425 L +685.759 425 L +685.836 425 L +685.914 425 L +685.992 425 L +686.07 425 L +686.147 425 L +686.225 425 L +686.303 425 L +686.38 425 L +686.458 425 L +686.536 425 L +686.614 425 L +686.691 425 L +686.769 425 L +686.847 425 L +686.925 425 L +687.002 425 L +687.08 425 L +687.158 425 L +687.236 425 L +687.313 425 L +687.391 425 L +687.469 425 L +687.547 425 L +687.624 425 L +687.702 425 L +687.78 425 L +687.857 425 L +687.935 425 L +688.013 425 L +688.091 425 L +688.168 425 L +688.246 425 L +688.324 425 L +688.402 425 L +688.479 425 L +688.557 425 L +688.635 425 L +688.713 425 L +688.79 425 L +688.868 425 L +688.946 425 L +689.023 425 L +689.101 425 L +689.179 425 L +689.257 425 L +689.334 425 L +689.412 425 L +689.49 425 L +689.568 425 L +689.645 425 L +689.723 425 L +689.801 425 L +689.879 425 L +689.956 425 L +690.034 425 L +690.112 425 L +690.189 425 L +690.267 425 L +690.345 425 L +690.423 425 L +690.5 425 L +690.578 425 L +690.656 425 L +690.734 425 L +690.811 425 L +690.889 425 L +690.967 425 L +691.045 425 L +691.122 425 L +691.2 425 L +691.278 425 L +691.355 425 L +691.433 425 L +691.511 425 L +691.589 425 L +691.666 425 L +691.744 425 L +691.822 425 L +691.9 425 L +691.977 425 L +692.055 425 L +692.133 425 L +692.211 425 L +692.288 425 L +692.366 425 L +692.444 425 L +692.521 425 L +692.599 425 L +692.677 425 L +692.755 425 L +692.832 425 L +692.91 425 L +692.988 425 L +693.066 425 L +693.143 425 L +693.221 425 L +693.299 425 L +693.377 425 L +693.454 425 L +693.532 425 L +693.61 425 L +693.688 425 L +693.765 425 L +693.843 425 L +693.921 425 L +693.998 425 L +694.076 425 L +694.154 425 L +694.232 425 L +694.309 425 L +694.387 425 L +694.465 425 L +694.543 425 L +694.62 425 L +694.698 425 L +694.776 425 L +694.854 425 L +694.931 425 L +695.009 425 L +695.087 425 L +695.164 425 L +695.242 425 L +695.32 425 L +695.398 425 L +695.475 425 L +695.553 425 L +695.631 425 L +695.709 425 L +695.786 425 L +695.864 425 L +695.942 425 L +696.02 425 L +696.097 425 L +696.175 425 L +696.253 425 L +696.33 425 L +696.408 425 L +696.486 425 L +696.564 425 L +696.641 425 L +696.719 425 L +696.797 425 L +696.875 425 L +696.952 425 L +697.03 425 L +697.108 425 L +697.186 425 L +697.263 425 L +697.341 425 L +697.419 425 L +697.496 425 L +697.574 425 L +697.652 425 L +697.73 425 L +697.807 425 L +697.885 425 L +697.963 425 L +698.041 425 L +698.118 425 L +698.196 425 L +698.274 425 L +698.352 425 L +698.429 425 L +698.507 425 L +698.585 425 L +698.662 425 L +698.74 425 L +698.818 425 L +698.896 425 L +698.973 425 L +699.051 425 L +699.129 425 L +699.207 425 L +699.284 425 L +699.362 425 L +699.44 425 L +699.518 425 L +699.595 425 L +699.673 425 L +699.751 425 L +699.828 425 L +699.906 425 L +699.984 425 L +700.062 425 L +700.139 425 L +700.217 425 L +700.295 425 L +700.373 425 L +700.45 425 L +700.528 425 L +700.606 425 L +700.684 425 L +700.761 425 L +700.839 425 L +700.917 425 L +700.995 425 L +701.072 425 L +701.15 425 L +701.228 425 L +701.305 425 L +701.383 425 L +701.461 425 L +701.539 425 L +701.616 425 L +701.694 425 L +701.772 425 L +701.85 425 L +701.927 425 L +702.005 425 L +702.083 425 L +702.161 425 L +702.238 425 L +702.316 425 L +702.394 425 L +702.471 425 L +702.549 425 L +702.627 425 L +702.705 425 L +702.782 425 L +702.86 425 L +702.938 425 L +703.016 425 L +703.093 425 L +703.171 425 L +703.249 425 L +703.327 425 L +703.404 425 L +703.482 425 L +703.56 425 L +703.638 425 L +703.715 425 L +703.793 425 L +703.871 425 L +703.948 425 L +704.026 425 L +704.104 425 L +704.182 425 L +704.259 425 L +704.337 425 L +704.415 425 L +704.493 425 L +704.57 425 L +704.648 425 L +704.726 425 L +704.804 425 L +704.881 425 L +704.959 425 L +705.037 425 L +705.114 425 L +705.192 425 L +705.27 425 L +705.348 425 L +705.425 425 L +705.503 425 L +705.581 425 L +705.659 425 L +705.736 425 L +705.814 425 L +705.892 425 L +705.97 425 L +706.047 425 L +706.125 425 L +706.203 425 L +706.28 425 L +706.358 425 L +706.436 425 L +706.514 425 L +706.591 425 L +706.669 425 L +706.747 425 L +706.825 425 L +706.902 425 L +706.98 425 L +707.058 425 L +707.136 425 L +707.213 425 L +707.291 425 L +707.369 425 L +707.446 425 L +707.524 425 L +707.602 425 L +707.68 425 L +707.757 425 L +707.835 425 L +707.913 425 L +707.991 425 L +708.068 425 L +708.146 425 L +708.224 425 L +708.302 425 L +708.379 425 L +708.457 425 L +708.535 425 L +708.612 425 L +708.69 425 L +708.768 425 L +708.846 425 L +708.923 425 L +709.001 425 L +709.079 425 L +709.157 425 L +709.234 425 L +709.312 425 L +709.39 425 L +709.468 425 L +709.545 425 L +709.623 425 L +709.701 425 L +709.779 425 L +709.856 425 L +709.934 425 L +710.012 425 L +710.089 425 L +710.167 425 L +710.245 425 L +710.323 425 L +710.4 425 L +710.478 425 L +710.556 425 L +710.634 425 L +710.711 425 L +710.789 425 L +710.867 425 L +710.945 425 L +711.022 425 L +711.1 425 L +711.178 425 L +711.255 425 L +711.333 425 L +711.411 425 L +711.489 425 L +711.566 425 L +711.644 425 L +711.722 425 L +711.8 425 L +711.877 425 L +711.955 425 L +712.033 425 L +712.111 425 L +712.188 425 L +712.266 425 L +712.344 425 L +712.422 425 L +712.499 425 L +712.577 425 L +712.655 425 L +712.732 425 L +712.81 425 L +712.888 425 L +712.966 425 L +713.043 425 L +713.121 425 L +713.199 425 L +713.277 425 L +713.354 425 L +713.432 425 L +713.51 425 L +713.588 425 L +713.665 425 L +713.743 425 L +713.821 425 L +713.898 425 L +713.976 425 L +714.054 425 L +714.132 425 L +714.209 425 L +714.287 425 L +714.365 425 L +714.443 425 L +714.52 425 L +714.598 425 L +714.676 425 L +714.754 425 L +714.831 425 L +714.909 425 L +714.987 425 L +715.064 425 L +715.142 425 L +715.22 425 L +715.298 425 L +715.375 425 L +715.453 425 L +715.531 425 L +715.609 425 L +715.686 425 L +715.764 425 L +715.842 425 L +715.92 425 L +715.997 425 L +716.075 425 L +716.153 425 L +716.23 425 L +716.308 425 L +716.386 425 L +716.464 425 L +716.541 425 L +716.619 425 L +716.697 425 L +716.775 425 L +716.852 425 L +716.93 425 L +717.008 425 L +717.086 425 L +717.163 425 L +717.241 425 L +717.319 425 L +717.396 425 L +717.474 425 L +717.552 425 L +717.63 425 L +717.707 425 L +717.785 425 L +717.863 425 L +717.941 425 L +718.018 425 L +718.096 425 L +718.174 425 L +718.252 425 L +718.329 425 L +718.407 425 L +718.485 425 L +718.563 425 L +718.64 425 L +718.718 425 L +718.796 425 L +718.873 425 L +718.951 425 L +719.029 425 L +719.107 425 L +719.184 425 L +719.262 425 L +719.34 425 L +719.418 425 L +719.495 425 L +719.573 425 L +719.651 425 L +719.729 425 L +719.806 425 L +719.884 425 L +719.962 425 L +720.039 425 L +720.117 425 L +720.195 425 L +720.273 425 L +720.35 425 L +720.428 425 L +720.506 425 L +720.584 425 L +720.661 425 L +720.739 425 L +720.817 425 L +720.895 425 L +720.972 425 L +721.05 425 L +721.128 425 L +721.205 425 L +721.283 425 L +721.361 425 L +721.439 425 L +721.516 425 L +721.594 425 L +721.672 425 L +721.75 425 L +721.827 425 L +721.905 425 L +721.983 425 L +722.061 425 L +722.138 425 L +722.216 425 L +722.294 425 L +722.371 425 L +722.449 425 L +722.527 425 L +722.605 425 L +722.682 425 L +722.76 425 L +722.838 425 L +722.916 425 L +722.993 425 L +723.071 425 L +723.149 425 L +723.227 425 L +723.304 425 L +723.382 425 L +723.46 425 L +723.537 425 L +723.615 425 L +723.693 425 L +723.771 425 L +723.848 425 L +723.926 425 L +724.004 425 L +724.082 425 L +724.159 425 L +724.237 425 L +724.315 425 L +724.393 425 L +724.47 425 L +724.548 425 L +724.626 425 L +724.703 425 L +724.781 425 L +724.859 425 L +724.937 425 L +725.014 425 L +725.092 425 L +725.17 425 L +725.248 425 L +725.325 425 L +725.403 425 L +725.481 425 L +725.559 425 L +725.636 425 L +725.714 425 L +725.792 425 L +725.87 425 L +725.947 425 L +726.025 425 L +726.103 425 L +726.18 425 L +726.258 425 L +726.336 425 L +726.414 425 L +726.491 425 L +726.569 425 L +726.647 425 L +726.725 425 L +726.802 425 L +726.88 425 L +726.958 425 L +727.036 425 L +727.113 425 L +727.191 425 L +727.269 425 L +727.346 425 L +727.424 425 L +727.502 425 L +727.58 425 L +727.657 425 L +727.735 425 L +727.813 425 L +727.891 425 L +727.968 425 L +728.046 425 L +728.124 425 L +728.202 425 L +728.279 425 L +728.357 425 L +728.435 425 L +728.513 425 L +728.59 425 L +728.668 425 L +728.746 425 L +728.823 425 L +728.901 425 L +728.979 425 L +729.057 425 L +729.134 425 L +729.212 425 L +729.29 425 L +729.368 425 L +729.445 425 L +729.523 425 L +729.601 425 L +729.679 425 L +729.756 425 L +729.834 425 L +729.912 425 L +729.989 425 L +730.067 425 L +730.145 425 L +730.223 425 L +730.3 425 L +730.378 425 L +730.456 425 L +730.534 425 L +730.611 425 L +730.689 425 L +730.767 425 L +730.845 425 L +730.922 425 L +731 425 L +731.078 425 L +731.155 425 L +731.233 425 L +731.311 425 L +731.389 425 L +731.466 425 L +731.544 425 L +731.622 425 L +731.7 425 L +731.777 425 L +731.855 425 L +731.933 425 L +732.011 425 L +732.088 425 L +732.166 425 L +732.244 425 L +732.321 425 L +732.399 425 L +732.477 425 L +732.555 425 L +732.632 425 L +732.71 425 L +732.788 425 L +732.866 425 L +732.943 425 L +733.021 425 L +733.099 425 L +733.177 425 L +733.254 425 L +733.332 425 L +733.41 425 L +733.487 425 L +733.565 425 L +733.643 425 L +733.721 425 L +733.798 425 L +733.876 425 L +733.954 425 L +734.032 425 L +734.109 425 L +734.187 425 L +734.265 425 L +734.343 425 L +734.42 425 L +734.498 425 L +734.576 425 L +734.654 425 L +734.731 425 L +734.809 425 L +734.887 425 L +734.964 425 L +735.042 425 L +735.12 425 L +735.198 425 L +735.275 425 L +735.353 425 L +735.431 425 L +735.509 425 L +735.586 425 L +735.664 425 L +735.742 425 L +735.82 425 L +735.897 425 L +735.975 425 L +736.053 425 L +736.13 425 L +736.208 425 L +736.286 425 L +736.364 425 L +736.441 425 L +736.519 425 L +736.597 425 L +736.675 425 L +736.752 425 L +736.83 425 L +736.908 425 L +736.986 425 L +737.063 425 L +737.141 425 L +737.219 425 L +737.297 425 L +737.374 425 L +737.452 425 L +737.53 425 L +737.607 425 L +737.685 425 L +737.763 425 L +737.841 425 L +737.918 425 L +737.996 425 L +738.074 425 L +738.152 425 L +738.229 425 L +738.307 425 L +738.385 425 L +738.463 425 L +738.54 425 L +738.618 425 L +738.696 425 L +738.773 425 L +738.851 425 L +738.929 425 L +739.007 425 L +739.084 425 L +739.162 425 L +739.24 425 L +739.318 425 L +739.395 425 L +739.473 425 L +739.551 425 L +739.629 425 L +739.706 425 L +739.784 425 L +739.862 425 L +739.939 425 L +740.017 425 L +740.095 425 L +740.173 425 L +740.25 425 L +740.328 425 L +740.406 425 L +740.484 425 L +740.561 425 L +740.639 425 L +740.717 425 L +740.795 425 L +740.872 425 L +740.95 425 L +741.028 425 L +741.105 425 L +741.183 425 L +741.261 425 L +741.339 425 L +741.416 425 L +741.494 425 L +741.572 425 L +741.65 425 L +741.727 425 L +741.805 425 L +741.883 425 L +741.961 425 L +742.038 425 L +742.116 425 L +742.194 425 L +742.271 425 L +742.349 425 L +742.427 425 L +742.505 425 L +742.582 425 L +742.66 425 L +742.738 425 L +742.816 425 L +742.893 425 L +742.971 425 L +743.049 425 L +743.127 425 L +743.204 425 L +743.282 425 L +743.36 425 L +743.438 425 L +743.515 425 L +743.593 425 L +743.671 425 L +743.748 425 L +743.826 425 L +743.904 425 L +743.982 425 L +744.059 425 L +744.137 425 L +744.215 425 L +744.293 425 L +744.37 425 L +744.448 425 L +744.526 425 L +744.604 425 L +744.681 425 L +744.759 425 L +744.837 425 L +744.914 425 L +744.992 425 L +745.07 425 L +745.148 425 L +745.225 425 L +745.303 425 L +745.381 425 L +745.459 425 L +745.536 425 L +745.614 425 L +745.692 425 L +745.77 425 L +745.847 425 L +745.925 425 L +746.003 425 L +746.08 425 L +746.158 425 L +746.236 425 L +746.314 425 L +746.391 425 L +746.469 425 L +746.547 425 L +746.625 425 L +746.702 425 L +746.78 425 L +746.858 425 L +746.936 425 L +747.013 425 L +747.091 425 L +747.169 425 L +747.246 425 L +747.324 425 L +747.402 425 L +747.48 425 L +747.557 425 L +747.635 425 L +747.713 425 L +747.791 425 L +747.868 425 L +747.946 425 L +748.024 425 L +748.102 425 L +748.179 425 L +748.257 425 L +748.335 425 L +748.412 425 L +748.49 425 L +748.568 425 L +748.646 425 L +748.723 425 L +748.801 425 L +748.879 425 L +748.957 425 L +749.034 425 L +749.112 425 L +749.19 425 L +749.268 425 L +749.345 425 L +749.423 425 L +749.501 425 L +749.578 425 L +749.656 425 L +749.734 425 L +749.812 425 L +749.889 425 L +749.967 425 L +750.045 425 L +750.123 425 L +750.2 425 L +750.278 425 L +750.356 425 L +750.434 425 L +750.511 425 L +750.589 425 L +750.667 425 L +750.745 425 L +750.822 425 L +750.9 425 L +750.978 425 L +751.055 425 L +751.133 425 L +751.211 425 L +751.289 425 L +751.366 425 L +751.444 425 L +751.522 425 L +751.6 425 L +751.677 425 L +751.755 425 L +751.833 425 L +751.911 425 L +751.988 425 L +752.066 425 L +752.144 425 L +752.221 425 L +752.299 425 L +752.377 425 L +752.455 425 L +752.532 425 L +752.61 425 L +752.688 425 L +752.766 425 L +752.843 425 L +752.921 425 L +752.999 425 L +753.077 425 L +753.154 425 L +753.232 425 L +753.31 425 L +753.388 425 L +753.465 425 L +753.543 425 L +753.621 425 L +753.698 425 L +753.776 425 L +753.854 425 L +753.932 425 L +754.009 425 L +754.087 425 L +754.165 425 L +754.243 425 L +754.32 425 L +754.398 425 L +754.476 425 L +754.554 425 L +754.631 425 L +754.709 425 L +754.787 425 L +754.864 425 L +754.942 425 L +755.02 425 L +755.098 425 L +755.175 425 L +755.253 425 L +755.331 425 L +755.409 425 L +755.486 425 L +755.564 425 L +755.642 425 L +755.72 425 L +755.797 425 L +755.875 425 L +755.953 425 L +756.03 425 L +756.108 425 L +756.186 425 L +756.264 425 L +756.341 425 L +756.419 425 L +756.497 425 L +756.575 425 L +756.652 425 L +756.73 425 L +756.808 425 L +756.886 425 L +756.963 425 L +757.041 425 L +757.119 425 L +757.196 425 L +757.274 425 L +757.352 425 L +757.43 425 L +757.507 425 L +757.585 425 L +757.663 425 L +757.741 425 L +757.818 425 L +757.896 425 L +757.974 425 L +758.052 425 L +758.129 425 L +758.207 425 L +758.285 425 L +758.362 425 L +758.44 425 L +758.518 425 L +758.596 425 L +758.673 425 L +758.751 425 L +758.829 425 L +758.907 425 L +758.984 425 L +759.062 425 L +759.14 425 L +759.218 425 L +759.295 425 L +759.373 425 L +759.451 425 L +759.529 425 L +759.606 425 L +759.684 425 L +759.762 425 L +759.839 425 L +759.917 425 L +759.995 425 L +760.073 425 L +760.15 425 L +760.228 425 L +760.306 425 L +760.384 425 L +760.461 425 L +760.539 425 L +760.617 425 L +760.695 425 L +760.772 425 L +760.85 425 L +760.928 425 L +761.005 425 L +761.083 425 L +761.161 425 L +761.239 425 L +761.316 425 L +761.394 425 L +761.472 425 L +761.55 425 L +761.627 425 L +761.705 425 L +761.783 425 L +761.861 425 L +761.938 425 L +762.016 425 L +762.094 425 L +762.172 425 L +762.249 425 L +762.327 425 L +762.405 425 L +762.482 425 L +762.56 425 L +762.638 425 L +762.716 425 L +762.793 425 L +762.871 425 L +762.949 425 L +763.027 425 L +763.104 425 L +763.182 425 L +763.26 425 L +763.338 425 L +763.415 425 L +763.493 425 L +763.571 425 L +763.648 425 L +763.726 425 L +763.804 425 L +763.882 425 L +763.959 425 L +764.037 425 L +764.115 425 L +764.193 425 L +764.27 425 L +764.348 425 L +764.426 425 L +764.504 425 L +764.581 425 L +764.659 425 L +764.737 425 L +764.814 425 L +764.892 425 L +764.97 425 L +765.048 425 L +765.125 425 L +765.203 425 L +765.281 425 L +765.359 425 L +765.436 425 L +765.514 425 L +765.592 425 L +765.67 425 L +765.747 425 L +765.825 425 L +765.903 425 L +765.98 425 L +766.058 425 L +766.136 425 L +766.214 425 L +766.291 425 L +766.369 425 L +766.447 425 L +766.525 425 L +766.602 425 L +766.68 425 L +766.758 425 L +766.836 425 L +766.913 425 L +766.991 425 L +767.069 425 L +767.146 425 L +767.224 425 L +767.302 425 L +767.38 425 L +767.457 425 L +767.535 425 L +767.613 425 L +767.691 425 L +767.768 425 L +767.846 425 L +767.924 425 L +768.002 425 L +768.079 425 L +768.157 425 L +768.235 425 L +768.313 425 L +768.39 425 L +768.468 425 L +768.546 425 L +768.623 425 L +768.701 425 L +768.779 425 L +768.857 425 L +768.934 425 L +769.012 425 L +769.09 425 L +769.168 425 L +769.245 425 L +769.323 425 L +769.401 425 L +769.479 425 L +769.556 425 L +769.634 425 L +769.712 425 L +769.789 425 L +769.867 425 L +769.945 425 L +770.023 425 L +770.1 425 L +770.178 425 L +770.256 425 L +770.334 425 L +770.411 425 L +770.489 425 L +770.567 425 L +770.645 425 L +770.722 425 L +770.8 36 L +770.878 36 L +770.955 36 L +771.033 36 L +771.111 36 L +771.189 36 L +771.266 36 L +771.344 36 L +771.422 36 L +771.5 36 L +771.577 36 L +771.655 36 L +771.733 36 L +771.811 36 L +771.888 36 L +771.966 36 L +772.044 36 L +772.121 36 L +772.199 36 L +772.277 36 L +772.355 36 L +772.432 36 L +772.51 36 L +772.588 36 L +772.666 36 L +772.743 36 L +772.821 36 L +772.899 36 L +772.977 36 L +773.054 36 L +773.132 36 L +773.21 36 L +773.287 36 L +773.365 36 L +773.443 36 L +773.521 36 L +773.598 36 L +773.676 36 L +773.754 36 L +773.832 36 L +773.909 36 L +773.987 36 L +774.065 36 L +774.143 36 L +774.22 36 L +774.298 36 L +774.376 36 L +774.453 36 L +774.531 36 L +774.609 36 L +774.687 36 L +774.764 36 L +774.842 36 L +774.92 36 L +774.998 36 L +775.075 36 L +775.153 36 L +775.231 36 L +775.309 36 L +775.386 36 L +775.464 36 L +775.542 36 L +775.62 36 L +775.697 36 L +775.775 36 L +775.853 36 L +775.93 36 L +776.008 36 L +776.086 36 L +776.164 36 L +776.241 36 L +776.319 36 L +776.397 36 L +776.475 36 L +776.552 36 L +776.63 36 L +776.708 36 L +776.786 36 L +776.863 36 L +776.941 36 L +777.019 36 L +777.096 36 L +777.174 36 L +777.252 36 L +777.33 36 L +777.407 36 L +777.485 36 L +777.563 36 L +777.641 36 L +777.718 36 L +777.796 36 L +777.874 36 L +777.952 36 L +778.029 36 L +778.107 36 L +778.185 36 L +778.263 36 L +778.34 36 L +778.418 36 L +778.496 36 L +778.573 36 L +778.651 36 L +778.729 36 L +778.807 36 L +778.884 36 L +778.962 36 L +779.04 36 L +779.118 36 L +779.195 36 L +779.273 36 L +779.351 36 L +779.429 36 L +779.506 36 L +779.584 36 L +779.662 36 L +779.739 36 L +779.817 36 L +779.895 36 L +779.973 36 L +780.05 36 L +780.128 36 L +780.206 36 L +780.284 36 L +780.361 36 L +780.439 36 L +780.517 36 L +780.595 36 L +780.672 36 L +780.75 36 L +780.828 36 L +780.905 36 L +780.983 36 L +781.061 36 L +781.139 36 L +781.216 36 L +781.294 36 L +781.372 36 L +781.45 36 L +781.527 36 L +781.605 36 L +781.683 36 L +781.761 36 L +781.838 36 L +781.916 36 L +781.994 36 L +782.071 36 L +782.149 36 L +782.227 36 L +782.305 36 L +782.382 36 L +782.46 36 L +782.538 36 L +782.616 36 L +782.693 36 L +782.771 36 L +782.849 36 L +782.927 36 L +783.004 36 L +783.082 36 L +783.16 36 L +783.237 36 L +783.315 36 L +783.393 36 L +783.471 36 L +783.548 36 L +783.626 36 L +783.704 36 L +783.782 36 L +783.859 36 L +783.937 36 L +784.015 36 L +784.093 36 L +784.17 36 L +784.248 36 L +784.326 36 L +784.404 36 L +784.481 36 L +784.559 36 L +784.637 36 L +784.714 36 L +784.792 36 L +784.87 36 L +784.948 36 L +785.025 36 L +785.103 36 L +785.181 36 L +785.259 36 L +785.336 36 L +785.414 36 L +785.492 36 L +785.57 36 L +785.647 36 L +785.725 36 L +785.803 36 L +785.88 36 L +785.958 36 L +786.036 36 L +786.114 36 L +786.191 36 L +786.269 36 L +786.347 36 L +786.425 36 L +786.502 36 L +786.58 36 L +786.658 36 L +786.736 36 L +786.813 36 L +786.891 36 L +786.969 36 L +787.047 36 L +787.124 36 L +787.202 36 L +787.28 36 L +787.357 36 L +787.435 36 L +787.513 36 L +787.591 36 L +787.668 36 L +787.746 36 L +787.824 36 L +787.902 36 L +787.979 36 L +788.057 36 L +788.135 36 L +788.213 36 L +788.29 36 L +788.368 36 L +788.446 36 L +788.523 36 L +788.601 36 L +788.679 36 L +788.757 36 L +788.834 36 L +788.912 36 L +788.99 36 L +789.068 36 L +789.145 36 L +789.223 36 L +789.301 36 L +789.379 36 L +789.456 36 L +789.534 36 L +789.612 36 L +789.689 36 L +789.767 36 L +789.845 36 L +789.923 36 L +790 36 L +790.078 36 L +790.156 36 L +790.234 36 L +790.311 36 L +790.389 36 L +790.467 36 L +790.545 36 L +790.622 36 L +790.7 36 L +790.778 36 L +790.855 36 L +790.933 36 L +791.011 36 L +791.089 36 L +791.166 36 L +791.244 36 L +791.322 36 L +791.4 36 L +791.477 36 L +791.555 36 L +791.633 36 L +791.711 36 L +791.788 36 L +791.866 36 L +791.944 36 L +792.021 36 L +792.099 36 L +792.177 36 L +792.255 36 L +792.332 36 L +792.41 36 L +792.488 36 L +792.566 36 L +792.643 36 L +792.721 36 L +792.799 36 L +792.877 36 L +792.954 36 L +793.032 36 L +793.11 36 L +793.188 36 L +793.265 36 L +793.343 36 L +793.421 36 L +793.498 36 L +793.576 36 L +793.654 36 L +793.732 36 L +793.809 36 L +793.887 36 L +793.965 36 L +794.043 36 L +794.12 36 L +794.198 36 L +794.276 36 L +794.354 36 L +794.431 36 L +794.509 36 L +794.587 36 L +794.664 36 L +794.742 36 L +794.82 36 L +794.898 36 L +794.975 36 L +795.053 36 L +795.131 36 L +795.209 36 L +795.286 36 L +795.364 36 L +795.442 36 L +795.52 36 L +795.597 36 L +795.675 36 L +795.753 36 L +795.83 36 L +795.908 36 L +795.986 36 L +796.064 36 L +796.141 36 L +796.219 36 L +796.297 36 L +796.375 36 L +796.452 36 L +796.53 36 L +796.608 36 L +796.686 36 L +796.763 36 L +796.841 36 L +796.919 36 L +796.996 36 L +797.074 36 L +797.152 36 L +797.23 36 L +797.307 36 L +797.385 36 L +797.463 36 L +797.541 36 L +797.618 36 L +797.696 36 L +797.774 36 L +797.852 36 L +797.929 36 L +798.007 36 L +798.085 36 L +798.162 36 L +798.24 36 L +798.318 36 L +798.396 36 L +798.473 36 L +798.551 36 L +798.629 36 L +798.707 36 L +798.784 36 L +798.862 36 L +798.94 36 L +799.018 36 L +799.095 36 L +799.173 36 L +799.251 36 L +799.328 36 L +799.406 36 L +799.484 36 L +799.562 36 L +799.639 36 L +799.717 36 L +799.795 36 L +799.873 36 L +799.95 36 L +800.028 36 L +800.106 36 L +800.184 36 L +800.261 36 L +800.339 36 L +800.417 36 L +800.495 36 L +800.572 36 L +800.65 36 L +800.728 36 L +800.805 36 L +800.883 36 L +800.961 36 L +801.039 36 L +801.116 36 L +801.194 36 L +801.272 36 L +801.35 36 L +801.427 36 L +801.505 36 L +801.583 36 L +801.661 36 L +801.738 36 L +801.816 36 L +801.894 36 L +801.971 36 L +802.049 36 L +802.127 36 L +802.205 36 L +802.282 36 L +802.36 36 L +802.438 36 L +802.516 36 L +802.593 36 L +802.671 36 L +802.749 36 L +802.827 36 L +802.904 36 L +802.982 36 L +803.06 36 L +803.138 36 L +803.215 36 L +803.293 36 L +803.371 36 L +803.448 36 L +803.526 36 L +803.604 36 L +803.682 36 L +803.759 36 L +803.837 36 L +803.915 36 L +803.993 36 L +804.07 36 L +804.148 36 L +804.226 36 L +804.304 36 L +804.381 36 L +804.459 36 L +804.537 36 L +804.614 36 L +804.692 36 L +804.77 36 L +804.848 36 L +804.925 36 L +805.003 36 L +805.081 36 L +805.159 36 L +805.236 36 L +805.314 36 L +805.392 36 L +805.47 36 L +805.547 36 L +805.625 36 L +805.703 36 L +805.78 36 L +805.858 36 L +805.936 36 L +806.014 36 L +806.091 36 L +806.169 36 L +806.247 36 L +806.325 36 L +806.402 36 L +806.48 36 L +806.558 36 L +806.636 36 L +806.713 36 L +806.791 36 L +806.869 36 L +806.946 36 L +807.024 36 L +807.102 36 L +807.18 36 L +807.257 36 L +807.335 36 L +807.413 36 L +807.491 36 L +807.568 36 L +807.646 36 L +807.724 36 L +807.802 36 L +807.879 36 L +807.957 36 L +808.035 36 L +808.112 36 L +808.19 36 L +808.268 36 L +808.346 36 L +808.423 36 L +808.501 36 L +808.579 36 L +808.657 36 L +808.734 36 L +808.812 36 L +808.89 36 L +808.968 36 L +809.045 36 L +809.123 36 L +809.201 36 L +809.279 36 L +809.356 36 L +809.434 36 L +809.512 36 L +809.589 36 L +809.667 36 L +809.745 36 L +809.823 36 L +809.9 36 L +809.978 36 L +810.056 36 L +810.134 36 L +810.211 36 L +810.289 36 L +810.367 36 L +810.445 36 L +810.522 36 L +810.6 36 L +810.678 36 L +810.755 36 L +810.833 36 L +810.911 36 L +810.989 36 L +811.066 36 L +811.144 36 L +811.222 36 L +811.3 36 L +811.377 36 L +811.455 36 L +811.533 36 L +811.611 36 L +811.688 36 L +811.766 36 L +811.844 36 L +811.922 36 L +811.999 36 L +812.077 36 L +812.155 36 L +812.232 36 L +812.31 36 L +812.388 36 L +812.466 36 L +812.543 36 L +812.621 36 L +812.699 36 L +812.777 36 L +812.854 36 L +812.932 36 L +813.01 36 L +813.088 36 L +813.165 36 L +813.243 36 L +813.321 36 L +813.398 36 L +813.476 36 L +813.554 36 L +813.632 36 L +813.709 36 L +813.787 36 L +813.865 36 L +813.943 36 L +814.02 36 L +814.098 36 L +814.176 36 L +814.254 36 L +814.331 36 L +814.409 36 L +814.487 36 L +814.564 36 L +814.642 36 L +814.72 36 L +814.798 36 L +814.875 36 L +814.953 36 L +815.031 36 L +815.109 36 L +815.186 36 L +815.264 36 L +815.342 36 L +815.42 36 L +815.497 36 L +815.575 36 L +815.653 36 L +815.73 36 L +815.808 36 L +815.886 36 L +815.964 36 L +816.041 36 L +816.119 36 L +816.197 36 L +816.275 36 L +816.352 36 L +816.43 36 L +816.508 36 L +816.586 36 L +816.663 36 L +816.741 36 L +816.819 36 L +816.896 36 L +816.974 36 L +817.052 36 L +817.13 36 L +817.207 36 L +817.285 36 L +817.363 36 L +817.441 36 L +817.518 36 L +817.596 36 L +817.674 36 L +817.752 36 L +817.829 36 L +817.907 36 L +817.985 36 L +818.063 36 L +818.14 36 L +818.218 36 L +818.296 36 L +818.373 36 L +818.451 36 L +818.529 36 L +818.607 36 L +818.684 36 L +818.762 36 L +818.84 36 L +818.918 36 L +818.995 36 L +819.073 36 L +819.151 36 L +819.229 36 L +819.306 36 L +819.384 36 L +819.462 36 L +819.539 36 L +819.617 36 L +819.695 36 L +819.773 36 L +819.85 36 L +819.928 36 L +820.006 36 L +820.084 36 L +820.161 36 L +820.239 36 L +820.317 36 L +820.395 36 L +820.472 36 L +820.55 36 L +820.628 36 L +820.705 36 L +820.783 36 L +820.861 36 L +820.939 36 L +821.016 36 L +821.094 36 L +821.172 36 L +821.25 36 L +821.327 36 L +821.405 36 L +821.483 36 L +821.561 36 L +821.638 36 L +821.716 36 L +821.794 36 L +821.871 36 L +821.949 36 L +822.027 36 L +822.105 36 L +822.182 36 L +822.26 36 L +822.338 36 L +822.416 36 L +822.493 36 L +822.571 36 L +822.649 36 L +822.727 36 L +822.804 36 L +822.882 36 L +822.96 36 L +823.037 36 L +823.115 36 L +823.193 36 L +823.271 36 L +823.348 36 L +823.426 36 L +823.504 36 L +823.582 36 L +823.659 36 L +823.737 36 L +823.815 36 L +823.893 36 L +823.97 36 L +824.048 36 L +824.126 36 L +824.203 36 L +824.281 36 L +824.359 36 L +824.437 36 L +824.514 36 L +824.592 36 L +824.67 36 L +824.748 36 L +824.825 36 L +824.903 36 L +824.981 36 L +825.059 36 L +825.136 36 L +825.214 36 L +825.292 36 L +825.37 36 L +825.447 36 L +825.525 36 L +825.603 36 L +825.68 36 L +825.758 36 L +825.836 36 L +825.914 36 L +825.991 36 L +826.069 36 L +826.147 36 L +826.225 36 L +826.302 36 L +826.38 36 L +826.458 36 L +826.536 36 L +826.613 36 L +826.691 36 L +826.769 36 L +826.846 36 L +826.924 36 L +827.002 36 L +827.08 36 L +827.157 36 L +827.235 36 L +827.313 36 L +827.391 36 L +827.468 36 L +827.546 36 L +827.624 36 L +827.702 36 L +827.779 36 L +827.857 36 L +827.935 36 L +828.013 36 L +828.09 36 L +828.168 36 L +828.246 36 L +828.323 36 L +828.401 36 L +828.479 36 L +828.557 36 L +828.634 36 L +828.712 36 L +828.79 36 L +828.868 36 L +828.945 36 L +829.023 36 L +829.101 36 L +829.179 36 L +829.256 36 L +829.334 36 L +829.412 36 L +829.489 36 L +829.567 36 L +829.645 36 L +829.723 36 L +829.8 36 L +829.878 36 L +829.956 36 L +830.034 36 L +830.111 36 L +830.189 36 L +830.267 36 L +830.345 36 L +830.422 36 L +830.5 36 L +830.578 36 L +830.655 36 L +830.733 36 L +830.811 36 L +830.889 36 L +830.966 36 L +831.044 36 L +831.122 36 L +831.2 36 L +831.277 36 L +831.355 36 L +831.433 36 L +831.511 36 L +831.588 36 L +831.666 36 L +831.744 36 L +831.821 36 L +831.899 36 L +831.977 36 L +832.055 36 L +832.132 36 L +832.21 36 L +832.288 36 L +832.366 36 L +832.443 36 L +832.521 36 L +832.599 36 L +832.677 36 L +832.754 36 L +832.832 36 L +832.91 36 L +832.987 36 L +833.065 36 L +833.143 36 L +833.221 36 L +833.298 36 L +833.376 36 L +833.454 36 L +833.532 36 L +833.609 36 L +833.687 36 L +833.765 36 L +833.843 36 L +833.92 36 L +833.998 36 L +834.076 36 L +834.154 36 L +834.231 36 L +834.309 36 L +834.387 36 L +834.464 36 L +834.542 36 L +834.62 36 L +834.698 36 L +834.775 36 L +834.853 36 L +834.931 36 L +835.009 36 L +835.086 36 L +835.164 36 L +835.242 36 L +835.32 36 L +835.397 36 L +835.475 36 L +835.553 36 L +835.63 36 L +835.708 36 L +835.786 36 L +835.864 36 L +835.941 36 L +836.019 36 L +836.097 36 L +836.175 36 L +836.252 36 L +836.33 36 L +836.408 36 L +836.486 36 L +836.563 36 L +836.641 36 L +836.719 36 L +836.797 36 L +836.874 36 L +836.952 36 L +837.03 36 L +837.107 36 L +837.185 36 L +837.263 36 L +837.341 36 L +837.418 36 L +837.496 36 L +837.574 36 L +837.652 36 L +837.729 36 L +837.807 36 L +837.885 36 L +837.963 36 L +838.04 36 L +838.118 36 L +838.196 36 L +838.273 36 L +838.351 36 L +838.429 36 L +838.507 36 L +838.584 36 L +838.662 36 L +838.74 36 L +838.818 36 L +838.895 36 L +838.973 36 L +839.051 36 L +839.129 36 L +839.206 36 L +839.284 36 L +839.362 36 L +839.439 36 L +839.517 36 L +839.595 36 L +839.673 36 L +839.75 36 L +839.828 36 L +839.906 36 L +839.984 36 L +840.061 36 L +840.139 36 L +840.217 36 L +840.295 36 L +840.372 36 L +840.45 36 L +840.528 36 L +840.605 36 L +840.683 36 L +840.761 36 L +840.839 36 L +840.916 36 L +840.994 36 L +841.072 36 L +841.15 36 L +841.227 36 L +841.305 36 L +841.383 36 L +841.461 36 L +841.538 36 L +841.616 36 L +841.694 36 L +841.771 36 L +841.849 36 L +841.927 36 L +842.005 36 L +842.082 36 L +842.16 36 L +842.238 36 L +842.316 36 L +842.393 36 L +842.471 36 L +842.549 36 L +842.627 36 L +842.704 36 L +842.782 36 L +842.86 36 L +842.938 36 L +843.015 36 L +843.093 36 L +843.171 36 L +843.248 36 L +843.326 36 L +843.404 36 L +843.482 36 L +843.559 36 L +843.637 36 L +843.715 36 L +843.793 36 L +843.87 36 L +843.948 36 L +844.026 36 L +844.104 36 L +844.181 36 L +844.259 36 L +844.337 36 L +844.414 36 L +844.492 36 L +844.57 36 L +844.648 36 L +844.725 36 L +844.803 36 L +844.881 36 L +844.959 36 L +845.036 36 L +845.114 36 L +845.192 36 L +845.27 36 L +845.347 36 L +845.425 36 L +845.503 36 L +845.58 36 L +845.658 36 L +845.736 36 L +845.814 36 L +845.891 36 L +845.969 36 L +846.047 36 L +846.125 36 L +846.202 36 L +846.28 36 L +846.358 36 L +846.436 36 L +846.513 36 L +846.591 36 L +846.669 36 L +846.746 36 L +846.824 36 L +846.902 36 L +846.98 36 L +847.057 36 L +847.135 36 L +847.213 36 L +847.291 36 L +847.368 36 L +847.446 36 L +847.524 36 L +847.602 36 L +847.679 36 L +847.757 36 L +847.835 36 L +847.912 36 L +847.99 36 L +848.068 36 L +848.146 36 L +848.223 36 L +848.301 36 L +848.379 36 L +848.457 36 L +848.534 36 L +848.612 36 L +848.69 36 L +848.768 36 L +848.845 36 L +848.923 36 L +849.001 36 L +849.078 36 L +849.156 36 L +849.234 36 L +849.312 36 L +849.389 36 L +849.467 36 L +849.545 36 L +849.623 36 L +849.7 36 L +849.778 36 L +849.856 36 L +849.934 36 L +850.011 36 L +850.089 36 L +850.167 36 L +850.245 36 L +850.322 36 L +850.4 36 L +850.478 425 L +850.555 425 L +850.633 425 L +850.711 425 L +850.789 425 L +850.866 425 L +850.944 425 L +851.022 425 L +851.1 425 L +851.177 425 L +851.255 425 L +851.333 425 L +851.411 425 L +851.488 425 L +851.566 425 L +851.644 425 L +851.721 425 L +851.799 425 L +851.877 425 L +851.955 425 L +852.032 425 L +852.11 425 L +852.188 425 L +852.266 425 L +852.343 425 L +852.421 425 L +852.499 425 L +852.577 425 L +852.654 425 L +852.732 425 L +852.81 425 L +852.888 425 L +852.965 425 L +853.043 425 L +853.121 425 L +853.198 425 L +853.276 425 L +853.354 425 L +853.432 425 L +853.509 425 L +853.587 425 L +853.665 425 L +853.743 425 L +853.82 425 L +853.898 425 L +853.976 425 L +854.054 425 L +854.131 425 L +854.209 425 L +854.287 425 L +854.364 425 L +854.442 425 L +854.52 425 L +854.598 425 L +854.675 425 L +854.753 425 L +854.831 425 L +854.909 425 L +854.986 425 L +855.064 425 L +855.142 425 L +855.22 425 L +855.297 425 L +855.375 425 L +855.453 425 L +855.53 425 L +855.608 425 L +855.686 425 L +855.764 425 L +855.841 425 L +855.919 425 L +855.997 425 L +856.075 425 L +856.152 425 L +856.23 425 L +856.308 425 L +856.386 425 L +856.463 425 L +856.541 425 L +856.619 425 L +856.696 425 L +856.774 425 L +856.852 425 L +856.93 425 L +857.007 425 L +857.085 425 L +857.163 425 L +857.241 425 L +857.318 425 L +857.396 425 L +857.474 425 L +857.552 425 L +857.629 425 L +857.707 425 L +857.785 425 L +857.862 425 L +857.94 425 L +858.018 425 L +858.096 425 L +858.173 425 L +858.251 425 L +858.329 425 L +858.407 425 L +858.484 425 L +858.562 425 L +858.64 425 L +858.718 425 L +858.795 425 L +858.873 425 L +858.951 425 L +859.029 425 L +859.106 425 L +859.184 425 L +859.262 425 L +859.339 425 L +859.417 425 L +859.495 425 L +859.573 425 L +859.65 425 L +859.728 425 L +859.806 425 L +859.884 425 L +859.961 425 L +860.039 425 L +860.117 425 L +860.195 425 L +860.272 425 L +860.35 425 L +860.428 425 L +860.505 425 L +860.583 425 L +860.661 425 L +860.739 425 L +860.816 425 L +860.894 425 L +860.972 425 L +861.05 425 L +861.127 425 L +861.205 425 L +861.283 425 L +861.361 425 L +861.438 425 L +861.516 425 L +861.594 425 L +861.672 425 L +861.749 425 L +861.827 425 L +861.905 425 L +861.982 425 L +862.06 425 L +862.138 425 L +862.216 425 L +862.293 425 L +862.371 425 L +862.449 425 L +862.527 425 L +862.604 425 L +862.682 425 L +862.76 425 L +862.838 425 L +862.915 425 L +862.993 425 L +863.071 425 L +863.148 425 L +863.226 425 L +863.304 425 L +863.382 425 L +863.459 425 L +863.537 425 L +863.615 425 L +863.693 425 L +863.77 425 L +863.848 425 L +863.926 425 L +864.004 425 L +864.081 425 L +864.159 425 L +864.237 425 L +864.314 425 L +864.392 425 L +864.47 425 L +864.548 425 L +864.625 425 L +864.703 425 L +864.781 425 L +864.859 425 L +864.936 425 L +865.014 425 L +865.092 425 L +865.17 425 L +865.247 425 L +865.325 425 L +865.403 425 L +865.48 425 L +865.558 425 L +865.636 425 L +865.714 425 L +865.791 425 L +865.869 425 L +865.947 425 L +866.025 425 L +866.102 425 L +866.18 425 L +866.258 425 L +866.336 425 L +866.413 425 L +866.491 425 L +866.569 425 L +866.646 425 L +866.724 425 L +866.802 425 L +866.88 425 L +866.957 425 L +867.035 425 L +867.113 425 L +867.191 425 L +867.268 425 L +867.346 425 L +867.424 425 L +867.502 425 L +867.579 425 L +867.657 425 L +867.735 425 L +867.813 425 L +867.89 425 L +867.968 425 L +868.046 425 L +868.123 425 L +868.201 425 L +868.279 425 L +868.357 425 L +868.434 425 L +868.512 425 L +868.59 425 L +868.668 425 L +868.745 425 L +868.823 425 L +868.901 425 L +868.979 425 L +869.056 425 L +869.134 425 L +869.212 425 L +869.289 425 L +869.367 425 L +869.445 425 L +869.523 425 L +869.6 425 L +869.678 425 L +869.756 425 L +869.834 425 L +869.911 425 L +869.989 425 L +870.067 425 L +870.145 425 L +870.222 425 L +870.3 425 L +870.378 425 L +870.455 425 L +870.533 425 L +870.611 425 L +870.689 425 L +870.766 425 L +870.844 425 L +870.922 425 L +871 425 L +871.077 425 L +871.155 425 L +871.233 425 L +871.311 425 L +871.388 425 L +871.466 425 L +871.544 425 L +871.621 425 L +871.699 425 L +871.777 425 L +871.855 425 L +871.932 425 L +872.01 425 L +872.088 425 L +872.166 425 L +872.243 425 L +872.321 425 L +872.399 425 L +872.477 425 L +872.554 425 L +872.632 425 L +872.71 425 L +872.787 425 L +872.865 425 L +872.943 425 L +873.021 425 L +873.098 425 L +873.176 425 L +873.254 425 L +873.332 425 L +873.409 425 L +873.487 425 L +873.565 425 L +873.643 425 L +873.72 425 L +873.798 425 L +873.876 425 L +873.953 425 L +874.031 425 L +874.109 425 L +874.187 425 L +874.264 425 L +874.342 425 L +874.42 425 L +874.498 425 L +874.575 425 L +874.653 425 L +874.731 425 L +874.809 425 L +874.886 425 L +874.964 425 L +875.042 425 L +875.12 425 L +875.197 425 L +875.275 425 L +875.353 425 L +875.43 425 L +875.508 425 L +875.586 425 L +875.664 425 L +875.741 425 L +875.819 425 L +875.897 425 L +875.975 425 L +876.052 425 L +876.13 425 L +876.208 425 L +876.286 425 L +876.363 425 L +876.441 425 L +876.519 425 L +876.596 425 L +876.674 425 L +876.752 425 L +876.83 425 L +876.907 425 L +876.985 425 L +877.063 425 L +877.141 425 L +877.218 425 L +877.296 425 L +877.374 425 L +877.452 425 L +877.529 425 L +877.607 425 L +877.685 425 L +877.763 425 L +877.84 425 L +877.918 425 L +877.996 425 L +878.073 425 L +878.151 425 L +878.229 425 L +878.307 425 L +878.384 425 L +878.462 425 L +878.54 425 L +878.618 425 L +878.695 425 L +878.773 425 L +878.851 425 L +878.929 425 L +879.006 425 L +879.084 425 L +879.162 425 L +879.239 425 L +879.317 425 L +879.395 425 L +879.473 425 L +879.55 425 L +879.628 425 L +879.706 425 L +879.784 425 L +879.861 425 L +879.939 425 L +880.017 425 L +880.095 425 L +880.172 425 L +880.25 425 L +880.328 425 L +880.405 425 L +880.483 425 L +880.561 425 L +880.639 425 L +880.716 425 L +880.794 425 L +880.872 425 L +880.95 425 L +881.027 425 L +881.105 425 L +881.183 425 L +881.261 425 L +881.338 425 L +881.416 425 L +881.494 425 L +881.571 425 L +881.649 425 L +881.727 425 L +881.805 425 L +881.882 425 L +881.96 425 L +882.038 425 L +882.116 425 L +882.193 425 L +882.271 425 L +882.349 425 L +882.427 425 L +882.504 425 L +882.582 425 L +882.66 425 L +882.737 425 L +882.815 425 L +882.893 425 L +882.971 425 L +883.048 425 L +883.126 425 L +883.204 425 L +883.282 425 L +883.359 425 L +883.437 425 L +883.515 425 L +883.593 425 L +883.67 425 L +883.748 425 L +883.826 425 L +883.904 425 L +883.981 425 L +884.059 425 L +884.137 425 L +884.214 425 L +884.292 425 L +884.37 425 L +884.448 425 L +884.525 425 L +884.603 425 L +884.681 425 L +884.759 425 L +884.836 425 L +884.914 425 L +884.992 425 L +885.07 425 L +885.147 425 L +885.225 425 L +885.303 425 L +885.38 425 L +885.458 425 L +885.536 425 L +885.614 425 L +885.691 425 L +885.769 425 L +885.847 425 L +885.925 425 L +886.002 425 L +886.08 425 L +886.158 425 L +886.236 425 L +886.313 425 L +886.391 425 L +886.469 425 L +886.547 425 L +886.624 425 L +886.702 425 L +886.78 425 L +886.857 425 L +886.935 425 L +887.013 425 L +887.091 425 L +887.168 425 L +887.246 425 L +887.324 425 L +887.402 425 L +887.479 425 L +887.557 425 L +887.635 425 L +887.713 425 L +887.79 425 L +887.868 425 L +887.946 425 L +888.023 425 L +888.101 425 L +888.179 425 L +888.257 425 L +888.334 425 L +888.412 425 L +888.49 425 L +888.568 425 L +888.645 425 L +888.723 425 L +888.801 425 L +888.879 425 L +888.956 425 L +889.034 425 L +889.112 425 L +889.189 425 L +889.267 425 L +889.345 425 L +889.423 425 L +889.5 425 L +889.578 425 L +889.656 425 L +889.734 425 L +889.811 425 L +889.889 425 L +889.967 425 L +890.045 425 L +890.122 425 L +890.2 425 L +890.278 425 L +890.355 425 L +890.433 425 L +890.511 425 L +890.589 425 L +890.666 425 L +890.744 425 L +890.822 425 L +890.9 425 L +890.977 425 L +891.055 425 L +891.133 425 L +891.211 425 L +891.288 425 L +891.366 425 L +891.444 425 L +891.521 425 L +891.599 425 L +891.677 425 L +891.755 425 L +891.832 425 L +891.91 425 L +891.988 425 L +892.066 425 L +892.143 425 L +892.221 425 L +892.299 425 L +892.377 425 L +892.454 425 L +892.532 425 L +892.61 425 L +892.688 425 L +892.765 425 L +892.843 425 L +892.921 425 L +892.998 425 L +893.076 425 L +893.154 425 L +893.232 425 L +893.309 425 L +893.387 425 L +893.465 425 L +893.543 425 L +893.62 425 L +893.698 425 L +893.776 425 L +893.854 425 L +893.931 425 L +894.009 425 L +894.087 425 L +894.164 425 L +894.242 425 L +894.32 425 L +894.398 425 L +894.475 425 L +894.553 425 L +894.631 425 L +894.709 425 L +894.786 425 L +894.864 425 L +894.942 425 L +895.02 425 L +895.097 425 L +895.175 425 L +895.253 425 L +895.33 425 L +895.408 425 L +895.486 425 L +895.564 425 L +895.641 425 L +895.719 425 L +895.797 425 L +895.875 425 L +895.952 425 L +896.03 425 L +896.108 425 L +896.186 425 L +896.263 425 L +896.341 425 L +896.419 425 L +896.496 425 L +896.574 425 L +896.652 425 L +896.73 425 L +896.807 425 L +896.885 425 L +896.963 425 L +897.041 425 L +897.118 425 L +897.196 425 L +897.274 425 L +897.352 425 L +897.429 425 L +897.507 425 L +897.585 425 L +897.662 425 L +897.74 425 L +897.818 425 L +897.896 425 L +897.973 425 L +898.051 425 L +898.129 425 L +898.207 425 L +898.284 425 L +898.362 425 L +898.44 425 L +898.518 425 L +898.595 425 L +898.673 425 L +898.751 425 L +898.828 425 L +898.906 425 L +898.984 425 L +899.062 425 L +899.139 425 L +899.217 425 L +899.295 425 L +899.373 425 L +899.45 425 L +899.528 425 L +899.606 425 L +899.684 425 L +899.761 425 L +899.839 425 L +899.917 425 L +899.995 425 L +900.072 425 L +900.15 425 L +900.228 425 L +900.305 425 L +900.383 425 L +900.461 425 L +900.539 425 L +900.616 425 L +900.694 425 L +900.772 425 L +900.85 425 L +900.927 425 L +901.005 425 L +901.083 425 L +901.161 425 L +901.238 425 L +901.316 425 L +901.394 425 L +901.471 425 L +901.549 425 L +901.627 425 L +901.705 425 L +901.782 425 L +901.86 425 L +901.938 425 L +902.016 425 L +902.093 425 L +902.171 425 L +902.249 425 L +902.327 425 L +902.404 425 L +902.482 425 L +902.56 425 L +902.638 425 L +902.715 425 L +902.793 425 L +902.871 425 L +902.948 425 L +903.026 425 L +903.104 425 L +903.182 425 L +903.259 425 L +903.337 425 L +903.415 425 L +903.493 425 L +903.57 425 L +903.648 425 L +903.726 425 L +903.804 425 L +903.881 425 L +903.959 425 L +904.037 425 L +904.114 425 L +904.192 425 L +904.27 425 L +904.348 425 L +904.425 425 L +904.503 425 L +904.581 425 L +904.659 425 L +904.736 425 L +904.814 425 L +904.892 425 L +904.97 425 L +905.047 425 L +905.125 425 L +905.203 425 L +905.28 425 L +905.358 425 L +905.436 425 L +905.514 425 L +905.591 425 L +905.669 425 L +905.747 425 L +905.825 425 L +905.902 425 L +905.98 425 L +906.058 425 L +906.136 425 L +906.213 425 L +906.291 425 L +906.369 425 L +906.446 425 L +906.524 425 L +906.602 425 L +906.68 425 L +906.757 425 L +906.835 425 L +906.913 425 L +906.991 425 L +907.068 425 L +907.146 425 L +907.224 425 L +907.302 425 L +907.379 425 L +907.457 425 L +907.535 425 L +907.612 425 L +907.69 425 L +907.768 425 L +907.846 425 L +907.923 425 L +908.001 425 L +908.079 425 L +908.157 425 L +908.234 425 L +908.312 425 L +908.39 425 L +908.468 425 L +908.545 425 L +908.623 425 L +908.701 425 L +908.779 425 L +908.856 425 L +908.934 425 L +909.012 425 L +909.089 425 L +909.167 425 L +909.245 425 L +909.323 425 L +909.4 425 L +909.478 425 L +909.556 425 L +909.634 425 L +909.711 425 L +909.789 425 L +909.867 425 L +909.945 425 L +910.022 425 L +910.1 425 L +910.178 425 L +910.255 425 L +910.333 425 L +910.411 425 L +910.489 425 L +910.566 425 L +910.644 425 L +910.722 425 L +910.8 425 L +910.877 425 L +910.955 425 L +911.033 425 L +911.111 425 L +911.188 425 L +911.266 425 L +911.344 425 L +911.422 425 L +911.499 425 L +911.577 425 L +911.655 425 L +911.732 425 L +911.81 425 L +911.888 425 L +911.966 425 L +912.043 425 L +912.121 425 L +912.199 425 L +912.277 425 L +912.354 425 L +912.432 425 L +912.51 425 L +912.588 425 L +912.665 425 L +912.743 425 L +912.821 425 L +912.898 425 L +912.976 425 L +913.054 425 L +913.132 425 L +913.209 425 L +913.287 425 L +913.365 425 L +913.443 425 L +913.52 425 L +913.598 425 L +913.676 425 L +913.754 425 L +913.831 425 L +913.909 425 L +913.987 425 L +914.064 425 L +914.142 425 L +914.22 425 L +914.298 425 L +914.375 425 L +914.453 425 L +914.531 425 L +914.609 425 L +914.686 425 L +914.764 425 L +914.842 425 L +914.92 425 L +914.997 425 L +915.075 425 L +915.153 425 L +915.23 425 L +915.308 425 L +915.386 425 L +915.464 425 L +915.541 425 L +915.619 425 L +915.697 425 L +915.775 425 L +915.852 425 L +915.93 425 L +916.008 425 L +916.086 425 L +916.163 425 L +916.241 425 L +916.319 425 L +916.396 425 L +916.474 425 L +916.552 425 L +916.63 425 L +916.707 425 L +916.785 425 L +916.863 425 L +916.941 425 L +917.018 425 L +917.096 425 L +917.174 425 L +917.252 425 L +917.329 425 L +917.407 425 L +917.485 425 L +917.563 425 L +917.64 425 L +917.718 425 L +917.796 425 L +917.873 425 L +917.951 425 L +918.029 425 L +918.107 425 L +918.184 425 L +918.262 425 L +918.34 425 L +918.418 425 L +918.495 425 L +918.573 425 L +918.651 425 L +918.729 425 L +918.806 425 L +918.884 425 L +918.962 425 L +919.039 425 L +919.117 425 L +919.195 425 L +919.273 425 L +919.35 425 L +919.428 425 L +919.506 425 L +919.584 425 L +919.661 425 L +919.739 425 L +919.817 425 L +919.895 425 L +919.972 425 L +920.05 425 L +920.128 425 L +920.205 425 L +920.283 425 L +920.361 425 L +920.439 425 L +920.516 425 L +920.594 425 L +920.672 425 L +920.75 425 L +920.827 425 L +920.905 425 L +920.983 425 L +921.061 425 L +921.138 425 L +921.216 425 L +921.294 425 L +921.371 425 L +921.449 425 L +921.527 425 L +921.605 425 L +921.682 425 L +921.76 425 L +921.838 425 L +921.916 425 L +921.993 425 L +922.071 425 L +922.149 425 L +922.227 425 L +922.304 425 L +922.382 425 L +922.46 425 L +922.537 425 L +922.615 425 L +922.693 425 L +922.771 425 L +922.848 425 L +922.926 425 L +923.004 425 L +923.082 425 L +923.159 425 L +923.237 425 L +923.315 425 L +923.393 425 L +923.47 425 L +923.548 425 L +923.626 425 L +923.703 425 L +923.781 425 L +923.859 425 L +923.937 425 L +924.014 425 L +924.092 425 L +924.17 425 L +924.248 425 L +924.325 425 L +924.403 425 L +924.481 425 L +924.559 425 L +924.636 425 L +924.714 425 L +924.792 425 L +924.87 425 L +924.947 425 L +925.025 425 L +925.103 425 L +925.18 425 L +925.258 425 L +925.336 425 L +925.414 425 L +925.491 425 L +925.569 425 L +925.647 425 L +925.725 425 L +925.802 425 L +925.88 425 L +925.958 425 L +926.036 425 L +926.113 425 L +926.191 425 L +926.269 425 L +926.346 425 L +926.424 425 L +926.502 425 L +926.58 425 L +926.657 425 L +926.735 425 L +926.813 425 L +926.891 425 L +926.968 425 L +927.046 425 L +927.124 425 L +927.202 425 L +927.279 425 L +927.357 425 L +927.435 425 L +927.513 425 L +927.59 425 L +927.668 425 L +927.746 425 L +927.823 425 L +927.901 425 L +927.979 425 L +928.057 425 L +928.134 425 L +928.212 425 L +928.29 425 L +928.368 425 L +928.445 425 L +928.523 425 L +928.601 425 L +928.679 425 L +928.756 425 L +928.834 425 L +928.912 425 L +928.989 425 L +929.067 425 L +929.145 425 L +929.223 425 L +929.3 425 L +929.378 425 L +929.456 425 L +929.534 425 L +929.611 425 L +929.689 425 L +929.767 425 L +929.845 425 L +929.922 425 L +930 425 L +930.078 425 L +930.095 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +1 GC +N +151 115 M +151 55 L +286 55 L +286 115 L +cp +f +GR +GS +[0.75 0 0 0.75 141 65.57353] CT +/Helvetica 14.4 F +GS +[1 0 0 1 0 0] CT +0 4.5 moveto +1 -1 scale +(PulseSigmoid) t +GR +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0 0.447 0.741 RC +1 LJ +2.667 LW +N +155 86.765 M +185 86.765 L +S +GR +GS +[0.75 0 0 0.75 141 78.80882] CT +/Helvetica 14.4 F +GS +[1 0 0 1 0 0] CT +0 4.5 moveto +1 -1 scale +(PulseRect) t +GR +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.851 0.325 0.098 RC +1 LJ +2.667 LW +N +155 104.412 M +185 104.412 L +S +GR +GS +[0.75 0 0 0.75 163.875 49.69118] CT +/Helvetica-Bold 14.4 F +GS +[1 0 0 1 0 0] CT +-35 4.5 moveto +1 -1 scale +(Stimulus) t +GR +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +10.0 ML +0.667 LW +N +151 115 M +151 55 L +286 55 L +286 115 L +cp +S +GR +GS +[0.75 0 0 0.75 0 0.5] CT +0.149 GC +1 LJ +0.667 LW +N +151 76.176 M +286 76.176 L +S +GR +%%Trailer +%%Pages: 1 +%%EOF diff --git a/doc/img/stimulus_sine.eps b/doc/img/stimulus_sine.eps new file mode 100644 index 0000000..846cfe9 --- /dev/null +++ b/doc/img/stimulus_sine.eps @@ -0,0 +1,16604 @@ +%!PS-Adobe-3.0 EPSF-3.0 +%%Creator: (MATLAB, The Mathworks, Inc. Version 9.1.0.441655 \(R2016b\). Operating System: Linux) +%%Title: /suphys/akno9866/GitHub/neurofield/doc/img/stimulus_sine.eps +%%CreationDate: 2018-02-13T16:15:54 +%%Pages: (atend) +%%BoundingBox: 0 0 772 358 +%%LanguageLevel: 3 +%%EndComments +%%BeginProlog +%%BeginResource: procset (Apache XML Graphics Std ProcSet) 1.2 0 +%%Version: 1.2 0 +%%Copyright: (Copyright 2001-2003,2010 The Apache Software Foundation. License terms: http://www.apache.org/licenses/LICENSE-2.0) +/bd{bind def}bind def +/ld{load def}bd +/GR/grestore ld +/M/moveto ld +/LJ/setlinejoin ld +/C/curveto ld +/f/fill ld +/LW/setlinewidth ld +/GC/setgray ld +/t/show ld +/N/newpath ld +/CT/concat ld +/cp/closepath ld +/S/stroke ld +/L/lineto ld +/CC/setcmykcolor ld +/A/ashow ld +/GS/gsave ld +/RC/setrgbcolor ld +/RM/rmoveto ld +/ML/setmiterlimit ld +/re {4 2 roll M +1 index 0 rlineto +0 exch rlineto +neg 0 rlineto +cp } bd +/_ctm matrix def +/_tm matrix def +/BT { _ctm currentmatrix pop matrix _tm copy pop 0 0 moveto } bd +/ET { _ctm setmatrix } bd +/iTm { _ctm setmatrix _tm concat } bd +/Tm { _tm astore pop iTm 0 0 moveto } bd +/ux 0.0 def +/uy 0.0 def +/F { + /Tp exch def + /Tf exch def + Tf findfont Tp scalefont setfont + /cf Tf def /cs Tp def +} bd +/ULS {currentpoint /uy exch def /ux exch def} bd +/ULE { + /Tcx currentpoint pop def + gsave + newpath + cf findfont cs scalefont dup + /FontMatrix get 0 get /Ts exch def /FontInfo get dup + /UnderlinePosition get Ts mul /To exch def + /UnderlineThickness get Ts mul /Tt exch def + ux uy To add moveto Tcx uy To add lineto + Tt setlinewidth stroke + grestore +} bd +/OLE { + /Tcx currentpoint pop def + gsave + newpath + cf findfont cs scalefont dup + /FontMatrix get 0 get /Ts exch def /FontInfo get dup + /UnderlinePosition get Ts mul /To exch def + /UnderlineThickness get Ts mul /Tt exch def + ux uy To add cs add moveto Tcx uy To add cs add lineto + Tt setlinewidth stroke + grestore +} bd +/SOE { + /Tcx currentpoint pop def + gsave + newpath + cf findfont cs scalefont dup + /FontMatrix get 0 get /Ts exch def /FontInfo get dup + /UnderlinePosition get Ts mul /To exch def + /UnderlineThickness get Ts mul /Tt exch def + ux uy To add cs 10 mul 26 idiv add moveto Tcx uy To add cs 10 mul 26 idiv add lineto + Tt setlinewidth stroke + grestore +} bd +/QT { +/Y22 exch store +/X22 exch store +/Y21 exch store +/X21 exch store +currentpoint +/Y21 load 2 mul add 3 div exch +/X21 load 2 mul add 3 div exch +/X21 load 2 mul /X22 load add 3 div +/Y21 load 2 mul /Y22 load add 3 div +/X22 load /Y22 load curveto +} bd +/SSPD { +dup length /d exch dict def +{ +/v exch def +/k exch def +currentpagedevice k known { +/cpdv currentpagedevice k get def +v cpdv ne { +/upd false def +/nullv v type /nulltype eq def +/nullcpdv cpdv type /nulltype eq def +nullv nullcpdv or +{ +/upd true def +} { +/sametype v type cpdv type eq def +sametype { +v type /arraytype eq { +/vlen v length def +/cpdvlen cpdv length def +vlen cpdvlen eq { +0 1 vlen 1 sub { +/i exch def +/obj v i get def +/cpdobj cpdv i get def +obj cpdobj ne { +/upd true def +exit +} if +} for +} { +/upd true def +} ifelse +} { +v type /dicttype eq { +v { +/dv exch def +/dk exch def +/cpddv cpdv dk get def +dv cpddv ne { +/upd true def +exit +} if +} forall +} { +/upd true def +} ifelse +} ifelse +} if +} ifelse +upd true eq { +d k v put +} if +} if +} if +} forall +d length 0 gt { +d setpagedevice +} if +} bd +/RE { % /NewFontName [NewEncodingArray] /FontName RE - + findfont dup length dict begin + { + 1 index /FID ne + {def} {pop pop} ifelse + } forall + /Encoding exch def + /FontName 1 index def + currentdict definefont pop + end +} bind def +%%EndResource +%%BeginResource: procset (Apache XML Graphics EPS ProcSet) 1.0 0 +%%Version: 1.0 0 +%%Copyright: (Copyright 2002-2003 The Apache Software Foundation. License terms: http://www.apache.org/licenses/LICENSE-2.0) +/BeginEPSF { %def +/b4_Inc_state save def % Save state for cleanup +/dict_count countdictstack def % Count objects on dict stack +/op_count count 1 sub def % Count objects on operand stack +userdict begin % Push userdict on dict stack +/showpage { } def % Redefine showpage, { } = null proc +0 setgray 0 setlinecap % Prepare graphics state +1 setlinewidth 0 setlinejoin +10 setmiterlimit [ ] 0 setdash newpath +/languagelevel where % If level not equal to 1 then +{pop languagelevel % set strokeadjust and +1 ne % overprint to their defaults. +{false setstrokeadjust false setoverprint +} if +} if +} bd +/EndEPSF { %def +count op_count sub {pop} repeat % Clean up stacks +countdictstack dict_count sub {end} repeat +b4_Inc_state restore +} bd +%%EndResource +%FOPBeginFontDict +%%IncludeResource: font Courier-Bold +%%IncludeResource: font Helvetica +%%IncludeResource: font Courier-BoldOblique +%%IncludeResource: font Courier-Oblique +%%IncludeResource: font Times-Roman +%%IncludeResource: font Helvetica-BoldOblique +%%IncludeResource: font Helvetica-Bold +%%IncludeResource: font Helvetica-Oblique +%%IncludeResource: font Times-BoldItalic +%%IncludeResource: font Courier +%%IncludeResource: font Times-Italic +%%IncludeResource: font Times-Bold +%%IncludeResource: font Symbol +%%IncludeResource: font ZapfDingbats +%FOPEndFontDict +%%BeginResource: encoding WinAnsiEncoding +/WinAnsiEncoding [ +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /.notdef /.notdef /.notdef +/.notdef /.notdef /space /exclam /quotedbl +/numbersign /dollar /percent /ampersand /quotesingle +/parenleft /parenright /asterisk /plus /comma +/hyphen /period /slash /zero /one +/two /three /four /five /six +/seven /eight /nine /colon /semicolon +/less /equal /greater /question /at +/A /B /C /D /E +/F /G /H /I /J +/K /L /M /N /O +/P /Q /R /S /T +/U /V /W /X /Y +/Z /bracketleft /backslash /bracketright /asciicircum +/underscore /quoteleft /a /b /c +/d /e /f /g /h +/i /j /k /l /m +/n /o /p /q /r +/s /t /u /v /w +/x /y /z /braceleft /bar +/braceright /asciitilde /bullet /Euro /bullet +/quotesinglbase /florin /quotedblbase /ellipsis /dagger +/daggerdbl /circumflex /perthousand /Scaron /guilsinglleft +/OE /bullet /Zcaron /bullet /bullet +/quoteleft /quoteright /quotedblleft /quotedblright /bullet +/endash /emdash /asciitilde /trademark /scaron +/guilsinglright /oe /bullet /zcaron /Ydieresis +/space /exclamdown /cent /sterling /currency +/yen /brokenbar /section /dieresis /copyright +/ordfeminine /guillemotleft /logicalnot /sfthyphen /registered +/macron /degree /plusminus /twosuperior /threesuperior +/acute /mu /paragraph /middot /cedilla +/onesuperior /ordmasculine /guillemotright /onequarter /onehalf +/threequarters /questiondown /Agrave /Aacute /Acircumflex +/Atilde /Adieresis /Aring /AE /Ccedilla +/Egrave /Eacute /Ecircumflex /Edieresis /Igrave +/Iacute /Icircumflex /Idieresis /Eth /Ntilde +/Ograve /Oacute /Ocircumflex /Otilde /Odieresis +/multiply /Oslash /Ugrave /Uacute /Ucircumflex +/Udieresis /Yacute /Thorn /germandbls /agrave +/aacute /acircumflex /atilde /adieresis /aring +/ae /ccedilla /egrave /eacute /ecircumflex +/edieresis /igrave /iacute /icircumflex /idieresis +/eth /ntilde /ograve /oacute /ocircumflex +/otilde /odieresis /divide /oslash /ugrave +/uacute /ucircumflex /udieresis /yacute /thorn +/ydieresis +] def +%%EndResource +%FOPBeginFontReencode +/Courier-Bold findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier-Bold exch definefont pop +/Helvetica findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica exch definefont pop +/Courier-BoldOblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier-BoldOblique exch definefont pop +/Courier-Oblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier-Oblique exch definefont pop +/Times-Roman findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-Roman exch definefont pop +/Helvetica-BoldOblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica-BoldOblique exch definefont pop +/Helvetica-Bold findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica-Bold exch definefont pop +/Helvetica-Oblique findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Helvetica-Oblique exch definefont pop +/Times-BoldItalic findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-BoldItalic exch definefont pop +/Courier findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Courier exch definefont pop +/Times-Italic findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-Italic exch definefont pop +/Times-Bold findfont +dup length dict begin + {1 index /FID ne {def} {pop pop} ifelse} forall + /Encoding WinAnsiEncoding def + currentdict +end +/Times-Bold exch definefont pop +%FOPEndFontReencode +%%EndProlog +%%Page: 1 1 +%%PageBoundingBox: 0 0 772 358 +%%BeginPageSetup +[1 0 0 -1 0 358] CT +%%EndPageSetup +GS +[0.75 0 0 0.75 0 0.25] CT +1 GC +N +0 0 1029 477 re +f +GR +GS +[0.75 0 0 0.75 0 0.25] CT +1 GC +N +0 0 1029 477 re +f +GR +GS +[0.75 0 0 0.75 0 0.25] CT +1 GC +N +134 425 M +931 425 L +931 36 L +134 36 L +cp +f +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +931 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 36 M +931 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +134 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +213.7 425 M +213.7 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +293.4 425 M +293.4 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +373.1 425 M +373.1 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +452.8 425 M +452.8 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +532.5 425 M +532.5 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +612.2 425 M +612.2 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +691.9 425 M +691.9 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +771.6 425 M +771.6 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +851.3 425 M +851.3 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 425 M +931 417.03 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 36 M +134 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +213.7 36 M +213.7 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +293.4 36 M +293.4 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +373.1 36 M +373.1 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +452.8 36 M +452.8 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +532.5 36 M +532.5 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +612.2 36 M +612.2 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +691.9 36 M +691.9 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +771.6 36 M +771.6 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +851.3 36 M +851.3 43.97 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 36 M +931 43.97 L +S +GR +GS +[0.75 0 0 0.75 100.5 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(0) t +GR +GR +GS +[0.75 0 0 0.75 160.275 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-13 15 moveto +1 -1 scale +(0.5) t +GR +GR +GS +[0.75 0 0 0.75 220.05 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(1) t +GR +GR +GS +[0.75 0 0 0.75 279.825 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-13 15 moveto +1 -1 scale +(1.5) t +GR +GR +GS +[0.75 0 0 0.75 339.59999 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(2) t +GR +GR +GS +[0.75 0 0 0.75 399.375 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-13 15 moveto +1 -1 scale +(2.5) t +GR +GR +GS +[0.75 0 0 0.75 459.15001 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(3) t +GR +GR +GS +[0.75 0 0 0.75 518.92502 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-13 15 moveto +1 -1 scale +(3.5) t +GR +GR +GS +[0.75 0 0 0.75 578.69998 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(4) t +GR +GR +GS +[0.75 0 0 0.75 638.47499 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-13 15 moveto +1 -1 scale +(4.5) t +GR +GR +GS +[0.75 0 0 0.75 698.25 323.4] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-5.5 15 moveto +1 -1 scale +(5) t +GR +GR +GS +[0.75 0 0 0.75 399.37527 338.64999] CT +0.149 GC +/Helvetica 21.333 F +GS +[1 0 0 1 0 0] CT +-43.5 20 moveto +1 -1 scale +(Time [s]) t +GR +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +134 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 425 M +931 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 425 M +141.97 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 376.375 M +141.97 376.375 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 327.75 M +141.97 327.75 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 279.125 M +141.97 279.125 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 230.5 M +141.97 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 181.875 M +141.97 181.875 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 133.25 M +141.97 133.25 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 84.625 M +141.97 84.625 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +134 36 M +141.97 36 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 425 M +923.03 425 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 376.375 M +923.03 376.375 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 327.75 M +923.03 327.75 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 279.125 M +923.03 279.125 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 230.5 M +923.03 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 181.875 M +923.03 181.875 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 133.25 M +923.03 133.25 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 84.625 M +923.03 84.625 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +2 setlinecap +1 LJ +0.667 LW +N +931 36 M +923.03 36 L +S +GR +GS +[0.75 0 0 0.75 96.1 319] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-16 5.5 moveto +1 -1 scale +(-2) t +GR +GR +GS +[0.75 0 0 0.75 96.1 282.53125] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-32 5.5 moveto +1 -1 scale +(-1.5) t +GR +GR +GS +[0.75 0 0 0.75 96.1 246.0625] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-16 5.5 moveto +1 -1 scale +(-1) t +GR +GR +GS +[0.75 0 0 0.75 96.1 209.59375] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-32 5.5 moveto +1 -1 scale +(-0.5) t +GR +GR +GS +[0.75 0 0 0.75 96.1 173.125] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-11 5.5 moveto +1 -1 scale +(0) t +GR +GR +GS +[0.75 0 0 0.75 96.1 136.65625] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(0.5) t +GR +GR +GS +[0.75 0 0 0.75 96.1 100.1875] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-11 5.5 moveto +1 -1 scale +(1) t +GR +GR +GS +[0.75 0 0 0.75 96.1 63.71875] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-26 5.5 moveto +1 -1 scale +(1.5) t +GR +GR +GS +[0.75 0 0 0.75 96.1 27.25] CT +0.149 GC +/Helvetica 16 F +GS +[1 0 0 1 0 0] CT +-11 5.5 moveto +1 -1 scale +(2) t +GR +GR +GS +[0 -0.75 0.75 0 69.1 173.12486] CT +0.149 GC +/Helvetica 21.333 F +GS +[1 0 0 1 0 0] CT +-54 -5 moveto +1 -1 scale +(Amplitude) t +GR +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0 0.447 0.741 RC +1 LJ +2.667 LW +N +134.156 230.5 M +134.311 230.5 L +134.467 230.5 L +134.623 230.5 L +134.778 230.5 L +134.934 230.5 L +135.09 230.5 L +135.245 230.5 L +135.401 230.5 L +135.557 230.5 L +135.712 230.5 L +135.868 230.5 L +136.024 230.5 L +136.179 230.5 L +136.335 230.5 L +136.491 230.5 L +136.646 230.5 L +136.802 230.5 L +136.958 230.5 L +137.113 230.5 L +137.269 230.5 L +137.425 230.5 L +137.58 230.5 L +137.736 230.5 L +137.892 230.5 L +138.047 230.5 L +138.203 230.5 L +138.359 230.5 L +138.514 230.5 L +138.67 230.5 L +138.826 230.5 L +138.981 230.5 L +139.137 230.5 L +139.293 230.5 L +139.448 230.5 L +139.604 230.5 L +139.76 230.5 L +139.915 230.5 L +140.071 230.5 L +140.227 230.5 L +140.382 230.5 L +140.538 230.5 L +140.694 230.5 L +140.849 230.5 L +141.005 230.5 L +141.161 230.5 L +141.316 230.5 L +141.472 230.5 L +141.628 230.5 L +141.783 230.5 L +141.939 230.5 L +142.095 230.5 L +142.25 230.5 L +142.406 230.5 L +142.562 230.5 L +142.717 230.5 L +142.873 230.5 L +143.029 230.5 L +143.184 230.5 L +143.34 230.5 L +143.496 230.5 L +143.651 230.5 L +143.807 230.5 L +143.962 230.5 L +144.118 230.5 L +144.274 230.5 L +144.429 230.5 L +144.585 230.5 L +144.741 230.5 L +144.896 230.5 L +145.052 230.5 L +145.208 230.5 L +145.363 230.5 L +145.519 230.5 L +145.675 230.5 L +145.83 230.5 L +145.986 230.5 L +146.142 230.5 L +146.297 230.5 L +146.453 230.5 L +146.609 230.5 L +146.764 230.5 L +146.92 230.5 L +147.076 230.5 L +147.231 230.5 L +147.387 230.5 L +147.543 230.5 L +147.698 230.5 L +147.854 230.5 L +148.01 230.5 L +148.165 230.5 L +148.321 230.5 L +148.477 230.5 L +148.632 230.5 L +148.788 230.5 L +148.944 230.5 L +149.099 230.5 L +149.255 230.5 L +149.411 230.5 L +149.566 230.5 L +149.722 230.5 L +149.878 230.5 L +150.033 230.5 L +150.189 230.5 L +150.345 230.5 L +150.5 230.5 L +150.656 230.5 L +150.812 230.5 L +150.967 230.5 L +151.123 230.5 L +151.279 230.5 L +151.434 230.5 L +151.59 230.5 L +151.746 230.5 L +151.901 230.5 L +152.057 230.5 L +152.213 230.5 L +152.368 230.5 L +152.524 230.5 L +152.68 230.5 L +152.835 230.5 L +152.991 230.5 L +153.147 230.5 L +153.302 230.5 L +153.458 230.5 L +153.614 230.5 L +153.769 230.5 L +153.925 230.5 L +154.081 230.5 L +154.236 230.5 L +154.392 230.5 L +154.548 230.5 L +154.703 230.5 L +154.859 230.5 L +155.015 230.5 L +155.17 230.5 L +155.326 230.5 L +155.482 230.5 L +155.637 230.5 L +155.793 230.5 L +155.949 230.5 L +156.104 230.5 L +156.26 230.5 L +156.416 230.5 L +156.571 230.5 L +156.727 230.5 L +156.883 230.5 L +157.038 230.5 L +157.194 230.5 L +157.35 230.5 L +157.505 230.5 L +157.661 230.5 L +157.817 230.5 L +157.972 230.5 L +158.128 230.5 L +158.284 230.5 L +158.439 230.5 L +158.595 230.5 L +158.751 230.5 L +158.906 230.5 L +159.062 230.5 L +159.218 230.5 L +159.373 230.5 L +159.529 230.5 L +159.685 230.5 L +159.84 230.5 L +159.996 230.5 L +160.152 230.5 L +160.307 230.5 L +160.463 230.5 L +160.619 230.5 L +160.774 230.5 L +160.93 230.5 L +161.086 230.5 L +161.241 230.5 L +161.397 230.5 L +161.553 230.5 L +161.708 230.5 L +161.864 230.5 L +162.02 230.5 L +162.175 230.5 L +162.331 230.5 L +162.487 230.5 L +162.642 230.5 L +162.798 230.5 L +162.954 230.5 L +163.109 230.5 L +163.265 230.5 L +163.421 230.5 L +163.576 230.5 L +163.732 230.5 L +163.887 230.5 L +164.043 230.5 L +164.199 230.5 L +164.354 230.5 L +164.51 230.5 L +164.666 230.5 L +164.821 230.5 L +164.977 230.5 L +165.133 230.5 L +165.288 230.5 L +165.444 230.5 L +165.6 230.5 L +165.755 230.5 L +165.911 230.5 L +166.067 230.5 L +166.222 230.5 L +166.378 230.5 L +166.534 230.5 L +166.689 230.5 L +166.845 230.5 L +167.001 230.5 L +167.156 230.5 L +167.312 230.5 L +167.468 230.5 L +167.623 230.5 L +167.779 230.5 L +167.935 230.5 L +168.09 230.5 L +168.246 230.5 L +168.402 230.5 L +168.557 230.5 L +168.713 230.5 L +168.869 230.5 L +169.024 230.5 L +169.18 230.5 L +169.336 230.5 L +169.491 230.5 L +169.647 230.5 L +169.803 230.5 L +169.958 230.5 L +170.114 230.5 L +170.27 230.5 L +170.425 230.5 L +170.581 230.5 L +170.737 230.5 L +170.892 230.5 L +171.048 230.5 L +171.204 230.5 L +171.359 230.5 L +171.515 230.5 L +171.671 230.5 L +171.826 230.5 L +171.982 230.5 L +172.138 230.5 L +172.293 230.5 L +172.449 230.5 L +172.605 230.5 L +172.76 230.5 L +172.916 230.5 L +173.072 230.5 L +173.227 230.5 L +173.383 230.5 L +173.539 230.5 L +173.694 230.5 L +173.85 230.5 L +174.006 230.5 L +174.161 230.5 L +174.317 230.5 L +174.473 230.5 L +174.628 230.5 L +174.784 230.5 L +174.94 230.5 L +175.095 230.5 L +175.251 230.5 L +175.407 230.5 L +175.562 230.5 L +175.718 230.5 L +175.874 230.5 L +176.029 230.5 L +176.185 230.5 L +176.341 230.5 L +176.496 230.5 L +176.652 230.5 L +176.808 230.5 L +176.963 230.5 L +177.119 230.5 L +177.275 230.5 L +177.43 230.5 L +177.586 230.5 L +177.742 230.5 L +177.897 230.5 L +178.053 230.5 L +178.209 230.5 L +178.364 230.5 L +178.52 230.5 L +178.676 230.5 L +178.831 230.5 L +178.987 230.5 L +179.143 230.5 L +179.298 230.5 L +179.454 230.5 L +179.61 230.5 L +179.765 230.5 L +179.921 230.5 L +180.077 230.5 L +180.232 230.5 L +180.388 230.5 L +180.544 230.5 L +180.699 230.5 L +180.855 230.5 L +181.011 230.5 L +181.166 230.5 L +181.322 230.5 L +181.478 230.5 L +181.633 230.5 L +181.789 230.5 L +181.945 230.5 L +182.1 230.5 L +182.256 230.5 L +182.412 230.5 L +182.567 230.5 L +182.723 230.5 L +182.879 230.5 L +183.034 230.5 L +183.19 230.5 L +183.346 230.5 L +183.501 230.5 L +183.657 230.5 L +183.813 230.5 L +183.968 230.5 L +184.124 230.5 L +184.279 230.5 L +184.435 230.5 L +184.591 230.5 L +184.746 230.5 L +184.902 230.5 L +185.058 230.5 L +185.213 230.5 L +185.369 230.5 L +185.525 230.5 L +185.68 230.5 L +185.836 230.5 L +185.992 230.5 L +186.147 230.5 L +186.303 230.5 L +186.459 230.5 L +186.614 230.5 L +186.77 230.5 L +186.926 230.5 L +187.081 230.5 L +187.237 230.5 L +187.393 230.5 L +187.548 230.5 L +187.704 230.5 L +187.86 230.5 L +188.015 230.5 L +188.171 230.5 L +188.327 230.5 L +188.482 230.5 L +188.638 230.5 L +188.794 230.5 L +188.949 230.5 L +189.105 230.5 L +189.261 230.5 L +189.416 230.5 L +189.572 230.5 L +189.728 230.5 L +189.883 230.5 L +190.039 230.5 L +190.195 230.5 L +190.35 230.5 L +190.506 230.5 L +190.662 230.5 L +190.817 230.5 L +190.973 230.5 L +191.129 230.5 L +191.284 230.5 L +191.44 230.5 L +191.596 230.5 L +191.751 230.5 L +191.907 230.5 L +192.063 230.5 L +192.218 230.5 L +192.374 230.5 L +192.53 230.5 L +192.685 230.5 L +192.841 230.5 L +192.997 230.5 L +193.152 230.5 L +193.308 230.5 L +193.464 230.5 L +193.619 230.5 L +193.775 230.5 L +193.931 230.5 L +194.086 230.5 L +194.242 230.5 L +194.398 230.5 L +194.553 230.5 L +194.709 230.5 L +194.865 230.5 L +195.02 230.5 L +195.176 230.5 L +195.332 230.5 L +195.487 230.5 L +195.643 230.5 L +195.799 230.5 L +195.954 230.5 L +196.11 230.5 L +196.266 230.5 L +196.421 230.5 L +196.577 230.5 L +196.733 230.5 L +196.888 230.5 L +197.044 230.5 L +197.2 230.5 L +197.355 230.5 L +197.511 230.5 L +197.667 230.5 L +197.822 230.5 L +197.978 230.5 L +198.134 230.5 L +198.289 230.5 L +198.445 230.5 L +198.601 230.5 L +198.756 230.5 L +198.912 230.5 L +199.068 230.5 L +199.223 230.5 L +199.379 230.5 L +199.535 230.5 L +199.69 230.5 L +199.846 230.5 L +200.002 230.5 L +200.157 230.5 L +200.313 230.5 L +200.469 230.5 L +200.624 230.5 L +200.78 230.5 L +200.936 230.5 L +201.091 230.5 L +201.247 230.5 L +201.403 230.5 L +201.558 230.5 L +201.714 230.5 L +201.87 230.5 L +202.025 230.5 L +202.181 230.5 L +202.337 230.5 L +202.492 230.5 L +202.648 230.5 L +202.804 230.5 L +202.959 230.5 L +203.115 230.5 L +203.271 230.5 L +203.426 230.5 L +203.582 230.5 L +203.738 230.5 L +203.893 230.5 L +204.049 230.5 L +204.204 230.5 L +204.36 230.5 L +204.516 230.5 L +204.671 230.5 L +204.827 230.5 L +204.983 230.5 L +205.138 230.5 L +205.294 230.5 L +205.45 230.5 L +205.605 230.5 L +205.761 230.5 L +205.917 230.5 L +206.072 230.5 L +206.228 230.5 L +206.384 230.5 L +206.539 230.5 L +206.695 230.5 L +206.851 230.5 L +207.006 230.5 L +207.162 230.5 L +207.318 230.5 L +207.473 230.5 L +207.629 230.5 L +207.785 230.5 L +207.94 230.5 L +208.096 230.5 L +208.252 230.5 L +208.407 230.5 L +208.563 230.5 L +208.719 230.5 L +208.874 230.5 L +209.03 230.5 L +209.186 230.5 L +209.341 230.5 L +209.497 230.5 L +209.653 230.5 L +209.808 230.5 L +209.964 230.5 L +210.12 230.5 L +210.275 230.5 L +210.431 230.5 L +210.587 230.5 L +210.742 230.5 L +210.898 230.5 L +211.054 230.5 L +211.209 230.5 L +211.365 230.5 L +211.521 230.5 L +211.676 230.5 L +211.832 230.5 L +211.988 230.5 L +212.143 230.5 L +212.299 230.5 L +212.455 230.5 L +212.61 230.5 L +212.766 230.5 L +212.922 230.5 L +213.077 230.5 L +213.233 230.5 L +213.389 230.5 L +213.544 230.5 L +213.7 230.5 L +213.856 230.5 L +214.011 230.5 L +214.167 230.5 L +214.323 230.5 L +214.478 230.5 L +214.634 230.5 L +214.79 230.5 L +214.945 230.5 L +215.101 230.5 L +215.257 230.5 L +215.412 230.5 L +215.568 230.5 L +215.724 230.5 L +215.879 230.5 L +216.035 230.5 L +216.191 230.5 L +216.346 230.5 L +216.502 230.5 L +216.658 230.5 L +216.813 230.5 L +216.969 230.5 L +217.125 230.5 L +217.28 230.5 L +217.436 230.5 L +217.592 230.5 L +217.747 230.5 L +217.903 230.5 L +218.059 230.5 L +218.214 230.5 L +218.37 230.5 L +218.526 230.5 L +218.681 230.5 L +218.837 230.5 L +218.993 230.5 L +219.148 230.5 L +219.304 230.5 L +219.46 230.5 L +219.615 230.5 L +219.771 230.5 L +219.927 230.5 L +220.082 230.5 L +220.238 230.5 L +220.394 230.5 L +220.549 230.5 L +220.705 230.5 L +220.861 230.5 L +221.016 230.5 L +221.172 230.5 L +221.328 230.5 L +221.483 230.5 L +221.639 230.5 L +221.795 230.5 L +221.95 230.5 L +222.106 230.5 L +222.262 230.5 L +222.417 230.5 L +222.573 230.5 L +222.729 230.5 L +222.884 230.5 L +223.04 230.5 L +223.196 230.5 L +223.351 230.5 L +223.507 230.5 L +223.663 230.5 L +223.818 230.5 L +223.974 230.5 L +224.129 230.5 L +224.285 230.5 L +224.441 230.5 L +224.596 230.5 L +224.752 230.5 L +224.908 230.5 L +225.063 230.5 L +225.219 230.5 L +225.375 230.5 L +225.53 230.5 L +225.686 230.5 L +225.842 230.5 L +225.997 230.5 L +226.153 230.5 L +226.309 230.5 L +226.464 230.5 L +226.62 230.5 L +226.776 230.5 L +226.931 230.5 L +227.087 230.5 L +227.243 230.5 L +227.398 230.5 L +227.554 230.5 L +227.71 230.5 L +227.865 230.5 L +228.021 230.5 L +228.177 230.5 L +228.332 230.5 L +228.488 230.5 L +228.644 230.5 L +228.799 230.5 L +228.955 230.5 L +229.111 230.5 L +229.266 230.5 L +229.422 230.5 L +229.578 230.5 L +229.733 230.5 L +229.889 230.5 L +230.045 230.5 L +230.2 230.5 L +230.356 230.5 L +230.512 230.5 L +230.667 230.5 L +230.823 230.5 L +230.979 230.5 L +231.134 230.5 L +231.29 230.5 L +231.446 230.5 L +231.601 230.5 L +231.757 230.5 L +231.913 230.5 L +232.068 230.5 L +232.224 230.5 L +232.38 230.5 L +232.535 230.5 L +232.691 230.5 L +232.847 230.5 L +233.002 230.5 L +233.158 230.5 L +233.314 230.5 L +233.469 230.5 L +233.625 230.5 L +233.781 230.5 L +233.936 230.5 L +234.092 230.5 L +234.248 230.5 L +234.403 230.5 L +234.559 230.5 L +234.715 230.5 L +234.87 230.5 L +235.026 230.5 L +235.182 230.5 L +235.337 230.5 L +235.493 230.5 L +235.649 230.5 L +235.804 230.5 L +235.96 230.5 L +236.116 230.5 L +236.271 230.5 L +236.427 230.5 L +236.583 230.5 L +236.738 230.5 L +236.894 230.5 L +237.05 230.5 L +237.205 230.5 L +237.361 230.5 L +237.517 230.5 L +237.672 230.5 L +237.828 230.5 L +237.984 230.5 L +238.139 230.5 L +238.295 230.5 L +238.451 230.5 L +238.606 230.5 L +238.762 230.5 L +238.918 230.5 L +239.073 230.5 L +239.229 230.5 L +239.385 230.5 L +239.54 230.5 L +239.696 230.5 L +239.852 230.5 L +240.007 230.5 L +240.163 230.5 L +240.319 230.5 L +240.474 230.5 L +240.63 230.5 L +240.786 230.5 L +240.941 230.5 L +241.097 230.5 L +241.253 230.5 L +241.408 230.5 L +241.564 230.5 L +241.72 230.5 L +241.875 230.5 L +242.031 230.5 L +242.187 230.5 L +242.342 230.5 L +242.498 230.5 L +242.654 230.5 L +242.809 230.5 L +242.965 230.5 L +243.121 230.5 L +243.276 230.5 L +243.432 230.5 L +243.587 230.5 L +243.743 230.5 L +243.899 230.5 L +244.054 230.5 L +244.21 230.5 L +244.366 230.5 L +244.521 230.5 L +244.677 230.5 L +244.833 230.5 L +244.988 230.5 L +245.144 230.5 L +245.3 230.5 L +245.455 230.5 L +245.611 230.5 L +245.767 230.5 L +245.922 230.5 L +246.078 230.5 L +246.234 230.5 L +246.389 230.5 L +246.545 230.5 L +246.701 230.5 L +246.856 230.5 L +247.012 230.5 L +247.168 230.5 L +247.323 230.5 L +247.479 230.5 L +247.635 230.5 L +247.79 230.5 L +247.946 230.5 L +248.102 230.5 L +248.257 230.5 L +248.413 230.5 L +248.569 230.5 L +248.724 230.5 L +248.88 230.5 L +249.036 230.5 L +249.191 230.5 L +249.347 230.5 L +249.503 230.5 L +249.658 230.5 L +249.814 230.5 L +249.97 230.5 L +250.125 230.5 L +250.281 230.5 L +250.437 230.5 L +250.592 230.5 L +250.748 230.5 L +250.904 230.5 L +251.059 230.5 L +251.215 230.5 L +251.371 230.5 L +251.526 230.5 L +251.682 230.5 L +251.838 230.5 L +251.993 230.5 L +252.149 230.5 L +252.305 230.5 L +252.46 230.5 L +252.616 230.5 L +252.772 230.5 L +252.927 230.5 L +253.083 230.5 L +253.239 230.5 L +253.394 230.5 L +253.55 230.5 L +253.706 230.5 L +253.861 230.5 L +254.017 230.5 L +254.173 230.5 L +254.328 230.5 L +254.484 230.5 L +254.64 230.5 L +254.795 230.5 L +254.951 230.5 L +255.107 230.5 L +255.262 230.5 L +255.418 230.5 L +255.574 230.5 L +255.729 230.5 L +255.885 230.5 L +256.041 230.5 L +256.196 230.5 L +256.352 230.5 L +256.508 230.5 L +256.663 230.5 L +256.819 230.5 L +256.975 230.5 L +257.13 230.5 L +257.286 230.5 L +257.442 230.5 L +257.597 230.5 L +257.753 230.5 L +257.909 230.5 L +258.064 230.5 L +258.22 230.5 L +258.376 230.5 L +258.531 230.5 L +258.687 230.5 L +258.843 230.5 L +258.998 230.5 L +259.154 230.5 L +259.31 230.5 L +259.465 230.5 L +259.621 230.5 L +259.777 230.5 L +259.932 230.5 L +260.088 230.5 L +260.244 230.5 L +260.399 230.5 L +260.555 230.5 L +260.711 230.5 L +260.866 230.5 L +261.022 230.5 L +261.178 230.5 L +261.333 230.5 L +261.489 230.5 L +261.645 230.5 L +261.8 230.5 L +261.956 230.5 L +262.112 230.5 L +262.267 230.5 L +262.423 230.5 L +262.579 230.5 L +262.734 230.5 L +262.89 230.5 L +263.046 230.5 L +263.201 230.5 L +263.357 230.5 L +263.513 230.5 L +263.668 230.5 L +263.824 230.5 L +263.979 230.5 L +264.135 230.5 L +264.291 230.5 L +264.446 230.5 L +264.602 230.5 L +264.758 230.5 L +264.913 230.5 L +265.069 230.5 L +265.225 230.5 L +265.38 230.5 L +265.536 230.5 L +265.692 230.5 L +265.847 230.5 L +266.003 230.5 L +266.159 230.5 L +266.314 230.5 L +266.47 230.5 L +266.626 230.5 L +266.781 230.5 L +266.937 230.5 L +267.093 230.5 L +267.248 230.5 L +267.404 230.5 L +267.56 230.5 L +267.715 230.5 L +267.871 230.5 L +268.027 230.5 L +268.182 230.5 L +268.338 230.5 L +268.494 230.5 L +268.649 230.5 L +268.805 230.5 L +268.961 230.5 L +269.116 230.5 L +269.272 230.5 L +269.428 230.5 L +269.583 230.5 L +269.739 230.5 L +269.895 230.5 L +270.05 230.5 L +270.206 230.5 L +270.362 230.5 L +270.517 230.5 L +270.673 230.5 L +270.829 230.5 L +270.984 230.5 L +271.14 230.5 L +271.296 230.5 L +271.451 230.5 L +271.607 230.5 L +271.763 230.5 L +271.918 230.5 L +272.074 230.5 L +272.23 230.5 L +272.385 230.5 L +272.541 230.5 L +272.697 230.5 L +272.852 230.5 L +273.008 230.5 L +273.164 230.5 L +273.319 230.5 L +273.475 230.5 L +273.631 230.5 L +273.786 230.5 L +273.942 230.5 L +274.098 230.5 L +274.253 230.5 L +274.409 230.5 L +274.565 230.5 L +274.72 230.5 L +274.876 230.5 L +275.032 230.5 L +275.187 230.5 L +275.343 230.5 L +275.499 230.5 L +275.654 230.5 L +275.81 230.5 L +275.966 230.5 L +276.121 230.5 L +276.277 230.5 L +276.433 230.5 L +276.588 230.5 L +276.744 230.5 L +276.9 230.5 L +277.055 230.5 L +277.211 230.5 L +277.367 230.5 L +277.522 230.5 L +277.678 230.5 L +277.834 230.5 L +277.989 230.5 L +278.145 230.5 L +278.301 230.5 L +278.456 230.5 L +278.612 230.5 L +278.768 230.5 L +278.923 230.5 L +279.079 230.5 L +279.235 230.5 L +279.39 230.5 L +279.546 230.5 L +279.702 230.5 L +279.857 230.5 L +280.013 230.5 L +280.169 230.5 L +280.324 230.5 L +280.48 230.5 L +280.636 230.5 L +280.791 230.5 L +280.947 230.5 L +281.103 230.5 L +281.258 230.5 L +281.414 230.5 L +281.57 230.5 L +281.725 230.5 L +281.881 230.5 L +282.037 230.5 L +282.192 230.5 L +282.348 230.5 L +282.504 230.5 L +282.659 230.5 L +282.815 230.5 L +282.971 230.5 L +283.126 230.5 L +283.282 230.5 L +283.438 230.5 L +283.593 230.5 L +283.749 230.5 L +283.904 230.5 L +284.06 230.5 L +284.216 230.5 L +284.371 230.5 L +284.527 230.5 L +284.683 230.5 L +284.838 230.5 L +284.994 230.5 L +285.15 230.5 L +285.305 230.5 L +285.461 230.5 L +285.617 230.5 L +285.772 230.5 L +285.928 230.5 L +286.084 230.5 L +286.239 230.5 L +286.395 230.5 L +286.551 230.5 L +286.706 230.5 L +286.862 230.5 L +287.018 230.5 L +287.173 230.5 L +287.329 230.5 L +287.485 230.5 L +287.64 230.5 L +287.796 230.5 L +287.952 230.5 L +288.107 230.5 L +288.263 230.5 L +288.419 230.5 L +288.574 230.5 L +288.73 230.5 L +288.886 230.5 L +289.041 230.5 L +289.197 230.5 L +289.353 230.5 L +289.508 230.5 L +289.664 230.5 L +289.82 230.5 L +289.975 230.5 L +290.131 230.5 L +290.287 230.5 L +290.442 230.5 L +290.598 230.5 L +290.754 230.5 L +290.909 230.5 L +291.065 230.5 L +291.221 230.5 L +291.376 230.5 L +291.532 230.5 L +291.688 230.5 L +291.843 230.5 L +291.999 230.5 L +292.155 230.5 L +292.31 230.5 L +292.466 230.5 L +292.622 230.5 L +292.777 230.5 L +292.933 230.5 L +293.089 230.5 L +293.244 230.5 L +293.4 230.5 L +293.556 230.202 L +293.711 229.903 L +293.867 229.605 L +294.023 229.307 L +294.178 229.008 L +294.334 228.71 L +294.49 228.412 L +294.645 228.113 L +294.801 227.815 L +294.957 227.517 L +295.112 227.219 L +295.268 226.921 L +295.424 226.622 L +295.579 226.324 L +295.735 226.026 L +295.891 225.728 L +296.046 225.43 L +296.202 225.132 L +296.358 224.834 L +296.513 224.537 L +296.669 224.239 L +296.825 223.941 L +296.98 223.643 L +297.136 223.346 L +297.292 223.048 L +297.447 222.751 L +297.603 222.454 L +297.759 222.156 L +297.914 221.859 L +298.07 221.562 L +298.226 221.265 L +298.381 220.968 L +298.537 220.671 L +298.693 220.374 L +298.848 220.077 L +299.004 219.781 L +299.16 219.484 L +299.315 219.188 L +299.471 218.892 L +299.627 218.596 L +299.782 218.299 L +299.938 218.004 L +300.094 217.708 L +300.249 217.412 L +300.405 217.116 L +300.561 216.821 L +300.716 216.526 L +300.872 216.23 L +301.028 215.935 L +301.183 215.64 L +301.339 215.346 L +301.495 215.051 L +301.65 214.757 L +301.806 214.462 L +301.962 214.168 L +302.117 213.874 L +302.273 213.58 L +302.429 213.286 L +302.584 212.993 L +302.74 212.699 L +302.896 212.406 L +303.051 212.113 L +303.207 211.82 L +303.362 211.527 L +303.518 211.235 L +303.674 210.943 L +303.829 210.65 L +303.985 210.358 L +304.141 210.067 L +304.296 209.775 L +304.452 209.484 L +304.608 209.192 L +304.763 208.901 L +304.919 208.611 L +305.075 208.32 L +305.23 208.03 L +305.386 207.739 L +305.542 207.449 L +305.697 207.16 L +305.853 206.87 L +306.009 206.581 L +306.164 206.292 L +306.32 206.003 L +306.476 205.714 L +306.631 205.426 L +306.787 205.138 L +306.943 204.85 L +307.098 204.562 L +307.254 204.275 L +307.41 203.988 L +307.565 203.701 L +307.721 203.414 L +307.877 203.128 L +308.032 202.841 L +308.188 202.555 L +308.344 202.27 L +308.499 201.984 L +308.655 201.699 L +308.811 201.414 L +308.966 201.13 L +309.122 200.846 L +309.278 200.562 L +309.433 200.278 L +309.589 199.994 L +309.745 199.711 L +309.9 199.428 L +310.056 199.146 L +310.212 198.864 L +310.367 198.582 L +310.523 198.3 L +310.679 198.019 L +310.834 197.737 L +310.99 197.457 L +311.146 197.176 L +311.301 196.896 L +311.457 196.616 L +311.613 196.337 L +311.768 196.058 L +311.924 195.779 L +312.08 195.5 L +312.235 195.222 L +312.391 194.944 L +312.547 194.667 L +312.702 194.389 L +312.858 194.113 L +313.014 193.836 L +313.169 193.56 L +313.325 193.284 L +313.481 193.009 L +313.636 192.733 L +313.792 192.459 L +313.948 192.184 L +314.103 191.91 L +314.259 191.637 L +314.415 191.363 L +314.57 191.09 L +314.726 190.818 L +314.882 190.546 L +315.037 190.274 L +315.193 190.002 L +315.349 189.731 L +315.504 189.46 L +315.66 189.19 L +315.816 188.92 L +315.971 188.651 L +316.127 188.382 L +316.283 188.113 L +316.438 187.845 L +316.594 187.577 L +316.75 187.309 L +316.905 187.042 L +317.061 186.775 L +317.217 186.509 L +317.372 186.243 L +317.528 185.978 L +317.684 185.713 L +317.839 185.448 L +317.995 185.184 L +318.151 184.92 L +318.306 184.657 L +318.462 184.394 L +318.618 184.131 L +318.773 183.869 L +318.929 183.608 L +319.085 183.346 L +319.24 183.086 L +319.396 182.825 L +319.552 182.566 L +319.707 182.306 L +319.863 182.047 L +320.019 181.789 L +320.174 181.531 L +320.33 181.273 L +320.486 181.016 L +320.641 180.76 L +320.797 180.504 L +320.953 180.248 L +321.108 179.993 L +321.264 179.738 L +321.42 179.484 L +321.575 179.23 L +321.731 178.977 L +321.887 178.724 L +322.042 178.471 L +322.198 178.22 L +322.354 177.968 L +322.509 177.717 L +322.665 177.467 L +322.82 177.217 L +322.976 176.968 L +323.132 176.719 L +323.288 176.471 L +323.443 176.223 L +323.599 175.976 L +323.754 175.729 L +323.91 175.483 L +324.066 175.237 L +324.221 174.992 L +324.377 174.747 L +324.533 174.503 L +324.688 174.259 L +324.844 174.016 L +325 173.773 L +325.155 173.531 L +325.311 173.29 L +325.467 173.049 L +325.622 172.808 L +325.778 172.568 L +325.934 172.329 L +326.089 172.09 L +326.245 171.852 L +326.401 171.614 L +326.556 171.377 L +326.712 171.14 L +326.868 170.904 L +327.023 170.669 L +327.179 170.434 L +327.335 170.199 L +327.49 169.966 L +327.646 169.732 L +327.802 169.5 L +327.957 169.268 L +328.113 169.036 L +328.269 168.805 L +328.424 168.575 L +328.58 168.345 L +328.736 168.116 L +328.891 167.887 L +329.047 167.659 L +329.203 167.432 L +329.358 167.205 L +329.514 166.979 L +329.67 166.753 L +329.825 166.528 L +329.981 166.304 L +330.137 166.08 L +330.292 165.857 L +330.448 165.634 L +330.604 165.412 L +330.759 165.191 L +330.915 164.97 L +331.071 164.75 L +331.226 164.53 L +331.382 164.312 L +331.538 164.093 L +331.693 163.876 L +331.849 163.659 L +332.005 163.442 L +332.16 163.226 L +332.316 163.011 L +332.472 162.797 L +332.627 162.583 L +332.783 162.37 L +332.939 162.157 L +333.094 161.945 L +333.25 161.734 L +333.406 161.523 L +333.561 161.313 L +333.717 161.104 L +333.873 160.895 L +334.028 160.687 L +334.184 160.48 L +334.34 160.273 L +334.495 160.067 L +334.651 159.862 L +334.807 159.657 L +334.962 159.453 L +335.118 159.249 L +335.274 159.047 L +335.429 158.845 L +335.585 158.643 L +335.741 158.443 L +335.896 158.242 L +336.052 158.043 L +336.208 157.844 L +336.363 157.646 L +336.519 157.449 L +336.675 157.253 L +336.83 157.057 L +336.986 156.861 L +337.142 156.667 L +337.297 156.473 L +337.453 156.28 L +337.609 156.087 L +337.764 155.896 L +337.92 155.705 L +338.076 155.514 L +338.231 155.325 L +338.387 155.136 L +338.543 154.948 L +338.698 154.76 L +338.854 154.573 L +339.01 154.387 L +339.165 154.202 L +339.321 154.017 L +339.477 153.833 L +339.632 153.65 L +339.788 153.468 L +339.944 153.286 L +340.099 153.105 L +340.255 152.925 L +340.411 152.745 L +340.566 152.566 L +340.722 152.388 L +340.878 152.211 L +341.033 152.034 L +341.189 151.858 L +341.345 151.683 L +341.5 151.509 L +341.656 151.335 L +341.812 151.162 L +341.967 150.99 L +342.123 150.818 L +342.279 150.648 L +342.434 150.478 L +342.59 150.309 L +342.746 150.14 L +342.901 149.973 L +343.057 149.806 L +343.212 149.64 L +343.368 149.474 L +343.524 149.31 L +343.68 149.146 L +343.835 148.983 L +343.991 148.82 L +344.146 148.659 L +344.302 148.498 L +344.458 148.338 L +344.613 148.179 L +344.769 148.02 L +344.925 147.863 L +345.08 147.706 L +345.236 147.55 L +345.392 147.394 L +345.547 147.24 L +345.703 147.086 L +345.859 146.933 L +346.014 146.781 L +346.17 146.629 L +346.326 146.479 L +346.481 146.329 L +346.637 146.18 L +346.793 146.031 L +346.948 145.884 L +347.104 145.737 L +347.26 145.592 L +347.415 145.446 L +347.571 145.302 L +347.727 145.159 L +347.882 145.016 L +348.038 144.874 L +348.194 144.733 L +348.349 144.593 L +348.505 144.453 L +348.661 144.315 L +348.816 144.177 L +348.972 144.04 L +349.128 143.904 L +349.283 143.768 L +349.439 143.634 L +349.595 143.5 L +349.75 143.367 L +349.906 143.235 L +350.062 143.104 L +350.217 142.973 L +350.373 142.844 L +350.529 142.715 L +350.684 142.587 L +350.84 142.46 L +350.996 142.334 L +351.151 142.208 L +351.307 142.083 L +351.463 141.96 L +351.618 141.837 L +351.774 141.714 L +351.93 141.593 L +352.085 141.473 L +352.241 141.353 L +352.397 141.234 L +352.552 141.116 L +352.708 140.999 L +352.864 140.883 L +353.019 140.767 L +353.175 140.653 L +353.331 140.539 L +353.486 140.426 L +353.642 140.314 L +353.798 140.203 L +353.953 140.092 L +354.109 139.983 L +354.265 139.874 L +354.42 139.766 L +354.576 139.66 L +354.732 139.553 L +354.887 139.448 L +355.043 139.344 L +355.199 139.24 L +355.354 139.138 L +355.51 139.036 L +355.666 138.935 L +355.821 138.835 L +355.977 138.736 L +356.133 138.637 L +356.288 138.54 L +356.444 138.443 L +356.6 138.347 L +356.755 138.252 L +356.911 138.158 L +357.067 138.065 L +357.222 137.973 L +357.378 137.882 L +357.534 137.791 L +357.689 137.701 L +357.845 137.613 L +358.001 137.525 L +358.156 137.438 L +358.312 137.351 L +358.468 137.266 L +358.623 137.182 L +358.779 137.098 L +358.935 137.015 L +359.09 136.934 L +359.246 136.853 L +359.402 136.773 L +359.557 136.694 L +359.713 136.615 L +359.869 136.538 L +360.024 136.462 L +360.18 136.386 L +360.336 136.311 L +360.491 136.237 L +360.647 136.164 L +360.803 136.092 L +360.958 136.021 L +361.114 135.951 L +361.27 135.882 L +361.425 135.813 L +361.581 135.745 L +361.737 135.679 L +361.892 135.613 L +362.048 135.548 L +362.204 135.484 L +362.359 135.421 L +362.515 135.359 L +362.671 135.297 L +362.826 135.237 L +362.982 135.177 L +363.138 135.119 L +363.293 135.061 L +363.449 135.004 L +363.604 134.948 L +363.76 134.893 L +363.916 134.839 L +364.071 134.786 L +364.227 134.733 L +364.383 134.682 L +364.538 134.631 L +364.694 134.582 L +364.85 134.533 L +365.005 134.485 L +365.161 134.438 L +365.317 134.392 L +365.472 134.347 L +365.628 134.303 L +365.784 134.259 L +365.939 134.217 L +366.095 134.175 L +366.251 134.135 L +366.406 134.095 L +366.562 134.056 L +366.718 134.018 L +366.873 133.981 L +367.029 133.945 L +367.185 133.91 L +367.34 133.876 L +367.496 133.843 L +367.652 133.81 L +367.807 133.779 L +367.963 133.748 L +368.119 133.718 L +368.274 133.689 L +368.43 133.662 L +368.586 133.635 L +368.741 133.609 L +368.897 133.583 L +369.053 133.559 L +369.208 133.536 L +369.364 133.514 L +369.52 133.492 L +369.675 133.471 L +369.831 133.452 L +369.987 133.433 L +370.142 133.415 L +370.298 133.398 L +370.454 133.382 L +370.609 133.367 L +370.765 133.353 L +370.921 133.34 L +371.076 133.327 L +371.232 133.316 L +371.388 133.305 L +371.543 133.296 L +371.699 133.287 L +371.855 133.279 L +372.01 133.272 L +372.166 133.266 L +372.322 133.261 L +372.477 133.257 L +372.633 133.254 L +372.789 133.252 L +372.944 133.25 L +373.1 133.25 L +373.256 133.25 L +373.411 133.252 L +373.567 133.254 L +373.723 133.257 L +373.878 133.261 L +374.034 133.266 L +374.19 133.272 L +374.345 133.279 L +374.501 133.287 L +374.657 133.296 L +374.812 133.305 L +374.968 133.316 L +375.124 133.327 L +375.279 133.34 L +375.435 133.353 L +375.591 133.367 L +375.746 133.382 L +375.902 133.398 L +376.058 133.415 L +376.213 133.433 L +376.369 133.452 L +376.525 133.471 L +376.68 133.492 L +376.836 133.514 L +376.992 133.536 L +377.147 133.559 L +377.303 133.583 L +377.459 133.609 L +377.614 133.635 L +377.77 133.662 L +377.926 133.689 L +378.081 133.718 L +378.237 133.748 L +378.393 133.779 L +378.548 133.81 L +378.704 133.843 L +378.86 133.876 L +379.015 133.91 L +379.171 133.945 L +379.327 133.981 L +379.482 134.018 L +379.638 134.056 L +379.794 134.095 L +379.949 134.135 L +380.105 134.175 L +380.261 134.217 L +380.416 134.259 L +380.572 134.303 L +380.728 134.347 L +380.883 134.392 L +381.039 134.438 L +381.195 134.485 L +381.35 134.533 L +381.506 134.582 L +381.662 134.631 L +381.817 134.682 L +381.973 134.733 L +382.129 134.786 L +382.284 134.839 L +382.44 134.893 L +382.596 134.948 L +382.751 135.004 L +382.907 135.061 L +383.063 135.119 L +383.218 135.177 L +383.374 135.237 L +383.529 135.297 L +383.685 135.359 L +383.841 135.421 L +383.996 135.484 L +384.152 135.548 L +384.308 135.613 L +384.463 135.679 L +384.619 135.745 L +384.775 135.813 L +384.93 135.882 L +385.086 135.951 L +385.242 136.021 L +385.397 136.092 L +385.553 136.164 L +385.709 136.237 L +385.864 136.311 L +386.02 136.386 L +386.176 136.462 L +386.331 136.538 L +386.487 136.615 L +386.643 136.694 L +386.798 136.773 L +386.954 136.853 L +387.11 136.934 L +387.265 137.015 L +387.421 137.098 L +387.577 137.182 L +387.732 137.266 L +387.888 137.351 L +388.044 137.438 L +388.199 137.525 L +388.355 137.613 L +388.511 137.701 L +388.666 137.791 L +388.822 137.882 L +388.978 137.973 L +389.133 138.065 L +389.289 138.158 L +389.445 138.252 L +389.6 138.347 L +389.756 138.443 L +389.912 138.54 L +390.067 138.637 L +390.223 138.736 L +390.379 138.835 L +390.534 138.935 L +390.69 139.036 L +390.846 139.138 L +391.001 139.24 L +391.157 139.344 L +391.313 139.448 L +391.468 139.553 L +391.624 139.66 L +391.78 139.766 L +391.935 139.874 L +392.091 139.983 L +392.247 140.092 L +392.402 140.203 L +392.558 140.314 L +392.714 140.426 L +392.869 140.539 L +393.025 140.653 L +393.181 140.767 L +393.336 140.883 L +393.492 140.999 L +393.648 141.116 L +393.803 141.234 L +393.959 141.353 L +394.115 141.473 L +394.27 141.593 L +394.426 141.714 L +394.582 141.837 L +394.737 141.96 L +394.893 142.083 L +395.049 142.208 L +395.204 142.334 L +395.36 142.46 L +395.516 142.587 L +395.671 142.715 L +395.827 142.844 L +395.983 142.973 L +396.138 143.104 L +396.294 143.235 L +396.45 143.367 L +396.605 143.5 L +396.761 143.634 L +396.917 143.768 L +397.072 143.904 L +397.228 144.04 L +397.384 144.177 L +397.539 144.315 L +397.695 144.453 L +397.851 144.593 L +398.006 144.733 L +398.162 144.874 L +398.318 145.016 L +398.473 145.159 L +398.629 145.302 L +398.785 145.446 L +398.94 145.592 L +399.096 145.737 L +399.252 145.884 L +399.407 146.031 L +399.563 146.18 L +399.719 146.329 L +399.874 146.479 L +400.03 146.629 L +400.186 146.781 L +400.341 146.933 L +400.497 147.086 L +400.653 147.24 L +400.808 147.394 L +400.964 147.55 L +401.12 147.706 L +401.275 147.863 L +401.431 148.02 L +401.587 148.179 L +401.742 148.338 L +401.898 148.498 L +402.054 148.659 L +402.209 148.82 L +402.365 148.983 L +402.521 149.146 L +402.676 149.31 L +402.832 149.474 L +402.987 149.64 L +403.143 149.806 L +403.299 149.973 L +403.454 150.14 L +403.61 150.309 L +403.766 150.478 L +403.921 150.648 L +404.077 150.818 L +404.233 150.99 L +404.388 151.162 L +404.544 151.335 L +404.7 151.509 L +404.855 151.683 L +405.011 151.858 L +405.167 152.034 L +405.322 152.211 L +405.478 152.388 L +405.634 152.566 L +405.789 152.745 L +405.945 152.925 L +406.101 153.105 L +406.256 153.286 L +406.412 153.468 L +406.568 153.65 L +406.723 153.833 L +406.879 154.017 L +407.035 154.202 L +407.19 154.387 L +407.346 154.573 L +407.502 154.76 L +407.657 154.948 L +407.813 155.136 L +407.969 155.325 L +408.124 155.514 L +408.28 155.705 L +408.436 155.896 L +408.591 156.087 L +408.747 156.28 L +408.903 156.473 L +409.058 156.667 L +409.214 156.861 L +409.37 157.057 L +409.525 157.253 L +409.681 157.449 L +409.837 157.646 L +409.992 157.844 L +410.148 158.043 L +410.304 158.242 L +410.459 158.443 L +410.615 158.643 L +410.771 158.845 L +410.926 159.047 L +411.082 159.249 L +411.238 159.453 L +411.393 159.657 L +411.549 159.862 L +411.705 160.067 L +411.86 160.273 L +412.016 160.48 L +412.172 160.687 L +412.327 160.895 L +412.483 161.104 L +412.639 161.313 L +412.794 161.523 L +412.95 161.734 L +413.106 161.945 L +413.261 162.157 L +413.417 162.37 L +413.573 162.583 L +413.728 162.797 L +413.884 163.011 L +414.04 163.226 L +414.195 163.442 L +414.351 163.659 L +414.507 163.876 L +414.662 164.093 L +414.818 164.312 L +414.974 164.53 L +415.129 164.75 L +415.285 164.97 L +415.441 165.191 L +415.596 165.412 L +415.752 165.634 L +415.908 165.857 L +416.063 166.08 L +416.219 166.304 L +416.375 166.528 L +416.53 166.753 L +416.686 166.979 L +416.842 167.205 L +416.997 167.432 L +417.153 167.659 L +417.309 167.887 L +417.464 168.116 L +417.62 168.345 L +417.776 168.575 L +417.931 168.805 L +418.087 169.036 L +418.243 169.268 L +418.398 169.5 L +418.554 169.732 L +418.71 169.966 L +418.865 170.199 L +419.021 170.434 L +419.177 170.669 L +419.332 170.904 L +419.488 171.14 L +419.644 171.377 L +419.799 171.614 L +419.955 171.852 L +420.111 172.09 L +420.266 172.329 L +420.422 172.568 L +420.578 172.808 L +420.733 173.049 L +420.889 173.29 L +421.045 173.531 L +421.2 173.773 L +421.356 174.016 L +421.512 174.259 L +421.667 174.503 L +421.823 174.747 L +421.979 174.992 L +422.134 175.237 L +422.29 175.483 L +422.445 175.729 L +422.601 175.976 L +422.757 176.223 L +422.913 176.471 L +423.068 176.719 L +423.224 176.968 L +423.379 177.217 L +423.535 177.467 L +423.691 177.717 L +423.846 177.968 L +424.002 178.22 L +424.158 178.471 L +424.313 178.724 L +424.469 178.977 L +424.625 179.23 L +424.78 179.484 L +424.936 179.738 L +425.092 179.993 L +425.247 180.248 L +425.403 180.504 L +425.559 180.76 L +425.714 181.016 L +425.87 181.273 L +426.026 181.531 L +426.181 181.789 L +426.337 182.047 L +426.493 182.306 L +426.648 182.566 L +426.804 182.825 L +426.96 183.086 L +427.115 183.346 L +427.271 183.608 L +427.427 183.869 L +427.582 184.131 L +427.738 184.394 L +427.894 184.657 L +428.049 184.92 L +428.205 185.184 L +428.361 185.448 L +428.516 185.713 L +428.672 185.978 L +428.828 186.243 L +428.983 186.509 L +429.139 186.775 L +429.295 187.042 L +429.45 187.309 L +429.606 187.577 L +429.762 187.845 L +429.917 188.113 L +430.073 188.382 L +430.229 188.651 L +430.384 188.92 L +430.54 189.19 L +430.696 189.46 L +430.851 189.731 L +431.007 190.002 L +431.163 190.274 L +431.318 190.546 L +431.474 190.818 L +431.63 191.09 L +431.785 191.363 L +431.941 191.637 L +432.097 191.91 L +432.252 192.184 L +432.408 192.459 L +432.564 192.733 L +432.719 193.009 L +432.875 193.284 L +433.031 193.56 L +433.186 193.836 L +433.342 194.113 L +433.498 194.389 L +433.653 194.667 L +433.809 194.944 L +433.965 195.222 L +434.12 195.5 L +434.276 195.779 L +434.432 196.058 L +434.587 196.337 L +434.743 196.616 L +434.899 196.896 L +435.054 197.176 L +435.21 197.457 L +435.366 197.737 L +435.521 198.019 L +435.677 198.3 L +435.833 198.582 L +435.988 198.864 L +436.144 199.146 L +436.3 199.428 L +436.455 199.711 L +436.611 199.994 L +436.767 200.278 L +436.922 200.562 L +437.078 200.846 L +437.234 201.13 L +437.389 201.414 L +437.545 201.699 L +437.701 201.984 L +437.856 202.27 L +438.012 202.555 L +438.168 202.841 L +438.323 203.128 L +438.479 203.414 L +438.635 203.701 L +438.79 203.988 L +438.946 204.275 L +439.102 204.562 L +439.257 204.85 L +439.413 205.138 L +439.569 205.426 L +439.724 205.714 L +439.88 206.003 L +440.036 206.292 L +440.191 206.581 L +440.347 206.87 L +440.503 207.16 L +440.658 207.449 L +440.814 207.739 L +440.97 208.03 L +441.125 208.32 L +441.281 208.611 L +441.437 208.901 L +441.592 209.192 L +441.748 209.484 L +441.904 209.775 L +442.059 210.067 L +442.215 210.358 L +442.371 210.65 L +442.526 210.943 L +442.682 211.235 L +442.837 211.527 L +442.993 211.82 L +443.149 212.113 L +443.305 212.406 L +443.46 212.699 L +443.616 212.993 L +443.771 213.286 L +443.927 213.58 L +444.083 213.874 L +444.238 214.168 L +444.394 214.462 L +444.55 214.757 L +444.705 215.051 L +444.861 215.346 L +445.017 215.64 L +445.172 215.935 L +445.328 216.23 L +445.484 216.526 L +445.639 216.821 L +445.795 217.116 L +445.951 217.412 L +446.106 217.708 L +446.262 218.004 L +446.418 218.299 L +446.573 218.596 L +446.729 218.892 L +446.885 219.188 L +447.04 219.484 L +447.196 219.781 L +447.352 220.077 L +447.507 220.374 L +447.663 220.671 L +447.819 220.968 L +447.974 221.265 L +448.13 221.562 L +448.286 221.859 L +448.441 222.156 L +448.597 222.454 L +448.753 222.751 L +448.908 223.048 L +449.064 223.346 L +449.22 223.643 L +449.375 223.941 L +449.531 224.239 L +449.687 224.537 L +449.842 224.834 L +449.998 225.132 L +450.154 225.43 L +450.309 225.728 L +450.465 226.026 L +450.621 226.324 L +450.776 226.622 L +450.932 226.921 L +451.088 227.219 L +451.243 227.517 L +451.399 227.815 L +451.555 228.113 L +451.71 228.412 L +451.866 228.71 L +452.022 229.008 L +452.177 229.307 L +452.333 229.605 L +452.489 229.903 L +452.644 230.202 L +452.8 230.5 L +452.956 229.605 L +453.111 228.71 L +453.267 227.816 L +453.423 226.922 L +453.578 226.028 L +453.734 225.136 L +453.89 224.245 L +454.045 223.354 L +454.201 222.466 L +454.357 221.579 L +454.512 220.693 L +454.668 219.81 L +454.824 218.929 L +454.979 218.05 L +455.135 217.173 L +455.291 216.299 L +455.446 215.428 L +455.602 214.56 L +455.758 213.695 L +455.913 212.834 L +456.069 211.976 L +456.225 211.121 L +456.38 210.271 L +456.536 209.424 L +456.692 208.582 L +456.847 207.744 L +457.003 206.91 L +457.159 206.081 L +457.314 205.257 L +457.47 204.438 L +457.626 203.625 L +457.781 202.816 L +457.937 202.013 L +458.093 201.216 L +458.248 200.425 L +458.404 199.639 L +458.56 198.86 L +458.715 198.087 L +458.871 197.321 L +459.027 196.561 L +459.182 195.808 L +459.338 195.062 L +459.494 194.323 L +459.649 193.591 L +459.805 192.867 L +459.961 192.15 L +460.116 191.441 L +460.272 190.74 L +460.428 190.047 L +460.583 189.362 L +460.739 188.685 L +460.895 188.017 L +461.05 187.357 L +461.206 186.707 L +461.362 186.064 L +461.517 185.431 L +461.673 184.807 L +461.829 184.193 L +461.984 183.587 L +462.14 182.992 L +462.296 182.405 L +462.451 181.829 L +462.607 181.263 L +462.763 180.706 L +462.918 180.16 L +463.074 179.624 L +463.229 179.099 L +463.385 178.584 L +463.541 178.08 L +463.696 177.586 L +463.852 177.104 L +464.008 176.632 L +464.163 176.172 L +464.319 175.723 L +464.475 175.285 L +464.63 174.858 L +464.786 174.444 L +464.942 174.04 L +465.097 173.649 L +465.253 173.269 L +465.409 172.902 L +465.564 172.546 L +465.72 172.203 L +465.876 171.872 L +466.031 171.553 L +466.187 171.246 L +466.343 170.952 L +466.498 170.671 L +466.654 170.402 L +466.81 170.146 L +466.965 169.903 L +467.121 169.673 L +467.277 169.456 L +467.432 169.252 L +467.588 169.061 L +467.744 168.883 L +467.899 168.718 L +468.055 168.567 L +468.211 168.429 L +468.366 168.305 L +468.522 168.194 L +468.678 168.097 L +468.833 168.013 L +468.989 167.943 L +469.145 167.887 L +469.3 167.844 L +469.456 167.816 L +469.612 167.801 L +469.767 167.8 L +469.923 167.813 L +470.079 167.84 L +470.234 167.881 L +470.39 167.936 L +470.546 168.006 L +470.701 168.089 L +470.857 168.186 L +471.013 168.298 L +471.168 168.424 L +471.324 168.564 L +471.48 168.718 L +471.635 168.887 L +471.791 169.069 L +471.947 169.266 L +472.102 169.478 L +472.258 169.703 L +472.414 169.943 L +472.569 170.197 L +472.725 170.466 L +472.881 170.749 L +473.036 171.046 L +473.192 171.357 L +473.348 171.683 L +473.503 172.023 L +473.659 172.377 L +473.815 172.745 L +473.97 173.128 L +474.126 173.525 L +474.282 173.936 L +474.437 174.361 L +474.593 174.8 L +474.749 175.254 L +474.904 175.721 L +475.06 176.203 L +475.216 176.698 L +475.371 177.208 L +475.527 177.731 L +475.683 178.269 L +475.838 178.82 L +475.994 179.385 L +476.15 179.964 L +476.305 180.556 L +476.461 181.162 L +476.617 181.782 L +476.772 182.415 L +476.928 183.062 L +477.084 183.722 L +477.239 184.396 L +477.395 185.083 L +477.551 185.783 L +477.706 186.496 L +477.862 187.222 L +478.018 187.962 L +478.173 188.714 L +478.329 189.479 L +478.485 190.257 L +478.64 191.048 L +478.796 191.852 L +478.952 192.668 L +479.107 193.496 L +479.263 194.337 L +479.419 195.19 L +479.574 196.055 L +479.73 196.932 L +479.886 197.822 L +480.041 198.723 L +480.197 199.636 L +480.353 200.561 L +480.508 201.497 L +480.664 202.445 L +480.82 203.404 L +480.975 204.375 L +481.131 205.357 L +481.287 206.35 L +481.442 207.353 L +481.598 208.368 L +481.754 209.393 L +481.909 210.429 L +482.065 211.475 L +482.221 212.532 L +482.376 213.599 L +482.532 214.676 L +482.688 215.763 L +482.843 216.86 L +482.999 217.967 L +483.154 219.083 L +483.31 220.208 L +483.466 221.343 L +483.621 222.487 L +483.777 223.641 L +483.933 224.803 L +484.088 225.973 L +484.244 227.153 L +484.4 228.341 L +484.555 229.537 L +484.711 230.742 L +484.867 231.954 L +485.022 233.174 L +485.178 234.403 L +485.334 235.638 L +485.489 236.881 L +485.645 238.132 L +485.801 239.389 L +485.956 240.654 L +486.112 241.925 L +486.268 243.203 L +486.423 244.488 L +486.579 245.779 L +486.735 247.076 L +486.89 248.379 L +487.046 249.688 L +487.202 251.002 L +487.357 252.323 L +487.513 253.648 L +487.669 254.979 L +487.824 256.314 L +487.98 257.655 L +488.136 259 L +488.291 260.35 L +488.447 261.704 L +488.603 263.062 L +488.758 264.425 L +488.914 265.791 L +489.07 267.161 L +489.225 268.534 L +489.381 269.91 L +489.537 271.29 L +489.692 272.673 L +489.848 274.058 L +490.004 275.446 L +490.159 276.837 L +490.315 278.229 L +490.471 279.624 L +490.626 281.021 L +490.782 282.419 L +490.938 283.819 L +491.093 285.22 L +491.249 286.622 L +491.405 288.026 L +491.56 289.43 L +491.716 290.835 L +491.872 292.24 L +492.027 293.645 L +492.183 295.051 L +492.339 296.456 L +492.494 297.861 L +492.65 299.266 L +492.806 300.67 L +492.961 302.073 L +493.117 303.476 L +493.273 304.877 L +493.428 306.276 L +493.584 307.674 L +493.74 309.071 L +493.895 310.465 L +494.051 311.858 L +494.207 313.248 L +494.362 314.635 L +494.518 316.02 L +494.674 317.402 L +494.829 318.781 L +494.985 320.157 L +495.141 321.53 L +495.296 322.899 L +495.452 324.264 L +495.608 325.626 L +495.763 326.983 L +495.919 328.336 L +496.075 329.685 L +496.23 331.029 L +496.386 332.369 L +496.542 333.703 L +496.697 335.033 L +496.853 336.357 L +497.009 337.675 L +497.164 338.988 L +497.32 340.295 L +497.476 341.596 L +497.631 342.891 L +497.787 344.18 L +497.943 345.462 L +498.098 346.738 L +498.254 348.006 L +498.41 349.268 L +498.565 350.523 L +498.721 351.77 L +498.877 353.01 L +499.032 354.242 L +499.188 355.467 L +499.344 356.683 L +499.499 357.892 L +499.655 359.092 L +499.811 360.284 L +499.966 361.467 L +500.122 362.641 L +500.278 363.807 L +500.433 364.963 L +500.589 366.111 L +500.745 367.249 L +500.9 368.377 L +501.056 369.496 L +501.212 370.606 L +501.367 371.705 L +501.523 372.794 L +501.679 373.873 L +501.834 374.942 L +501.99 376 L +502.146 377.048 L +502.301 378.085 L +502.457 379.111 L +502.612 380.127 L +502.768 381.131 L +502.924 382.123 L +503.079 383.105 L +503.235 384.075 L +503.391 385.033 L +503.546 385.98 L +503.702 386.915 L +503.858 387.837 L +504.013 388.748 L +504.169 389.646 L +504.325 390.533 L +504.48 391.406 L +504.636 392.267 L +504.792 393.116 L +504.947 393.952 L +505.103 394.775 L +505.259 395.584 L +505.414 396.381 L +505.57 397.165 L +505.726 397.935 L +505.881 398.693 L +506.037 399.436 L +506.193 400.166 L +506.348 400.883 L +506.504 401.586 L +506.66 402.275 L +506.815 402.95 L +506.971 403.611 L +507.127 404.258 L +507.282 404.891 L +507.438 405.51 L +507.594 406.114 L +507.749 406.704 L +507.905 407.28 L +508.061 407.841 L +508.216 408.388 L +508.372 408.92 L +508.528 409.438 L +508.683 409.941 L +508.839 410.428 L +508.995 410.902 L +509.15 411.36 L +509.306 411.803 L +509.462 412.232 L +509.617 412.645 L +509.773 413.043 L +509.929 413.426 L +510.084 413.794 L +510.24 414.147 L +510.396 414.485 L +510.551 414.807 L +510.707 415.114 L +510.863 415.406 L +511.018 415.682 L +511.174 415.943 L +511.33 416.189 L +511.485 416.419 L +511.641 416.634 L +511.797 416.833 L +511.952 417.017 L +512.108 417.185 L +512.264 417.338 L +512.419 417.475 L +512.575 417.597 L +512.731 417.704 L +512.886 417.795 L +513.042 417.87 L +513.198 417.93 L +513.353 417.975 L +513.509 418.004 L +513.665 418.017 L +513.82 418.015 L +513.976 417.998 L +514.132 417.965 L +514.287 417.917 L +514.443 417.854 L +514.599 417.775 L +514.754 417.681 L +514.91 417.571 L +515.066 417.447 L +515.221 417.307 L +515.377 417.151 L +515.533 416.981 L +515.688 416.796 L +515.844 416.595 L +516 416.38 L +516.155 416.149 L +516.311 415.904 L +516.467 415.644 L +516.622 415.369 L +516.778 415.079 L +516.934 414.774 L +517.089 414.455 L +517.245 414.121 L +517.401 413.773 L +517.556 413.41 L +517.712 413.032 L +517.868 412.641 L +518.023 412.235 L +518.179 411.815 L +518.335 411.381 L +518.49 410.932 L +518.646 410.47 L +518.802 409.994 L +518.957 409.504 L +519.113 409.001 L +519.269 408.483 L +519.424 407.953 L +519.58 407.408 L +519.736 406.851 L +519.891 406.28 L +520.047 405.696 L +520.203 405.099 L +520.358 404.489 L +520.514 403.866 L +520.67 403.23 L +520.825 402.582 L +520.981 401.921 L +521.137 401.248 L +521.292 400.562 L +521.448 399.864 L +521.604 399.155 L +521.759 398.433 L +521.915 397.699 L +522.07 396.953 L +522.226 396.196 L +522.382 395.428 L +522.537 394.647 L +522.693 393.856 L +522.849 393.054 L +523.005 392.24 L +523.16 391.416 L +523.316 390.581 L +523.471 389.736 L +523.627 388.879 L +523.783 388.013 L +523.938 387.136 L +524.094 386.25 L +524.25 385.353 L +524.405 384.447 L +524.561 383.531 L +524.717 382.605 L +524.872 381.671 L +525.028 380.727 L +525.184 379.774 L +525.339 378.812 L +525.495 377.841 L +525.651 376.862 L +525.806 375.874 L +525.962 374.878 L +526.118 373.874 L +526.273 372.862 L +526.429 371.842 L +526.585 370.815 L +526.74 369.78 L +526.896 368.737 L +527.052 367.688 L +527.207 366.631 L +527.363 365.568 L +527.519 364.498 L +527.674 363.421 L +527.83 362.338 L +527.986 361.249 L +528.141 360.154 L +528.297 359.053 L +528.453 357.946 L +528.608 356.834 L +528.764 355.717 L +528.92 354.594 L +529.075 353.466 L +529.231 352.334 L +529.387 351.197 L +529.542 350.055 L +529.698 348.909 L +529.854 347.759 L +530.009 346.605 L +530.165 345.448 L +530.321 344.286 L +530.476 343.122 L +530.632 341.954 L +530.788 340.783 L +530.943 339.609 L +531.099 338.432 L +531.255 337.253 L +531.41 336.071 L +531.566 334.888 L +531.722 333.702 L +531.877 332.514 L +532.033 331.325 L +532.189 330.135 L +532.344 328.943 L +532.5 327.75 L +532.656 326.556 L +532.811 325.362 L +532.967 324.166 L +533.123 322.971 L +533.278 321.775 L +533.434 320.579 L +533.59 319.384 L +533.745 318.189 L +533.901 316.994 L +534.057 315.8 L +534.212 314.607 L +534.368 313.415 L +534.524 312.224 L +534.679 311.034 L +534.835 309.846 L +534.991 308.66 L +535.146 307.476 L +535.302 306.294 L +535.458 305.114 L +535.613 303.937 L +535.769 302.763 L +535.925 301.591 L +536.08 300.422 L +536.236 299.256 L +536.392 298.094 L +536.547 296.935 L +536.703 295.78 L +536.859 294.629 L +537.014 293.482 L +537.17 292.339 L +537.326 291.2 L +537.481 290.066 L +537.637 288.936 L +537.793 287.812 L +537.948 286.692 L +538.104 285.578 L +538.26 284.469 L +538.415 283.365 L +538.571 282.267 L +538.727 281.175 L +538.882 280.089 L +539.038 279.009 L +539.194 277.936 L +539.349 276.869 L +539.505 275.808 L +539.661 274.755 L +539.816 273.708 L +539.972 272.668 L +540.128 271.636 L +540.283 270.611 L +540.439 269.593 L +540.595 268.583 L +540.75 267.581 L +540.906 266.587 L +541.062 265.601 L +541.217 264.624 L +541.373 263.654 L +541.529 262.693 L +541.684 261.741 L +541.84 260.798 L +541.995 259.863 L +542.151 258.938 L +542.307 258.022 L +542.463 257.115 L +542.618 256.218 L +542.774 255.33 L +542.93 254.452 L +543.085 253.584 L +543.241 252.726 L +543.396 251.877 L +543.552 251.039 L +543.708 250.212 L +543.863 249.395 L +544.019 248.588 L +544.175 247.792 L +544.33 247.006 L +544.486 246.232 L +544.642 245.469 L +544.797 244.716 L +544.953 243.975 L +545.109 243.245 L +545.264 242.527 L +545.42 241.82 L +545.576 241.124 L +545.731 240.441 L +545.887 239.769 L +546.043 239.109 L +546.198 238.46 L +546.354 237.824 L +546.51 237.2 L +546.665 236.588 L +546.821 235.989 L +546.977 235.402 L +547.132 234.827 L +547.288 234.265 L +547.444 233.715 L +547.599 233.178 L +547.755 232.654 L +547.911 232.142 L +548.066 231.644 L +548.222 231.158 L +548.378 230.685 L +548.533 230.226 L +548.689 229.779 L +548.845 229.346 L +549 228.925 L +549.156 228.518 L +549.312 228.125 L +549.467 227.744 L +549.623 227.377 L +549.779 227.024 L +549.934 226.684 L +550.09 226.357 L +550.246 226.044 L +550.401 225.745 L +550.557 225.459 L +550.713 225.187 L +550.868 224.928 L +551.024 224.683 L +551.18 224.452 L +551.335 224.234 L +551.491 224.031 L +551.647 223.841 L +551.802 223.664 L +551.958 223.502 L +552.114 223.353 L +552.269 223.218 L +552.425 223.097 L +552.581 222.99 L +552.736 222.897 L +552.892 222.817 L +553.048 222.751 L +553.203 222.699 L +553.359 222.661 L +553.515 222.636 L +553.67 222.625 L +553.826 222.628 L +553.982 222.645 L +554.137 222.675 L +554.293 222.719 L +554.449 222.777 L +554.604 222.848 L +554.76 222.933 L +554.916 223.032 L +555.071 223.144 L +555.227 223.269 L +555.383 223.408 L +555.538 223.561 L +555.694 223.726 L +555.85 223.906 L +556.005 224.098 L +556.161 224.304 L +556.317 224.522 L +556.472 224.755 L +556.628 225 L +556.784 225.258 L +556.939 225.529 L +557.095 225.813 L +557.251 226.11 L +557.406 226.42 L +557.562 226.742 L +557.718 227.077 L +557.873 227.425 L +558.029 227.785 L +558.185 228.157 L +558.34 228.542 L +558.496 228.94 L +558.652 229.349 L +558.807 229.771 L +558.963 230.204 L +559.119 230.65 L +559.274 231.107 L +559.43 231.576 L +559.586 232.057 L +559.741 232.55 L +559.897 233.054 L +560.053 233.569 L +560.208 234.096 L +560.364 234.633 L +560.52 235.182 L +560.675 235.742 L +560.831 236.313 L +560.987 236.895 L +561.142 237.487 L +561.298 238.089 L +561.453 238.703 L +561.609 239.326 L +561.765 239.96 L +561.921 240.604 L +562.076 241.257 L +562.232 241.921 L +562.388 242.594 L +562.543 243.277 L +562.699 243.97 L +562.854 244.671 L +563.01 245.382 L +563.166 246.102 L +563.321 246.831 L +563.477 247.569 L +563.633 248.315 L +563.788 249.07 L +563.944 249.834 L +564.1 250.605 L +564.255 251.385 L +564.411 252.173 L +564.567 252.969 L +564.722 253.772 L +564.878 254.583 L +565.034 255.401 L +565.189 256.226 L +565.345 257.059 L +565.501 257.899 L +565.656 258.745 L +565.812 259.598 L +565.968 260.458 L +566.123 261.323 L +566.279 262.195 L +566.435 263.073 L +566.59 263.957 L +566.746 264.847 L +566.902 265.742 L +567.057 266.643 L +567.213 267.548 L +567.369 268.459 L +567.524 269.375 L +567.68 270.296 L +567.836 271.221 L +567.991 272.15 L +568.147 273.084 L +568.303 274.021 L +568.458 274.963 L +568.614 275.908 L +568.77 276.857 L +568.925 277.81 L +569.081 278.765 L +569.237 279.724 L +569.392 280.685 L +569.548 281.649 L +569.704 282.616 L +569.859 283.585 L +570.015 284.556 L +570.171 285.529 L +570.326 286.504 L +570.482 287.481 L +570.638 288.459 L +570.793 289.439 L +570.949 290.419 L +571.105 291.401 L +571.26 292.383 L +571.416 293.366 L +571.572 294.349 L +571.727 295.333 L +571.883 296.317 L +572.039 297.3 L +572.194 298.283 L +572.35 299.266 L +572.506 300.248 L +572.661 301.23 L +572.817 302.21 L +572.973 303.189 L +573.128 304.167 L +573.284 305.143 L +573.44 306.117 L +573.595 307.09 L +573.751 308.061 L +573.907 309.029 L +574.062 309.995 L +574.218 310.958 L +574.374 311.918 L +574.529 312.876 L +574.685 313.831 L +574.841 314.782 L +574.996 315.729 L +575.152 316.673 L +575.308 317.614 L +575.463 318.55 L +575.619 319.482 L +575.775 320.41 L +575.93 321.333 L +576.086 322.251 L +576.242 323.165 L +576.397 324.074 L +576.553 324.977 L +576.709 325.875 L +576.864 326.768 L +577.02 327.655 L +577.176 328.536 L +577.331 329.411 L +577.487 330.28 L +577.643 331.142 L +577.798 331.998 L +577.954 332.847 L +578.11 333.69 L +578.265 334.525 L +578.421 335.354 L +578.577 336.175 L +578.732 336.988 L +578.888 337.794 L +579.044 338.592 L +579.199 339.382 L +579.355 340.165 L +579.511 340.938 L +579.666 341.704 L +579.822 342.461 L +579.978 343.209 L +580.133 343.949 L +580.289 344.679 L +580.445 345.401 L +580.6 346.113 L +580.756 346.815 L +580.911 347.509 L +581.067 348.192 L +581.223 348.866 L +581.379 349.529 L +581.534 350.183 L +581.69 350.827 L +581.846 351.46 L +582.001 352.082 L +582.157 352.694 L +582.313 353.295 L +582.468 353.886 L +582.624 354.465 L +582.779 355.033 L +582.935 355.59 L +583.091 356.136 L +583.246 356.67 L +583.402 357.193 L +583.558 357.704 L +583.714 358.203 L +583.869 358.69 L +584.025 359.165 L +584.18 359.628 L +584.336 360.079 L +584.492 360.517 L +584.647 360.943 L +584.803 361.357 L +584.959 361.758 L +585.114 362.146 L +585.27 362.521 L +585.426 362.883 L +585.581 363.232 L +585.737 363.569 L +585.893 363.892 L +586.048 364.201 L +586.204 364.497 L +586.36 364.78 L +586.515 365.05 L +586.671 365.305 L +586.827 365.547 L +586.982 365.776 L +587.138 365.99 L +587.294 366.191 L +587.449 366.377 L +587.605 366.55 L +587.761 366.708 L +587.916 366.853 L +588.072 366.983 L +588.228 367.099 L +588.383 367.2 L +588.539 367.287 L +588.695 367.36 L +588.85 367.418 L +589.006 367.462 L +589.162 367.491 L +589.317 367.506 L +589.473 367.505 L +589.629 367.491 L +589.784 367.461 L +589.94 367.417 L +590.096 367.358 L +590.251 367.284 L +590.407 367.195 L +590.563 367.092 L +590.718 366.973 L +590.874 366.84 L +591.03 366.691 L +591.185 366.528 L +591.341 366.35 L +591.497 366.157 L +591.652 365.949 L +591.808 365.725 L +591.964 365.487 L +592.119 365.234 L +592.275 364.966 L +592.431 364.683 L +592.586 364.385 L +592.742 364.072 L +592.898 363.743 L +593.053 363.4 L +593.209 363.042 L +593.365 362.669 L +593.52 362.281 L +593.676 361.879 L +593.832 361.461 L +593.987 361.029 L +594.143 360.581 L +594.299 360.119 L +594.454 359.642 L +594.61 359.15 L +594.766 358.644 L +594.921 358.123 L +595.077 357.587 L +595.233 357.037 L +595.388 356.472 L +595.544 355.893 L +595.7 355.299 L +595.855 354.691 L +596.011 354.068 L +596.167 353.431 L +596.322 352.78 L +596.478 352.115 L +596.634 351.435 L +596.789 350.742 L +596.945 350.034 L +597.101 349.313 L +597.256 348.577 L +597.412 347.828 L +597.568 347.066 L +597.723 346.289 L +597.879 345.499 L +598.035 344.695 L +598.19 343.878 L +598.346 343.048 L +598.502 342.205 L +598.657 341.348 L +598.813 340.478 L +598.969 339.595 L +599.124 338.7 L +599.28 337.791 L +599.436 336.87 L +599.591 335.936 L +599.747 334.99 L +599.903 334.032 L +600.058 333.061 L +600.214 332.078 L +600.37 331.082 L +600.525 330.075 L +600.681 329.056 L +600.837 328.025 L +600.992 326.983 L +601.148 325.929 L +601.304 324.864 L +601.459 323.787 L +601.615 322.699 L +601.771 321.6 L +601.926 320.49 L +602.082 319.37 L +602.237 318.239 L +602.393 317.097 L +602.549 315.945 L +602.704 314.782 L +602.86 313.61 L +603.016 312.427 L +603.172 311.235 L +603.327 310.033 L +603.483 308.821 L +603.638 307.6 L +603.794 306.369 L +603.95 305.129 L +604.105 303.881 L +604.261 302.623 L +604.417 301.357 L +604.572 300.082 L +604.728 298.799 L +604.884 297.507 L +605.039 296.208 L +605.195 294.9 L +605.351 293.584 L +605.506 292.261 L +605.662 290.931 L +605.818 289.593 L +605.973 288.248 L +606.129 286.896 L +606.285 285.537 L +606.44 284.171 L +606.596 282.799 L +606.752 281.42 L +606.907 280.036 L +607.063 278.645 L +607.219 277.248 L +607.374 275.846 L +607.53 274.438 L +607.686 273.025 L +607.841 271.606 L +607.997 270.183 L +608.153 268.755 L +608.308 267.322 L +608.464 265.884 L +608.62 264.443 L +608.775 262.997 L +608.931 261.547 L +609.087 260.093 L +609.242 258.636 L +609.398 257.175 L +609.554 255.711 L +609.709 254.244 L +609.865 252.774 L +610.021 251.302 L +610.176 249.827 L +610.332 248.349 L +610.488 246.869 L +610.643 245.388 L +610.799 243.904 L +610.955 242.419 L +611.11 240.932 L +611.266 239.444 L +611.422 237.955 L +611.577 236.465 L +611.733 234.975 L +611.889 233.483 L +612.044 231.992 L +612.2 230.5 L +612.356 229.008 L +612.511 227.517 L +612.667 226.025 L +612.823 224.535 L +612.978 223.045 L +613.134 221.556 L +613.29 220.068 L +613.445 218.581 L +613.601 217.096 L +613.757 215.612 L +613.912 214.131 L +614.068 212.651 L +614.224 211.173 L +614.379 209.698 L +614.535 208.226 L +614.691 206.756 L +614.846 205.289 L +615.002 203.825 L +615.158 202.364 L +615.313 200.907 L +615.469 199.453 L +615.625 198.003 L +615.78 196.557 L +615.936 195.116 L +616.092 193.678 L +616.247 192.245 L +616.403 190.817 L +616.559 189.394 L +616.714 187.975 L +616.87 186.562 L +617.026 185.154 L +617.181 183.752 L +617.337 182.355 L +617.493 180.964 L +617.648 179.58 L +617.804 178.201 L +617.96 176.829 L +618.115 175.463 L +618.271 174.104 L +618.427 172.752 L +618.582 171.407 L +618.738 170.069 L +618.894 168.739 L +619.049 167.416 L +619.205 166.1 L +619.361 164.792 L +619.516 163.493 L +619.672 162.201 L +619.828 160.918 L +619.983 159.643 L +620.139 158.377 L +620.295 157.119 L +620.45 155.871 L +620.606 154.631 L +620.762 153.4 L +620.917 152.179 L +621.073 150.967 L +621.229 149.765 L +621.384 148.573 L +621.54 147.39 L +621.695 146.218 L +621.851 145.055 L +622.007 143.903 L +622.162 142.761 L +622.318 141.63 L +622.474 140.51 L +622.63 139.4 L +622.785 138.301 L +622.941 137.213 L +623.096 136.136 L +623.252 135.071 L +623.408 134.017 L +623.563 132.975 L +623.719 131.944 L +623.875 130.925 L +624.03 129.918 L +624.186 128.922 L +624.342 127.939 L +624.497 126.968 L +624.653 126.01 L +624.809 125.064 L +624.964 124.13 L +625.12 123.209 L +625.276 122.3 L +625.431 121.405 L +625.587 120.522 L +625.743 119.652 L +625.898 118.795 L +626.054 117.952 L +626.21 117.122 L +626.365 116.305 L +626.521 115.501 L +626.677 114.711 L +626.832 113.934 L +626.988 113.172 L +627.144 112.423 L +627.299 111.687 L +627.455 110.966 L +627.611 110.258 L +627.766 109.565 L +627.922 108.885 L +628.078 108.22 L +628.233 107.569 L +628.389 106.932 L +628.545 106.309 L +628.7 105.701 L +628.856 105.107 L +629.012 104.528 L +629.167 103.963 L +629.323 103.413 L +629.479 102.877 L +629.634 102.356 L +629.79 101.85 L +629.946 101.358 L +630.101 100.881 L +630.257 100.419 L +630.413 99.971 L +630.568 99.539 L +630.724 99.121 L +630.88 98.718 L +631.035 98.331 L +631.191 97.958 L +631.347 97.6 L +631.502 97.257 L +631.658 96.928 L +631.814 96.615 L +631.969 96.317 L +632.125 96.034 L +632.281 95.766 L +632.436 95.513 L +632.592 95.275 L +632.748 95.051 L +632.903 94.843 L +633.059 94.65 L +633.215 94.472 L +633.37 94.309 L +633.526 94.16 L +633.682 94.027 L +633.837 93.908 L +633.993 93.805 L +634.149 93.716 L +634.304 93.642 L +634.46 93.583 L +634.616 93.539 L +634.771 93.509 L +634.927 93.495 L +635.083 93.494 L +635.238 93.509 L +635.394 93.538 L +635.55 93.582 L +635.705 93.64 L +635.861 93.713 L +636.017 93.8 L +636.172 93.901 L +636.328 94.017 L +636.484 94.147 L +636.639 94.292 L +636.795 94.45 L +636.951 94.623 L +637.106 94.809 L +637.262 95.01 L +637.418 95.224 L +637.573 95.453 L +637.729 95.695 L +637.885 95.95 L +638.04 96.22 L +638.196 96.503 L +638.352 96.799 L +638.507 97.108 L +638.663 97.431 L +638.819 97.768 L +638.974 98.117 L +639.13 98.479 L +639.286 98.854 L +639.441 99.242 L +639.597 99.643 L +639.753 100.057 L +639.908 100.483 L +640.064 100.921 L +640.22 101.372 L +640.375 101.835 L +640.531 102.31 L +640.687 102.797 L +640.842 103.296 L +640.998 103.807 L +641.154 104.33 L +641.309 104.864 L +641.465 105.41 L +641.62 105.967 L +641.776 106.535 L +641.932 107.114 L +642.088 107.705 L +642.243 108.306 L +642.399 108.918 L +642.555 109.54 L +642.71 110.173 L +642.866 110.817 L +643.021 111.471 L +643.177 112.134 L +643.333 112.808 L +643.488 113.491 L +643.644 114.185 L +643.8 114.887 L +643.955 115.599 L +644.111 116.321 L +644.267 117.051 L +644.422 117.791 L +644.578 118.539 L +644.734 119.296 L +644.889 120.062 L +645.045 120.835 L +645.201 121.618 L +645.356 122.408 L +645.512 123.206 L +645.668 124.012 L +645.823 124.825 L +645.979 125.646 L +646.135 126.475 L +646.29 127.31 L +646.446 128.153 L +646.602 129.002 L +646.757 129.858 L +646.913 130.72 L +647.069 131.589 L +647.224 132.464 L +647.38 133.345 L +647.536 134.232 L +647.691 135.125 L +647.847 136.023 L +648.003 136.926 L +648.158 137.835 L +648.314 138.749 L +648.47 139.667 L +648.625 140.59 L +648.781 141.518 L +648.937 142.45 L +649.092 143.386 L +649.248 144.327 L +649.404 145.271 L +649.559 146.218 L +649.715 147.17 L +649.871 148.124 L +650.026 149.081 L +650.182 150.042 L +650.338 151.005 L +650.493 151.971 L +650.649 152.939 L +650.805 153.91 L +650.96 154.883 L +651.116 155.857 L +651.272 156.833 L +651.427 157.811 L +651.583 158.79 L +651.739 159.77 L +651.894 160.752 L +652.05 161.734 L +652.206 162.717 L +652.361 163.7 L +652.517 164.683 L +652.673 165.667 L +652.828 166.651 L +652.984 167.634 L +653.14 168.617 L +653.295 169.599 L +653.451 170.581 L +653.607 171.561 L +653.762 172.541 L +653.918 173.519 L +654.074 174.496 L +654.229 175.471 L +654.385 176.444 L +654.541 177.415 L +654.696 178.384 L +654.852 179.351 L +655.008 180.315 L +655.163 181.276 L +655.319 182.235 L +655.475 183.19 L +655.63 184.143 L +655.786 185.092 L +655.942 186.037 L +656.097 186.979 L +656.253 187.916 L +656.409 188.85 L +656.564 189.779 L +656.72 190.704 L +656.876 191.625 L +657.031 192.541 L +657.187 193.452 L +657.343 194.357 L +657.498 195.258 L +657.654 196.153 L +657.81 197.043 L +657.965 197.927 L +658.121 198.805 L +658.277 199.677 L +658.432 200.542 L +658.588 201.402 L +658.744 202.255 L +658.899 203.101 L +659.055 203.941 L +659.211 204.774 L +659.366 205.599 L +659.522 206.417 L +659.678 207.228 L +659.833 208.031 L +659.989 208.827 L +660.145 209.615 L +660.3 210.395 L +660.456 211.166 L +660.612 211.93 L +660.767 212.685 L +660.923 213.431 L +661.078 214.169 L +661.234 214.898 L +661.39 215.618 L +661.546 216.329 L +661.701 217.03 L +661.857 217.723 L +662.013 218.406 L +662.168 219.079 L +662.324 219.743 L +662.479 220.396 L +662.635 221.04 L +662.791 221.674 L +662.946 222.297 L +663.102 222.911 L +663.258 223.513 L +663.413 224.105 L +663.569 224.687 L +663.725 225.258 L +663.88 225.818 L +664.036 226.367 L +664.192 226.904 L +664.347 227.431 L +664.503 227.946 L +664.659 228.45 L +664.814 228.943 L +664.97 229.424 L +665.126 229.893 L +665.281 230.35 L +665.437 230.796 L +665.593 231.229 L +665.748 231.651 L +665.904 232.06 L +666.06 232.458 L +666.215 232.843 L +666.371 233.215 L +666.527 233.575 L +666.682 233.923 L +666.838 234.258 L +666.994 234.58 L +667.149 234.89 L +667.305 235.187 L +667.461 235.471 L +667.616 235.742 L +667.772 236 L +667.928 236.245 L +668.083 236.478 L +668.239 236.696 L +668.395 236.902 L +668.55 237.094 L +668.706 237.274 L +668.862 237.439 L +669.017 237.592 L +669.173 237.731 L +669.329 237.856 L +669.484 237.968 L +669.64 238.067 L +669.796 238.152 L +669.951 238.223 L +670.107 238.281 L +670.263 238.325 L +670.418 238.355 L +670.574 238.372 L +670.73 238.375 L +670.885 238.364 L +671.041 238.339 L +671.197 238.301 L +671.352 238.249 L +671.508 238.183 L +671.664 238.103 L +671.819 238.01 L +671.975 237.903 L +672.131 237.782 L +672.286 237.647 L +672.442 237.498 L +672.598 237.336 L +672.753 237.159 L +672.909 236.969 L +673.065 236.766 L +673.22 236.548 L +673.376 236.317 L +673.532 236.072 L +673.687 235.813 L +673.843 235.541 L +673.999 235.255 L +674.154 234.956 L +674.31 234.643 L +674.466 234.316 L +674.621 233.976 L +674.777 233.623 L +674.933 233.256 L +675.088 232.875 L +675.244 232.482 L +675.4 232.075 L +675.555 231.654 L +675.711 231.221 L +675.867 230.774 L +676.022 230.315 L +676.178 229.842 L +676.334 229.356 L +676.489 228.858 L +676.645 228.346 L +676.801 227.822 L +676.956 227.285 L +677.112 226.735 L +677.268 226.173 L +677.423 225.598 L +677.579 225.011 L +677.735 224.412 L +677.89 223.8 L +678.046 223.176 L +678.202 222.54 L +678.357 221.891 L +678.513 221.231 L +678.669 220.559 L +678.824 219.876 L +678.98 219.18 L +679.136 218.473 L +679.291 217.755 L +679.447 217.025 L +679.603 216.284 L +679.758 215.531 L +679.914 214.768 L +680.07 213.994 L +680.225 213.208 L +680.381 212.412 L +680.536 211.605 L +680.692 210.788 L +680.848 209.961 L +681.004 209.123 L +681.159 208.274 L +681.315 207.416 L +681.471 206.548 L +681.626 205.67 L +681.782 204.782 L +681.938 203.885 L +682.093 202.978 L +682.249 202.062 L +682.404 201.137 L +682.56 200.202 L +682.716 199.259 L +682.871 198.307 L +683.027 197.346 L +683.183 196.376 L +683.339 195.399 L +683.494 194.413 L +683.65 193.419 L +683.805 192.417 L +683.961 191.407 L +684.117 190.389 L +684.272 189.364 L +684.428 188.332 L +684.584 187.292 L +684.739 186.245 L +684.895 185.192 L +685.051 184.131 L +685.206 183.064 L +685.362 181.991 L +685.518 180.911 L +685.673 179.825 L +685.829 178.733 L +685.985 177.635 L +686.14 176.531 L +686.296 175.422 L +686.452 174.308 L +686.607 173.188 L +686.763 172.064 L +686.919 170.934 L +687.074 169.8 L +687.23 168.661 L +687.386 167.518 L +687.541 166.371 L +687.697 165.22 L +687.853 164.065 L +688.008 162.906 L +688.164 161.744 L +688.32 160.578 L +688.475 159.409 L +688.631 158.237 L +688.787 157.063 L +688.942 155.886 L +689.098 154.706 L +689.254 153.524 L +689.409 152.34 L +689.565 151.154 L +689.721 149.966 L +689.876 148.776 L +690.032 147.585 L +690.188 146.393 L +690.343 145.2 L +690.499 144.006 L +690.655 142.811 L +690.81 141.616 L +690.966 140.421 L +691.122 139.225 L +691.277 138.029 L +691.433 136.834 L +691.589 135.638 L +691.744 134.444 L +691.9 133.25 L +692.056 132.057 L +692.211 130.865 L +692.367 129.675 L +692.523 128.485 L +692.678 127.298 L +692.834 126.112 L +692.99 124.929 L +693.145 123.747 L +693.301 122.568 L +693.457 121.391 L +693.612 120.217 L +693.768 119.046 L +693.924 117.878 L +694.079 116.714 L +694.235 115.552 L +694.391 114.395 L +694.546 113.241 L +694.702 112.091 L +694.858 110.945 L +695.013 109.803 L +695.169 108.666 L +695.325 107.534 L +695.48 106.406 L +695.636 105.283 L +695.792 104.166 L +695.947 103.054 L +696.103 101.947 L +696.259 100.846 L +696.414 99.751 L +696.57 98.662 L +696.726 97.579 L +696.881 96.502 L +697.037 95.432 L +697.193 94.369 L +697.348 93.312 L +697.504 92.263 L +697.66 91.22 L +697.815 90.185 L +697.971 89.158 L +698.127 88.138 L +698.282 87.126 L +698.438 86.122 L +698.594 85.126 L +698.749 84.138 L +698.905 83.159 L +699.061 82.188 L +699.216 81.226 L +699.372 80.273 L +699.528 79.329 L +699.683 78.395 L +699.839 77.469 L +699.995 76.553 L +700.15 75.647 L +700.306 74.75 L +700.462 73.864 L +700.617 72.987 L +700.773 72.121 L +700.929 71.265 L +701.084 70.419 L +701.24 69.584 L +701.396 68.76 L +701.551 67.946 L +701.707 67.144 L +701.862 66.352 L +702.018 65.572 L +702.174 64.804 L +702.329 64.047 L +702.485 63.301 L +702.641 62.567 L +702.797 61.845 L +702.952 61.136 L +703.108 60.438 L +703.263 59.752 L +703.419 59.079 L +703.575 58.418 L +703.73 57.77 L +703.886 57.134 L +704.042 56.511 L +704.197 55.901 L +704.353 55.304 L +704.509 54.72 L +704.664 54.149 L +704.82 53.592 L +704.976 53.047 L +705.131 52.517 L +705.287 51.999 L +705.443 51.496 L +705.598 51.006 L +705.754 50.53 L +705.91 50.068 L +706.065 49.619 L +706.221 49.185 L +706.377 48.765 L +706.532 48.359 L +706.688 47.968 L +706.844 47.59 L +706.999 47.227 L +707.155 46.879 L +707.311 46.545 L +707.466 46.226 L +707.622 45.921 L +707.778 45.631 L +707.933 45.356 L +708.089 45.096 L +708.245 44.851 L +708.4 44.62 L +708.556 44.405 L +708.712 44.204 L +708.867 44.019 L +709.023 43.849 L +709.179 43.693 L +709.334 43.553 L +709.49 43.429 L +709.646 43.319 L +709.801 43.225 L +709.957 43.146 L +710.113 43.083 L +710.268 43.035 L +710.424 43.002 L +710.58 42.985 L +710.735 42.983 L +710.891 42.996 L +711.047 43.025 L +711.202 43.07 L +711.358 43.13 L +711.514 43.205 L +711.669 43.296 L +711.825 43.403 L +711.981 43.525 L +712.136 43.662 L +712.292 43.815 L +712.448 43.983 L +712.603 44.167 L +712.759 44.366 L +712.915 44.581 L +713.07 44.811 L +713.226 45.057 L +713.382 45.318 L +713.537 45.594 L +713.693 45.886 L +713.849 46.193 L +714.004 46.515 L +714.16 46.853 L +714.316 47.206 L +714.471 47.574 L +714.627 47.957 L +714.783 48.355 L +714.938 48.768 L +715.094 49.197 L +715.25 49.64 L +715.405 50.098 L +715.561 50.571 L +715.717 51.059 L +715.872 51.562 L +716.028 52.08 L +716.184 52.612 L +716.339 53.159 L +716.495 53.72 L +716.651 54.296 L +716.806 54.886 L +716.962 55.49 L +717.118 56.109 L +717.273 56.742 L +717.429 57.389 L +717.585 58.05 L +717.74 58.725 L +717.896 59.414 L +718.052 60.117 L +718.207 60.834 L +718.363 61.564 L +718.519 62.307 L +718.674 63.065 L +718.83 63.835 L +718.986 64.619 L +719.141 65.416 L +719.297 66.225 L +719.453 67.048 L +719.608 67.884 L +719.764 68.733 L +719.92 69.594 L +720.075 70.467 L +720.231 71.354 L +720.387 72.252 L +720.542 73.163 L +720.698 74.085 L +720.854 75.02 L +721.009 75.967 L +721.165 76.925 L +721.32 77.895 L +721.476 78.877 L +721.632 79.869 L +721.787 80.873 L +721.943 81.889 L +722.099 82.915 L +722.255 83.952 L +722.41 85 L +722.566 86.058 L +722.721 87.127 L +722.877 88.206 L +723.033 89.295 L +723.188 90.394 L +723.344 91.504 L +723.5 92.623 L +723.655 93.751 L +723.811 94.889 L +723.967 96.037 L +724.122 97.193 L +724.278 98.359 L +724.434 99.533 L +724.589 100.716 L +724.745 101.908 L +724.901 103.108 L +725.056 104.317 L +725.212 105.533 L +725.368 106.758 L +725.523 107.99 L +725.679 109.23 L +725.835 110.477 L +725.99 111.732 L +726.146 112.994 L +726.302 114.262 L +726.457 115.538 L +726.613 116.82 L +726.769 118.109 L +726.924 119.404 L +727.08 120.705 L +727.236 122.012 L +727.391 123.325 L +727.547 124.644 L +727.703 125.968 L +727.858 127.297 L +728.014 128.631 L +728.17 129.971 L +728.325 131.315 L +728.481 132.663 L +728.637 134.017 L +728.792 135.374 L +728.948 136.736 L +729.104 138.101 L +729.259 139.47 L +729.415 140.843 L +729.571 142.219 L +729.726 143.598 L +729.882 144.98 L +730.038 146.365 L +730.193 147.752 L +730.349 149.142 L +730.505 150.535 L +730.66 151.929 L +730.816 153.326 L +730.972 154.724 L +731.127 156.123 L +731.283 157.524 L +731.439 158.927 L +731.594 160.33 L +731.75 161.734 L +731.906 163.139 L +732.061 164.544 L +732.217 165.949 L +732.373 167.355 L +732.528 168.76 L +732.684 170.165 L +732.84 171.57 L +732.995 172.974 L +733.151 174.378 L +733.307 175.78 L +733.462 177.181 L +733.618 178.581 L +733.774 179.979 L +733.929 181.376 L +734.085 182.771 L +734.241 184.163 L +734.396 185.554 L +734.552 186.942 L +734.708 188.327 L +734.863 189.71 L +735.019 191.09 L +735.175 192.466 L +735.33 193.839 L +735.486 195.209 L +735.642 196.575 L +735.797 197.938 L +735.953 199.296 L +736.109 200.65 L +736.264 202 L +736.42 203.345 L +736.576 204.686 L +736.731 206.021 L +736.887 207.352 L +737.043 208.677 L +737.198 209.998 L +737.354 211.312 L +737.51 212.621 L +737.665 213.924 L +737.821 215.221 L +737.977 216.512 L +738.132 217.797 L +738.288 219.075 L +738.444 220.346 L +738.599 221.611 L +738.755 222.868 L +738.911 224.119 L +739.066 225.362 L +739.222 226.597 L +739.378 227.826 L +739.533 229.046 L +739.689 230.258 L +739.845 231.463 L +740 232.659 L +740.156 233.847 L +740.312 235.027 L +740.467 236.197 L +740.623 237.359 L +740.779 238.513 L +740.934 239.657 L +741.09 240.792 L +741.245 241.917 L +741.401 243.033 L +741.557 244.14 L +741.713 245.237 L +741.868 246.324 L +742.024 247.401 L +742.18 248.468 L +742.335 249.525 L +742.491 250.571 L +742.646 251.607 L +742.802 252.632 L +742.958 253.647 L +743.113 254.65 L +743.269 255.643 L +743.425 256.625 L +743.58 257.596 L +743.736 258.555 L +743.892 259.503 L +744.047 260.439 L +744.203 261.364 L +744.359 262.277 L +744.514 263.178 L +744.67 264.068 L +744.826 264.945 L +744.981 265.81 L +745.137 266.663 L +745.293 267.504 L +745.448 268.332 L +745.604 269.148 L +745.76 269.952 L +745.915 270.743 L +746.071 271.521 L +746.227 272.286 L +746.382 273.038 L +746.538 273.778 L +746.694 274.504 L +746.849 275.217 L +747.005 275.917 L +747.161 276.604 L +747.316 277.278 L +747.472 277.938 L +747.628 278.585 L +747.783 279.218 L +747.939 279.838 L +748.095 280.444 L +748.25 281.036 L +748.406 281.615 L +748.562 282.18 L +748.717 282.731 L +748.873 283.269 L +749.029 283.792 L +749.184 284.302 L +749.34 284.797 L +749.496 285.279 L +749.651 285.746 L +749.807 286.2 L +749.963 286.639 L +750.118 287.064 L +750.274 287.475 L +750.43 287.872 L +750.585 288.255 L +750.741 288.623 L +750.897 288.977 L +751.052 289.317 L +751.208 289.643 L +751.364 289.954 L +751.519 290.251 L +751.675 290.534 L +751.831 290.803 L +751.986 291.057 L +752.142 291.297 L +752.298 291.522 L +752.453 291.734 L +752.609 291.931 L +752.765 292.113 L +752.92 292.282 L +753.076 292.436 L +753.232 292.576 L +753.387 292.702 L +753.543 292.814 L +753.699 292.911 L +753.854 292.995 L +754.01 293.064 L +754.166 293.119 L +754.321 293.16 L +754.477 293.187 L +754.633 293.2 L +754.788 293.199 L +754.944 293.184 L +755.1 293.156 L +755.255 293.113 L +755.411 293.057 L +755.567 292.987 L +755.722 292.903 L +755.878 292.806 L +756.034 292.695 L +756.189 292.571 L +756.345 292.433 L +756.501 292.282 L +756.656 292.117 L +756.812 291.939 L +756.968 291.748 L +757.123 291.544 L +757.279 291.327 L +757.435 291.097 L +757.59 290.854 L +757.746 290.598 L +757.902 290.329 L +758.057 290.048 L +758.213 289.754 L +758.369 289.447 L +758.524 289.128 L +758.68 288.797 L +758.836 288.454 L +758.991 288.098 L +759.147 287.731 L +759.303 287.351 L +759.458 286.96 L +759.614 286.556 L +759.77 286.142 L +759.925 285.715 L +760.081 285.277 L +760.237 284.828 L +760.392 284.368 L +760.548 283.896 L +760.703 283.414 L +760.859 282.92 L +761.015 282.416 L +761.171 281.901 L +761.326 281.376 L +761.482 280.84 L +761.638 280.294 L +761.793 279.737 L +761.949 279.171 L +762.104 278.595 L +762.26 278.008 L +762.416 277.413 L +762.571 276.807 L +762.727 276.193 L +762.883 275.569 L +763.038 274.936 L +763.194 274.293 L +763.35 273.642 L +763.505 272.983 L +763.661 272.315 L +763.817 271.638 L +763.972 270.953 L +764.128 270.26 L +764.284 269.559 L +764.439 268.85 L +764.595 268.133 L +764.751 267.409 L +764.906 266.677 L +765.062 265.938 L +765.218 265.192 L +765.373 264.439 L +765.529 263.679 L +765.685 262.913 L +765.84 262.14 L +765.996 261.361 L +766.152 260.575 L +766.307 259.784 L +766.463 258.987 L +766.619 258.184 L +766.774 257.375 L +766.93 256.562 L +767.086 255.743 L +767.241 254.919 L +767.397 254.09 L +767.553 253.256 L +767.708 252.418 L +767.864 251.576 L +768.02 250.729 L +768.175 249.879 L +768.331 249.024 L +768.487 248.166 L +768.642 247.305 L +768.798 246.44 L +768.954 245.572 L +769.109 244.701 L +769.265 243.827 L +769.421 242.95 L +769.576 242.071 L +769.732 241.19 L +769.888 240.307 L +770.043 239.421 L +770.199 238.534 L +770.355 237.646 L +770.51 236.755 L +770.666 235.864 L +770.822 234.972 L +770.977 234.078 L +771.133 233.184 L +771.289 232.29 L +771.444 231.395 L +771.6 230.5 L +771.756 230.798 L +771.911 231.097 L +772.067 231.395 L +772.223 231.693 L +772.378 231.992 L +772.534 232.29 L +772.69 232.588 L +772.845 232.887 L +773.001 233.185 L +773.157 233.483 L +773.312 233.781 L +773.468 234.079 L +773.624 234.378 L +773.779 234.676 L +773.935 234.974 L +774.091 235.272 L +774.246 235.57 L +774.402 235.868 L +774.558 236.166 L +774.713 236.463 L +774.869 236.761 L +775.025 237.059 L +775.18 237.357 L +775.336 237.654 L +775.492 237.952 L +775.647 238.249 L +775.803 238.546 L +775.959 238.844 L +776.114 239.141 L +776.27 239.438 L +776.426 239.735 L +776.581 240.032 L +776.737 240.329 L +776.893 240.626 L +777.048 240.923 L +777.204 241.219 L +777.36 241.516 L +777.515 241.812 L +777.671 242.108 L +777.827 242.404 L +777.982 242.701 L +778.138 242.996 L +778.294 243.292 L +778.449 243.588 L +778.605 243.884 L +778.761 244.179 L +778.916 244.474 L +779.072 244.77 L +779.228 245.065 L +779.383 245.36 L +779.539 245.654 L +779.695 245.949 L +779.85 246.243 L +780.006 246.538 L +780.161 246.832 L +780.317 247.126 L +780.473 247.42 L +780.629 247.714 L +780.784 248.007 L +780.94 248.301 L +781.096 248.594 L +781.251 248.887 L +781.407 249.18 L +781.563 249.473 L +781.718 249.765 L +781.874 250.057 L +782.029 250.35 L +782.185 250.642 L +782.341 250.933 L +782.496 251.225 L +782.652 251.516 L +782.808 251.808 L +782.964 252.099 L +783.119 252.389 L +783.275 252.68 L +783.43 252.97 L +783.586 253.261 L +783.742 253.551 L +783.897 253.84 L +784.053 254.13 L +784.209 254.419 L +784.364 254.708 L +784.52 254.997 L +784.676 255.286 L +784.831 255.574 L +784.987 255.862 L +785.143 256.15 L +785.298 256.438 L +785.454 256.725 L +785.61 257.012 L +785.765 257.299 L +785.921 257.586 L +786.077 257.872 L +786.232 258.159 L +786.388 258.445 L +786.544 258.73 L +786.699 259.016 L +786.855 259.301 L +787.011 259.586 L +787.166 259.87 L +787.322 260.154 L +787.478 260.438 L +787.633 260.722 L +787.789 261.006 L +787.945 261.289 L +788.1 261.572 L +788.256 261.854 L +788.412 262.136 L +788.567 262.418 L +788.723 262.7 L +788.879 262.981 L +789.034 263.263 L +789.19 263.543 L +789.346 263.824 L +789.501 264.104 L +789.657 264.384 L +789.813 264.663 L +789.968 264.942 L +790.124 265.221 L +790.28 265.5 L +790.435 265.778 L +790.591 266.056 L +790.747 266.333 L +790.902 266.611 L +791.058 266.887 L +791.214 267.164 L +791.369 267.44 L +791.525 267.716 L +791.681 267.991 L +791.836 268.267 L +791.992 268.541 L +792.148 268.816 L +792.303 269.09 L +792.459 269.363 L +792.615 269.637 L +792.77 269.91 L +792.926 270.182 L +793.082 270.454 L +793.237 270.726 L +793.393 270.998 L +793.549 271.269 L +793.704 271.54 L +793.86 271.81 L +794.016 272.08 L +794.171 272.349 L +794.327 272.618 L +794.483 272.887 L +794.638 273.155 L +794.794 273.423 L +794.95 273.691 L +795.105 273.958 L +795.261 274.225 L +795.417 274.491 L +795.572 274.757 L +795.728 275.022 L +795.884 275.287 L +796.039 275.552 L +796.195 275.816 L +796.351 276.08 L +796.506 276.343 L +796.662 276.606 L +796.818 276.869 L +796.973 277.131 L +797.129 277.392 L +797.285 277.654 L +797.44 277.914 L +797.596 278.175 L +797.752 278.434 L +797.907 278.694 L +798.063 278.953 L +798.219 279.211 L +798.374 279.469 L +798.53 279.727 L +798.686 279.984 L +798.841 280.24 L +798.997 280.496 L +799.153 280.752 L +799.308 281.007 L +799.464 281.262 L +799.62 281.516 L +799.775 281.77 L +799.931 282.023 L +800.087 282.276 L +800.242 282.529 L +800.398 282.78 L +800.554 283.032 L +800.709 283.283 L +800.865 283.533 L +801.021 283.783 L +801.176 284.032 L +801.332 284.281 L +801.487 284.529 L +801.643 284.777 L +801.799 285.024 L +801.954 285.271 L +802.11 285.517 L +802.266 285.763 L +802.422 286.008 L +802.577 286.253 L +802.733 286.497 L +802.888 286.741 L +803.044 286.984 L +803.2 287.227 L +803.355 287.469 L +803.511 287.71 L +803.667 287.951 L +803.822 288.192 L +803.978 288.432 L +804.134 288.671 L +804.289 288.91 L +804.445 289.148 L +804.601 289.386 L +804.756 289.623 L +804.912 289.86 L +805.068 290.096 L +805.223 290.331 L +805.379 290.566 L +805.535 290.801 L +805.69 291.034 L +805.846 291.268 L +806.002 291.5 L +806.157 291.732 L +806.313 291.964 L +806.469 292.195 L +806.624 292.425 L +806.78 292.655 L +806.936 292.884 L +807.091 293.113 L +807.247 293.341 L +807.403 293.568 L +807.558 293.795 L +807.714 294.021 L +807.87 294.247 L +808.025 294.472 L +808.181 294.696 L +808.337 294.92 L +808.492 295.143 L +808.648 295.366 L +808.804 295.588 L +808.959 295.809 L +809.115 296.03 L +809.271 296.25 L +809.426 296.47 L +809.582 296.688 L +809.738 296.907 L +809.893 297.124 L +810.049 297.341 L +810.205 297.558 L +810.36 297.774 L +810.516 297.989 L +810.672 298.203 L +810.827 298.417 L +810.983 298.63 L +811.139 298.843 L +811.294 299.055 L +811.45 299.266 L +811.606 299.477 L +811.761 299.687 L +811.917 299.896 L +812.073 300.105 L +812.228 300.313 L +812.384 300.52 L +812.54 300.727 L +812.695 300.933 L +812.851 301.138 L +813.007 301.343 L +813.162 301.547 L +813.318 301.751 L +813.474 301.953 L +813.629 302.155 L +813.785 302.357 L +813.941 302.557 L +814.096 302.758 L +814.252 302.957 L +814.408 303.156 L +814.563 303.354 L +814.719 303.551 L +814.875 303.747 L +815.03 303.943 L +815.186 304.139 L +815.342 304.333 L +815.497 304.527 L +815.653 304.72 L +815.809 304.913 L +815.964 305.104 L +816.12 305.295 L +816.276 305.486 L +816.431 305.675 L +816.587 305.864 L +816.743 306.052 L +816.898 306.24 L +817.054 306.427 L +817.21 306.613 L +817.365 306.798 L +817.521 306.983 L +817.677 307.167 L +817.832 307.35 L +817.988 307.532 L +818.144 307.714 L +818.299 307.895 L +818.455 308.075 L +818.611 308.255 L +818.766 308.434 L +818.922 308.612 L +819.078 308.789 L +819.233 308.966 L +819.389 309.142 L +819.545 309.317 L +819.7 309.491 L +819.856 309.665 L +820.012 309.838 L +820.167 310.01 L +820.323 310.182 L +820.479 310.352 L +820.634 310.522 L +820.79 310.691 L +820.945 310.86 L +821.101 311.027 L +821.257 311.194 L +821.412 311.36 L +821.568 311.526 L +821.724 311.69 L +821.88 311.854 L +822.035 312.017 L +822.191 312.18 L +822.346 312.341 L +822.502 312.502 L +822.658 312.662 L +822.813 312.821 L +822.969 312.98 L +823.125 313.137 L +823.28 313.294 L +823.436 313.45 L +823.592 313.606 L +823.747 313.76 L +823.903 313.914 L +824.059 314.067 L +824.214 314.219 L +824.37 314.371 L +824.526 314.521 L +824.681 314.671 L +824.837 314.82 L +824.993 314.969 L +825.148 315.116 L +825.304 315.263 L +825.46 315.408 L +825.615 315.554 L +825.771 315.698 L +825.927 315.841 L +826.082 315.984 L +826.238 316.126 L +826.394 316.267 L +826.549 316.407 L +826.705 316.547 L +826.861 316.685 L +827.016 316.823 L +827.172 316.96 L +827.328 317.096 L +827.483 317.232 L +827.639 317.366 L +827.795 317.5 L +827.95 317.633 L +828.106 317.765 L +828.262 317.896 L +828.417 318.027 L +828.573 318.156 L +828.729 318.285 L +828.884 318.413 L +829.04 318.54 L +829.196 318.666 L +829.351 318.792 L +829.507 318.917 L +829.663 319.04 L +829.818 319.163 L +829.974 319.286 L +830.13 319.407 L +830.285 319.527 L +830.441 319.647 L +830.597 319.766 L +830.752 319.884 L +830.908 320.001 L +831.064 320.117 L +831.219 320.233 L +831.375 320.347 L +831.531 320.461 L +831.686 320.574 L +831.842 320.686 L +831.998 320.797 L +832.153 320.908 L +832.309 321.017 L +832.465 321.126 L +832.62 321.234 L +832.776 321.34 L +832.932 321.447 L +833.087 321.552 L +833.243 321.656 L +833.399 321.76 L +833.554 321.862 L +833.71 321.964 L +833.866 322.065 L +834.021 322.165 L +834.177 322.264 L +834.333 322.363 L +834.488 322.46 L +834.644 322.557 L +834.8 322.653 L +834.955 322.748 L +835.111 322.842 L +835.267 322.935 L +835.422 323.027 L +835.578 323.118 L +835.734 323.209 L +835.889 323.299 L +836.045 323.387 L +836.201 323.475 L +836.356 323.562 L +836.512 323.649 L +836.668 323.734 L +836.823 323.818 L +836.979 323.902 L +837.135 323.985 L +837.29 324.066 L +837.446 324.147 L +837.602 324.227 L +837.757 324.306 L +837.913 324.385 L +838.069 324.462 L +838.224 324.538 L +838.38 324.614 L +838.536 324.689 L +838.691 324.763 L +838.847 324.836 L +839.003 324.908 L +839.158 324.979 L +839.314 325.049 L +839.47 325.118 L +839.625 325.187 L +839.781 325.255 L +839.937 325.321 L +840.092 325.387 L +840.248 325.452 L +840.404 325.516 L +840.559 325.579 L +840.715 325.641 L +840.87 325.703 L +841.026 325.763 L +841.182 325.823 L +841.338 325.881 L +841.493 325.939 L +841.649 325.996 L +841.805 326.052 L +841.96 326.107 L +842.116 326.161 L +842.271 326.214 L +842.427 326.267 L +842.583 326.318 L +842.738 326.369 L +842.894 326.418 L +843.05 326.467 L +843.205 326.515 L +843.361 326.562 L +843.517 326.608 L +843.672 326.653 L +843.828 326.697 L +843.984 326.741 L +844.139 326.783 L +844.295 326.825 L +844.451 326.865 L +844.606 326.905 L +844.762 326.944 L +844.918 326.982 L +845.073 327.019 L +845.229 327.055 L +845.385 327.09 L +845.54 327.124 L +845.696 327.157 L +845.852 327.19 L +846.007 327.221 L +846.163 327.252 L +846.319 327.282 L +846.474 327.311 L +846.63 327.338 L +846.786 327.365 L +846.941 327.391 L +847.097 327.417 L +847.253 327.441 L +847.408 327.464 L +847.564 327.486 L +847.72 327.508 L +847.875 327.529 L +848.031 327.548 L +848.187 327.567 L +848.342 327.585 L +848.498 327.602 L +848.654 327.618 L +848.809 327.633 L +848.965 327.647 L +849.121 327.66 L +849.276 327.673 L +849.432 327.684 L +849.588 327.695 L +849.743 327.704 L +849.899 327.713 L +850.055 327.721 L +850.21 327.728 L +850.366 327.734 L +850.522 327.739 L +850.677 327.743 L +850.833 327.746 L +850.989 327.748 L +851.144 327.75 L +851.3 327.75 L +851.456 327.75 L +851.611 327.748 L +851.767 327.746 L +851.923 327.743 L +852.078 327.739 L +852.234 327.734 L +852.39 327.728 L +852.545 327.721 L +852.701 327.713 L +852.857 327.704 L +853.012 327.695 L +853.168 327.684 L +853.324 327.673 L +853.479 327.66 L +853.635 327.647 L +853.791 327.633 L +853.946 327.618 L +854.102 327.602 L +854.258 327.585 L +854.413 327.567 L +854.569 327.548 L +854.725 327.529 L +854.88 327.508 L +855.036 327.486 L +855.192 327.464 L +855.347 327.441 L +855.503 327.417 L +855.659 327.391 L +855.814 327.365 L +855.97 327.338 L +856.126 327.311 L +856.281 327.282 L +856.437 327.252 L +856.593 327.221 L +856.748 327.19 L +856.904 327.157 L +857.06 327.124 L +857.215 327.09 L +857.371 327.055 L +857.527 327.019 L +857.682 326.982 L +857.838 326.944 L +857.994 326.905 L +858.149 326.865 L +858.305 326.825 L +858.461 326.783 L +858.616 326.741 L +858.772 326.697 L +858.928 326.653 L +859.083 326.608 L +859.239 326.562 L +859.395 326.515 L +859.55 326.467 L +859.706 326.418 L +859.862 326.369 L +860.017 326.318 L +860.173 326.267 L +860.328 326.214 L +860.484 326.161 L +860.64 326.107 L +860.796 326.052 L +860.951 325.996 L +861.107 325.939 L +861.263 325.881 L +861.418 325.823 L +861.574 325.763 L +861.729 325.703 L +861.885 325.641 L +862.041 325.579 L +862.196 325.516 L +862.352 325.452 L +862.508 325.387 L +862.663 325.321 L +862.819 325.255 L +862.975 325.187 L +863.13 325.118 L +863.286 325.049 L +863.442 324.979 L +863.597 324.908 L +863.753 324.836 L +863.909 324.763 L +864.064 324.689 L +864.22 324.614 L +864.376 324.538 L +864.531 324.462 L +864.687 324.385 L +864.843 324.306 L +864.998 324.227 L +865.154 324.147 L +865.31 324.066 L +865.465 323.985 L +865.621 323.902 L +865.777 323.818 L +865.932 323.734 L +866.088 323.649 L +866.244 323.562 L +866.399 323.475 L +866.555 323.387 L +866.711 323.299 L +866.866 323.209 L +867.022 323.118 L +867.178 323.027 L +867.333 322.935 L +867.489 322.842 L +867.645 322.748 L +867.8 322.653 L +867.956 322.557 L +868.112 322.46 L +868.267 322.363 L +868.423 322.264 L +868.579 322.165 L +868.734 322.065 L +868.89 321.964 L +869.046 321.862 L +869.201 321.76 L +869.357 321.656 L +869.513 321.552 L +869.668 321.447 L +869.824 321.34 L +869.98 321.234 L +870.135 321.126 L +870.291 321.017 L +870.447 320.908 L +870.602 320.797 L +870.758 320.686 L +870.914 320.574 L +871.069 320.461 L +871.225 320.347 L +871.381 320.233 L +871.536 320.117 L +871.692 320.001 L +871.848 319.884 L +872.003 319.766 L +872.159 319.647 L +872.315 319.527 L +872.47 319.407 L +872.626 319.286 L +872.782 319.163 L +872.937 319.04 L +873.093 318.917 L +873.249 318.792 L +873.404 318.666 L +873.56 318.54 L +873.716 318.413 L +873.871 318.285 L +874.027 318.156 L +874.183 318.027 L +874.338 317.896 L +874.494 317.765 L +874.65 317.633 L +874.805 317.5 L +874.961 317.366 L +875.117 317.232 L +875.272 317.096 L +875.428 316.96 L +875.584 316.823 L +875.739 316.685 L +875.895 316.547 L +876.051 316.407 L +876.206 316.267 L +876.362 316.126 L +876.518 315.984 L +876.673 315.841 L +876.829 315.698 L +876.985 315.554 L +877.14 315.408 L +877.296 315.263 L +877.452 315.116 L +877.607 314.969 L +877.763 314.82 L +877.919 314.671 L +878.074 314.521 L +878.23 314.371 L +878.386 314.219 L +878.541 314.067 L +878.697 313.914 L +878.853 313.76 L +879.008 313.606 L +879.164 313.45 L +879.32 313.294 L +879.475 313.137 L +879.631 312.98 L +879.786 312.821 L +879.942 312.662 L +880.098 312.502 L +880.254 312.341 L +880.409 312.18 L +880.565 312.017 L +880.721 311.854 L +880.876 311.69 L +881.032 311.526 L +881.188 311.36 L +881.343 311.194 L +881.499 311.027 L +881.654 310.86 L +881.81 310.691 L +881.966 310.522 L +882.121 310.352 L +882.277 310.182 L +882.433 310.01 L +882.589 309.838 L +882.744 309.665 L +882.9 309.491 L +883.055 309.317 L +883.211 309.142 L +883.367 308.966 L +883.522 308.789 L +883.678 308.612 L +883.834 308.434 L +883.989 308.255 L +884.145 308.075 L +884.301 307.895 L +884.456 307.714 L +884.612 307.532 L +884.768 307.35 L +884.923 307.167 L +885.079 306.983 L +885.235 306.798 L +885.39 306.613 L +885.546 306.427 L +885.702 306.24 L +885.857 306.052 L +886.013 305.864 L +886.169 305.675 L +886.324 305.486 L +886.48 305.295 L +886.636 305.104 L +886.791 304.913 L +886.947 304.72 L +887.103 304.527 L +887.258 304.333 L +887.414 304.139 L +887.57 303.943 L +887.725 303.747 L +887.881 303.551 L +888.037 303.354 L +888.192 303.156 L +888.348 302.957 L +888.504 302.758 L +888.659 302.557 L +888.815 302.357 L +888.971 302.155 L +889.126 301.953 L +889.282 301.751 L +889.438 301.547 L +889.593 301.343 L +889.749 301.138 L +889.905 300.933 L +890.06 300.727 L +890.216 300.52 L +890.372 300.313 L +890.527 300.105 L +890.683 299.896 L +890.839 299.687 L +890.994 299.477 L +891.15 299.266 L +891.306 299.055 L +891.461 298.843 L +891.617 298.63 L +891.773 298.417 L +891.928 298.203 L +892.084 297.989 L +892.24 297.774 L +892.395 297.558 L +892.551 297.341 L +892.707 297.124 L +892.862 296.907 L +893.018 296.688 L +893.174 296.47 L +893.329 296.25 L +893.485 296.03 L +893.641 295.809 L +893.796 295.588 L +893.952 295.366 L +894.108 295.143 L +894.263 294.92 L +894.419 294.696 L +894.575 294.472 L +894.73 294.247 L +894.886 294.021 L +895.042 293.795 L +895.197 293.568 L +895.353 293.341 L +895.509 293.113 L +895.664 292.884 L +895.82 292.655 L +895.976 292.425 L +896.131 292.195 L +896.287 291.964 L +896.443 291.732 L +896.598 291.5 L +896.754 291.268 L +896.91 291.034 L +897.065 290.801 L +897.221 290.566 L +897.377 290.331 L +897.532 290.096 L +897.688 289.86 L +897.844 289.623 L +897.999 289.386 L +898.155 289.148 L +898.311 288.91 L +898.466 288.671 L +898.622 288.432 L +898.778 288.192 L +898.933 287.951 L +899.089 287.71 L +899.245 287.469 L +899.4 287.227 L +899.556 286.984 L +899.712 286.741 L +899.867 286.497 L +900.023 286.253 L +900.179 286.008 L +900.334 285.763 L +900.49 285.517 L +900.646 285.271 L +900.801 285.024 L +900.957 284.777 L +901.112 284.529 L +901.268 284.281 L +901.424 284.032 L +901.579 283.783 L +901.735 283.533 L +901.891 283.283 L +902.047 283.032 L +902.202 282.78 L +902.358 282.529 L +902.513 282.276 L +902.669 282.023 L +902.825 281.77 L +902.98 281.516 L +903.136 281.262 L +903.292 281.007 L +903.447 280.752 L +903.603 280.496 L +903.759 280.24 L +903.914 279.984 L +904.07 279.727 L +904.226 279.469 L +904.381 279.211 L +904.537 278.953 L +904.693 278.694 L +904.848 278.434 L +905.004 278.175 L +905.16 277.914 L +905.315 277.654 L +905.471 277.392 L +905.627 277.131 L +905.782 276.869 L +905.938 276.606 L +906.094 276.343 L +906.249 276.08 L +906.405 275.816 L +906.561 275.552 L +906.716 275.287 L +906.872 275.022 L +907.028 274.757 L +907.183 274.491 L +907.339 274.225 L +907.495 273.958 L +907.65 273.691 L +907.806 273.423 L +907.962 273.155 L +908.117 272.887 L +908.273 272.618 L +908.429 272.349 L +908.584 272.08 L +908.74 271.81 L +908.896 271.54 L +909.051 271.269 L +909.207 270.998 L +909.363 270.726 L +909.518 270.454 L +909.674 270.182 L +909.83 269.91 L +909.985 269.637 L +910.141 269.363 L +910.297 269.09 L +910.452 268.816 L +910.608 268.541 L +910.764 268.267 L +910.919 267.991 L +911.075 267.716 L +911.231 267.44 L +911.386 267.164 L +911.542 266.887 L +911.698 266.611 L +911.853 266.333 L +912.009 266.056 L +912.165 265.778 L +912.32 265.5 L +912.476 265.221 L +912.632 264.942 L +912.787 264.663 L +912.943 264.384 L +913.099 264.104 L +913.254 263.824 L +913.41 263.543 L +913.566 263.263 L +913.721 262.981 L +913.877 262.7 L +914.033 262.418 L +914.188 262.136 L +914.344 261.854 L +914.5 261.572 L +914.655 261.289 L +914.811 261.006 L +914.967 260.722 L +915.122 260.438 L +915.278 260.154 L +915.434 259.87 L +915.589 259.586 L +915.745 259.301 L +915.901 259.016 L +916.056 258.73 L +916.212 258.445 L +916.368 258.159 L +916.523 257.872 L +916.679 257.586 L +916.835 257.299 L +916.99 257.012 L +917.146 256.725 L +917.302 256.438 L +917.457 256.15 L +917.613 255.862 L +917.769 255.574 L +917.924 255.286 L +918.08 254.997 L +918.236 254.708 L +918.391 254.419 L +918.547 254.13 L +918.703 253.84 L +918.858 253.551 L +919.014 253.261 L +919.17 252.97 L +919.325 252.68 L +919.481 252.389 L +919.637 252.099 L +919.792 251.808 L +919.948 251.516 L +920.104 251.225 L +920.259 250.933 L +920.415 250.642 L +920.57 250.35 L +920.726 250.057 L +920.882 249.765 L +921.037 249.473 L +921.193 249.18 L +921.349 248.887 L +921.505 248.594 L +921.66 248.301 L +921.816 248.007 L +921.971 247.714 L +922.127 247.42 L +922.283 247.126 L +922.438 246.832 L +922.594 246.538 L +922.75 246.243 L +922.905 245.949 L +923.061 245.654 L +923.217 245.36 L +923.372 245.065 L +923.528 244.77 L +923.684 244.474 L +923.839 244.179 L +923.995 243.884 L +924.151 243.588 L +924.306 243.292 L +924.462 242.996 L +924.618 242.701 L +924.773 242.404 L +924.929 242.108 L +925.085 241.812 L +925.24 241.516 L +925.396 241.219 L +925.552 240.923 L +925.707 240.626 L +925.863 240.329 L +926.019 240.032 L +926.174 239.735 L +926.33 239.438 L +926.486 239.141 L +926.641 238.844 L +926.797 238.546 L +926.953 238.249 L +927.108 237.952 L +927.264 237.654 L +927.42 237.357 L +927.575 237.059 L +927.731 236.761 L +927.887 236.463 L +928.042 236.166 L +928.198 235.868 L +928.354 235.57 L +928.509 235.272 L +928.665 234.974 L +928.821 234.676 L +928.976 234.378 L +929.132 234.079 L +929.288 233.781 L +929.443 233.483 L +929.599 233.185 L +929.755 232.887 L +929.91 232.588 L +930.066 232.29 L +930.222 231.992 L +930.377 231.693 L +930.533 231.395 L +930.689 231.097 L +930.844 230.798 L +931 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.851 0.325 0.098 RC +1 LJ +2.667 LW +N +134.156 230.5 M +134.311 230.5 L +134.467 230.5 L +134.623 230.5 L +134.778 230.5 L +134.934 230.5 L +135.09 230.5 L +135.245 230.5 L +135.401 230.5 L +135.557 230.5 L +135.712 230.5 L +135.868 230.5 L +136.024 230.5 L +136.179 230.5 L +136.335 230.5 L +136.491 230.5 L +136.646 230.5 L +136.802 230.5 L +136.958 230.5 L +137.113 230.5 L +137.269 230.5 L +137.425 230.5 L +137.58 230.5 L +137.736 230.5 L +137.892 230.5 L +138.047 230.5 L +138.203 230.5 L +138.359 230.5 L +138.514 230.5 L +138.67 230.5 L +138.826 230.5 L +138.981 230.5 L +139.137 230.5 L +139.293 230.5 L +139.448 230.5 L +139.604 230.5 L +139.76 230.5 L +139.915 230.5 L +140.071 230.5 L +140.227 230.5 L +140.382 230.5 L +140.538 230.5 L +140.694 230.5 L +140.849 230.5 L +141.005 230.5 L +141.161 230.5 L +141.316 230.5 L +141.472 230.5 L +141.628 230.5 L +141.783 230.5 L +141.939 230.5 L +142.095 230.5 L +142.25 230.5 L +142.406 230.5 L +142.562 230.5 L +142.717 230.5 L +142.873 230.5 L +143.029 230.5 L +143.184 230.5 L +143.34 230.5 L +143.496 230.5 L +143.651 230.5 L +143.807 230.5 L +143.962 230.5 L +144.118 230.5 L +144.274 230.5 L +144.429 230.5 L +144.585 230.5 L +144.741 230.5 L +144.896 230.5 L +145.052 230.5 L +145.208 230.5 L +145.363 230.5 L +145.519 230.5 L +145.675 230.5 L +145.83 230.5 L +145.986 230.5 L +146.142 230.5 L +146.297 230.5 L +146.453 230.5 L +146.609 230.5 L +146.764 230.5 L +146.92 230.5 L +147.076 230.5 L +147.231 230.5 L +147.387 230.5 L +147.543 230.5 L +147.698 230.5 L +147.854 230.5 L +148.01 230.5 L +148.165 230.5 L +148.321 230.5 L +148.477 230.5 L +148.632 230.5 L +148.788 230.5 L +148.944 230.5 L +149.099 230.5 L +149.255 230.5 L +149.411 230.5 L +149.566 230.5 L +149.722 230.5 L +149.878 230.5 L +150.033 230.5 L +150.189 230.5 L +150.345 230.5 L +150.5 230.5 L +150.656 230.5 L +150.812 230.5 L +150.967 230.5 L +151.123 230.5 L +151.279 230.5 L +151.434 230.5 L +151.59 230.5 L +151.746 230.5 L +151.901 230.5 L +152.057 230.5 L +152.213 230.5 L +152.368 230.5 L +152.524 230.5 L +152.68 230.5 L +152.835 230.5 L +152.991 230.5 L +153.147 230.5 L +153.302 230.5 L +153.458 230.5 L +153.614 230.5 L +153.769 230.5 L +153.925 230.5 L +154.081 230.5 L +154.236 230.5 L +154.392 230.5 L +154.548 230.5 L +154.703 230.5 L +154.859 230.5 L +155.015 230.5 L +155.17 230.5 L +155.326 230.5 L +155.482 230.5 L +155.637 230.5 L +155.793 230.5 L +155.949 230.5 L +156.104 230.5 L +156.26 230.5 L +156.416 230.5 L +156.571 230.5 L +156.727 230.5 L +156.883 230.5 L +157.038 230.5 L +157.194 230.5 L +157.35 230.5 L +157.505 230.5 L +157.661 230.5 L +157.817 230.5 L +157.972 230.5 L +158.128 230.5 L +158.284 230.5 L +158.439 230.5 L +158.595 230.5 L +158.751 230.5 L +158.906 230.5 L +159.062 230.5 L +159.218 230.5 L +159.373 230.5 L +159.529 230.5 L +159.685 230.5 L +159.84 230.5 L +159.996 230.5 L +160.152 230.5 L +160.307 230.5 L +160.463 230.5 L +160.619 230.5 L +160.774 230.5 L +160.93 230.5 L +161.086 230.5 L +161.241 230.5 L +161.397 230.5 L +161.553 230.5 L +161.708 230.5 L +161.864 230.5 L +162.02 230.5 L +162.175 230.5 L +162.331 230.5 L +162.487 230.5 L +162.642 230.5 L +162.798 230.5 L +162.954 230.5 L +163.109 230.5 L +163.265 230.5 L +163.421 230.5 L +163.576 230.5 L +163.732 230.5 L +163.887 230.5 L +164.043 230.5 L +164.199 230.5 L +164.354 230.5 L +164.51 230.5 L +164.666 230.5 L +164.821 230.5 L +164.977 230.5 L +165.133 230.5 L +165.288 230.5 L +165.444 230.5 L +165.6 230.5 L +165.755 230.5 L +165.911 230.5 L +166.067 230.5 L +166.222 230.5 L +166.378 230.5 L +166.534 230.5 L +166.689 230.5 L +166.845 230.5 L +167.001 230.5 L +167.156 230.5 L +167.312 230.5 L +167.468 230.5 L +167.623 230.5 L +167.779 230.5 L +167.935 230.5 L +168.09 230.5 L +168.246 230.5 L +168.402 230.5 L +168.557 230.5 L +168.713 230.5 L +168.869 230.5 L +169.024 230.5 L +169.18 230.5 L +169.336 230.5 L +169.491 230.5 L +169.647 230.5 L +169.803 230.5 L +169.958 230.5 L +170.114 230.5 L +170.27 230.5 L +170.425 230.5 L +170.581 230.5 L +170.737 230.5 L +170.892 230.5 L +171.048 230.5 L +171.204 230.5 L +171.359 230.5 L +171.515 230.5 L +171.671 230.5 L +171.826 230.5 L +171.982 230.5 L +172.138 230.5 L +172.293 230.5 L +172.449 230.5 L +172.605 230.5 L +172.76 230.5 L +172.916 230.5 L +173.072 230.5 L +173.227 230.5 L +173.383 230.5 L +173.539 230.5 L +173.694 230.5 L +173.85 230.5 L +174.006 230.5 L +174.161 230.5 L +174.317 230.5 L +174.473 230.5 L +174.628 230.5 L +174.784 230.5 L +174.94 230.5 L +175.095 230.5 L +175.251 230.5 L +175.407 230.5 L +175.562 230.5 L +175.718 230.5 L +175.874 230.5 L +176.029 230.5 L +176.185 230.5 L +176.341 230.5 L +176.496 230.5 L +176.652 230.5 L +176.808 230.5 L +176.963 230.5 L +177.119 230.5 L +177.275 230.5 L +177.43 230.5 L +177.586 230.5 L +177.742 230.5 L +177.897 230.5 L +178.053 230.5 L +178.209 230.5 L +178.364 230.5 L +178.52 230.5 L +178.676 230.5 L +178.831 230.5 L +178.987 230.5 L +179.143 230.5 L +179.298 230.5 L +179.454 230.5 L +179.61 230.5 L +179.765 230.5 L +179.921 230.5 L +180.077 230.5 L +180.232 230.5 L +180.388 230.5 L +180.544 230.5 L +180.699 230.5 L +180.855 230.5 L +181.011 230.5 L +181.166 230.5 L +181.322 230.5 L +181.478 230.5 L +181.633 230.5 L +181.789 230.5 L +181.945 230.5 L +182.1 230.5 L +182.256 230.5 L +182.412 230.5 L +182.567 230.5 L +182.723 230.5 L +182.879 230.5 L +183.034 230.5 L +183.19 230.5 L +183.346 230.5 L +183.501 230.5 L +183.657 230.5 L +183.813 230.5 L +183.968 230.5 L +184.124 230.5 L +184.279 230.5 L +184.435 230.5 L +184.591 230.5 L +184.746 230.5 L +184.902 230.5 L +185.058 230.5 L +185.213 230.5 L +185.369 230.5 L +185.525 230.5 L +185.68 230.5 L +185.836 230.5 L +185.992 230.5 L +186.147 230.5 L +186.303 230.5 L +186.459 230.5 L +186.614 230.5 L +186.77 230.5 L +186.926 230.5 L +187.081 230.5 L +187.237 230.5 L +187.393 230.5 L +187.548 230.5 L +187.704 230.5 L +187.86 230.5 L +188.015 230.5 L +188.171 230.5 L +188.327 230.5 L +188.482 230.5 L +188.638 230.5 L +188.794 230.5 L +188.949 230.5 L +189.105 230.5 L +189.261 230.5 L +189.416 230.5 L +189.572 230.5 L +189.728 230.5 L +189.883 230.5 L +190.039 230.5 L +190.195 230.5 L +190.35 230.5 L +190.506 230.5 L +190.662 230.5 L +190.817 230.5 L +190.973 230.5 L +191.129 230.5 L +191.284 230.5 L +191.44 230.5 L +191.596 230.5 L +191.751 230.5 L +191.907 230.5 L +192.063 230.5 L +192.218 230.5 L +192.374 230.5 L +192.53 230.5 L +192.685 230.5 L +192.841 230.5 L +192.997 230.5 L +193.152 230.5 L +193.308 230.5 L +193.464 230.5 L +193.619 230.5 L +193.775 230.5 L +193.931 230.5 L +194.086 230.5 L +194.242 230.5 L +194.398 230.5 L +194.553 230.5 L +194.709 230.5 L +194.865 230.5 L +195.02 230.5 L +195.176 230.5 L +195.332 230.5 L +195.487 230.5 L +195.643 230.5 L +195.799 230.5 L +195.954 230.5 L +196.11 230.5 L +196.266 230.5 L +196.421 230.5 L +196.577 230.5 L +196.733 230.5 L +196.888 230.5 L +197.044 230.5 L +197.2 230.5 L +197.355 230.5 L +197.511 230.5 L +197.667 230.5 L +197.822 230.5 L +197.978 230.5 L +198.134 230.5 L +198.289 230.5 L +198.445 230.5 L +198.601 230.5 L +198.756 230.5 L +198.912 230.5 L +199.068 230.5 L +199.223 230.5 L +199.379 230.5 L +199.535 230.5 L +199.69 230.5 L +199.846 230.5 L +200.002 230.5 L +200.157 230.5 L +200.313 230.5 L +200.469 230.5 L +200.624 230.5 L +200.78 230.5 L +200.936 230.5 L +201.091 230.5 L +201.247 230.5 L +201.403 230.5 L +201.558 230.5 L +201.714 230.5 L +201.87 230.5 L +202.025 230.5 L +202.181 230.5 L +202.337 230.5 L +202.492 230.5 L +202.648 230.5 L +202.804 230.5 L +202.959 230.5 L +203.115 230.5 L +203.271 230.5 L +203.426 230.5 L +203.582 230.5 L +203.738 230.5 L +203.893 230.5 L +204.049 230.5 L +204.204 230.5 L +204.36 230.5 L +204.516 230.5 L +204.671 230.5 L +204.827 230.5 L +204.983 230.5 L +205.138 230.5 L +205.294 230.5 L +205.45 230.5 L +205.605 230.5 L +205.761 230.5 L +205.917 230.5 L +206.072 230.5 L +206.228 230.5 L +206.384 230.5 L +206.539 230.5 L +206.695 230.5 L +206.851 230.5 L +207.006 230.5 L +207.162 230.5 L +207.318 230.5 L +207.473 230.5 L +207.629 230.5 L +207.785 230.5 L +207.94 230.5 L +208.096 230.5 L +208.252 230.5 L +208.407 230.5 L +208.563 230.5 L +208.719 230.5 L +208.874 230.5 L +209.03 230.5 L +209.186 230.5 L +209.341 230.5 L +209.497 230.5 L +209.653 230.5 L +209.808 230.5 L +209.964 230.5 L +210.12 230.5 L +210.275 230.5 L +210.431 230.5 L +210.587 230.5 L +210.742 230.5 L +210.898 230.5 L +211.054 230.5 L +211.209 230.5 L +211.365 230.5 L +211.521 230.5 L +211.676 230.5 L +211.832 230.5 L +211.988 230.5 L +212.143 230.5 L +212.299 230.5 L +212.455 230.5 L +212.61 230.5 L +212.766 230.5 L +212.922 230.5 L +213.077 230.5 L +213.233 230.5 L +213.389 230.5 L +213.544 230.5 L +213.7 230.5 L +213.856 230.5 L +214.011 230.5 L +214.167 230.5 L +214.323 230.5 L +214.478 230.5 L +214.634 230.5 L +214.79 230.5 L +214.945 230.5 L +215.101 230.5 L +215.257 230.5 L +215.412 230.5 L +215.568 230.5 L +215.724 230.5 L +215.879 230.5 L +216.035 230.5 L +216.191 230.5 L +216.346 230.5 L +216.502 230.5 L +216.658 230.5 L +216.813 230.5 L +216.969 230.5 L +217.125 230.5 L +217.28 230.5 L +217.436 230.5 L +217.592 230.5 L +217.747 230.5 L +217.903 230.5 L +218.059 230.5 L +218.214 230.5 L +218.37 230.5 L +218.526 230.5 L +218.681 230.5 L +218.837 230.5 L +218.993 230.5 L +219.148 230.5 L +219.304 230.5 L +219.46 230.5 L +219.615 230.5 L +219.771 230.5 L +219.927 230.5 L +220.082 230.5 L +220.238 230.5 L +220.394 230.5 L +220.549 230.5 L +220.705 230.5 L +220.861 230.5 L +221.016 230.5 L +221.172 230.5 L +221.328 230.5 L +221.483 230.5 L +221.639 230.5 L +221.795 230.5 L +221.95 230.5 L +222.106 230.5 L +222.262 230.5 L +222.417 230.5 L +222.573 230.5 L +222.729 230.5 L +222.884 230.5 L +223.04 230.5 L +223.196 230.5 L +223.351 230.5 L +223.507 230.5 L +223.663 230.5 L +223.818 230.5 L +223.974 230.5 L +224.129 230.5 L +224.285 230.5 L +224.441 230.5 L +224.596 230.5 L +224.752 230.5 L +224.908 230.5 L +225.063 230.5 L +225.219 230.5 L +225.375 230.5 L +225.53 230.5 L +225.686 230.5 L +225.842 230.5 L +225.997 230.5 L +226.153 230.5 L +226.309 230.5 L +226.464 230.5 L +226.62 230.5 L +226.776 230.5 L +226.931 230.5 L +227.087 230.5 L +227.243 230.5 L +227.398 230.5 L +227.554 230.5 L +227.71 230.5 L +227.865 230.5 L +228.021 230.5 L +228.177 230.5 L +228.332 230.5 L +228.488 230.5 L +228.644 230.5 L +228.799 230.5 L +228.955 230.5 L +229.111 230.5 L +229.266 230.5 L +229.422 230.5 L +229.578 230.5 L +229.733 230.5 L +229.889 230.5 L +230.045 230.5 L +230.2 230.5 L +230.356 230.5 L +230.512 230.5 L +230.667 230.5 L +230.823 230.5 L +230.979 230.5 L +231.134 230.5 L +231.29 230.5 L +231.446 230.5 L +231.601 230.5 L +231.757 230.5 L +231.913 230.5 L +232.068 230.5 L +232.224 230.5 L +232.38 230.5 L +232.535 230.5 L +232.691 230.5 L +232.847 230.5 L +233.002 230.5 L +233.158 230.5 L +233.314 230.5 L +233.469 230.5 L +233.625 230.5 L +233.781 230.5 L +233.936 230.5 L +234.092 230.5 L +234.248 230.5 L +234.403 230.5 L +234.559 230.5 L +234.715 230.5 L +234.87 230.5 L +235.026 230.5 L +235.182 230.5 L +235.337 230.5 L +235.493 230.5 L +235.649 230.5 L +235.804 230.5 L +235.96 230.5 L +236.116 230.5 L +236.271 230.5 L +236.427 230.5 L +236.583 230.5 L +236.738 230.5 L +236.894 230.5 L +237.05 230.5 L +237.205 230.5 L +237.361 230.5 L +237.517 230.5 L +237.672 230.5 L +237.828 230.5 L +237.984 230.5 L +238.139 230.5 L +238.295 230.5 L +238.451 230.5 L +238.606 230.5 L +238.762 230.5 L +238.918 230.5 L +239.073 230.5 L +239.229 230.5 L +239.385 230.5 L +239.54 230.5 L +239.696 230.5 L +239.852 230.5 L +240.007 230.5 L +240.163 230.5 L +240.319 230.5 L +240.474 230.5 L +240.63 230.5 L +240.786 230.5 L +240.941 230.5 L +241.097 230.5 L +241.253 230.5 L +241.408 230.5 L +241.564 230.5 L +241.72 230.5 L +241.875 230.5 L +242.031 230.5 L +242.187 230.5 L +242.342 230.5 L +242.498 230.5 L +242.654 230.5 L +242.809 230.5 L +242.965 230.5 L +243.121 230.5 L +243.276 230.5 L +243.432 230.5 L +243.587 230.5 L +243.743 230.5 L +243.899 230.5 L +244.054 230.5 L +244.21 230.5 L +244.366 230.5 L +244.521 230.5 L +244.677 230.5 L +244.833 230.5 L +244.988 230.5 L +245.144 230.5 L +245.3 230.5 L +245.455 230.5 L +245.611 230.5 L +245.767 230.5 L +245.922 230.5 L +246.078 230.5 L +246.234 230.5 L +246.389 230.5 L +246.545 230.5 L +246.701 230.5 L +246.856 230.5 L +247.012 230.5 L +247.168 230.5 L +247.323 230.5 L +247.479 230.5 L +247.635 230.5 L +247.79 230.5 L +247.946 230.5 L +248.102 230.5 L +248.257 230.5 L +248.413 230.5 L +248.569 230.5 L +248.724 230.5 L +248.88 230.5 L +249.036 230.5 L +249.191 230.5 L +249.347 230.5 L +249.503 230.5 L +249.658 230.5 L +249.814 230.5 L +249.97 230.5 L +250.125 230.5 L +250.281 230.5 L +250.437 230.5 L +250.592 230.5 L +250.748 230.5 L +250.904 230.5 L +251.059 230.5 L +251.215 230.5 L +251.371 230.5 L +251.526 230.5 L +251.682 230.5 L +251.838 230.5 L +251.993 230.5 L +252.149 230.5 L +252.305 230.5 L +252.46 230.5 L +252.616 230.5 L +252.772 230.5 L +252.927 230.5 L +253.083 230.5 L +253.239 230.5 L +253.394 230.5 L +253.55 230.5 L +253.706 230.5 L +253.861 230.5 L +254.017 230.5 L +254.173 230.5 L +254.328 230.5 L +254.484 230.5 L +254.64 230.5 L +254.795 230.5 L +254.951 230.5 L +255.107 230.5 L +255.262 230.5 L +255.418 230.5 L +255.574 230.5 L +255.729 230.5 L +255.885 230.5 L +256.041 230.5 L +256.196 230.5 L +256.352 230.5 L +256.508 230.5 L +256.663 230.5 L +256.819 230.5 L +256.975 230.5 L +257.13 230.5 L +257.286 230.5 L +257.442 230.5 L +257.597 230.5 L +257.753 230.5 L +257.909 230.5 L +258.064 230.5 L +258.22 230.5 L +258.376 230.5 L +258.531 230.5 L +258.687 230.5 L +258.843 230.5 L +258.998 230.5 L +259.154 230.5 L +259.31 230.5 L +259.465 230.5 L +259.621 230.5 L +259.777 230.5 L +259.932 230.5 L +260.088 230.5 L +260.244 230.5 L +260.399 230.5 L +260.555 230.5 L +260.711 230.5 L +260.866 230.5 L +261.022 230.5 L +261.178 230.5 L +261.333 230.5 L +261.489 230.5 L +261.645 230.5 L +261.8 230.5 L +261.956 230.5 L +262.112 230.5 L +262.267 230.5 L +262.423 230.5 L +262.579 230.5 L +262.734 230.5 L +262.89 230.5 L +263.046 230.5 L +263.201 230.5 L +263.357 230.5 L +263.513 230.5 L +263.668 230.5 L +263.824 230.5 L +263.979 230.5 L +264.135 230.5 L +264.291 230.5 L +264.446 230.5 L +264.602 230.5 L +264.758 230.5 L +264.913 230.5 L +265.069 230.5 L +265.225 230.5 L +265.38 230.5 L +265.536 230.5 L +265.692 230.5 L +265.847 230.5 L +266.003 230.5 L +266.159 230.5 L +266.314 230.5 L +266.47 230.5 L +266.626 230.5 L +266.781 230.5 L +266.937 230.5 L +267.093 230.5 L +267.248 230.5 L +267.404 230.5 L +267.56 230.5 L +267.715 230.5 L +267.871 230.5 L +268.027 230.5 L +268.182 230.5 L +268.338 230.5 L +268.494 230.5 L +268.649 230.5 L +268.805 230.5 L +268.961 230.5 L +269.116 230.5 L +269.272 230.5 L +269.428 230.5 L +269.583 230.5 L +269.739 230.5 L +269.895 230.5 L +270.05 230.5 L +270.206 230.5 L +270.362 230.5 L +270.517 230.5 L +270.673 230.5 L +270.829 230.5 L +270.984 230.5 L +271.14 230.5 L +271.296 230.5 L +271.451 230.5 L +271.607 230.5 L +271.763 230.5 L +271.918 230.5 L +272.074 230.5 L +272.23 230.5 L +272.385 230.5 L +272.541 230.5 L +272.697 230.5 L +272.852 230.5 L +273.008 230.5 L +273.164 230.5 L +273.319 230.5 L +273.475 230.5 L +273.631 230.5 L +273.786 230.5 L +273.942 230.5 L +274.098 230.5 L +274.253 230.5 L +274.409 230.5 L +274.565 230.5 L +274.72 230.5 L +274.876 230.5 L +275.032 230.5 L +275.187 230.5 L +275.343 230.5 L +275.499 230.5 L +275.654 230.5 L +275.81 230.5 L +275.966 230.5 L +276.121 230.5 L +276.277 230.5 L +276.433 230.5 L +276.588 230.5 L +276.744 230.5 L +276.9 230.5 L +277.055 230.5 L +277.211 230.5 L +277.367 230.5 L +277.522 230.5 L +277.678 230.5 L +277.834 230.5 L +277.989 230.5 L +278.145 230.5 L +278.301 230.5 L +278.456 230.5 L +278.612 230.5 L +278.768 230.5 L +278.923 230.5 L +279.079 230.5 L +279.235 230.5 L +279.39 230.5 L +279.546 230.5 L +279.702 230.5 L +279.857 230.5 L +280.013 230.5 L +280.169 230.5 L +280.324 230.5 L +280.48 230.5 L +280.636 230.5 L +280.791 230.5 L +280.947 230.5 L +281.103 230.5 L +281.258 230.5 L +281.414 230.5 L +281.57 230.5 L +281.725 230.5 L +281.881 230.5 L +282.037 230.5 L +282.192 230.5 L +282.348 230.5 L +282.504 230.5 L +282.659 230.5 L +282.815 230.5 L +282.971 230.5 L +283.126 230.5 L +283.282 230.5 L +283.438 230.5 L +283.593 230.5 L +283.749 230.5 L +283.904 230.5 L +284.06 230.5 L +284.216 230.5 L +284.371 230.5 L +284.527 230.5 L +284.683 230.5 L +284.838 230.5 L +284.994 230.5 L +285.15 230.5 L +285.305 230.5 L +285.461 230.5 L +285.617 230.5 L +285.772 230.5 L +285.928 230.5 L +286.084 230.5 L +286.239 230.5 L +286.395 230.5 L +286.551 230.5 L +286.706 230.5 L +286.862 230.5 L +287.018 230.5 L +287.173 230.5 L +287.329 230.5 L +287.485 230.5 L +287.64 230.5 L +287.796 230.5 L +287.952 230.5 L +288.107 230.5 L +288.263 230.5 L +288.419 230.5 L +288.574 230.5 L +288.73 230.5 L +288.886 230.5 L +289.041 230.5 L +289.197 230.5 L +289.353 230.5 L +289.508 230.5 L +289.664 230.5 L +289.82 230.5 L +289.975 230.5 L +290.131 230.5 L +290.287 230.5 L +290.442 230.5 L +290.598 230.5 L +290.754 230.5 L +290.909 230.5 L +291.065 230.5 L +291.221 230.5 L +291.376 230.5 L +291.532 230.5 L +291.688 230.5 L +291.843 230.5 L +291.999 230.5 L +292.155 230.5 L +292.31 230.5 L +292.466 230.5 L +292.622 230.5 L +292.777 230.5 L +292.933 230.5 L +293.089 230.5 L +293.244 230.5 L +293.4 230.5 L +293.556 230.5 L +293.711 230.5 L +293.867 230.5 L +294.023 230.5 L +294.178 230.5 L +294.334 230.5 L +294.49 230.5 L +294.645 230.5 L +294.801 230.5 L +294.957 230.5 L +295.112 230.5 L +295.268 230.5 L +295.424 230.5 L +295.579 230.5 L +295.735 230.5 L +295.891 230.5 L +296.046 230.5 L +296.202 230.5 L +296.358 230.5 L +296.513 230.5 L +296.669 230.5 L +296.825 230.5 L +296.98 230.5 L +297.136 230.5 L +297.292 230.5 L +297.447 230.5 L +297.603 230.5 L +297.759 230.5 L +297.914 230.5 L +298.07 230.5 L +298.226 230.5 L +298.381 230.5 L +298.537 230.5 L +298.693 230.5 L +298.848 230.5 L +299.004 230.5 L +299.16 230.5 L +299.315 230.5 L +299.471 230.5 L +299.627 230.5 L +299.782 230.5 L +299.938 230.5 L +300.094 230.5 L +300.249 230.5 L +300.405 230.5 L +300.561 230.5 L +300.716 230.5 L +300.872 230.5 L +301.028 230.5 L +301.183 230.5 L +301.339 230.5 L +301.495 230.5 L +301.65 230.5 L +301.806 230.5 L +301.962 230.5 L +302.117 230.5 L +302.273 230.5 L +302.429 230.5 L +302.584 230.5 L +302.74 230.5 L +302.896 230.5 L +303.051 230.5 L +303.207 230.5 L +303.362 230.5 L +303.518 230.5 L +303.674 230.5 L +303.829 230.5 L +303.985 230.5 L +304.141 230.5 L +304.296 230.5 L +304.452 230.5 L +304.608 230.5 L +304.763 230.5 L +304.919 230.5 L +305.075 230.5 L +305.23 230.5 L +305.386 230.5 L +305.542 230.5 L +305.697 230.5 L +305.853 230.5 L +306.009 230.5 L +306.164 230.5 L +306.32 230.5 L +306.476 230.5 L +306.631 230.5 L +306.787 230.5 L +306.943 230.5 L +307.098 230.5 L +307.254 230.5 L +307.41 230.5 L +307.565 230.5 L +307.721 230.5 L +307.877 230.5 L +308.032 230.5 L +308.188 230.5 L +308.344 230.5 L +308.499 230.5 L +308.655 230.5 L +308.811 230.5 L +308.966 230.5 L +309.122 230.5 L +309.278 230.5 L +309.433 230.5 L +309.589 230.5 L +309.745 230.5 L +309.9 230.5 L +310.056 230.5 L +310.212 230.5 L +310.367 230.5 L +310.523 230.5 L +310.679 230.5 L +310.834 230.5 L +310.99 230.5 L +311.146 230.5 L +311.301 230.5 L +311.457 230.5 L +311.613 230.5 L +311.768 230.5 L +311.924 230.5 L +312.08 230.5 L +312.235 230.5 L +312.391 230.5 L +312.547 230.5 L +312.702 230.5 L +312.858 230.5 L +313.014 230.5 L +313.169 230.5 L +313.325 230.5 L +313.481 230.5 L +313.636 230.5 L +313.792 230.5 L +313.948 230.5 L +314.103 230.5 L +314.259 230.5 L +314.415 230.5 L +314.57 230.5 L +314.726 230.5 L +314.882 230.5 L +315.037 230.5 L +315.193 230.5 L +315.349 230.5 L +315.504 230.5 L +315.66 230.5 L +315.816 230.5 L +315.971 230.5 L +316.127 230.5 L +316.283 230.5 L +316.438 230.5 L +316.594 230.5 L +316.75 230.5 L +316.905 230.5 L +317.061 230.5 L +317.217 230.5 L +317.372 230.5 L +317.528 230.5 L +317.684 230.5 L +317.839 230.5 L +317.995 230.5 L +318.151 230.5 L +318.306 230.5 L +318.462 230.5 L +318.618 230.5 L +318.773 230.5 L +318.929 230.5 L +319.085 230.5 L +319.24 230.5 L +319.396 230.5 L +319.552 230.5 L +319.707 230.5 L +319.863 230.5 L +320.019 230.5 L +320.174 230.5 L +320.33 230.5 L +320.486 230.5 L +320.641 230.5 L +320.797 230.5 L +320.953 230.5 L +321.108 230.5 L +321.264 230.5 L +321.42 230.5 L +321.575 230.5 L +321.731 230.5 L +321.887 230.5 L +322.042 230.5 L +322.198 230.5 L +322.354 230.5 L +322.509 230.5 L +322.665 230.5 L +322.82 230.5 L +322.976 230.5 L +323.132 230.5 L +323.288 230.5 L +323.443 230.5 L +323.599 230.5 L +323.754 230.5 L +323.91 230.5 L +324.066 230.5 L +324.221 230.5 L +324.377 230.5 L +324.533 230.5 L +324.688 230.5 L +324.844 230.5 L +325 230.5 L +325.155 230.5 L +325.311 230.5 L +325.467 230.5 L +325.622 230.5 L +325.778 230.5 L +325.934 230.5 L +326.089 230.5 L +326.245 230.5 L +326.401 230.5 L +326.556 230.5 L +326.712 230.5 L +326.868 230.5 L +327.023 230.5 L +327.179 230.5 L +327.335 230.5 L +327.49 230.5 L +327.646 230.5 L +327.802 230.5 L +327.957 230.5 L +328.113 230.5 L +328.269 230.5 L +328.424 230.5 L +328.58 230.5 L +328.736 230.5 L +328.891 230.5 L +329.047 230.5 L +329.203 230.5 L +329.358 230.5 L +329.514 230.5 L +329.67 230.5 L +329.825 230.5 L +329.981 230.5 L +330.137 230.5 L +330.292 230.5 L +330.448 230.5 L +330.604 230.5 L +330.759 230.5 L +330.915 230.5 L +331.071 230.5 L +331.226 230.5 L +331.382 230.5 L +331.538 230.5 L +331.693 230.5 L +331.849 230.5 L +332.005 230.5 L +332.16 230.5 L +332.316 230.5 L +332.472 230.5 L +332.627 230.5 L +332.783 230.5 L +332.939 230.5 L +333.094 230.5 L +333.25 230.5 L +333.406 230.5 L +333.561 230.5 L +333.717 230.5 L +333.873 230.5 L +334.028 230.5 L +334.184 230.5 L +334.34 230.5 L +334.495 230.5 L +334.651 230.5 L +334.807 230.5 L +334.962 230.5 L +335.118 230.5 L +335.274 230.5 L +335.429 230.5 L +335.585 230.5 L +335.741 230.5 L +335.896 230.5 L +336.052 230.5 L +336.208 230.5 L +336.363 230.5 L +336.519 230.5 L +336.675 230.5 L +336.83 230.5 L +336.986 230.5 L +337.142 230.5 L +337.297 230.5 L +337.453 230.5 L +337.609 230.5 L +337.764 230.5 L +337.92 230.5 L +338.076 230.5 L +338.231 230.5 L +338.387 230.5 L +338.543 230.5 L +338.698 230.5 L +338.854 230.5 L +339.01 230.5 L +339.165 230.5 L +339.321 230.5 L +339.477 230.5 L +339.632 230.5 L +339.788 230.5 L +339.944 230.5 L +340.099 230.5 L +340.255 230.5 L +340.411 230.5 L +340.566 230.5 L +340.722 230.5 L +340.878 230.5 L +341.033 230.5 L +341.189 230.5 L +341.345 230.5 L +341.5 230.5 L +341.656 230.5 L +341.812 230.5 L +341.967 230.5 L +342.123 230.5 L +342.279 230.5 L +342.434 230.5 L +342.59 230.5 L +342.746 230.5 L +342.901 230.5 L +343.057 230.5 L +343.212 230.5 L +343.368 230.5 L +343.524 230.5 L +343.68 230.5 L +343.835 230.5 L +343.991 230.5 L +344.146 230.5 L +344.302 230.5 L +344.458 230.5 L +344.613 230.5 L +344.769 230.5 L +344.925 230.5 L +345.08 230.5 L +345.236 230.5 L +345.392 230.5 L +345.547 230.5 L +345.703 230.5 L +345.859 230.5 L +346.014 230.5 L +346.17 230.5 L +346.326 230.5 L +346.481 230.5 L +346.637 230.5 L +346.793 230.5 L +346.948 230.5 L +347.104 230.5 L +347.26 230.5 L +347.415 230.5 L +347.571 230.5 L +347.727 230.5 L +347.882 230.5 L +348.038 230.5 L +348.194 230.5 L +348.349 230.5 L +348.505 230.5 L +348.661 230.5 L +348.816 230.5 L +348.972 230.5 L +349.128 230.5 L +349.283 230.5 L +349.439 230.5 L +349.595 230.5 L +349.75 230.5 L +349.906 230.5 L +350.062 230.5 L +350.217 230.5 L +350.373 230.5 L +350.529 230.5 L +350.684 230.5 L +350.84 230.5 L +350.996 230.5 L +351.151 230.5 L +351.307 230.5 L +351.463 230.5 L +351.618 230.5 L +351.774 230.5 L +351.93 230.5 L +352.085 230.5 L +352.241 230.5 L +352.397 230.5 L +352.552 230.5 L +352.708 230.5 L +352.864 230.5 L +353.019 230.5 L +353.175 230.5 L +353.331 230.5 L +353.486 230.5 L +353.642 230.5 L +353.798 230.5 L +353.953 230.5 L +354.109 230.5 L +354.265 230.5 L +354.42 230.5 L +354.576 230.5 L +354.732 230.5 L +354.887 230.5 L +355.043 230.5 L +355.199 230.5 L +355.354 230.5 L +355.51 230.5 L +355.666 230.5 L +355.821 230.5 L +355.977 230.5 L +356.133 230.5 L +356.288 230.5 L +356.444 230.5 L +356.6 230.5 L +356.755 230.5 L +356.911 230.5 L +357.067 230.5 L +357.222 230.5 L +357.378 230.5 L +357.534 230.5 L +357.689 230.5 L +357.845 230.5 L +358.001 230.5 L +358.156 230.5 L +358.312 230.5 L +358.468 230.5 L +358.623 230.5 L +358.779 230.5 L +358.935 230.5 L +359.09 230.5 L +359.246 230.5 L +359.402 230.5 L +359.557 230.5 L +359.713 230.5 L +359.869 230.5 L +360.024 230.5 L +360.18 230.5 L +360.336 230.5 L +360.491 230.5 L +360.647 230.5 L +360.803 230.5 L +360.958 230.5 L +361.114 230.5 L +361.27 230.5 L +361.425 230.5 L +361.581 230.5 L +361.737 230.5 L +361.892 230.5 L +362.048 230.5 L +362.204 230.5 L +362.359 230.5 L +362.515 230.5 L +362.671 230.5 L +362.826 230.5 L +362.982 230.5 L +363.138 230.5 L +363.293 230.5 L +363.449 230.5 L +363.604 230.5 L +363.76 230.5 L +363.916 230.5 L +364.071 230.5 L +364.227 230.5 L +364.383 230.5 L +364.538 230.5 L +364.694 230.5 L +364.85 230.5 L +365.005 230.5 L +365.161 230.5 L +365.317 230.5 L +365.472 230.5 L +365.628 230.5 L +365.784 230.5 L +365.939 230.5 L +366.095 230.5 L +366.251 230.5 L +366.406 230.5 L +366.562 230.5 L +366.718 230.5 L +366.873 230.5 L +367.029 230.5 L +367.185 230.5 L +367.34 230.5 L +367.496 230.5 L +367.652 230.5 L +367.807 230.5 L +367.963 230.5 L +368.119 230.5 L +368.274 230.5 L +368.43 230.5 L +368.586 230.5 L +368.741 230.5 L +368.897 230.5 L +369.053 230.5 L +369.208 230.5 L +369.364 230.5 L +369.52 230.5 L +369.675 230.5 L +369.831 230.5 L +369.987 230.5 L +370.142 230.5 L +370.298 230.5 L +370.454 230.5 L +370.609 230.5 L +370.765 230.5 L +370.921 230.5 L +371.076 230.5 L +371.232 230.5 L +371.388 230.5 L +371.543 230.5 L +371.699 230.5 L +371.855 230.5 L +372.01 230.5 L +372.166 230.5 L +372.322 230.5 L +372.477 230.5 L +372.633 230.5 L +372.789 230.5 L +372.944 230.5 L +373.1 230.5 L +373.256 230.5 L +373.411 230.5 L +373.567 230.5 L +373.723 230.5 L +373.878 230.5 L +374.034 230.5 L +374.19 230.5 L +374.345 230.5 L +374.501 230.5 L +374.657 230.5 L +374.812 230.5 L +374.968 230.5 L +375.124 230.5 L +375.279 230.5 L +375.435 230.5 L +375.591 230.5 L +375.746 230.5 L +375.902 230.5 L +376.058 230.5 L +376.213 230.5 L +376.369 230.5 L +376.525 230.5 L +376.68 230.5 L +376.836 230.5 L +376.992 230.5 L +377.147 230.5 L +377.303 230.5 L +377.459 230.5 L +377.614 230.5 L +377.77 230.5 L +377.926 230.5 L +378.081 230.5 L +378.237 230.5 L +378.393 230.5 L +378.548 230.5 L +378.704 230.5 L +378.86 230.5 L +379.015 230.5 L +379.171 230.5 L +379.327 230.5 L +379.482 230.5 L +379.638 230.5 L +379.794 230.5 L +379.949 230.5 L +380.105 230.5 L +380.261 230.5 L +380.416 230.5 L +380.572 230.5 L +380.728 230.5 L +380.883 230.5 L +381.039 230.5 L +381.195 230.5 L +381.35 230.5 L +381.506 230.5 L +381.662 230.5 L +381.817 230.5 L +381.973 230.5 L +382.129 230.5 L +382.284 230.5 L +382.44 230.5 L +382.596 230.5 L +382.751 230.5 L +382.907 230.5 L +383.063 230.5 L +383.218 230.5 L +383.374 230.5 L +383.529 230.5 L +383.685 230.5 L +383.841 230.5 L +383.996 230.5 L +384.152 230.5 L +384.308 230.5 L +384.463 230.5 L +384.619 230.5 L +384.775 230.5 L +384.93 230.5 L +385.086 230.5 L +385.242 230.5 L +385.397 230.5 L +385.553 230.5 L +385.709 230.5 L +385.864 230.5 L +386.02 230.5 L +386.176 230.5 L +386.331 230.5 L +386.487 230.5 L +386.643 230.5 L +386.798 230.5 L +386.954 230.5 L +387.11 230.5 L +387.265 230.5 L +387.421 230.5 L +387.577 230.5 L +387.732 230.5 L +387.888 230.5 L +388.044 230.5 L +388.199 230.5 L +388.355 230.5 L +388.511 230.5 L +388.666 230.5 L +388.822 230.5 L +388.978 230.5 L +389.133 230.5 L +389.289 230.5 L +389.445 230.5 L +389.6 230.5 L +389.756 230.5 L +389.912 230.5 L +390.067 230.5 L +390.223 230.5 L +390.379 230.5 L +390.534 230.5 L +390.69 230.5 L +390.846 230.5 L +391.001 230.5 L +391.157 230.5 L +391.313 230.5 L +391.468 230.5 L +391.624 230.5 L +391.78 230.5 L +391.935 230.5 L +392.091 230.5 L +392.247 230.5 L +392.402 230.5 L +392.558 230.5 L +392.714 230.5 L +392.869 230.5 L +393.025 230.5 L +393.181 230.5 L +393.336 230.5 L +393.492 230.5 L +393.648 230.5 L +393.803 230.5 L +393.959 230.5 L +394.115 230.5 L +394.27 230.5 L +394.426 230.5 L +394.582 230.5 L +394.737 230.5 L +394.893 230.5 L +395.049 230.5 L +395.204 230.5 L +395.36 230.5 L +395.516 230.5 L +395.671 230.5 L +395.827 230.5 L +395.983 230.5 L +396.138 230.5 L +396.294 230.5 L +396.45 230.5 L +396.605 230.5 L +396.761 230.5 L +396.917 230.5 L +397.072 230.5 L +397.228 230.5 L +397.384 230.5 L +397.539 230.5 L +397.695 230.5 L +397.851 230.5 L +398.006 230.5 L +398.162 230.5 L +398.318 230.5 L +398.473 230.5 L +398.629 230.5 L +398.785 230.5 L +398.94 230.5 L +399.096 230.5 L +399.252 230.5 L +399.407 230.5 L +399.563 230.5 L +399.719 230.5 L +399.874 230.5 L +400.03 230.5 L +400.186 230.5 L +400.341 230.5 L +400.497 230.5 L +400.653 230.5 L +400.808 230.5 L +400.964 230.5 L +401.12 230.5 L +401.275 230.5 L +401.431 230.5 L +401.587 230.5 L +401.742 230.5 L +401.898 230.5 L +402.054 230.5 L +402.209 230.5 L +402.365 230.5 L +402.521 230.5 L +402.676 230.5 L +402.832 230.5 L +402.987 230.5 L +403.143 230.5 L +403.299 230.5 L +403.454 230.5 L +403.61 230.5 L +403.766 230.5 L +403.921 230.5 L +404.077 230.5 L +404.233 230.5 L +404.388 230.5 L +404.544 230.5 L +404.7 230.5 L +404.855 230.5 L +405.011 230.5 L +405.167 230.5 L +405.322 230.5 L +405.478 230.5 L +405.634 230.5 L +405.789 230.5 L +405.945 230.5 L +406.101 230.5 L +406.256 230.5 L +406.412 230.5 L +406.568 230.5 L +406.723 230.5 L +406.879 230.5 L +407.035 230.5 L +407.19 230.5 L +407.346 230.5 L +407.502 230.5 L +407.657 230.5 L +407.813 230.5 L +407.969 230.5 L +408.124 230.5 L +408.28 230.5 L +408.436 230.5 L +408.591 230.5 L +408.747 230.5 L +408.903 230.5 L +409.058 230.5 L +409.214 230.5 L +409.37 230.5 L +409.525 230.5 L +409.681 230.5 L +409.837 230.5 L +409.992 230.5 L +410.148 230.5 L +410.304 230.5 L +410.459 230.5 L +410.615 230.5 L +410.771 230.5 L +410.926 230.5 L +411.082 230.5 L +411.238 230.5 L +411.393 230.5 L +411.549 230.5 L +411.705 230.5 L +411.86 230.5 L +412.016 230.5 L +412.172 230.5 L +412.327 230.5 L +412.483 230.5 L +412.639 230.5 L +412.794 230.5 L +412.95 230.5 L +413.106 230.5 L +413.261 230.5 L +413.417 230.5 L +413.573 230.5 L +413.728 230.5 L +413.884 230.5 L +414.04 230.5 L +414.195 230.5 L +414.351 230.5 L +414.507 230.5 L +414.662 230.5 L +414.818 230.5 L +414.974 230.5 L +415.129 230.5 L +415.285 230.5 L +415.441 230.5 L +415.596 230.5 L +415.752 230.5 L +415.908 230.5 L +416.063 230.5 L +416.219 230.5 L +416.375 230.5 L +416.53 230.5 L +416.686 230.5 L +416.842 230.5 L +416.997 230.5 L +417.153 230.5 L +417.309 230.5 L +417.464 230.5 L +417.62 230.5 L +417.776 230.5 L +417.931 230.5 L +418.087 230.5 L +418.243 230.5 L +418.398 230.5 L +418.554 230.5 L +418.71 230.5 L +418.865 230.5 L +419.021 230.5 L +419.177 230.5 L +419.332 230.5 L +419.488 230.5 L +419.644 230.5 L +419.799 230.5 L +419.955 230.5 L +420.111 230.5 L +420.266 230.5 L +420.422 230.5 L +420.578 230.5 L +420.733 230.5 L +420.889 230.5 L +421.045 230.5 L +421.2 230.5 L +421.356 230.5 L +421.512 230.5 L +421.667 230.5 L +421.823 230.5 L +421.979 230.5 L +422.134 230.5 L +422.29 230.5 L +422.445 230.5 L +422.601 230.5 L +422.757 230.5 L +422.913 230.5 L +423.068 230.5 L +423.224 230.5 L +423.379 230.5 L +423.535 230.5 L +423.691 230.5 L +423.846 230.5 L +424.002 230.5 L +424.158 230.5 L +424.313 230.5 L +424.469 230.5 L +424.625 230.5 L +424.78 230.5 L +424.936 230.5 L +425.092 230.5 L +425.247 230.5 L +425.403 230.5 L +425.559 230.5 L +425.714 230.5 L +425.87 230.5 L +426.026 230.5 L +426.181 230.5 L +426.337 230.5 L +426.493 230.5 L +426.648 230.5 L +426.804 230.5 L +426.96 230.5 L +427.115 230.5 L +427.271 230.5 L +427.427 230.5 L +427.582 230.5 L +427.738 230.5 L +427.894 230.5 L +428.049 230.5 L +428.205 230.5 L +428.361 230.5 L +428.516 230.5 L +428.672 230.5 L +428.828 230.5 L +428.983 230.5 L +429.139 230.5 L +429.295 230.5 L +429.45 230.5 L +429.606 230.5 L +429.762 230.5 L +429.917 230.5 L +430.073 230.5 L +430.229 230.5 L +430.384 230.5 L +430.54 230.5 L +430.696 230.5 L +430.851 230.5 L +431.007 230.5 L +431.163 230.5 L +431.318 230.5 L +431.474 230.5 L +431.63 230.5 L +431.785 230.5 L +431.941 230.5 L +432.097 230.5 L +432.252 230.5 L +432.408 230.5 L +432.564 230.5 L +432.719 230.5 L +432.875 230.5 L +433.031 230.5 L +433.186 230.5 L +433.342 230.5 L +433.498 230.5 L +433.653 230.5 L +433.809 230.5 L +433.965 230.5 L +434.12 230.5 L +434.276 230.5 L +434.432 230.5 L +434.587 230.5 L +434.743 230.5 L +434.899 230.5 L +435.054 230.5 L +435.21 230.5 L +435.366 230.5 L +435.521 230.5 L +435.677 230.5 L +435.833 230.5 L +435.988 230.5 L +436.144 230.5 L +436.3 230.5 L +436.455 230.5 L +436.611 230.5 L +436.767 230.5 L +436.922 230.5 L +437.078 230.5 L +437.234 230.5 L +437.389 230.5 L +437.545 230.5 L +437.701 230.5 L +437.856 230.5 L +438.012 230.5 L +438.168 230.5 L +438.323 230.5 L +438.479 230.5 L +438.635 230.5 L +438.79 230.5 L +438.946 230.5 L +439.102 230.5 L +439.257 230.5 L +439.413 230.5 L +439.569 230.5 L +439.724 230.5 L +439.88 230.5 L +440.036 230.5 L +440.191 230.5 L +440.347 230.5 L +440.503 230.5 L +440.658 230.5 L +440.814 230.5 L +440.97 230.5 L +441.125 230.5 L +441.281 230.5 L +441.437 230.5 L +441.592 230.5 L +441.748 230.5 L +441.904 230.5 L +442.059 230.5 L +442.215 230.5 L +442.371 230.5 L +442.526 230.5 L +442.682 230.5 L +442.837 230.5 L +442.993 230.5 L +443.149 230.5 L +443.305 230.5 L +443.46 230.5 L +443.616 230.5 L +443.771 230.5 L +443.927 230.5 L +444.083 230.5 L +444.238 230.5 L +444.394 230.5 L +444.55 230.5 L +444.705 230.5 L +444.861 230.5 L +445.017 230.5 L +445.172 230.5 L +445.328 230.5 L +445.484 230.5 L +445.639 230.5 L +445.795 230.5 L +445.951 230.5 L +446.106 230.5 L +446.262 230.5 L +446.418 230.5 L +446.573 230.5 L +446.729 230.5 L +446.885 230.5 L +447.04 230.5 L +447.196 230.5 L +447.352 230.5 L +447.507 230.5 L +447.663 230.5 L +447.819 230.5 L +447.974 230.5 L +448.13 230.5 L +448.286 230.5 L +448.441 230.5 L +448.597 230.5 L +448.753 230.5 L +448.908 230.5 L +449.064 230.5 L +449.22 230.5 L +449.375 230.5 L +449.531 230.5 L +449.687 230.5 L +449.842 230.5 L +449.998 230.5 L +450.154 230.5 L +450.309 230.5 L +450.465 230.5 L +450.621 230.5 L +450.776 230.5 L +450.932 230.5 L +451.088 230.5 L +451.243 230.5 L +451.399 230.5 L +451.555 230.5 L +451.71 230.5 L +451.866 230.5 L +452.022 230.5 L +452.177 230.5 L +452.333 230.5 L +452.489 230.5 L +452.644 230.5 L +452.8 230.5 L +452.956 229.307 L +453.111 228.113 L +453.267 226.921 L +453.423 225.728 L +453.578 224.537 L +453.734 223.346 L +453.89 222.156 L +454.045 220.968 L +454.201 219.781 L +454.357 218.596 L +454.512 217.412 L +454.668 216.23 L +454.824 215.051 L +454.979 213.874 L +455.135 212.699 L +455.291 211.527 L +455.446 210.358 L +455.602 209.192 L +455.758 208.03 L +455.913 206.87 L +456.069 205.714 L +456.225 204.562 L +456.38 203.414 L +456.536 202.27 L +456.692 201.13 L +456.847 199.994 L +457.003 198.864 L +457.159 197.737 L +457.314 196.616 L +457.47 195.5 L +457.626 194.389 L +457.781 193.284 L +457.937 192.184 L +458.093 191.09 L +458.248 190.002 L +458.404 188.92 L +458.56 187.845 L +458.715 186.775 L +458.871 185.713 L +459.027 184.657 L +459.182 183.608 L +459.338 182.566 L +459.494 181.531 L +459.649 180.504 L +459.805 179.484 L +459.961 178.471 L +460.116 177.467 L +460.272 176.471 L +460.428 175.483 L +460.583 174.503 L +460.739 173.531 L +460.895 172.568 L +461.05 171.614 L +461.206 170.669 L +461.362 169.732 L +461.517 168.805 L +461.673 167.887 L +461.829 166.979 L +461.984 166.08 L +462.14 165.191 L +462.296 164.312 L +462.451 163.442 L +462.607 162.583 L +462.763 161.734 L +462.918 160.895 L +463.074 160.067 L +463.229 159.249 L +463.385 158.443 L +463.541 157.646 L +463.696 156.861 L +463.852 156.087 L +464.008 155.325 L +464.163 154.573 L +464.319 153.833 L +464.475 153.105 L +464.63 152.388 L +464.786 151.683 L +464.942 150.99 L +465.097 150.309 L +465.253 149.64 L +465.409 148.983 L +465.564 148.338 L +465.72 147.706 L +465.876 147.086 L +466.031 146.479 L +466.187 145.884 L +466.343 145.302 L +466.498 144.733 L +466.654 144.177 L +466.81 143.634 L +466.965 143.104 L +467.121 142.587 L +467.277 142.083 L +467.432 141.593 L +467.588 141.116 L +467.744 140.653 L +467.899 140.203 L +468.055 139.766 L +468.211 139.344 L +468.366 138.935 L +468.522 138.54 L +468.678 138.158 L +468.833 137.791 L +468.989 137.438 L +469.145 137.098 L +469.3 136.773 L +469.456 136.462 L +469.612 136.164 L +469.767 135.882 L +469.923 135.613 L +470.079 135.359 L +470.234 135.119 L +470.39 134.893 L +470.546 134.682 L +470.701 134.485 L +470.857 134.303 L +471.013 134.135 L +471.168 133.981 L +471.324 133.843 L +471.48 133.718 L +471.635 133.609 L +471.791 133.514 L +471.947 133.433 L +472.102 133.367 L +472.258 133.316 L +472.414 133.279 L +472.569 133.257 L +472.725 133.25 L +472.881 133.257 L +473.036 133.279 L +473.192 133.316 L +473.348 133.367 L +473.503 133.433 L +473.659 133.514 L +473.815 133.609 L +473.97 133.718 L +474.126 133.843 L +474.282 133.981 L +474.437 134.135 L +474.593 134.303 L +474.749 134.485 L +474.904 134.682 L +475.06 134.893 L +475.216 135.119 L +475.371 135.359 L +475.527 135.613 L +475.683 135.882 L +475.838 136.164 L +475.994 136.462 L +476.15 136.773 L +476.305 137.098 L +476.461 137.438 L +476.617 137.791 L +476.772 138.158 L +476.928 138.54 L +477.084 138.935 L +477.239 139.344 L +477.395 139.766 L +477.551 140.203 L +477.706 140.653 L +477.862 141.116 L +478.018 141.593 L +478.173 142.083 L +478.329 142.587 L +478.485 143.104 L +478.64 143.634 L +478.796 144.177 L +478.952 144.733 L +479.107 145.302 L +479.263 145.884 L +479.419 146.479 L +479.574 147.086 L +479.73 147.706 L +479.886 148.338 L +480.041 148.983 L +480.197 149.64 L +480.353 150.309 L +480.508 150.99 L +480.664 151.683 L +480.82 152.388 L +480.975 153.105 L +481.131 153.833 L +481.287 154.573 L +481.442 155.325 L +481.598 156.087 L +481.754 156.861 L +481.909 157.646 L +482.065 158.443 L +482.221 159.249 L +482.376 160.067 L +482.532 160.895 L +482.688 161.734 L +482.843 162.583 L +482.999 163.442 L +483.154 164.312 L +483.31 165.191 L +483.466 166.08 L +483.621 166.979 L +483.777 167.887 L +483.933 168.805 L +484.088 169.732 L +484.244 170.669 L +484.4 171.614 L +484.555 172.568 L +484.711 173.531 L +484.867 174.503 L +485.022 175.483 L +485.178 176.471 L +485.334 177.467 L +485.489 178.471 L +485.645 179.484 L +485.801 180.504 L +485.956 181.531 L +486.112 182.566 L +486.268 183.608 L +486.423 184.657 L +486.579 185.713 L +486.735 186.775 L +486.89 187.845 L +487.046 188.92 L +487.202 190.002 L +487.357 191.09 L +487.513 192.184 L +487.669 193.284 L +487.824 194.389 L +487.98 195.5 L +488.136 196.616 L +488.291 197.737 L +488.447 198.864 L +488.603 199.994 L +488.758 201.13 L +488.914 202.27 L +489.07 203.414 L +489.225 204.562 L +489.381 205.714 L +489.537 206.87 L +489.692 208.03 L +489.848 209.192 L +490.004 210.358 L +490.159 211.527 L +490.315 212.699 L +490.471 213.874 L +490.626 215.051 L +490.782 216.23 L +490.938 217.412 L +491.093 218.596 L +491.249 219.781 L +491.405 220.968 L +491.56 222.156 L +491.716 223.346 L +491.872 224.537 L +492.027 225.728 L +492.183 226.921 L +492.339 228.113 L +492.494 229.307 L +492.65 230.5 L +492.806 231.693 L +492.961 232.887 L +493.117 234.079 L +493.273 235.272 L +493.428 236.463 L +493.584 237.654 L +493.74 238.844 L +493.895 240.032 L +494.051 241.219 L +494.207 242.404 L +494.362 243.588 L +494.518 244.77 L +494.674 245.949 L +494.829 247.126 L +494.985 248.301 L +495.141 249.473 L +495.296 250.642 L +495.452 251.808 L +495.608 252.97 L +495.763 254.13 L +495.919 255.286 L +496.075 256.438 L +496.23 257.586 L +496.386 258.73 L +496.542 259.87 L +496.697 261.006 L +496.853 262.136 L +497.009 263.263 L +497.164 264.384 L +497.32 265.5 L +497.476 266.611 L +497.631 267.716 L +497.787 268.816 L +497.943 269.91 L +498.098 270.998 L +498.254 272.08 L +498.41 273.155 L +498.565 274.225 L +498.721 275.287 L +498.877 276.343 L +499.032 277.392 L +499.188 278.434 L +499.344 279.469 L +499.499 280.496 L +499.655 281.516 L +499.811 282.529 L +499.966 283.533 L +500.122 284.529 L +500.278 285.517 L +500.433 286.497 L +500.589 287.469 L +500.745 288.432 L +500.9 289.386 L +501.056 290.331 L +501.212 291.268 L +501.367 292.195 L +501.523 293.113 L +501.679 294.021 L +501.834 294.92 L +501.99 295.809 L +502.146 296.688 L +502.301 297.558 L +502.457 298.417 L +502.612 299.266 L +502.768 300.105 L +502.924 300.933 L +503.079 301.751 L +503.235 302.557 L +503.391 303.354 L +503.546 304.139 L +503.702 304.913 L +503.858 305.675 L +504.013 306.427 L +504.169 307.167 L +504.325 307.895 L +504.48 308.612 L +504.636 309.317 L +504.792 310.01 L +504.947 310.691 L +505.103 311.36 L +505.259 312.017 L +505.414 312.662 L +505.57 313.294 L +505.726 313.914 L +505.881 314.521 L +506.037 315.116 L +506.193 315.698 L +506.348 316.267 L +506.504 316.823 L +506.66 317.366 L +506.815 317.896 L +506.971 318.413 L +507.127 318.917 L +507.282 319.407 L +507.438 319.884 L +507.594 320.347 L +507.749 320.797 L +507.905 321.234 L +508.061 321.656 L +508.216 322.065 L +508.372 322.46 L +508.528 322.842 L +508.683 323.209 L +508.839 323.562 L +508.995 323.902 L +509.15 324.227 L +509.306 324.538 L +509.462 324.836 L +509.617 325.118 L +509.773 325.387 L +509.929 325.641 L +510.084 325.881 L +510.24 326.107 L +510.396 326.318 L +510.551 326.515 L +510.707 326.697 L +510.863 326.865 L +511.018 327.019 L +511.174 327.157 L +511.33 327.282 L +511.485 327.391 L +511.641 327.486 L +511.797 327.567 L +511.952 327.633 L +512.108 327.684 L +512.264 327.721 L +512.419 327.743 L +512.575 327.75 L +512.731 327.743 L +512.886 327.721 L +513.042 327.684 L +513.198 327.633 L +513.353 327.567 L +513.509 327.486 L +513.665 327.391 L +513.82 327.282 L +513.976 327.157 L +514.132 327.019 L +514.287 326.865 L +514.443 326.697 L +514.599 326.515 L +514.754 326.318 L +514.91 326.107 L +515.066 325.881 L +515.221 325.641 L +515.377 325.387 L +515.533 325.118 L +515.688 324.836 L +515.844 324.538 L +516 324.227 L +516.155 323.902 L +516.311 323.562 L +516.467 323.209 L +516.622 322.842 L +516.778 322.46 L +516.934 322.065 L +517.089 321.656 L +517.245 321.234 L +517.401 320.797 L +517.556 320.347 L +517.712 319.884 L +517.868 319.407 L +518.023 318.917 L +518.179 318.413 L +518.335 317.896 L +518.49 317.366 L +518.646 316.823 L +518.802 316.267 L +518.957 315.698 L +519.113 315.116 L +519.269 314.521 L +519.424 313.914 L +519.58 313.294 L +519.736 312.662 L +519.891 312.017 L +520.047 311.36 L +520.203 310.691 L +520.358 310.01 L +520.514 309.317 L +520.67 308.612 L +520.825 307.895 L +520.981 307.167 L +521.137 306.427 L +521.292 305.675 L +521.448 304.913 L +521.604 304.139 L +521.759 303.354 L +521.915 302.557 L +522.07 301.751 L +522.226 300.933 L +522.382 300.105 L +522.537 299.266 L +522.693 298.417 L +522.849 297.558 L +523.005 296.688 L +523.16 295.809 L +523.316 294.92 L +523.471 294.021 L +523.627 293.113 L +523.783 292.195 L +523.938 291.268 L +524.094 290.331 L +524.25 289.386 L +524.405 288.432 L +524.561 287.469 L +524.717 286.497 L +524.872 285.517 L +525.028 284.529 L +525.184 283.533 L +525.339 282.529 L +525.495 281.516 L +525.651 280.496 L +525.806 279.469 L +525.962 278.434 L +526.118 277.392 L +526.273 276.343 L +526.429 275.287 L +526.585 274.225 L +526.74 273.155 L +526.896 272.08 L +527.052 270.998 L +527.207 269.91 L +527.363 268.816 L +527.519 267.716 L +527.674 266.611 L +527.83 265.5 L +527.986 264.384 L +528.141 263.263 L +528.297 262.136 L +528.453 261.006 L +528.608 259.87 L +528.764 258.73 L +528.92 257.586 L +529.075 256.438 L +529.231 255.286 L +529.387 254.13 L +529.542 252.97 L +529.698 251.808 L +529.854 250.642 L +530.009 249.473 L +530.165 248.301 L +530.321 247.126 L +530.476 245.949 L +530.632 244.77 L +530.788 243.588 L +530.943 242.404 L +531.099 241.219 L +531.255 240.032 L +531.41 238.844 L +531.566 237.654 L +531.722 236.463 L +531.877 235.272 L +532.033 234.079 L +532.189 232.887 L +532.344 231.693 L +532.5 230.5 L +532.656 229.307 L +532.811 228.113 L +532.967 226.921 L +533.123 225.728 L +533.278 224.537 L +533.434 223.346 L +533.59 222.156 L +533.745 220.968 L +533.901 219.781 L +534.057 218.596 L +534.212 217.412 L +534.368 216.23 L +534.524 215.051 L +534.679 213.874 L +534.835 212.699 L +534.991 211.527 L +535.146 210.358 L +535.302 209.192 L +535.458 208.03 L +535.613 206.87 L +535.769 205.714 L +535.925 204.562 L +536.08 203.414 L +536.236 202.27 L +536.392 201.13 L +536.547 199.994 L +536.703 198.864 L +536.859 197.737 L +537.014 196.616 L +537.17 195.5 L +537.326 194.389 L +537.481 193.284 L +537.637 192.184 L +537.793 191.09 L +537.948 190.002 L +538.104 188.92 L +538.26 187.845 L +538.415 186.775 L +538.571 185.713 L +538.727 184.657 L +538.882 183.608 L +539.038 182.566 L +539.194 181.531 L +539.349 180.504 L +539.505 179.484 L +539.661 178.471 L +539.816 177.467 L +539.972 176.471 L +540.128 175.483 L +540.283 174.503 L +540.439 173.531 L +540.595 172.568 L +540.75 171.614 L +540.906 170.669 L +541.062 169.732 L +541.217 168.805 L +541.373 167.887 L +541.529 166.979 L +541.684 166.08 L +541.84 165.191 L +541.995 164.312 L +542.151 163.442 L +542.307 162.583 L +542.463 161.734 L +542.618 160.895 L +542.774 160.067 L +542.93 159.249 L +543.085 158.443 L +543.241 157.646 L +543.396 156.861 L +543.552 156.087 L +543.708 155.325 L +543.863 154.573 L +544.019 153.833 L +544.175 153.105 L +544.33 152.388 L +544.486 151.683 L +544.642 150.99 L +544.797 150.309 L +544.953 149.64 L +545.109 148.983 L +545.264 148.338 L +545.42 147.706 L +545.576 147.086 L +545.731 146.479 L +545.887 145.884 L +546.043 145.302 L +546.198 144.733 L +546.354 144.177 L +546.51 143.634 L +546.665 143.104 L +546.821 142.587 L +546.977 142.083 L +547.132 141.593 L +547.288 141.116 L +547.444 140.653 L +547.599 140.203 L +547.755 139.766 L +547.911 139.344 L +548.066 138.935 L +548.222 138.54 L +548.378 138.158 L +548.533 137.791 L +548.689 137.438 L +548.845 137.098 L +549 136.773 L +549.156 136.462 L +549.312 136.164 L +549.467 135.882 L +549.623 135.613 L +549.779 135.359 L +549.934 135.119 L +550.09 134.893 L +550.246 134.682 L +550.401 134.485 L +550.557 134.303 L +550.713 134.135 L +550.868 133.981 L +551.024 133.843 L +551.18 133.718 L +551.335 133.609 L +551.491 133.514 L +551.647 133.433 L +551.802 133.367 L +551.958 133.316 L +552.114 133.279 L +552.269 133.257 L +552.425 133.25 L +552.581 133.257 L +552.736 133.279 L +552.892 133.316 L +553.048 133.367 L +553.203 133.433 L +553.359 133.514 L +553.515 133.609 L +553.67 133.718 L +553.826 133.843 L +553.982 133.981 L +554.137 134.135 L +554.293 134.303 L +554.449 134.485 L +554.604 134.682 L +554.76 134.893 L +554.916 135.119 L +555.071 135.359 L +555.227 135.613 L +555.383 135.882 L +555.538 136.164 L +555.694 136.462 L +555.85 136.773 L +556.005 137.098 L +556.161 137.438 L +556.317 137.791 L +556.472 138.158 L +556.628 138.54 L +556.784 138.935 L +556.939 139.344 L +557.095 139.766 L +557.251 140.203 L +557.406 140.653 L +557.562 141.116 L +557.718 141.593 L +557.873 142.083 L +558.029 142.587 L +558.185 143.104 L +558.34 143.634 L +558.496 144.177 L +558.652 144.733 L +558.807 145.302 L +558.963 145.884 L +559.119 146.479 L +559.274 147.086 L +559.43 147.706 L +559.586 148.338 L +559.741 148.983 L +559.897 149.64 L +560.053 150.309 L +560.208 150.99 L +560.364 151.683 L +560.52 152.388 L +560.675 153.105 L +560.831 153.833 L +560.987 154.573 L +561.142 155.325 L +561.298 156.087 L +561.453 156.861 L +561.609 157.646 L +561.765 158.443 L +561.921 159.249 L +562.076 160.067 L +562.232 160.895 L +562.388 161.734 L +562.543 162.583 L +562.699 163.442 L +562.854 164.312 L +563.01 165.191 L +563.166 166.08 L +563.321 166.979 L +563.477 167.887 L +563.633 168.805 L +563.788 169.732 L +563.944 170.669 L +564.1 171.614 L +564.255 172.568 L +564.411 173.531 L +564.567 174.503 L +564.722 175.483 L +564.878 176.471 L +565.034 177.467 L +565.189 178.471 L +565.345 179.484 L +565.501 180.504 L +565.656 181.531 L +565.812 182.566 L +565.968 183.608 L +566.123 184.657 L +566.279 185.713 L +566.435 186.775 L +566.59 187.845 L +566.746 188.92 L +566.902 190.002 L +567.057 191.09 L +567.213 192.184 L +567.369 193.284 L +567.524 194.389 L +567.68 195.5 L +567.836 196.616 L +567.991 197.737 L +568.147 198.864 L +568.303 199.994 L +568.458 201.13 L +568.614 202.27 L +568.77 203.414 L +568.925 204.562 L +569.081 205.714 L +569.237 206.87 L +569.392 208.03 L +569.548 209.192 L +569.704 210.358 L +569.859 211.527 L +570.015 212.699 L +570.171 213.874 L +570.326 215.051 L +570.482 216.23 L +570.638 217.412 L +570.793 218.596 L +570.949 219.781 L +571.105 220.968 L +571.26 222.156 L +571.416 223.346 L +571.572 224.537 L +571.727 225.728 L +571.883 226.921 L +572.039 228.113 L +572.194 229.307 L +572.35 230.5 L +572.506 231.693 L +572.661 232.887 L +572.817 234.079 L +572.973 235.272 L +573.128 236.463 L +573.284 237.654 L +573.44 238.844 L +573.595 240.032 L +573.751 241.219 L +573.907 242.404 L +574.062 243.588 L +574.218 244.77 L +574.374 245.949 L +574.529 247.126 L +574.685 248.301 L +574.841 249.473 L +574.996 250.642 L +575.152 251.808 L +575.308 252.97 L +575.463 254.13 L +575.619 255.286 L +575.775 256.438 L +575.93 257.586 L +576.086 258.73 L +576.242 259.87 L +576.397 261.006 L +576.553 262.136 L +576.709 263.263 L +576.864 264.384 L +577.02 265.5 L +577.176 266.611 L +577.331 267.716 L +577.487 268.816 L +577.643 269.91 L +577.798 270.998 L +577.954 272.08 L +578.11 273.155 L +578.265 274.225 L +578.421 275.287 L +578.577 276.343 L +578.732 277.392 L +578.888 278.434 L +579.044 279.469 L +579.199 280.496 L +579.355 281.516 L +579.511 282.529 L +579.666 283.533 L +579.822 284.529 L +579.978 285.517 L +580.133 286.497 L +580.289 287.469 L +580.445 288.432 L +580.6 289.386 L +580.756 290.331 L +580.911 291.268 L +581.067 292.195 L +581.223 293.113 L +581.379 294.021 L +581.534 294.92 L +581.69 295.809 L +581.846 296.688 L +582.001 297.558 L +582.157 298.417 L +582.313 299.266 L +582.468 300.105 L +582.624 300.933 L +582.779 301.751 L +582.935 302.557 L +583.091 303.354 L +583.246 304.139 L +583.402 304.913 L +583.558 305.675 L +583.714 306.427 L +583.869 307.167 L +584.025 307.895 L +584.18 308.612 L +584.336 309.317 L +584.492 310.01 L +584.647 310.691 L +584.803 311.36 L +584.959 312.017 L +585.114 312.662 L +585.27 313.294 L +585.426 313.914 L +585.581 314.521 L +585.737 315.116 L +585.893 315.698 L +586.048 316.267 L +586.204 316.823 L +586.36 317.366 L +586.515 317.896 L +586.671 318.413 L +586.827 318.917 L +586.982 319.407 L +587.138 319.884 L +587.294 320.347 L +587.449 320.797 L +587.605 321.234 L +587.761 321.656 L +587.916 322.065 L +588.072 322.46 L +588.228 322.842 L +588.383 323.209 L +588.539 323.562 L +588.695 323.902 L +588.85 324.227 L +589.006 324.538 L +589.162 324.836 L +589.317 325.118 L +589.473 325.387 L +589.629 325.641 L +589.784 325.881 L +589.94 326.107 L +590.096 326.318 L +590.251 326.515 L +590.407 326.697 L +590.563 326.865 L +590.718 327.019 L +590.874 327.157 L +591.03 327.282 L +591.185 327.391 L +591.341 327.486 L +591.497 327.567 L +591.652 327.633 L +591.808 327.684 L +591.964 327.721 L +592.119 327.743 L +592.275 327.75 L +592.431 327.743 L +592.586 327.721 L +592.742 327.684 L +592.898 327.633 L +593.053 327.567 L +593.209 327.486 L +593.365 327.391 L +593.52 327.282 L +593.676 327.157 L +593.832 327.019 L +593.987 326.865 L +594.143 326.697 L +594.299 326.515 L +594.454 326.318 L +594.61 326.107 L +594.766 325.881 L +594.921 325.641 L +595.077 325.387 L +595.233 325.118 L +595.388 324.836 L +595.544 324.538 L +595.7 324.227 L +595.855 323.902 L +596.011 323.562 L +596.167 323.209 L +596.322 322.842 L +596.478 322.46 L +596.634 322.065 L +596.789 321.656 L +596.945 321.234 L +597.101 320.797 L +597.256 320.347 L +597.412 319.884 L +597.568 319.407 L +597.723 318.917 L +597.879 318.413 L +598.035 317.896 L +598.19 317.366 L +598.346 316.823 L +598.502 316.267 L +598.657 315.698 L +598.813 315.116 L +598.969 314.521 L +599.124 313.914 L +599.28 313.294 L +599.436 312.662 L +599.591 312.017 L +599.747 311.36 L +599.903 310.691 L +600.058 310.01 L +600.214 309.317 L +600.37 308.612 L +600.525 307.895 L +600.681 307.167 L +600.837 306.427 L +600.992 305.675 L +601.148 304.913 L +601.304 304.139 L +601.459 303.354 L +601.615 302.557 L +601.771 301.751 L +601.926 300.933 L +602.082 300.105 L +602.237 299.266 L +602.393 298.417 L +602.549 297.558 L +602.704 296.688 L +602.86 295.809 L +603.016 294.92 L +603.172 294.021 L +603.327 293.113 L +603.483 292.195 L +603.638 291.268 L +603.794 290.331 L +603.95 289.386 L +604.105 288.432 L +604.261 287.469 L +604.417 286.497 L +604.572 285.517 L +604.728 284.529 L +604.884 283.533 L +605.039 282.529 L +605.195 281.516 L +605.351 280.496 L +605.506 279.469 L +605.662 278.434 L +605.818 277.392 L +605.973 276.343 L +606.129 275.287 L +606.285 274.225 L +606.44 273.155 L +606.596 272.08 L +606.752 270.998 L +606.907 269.91 L +607.063 268.816 L +607.219 267.716 L +607.374 266.611 L +607.53 265.5 L +607.686 264.384 L +607.841 263.263 L +607.997 262.136 L +608.153 261.006 L +608.308 259.87 L +608.464 258.73 L +608.62 257.586 L +608.775 256.438 L +608.931 255.286 L +609.087 254.13 L +609.242 252.97 L +609.398 251.808 L +609.554 250.642 L +609.709 249.473 L +609.865 248.301 L +610.021 247.126 L +610.176 245.949 L +610.332 244.77 L +610.488 243.588 L +610.643 242.404 L +610.799 241.219 L +610.955 240.032 L +611.11 238.844 L +611.266 237.654 L +611.422 236.463 L +611.577 235.272 L +611.733 234.079 L +611.889 232.887 L +612.044 231.693 L +612.2 230.5 L +612.356 229.307 L +612.511 228.113 L +612.667 226.921 L +612.823 225.728 L +612.978 224.537 L +613.134 223.346 L +613.29 222.156 L +613.445 220.968 L +613.601 219.781 L +613.757 218.596 L +613.912 217.412 L +614.068 216.23 L +614.224 215.051 L +614.379 213.874 L +614.535 212.699 L +614.691 211.527 L +614.846 210.358 L +615.002 209.192 L +615.158 208.03 L +615.313 206.87 L +615.469 205.714 L +615.625 204.562 L +615.78 203.414 L +615.936 202.27 L +616.092 201.13 L +616.247 199.994 L +616.403 198.864 L +616.559 197.737 L +616.714 196.616 L +616.87 195.5 L +617.026 194.389 L +617.181 193.284 L +617.337 192.184 L +617.493 191.09 L +617.648 190.002 L +617.804 188.92 L +617.96 187.845 L +618.115 186.775 L +618.271 185.713 L +618.427 184.657 L +618.582 183.608 L +618.738 182.566 L +618.894 181.531 L +619.049 180.504 L +619.205 179.484 L +619.361 178.471 L +619.516 177.467 L +619.672 176.471 L +619.828 175.483 L +619.983 174.503 L +620.139 173.531 L +620.295 172.568 L +620.45 171.614 L +620.606 170.669 L +620.762 169.732 L +620.917 168.805 L +621.073 167.887 L +621.229 166.979 L +621.384 166.08 L +621.54 165.191 L +621.695 164.312 L +621.851 163.442 L +622.007 162.583 L +622.162 161.734 L +622.318 160.895 L +622.474 160.067 L +622.63 159.249 L +622.785 158.443 L +622.941 157.646 L +623.096 156.861 L +623.252 156.087 L +623.408 155.325 L +623.563 154.573 L +623.719 153.833 L +623.875 153.105 L +624.03 152.388 L +624.186 151.683 L +624.342 150.99 L +624.497 150.309 L +624.653 149.64 L +624.809 148.983 L +624.964 148.338 L +625.12 147.706 L +625.276 147.086 L +625.431 146.479 L +625.587 145.884 L +625.743 145.302 L +625.898 144.733 L +626.054 144.177 L +626.21 143.634 L +626.365 143.104 L +626.521 142.587 L +626.677 142.083 L +626.832 141.593 L +626.988 141.116 L +627.144 140.653 L +627.299 140.203 L +627.455 139.766 L +627.611 139.344 L +627.766 138.935 L +627.922 138.54 L +628.078 138.158 L +628.233 137.791 L +628.389 137.438 L +628.545 137.098 L +628.7 136.773 L +628.856 136.462 L +629.012 136.164 L +629.167 135.882 L +629.323 135.613 L +629.479 135.359 L +629.634 135.119 L +629.79 134.893 L +629.946 134.682 L +630.101 134.485 L +630.257 134.303 L +630.413 134.135 L +630.568 133.981 L +630.724 133.843 L +630.88 133.718 L +631.035 133.609 L +631.191 133.514 L +631.347 133.433 L +631.502 133.367 L +631.658 133.316 L +631.814 133.279 L +631.969 133.257 L +632.125 133.25 L +632.281 133.257 L +632.436 133.279 L +632.592 133.316 L +632.748 133.367 L +632.903 133.433 L +633.059 133.514 L +633.215 133.609 L +633.37 133.718 L +633.526 133.843 L +633.682 133.981 L +633.837 134.135 L +633.993 134.303 L +634.149 134.485 L +634.304 134.682 L +634.46 134.893 L +634.616 135.119 L +634.771 135.359 L +634.927 135.613 L +635.083 135.882 L +635.238 136.164 L +635.394 136.462 L +635.55 136.773 L +635.705 137.098 L +635.861 137.438 L +636.017 137.791 L +636.172 138.158 L +636.328 138.54 L +636.484 138.935 L +636.639 139.344 L +636.795 139.766 L +636.951 140.203 L +637.106 140.653 L +637.262 141.116 L +637.418 141.593 L +637.573 142.083 L +637.729 142.587 L +637.885 143.104 L +638.04 143.634 L +638.196 144.177 L +638.352 144.733 L +638.507 145.302 L +638.663 145.884 L +638.819 146.479 L +638.974 147.086 L +639.13 147.706 L +639.286 148.338 L +639.441 148.983 L +639.597 149.64 L +639.753 150.309 L +639.908 150.99 L +640.064 151.683 L +640.22 152.388 L +640.375 153.105 L +640.531 153.833 L +640.687 154.573 L +640.842 155.325 L +640.998 156.087 L +641.154 156.861 L +641.309 157.646 L +641.465 158.443 L +641.62 159.249 L +641.776 160.067 L +641.932 160.895 L +642.088 161.734 L +642.243 162.583 L +642.399 163.442 L +642.555 164.312 L +642.71 165.191 L +642.866 166.08 L +643.021 166.979 L +643.177 167.887 L +643.333 168.805 L +643.488 169.732 L +643.644 170.669 L +643.8 171.614 L +643.955 172.568 L +644.111 173.531 L +644.267 174.503 L +644.422 175.483 L +644.578 176.471 L +644.734 177.467 L +644.889 178.471 L +645.045 179.484 L +645.201 180.504 L +645.356 181.531 L +645.512 182.566 L +645.668 183.608 L +645.823 184.657 L +645.979 185.713 L +646.135 186.775 L +646.29 187.845 L +646.446 188.92 L +646.602 190.002 L +646.757 191.09 L +646.913 192.184 L +647.069 193.284 L +647.224 194.389 L +647.38 195.5 L +647.536 196.616 L +647.691 197.737 L +647.847 198.864 L +648.003 199.994 L +648.158 201.13 L +648.314 202.27 L +648.47 203.414 L +648.625 204.562 L +648.781 205.714 L +648.937 206.87 L +649.092 208.03 L +649.248 209.192 L +649.404 210.358 L +649.559 211.527 L +649.715 212.699 L +649.871 213.874 L +650.026 215.051 L +650.182 216.23 L +650.338 217.412 L +650.493 218.596 L +650.649 219.781 L +650.805 220.968 L +650.96 222.156 L +651.116 223.346 L +651.272 224.537 L +651.427 225.728 L +651.583 226.921 L +651.739 228.113 L +651.894 229.307 L +652.05 230.5 L +652.206 231.693 L +652.361 232.887 L +652.517 234.079 L +652.673 235.272 L +652.828 236.463 L +652.984 237.654 L +653.14 238.844 L +653.295 240.032 L +653.451 241.219 L +653.607 242.404 L +653.762 243.588 L +653.918 244.77 L +654.074 245.949 L +654.229 247.126 L +654.385 248.301 L +654.541 249.473 L +654.696 250.642 L +654.852 251.808 L +655.008 252.97 L +655.163 254.13 L +655.319 255.286 L +655.475 256.438 L +655.63 257.586 L +655.786 258.73 L +655.942 259.87 L +656.097 261.006 L +656.253 262.136 L +656.409 263.263 L +656.564 264.384 L +656.72 265.5 L +656.876 266.611 L +657.031 267.716 L +657.187 268.816 L +657.343 269.91 L +657.498 270.998 L +657.654 272.08 L +657.81 273.155 L +657.965 274.225 L +658.121 275.287 L +658.277 276.343 L +658.432 277.392 L +658.588 278.434 L +658.744 279.469 L +658.899 280.496 L +659.055 281.516 L +659.211 282.529 L +659.366 283.533 L +659.522 284.529 L +659.678 285.517 L +659.833 286.497 L +659.989 287.469 L +660.145 288.432 L +660.3 289.386 L +660.456 290.331 L +660.612 291.268 L +660.767 292.195 L +660.923 293.113 L +661.078 294.021 L +661.234 294.92 L +661.39 295.809 L +661.546 296.688 L +661.701 297.558 L +661.857 298.417 L +662.013 299.266 L +662.168 300.105 L +662.324 300.933 L +662.479 301.751 L +662.635 302.557 L +662.791 303.354 L +662.946 304.139 L +663.102 304.913 L +663.258 305.675 L +663.413 306.427 L +663.569 307.167 L +663.725 307.895 L +663.88 308.612 L +664.036 309.317 L +664.192 310.01 L +664.347 310.691 L +664.503 311.36 L +664.659 312.017 L +664.814 312.662 L +664.97 313.294 L +665.126 313.914 L +665.281 314.521 L +665.437 315.116 L +665.593 315.698 L +665.748 316.267 L +665.904 316.823 L +666.06 317.366 L +666.215 317.896 L +666.371 318.413 L +666.527 318.917 L +666.682 319.407 L +666.838 319.884 L +666.994 320.347 L +667.149 320.797 L +667.305 321.234 L +667.461 321.656 L +667.616 322.065 L +667.772 322.46 L +667.928 322.842 L +668.083 323.209 L +668.239 323.562 L +668.395 323.902 L +668.55 324.227 L +668.706 324.538 L +668.862 324.836 L +669.017 325.118 L +669.173 325.387 L +669.329 325.641 L +669.484 325.881 L +669.64 326.107 L +669.796 326.318 L +669.951 326.515 L +670.107 326.697 L +670.263 326.865 L +670.418 327.019 L +670.574 327.157 L +670.73 327.282 L +670.885 327.391 L +671.041 327.486 L +671.197 327.567 L +671.352 327.633 L +671.508 327.684 L +671.664 327.721 L +671.819 327.743 L +671.975 327.75 L +672.131 327.743 L +672.286 327.721 L +672.442 327.684 L +672.598 327.633 L +672.753 327.567 L +672.909 327.486 L +673.065 327.391 L +673.22 327.282 L +673.376 327.157 L +673.532 327.019 L +673.687 326.865 L +673.843 326.697 L +673.999 326.515 L +674.154 326.318 L +674.31 326.107 L +674.466 325.881 L +674.621 325.641 L +674.777 325.387 L +674.933 325.118 L +675.088 324.836 L +675.244 324.538 L +675.4 324.227 L +675.555 323.902 L +675.711 323.562 L +675.867 323.209 L +676.022 322.842 L +676.178 322.46 L +676.334 322.065 L +676.489 321.656 L +676.645 321.234 L +676.801 320.797 L +676.956 320.347 L +677.112 319.884 L +677.268 319.407 L +677.423 318.917 L +677.579 318.413 L +677.735 317.896 L +677.89 317.366 L +678.046 316.823 L +678.202 316.267 L +678.357 315.698 L +678.513 315.116 L +678.669 314.521 L +678.824 313.914 L +678.98 313.294 L +679.136 312.662 L +679.291 312.017 L +679.447 311.36 L +679.603 310.691 L +679.758 310.01 L +679.914 309.317 L +680.07 308.612 L +680.225 307.895 L +680.381 307.167 L +680.536 306.427 L +680.692 305.675 L +680.848 304.913 L +681.004 304.139 L +681.159 303.354 L +681.315 302.557 L +681.471 301.751 L +681.626 300.933 L +681.782 300.105 L +681.938 299.266 L +682.093 298.417 L +682.249 297.558 L +682.404 296.688 L +682.56 295.809 L +682.716 294.92 L +682.871 294.021 L +683.027 293.113 L +683.183 292.195 L +683.339 291.268 L +683.494 290.331 L +683.65 289.386 L +683.805 288.432 L +683.961 287.469 L +684.117 286.497 L +684.272 285.517 L +684.428 284.529 L +684.584 283.533 L +684.739 282.529 L +684.895 281.516 L +685.051 280.496 L +685.206 279.469 L +685.362 278.434 L +685.518 277.392 L +685.673 276.343 L +685.829 275.287 L +685.985 274.225 L +686.14 273.155 L +686.296 272.08 L +686.452 270.998 L +686.607 269.91 L +686.763 268.816 L +686.919 267.716 L +687.074 266.611 L +687.23 265.5 L +687.386 264.384 L +687.541 263.263 L +687.697 262.136 L +687.853 261.006 L +688.008 259.87 L +688.164 258.73 L +688.32 257.586 L +688.475 256.438 L +688.631 255.286 L +688.787 254.13 L +688.942 252.97 L +689.098 251.808 L +689.254 250.642 L +689.409 249.473 L +689.565 248.301 L +689.721 247.126 L +689.876 245.949 L +690.032 244.77 L +690.188 243.588 L +690.343 242.404 L +690.499 241.219 L +690.655 240.032 L +690.81 238.844 L +690.966 237.654 L +691.122 236.463 L +691.277 235.272 L +691.433 234.079 L +691.589 232.887 L +691.744 231.693 L +691.9 230.5 L +692.056 229.307 L +692.211 228.113 L +692.367 226.921 L +692.523 225.728 L +692.678 224.537 L +692.834 223.346 L +692.99 222.156 L +693.145 220.968 L +693.301 219.781 L +693.457 218.596 L +693.612 217.412 L +693.768 216.23 L +693.924 215.051 L +694.079 213.874 L +694.235 212.699 L +694.391 211.527 L +694.546 210.358 L +694.702 209.192 L +694.858 208.03 L +695.013 206.87 L +695.169 205.714 L +695.325 204.562 L +695.48 203.414 L +695.636 202.27 L +695.792 201.13 L +695.947 199.994 L +696.103 198.864 L +696.259 197.737 L +696.414 196.616 L +696.57 195.5 L +696.726 194.389 L +696.881 193.284 L +697.037 192.184 L +697.193 191.09 L +697.348 190.002 L +697.504 188.92 L +697.66 187.845 L +697.815 186.775 L +697.971 185.713 L +698.127 184.657 L +698.282 183.608 L +698.438 182.566 L +698.594 181.531 L +698.749 180.504 L +698.905 179.484 L +699.061 178.471 L +699.216 177.467 L +699.372 176.471 L +699.528 175.483 L +699.683 174.503 L +699.839 173.531 L +699.995 172.568 L +700.15 171.614 L +700.306 170.669 L +700.462 169.732 L +700.617 168.805 L +700.773 167.887 L +700.929 166.979 L +701.084 166.08 L +701.24 165.191 L +701.396 164.312 L +701.551 163.442 L +701.707 162.583 L +701.862 161.734 L +702.018 160.895 L +702.174 160.067 L +702.329 159.249 L +702.485 158.443 L +702.641 157.646 L +702.797 156.861 L +702.952 156.087 L +703.108 155.325 L +703.263 154.573 L +703.419 153.833 L +703.575 153.105 L +703.73 152.388 L +703.886 151.683 L +704.042 150.99 L +704.197 150.309 L +704.353 149.64 L +704.509 148.983 L +704.664 148.338 L +704.82 147.706 L +704.976 147.086 L +705.131 146.479 L +705.287 145.884 L +705.443 145.302 L +705.598 144.733 L +705.754 144.177 L +705.91 143.634 L +706.065 143.104 L +706.221 142.587 L +706.377 142.083 L +706.532 141.593 L +706.688 141.116 L +706.844 140.653 L +706.999 140.203 L +707.155 139.766 L +707.311 139.344 L +707.466 138.935 L +707.622 138.54 L +707.778 138.158 L +707.933 137.791 L +708.089 137.438 L +708.245 137.098 L +708.4 136.773 L +708.556 136.462 L +708.712 136.164 L +708.867 135.882 L +709.023 135.613 L +709.179 135.359 L +709.334 135.119 L +709.49 134.893 L +709.646 134.682 L +709.801 134.485 L +709.957 134.303 L +710.113 134.135 L +710.268 133.981 L +710.424 133.843 L +710.58 133.718 L +710.735 133.609 L +710.891 133.514 L +711.047 133.433 L +711.202 133.367 L +711.358 133.316 L +711.514 133.279 L +711.669 133.257 L +711.825 133.25 L +711.981 133.257 L +712.136 133.279 L +712.292 133.316 L +712.448 133.367 L +712.603 133.433 L +712.759 133.514 L +712.915 133.609 L +713.07 133.718 L +713.226 133.843 L +713.382 133.981 L +713.537 134.135 L +713.693 134.303 L +713.849 134.485 L +714.004 134.682 L +714.16 134.893 L +714.316 135.119 L +714.471 135.359 L +714.627 135.613 L +714.783 135.882 L +714.938 136.164 L +715.094 136.462 L +715.25 136.773 L +715.405 137.098 L +715.561 137.438 L +715.717 137.791 L +715.872 138.158 L +716.028 138.54 L +716.184 138.935 L +716.339 139.344 L +716.495 139.766 L +716.651 140.203 L +716.806 140.653 L +716.962 141.116 L +717.118 141.593 L +717.273 142.083 L +717.429 142.587 L +717.585 143.104 L +717.74 143.634 L +717.896 144.177 L +718.052 144.733 L +718.207 145.302 L +718.363 145.884 L +718.519 146.479 L +718.674 147.086 L +718.83 147.706 L +718.986 148.338 L +719.141 148.983 L +719.297 149.64 L +719.453 150.309 L +719.608 150.99 L +719.764 151.683 L +719.92 152.388 L +720.075 153.105 L +720.231 153.833 L +720.387 154.573 L +720.542 155.325 L +720.698 156.087 L +720.854 156.861 L +721.009 157.646 L +721.165 158.443 L +721.32 159.249 L +721.476 160.067 L +721.632 160.895 L +721.787 161.734 L +721.943 162.583 L +722.099 163.442 L +722.255 164.312 L +722.41 165.191 L +722.566 166.08 L +722.721 166.979 L +722.877 167.887 L +723.033 168.805 L +723.188 169.732 L +723.344 170.669 L +723.5 171.614 L +723.655 172.568 L +723.811 173.531 L +723.967 174.503 L +724.122 175.483 L +724.278 176.471 L +724.434 177.467 L +724.589 178.471 L +724.745 179.484 L +724.901 180.504 L +725.056 181.531 L +725.212 182.566 L +725.368 183.608 L +725.523 184.657 L +725.679 185.713 L +725.835 186.775 L +725.99 187.845 L +726.146 188.92 L +726.302 190.002 L +726.457 191.09 L +726.613 192.184 L +726.769 193.284 L +726.924 194.389 L +727.08 195.5 L +727.236 196.616 L +727.391 197.737 L +727.547 198.864 L +727.703 199.994 L +727.858 201.13 L +728.014 202.27 L +728.17 203.414 L +728.325 204.562 L +728.481 205.714 L +728.637 206.87 L +728.792 208.03 L +728.948 209.192 L +729.104 210.358 L +729.259 211.527 L +729.415 212.699 L +729.571 213.874 L +729.726 215.051 L +729.882 216.23 L +730.038 217.412 L +730.193 218.596 L +730.349 219.781 L +730.505 220.968 L +730.66 222.156 L +730.816 223.346 L +730.972 224.537 L +731.127 225.728 L +731.283 226.921 L +731.439 228.113 L +731.594 229.307 L +731.75 230.5 L +731.906 231.693 L +732.061 232.887 L +732.217 234.079 L +732.373 235.272 L +732.528 236.463 L +732.684 237.654 L +732.84 238.844 L +732.995 240.032 L +733.151 241.219 L +733.307 242.404 L +733.462 243.588 L +733.618 244.77 L +733.774 245.949 L +733.929 247.126 L +734.085 248.301 L +734.241 249.473 L +734.396 250.642 L +734.552 251.808 L +734.708 252.97 L +734.863 254.13 L +735.019 255.286 L +735.175 256.438 L +735.33 257.586 L +735.486 258.73 L +735.642 259.87 L +735.797 261.006 L +735.953 262.136 L +736.109 263.263 L +736.264 264.384 L +736.42 265.5 L +736.576 266.611 L +736.731 267.716 L +736.887 268.816 L +737.043 269.91 L +737.198 270.998 L +737.354 272.08 L +737.51 273.155 L +737.665 274.225 L +737.821 275.287 L +737.977 276.343 L +738.132 277.392 L +738.288 278.434 L +738.444 279.469 L +738.599 280.496 L +738.755 281.516 L +738.911 282.529 L +739.066 283.533 L +739.222 284.529 L +739.378 285.517 L +739.533 286.497 L +739.689 287.469 L +739.845 288.432 L +740 289.386 L +740.156 290.331 L +740.312 291.268 L +740.467 292.195 L +740.623 293.113 L +740.779 294.021 L +740.934 294.92 L +741.09 295.809 L +741.245 296.688 L +741.401 297.558 L +741.557 298.417 L +741.713 299.266 L +741.868 300.105 L +742.024 300.933 L +742.18 301.751 L +742.335 302.557 L +742.491 303.354 L +742.646 304.139 L +742.802 304.913 L +742.958 305.675 L +743.113 306.427 L +743.269 307.167 L +743.425 307.895 L +743.58 308.612 L +743.736 309.317 L +743.892 310.01 L +744.047 310.691 L +744.203 311.36 L +744.359 312.017 L +744.514 312.662 L +744.67 313.294 L +744.826 313.914 L +744.981 314.521 L +745.137 315.116 L +745.293 315.698 L +745.448 316.267 L +745.604 316.823 L +745.76 317.366 L +745.915 317.896 L +746.071 318.413 L +746.227 318.917 L +746.382 319.407 L +746.538 319.884 L +746.694 320.347 L +746.849 320.797 L +747.005 321.234 L +747.161 321.656 L +747.316 322.065 L +747.472 322.46 L +747.628 322.842 L +747.783 323.209 L +747.939 323.562 L +748.095 323.902 L +748.25 324.227 L +748.406 324.538 L +748.562 324.836 L +748.717 325.118 L +748.873 325.387 L +749.029 325.641 L +749.184 325.881 L +749.34 326.107 L +749.496 326.318 L +749.651 326.515 L +749.807 326.697 L +749.963 326.865 L +750.118 327.019 L +750.274 327.157 L +750.43 327.282 L +750.585 327.391 L +750.741 327.486 L +750.897 327.567 L +751.052 327.633 L +751.208 327.684 L +751.364 327.721 L +751.519 327.743 L +751.675 327.75 L +751.831 327.743 L +751.986 327.721 L +752.142 327.684 L +752.298 327.633 L +752.453 327.567 L +752.609 327.486 L +752.765 327.391 L +752.92 327.282 L +753.076 327.157 L +753.232 327.019 L +753.387 326.865 L +753.543 326.697 L +753.699 326.515 L +753.854 326.318 L +754.01 326.107 L +754.166 325.881 L +754.321 325.641 L +754.477 325.387 L +754.633 325.118 L +754.788 324.836 L +754.944 324.538 L +755.1 324.227 L +755.255 323.902 L +755.411 323.562 L +755.567 323.209 L +755.722 322.842 L +755.878 322.46 L +756.034 322.065 L +756.189 321.656 L +756.345 321.234 L +756.501 320.797 L +756.656 320.347 L +756.812 319.884 L +756.968 319.407 L +757.123 318.917 L +757.279 318.413 L +757.435 317.896 L +757.59 317.366 L +757.746 316.823 L +757.902 316.267 L +758.057 315.698 L +758.213 315.116 L +758.369 314.521 L +758.524 313.914 L +758.68 313.294 L +758.836 312.662 L +758.991 312.017 L +759.147 311.36 L +759.303 310.691 L +759.458 310.01 L +759.614 309.317 L +759.77 308.612 L +759.925 307.895 L +760.081 307.167 L +760.237 306.427 L +760.392 305.675 L +760.548 304.913 L +760.703 304.139 L +760.859 303.354 L +761.015 302.557 L +761.171 301.751 L +761.326 300.933 L +761.482 300.105 L +761.638 299.266 L +761.793 298.417 L +761.949 297.558 L +762.104 296.688 L +762.26 295.809 L +762.416 294.92 L +762.571 294.021 L +762.727 293.113 L +762.883 292.195 L +763.038 291.268 L +763.194 290.331 L +763.35 289.386 L +763.505 288.432 L +763.661 287.469 L +763.817 286.497 L +763.972 285.517 L +764.128 284.529 L +764.284 283.533 L +764.439 282.529 L +764.595 281.516 L +764.751 280.496 L +764.906 279.469 L +765.062 278.434 L +765.218 277.392 L +765.373 276.343 L +765.529 275.287 L +765.685 274.225 L +765.84 273.155 L +765.996 272.08 L +766.152 270.998 L +766.307 269.91 L +766.463 268.816 L +766.619 267.716 L +766.774 266.611 L +766.93 265.5 L +767.086 264.384 L +767.241 263.263 L +767.397 262.136 L +767.553 261.006 L +767.708 259.87 L +767.864 258.73 L +768.02 257.586 L +768.175 256.438 L +768.331 255.286 L +768.487 254.13 L +768.642 252.97 L +768.798 251.808 L +768.954 250.642 L +769.109 249.473 L +769.265 248.301 L +769.421 247.126 L +769.576 245.949 L +769.732 244.77 L +769.888 243.588 L +770.043 242.404 L +770.199 241.219 L +770.355 240.032 L +770.51 238.844 L +770.666 237.654 L +770.822 236.463 L +770.977 235.272 L +771.133 234.079 L +771.289 232.887 L +771.444 231.693 L +771.6 230.5 L +771.756 230.5 L +771.911 230.5 L +772.067 230.5 L +772.223 230.5 L +772.378 230.5 L +772.534 230.5 L +772.69 230.5 L +772.845 230.5 L +773.001 230.5 L +773.157 230.5 L +773.312 230.5 L +773.468 230.5 L +773.624 230.5 L +773.779 230.5 L +773.935 230.5 L +774.091 230.5 L +774.246 230.5 L +774.402 230.5 L +774.558 230.5 L +774.713 230.5 L +774.869 230.5 L +775.025 230.5 L +775.18 230.5 L +775.336 230.5 L +775.492 230.5 L +775.647 230.5 L +775.803 230.5 L +775.959 230.5 L +776.114 230.5 L +776.27 230.5 L +776.426 230.5 L +776.581 230.5 L +776.737 230.5 L +776.893 230.5 L +777.048 230.5 L +777.204 230.5 L +777.36 230.5 L +777.515 230.5 L +777.671 230.5 L +777.827 230.5 L +777.982 230.5 L +778.138 230.5 L +778.294 230.5 L +778.449 230.5 L +778.605 230.5 L +778.761 230.5 L +778.916 230.5 L +779.072 230.5 L +779.228 230.5 L +779.383 230.5 L +779.539 230.5 L +779.695 230.5 L +779.85 230.5 L +780.006 230.5 L +780.161 230.5 L +780.317 230.5 L +780.473 230.5 L +780.629 230.5 L +780.784 230.5 L +780.94 230.5 L +781.096 230.5 L +781.251 230.5 L +781.407 230.5 L +781.563 230.5 L +781.718 230.5 L +781.874 230.5 L +782.029 230.5 L +782.185 230.5 L +782.341 230.5 L +782.496 230.5 L +782.652 230.5 L +782.808 230.5 L +782.964 230.5 L +783.119 230.5 L +783.275 230.5 L +783.43 230.5 L +783.586 230.5 L +783.742 230.5 L +783.897 230.5 L +784.053 230.5 L +784.209 230.5 L +784.364 230.5 L +784.52 230.5 L +784.676 230.5 L +784.831 230.5 L +784.987 230.5 L +785.143 230.5 L +785.298 230.5 L +785.454 230.5 L +785.61 230.5 L +785.765 230.5 L +785.921 230.5 L +786.077 230.5 L +786.232 230.5 L +786.388 230.5 L +786.544 230.5 L +786.699 230.5 L +786.855 230.5 L +787.011 230.5 L +787.166 230.5 L +787.322 230.5 L +787.478 230.5 L +787.633 230.5 L +787.789 230.5 L +787.945 230.5 L +788.1 230.5 L +788.256 230.5 L +788.412 230.5 L +788.567 230.5 L +788.723 230.5 L +788.879 230.5 L +789.034 230.5 L +789.19 230.5 L +789.346 230.5 L +789.501 230.5 L +789.657 230.5 L +789.813 230.5 L +789.968 230.5 L +790.124 230.5 L +790.28 230.5 L +790.435 230.5 L +790.591 230.5 L +790.747 230.5 L +790.902 230.5 L +791.058 230.5 L +791.214 230.5 L +791.369 230.5 L +791.525 230.5 L +791.681 230.5 L +791.836 230.5 L +791.992 230.5 L +792.148 230.5 L +792.303 230.5 L +792.459 230.5 L +792.615 230.5 L +792.77 230.5 L +792.926 230.5 L +793.082 230.5 L +793.237 230.5 L +793.393 230.5 L +793.549 230.5 L +793.704 230.5 L +793.86 230.5 L +794.016 230.5 L +794.171 230.5 L +794.327 230.5 L +794.483 230.5 L +794.638 230.5 L +794.794 230.5 L +794.95 230.5 L +795.105 230.5 L +795.261 230.5 L +795.417 230.5 L +795.572 230.5 L +795.728 230.5 L +795.884 230.5 L +796.039 230.5 L +796.195 230.5 L +796.351 230.5 L +796.506 230.5 L +796.662 230.5 L +796.818 230.5 L +796.973 230.5 L +797.129 230.5 L +797.285 230.5 L +797.44 230.5 L +797.596 230.5 L +797.752 230.5 L +797.907 230.5 L +798.063 230.5 L +798.219 230.5 L +798.374 230.5 L +798.53 230.5 L +798.686 230.5 L +798.841 230.5 L +798.997 230.5 L +799.153 230.5 L +799.308 230.5 L +799.464 230.5 L +799.62 230.5 L +799.775 230.5 L +799.931 230.5 L +800.087 230.5 L +800.242 230.5 L +800.398 230.5 L +800.554 230.5 L +800.709 230.5 L +800.865 230.5 L +801.021 230.5 L +801.176 230.5 L +801.332 230.5 L +801.487 230.5 L +801.643 230.5 L +801.799 230.5 L +801.954 230.5 L +802.11 230.5 L +802.266 230.5 L +802.422 230.5 L +802.577 230.5 L +802.733 230.5 L +802.888 230.5 L +803.044 230.5 L +803.2 230.5 L +803.355 230.5 L +803.511 230.5 L +803.667 230.5 L +803.822 230.5 L +803.978 230.5 L +804.134 230.5 L +804.289 230.5 L +804.445 230.5 L +804.601 230.5 L +804.756 230.5 L +804.912 230.5 L +805.068 230.5 L +805.223 230.5 L +805.379 230.5 L +805.535 230.5 L +805.69 230.5 L +805.846 230.5 L +806.002 230.5 L +806.157 230.5 L +806.313 230.5 L +806.469 230.5 L +806.624 230.5 L +806.78 230.5 L +806.936 230.5 L +807.091 230.5 L +807.247 230.5 L +807.403 230.5 L +807.558 230.5 L +807.714 230.5 L +807.87 230.5 L +808.025 230.5 L +808.181 230.5 L +808.337 230.5 L +808.492 230.5 L +808.648 230.5 L +808.804 230.5 L +808.959 230.5 L +809.115 230.5 L +809.271 230.5 L +809.426 230.5 L +809.582 230.5 L +809.738 230.5 L +809.893 230.5 L +810.049 230.5 L +810.205 230.5 L +810.36 230.5 L +810.516 230.5 L +810.672 230.5 L +810.827 230.5 L +810.983 230.5 L +811.139 230.5 L +811.294 230.5 L +811.45 230.5 L +811.606 230.5 L +811.761 230.5 L +811.917 230.5 L +812.073 230.5 L +812.228 230.5 L +812.384 230.5 L +812.54 230.5 L +812.695 230.5 L +812.851 230.5 L +813.007 230.5 L +813.162 230.5 L +813.318 230.5 L +813.474 230.5 L +813.629 230.5 L +813.785 230.5 L +813.941 230.5 L +814.096 230.5 L +814.252 230.5 L +814.408 230.5 L +814.563 230.5 L +814.719 230.5 L +814.875 230.5 L +815.03 230.5 L +815.186 230.5 L +815.342 230.5 L +815.497 230.5 L +815.653 230.5 L +815.809 230.5 L +815.964 230.5 L +816.12 230.5 L +816.276 230.5 L +816.431 230.5 L +816.587 230.5 L +816.743 230.5 L +816.898 230.5 L +817.054 230.5 L +817.21 230.5 L +817.365 230.5 L +817.521 230.5 L +817.677 230.5 L +817.832 230.5 L +817.988 230.5 L +818.144 230.5 L +818.299 230.5 L +818.455 230.5 L +818.611 230.5 L +818.766 230.5 L +818.922 230.5 L +819.078 230.5 L +819.233 230.5 L +819.389 230.5 L +819.545 230.5 L +819.7 230.5 L +819.856 230.5 L +820.012 230.5 L +820.167 230.5 L +820.323 230.5 L +820.479 230.5 L +820.634 230.5 L +820.79 230.5 L +820.945 230.5 L +821.101 230.5 L +821.257 230.5 L +821.412 230.5 L +821.568 230.5 L +821.724 230.5 L +821.88 230.5 L +822.035 230.5 L +822.191 230.5 L +822.346 230.5 L +822.502 230.5 L +822.658 230.5 L +822.813 230.5 L +822.969 230.5 L +823.125 230.5 L +823.28 230.5 L +823.436 230.5 L +823.592 230.5 L +823.747 230.5 L +823.903 230.5 L +824.059 230.5 L +824.214 230.5 L +824.37 230.5 L +824.526 230.5 L +824.681 230.5 L +824.837 230.5 L +824.993 230.5 L +825.148 230.5 L +825.304 230.5 L +825.46 230.5 L +825.615 230.5 L +825.771 230.5 L +825.927 230.5 L +826.082 230.5 L +826.238 230.5 L +826.394 230.5 L +826.549 230.5 L +826.705 230.5 L +826.861 230.5 L +827.016 230.5 L +827.172 230.5 L +827.328 230.5 L +827.483 230.5 L +827.639 230.5 L +827.795 230.5 L +827.95 230.5 L +828.106 230.5 L +828.262 230.5 L +828.417 230.5 L +828.573 230.5 L +828.729 230.5 L +828.884 230.5 L +829.04 230.5 L +829.196 230.5 L +829.351 230.5 L +829.507 230.5 L +829.663 230.5 L +829.818 230.5 L +829.974 230.5 L +830.13 230.5 L +830.285 230.5 L +830.441 230.5 L +830.597 230.5 L +830.752 230.5 L +830.908 230.5 L +831.064 230.5 L +831.219 230.5 L +831.375 230.5 L +831.531 230.5 L +831.686 230.5 L +831.842 230.5 L +831.998 230.5 L +832.153 230.5 L +832.309 230.5 L +832.465 230.5 L +832.62 230.5 L +832.776 230.5 L +832.932 230.5 L +833.087 230.5 L +833.243 230.5 L +833.399 230.5 L +833.554 230.5 L +833.71 230.5 L +833.866 230.5 L +834.021 230.5 L +834.177 230.5 L +834.333 230.5 L +834.488 230.5 L +834.644 230.5 L +834.8 230.5 L +834.955 230.5 L +835.111 230.5 L +835.267 230.5 L +835.422 230.5 L +835.578 230.5 L +835.734 230.5 L +835.889 230.5 L +836.045 230.5 L +836.201 230.5 L +836.356 230.5 L +836.512 230.5 L +836.668 230.5 L +836.823 230.5 L +836.979 230.5 L +837.135 230.5 L +837.29 230.5 L +837.446 230.5 L +837.602 230.5 L +837.757 230.5 L +837.913 230.5 L +838.069 230.5 L +838.224 230.5 L +838.38 230.5 L +838.536 230.5 L +838.691 230.5 L +838.847 230.5 L +839.003 230.5 L +839.158 230.5 L +839.314 230.5 L +839.47 230.5 L +839.625 230.5 L +839.781 230.5 L +839.937 230.5 L +840.092 230.5 L +840.248 230.5 L +840.404 230.5 L +840.559 230.5 L +840.715 230.5 L +840.87 230.5 L +841.026 230.5 L +841.182 230.5 L +841.338 230.5 L +841.493 230.5 L +841.649 230.5 L +841.805 230.5 L +841.96 230.5 L +842.116 230.5 L +842.271 230.5 L +842.427 230.5 L +842.583 230.5 L +842.738 230.5 L +842.894 230.5 L +843.05 230.5 L +843.205 230.5 L +843.361 230.5 L +843.517 230.5 L +843.672 230.5 L +843.828 230.5 L +843.984 230.5 L +844.139 230.5 L +844.295 230.5 L +844.451 230.5 L +844.606 230.5 L +844.762 230.5 L +844.918 230.5 L +845.073 230.5 L +845.229 230.5 L +845.385 230.5 L +845.54 230.5 L +845.696 230.5 L +845.852 230.5 L +846.007 230.5 L +846.163 230.5 L +846.319 230.5 L +846.474 230.5 L +846.63 230.5 L +846.786 230.5 L +846.941 230.5 L +847.097 230.5 L +847.253 230.5 L +847.408 230.5 L +847.564 230.5 L +847.72 230.5 L +847.875 230.5 L +848.031 230.5 L +848.187 230.5 L +848.342 230.5 L +848.498 230.5 L +848.654 230.5 L +848.809 230.5 L +848.965 230.5 L +849.121 230.5 L +849.276 230.5 L +849.432 230.5 L +849.588 230.5 L +849.743 230.5 L +849.899 230.5 L +850.055 230.5 L +850.21 230.5 L +850.366 230.5 L +850.522 230.5 L +850.677 230.5 L +850.833 230.5 L +850.989 230.5 L +851.144 230.5 L +851.3 230.5 L +851.456 230.5 L +851.611 230.5 L +851.767 230.5 L +851.923 230.5 L +852.078 230.5 L +852.234 230.5 L +852.39 230.5 L +852.545 230.5 L +852.701 230.5 L +852.857 230.5 L +853.012 230.5 L +853.168 230.5 L +853.324 230.5 L +853.479 230.5 L +853.635 230.5 L +853.791 230.5 L +853.946 230.5 L +854.102 230.5 L +854.258 230.5 L +854.413 230.5 L +854.569 230.5 L +854.725 230.5 L +854.88 230.5 L +855.036 230.5 L +855.192 230.5 L +855.347 230.5 L +855.503 230.5 L +855.659 230.5 L +855.814 230.5 L +855.97 230.5 L +856.126 230.5 L +856.281 230.5 L +856.437 230.5 L +856.593 230.5 L +856.748 230.5 L +856.904 230.5 L +857.06 230.5 L +857.215 230.5 L +857.371 230.5 L +857.527 230.5 L +857.682 230.5 L +857.838 230.5 L +857.994 230.5 L +858.149 230.5 L +858.305 230.5 L +858.461 230.5 L +858.616 230.5 L +858.772 230.5 L +858.928 230.5 L +859.083 230.5 L +859.239 230.5 L +859.395 230.5 L +859.55 230.5 L +859.706 230.5 L +859.862 230.5 L +860.017 230.5 L +860.173 230.5 L +860.328 230.5 L +860.484 230.5 L +860.64 230.5 L +860.796 230.5 L +860.951 230.5 L +861.107 230.5 L +861.263 230.5 L +861.418 230.5 L +861.574 230.5 L +861.729 230.5 L +861.885 230.5 L +862.041 230.5 L +862.196 230.5 L +862.352 230.5 L +862.508 230.5 L +862.663 230.5 L +862.819 230.5 L +862.975 230.5 L +863.13 230.5 L +863.286 230.5 L +863.442 230.5 L +863.597 230.5 L +863.753 230.5 L +863.909 230.5 L +864.064 230.5 L +864.22 230.5 L +864.376 230.5 L +864.531 230.5 L +864.687 230.5 L +864.843 230.5 L +864.998 230.5 L +865.154 230.5 L +865.31 230.5 L +865.465 230.5 L +865.621 230.5 L +865.777 230.5 L +865.932 230.5 L +866.088 230.5 L +866.244 230.5 L +866.399 230.5 L +866.555 230.5 L +866.711 230.5 L +866.866 230.5 L +867.022 230.5 L +867.178 230.5 L +867.333 230.5 L +867.489 230.5 L +867.645 230.5 L +867.8 230.5 L +867.956 230.5 L +868.112 230.5 L +868.267 230.5 L +868.423 230.5 L +868.579 230.5 L +868.734 230.5 L +868.89 230.5 L +869.046 230.5 L +869.201 230.5 L +869.357 230.5 L +869.513 230.5 L +869.668 230.5 L +869.824 230.5 L +869.98 230.5 L +870.135 230.5 L +870.291 230.5 L +870.447 230.5 L +870.602 230.5 L +870.758 230.5 L +870.914 230.5 L +871.069 230.5 L +871.225 230.5 L +871.381 230.5 L +871.536 230.5 L +871.692 230.5 L +871.848 230.5 L +872.003 230.5 L +872.159 230.5 L +872.315 230.5 L +872.47 230.5 L +872.626 230.5 L +872.782 230.5 L +872.937 230.5 L +873.093 230.5 L +873.249 230.5 L +873.404 230.5 L +873.56 230.5 L +873.716 230.5 L +873.871 230.5 L +874.027 230.5 L +874.183 230.5 L +874.338 230.5 L +874.494 230.5 L +874.65 230.5 L +874.805 230.5 L +874.961 230.5 L +875.117 230.5 L +875.272 230.5 L +875.428 230.5 L +875.584 230.5 L +875.739 230.5 L +875.895 230.5 L +876.051 230.5 L +876.206 230.5 L +876.362 230.5 L +876.518 230.5 L +876.673 230.5 L +876.829 230.5 L +876.985 230.5 L +877.14 230.5 L +877.296 230.5 L +877.452 230.5 L +877.607 230.5 L +877.763 230.5 L +877.919 230.5 L +878.074 230.5 L +878.23 230.5 L +878.386 230.5 L +878.541 230.5 L +878.697 230.5 L +878.853 230.5 L +879.008 230.5 L +879.164 230.5 L +879.32 230.5 L +879.475 230.5 L +879.631 230.5 L +879.786 230.5 L +879.942 230.5 L +880.098 230.5 L +880.254 230.5 L +880.409 230.5 L +880.565 230.5 L +880.721 230.5 L +880.876 230.5 L +881.032 230.5 L +881.188 230.5 L +881.343 230.5 L +881.499 230.5 L +881.654 230.5 L +881.81 230.5 L +881.966 230.5 L +882.121 230.5 L +882.277 230.5 L +882.433 230.5 L +882.589 230.5 L +882.744 230.5 L +882.9 230.5 L +883.055 230.5 L +883.211 230.5 L +883.367 230.5 L +883.522 230.5 L +883.678 230.5 L +883.834 230.5 L +883.989 230.5 L +884.145 230.5 L +884.301 230.5 L +884.456 230.5 L +884.612 230.5 L +884.768 230.5 L +884.923 230.5 L +885.079 230.5 L +885.235 230.5 L +885.39 230.5 L +885.546 230.5 L +885.702 230.5 L +885.857 230.5 L +886.013 230.5 L +886.169 230.5 L +886.324 230.5 L +886.48 230.5 L +886.636 230.5 L +886.791 230.5 L +886.947 230.5 L +887.103 230.5 L +887.258 230.5 L +887.414 230.5 L +887.57 230.5 L +887.725 230.5 L +887.881 230.5 L +888.037 230.5 L +888.192 230.5 L +888.348 230.5 L +888.504 230.5 L +888.659 230.5 L +888.815 230.5 L +888.971 230.5 L +889.126 230.5 L +889.282 230.5 L +889.438 230.5 L +889.593 230.5 L +889.749 230.5 L +889.905 230.5 L +890.06 230.5 L +890.216 230.5 L +890.372 230.5 L +890.527 230.5 L +890.683 230.5 L +890.839 230.5 L +890.994 230.5 L +891.15 230.5 L +891.306 230.5 L +891.461 230.5 L +891.617 230.5 L +891.773 230.5 L +891.928 230.5 L +892.084 230.5 L +892.24 230.5 L +892.395 230.5 L +892.551 230.5 L +892.707 230.5 L +892.862 230.5 L +893.018 230.5 L +893.174 230.5 L +893.329 230.5 L +893.485 230.5 L +893.641 230.5 L +893.796 230.5 L +893.952 230.5 L +894.108 230.5 L +894.263 230.5 L +894.419 230.5 L +894.575 230.5 L +894.73 230.5 L +894.886 230.5 L +895.042 230.5 L +895.197 230.5 L +895.353 230.5 L +895.509 230.5 L +895.664 230.5 L +895.82 230.5 L +895.976 230.5 L +896.131 230.5 L +896.287 230.5 L +896.443 230.5 L +896.598 230.5 L +896.754 230.5 L +896.91 230.5 L +897.065 230.5 L +897.221 230.5 L +897.377 230.5 L +897.532 230.5 L +897.688 230.5 L +897.844 230.5 L +897.999 230.5 L +898.155 230.5 L +898.311 230.5 L +898.466 230.5 L +898.622 230.5 L +898.778 230.5 L +898.933 230.5 L +899.089 230.5 L +899.245 230.5 L +899.4 230.5 L +899.556 230.5 L +899.712 230.5 L +899.867 230.5 L +900.023 230.5 L +900.179 230.5 L +900.334 230.5 L +900.49 230.5 L +900.646 230.5 L +900.801 230.5 L +900.957 230.5 L +901.112 230.5 L +901.268 230.5 L +901.424 230.5 L +901.579 230.5 L +901.735 230.5 L +901.891 230.5 L +902.047 230.5 L +902.202 230.5 L +902.358 230.5 L +902.513 230.5 L +902.669 230.5 L +902.825 230.5 L +902.98 230.5 L +903.136 230.5 L +903.292 230.5 L +903.447 230.5 L +903.603 230.5 L +903.759 230.5 L +903.914 230.5 L +904.07 230.5 L +904.226 230.5 L +904.381 230.5 L +904.537 230.5 L +904.693 230.5 L +904.848 230.5 L +905.004 230.5 L +905.16 230.5 L +905.315 230.5 L +905.471 230.5 L +905.627 230.5 L +905.782 230.5 L +905.938 230.5 L +906.094 230.5 L +906.249 230.5 L +906.405 230.5 L +906.561 230.5 L +906.716 230.5 L +906.872 230.5 L +907.028 230.5 L +907.183 230.5 L +907.339 230.5 L +907.495 230.5 L +907.65 230.5 L +907.806 230.5 L +907.962 230.5 L +908.117 230.5 L +908.273 230.5 L +908.429 230.5 L +908.584 230.5 L +908.74 230.5 L +908.896 230.5 L +909.051 230.5 L +909.207 230.5 L +909.363 230.5 L +909.518 230.5 L +909.674 230.5 L +909.83 230.5 L +909.985 230.5 L +910.141 230.5 L +910.297 230.5 L +910.452 230.5 L +910.608 230.5 L +910.764 230.5 L +910.919 230.5 L +911.075 230.5 L +911.231 230.5 L +911.386 230.5 L +911.542 230.5 L +911.698 230.5 L +911.853 230.5 L +912.009 230.5 L +912.165 230.5 L +912.32 230.5 L +912.476 230.5 L +912.632 230.5 L +912.787 230.5 L +912.943 230.5 L +913.099 230.5 L +913.254 230.5 L +913.41 230.5 L +913.566 230.5 L +913.721 230.5 L +913.877 230.5 L +914.033 230.5 L +914.188 230.5 L +914.344 230.5 L +914.5 230.5 L +914.655 230.5 L +914.811 230.5 L +914.967 230.5 L +915.122 230.5 L +915.278 230.5 L +915.434 230.5 L +915.589 230.5 L +915.745 230.5 L +915.901 230.5 L +916.056 230.5 L +916.212 230.5 L +916.368 230.5 L +916.523 230.5 L +916.679 230.5 L +916.835 230.5 L +916.99 230.5 L +917.146 230.5 L +917.302 230.5 L +917.457 230.5 L +917.613 230.5 L +917.769 230.5 L +917.924 230.5 L +918.08 230.5 L +918.236 230.5 L +918.391 230.5 L +918.547 230.5 L +918.703 230.5 L +918.858 230.5 L +919.014 230.5 L +919.17 230.5 L +919.325 230.5 L +919.481 230.5 L +919.637 230.5 L +919.792 230.5 L +919.948 230.5 L +920.104 230.5 L +920.259 230.5 L +920.415 230.5 L +920.57 230.5 L +920.726 230.5 L +920.882 230.5 L +921.037 230.5 L +921.193 230.5 L +921.349 230.5 L +921.505 230.5 L +921.66 230.5 L +921.816 230.5 L +921.971 230.5 L +922.127 230.5 L +922.283 230.5 L +922.438 230.5 L +922.594 230.5 L +922.75 230.5 L +922.905 230.5 L +923.061 230.5 L +923.217 230.5 L +923.372 230.5 L +923.528 230.5 L +923.684 230.5 L +923.839 230.5 L +923.995 230.5 L +924.151 230.5 L +924.306 230.5 L +924.462 230.5 L +924.618 230.5 L +924.773 230.5 L +924.929 230.5 L +925.085 230.5 L +925.24 230.5 L +925.396 230.5 L +925.552 230.5 L +925.707 230.5 L +925.863 230.5 L +926.019 230.5 L +926.174 230.5 L +926.33 230.5 L +926.486 230.5 L +926.641 230.5 L +926.797 230.5 L +926.953 230.5 L +927.108 230.5 L +927.264 230.5 L +927.42 230.5 L +927.575 230.5 L +927.731 230.5 L +927.887 230.5 L +928.042 230.5 L +928.198 230.5 L +928.354 230.5 L +928.509 230.5 L +928.665 230.5 L +928.821 230.5 L +928.976 230.5 L +929.132 230.5 L +929.288 230.5 L +929.443 230.5 L +929.599 230.5 L +929.755 230.5 L +929.91 230.5 L +930.066 230.5 L +930.222 230.5 L +930.377 230.5 L +930.533 230.5 L +930.689 230.5 L +930.844 230.5 L +931 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.929 0.694 0.125 RC +1 LJ +2.667 LW +N +134.156 230.5 M +134.311 230.5 L +134.467 230.5 L +134.623 230.5 L +134.778 230.5 L +134.934 230.5 L +135.09 230.5 L +135.245 230.5 L +135.401 230.5 L +135.557 230.5 L +135.712 230.5 L +135.868 230.5 L +136.024 230.5 L +136.179 230.5 L +136.335 230.5 L +136.491 230.5 L +136.646 230.5 L +136.802 230.5 L +136.958 230.5 L +137.113 230.5 L +137.269 230.5 L +137.425 230.5 L +137.58 230.5 L +137.736 230.5 L +137.892 230.5 L +138.047 230.5 L +138.203 230.5 L +138.359 230.5 L +138.514 230.5 L +138.67 230.5 L +138.826 230.5 L +138.981 230.5 L +139.137 230.5 L +139.293 230.5 L +139.448 230.5 L +139.604 230.5 L +139.76 230.5 L +139.915 230.5 L +140.071 230.5 L +140.227 230.5 L +140.382 230.5 L +140.538 230.5 L +140.694 230.5 L +140.849 230.5 L +141.005 230.5 L +141.161 230.5 L +141.316 230.5 L +141.472 230.5 L +141.628 230.5 L +141.783 230.5 L +141.939 230.5 L +142.095 230.5 L +142.25 230.5 L +142.406 230.5 L +142.562 230.5 L +142.717 230.5 L +142.873 230.5 L +143.029 230.5 L +143.184 230.5 L +143.34 230.5 L +143.496 230.5 L +143.651 230.5 L +143.807 230.5 L +143.962 230.5 L +144.118 230.5 L +144.274 230.5 L +144.429 230.5 L +144.585 230.5 L +144.741 230.5 L +144.896 230.5 L +145.052 230.5 L +145.208 230.5 L +145.363 230.5 L +145.519 230.5 L +145.675 230.5 L +145.83 230.5 L +145.986 230.5 L +146.142 230.5 L +146.297 230.5 L +146.453 230.5 L +146.609 230.5 L +146.764 230.5 L +146.92 230.5 L +147.076 230.5 L +147.231 230.5 L +147.387 230.5 L +147.543 230.5 L +147.698 230.5 L +147.854 230.5 L +148.01 230.5 L +148.165 230.5 L +148.321 230.5 L +148.477 230.5 L +148.632 230.5 L +148.788 230.5 L +148.944 230.5 L +149.099 230.5 L +149.255 230.5 L +149.411 230.5 L +149.566 230.5 L +149.722 230.5 L +149.878 230.5 L +150.033 230.5 L +150.189 230.5 L +150.345 230.5 L +150.5 230.5 L +150.656 230.5 L +150.812 230.5 L +150.967 230.5 L +151.123 230.5 L +151.279 230.5 L +151.434 230.5 L +151.59 230.5 L +151.746 230.5 L +151.901 230.5 L +152.057 230.5 L +152.213 230.5 L +152.368 230.5 L +152.524 230.5 L +152.68 230.5 L +152.835 230.5 L +152.991 230.5 L +153.147 230.5 L +153.302 230.5 L +153.458 230.5 L +153.614 230.5 L +153.769 230.5 L +153.925 230.5 L +154.081 230.5 L +154.236 230.5 L +154.392 230.5 L +154.548 230.5 L +154.703 230.5 L +154.859 230.5 L +155.015 230.5 L +155.17 230.5 L +155.326 230.5 L +155.482 230.5 L +155.637 230.5 L +155.793 230.5 L +155.949 230.5 L +156.104 230.5 L +156.26 230.5 L +156.416 230.5 L +156.571 230.5 L +156.727 230.5 L +156.883 230.5 L +157.038 230.5 L +157.194 230.5 L +157.35 230.5 L +157.505 230.5 L +157.661 230.5 L +157.817 230.5 L +157.972 230.5 L +158.128 230.5 L +158.284 230.5 L +158.439 230.5 L +158.595 230.5 L +158.751 230.5 L +158.906 230.5 L +159.062 230.5 L +159.218 230.5 L +159.373 230.5 L +159.529 230.5 L +159.685 230.5 L +159.84 230.5 L +159.996 230.5 L +160.152 230.5 L +160.307 230.5 L +160.463 230.5 L +160.619 230.5 L +160.774 230.5 L +160.93 230.5 L +161.086 230.5 L +161.241 230.5 L +161.397 230.5 L +161.553 230.5 L +161.708 230.5 L +161.864 230.5 L +162.02 230.5 L +162.175 230.5 L +162.331 230.5 L +162.487 230.5 L +162.642 230.5 L +162.798 230.5 L +162.954 230.5 L +163.109 230.5 L +163.265 230.5 L +163.421 230.5 L +163.576 230.5 L +163.732 230.5 L +163.887 230.5 L +164.043 230.5 L +164.199 230.5 L +164.354 230.5 L +164.51 230.5 L +164.666 230.5 L +164.821 230.5 L +164.977 230.5 L +165.133 230.5 L +165.288 230.5 L +165.444 230.5 L +165.6 230.5 L +165.755 230.5 L +165.911 230.5 L +166.067 230.5 L +166.222 230.5 L +166.378 230.5 L +166.534 230.5 L +166.689 230.5 L +166.845 230.5 L +167.001 230.5 L +167.156 230.5 L +167.312 230.5 L +167.468 230.5 L +167.623 230.5 L +167.779 230.5 L +167.935 230.5 L +168.09 230.5 L +168.246 230.5 L +168.402 230.5 L +168.557 230.5 L +168.713 230.5 L +168.869 230.5 L +169.024 230.5 L +169.18 230.5 L +169.336 230.5 L +169.491 230.5 L +169.647 230.5 L +169.803 230.5 L +169.958 230.5 L +170.114 230.5 L +170.27 230.5 L +170.425 230.5 L +170.581 230.5 L +170.737 230.5 L +170.892 230.5 L +171.048 230.5 L +171.204 230.5 L +171.359 230.5 L +171.515 230.5 L +171.671 230.5 L +171.826 230.5 L +171.982 230.5 L +172.138 230.5 L +172.293 230.5 L +172.449 230.5 L +172.605 230.5 L +172.76 230.5 L +172.916 230.5 L +173.072 230.5 L +173.227 230.5 L +173.383 230.5 L +173.539 230.5 L +173.694 230.5 L +173.85 230.5 L +174.006 230.5 L +174.161 230.5 L +174.317 230.5 L +174.473 230.5 L +174.628 230.5 L +174.784 230.5 L +174.94 230.5 L +175.095 230.5 L +175.251 230.5 L +175.407 230.5 L +175.562 230.5 L +175.718 230.5 L +175.874 230.5 L +176.029 230.5 L +176.185 230.5 L +176.341 230.5 L +176.496 230.5 L +176.652 230.5 L +176.808 230.5 L +176.963 230.5 L +177.119 230.5 L +177.275 230.5 L +177.43 230.5 L +177.586 230.5 L +177.742 230.5 L +177.897 230.5 L +178.053 230.5 L +178.209 230.5 L +178.364 230.5 L +178.52 230.5 L +178.676 230.5 L +178.831 230.5 L +178.987 230.5 L +179.143 230.5 L +179.298 230.5 L +179.454 230.5 L +179.61 230.5 L +179.765 230.5 L +179.921 230.5 L +180.077 230.5 L +180.232 230.5 L +180.388 230.5 L +180.544 230.5 L +180.699 230.5 L +180.855 230.5 L +181.011 230.5 L +181.166 230.5 L +181.322 230.5 L +181.478 230.5 L +181.633 230.5 L +181.789 230.5 L +181.945 230.5 L +182.1 230.5 L +182.256 230.5 L +182.412 230.5 L +182.567 230.5 L +182.723 230.5 L +182.879 230.5 L +183.034 230.5 L +183.19 230.5 L +183.346 230.5 L +183.501 230.5 L +183.657 230.5 L +183.813 230.5 L +183.968 230.5 L +184.124 230.5 L +184.279 230.5 L +184.435 230.5 L +184.591 230.5 L +184.746 230.5 L +184.902 230.5 L +185.058 230.5 L +185.213 230.5 L +185.369 230.5 L +185.525 230.5 L +185.68 230.5 L +185.836 230.5 L +185.992 230.5 L +186.147 230.5 L +186.303 230.5 L +186.459 230.5 L +186.614 230.5 L +186.77 230.5 L +186.926 230.5 L +187.081 230.5 L +187.237 230.5 L +187.393 230.5 L +187.548 230.5 L +187.704 230.5 L +187.86 230.5 L +188.015 230.5 L +188.171 230.5 L +188.327 230.5 L +188.482 230.5 L +188.638 230.5 L +188.794 230.5 L +188.949 230.5 L +189.105 230.5 L +189.261 230.5 L +189.416 230.5 L +189.572 230.5 L +189.728 230.5 L +189.883 230.5 L +190.039 230.5 L +190.195 230.5 L +190.35 230.5 L +190.506 230.5 L +190.662 230.5 L +190.817 230.5 L +190.973 230.5 L +191.129 230.5 L +191.284 230.5 L +191.44 230.5 L +191.596 230.5 L +191.751 230.5 L +191.907 230.5 L +192.063 230.5 L +192.218 230.5 L +192.374 230.5 L +192.53 230.5 L +192.685 230.5 L +192.841 230.5 L +192.997 230.5 L +193.152 230.5 L +193.308 230.5 L +193.464 230.5 L +193.619 230.5 L +193.775 230.5 L +193.931 230.5 L +194.086 230.5 L +194.242 230.5 L +194.398 230.5 L +194.553 230.5 L +194.709 230.5 L +194.865 230.5 L +195.02 230.5 L +195.176 230.5 L +195.332 230.5 L +195.487 230.5 L +195.643 230.5 L +195.799 230.5 L +195.954 230.5 L +196.11 230.5 L +196.266 230.5 L +196.421 230.5 L +196.577 230.5 L +196.733 230.5 L +196.888 230.5 L +197.044 230.5 L +197.2 230.5 L +197.355 230.5 L +197.511 230.5 L +197.667 230.5 L +197.822 230.5 L +197.978 230.5 L +198.134 230.5 L +198.289 230.5 L +198.445 230.5 L +198.601 230.5 L +198.756 230.5 L +198.912 230.5 L +199.068 230.5 L +199.223 230.5 L +199.379 230.5 L +199.535 230.5 L +199.69 230.5 L +199.846 230.5 L +200.002 230.5 L +200.157 230.5 L +200.313 230.5 L +200.469 230.5 L +200.624 230.5 L +200.78 230.5 L +200.936 230.5 L +201.091 230.5 L +201.247 230.5 L +201.403 230.5 L +201.558 230.5 L +201.714 230.5 L +201.87 230.5 L +202.025 230.5 L +202.181 230.5 L +202.337 230.5 L +202.492 230.5 L +202.648 230.5 L +202.804 230.5 L +202.959 230.5 L +203.115 230.5 L +203.271 230.5 L +203.426 230.5 L +203.582 230.5 L +203.738 230.5 L +203.893 230.5 L +204.049 230.5 L +204.204 230.5 L +204.36 230.5 L +204.516 230.5 L +204.671 230.5 L +204.827 230.5 L +204.983 230.5 L +205.138 230.5 L +205.294 230.5 L +205.45 230.5 L +205.605 230.5 L +205.761 230.5 L +205.917 230.5 L +206.072 230.5 L +206.228 230.5 L +206.384 230.5 L +206.539 230.5 L +206.695 230.5 L +206.851 230.5 L +207.006 230.5 L +207.162 230.5 L +207.318 230.5 L +207.473 230.5 L +207.629 230.5 L +207.785 230.5 L +207.94 230.5 L +208.096 230.5 L +208.252 230.5 L +208.407 230.5 L +208.563 230.5 L +208.719 230.5 L +208.874 230.5 L +209.03 230.5 L +209.186 230.5 L +209.341 230.5 L +209.497 230.5 L +209.653 230.5 L +209.808 230.5 L +209.964 230.5 L +210.12 230.5 L +210.275 230.5 L +210.431 230.5 L +210.587 230.5 L +210.742 230.5 L +210.898 230.5 L +211.054 230.5 L +211.209 230.5 L +211.365 230.5 L +211.521 230.5 L +211.676 230.5 L +211.832 230.5 L +211.988 230.5 L +212.143 230.5 L +212.299 230.5 L +212.455 230.5 L +212.61 230.5 L +212.766 230.5 L +212.922 230.5 L +213.077 230.5 L +213.233 230.5 L +213.389 230.5 L +213.544 230.5 L +213.7 230.5 L +213.856 230.5 L +214.011 230.5 L +214.167 230.5 L +214.323 230.5 L +214.478 230.5 L +214.634 230.5 L +214.79 230.5 L +214.945 230.5 L +215.101 230.5 L +215.257 230.5 L +215.412 230.5 L +215.568 230.5 L +215.724 230.5 L +215.879 230.5 L +216.035 230.5 L +216.191 230.5 L +216.346 230.5 L +216.502 230.5 L +216.658 230.5 L +216.813 230.5 L +216.969 230.5 L +217.125 230.5 L +217.28 230.5 L +217.436 230.5 L +217.592 230.5 L +217.747 230.5 L +217.903 230.5 L +218.059 230.5 L +218.214 230.5 L +218.37 230.5 L +218.526 230.5 L +218.681 230.5 L +218.837 230.5 L +218.993 230.5 L +219.148 230.5 L +219.304 230.5 L +219.46 230.5 L +219.615 230.5 L +219.771 230.5 L +219.927 230.5 L +220.082 230.5 L +220.238 230.5 L +220.394 230.5 L +220.549 230.5 L +220.705 230.5 L +220.861 230.5 L +221.016 230.5 L +221.172 230.5 L +221.328 230.5 L +221.483 230.5 L +221.639 230.5 L +221.795 230.5 L +221.95 230.5 L +222.106 230.5 L +222.262 230.5 L +222.417 230.5 L +222.573 230.5 L +222.729 230.5 L +222.884 230.5 L +223.04 230.5 L +223.196 230.5 L +223.351 230.5 L +223.507 230.5 L +223.663 230.5 L +223.818 230.5 L +223.974 230.5 L +224.129 230.5 L +224.285 230.5 L +224.441 230.5 L +224.596 230.5 L +224.752 230.5 L +224.908 230.5 L +225.063 230.5 L +225.219 230.5 L +225.375 230.5 L +225.53 230.5 L +225.686 230.5 L +225.842 230.5 L +225.997 230.5 L +226.153 230.5 L +226.309 230.5 L +226.464 230.5 L +226.62 230.5 L +226.776 230.5 L +226.931 230.5 L +227.087 230.5 L +227.243 230.5 L +227.398 230.5 L +227.554 230.5 L +227.71 230.5 L +227.865 230.5 L +228.021 230.5 L +228.177 230.5 L +228.332 230.5 L +228.488 230.5 L +228.644 230.5 L +228.799 230.5 L +228.955 230.5 L +229.111 230.5 L +229.266 230.5 L +229.422 230.5 L +229.578 230.5 L +229.733 230.5 L +229.889 230.5 L +230.045 230.5 L +230.2 230.5 L +230.356 230.5 L +230.512 230.5 L +230.667 230.5 L +230.823 230.5 L +230.979 230.5 L +231.134 230.5 L +231.29 230.5 L +231.446 230.5 L +231.601 230.5 L +231.757 230.5 L +231.913 230.5 L +232.068 230.5 L +232.224 230.5 L +232.38 230.5 L +232.535 230.5 L +232.691 230.5 L +232.847 230.5 L +233.002 230.5 L +233.158 230.5 L +233.314 230.5 L +233.469 230.5 L +233.625 230.5 L +233.781 230.5 L +233.936 230.5 L +234.092 230.5 L +234.248 230.5 L +234.403 230.5 L +234.559 230.5 L +234.715 230.5 L +234.87 230.5 L +235.026 230.5 L +235.182 230.5 L +235.337 230.5 L +235.493 230.5 L +235.649 230.5 L +235.804 230.5 L +235.96 230.5 L +236.116 230.5 L +236.271 230.5 L +236.427 230.5 L +236.583 230.5 L +236.738 230.5 L +236.894 230.5 L +237.05 230.5 L +237.205 230.5 L +237.361 230.5 L +237.517 230.5 L +237.672 230.5 L +237.828 230.5 L +237.984 230.5 L +238.139 230.5 L +238.295 230.5 L +238.451 230.5 L +238.606 230.5 L +238.762 230.5 L +238.918 230.5 L +239.073 230.5 L +239.229 230.5 L +239.385 230.5 L +239.54 230.5 L +239.696 230.5 L +239.852 230.5 L +240.007 230.5 L +240.163 230.5 L +240.319 230.5 L +240.474 230.5 L +240.63 230.5 L +240.786 230.5 L +240.941 230.5 L +241.097 230.5 L +241.253 230.5 L +241.408 230.5 L +241.564 230.5 L +241.72 230.5 L +241.875 230.5 L +242.031 230.5 L +242.187 230.5 L +242.342 230.5 L +242.498 230.5 L +242.654 230.5 L +242.809 230.5 L +242.965 230.5 L +243.121 230.5 L +243.276 230.5 L +243.432 230.5 L +243.587 230.5 L +243.743 230.5 L +243.899 230.5 L +244.054 230.5 L +244.21 230.5 L +244.366 230.5 L +244.521 230.5 L +244.677 230.5 L +244.833 230.5 L +244.988 230.5 L +245.144 230.5 L +245.3 230.5 L +245.455 230.5 L +245.611 230.5 L +245.767 230.5 L +245.922 230.5 L +246.078 230.5 L +246.234 230.5 L +246.389 230.5 L +246.545 230.5 L +246.701 230.5 L +246.856 230.5 L +247.012 230.5 L +247.168 230.5 L +247.323 230.5 L +247.479 230.5 L +247.635 230.5 L +247.79 230.5 L +247.946 230.5 L +248.102 230.5 L +248.257 230.5 L +248.413 230.5 L +248.569 230.5 L +248.724 230.5 L +248.88 230.5 L +249.036 230.5 L +249.191 230.5 L +249.347 230.5 L +249.503 230.5 L +249.658 230.5 L +249.814 230.5 L +249.97 230.5 L +250.125 230.5 L +250.281 230.5 L +250.437 230.5 L +250.592 230.5 L +250.748 230.5 L +250.904 230.5 L +251.059 230.5 L +251.215 230.5 L +251.371 230.5 L +251.526 230.5 L +251.682 230.5 L +251.838 230.5 L +251.993 230.5 L +252.149 230.5 L +252.305 230.5 L +252.46 230.5 L +252.616 230.5 L +252.772 230.5 L +252.927 230.5 L +253.083 230.5 L +253.239 230.5 L +253.394 230.5 L +253.55 230.5 L +253.706 230.5 L +253.861 230.5 L +254.017 230.5 L +254.173 230.5 L +254.328 230.5 L +254.484 230.5 L +254.64 230.5 L +254.795 230.5 L +254.951 230.5 L +255.107 230.5 L +255.262 230.5 L +255.418 230.5 L +255.574 230.5 L +255.729 230.5 L +255.885 230.5 L +256.041 230.5 L +256.196 230.5 L +256.352 230.5 L +256.508 230.5 L +256.663 230.5 L +256.819 230.5 L +256.975 230.5 L +257.13 230.5 L +257.286 230.5 L +257.442 230.5 L +257.597 230.5 L +257.753 230.5 L +257.909 230.5 L +258.064 230.5 L +258.22 230.5 L +258.376 230.5 L +258.531 230.5 L +258.687 230.5 L +258.843 230.5 L +258.998 230.5 L +259.154 230.5 L +259.31 230.5 L +259.465 230.5 L +259.621 230.5 L +259.777 230.5 L +259.932 230.5 L +260.088 230.5 L +260.244 230.5 L +260.399 230.5 L +260.555 230.5 L +260.711 230.5 L +260.866 230.5 L +261.022 230.5 L +261.178 230.5 L +261.333 230.5 L +261.489 230.5 L +261.645 230.5 L +261.8 230.5 L +261.956 230.5 L +262.112 230.5 L +262.267 230.5 L +262.423 230.5 L +262.579 230.5 L +262.734 230.5 L +262.89 230.5 L +263.046 230.5 L +263.201 230.5 L +263.357 230.5 L +263.513 230.5 L +263.668 230.5 L +263.824 230.5 L +263.979 230.5 L +264.135 230.5 L +264.291 230.5 L +264.446 230.5 L +264.602 230.5 L +264.758 230.5 L +264.913 230.5 L +265.069 230.5 L +265.225 230.5 L +265.38 230.5 L +265.536 230.5 L +265.692 230.5 L +265.847 230.5 L +266.003 230.5 L +266.159 230.5 L +266.314 230.5 L +266.47 230.5 L +266.626 230.5 L +266.781 230.5 L +266.937 230.5 L +267.093 230.5 L +267.248 230.5 L +267.404 230.5 L +267.56 230.5 L +267.715 230.5 L +267.871 230.5 L +268.027 230.5 L +268.182 230.5 L +268.338 230.5 L +268.494 230.5 L +268.649 230.5 L +268.805 230.5 L +268.961 230.5 L +269.116 230.5 L +269.272 230.5 L +269.428 230.5 L +269.583 230.5 L +269.739 230.5 L +269.895 230.5 L +270.05 230.5 L +270.206 230.5 L +270.362 230.5 L +270.517 230.5 L +270.673 230.5 L +270.829 230.5 L +270.984 230.5 L +271.14 230.5 L +271.296 230.5 L +271.451 230.5 L +271.607 230.5 L +271.763 230.5 L +271.918 230.5 L +272.074 230.5 L +272.23 230.5 L +272.385 230.5 L +272.541 230.5 L +272.697 230.5 L +272.852 230.5 L +273.008 230.5 L +273.164 230.5 L +273.319 230.5 L +273.475 230.5 L +273.631 230.5 L +273.786 230.5 L +273.942 230.5 L +274.098 230.5 L +274.253 230.5 L +274.409 230.5 L +274.565 230.5 L +274.72 230.5 L +274.876 230.5 L +275.032 230.5 L +275.187 230.5 L +275.343 230.5 L +275.499 230.5 L +275.654 230.5 L +275.81 230.5 L +275.966 230.5 L +276.121 230.5 L +276.277 230.5 L +276.433 230.5 L +276.588 230.5 L +276.744 230.5 L +276.9 230.5 L +277.055 230.5 L +277.211 230.5 L +277.367 230.5 L +277.522 230.5 L +277.678 230.5 L +277.834 230.5 L +277.989 230.5 L +278.145 230.5 L +278.301 230.5 L +278.456 230.5 L +278.612 230.5 L +278.768 230.5 L +278.923 230.5 L +279.079 230.5 L +279.235 230.5 L +279.39 230.5 L +279.546 230.5 L +279.702 230.5 L +279.857 230.5 L +280.013 230.5 L +280.169 230.5 L +280.324 230.5 L +280.48 230.5 L +280.636 230.5 L +280.791 230.5 L +280.947 230.5 L +281.103 230.5 L +281.258 230.5 L +281.414 230.5 L +281.57 230.5 L +281.725 230.5 L +281.881 230.5 L +282.037 230.5 L +282.192 230.5 L +282.348 230.5 L +282.504 230.5 L +282.659 230.5 L +282.815 230.5 L +282.971 230.5 L +283.126 230.5 L +283.282 230.5 L +283.438 230.5 L +283.593 230.5 L +283.749 230.5 L +283.904 230.5 L +284.06 230.5 L +284.216 230.5 L +284.371 230.5 L +284.527 230.5 L +284.683 230.5 L +284.838 230.5 L +284.994 230.5 L +285.15 230.5 L +285.305 230.5 L +285.461 230.5 L +285.617 230.5 L +285.772 230.5 L +285.928 230.5 L +286.084 230.5 L +286.239 230.5 L +286.395 230.5 L +286.551 230.5 L +286.706 230.5 L +286.862 230.5 L +287.018 230.5 L +287.173 230.5 L +287.329 230.5 L +287.485 230.5 L +287.64 230.5 L +287.796 230.5 L +287.952 230.5 L +288.107 230.5 L +288.263 230.5 L +288.419 230.5 L +288.574 230.5 L +288.73 230.5 L +288.886 230.5 L +289.041 230.5 L +289.197 230.5 L +289.353 230.5 L +289.508 230.5 L +289.664 230.5 L +289.82 230.5 L +289.975 230.5 L +290.131 230.5 L +290.287 230.5 L +290.442 230.5 L +290.598 230.5 L +290.754 230.5 L +290.909 230.5 L +291.065 230.5 L +291.221 230.5 L +291.376 230.5 L +291.532 230.5 L +291.688 230.5 L +291.843 230.5 L +291.999 230.5 L +292.155 230.5 L +292.31 230.5 L +292.466 230.5 L +292.622 230.5 L +292.777 230.5 L +292.933 230.5 L +293.089 230.5 L +293.244 230.5 L +293.4 230.5 L +293.556 230.202 L +293.711 229.903 L +293.867 229.605 L +294.023 229.307 L +294.178 229.008 L +294.334 228.71 L +294.49 228.412 L +294.645 228.113 L +294.801 227.815 L +294.957 227.517 L +295.112 227.219 L +295.268 226.921 L +295.424 226.622 L +295.579 226.324 L +295.735 226.026 L +295.891 225.728 L +296.046 225.43 L +296.202 225.132 L +296.358 224.834 L +296.513 224.537 L +296.669 224.239 L +296.825 223.941 L +296.98 223.643 L +297.136 223.346 L +297.292 223.048 L +297.447 222.751 L +297.603 222.454 L +297.759 222.156 L +297.914 221.859 L +298.07 221.562 L +298.226 221.265 L +298.381 220.968 L +298.537 220.671 L +298.693 220.374 L +298.848 220.077 L +299.004 219.781 L +299.16 219.484 L +299.315 219.188 L +299.471 218.892 L +299.627 218.596 L +299.782 218.299 L +299.938 218.004 L +300.094 217.708 L +300.249 217.412 L +300.405 217.116 L +300.561 216.821 L +300.716 216.526 L +300.872 216.23 L +301.028 215.935 L +301.183 215.64 L +301.339 215.346 L +301.495 215.051 L +301.65 214.757 L +301.806 214.462 L +301.962 214.168 L +302.117 213.874 L +302.273 213.58 L +302.429 213.286 L +302.584 212.993 L +302.74 212.699 L +302.896 212.406 L +303.051 212.113 L +303.207 211.82 L +303.362 211.527 L +303.518 211.235 L +303.674 210.943 L +303.829 210.65 L +303.985 210.358 L +304.141 210.067 L +304.296 209.775 L +304.452 209.484 L +304.608 209.192 L +304.763 208.901 L +304.919 208.611 L +305.075 208.32 L +305.23 208.03 L +305.386 207.739 L +305.542 207.449 L +305.697 207.16 L +305.853 206.87 L +306.009 206.581 L +306.164 206.292 L +306.32 206.003 L +306.476 205.714 L +306.631 205.426 L +306.787 205.138 L +306.943 204.85 L +307.098 204.562 L +307.254 204.275 L +307.41 203.988 L +307.565 203.701 L +307.721 203.414 L +307.877 203.128 L +308.032 202.841 L +308.188 202.555 L +308.344 202.27 L +308.499 201.984 L +308.655 201.699 L +308.811 201.414 L +308.966 201.13 L +309.122 200.846 L +309.278 200.562 L +309.433 200.278 L +309.589 199.994 L +309.745 199.711 L +309.9 199.428 L +310.056 199.146 L +310.212 198.864 L +310.367 198.582 L +310.523 198.3 L +310.679 198.019 L +310.834 197.737 L +310.99 197.457 L +311.146 197.176 L +311.301 196.896 L +311.457 196.616 L +311.613 196.337 L +311.768 196.058 L +311.924 195.779 L +312.08 195.5 L +312.235 195.222 L +312.391 194.944 L +312.547 194.667 L +312.702 194.389 L +312.858 194.113 L +313.014 193.836 L +313.169 193.56 L +313.325 193.284 L +313.481 193.009 L +313.636 192.733 L +313.792 192.459 L +313.948 192.184 L +314.103 191.91 L +314.259 191.637 L +314.415 191.363 L +314.57 191.09 L +314.726 190.818 L +314.882 190.546 L +315.037 190.274 L +315.193 190.002 L +315.349 189.731 L +315.504 189.46 L +315.66 189.19 L +315.816 188.92 L +315.971 188.651 L +316.127 188.382 L +316.283 188.113 L +316.438 187.845 L +316.594 187.577 L +316.75 187.309 L +316.905 187.042 L +317.061 186.775 L +317.217 186.509 L +317.372 186.243 L +317.528 185.978 L +317.684 185.713 L +317.839 185.448 L +317.995 185.184 L +318.151 184.92 L +318.306 184.657 L +318.462 184.394 L +318.618 184.131 L +318.773 183.869 L +318.929 183.608 L +319.085 183.346 L +319.24 183.086 L +319.396 182.825 L +319.552 182.566 L +319.707 182.306 L +319.863 182.047 L +320.019 181.789 L +320.174 181.531 L +320.33 181.273 L +320.486 181.016 L +320.641 180.76 L +320.797 180.504 L +320.953 180.248 L +321.108 179.993 L +321.264 179.738 L +321.42 179.484 L +321.575 179.23 L +321.731 178.977 L +321.887 178.724 L +322.042 178.471 L +322.198 178.22 L +322.354 177.968 L +322.509 177.717 L +322.665 177.467 L +322.82 177.217 L +322.976 176.968 L +323.132 176.719 L +323.288 176.471 L +323.443 176.223 L +323.599 175.976 L +323.754 175.729 L +323.91 175.483 L +324.066 175.237 L +324.221 174.992 L +324.377 174.747 L +324.533 174.503 L +324.688 174.259 L +324.844 174.016 L +325 173.773 L +325.155 173.531 L +325.311 173.29 L +325.467 173.049 L +325.622 172.808 L +325.778 172.568 L +325.934 172.329 L +326.089 172.09 L +326.245 171.852 L +326.401 171.614 L +326.556 171.377 L +326.712 171.14 L +326.868 170.904 L +327.023 170.669 L +327.179 170.434 L +327.335 170.199 L +327.49 169.966 L +327.646 169.732 L +327.802 169.5 L +327.957 169.268 L +328.113 169.036 L +328.269 168.805 L +328.424 168.575 L +328.58 168.345 L +328.736 168.116 L +328.891 167.887 L +329.047 167.659 L +329.203 167.432 L +329.358 167.205 L +329.514 166.979 L +329.67 166.753 L +329.825 166.528 L +329.981 166.304 L +330.137 166.08 L +330.292 165.857 L +330.448 165.634 L +330.604 165.412 L +330.759 165.191 L +330.915 164.97 L +331.071 164.75 L +331.226 164.53 L +331.382 164.312 L +331.538 164.093 L +331.693 163.876 L +331.849 163.659 L +332.005 163.442 L +332.16 163.226 L +332.316 163.011 L +332.472 162.797 L +332.627 162.583 L +332.783 162.37 L +332.939 162.157 L +333.094 161.945 L +333.25 161.734 L +333.406 161.523 L +333.561 161.313 L +333.717 161.104 L +333.873 160.895 L +334.028 160.687 L +334.184 160.48 L +334.34 160.273 L +334.495 160.067 L +334.651 159.862 L +334.807 159.657 L +334.962 159.453 L +335.118 159.249 L +335.274 159.047 L +335.429 158.845 L +335.585 158.643 L +335.741 158.443 L +335.896 158.242 L +336.052 158.043 L +336.208 157.844 L +336.363 157.646 L +336.519 157.449 L +336.675 157.253 L +336.83 157.057 L +336.986 156.861 L +337.142 156.667 L +337.297 156.473 L +337.453 156.28 L +337.609 156.087 L +337.764 155.896 L +337.92 155.705 L +338.076 155.514 L +338.231 155.325 L +338.387 155.136 L +338.543 154.948 L +338.698 154.76 L +338.854 154.573 L +339.01 154.387 L +339.165 154.202 L +339.321 154.017 L +339.477 153.833 L +339.632 153.65 L +339.788 153.468 L +339.944 153.286 L +340.099 153.105 L +340.255 152.925 L +340.411 152.745 L +340.566 152.566 L +340.722 152.388 L +340.878 152.211 L +341.033 152.034 L +341.189 151.858 L +341.345 151.683 L +341.5 151.509 L +341.656 151.335 L +341.812 151.162 L +341.967 150.99 L +342.123 150.818 L +342.279 150.648 L +342.434 150.478 L +342.59 150.309 L +342.746 150.14 L +342.901 149.973 L +343.057 149.806 L +343.212 149.64 L +343.368 149.474 L +343.524 149.31 L +343.68 149.146 L +343.835 148.983 L +343.991 148.82 L +344.146 148.659 L +344.302 148.498 L +344.458 148.338 L +344.613 148.179 L +344.769 148.02 L +344.925 147.863 L +345.08 147.706 L +345.236 147.55 L +345.392 147.394 L +345.547 147.24 L +345.703 147.086 L +345.859 146.933 L +346.014 146.781 L +346.17 146.629 L +346.326 146.479 L +346.481 146.329 L +346.637 146.18 L +346.793 146.031 L +346.948 145.884 L +347.104 145.737 L +347.26 145.592 L +347.415 145.446 L +347.571 145.302 L +347.727 145.159 L +347.882 145.016 L +348.038 144.874 L +348.194 144.733 L +348.349 144.593 L +348.505 144.453 L +348.661 144.315 L +348.816 144.177 L +348.972 144.04 L +349.128 143.904 L +349.283 143.768 L +349.439 143.634 L +349.595 143.5 L +349.75 143.367 L +349.906 143.235 L +350.062 143.104 L +350.217 142.973 L +350.373 142.844 L +350.529 142.715 L +350.684 142.587 L +350.84 142.46 L +350.996 142.334 L +351.151 142.208 L +351.307 142.083 L +351.463 141.96 L +351.618 141.837 L +351.774 141.714 L +351.93 141.593 L +352.085 141.473 L +352.241 141.353 L +352.397 141.234 L +352.552 141.116 L +352.708 140.999 L +352.864 140.883 L +353.019 140.767 L +353.175 140.653 L +353.331 140.539 L +353.486 140.426 L +353.642 140.314 L +353.798 140.203 L +353.953 140.092 L +354.109 139.983 L +354.265 139.874 L +354.42 139.766 L +354.576 139.66 L +354.732 139.553 L +354.887 139.448 L +355.043 139.344 L +355.199 139.24 L +355.354 139.138 L +355.51 139.036 L +355.666 138.935 L +355.821 138.835 L +355.977 138.736 L +356.133 138.637 L +356.288 138.54 L +356.444 138.443 L +356.6 138.347 L +356.755 138.252 L +356.911 138.158 L +357.067 138.065 L +357.222 137.973 L +357.378 137.882 L +357.534 137.791 L +357.689 137.701 L +357.845 137.613 L +358.001 137.525 L +358.156 137.438 L +358.312 137.351 L +358.468 137.266 L +358.623 137.182 L +358.779 137.098 L +358.935 137.015 L +359.09 136.934 L +359.246 136.853 L +359.402 136.773 L +359.557 136.694 L +359.713 136.615 L +359.869 136.538 L +360.024 136.462 L +360.18 136.386 L +360.336 136.311 L +360.491 136.237 L +360.647 136.164 L +360.803 136.092 L +360.958 136.021 L +361.114 135.951 L +361.27 135.882 L +361.425 135.813 L +361.581 135.745 L +361.737 135.679 L +361.892 135.613 L +362.048 135.548 L +362.204 135.484 L +362.359 135.421 L +362.515 135.359 L +362.671 135.297 L +362.826 135.237 L +362.982 135.177 L +363.138 135.119 L +363.293 135.061 L +363.449 135.004 L +363.604 134.948 L +363.76 134.893 L +363.916 134.839 L +364.071 134.786 L +364.227 134.733 L +364.383 134.682 L +364.538 134.631 L +364.694 134.582 L +364.85 134.533 L +365.005 134.485 L +365.161 134.438 L +365.317 134.392 L +365.472 134.347 L +365.628 134.303 L +365.784 134.259 L +365.939 134.217 L +366.095 134.175 L +366.251 134.135 L +366.406 134.095 L +366.562 134.056 L +366.718 134.018 L +366.873 133.981 L +367.029 133.945 L +367.185 133.91 L +367.34 133.876 L +367.496 133.843 L +367.652 133.81 L +367.807 133.779 L +367.963 133.748 L +368.119 133.718 L +368.274 133.689 L +368.43 133.662 L +368.586 133.635 L +368.741 133.609 L +368.897 133.583 L +369.053 133.559 L +369.208 133.536 L +369.364 133.514 L +369.52 133.492 L +369.675 133.471 L +369.831 133.452 L +369.987 133.433 L +370.142 133.415 L +370.298 133.398 L +370.454 133.382 L +370.609 133.367 L +370.765 133.353 L +370.921 133.34 L +371.076 133.327 L +371.232 133.316 L +371.388 133.305 L +371.543 133.296 L +371.699 133.287 L +371.855 133.279 L +372.01 133.272 L +372.166 133.266 L +372.322 133.261 L +372.477 133.257 L +372.633 133.254 L +372.789 133.252 L +372.944 133.25 L +373.1 133.25 L +373.256 133.25 L +373.411 133.252 L +373.567 133.254 L +373.723 133.257 L +373.878 133.261 L +374.034 133.266 L +374.19 133.272 L +374.345 133.279 L +374.501 133.287 L +374.657 133.296 L +374.812 133.305 L +374.968 133.316 L +375.124 133.327 L +375.279 133.34 L +375.435 133.353 L +375.591 133.367 L +375.746 133.382 L +375.902 133.398 L +376.058 133.415 L +376.213 133.433 L +376.369 133.452 L +376.525 133.471 L +376.68 133.492 L +376.836 133.514 L +376.992 133.536 L +377.147 133.559 L +377.303 133.583 L +377.459 133.609 L +377.614 133.635 L +377.77 133.662 L +377.926 133.689 L +378.081 133.718 L +378.237 133.748 L +378.393 133.779 L +378.548 133.81 L +378.704 133.843 L +378.86 133.876 L +379.015 133.91 L +379.171 133.945 L +379.327 133.981 L +379.482 134.018 L +379.638 134.056 L +379.794 134.095 L +379.949 134.135 L +380.105 134.175 L +380.261 134.217 L +380.416 134.259 L +380.572 134.303 L +380.728 134.347 L +380.883 134.392 L +381.039 134.438 L +381.195 134.485 L +381.35 134.533 L +381.506 134.582 L +381.662 134.631 L +381.817 134.682 L +381.973 134.733 L +382.129 134.786 L +382.284 134.839 L +382.44 134.893 L +382.596 134.948 L +382.751 135.004 L +382.907 135.061 L +383.063 135.119 L +383.218 135.177 L +383.374 135.237 L +383.529 135.297 L +383.685 135.359 L +383.841 135.421 L +383.996 135.484 L +384.152 135.548 L +384.308 135.613 L +384.463 135.679 L +384.619 135.745 L +384.775 135.813 L +384.93 135.882 L +385.086 135.951 L +385.242 136.021 L +385.397 136.092 L +385.553 136.164 L +385.709 136.237 L +385.864 136.311 L +386.02 136.386 L +386.176 136.462 L +386.331 136.538 L +386.487 136.615 L +386.643 136.694 L +386.798 136.773 L +386.954 136.853 L +387.11 136.934 L +387.265 137.015 L +387.421 137.098 L +387.577 137.182 L +387.732 137.266 L +387.888 137.351 L +388.044 137.438 L +388.199 137.525 L +388.355 137.613 L +388.511 137.701 L +388.666 137.791 L +388.822 137.882 L +388.978 137.973 L +389.133 138.065 L +389.289 138.158 L +389.445 138.252 L +389.6 138.347 L +389.756 138.443 L +389.912 138.54 L +390.067 138.637 L +390.223 138.736 L +390.379 138.835 L +390.534 138.935 L +390.69 139.036 L +390.846 139.138 L +391.001 139.24 L +391.157 139.344 L +391.313 139.448 L +391.468 139.553 L +391.624 139.66 L +391.78 139.766 L +391.935 139.874 L +392.091 139.983 L +392.247 140.092 L +392.402 140.203 L +392.558 140.314 L +392.714 140.426 L +392.869 140.539 L +393.025 140.653 L +393.181 140.767 L +393.336 140.883 L +393.492 140.999 L +393.648 141.116 L +393.803 141.234 L +393.959 141.353 L +394.115 141.473 L +394.27 141.593 L +394.426 141.714 L +394.582 141.837 L +394.737 141.96 L +394.893 142.083 L +395.049 142.208 L +395.204 142.334 L +395.36 142.46 L +395.516 142.587 L +395.671 142.715 L +395.827 142.844 L +395.983 142.973 L +396.138 143.104 L +396.294 143.235 L +396.45 143.367 L +396.605 143.5 L +396.761 143.634 L +396.917 143.768 L +397.072 143.904 L +397.228 144.04 L +397.384 144.177 L +397.539 144.315 L +397.695 144.453 L +397.851 144.593 L +398.006 144.733 L +398.162 144.874 L +398.318 145.016 L +398.473 145.159 L +398.629 145.302 L +398.785 145.446 L +398.94 145.592 L +399.096 145.737 L +399.252 145.884 L +399.407 146.031 L +399.563 146.18 L +399.719 146.329 L +399.874 146.479 L +400.03 146.629 L +400.186 146.781 L +400.341 146.933 L +400.497 147.086 L +400.653 147.24 L +400.808 147.394 L +400.964 147.55 L +401.12 147.706 L +401.275 147.863 L +401.431 148.02 L +401.587 148.179 L +401.742 148.338 L +401.898 148.498 L +402.054 148.659 L +402.209 148.82 L +402.365 148.983 L +402.521 149.146 L +402.676 149.31 L +402.832 149.474 L +402.987 149.64 L +403.143 149.806 L +403.299 149.973 L +403.454 150.14 L +403.61 150.309 L +403.766 150.478 L +403.921 150.648 L +404.077 150.818 L +404.233 150.99 L +404.388 151.162 L +404.544 151.335 L +404.7 151.509 L +404.855 151.683 L +405.011 151.858 L +405.167 152.034 L +405.322 152.211 L +405.478 152.388 L +405.634 152.566 L +405.789 152.745 L +405.945 152.925 L +406.101 153.105 L +406.256 153.286 L +406.412 153.468 L +406.568 153.65 L +406.723 153.833 L +406.879 154.017 L +407.035 154.202 L +407.19 154.387 L +407.346 154.573 L +407.502 154.76 L +407.657 154.948 L +407.813 155.136 L +407.969 155.325 L +408.124 155.514 L +408.28 155.705 L +408.436 155.896 L +408.591 156.087 L +408.747 156.28 L +408.903 156.473 L +409.058 156.667 L +409.214 156.861 L +409.37 157.057 L +409.525 157.253 L +409.681 157.449 L +409.837 157.646 L +409.992 157.844 L +410.148 158.043 L +410.304 158.242 L +410.459 158.443 L +410.615 158.643 L +410.771 158.845 L +410.926 159.047 L +411.082 159.249 L +411.238 159.453 L +411.393 159.657 L +411.549 159.862 L +411.705 160.067 L +411.86 160.273 L +412.016 160.48 L +412.172 160.687 L +412.327 160.895 L +412.483 161.104 L +412.639 161.313 L +412.794 161.523 L +412.95 161.734 L +413.106 161.945 L +413.261 162.157 L +413.417 162.37 L +413.573 162.583 L +413.728 162.797 L +413.884 163.011 L +414.04 163.226 L +414.195 163.442 L +414.351 163.659 L +414.507 163.876 L +414.662 164.093 L +414.818 164.312 L +414.974 164.53 L +415.129 164.75 L +415.285 164.97 L +415.441 165.191 L +415.596 165.412 L +415.752 165.634 L +415.908 165.857 L +416.063 166.08 L +416.219 166.304 L +416.375 166.528 L +416.53 166.753 L +416.686 166.979 L +416.842 167.205 L +416.997 167.432 L +417.153 167.659 L +417.309 167.887 L +417.464 168.116 L +417.62 168.345 L +417.776 168.575 L +417.931 168.805 L +418.087 169.036 L +418.243 169.268 L +418.398 169.5 L +418.554 169.732 L +418.71 169.966 L +418.865 170.199 L +419.021 170.434 L +419.177 170.669 L +419.332 170.904 L +419.488 171.14 L +419.644 171.377 L +419.799 171.614 L +419.955 171.852 L +420.111 172.09 L +420.266 172.329 L +420.422 172.568 L +420.578 172.808 L +420.733 173.049 L +420.889 173.29 L +421.045 173.531 L +421.2 173.773 L +421.356 174.016 L +421.512 174.259 L +421.667 174.503 L +421.823 174.747 L +421.979 174.992 L +422.134 175.237 L +422.29 175.483 L +422.445 175.729 L +422.601 175.976 L +422.757 176.223 L +422.913 176.471 L +423.068 176.719 L +423.224 176.968 L +423.379 177.217 L +423.535 177.467 L +423.691 177.717 L +423.846 177.968 L +424.002 178.22 L +424.158 178.471 L +424.313 178.724 L +424.469 178.977 L +424.625 179.23 L +424.78 179.484 L +424.936 179.738 L +425.092 179.993 L +425.247 180.248 L +425.403 180.504 L +425.559 180.76 L +425.714 181.016 L +425.87 181.273 L +426.026 181.531 L +426.181 181.789 L +426.337 182.047 L +426.493 182.306 L +426.648 182.566 L +426.804 182.825 L +426.96 183.086 L +427.115 183.346 L +427.271 183.608 L +427.427 183.869 L +427.582 184.131 L +427.738 184.394 L +427.894 184.657 L +428.049 184.92 L +428.205 185.184 L +428.361 185.448 L +428.516 185.713 L +428.672 185.978 L +428.828 186.243 L +428.983 186.509 L +429.139 186.775 L +429.295 187.042 L +429.45 187.309 L +429.606 187.577 L +429.762 187.845 L +429.917 188.113 L +430.073 188.382 L +430.229 188.651 L +430.384 188.92 L +430.54 189.19 L +430.696 189.46 L +430.851 189.731 L +431.007 190.002 L +431.163 190.274 L +431.318 190.546 L +431.474 190.818 L +431.63 191.09 L +431.785 191.363 L +431.941 191.637 L +432.097 191.91 L +432.252 192.184 L +432.408 192.459 L +432.564 192.733 L +432.719 193.009 L +432.875 193.284 L +433.031 193.56 L +433.186 193.836 L +433.342 194.113 L +433.498 194.389 L +433.653 194.667 L +433.809 194.944 L +433.965 195.222 L +434.12 195.5 L +434.276 195.779 L +434.432 196.058 L +434.587 196.337 L +434.743 196.616 L +434.899 196.896 L +435.054 197.176 L +435.21 197.457 L +435.366 197.737 L +435.521 198.019 L +435.677 198.3 L +435.833 198.582 L +435.988 198.864 L +436.144 199.146 L +436.3 199.428 L +436.455 199.711 L +436.611 199.994 L +436.767 200.278 L +436.922 200.562 L +437.078 200.846 L +437.234 201.13 L +437.389 201.414 L +437.545 201.699 L +437.701 201.984 L +437.856 202.27 L +438.012 202.555 L +438.168 202.841 L +438.323 203.128 L +438.479 203.414 L +438.635 203.701 L +438.79 203.988 L +438.946 204.275 L +439.102 204.562 L +439.257 204.85 L +439.413 205.138 L +439.569 205.426 L +439.724 205.714 L +439.88 206.003 L +440.036 206.292 L +440.191 206.581 L +440.347 206.87 L +440.503 207.16 L +440.658 207.449 L +440.814 207.739 L +440.97 208.03 L +441.125 208.32 L +441.281 208.611 L +441.437 208.901 L +441.592 209.192 L +441.748 209.484 L +441.904 209.775 L +442.059 210.067 L +442.215 210.358 L +442.371 210.65 L +442.526 210.943 L +442.682 211.235 L +442.837 211.527 L +442.993 211.82 L +443.149 212.113 L +443.305 212.406 L +443.46 212.699 L +443.616 212.993 L +443.771 213.286 L +443.927 213.58 L +444.083 213.874 L +444.238 214.168 L +444.394 214.462 L +444.55 214.757 L +444.705 215.051 L +444.861 215.346 L +445.017 215.64 L +445.172 215.935 L +445.328 216.23 L +445.484 216.526 L +445.639 216.821 L +445.795 217.116 L +445.951 217.412 L +446.106 217.708 L +446.262 218.004 L +446.418 218.299 L +446.573 218.596 L +446.729 218.892 L +446.885 219.188 L +447.04 219.484 L +447.196 219.781 L +447.352 220.077 L +447.507 220.374 L +447.663 220.671 L +447.819 220.968 L +447.974 221.265 L +448.13 221.562 L +448.286 221.859 L +448.441 222.156 L +448.597 222.454 L +448.753 222.751 L +448.908 223.048 L +449.064 223.346 L +449.22 223.643 L +449.375 223.941 L +449.531 224.239 L +449.687 224.537 L +449.842 224.834 L +449.998 225.132 L +450.154 225.43 L +450.309 225.728 L +450.465 226.026 L +450.621 226.324 L +450.776 226.622 L +450.932 226.921 L +451.088 227.219 L +451.243 227.517 L +451.399 227.815 L +451.555 228.113 L +451.71 228.412 L +451.866 228.71 L +452.022 229.008 L +452.177 229.307 L +452.333 229.605 L +452.489 229.903 L +452.644 230.202 L +452.8 230.5 L +452.956 230.798 L +453.111 231.097 L +453.267 231.395 L +453.423 231.693 L +453.578 231.992 L +453.734 232.29 L +453.89 232.588 L +454.045 232.887 L +454.201 233.185 L +454.357 233.483 L +454.512 233.781 L +454.668 234.079 L +454.824 234.378 L +454.979 234.676 L +455.135 234.974 L +455.291 235.272 L +455.446 235.57 L +455.602 235.868 L +455.758 236.166 L +455.913 236.463 L +456.069 236.761 L +456.225 237.059 L +456.38 237.357 L +456.536 237.654 L +456.692 237.952 L +456.847 238.249 L +457.003 238.546 L +457.159 238.844 L +457.314 239.141 L +457.47 239.438 L +457.626 239.735 L +457.781 240.032 L +457.937 240.329 L +458.093 240.626 L +458.248 240.923 L +458.404 241.219 L +458.56 241.516 L +458.715 241.812 L +458.871 242.108 L +459.027 242.404 L +459.182 242.701 L +459.338 242.996 L +459.494 243.292 L +459.649 243.588 L +459.805 243.884 L +459.961 244.179 L +460.116 244.474 L +460.272 244.77 L +460.428 245.065 L +460.583 245.36 L +460.739 245.654 L +460.895 245.949 L +461.05 246.243 L +461.206 246.538 L +461.362 246.832 L +461.517 247.126 L +461.673 247.42 L +461.829 247.714 L +461.984 248.007 L +462.14 248.301 L +462.296 248.594 L +462.451 248.887 L +462.607 249.18 L +462.763 249.473 L +462.918 249.765 L +463.074 250.057 L +463.229 250.35 L +463.385 250.642 L +463.541 250.933 L +463.696 251.225 L +463.852 251.516 L +464.008 251.808 L +464.163 252.099 L +464.319 252.389 L +464.475 252.68 L +464.63 252.97 L +464.786 253.261 L +464.942 253.551 L +465.097 253.84 L +465.253 254.13 L +465.409 254.419 L +465.564 254.708 L +465.72 254.997 L +465.876 255.286 L +466.031 255.574 L +466.187 255.862 L +466.343 256.15 L +466.498 256.438 L +466.654 256.725 L +466.81 257.012 L +466.965 257.299 L +467.121 257.586 L +467.277 257.872 L +467.432 258.159 L +467.588 258.445 L +467.744 258.73 L +467.899 259.016 L +468.055 259.301 L +468.211 259.586 L +468.366 259.87 L +468.522 260.154 L +468.678 260.438 L +468.833 260.722 L +468.989 261.006 L +469.145 261.289 L +469.3 261.572 L +469.456 261.854 L +469.612 262.136 L +469.767 262.418 L +469.923 262.7 L +470.079 262.981 L +470.234 263.263 L +470.39 263.543 L +470.546 263.824 L +470.701 264.104 L +470.857 264.384 L +471.013 264.663 L +471.168 264.942 L +471.324 265.221 L +471.48 265.5 L +471.635 265.778 L +471.791 266.056 L +471.947 266.333 L +472.102 266.611 L +472.258 266.887 L +472.414 267.164 L +472.569 267.44 L +472.725 267.716 L +472.881 267.991 L +473.036 268.267 L +473.192 268.541 L +473.348 268.816 L +473.503 269.09 L +473.659 269.363 L +473.815 269.637 L +473.97 269.91 L +474.126 270.182 L +474.282 270.454 L +474.437 270.726 L +474.593 270.998 L +474.749 271.269 L +474.904 271.54 L +475.06 271.81 L +475.216 272.08 L +475.371 272.349 L +475.527 272.618 L +475.683 272.887 L +475.838 273.155 L +475.994 273.423 L +476.15 273.691 L +476.305 273.958 L +476.461 274.225 L +476.617 274.491 L +476.772 274.757 L +476.928 275.022 L +477.084 275.287 L +477.239 275.552 L +477.395 275.816 L +477.551 276.08 L +477.706 276.343 L +477.862 276.606 L +478.018 276.869 L +478.173 277.131 L +478.329 277.392 L +478.485 277.654 L +478.64 277.914 L +478.796 278.175 L +478.952 278.434 L +479.107 278.694 L +479.263 278.953 L +479.419 279.211 L +479.574 279.469 L +479.73 279.727 L +479.886 279.984 L +480.041 280.24 L +480.197 280.496 L +480.353 280.752 L +480.508 281.007 L +480.664 281.262 L +480.82 281.516 L +480.975 281.77 L +481.131 282.023 L +481.287 282.276 L +481.442 282.529 L +481.598 282.78 L +481.754 283.032 L +481.909 283.283 L +482.065 283.533 L +482.221 283.783 L +482.376 284.032 L +482.532 284.281 L +482.688 284.529 L +482.843 284.777 L +482.999 285.024 L +483.154 285.271 L +483.31 285.517 L +483.466 285.763 L +483.621 286.008 L +483.777 286.253 L +483.933 286.497 L +484.088 286.741 L +484.244 286.984 L +484.4 287.227 L +484.555 287.469 L +484.711 287.71 L +484.867 287.951 L +485.022 288.192 L +485.178 288.432 L +485.334 288.671 L +485.489 288.91 L +485.645 289.148 L +485.801 289.386 L +485.956 289.623 L +486.112 289.86 L +486.268 290.096 L +486.423 290.331 L +486.579 290.566 L +486.735 290.801 L +486.89 291.034 L +487.046 291.268 L +487.202 291.5 L +487.357 291.732 L +487.513 291.964 L +487.669 292.195 L +487.824 292.425 L +487.98 292.655 L +488.136 292.884 L +488.291 293.113 L +488.447 293.341 L +488.603 293.568 L +488.758 293.795 L +488.914 294.021 L +489.07 294.247 L +489.225 294.472 L +489.381 294.696 L +489.537 294.92 L +489.692 295.143 L +489.848 295.366 L +490.004 295.588 L +490.159 295.809 L +490.315 296.03 L +490.471 296.25 L +490.626 296.47 L +490.782 296.688 L +490.938 296.907 L +491.093 297.124 L +491.249 297.341 L +491.405 297.558 L +491.56 297.774 L +491.716 297.989 L +491.872 298.203 L +492.027 298.417 L +492.183 298.63 L +492.339 298.843 L +492.494 299.055 L +492.65 299.266 L +492.806 299.477 L +492.961 299.687 L +493.117 299.896 L +493.273 300.105 L +493.428 300.313 L +493.584 300.52 L +493.74 300.727 L +493.895 300.933 L +494.051 301.138 L +494.207 301.343 L +494.362 301.547 L +494.518 301.751 L +494.674 301.953 L +494.829 302.155 L +494.985 302.357 L +495.141 302.557 L +495.296 302.758 L +495.452 302.957 L +495.608 303.156 L +495.763 303.354 L +495.919 303.551 L +496.075 303.747 L +496.23 303.943 L +496.386 304.139 L +496.542 304.333 L +496.697 304.527 L +496.853 304.72 L +497.009 304.913 L +497.164 305.104 L +497.32 305.295 L +497.476 305.486 L +497.631 305.675 L +497.787 305.864 L +497.943 306.052 L +498.098 306.24 L +498.254 306.427 L +498.41 306.613 L +498.565 306.798 L +498.721 306.983 L +498.877 307.167 L +499.032 307.35 L +499.188 307.532 L +499.344 307.714 L +499.499 307.895 L +499.655 308.075 L +499.811 308.255 L +499.966 308.434 L +500.122 308.612 L +500.278 308.789 L +500.433 308.966 L +500.589 309.142 L +500.745 309.317 L +500.9 309.491 L +501.056 309.665 L +501.212 309.838 L +501.367 310.01 L +501.523 310.182 L +501.679 310.352 L +501.834 310.522 L +501.99 310.691 L +502.146 310.86 L +502.301 311.027 L +502.457 311.194 L +502.612 311.36 L +502.768 311.526 L +502.924 311.69 L +503.079 311.854 L +503.235 312.017 L +503.391 312.18 L +503.546 312.341 L +503.702 312.502 L +503.858 312.662 L +504.013 312.821 L +504.169 312.98 L +504.325 313.137 L +504.48 313.294 L +504.636 313.45 L +504.792 313.606 L +504.947 313.76 L +505.103 313.914 L +505.259 314.067 L +505.414 314.219 L +505.57 314.371 L +505.726 314.521 L +505.881 314.671 L +506.037 314.82 L +506.193 314.969 L +506.348 315.116 L +506.504 315.263 L +506.66 315.408 L +506.815 315.554 L +506.971 315.698 L +507.127 315.841 L +507.282 315.984 L +507.438 316.126 L +507.594 316.267 L +507.749 316.407 L +507.905 316.547 L +508.061 316.685 L +508.216 316.823 L +508.372 316.96 L +508.528 317.096 L +508.683 317.232 L +508.839 317.366 L +508.995 317.5 L +509.15 317.633 L +509.306 317.765 L +509.462 317.896 L +509.617 318.027 L +509.773 318.156 L +509.929 318.285 L +510.084 318.413 L +510.24 318.54 L +510.396 318.666 L +510.551 318.792 L +510.707 318.917 L +510.863 319.04 L +511.018 319.163 L +511.174 319.286 L +511.33 319.407 L +511.485 319.527 L +511.641 319.647 L +511.797 319.766 L +511.952 319.884 L +512.108 320.001 L +512.264 320.117 L +512.419 320.233 L +512.575 320.347 L +512.731 320.461 L +512.886 320.574 L +513.042 320.686 L +513.198 320.797 L +513.353 320.908 L +513.509 321.017 L +513.665 321.126 L +513.82 321.234 L +513.976 321.34 L +514.132 321.447 L +514.287 321.552 L +514.443 321.656 L +514.599 321.76 L +514.754 321.862 L +514.91 321.964 L +515.066 322.065 L +515.221 322.165 L +515.377 322.264 L +515.533 322.363 L +515.688 322.46 L +515.844 322.557 L +516 322.653 L +516.155 322.748 L +516.311 322.842 L +516.467 322.935 L +516.622 323.027 L +516.778 323.118 L +516.934 323.209 L +517.089 323.299 L +517.245 323.387 L +517.401 323.475 L +517.556 323.562 L +517.712 323.649 L +517.868 323.734 L +518.023 323.818 L +518.179 323.902 L +518.335 323.985 L +518.49 324.066 L +518.646 324.147 L +518.802 324.227 L +518.957 324.306 L +519.113 324.385 L +519.269 324.462 L +519.424 324.538 L +519.58 324.614 L +519.736 324.689 L +519.891 324.763 L +520.047 324.836 L +520.203 324.908 L +520.358 324.979 L +520.514 325.049 L +520.67 325.118 L +520.825 325.187 L +520.981 325.255 L +521.137 325.321 L +521.292 325.387 L +521.448 325.452 L +521.604 325.516 L +521.759 325.579 L +521.915 325.641 L +522.07 325.703 L +522.226 325.763 L +522.382 325.823 L +522.537 325.881 L +522.693 325.939 L +522.849 325.996 L +523.005 326.052 L +523.16 326.107 L +523.316 326.161 L +523.471 326.214 L +523.627 326.267 L +523.783 326.318 L +523.938 326.369 L +524.094 326.418 L +524.25 326.467 L +524.405 326.515 L +524.561 326.562 L +524.717 326.608 L +524.872 326.653 L +525.028 326.697 L +525.184 326.741 L +525.339 326.783 L +525.495 326.825 L +525.651 326.865 L +525.806 326.905 L +525.962 326.944 L +526.118 326.982 L +526.273 327.019 L +526.429 327.055 L +526.585 327.09 L +526.74 327.124 L +526.896 327.157 L +527.052 327.19 L +527.207 327.221 L +527.363 327.252 L +527.519 327.282 L +527.674 327.311 L +527.83 327.338 L +527.986 327.365 L +528.141 327.391 L +528.297 327.417 L +528.453 327.441 L +528.608 327.464 L +528.764 327.486 L +528.92 327.508 L +529.075 327.529 L +529.231 327.548 L +529.387 327.567 L +529.542 327.585 L +529.698 327.602 L +529.854 327.618 L +530.009 327.633 L +530.165 327.647 L +530.321 327.66 L +530.476 327.673 L +530.632 327.684 L +530.788 327.695 L +530.943 327.704 L +531.099 327.713 L +531.255 327.721 L +531.41 327.728 L +531.566 327.734 L +531.722 327.739 L +531.877 327.743 L +532.033 327.746 L +532.189 327.748 L +532.344 327.75 L +532.5 327.75 L +532.656 327.75 L +532.811 327.748 L +532.967 327.746 L +533.123 327.743 L +533.278 327.739 L +533.434 327.734 L +533.59 327.728 L +533.745 327.721 L +533.901 327.713 L +534.057 327.704 L +534.212 327.695 L +534.368 327.684 L +534.524 327.673 L +534.679 327.66 L +534.835 327.647 L +534.991 327.633 L +535.146 327.618 L +535.302 327.602 L +535.458 327.585 L +535.613 327.567 L +535.769 327.548 L +535.925 327.529 L +536.08 327.508 L +536.236 327.486 L +536.392 327.464 L +536.547 327.441 L +536.703 327.417 L +536.859 327.391 L +537.014 327.365 L +537.17 327.338 L +537.326 327.311 L +537.481 327.282 L +537.637 327.252 L +537.793 327.221 L +537.948 327.19 L +538.104 327.157 L +538.26 327.124 L +538.415 327.09 L +538.571 327.055 L +538.727 327.019 L +538.882 326.982 L +539.038 326.944 L +539.194 326.905 L +539.349 326.865 L +539.505 326.825 L +539.661 326.783 L +539.816 326.741 L +539.972 326.697 L +540.128 326.653 L +540.283 326.608 L +540.439 326.562 L +540.595 326.515 L +540.75 326.467 L +540.906 326.418 L +541.062 326.369 L +541.217 326.318 L +541.373 326.267 L +541.529 326.214 L +541.684 326.161 L +541.84 326.107 L +541.995 326.052 L +542.151 325.996 L +542.307 325.939 L +542.463 325.881 L +542.618 325.823 L +542.774 325.763 L +542.93 325.703 L +543.085 325.641 L +543.241 325.579 L +543.396 325.516 L +543.552 325.452 L +543.708 325.387 L +543.863 325.321 L +544.019 325.255 L +544.175 325.187 L +544.33 325.118 L +544.486 325.049 L +544.642 324.979 L +544.797 324.908 L +544.953 324.836 L +545.109 324.763 L +545.264 324.689 L +545.42 324.614 L +545.576 324.538 L +545.731 324.462 L +545.887 324.385 L +546.043 324.306 L +546.198 324.227 L +546.354 324.147 L +546.51 324.066 L +546.665 323.985 L +546.821 323.902 L +546.977 323.818 L +547.132 323.734 L +547.288 323.649 L +547.444 323.562 L +547.599 323.475 L +547.755 323.387 L +547.911 323.299 L +548.066 323.209 L +548.222 323.118 L +548.378 323.027 L +548.533 322.935 L +548.689 322.842 L +548.845 322.748 L +549 322.653 L +549.156 322.557 L +549.312 322.46 L +549.467 322.363 L +549.623 322.264 L +549.779 322.165 L +549.934 322.065 L +550.09 321.964 L +550.246 321.862 L +550.401 321.76 L +550.557 321.656 L +550.713 321.552 L +550.868 321.447 L +551.024 321.34 L +551.18 321.234 L +551.335 321.126 L +551.491 321.017 L +551.647 320.908 L +551.802 320.797 L +551.958 320.686 L +552.114 320.574 L +552.269 320.461 L +552.425 320.347 L +552.581 320.233 L +552.736 320.117 L +552.892 320.001 L +553.048 319.884 L +553.203 319.766 L +553.359 319.647 L +553.515 319.527 L +553.67 319.407 L +553.826 319.286 L +553.982 319.163 L +554.137 319.04 L +554.293 318.917 L +554.449 318.792 L +554.604 318.666 L +554.76 318.54 L +554.916 318.413 L +555.071 318.285 L +555.227 318.156 L +555.383 318.027 L +555.538 317.896 L +555.694 317.765 L +555.85 317.633 L +556.005 317.5 L +556.161 317.366 L +556.317 317.232 L +556.472 317.096 L +556.628 316.96 L +556.784 316.823 L +556.939 316.685 L +557.095 316.547 L +557.251 316.407 L +557.406 316.267 L +557.562 316.126 L +557.718 315.984 L +557.873 315.841 L +558.029 315.698 L +558.185 315.554 L +558.34 315.408 L +558.496 315.263 L +558.652 315.116 L +558.807 314.969 L +558.963 314.82 L +559.119 314.671 L +559.274 314.521 L +559.43 314.371 L +559.586 314.219 L +559.741 314.067 L +559.897 313.914 L +560.053 313.76 L +560.208 313.606 L +560.364 313.45 L +560.52 313.294 L +560.675 313.137 L +560.831 312.98 L +560.987 312.821 L +561.142 312.662 L +561.298 312.502 L +561.453 312.341 L +561.609 312.18 L +561.765 312.017 L +561.921 311.854 L +562.076 311.69 L +562.232 311.526 L +562.388 311.36 L +562.543 311.194 L +562.699 311.027 L +562.854 310.86 L +563.01 310.691 L +563.166 310.522 L +563.321 310.352 L +563.477 310.182 L +563.633 310.01 L +563.788 309.838 L +563.944 309.665 L +564.1 309.491 L +564.255 309.317 L +564.411 309.142 L +564.567 308.966 L +564.722 308.789 L +564.878 308.612 L +565.034 308.434 L +565.189 308.255 L +565.345 308.075 L +565.501 307.895 L +565.656 307.714 L +565.812 307.532 L +565.968 307.35 L +566.123 307.167 L +566.279 306.983 L +566.435 306.798 L +566.59 306.613 L +566.746 306.427 L +566.902 306.24 L +567.057 306.052 L +567.213 305.864 L +567.369 305.675 L +567.524 305.486 L +567.68 305.295 L +567.836 305.104 L +567.991 304.913 L +568.147 304.72 L +568.303 304.527 L +568.458 304.333 L +568.614 304.139 L +568.77 303.943 L +568.925 303.747 L +569.081 303.551 L +569.237 303.354 L +569.392 303.156 L +569.548 302.957 L +569.704 302.758 L +569.859 302.557 L +570.015 302.357 L +570.171 302.155 L +570.326 301.953 L +570.482 301.751 L +570.638 301.547 L +570.793 301.343 L +570.949 301.138 L +571.105 300.933 L +571.26 300.727 L +571.416 300.52 L +571.572 300.313 L +571.727 300.105 L +571.883 299.896 L +572.039 299.687 L +572.194 299.477 L +572.35 299.266 L +572.506 299.055 L +572.661 298.843 L +572.817 298.63 L +572.973 298.417 L +573.128 298.203 L +573.284 297.989 L +573.44 297.774 L +573.595 297.558 L +573.751 297.341 L +573.907 297.124 L +574.062 296.907 L +574.218 296.688 L +574.374 296.47 L +574.529 296.25 L +574.685 296.03 L +574.841 295.809 L +574.996 295.588 L +575.152 295.366 L +575.308 295.143 L +575.463 294.92 L +575.619 294.696 L +575.775 294.472 L +575.93 294.247 L +576.086 294.021 L +576.242 293.795 L +576.397 293.568 L +576.553 293.341 L +576.709 293.113 L +576.864 292.884 L +577.02 292.655 L +577.176 292.425 L +577.331 292.195 L +577.487 291.964 L +577.643 291.732 L +577.798 291.5 L +577.954 291.268 L +578.11 291.034 L +578.265 290.801 L +578.421 290.566 L +578.577 290.331 L +578.732 290.096 L +578.888 289.86 L +579.044 289.623 L +579.199 289.386 L +579.355 289.148 L +579.511 288.91 L +579.666 288.671 L +579.822 288.432 L +579.978 288.192 L +580.133 287.951 L +580.289 287.71 L +580.445 287.469 L +580.6 287.227 L +580.756 286.984 L +580.911 286.741 L +581.067 286.497 L +581.223 286.253 L +581.379 286.008 L +581.534 285.763 L +581.69 285.517 L +581.846 285.271 L +582.001 285.024 L +582.157 284.777 L +582.313 284.529 L +582.468 284.281 L +582.624 284.032 L +582.779 283.783 L +582.935 283.533 L +583.091 283.283 L +583.246 283.032 L +583.402 282.78 L +583.558 282.529 L +583.714 282.276 L +583.869 282.023 L +584.025 281.77 L +584.18 281.516 L +584.336 281.262 L +584.492 281.007 L +584.647 280.752 L +584.803 280.496 L +584.959 280.24 L +585.114 279.984 L +585.27 279.727 L +585.426 279.469 L +585.581 279.211 L +585.737 278.953 L +585.893 278.694 L +586.048 278.434 L +586.204 278.175 L +586.36 277.914 L +586.515 277.654 L +586.671 277.392 L +586.827 277.131 L +586.982 276.869 L +587.138 276.606 L +587.294 276.343 L +587.449 276.08 L +587.605 275.816 L +587.761 275.552 L +587.916 275.287 L +588.072 275.022 L +588.228 274.757 L +588.383 274.491 L +588.539 274.225 L +588.695 273.958 L +588.85 273.691 L +589.006 273.423 L +589.162 273.155 L +589.317 272.887 L +589.473 272.618 L +589.629 272.349 L +589.784 272.08 L +589.94 271.81 L +590.096 271.54 L +590.251 271.269 L +590.407 270.998 L +590.563 270.726 L +590.718 270.454 L +590.874 270.182 L +591.03 269.91 L +591.185 269.637 L +591.341 269.363 L +591.497 269.09 L +591.652 268.816 L +591.808 268.541 L +591.964 268.267 L +592.119 267.991 L +592.275 267.716 L +592.431 267.44 L +592.586 267.164 L +592.742 266.887 L +592.898 266.611 L +593.053 266.333 L +593.209 266.056 L +593.365 265.778 L +593.52 265.5 L +593.676 265.221 L +593.832 264.942 L +593.987 264.663 L +594.143 264.384 L +594.299 264.104 L +594.454 263.824 L +594.61 263.543 L +594.766 263.263 L +594.921 262.981 L +595.077 262.7 L +595.233 262.418 L +595.388 262.136 L +595.544 261.854 L +595.7 261.572 L +595.855 261.289 L +596.011 261.006 L +596.167 260.722 L +596.322 260.438 L +596.478 260.154 L +596.634 259.87 L +596.789 259.586 L +596.945 259.301 L +597.101 259.016 L +597.256 258.73 L +597.412 258.445 L +597.568 258.159 L +597.723 257.872 L +597.879 257.586 L +598.035 257.299 L +598.19 257.012 L +598.346 256.725 L +598.502 256.438 L +598.657 256.15 L +598.813 255.862 L +598.969 255.574 L +599.124 255.286 L +599.28 254.997 L +599.436 254.708 L +599.591 254.419 L +599.747 254.13 L +599.903 253.84 L +600.058 253.551 L +600.214 253.261 L +600.37 252.97 L +600.525 252.68 L +600.681 252.389 L +600.837 252.099 L +600.992 251.808 L +601.148 251.516 L +601.304 251.225 L +601.459 250.933 L +601.615 250.642 L +601.771 250.35 L +601.926 250.057 L +602.082 249.765 L +602.237 249.473 L +602.393 249.18 L +602.549 248.887 L +602.704 248.594 L +602.86 248.301 L +603.016 248.007 L +603.172 247.714 L +603.327 247.42 L +603.483 247.126 L +603.638 246.832 L +603.794 246.538 L +603.95 246.243 L +604.105 245.949 L +604.261 245.654 L +604.417 245.36 L +604.572 245.065 L +604.728 244.77 L +604.884 244.474 L +605.039 244.179 L +605.195 243.884 L +605.351 243.588 L +605.506 243.292 L +605.662 242.996 L +605.818 242.701 L +605.973 242.404 L +606.129 242.108 L +606.285 241.812 L +606.44 241.516 L +606.596 241.219 L +606.752 240.923 L +606.907 240.626 L +607.063 240.329 L +607.219 240.032 L +607.374 239.735 L +607.53 239.438 L +607.686 239.141 L +607.841 238.844 L +607.997 238.546 L +608.153 238.249 L +608.308 237.952 L +608.464 237.654 L +608.62 237.357 L +608.775 237.059 L +608.931 236.761 L +609.087 236.463 L +609.242 236.166 L +609.398 235.868 L +609.554 235.57 L +609.709 235.272 L +609.865 234.974 L +610.021 234.676 L +610.176 234.378 L +610.332 234.079 L +610.488 233.781 L +610.643 233.483 L +610.799 233.185 L +610.955 232.887 L +611.11 232.588 L +611.266 232.29 L +611.422 231.992 L +611.577 231.693 L +611.733 231.395 L +611.889 231.097 L +612.044 230.798 L +612.2 230.5 L +612.356 230.202 L +612.511 229.903 L +612.667 229.605 L +612.823 229.307 L +612.978 229.008 L +613.134 228.71 L +613.29 228.412 L +613.445 228.113 L +613.601 227.815 L +613.757 227.517 L +613.912 227.219 L +614.068 226.921 L +614.224 226.622 L +614.379 226.324 L +614.535 226.026 L +614.691 225.728 L +614.846 225.43 L +615.002 225.132 L +615.158 224.834 L +615.313 224.537 L +615.469 224.239 L +615.625 223.941 L +615.78 223.643 L +615.936 223.346 L +616.092 223.048 L +616.247 222.751 L +616.403 222.454 L +616.559 222.156 L +616.714 221.859 L +616.87 221.562 L +617.026 221.265 L +617.181 220.968 L +617.337 220.671 L +617.493 220.374 L +617.648 220.077 L +617.804 219.781 L +617.96 219.484 L +618.115 219.188 L +618.271 218.892 L +618.427 218.596 L +618.582 218.299 L +618.738 218.004 L +618.894 217.708 L +619.049 217.412 L +619.205 217.116 L +619.361 216.821 L +619.516 216.526 L +619.672 216.23 L +619.828 215.935 L +619.983 215.64 L +620.139 215.346 L +620.295 215.051 L +620.45 214.757 L +620.606 214.462 L +620.762 214.168 L +620.917 213.874 L +621.073 213.58 L +621.229 213.286 L +621.384 212.993 L +621.54 212.699 L +621.695 212.406 L +621.851 212.113 L +622.007 211.82 L +622.162 211.527 L +622.318 211.235 L +622.474 210.943 L +622.63 210.65 L +622.785 210.358 L +622.941 210.067 L +623.096 209.775 L +623.252 209.484 L +623.408 209.192 L +623.563 208.901 L +623.719 208.611 L +623.875 208.32 L +624.03 208.03 L +624.186 207.739 L +624.342 207.449 L +624.497 207.16 L +624.653 206.87 L +624.809 206.581 L +624.964 206.292 L +625.12 206.003 L +625.276 205.714 L +625.431 205.426 L +625.587 205.138 L +625.743 204.85 L +625.898 204.562 L +626.054 204.275 L +626.21 203.988 L +626.365 203.701 L +626.521 203.414 L +626.677 203.128 L +626.832 202.841 L +626.988 202.555 L +627.144 202.27 L +627.299 201.984 L +627.455 201.699 L +627.611 201.414 L +627.766 201.13 L +627.922 200.846 L +628.078 200.562 L +628.233 200.278 L +628.389 199.994 L +628.545 199.711 L +628.7 199.428 L +628.856 199.146 L +629.012 198.864 L +629.167 198.582 L +629.323 198.3 L +629.479 198.019 L +629.634 197.737 L +629.79 197.457 L +629.946 197.176 L +630.101 196.896 L +630.257 196.616 L +630.413 196.337 L +630.568 196.058 L +630.724 195.779 L +630.88 195.5 L +631.035 195.222 L +631.191 194.944 L +631.347 194.667 L +631.502 194.389 L +631.658 194.113 L +631.814 193.836 L +631.969 193.56 L +632.125 193.284 L +632.281 193.009 L +632.436 192.733 L +632.592 192.459 L +632.748 192.184 L +632.903 191.91 L +633.059 191.637 L +633.215 191.363 L +633.37 191.09 L +633.526 190.818 L +633.682 190.546 L +633.837 190.274 L +633.993 190.002 L +634.149 189.731 L +634.304 189.46 L +634.46 189.19 L +634.616 188.92 L +634.771 188.651 L +634.927 188.382 L +635.083 188.113 L +635.238 187.845 L +635.394 187.577 L +635.55 187.309 L +635.705 187.042 L +635.861 186.775 L +636.017 186.509 L +636.172 186.243 L +636.328 185.978 L +636.484 185.713 L +636.639 185.448 L +636.795 185.184 L +636.951 184.92 L +637.106 184.657 L +637.262 184.394 L +637.418 184.131 L +637.573 183.869 L +637.729 183.608 L +637.885 183.346 L +638.04 183.086 L +638.196 182.825 L +638.352 182.566 L +638.507 182.306 L +638.663 182.047 L +638.819 181.789 L +638.974 181.531 L +639.13 181.273 L +639.286 181.016 L +639.441 180.76 L +639.597 180.504 L +639.753 180.248 L +639.908 179.993 L +640.064 179.738 L +640.22 179.484 L +640.375 179.23 L +640.531 178.977 L +640.687 178.724 L +640.842 178.471 L +640.998 178.22 L +641.154 177.968 L +641.309 177.717 L +641.465 177.467 L +641.62 177.217 L +641.776 176.968 L +641.932 176.719 L +642.088 176.471 L +642.243 176.223 L +642.399 175.976 L +642.555 175.729 L +642.71 175.483 L +642.866 175.237 L +643.021 174.992 L +643.177 174.747 L +643.333 174.503 L +643.488 174.259 L +643.644 174.016 L +643.8 173.773 L +643.955 173.531 L +644.111 173.29 L +644.267 173.049 L +644.422 172.808 L +644.578 172.568 L +644.734 172.329 L +644.889 172.09 L +645.045 171.852 L +645.201 171.614 L +645.356 171.377 L +645.512 171.14 L +645.668 170.904 L +645.823 170.669 L +645.979 170.434 L +646.135 170.199 L +646.29 169.966 L +646.446 169.732 L +646.602 169.5 L +646.757 169.268 L +646.913 169.036 L +647.069 168.805 L +647.224 168.575 L +647.38 168.345 L +647.536 168.116 L +647.691 167.887 L +647.847 167.659 L +648.003 167.432 L +648.158 167.205 L +648.314 166.979 L +648.47 166.753 L +648.625 166.528 L +648.781 166.304 L +648.937 166.08 L +649.092 165.857 L +649.248 165.634 L +649.404 165.412 L +649.559 165.191 L +649.715 164.97 L +649.871 164.75 L +650.026 164.53 L +650.182 164.312 L +650.338 164.093 L +650.493 163.876 L +650.649 163.659 L +650.805 163.442 L +650.96 163.226 L +651.116 163.011 L +651.272 162.797 L +651.427 162.583 L +651.583 162.37 L +651.739 162.157 L +651.894 161.945 L +652.05 161.734 L +652.206 161.523 L +652.361 161.313 L +652.517 161.104 L +652.673 160.895 L +652.828 160.687 L +652.984 160.48 L +653.14 160.273 L +653.295 160.067 L +653.451 159.862 L +653.607 159.657 L +653.762 159.453 L +653.918 159.249 L +654.074 159.047 L +654.229 158.845 L +654.385 158.643 L +654.541 158.443 L +654.696 158.242 L +654.852 158.043 L +655.008 157.844 L +655.163 157.646 L +655.319 157.449 L +655.475 157.253 L +655.63 157.057 L +655.786 156.861 L +655.942 156.667 L +656.097 156.473 L +656.253 156.28 L +656.409 156.087 L +656.564 155.896 L +656.72 155.705 L +656.876 155.514 L +657.031 155.325 L +657.187 155.136 L +657.343 154.948 L +657.498 154.76 L +657.654 154.573 L +657.81 154.387 L +657.965 154.202 L +658.121 154.017 L +658.277 153.833 L +658.432 153.65 L +658.588 153.468 L +658.744 153.286 L +658.899 153.105 L +659.055 152.925 L +659.211 152.745 L +659.366 152.566 L +659.522 152.388 L +659.678 152.211 L +659.833 152.034 L +659.989 151.858 L +660.145 151.683 L +660.3 151.509 L +660.456 151.335 L +660.612 151.162 L +660.767 150.99 L +660.923 150.818 L +661.078 150.648 L +661.234 150.478 L +661.39 150.309 L +661.546 150.14 L +661.701 149.973 L +661.857 149.806 L +662.013 149.64 L +662.168 149.474 L +662.324 149.31 L +662.479 149.146 L +662.635 148.983 L +662.791 148.82 L +662.946 148.659 L +663.102 148.498 L +663.258 148.338 L +663.413 148.179 L +663.569 148.02 L +663.725 147.863 L +663.88 147.706 L +664.036 147.55 L +664.192 147.394 L +664.347 147.24 L +664.503 147.086 L +664.659 146.933 L +664.814 146.781 L +664.97 146.629 L +665.126 146.479 L +665.281 146.329 L +665.437 146.18 L +665.593 146.031 L +665.748 145.884 L +665.904 145.737 L +666.06 145.592 L +666.215 145.446 L +666.371 145.302 L +666.527 145.159 L +666.682 145.016 L +666.838 144.874 L +666.994 144.733 L +667.149 144.593 L +667.305 144.453 L +667.461 144.315 L +667.616 144.177 L +667.772 144.04 L +667.928 143.904 L +668.083 143.768 L +668.239 143.634 L +668.395 143.5 L +668.55 143.367 L +668.706 143.235 L +668.862 143.104 L +669.017 142.973 L +669.173 142.844 L +669.329 142.715 L +669.484 142.587 L +669.64 142.46 L +669.796 142.334 L +669.951 142.208 L +670.107 142.083 L +670.263 141.96 L +670.418 141.837 L +670.574 141.714 L +670.73 141.593 L +670.885 141.473 L +671.041 141.353 L +671.197 141.234 L +671.352 141.116 L +671.508 140.999 L +671.664 140.883 L +671.819 140.767 L +671.975 140.653 L +672.131 140.539 L +672.286 140.426 L +672.442 140.314 L +672.598 140.203 L +672.753 140.092 L +672.909 139.983 L +673.065 139.874 L +673.22 139.766 L +673.376 139.66 L +673.532 139.553 L +673.687 139.448 L +673.843 139.344 L +673.999 139.24 L +674.154 139.138 L +674.31 139.036 L +674.466 138.935 L +674.621 138.835 L +674.777 138.736 L +674.933 138.637 L +675.088 138.54 L +675.244 138.443 L +675.4 138.347 L +675.555 138.252 L +675.711 138.158 L +675.867 138.065 L +676.022 137.973 L +676.178 137.882 L +676.334 137.791 L +676.489 137.701 L +676.645 137.613 L +676.801 137.525 L +676.956 137.438 L +677.112 137.351 L +677.268 137.266 L +677.423 137.182 L +677.579 137.098 L +677.735 137.015 L +677.89 136.934 L +678.046 136.853 L +678.202 136.773 L +678.357 136.694 L +678.513 136.615 L +678.669 136.538 L +678.824 136.462 L +678.98 136.386 L +679.136 136.311 L +679.291 136.237 L +679.447 136.164 L +679.603 136.092 L +679.758 136.021 L +679.914 135.951 L +680.07 135.882 L +680.225 135.813 L +680.381 135.745 L +680.536 135.679 L +680.692 135.613 L +680.848 135.548 L +681.004 135.484 L +681.159 135.421 L +681.315 135.359 L +681.471 135.297 L +681.626 135.237 L +681.782 135.177 L +681.938 135.119 L +682.093 135.061 L +682.249 135.004 L +682.404 134.948 L +682.56 134.893 L +682.716 134.839 L +682.871 134.786 L +683.027 134.733 L +683.183 134.682 L +683.339 134.631 L +683.494 134.582 L +683.65 134.533 L +683.805 134.485 L +683.961 134.438 L +684.117 134.392 L +684.272 134.347 L +684.428 134.303 L +684.584 134.259 L +684.739 134.217 L +684.895 134.175 L +685.051 134.135 L +685.206 134.095 L +685.362 134.056 L +685.518 134.018 L +685.673 133.981 L +685.829 133.945 L +685.985 133.91 L +686.14 133.876 L +686.296 133.843 L +686.452 133.81 L +686.607 133.779 L +686.763 133.748 L +686.919 133.718 L +687.074 133.689 L +687.23 133.662 L +687.386 133.635 L +687.541 133.609 L +687.697 133.583 L +687.853 133.559 L +688.008 133.536 L +688.164 133.514 L +688.32 133.492 L +688.475 133.471 L +688.631 133.452 L +688.787 133.433 L +688.942 133.415 L +689.098 133.398 L +689.254 133.382 L +689.409 133.367 L +689.565 133.353 L +689.721 133.34 L +689.876 133.327 L +690.032 133.316 L +690.188 133.305 L +690.343 133.296 L +690.499 133.287 L +690.655 133.279 L +690.81 133.272 L +690.966 133.266 L +691.122 133.261 L +691.277 133.257 L +691.433 133.254 L +691.589 133.252 L +691.744 133.25 L +691.9 133.25 L +692.056 133.25 L +692.211 133.252 L +692.367 133.254 L +692.523 133.257 L +692.678 133.261 L +692.834 133.266 L +692.99 133.272 L +693.145 133.279 L +693.301 133.287 L +693.457 133.296 L +693.612 133.305 L +693.768 133.316 L +693.924 133.327 L +694.079 133.34 L +694.235 133.353 L +694.391 133.367 L +694.546 133.382 L +694.702 133.398 L +694.858 133.415 L +695.013 133.433 L +695.169 133.452 L +695.325 133.471 L +695.48 133.492 L +695.636 133.514 L +695.792 133.536 L +695.947 133.559 L +696.103 133.583 L +696.259 133.609 L +696.414 133.635 L +696.57 133.662 L +696.726 133.689 L +696.881 133.718 L +697.037 133.748 L +697.193 133.779 L +697.348 133.81 L +697.504 133.843 L +697.66 133.876 L +697.815 133.91 L +697.971 133.945 L +698.127 133.981 L +698.282 134.018 L +698.438 134.056 L +698.594 134.095 L +698.749 134.135 L +698.905 134.175 L +699.061 134.217 L +699.216 134.259 L +699.372 134.303 L +699.528 134.347 L +699.683 134.392 L +699.839 134.438 L +699.995 134.485 L +700.15 134.533 L +700.306 134.582 L +700.462 134.631 L +700.617 134.682 L +700.773 134.733 L +700.929 134.786 L +701.084 134.839 L +701.24 134.893 L +701.396 134.948 L +701.551 135.004 L +701.707 135.061 L +701.862 135.119 L +702.018 135.177 L +702.174 135.237 L +702.329 135.297 L +702.485 135.359 L +702.641 135.421 L +702.797 135.484 L +702.952 135.548 L +703.108 135.613 L +703.263 135.679 L +703.419 135.745 L +703.575 135.813 L +703.73 135.882 L +703.886 135.951 L +704.042 136.021 L +704.197 136.092 L +704.353 136.164 L +704.509 136.237 L +704.664 136.311 L +704.82 136.386 L +704.976 136.462 L +705.131 136.538 L +705.287 136.615 L +705.443 136.694 L +705.598 136.773 L +705.754 136.853 L +705.91 136.934 L +706.065 137.015 L +706.221 137.098 L +706.377 137.182 L +706.532 137.266 L +706.688 137.351 L +706.844 137.438 L +706.999 137.525 L +707.155 137.613 L +707.311 137.701 L +707.466 137.791 L +707.622 137.882 L +707.778 137.973 L +707.933 138.065 L +708.089 138.158 L +708.245 138.252 L +708.4 138.347 L +708.556 138.443 L +708.712 138.54 L +708.867 138.637 L +709.023 138.736 L +709.179 138.835 L +709.334 138.935 L +709.49 139.036 L +709.646 139.138 L +709.801 139.24 L +709.957 139.344 L +710.113 139.448 L +710.268 139.553 L +710.424 139.66 L +710.58 139.766 L +710.735 139.874 L +710.891 139.983 L +711.047 140.092 L +711.202 140.203 L +711.358 140.314 L +711.514 140.426 L +711.669 140.539 L +711.825 140.653 L +711.981 140.767 L +712.136 140.883 L +712.292 140.999 L +712.448 141.116 L +712.603 141.234 L +712.759 141.353 L +712.915 141.473 L +713.07 141.593 L +713.226 141.714 L +713.382 141.837 L +713.537 141.96 L +713.693 142.083 L +713.849 142.208 L +714.004 142.334 L +714.16 142.46 L +714.316 142.587 L +714.471 142.715 L +714.627 142.844 L +714.783 142.973 L +714.938 143.104 L +715.094 143.235 L +715.25 143.367 L +715.405 143.5 L +715.561 143.634 L +715.717 143.768 L +715.872 143.904 L +716.028 144.04 L +716.184 144.177 L +716.339 144.315 L +716.495 144.453 L +716.651 144.593 L +716.806 144.733 L +716.962 144.874 L +717.118 145.016 L +717.273 145.159 L +717.429 145.302 L +717.585 145.446 L +717.74 145.592 L +717.896 145.737 L +718.052 145.884 L +718.207 146.031 L +718.363 146.18 L +718.519 146.329 L +718.674 146.479 L +718.83 146.629 L +718.986 146.781 L +719.141 146.933 L +719.297 147.086 L +719.453 147.24 L +719.608 147.394 L +719.764 147.55 L +719.92 147.706 L +720.075 147.863 L +720.231 148.02 L +720.387 148.179 L +720.542 148.338 L +720.698 148.498 L +720.854 148.659 L +721.009 148.82 L +721.165 148.983 L +721.32 149.146 L +721.476 149.31 L +721.632 149.474 L +721.787 149.64 L +721.943 149.806 L +722.099 149.973 L +722.255 150.14 L +722.41 150.309 L +722.566 150.478 L +722.721 150.648 L +722.877 150.818 L +723.033 150.99 L +723.188 151.162 L +723.344 151.335 L +723.5 151.509 L +723.655 151.683 L +723.811 151.858 L +723.967 152.034 L +724.122 152.211 L +724.278 152.388 L +724.434 152.566 L +724.589 152.745 L +724.745 152.925 L +724.901 153.105 L +725.056 153.286 L +725.212 153.468 L +725.368 153.65 L +725.523 153.833 L +725.679 154.017 L +725.835 154.202 L +725.99 154.387 L +726.146 154.573 L +726.302 154.76 L +726.457 154.948 L +726.613 155.136 L +726.769 155.325 L +726.924 155.514 L +727.08 155.705 L +727.236 155.896 L +727.391 156.087 L +727.547 156.28 L +727.703 156.473 L +727.858 156.667 L +728.014 156.861 L +728.17 157.057 L +728.325 157.253 L +728.481 157.449 L +728.637 157.646 L +728.792 157.844 L +728.948 158.043 L +729.104 158.242 L +729.259 158.443 L +729.415 158.643 L +729.571 158.845 L +729.726 159.047 L +729.882 159.249 L +730.038 159.453 L +730.193 159.657 L +730.349 159.862 L +730.505 160.067 L +730.66 160.273 L +730.816 160.48 L +730.972 160.687 L +731.127 160.895 L +731.283 161.104 L +731.439 161.313 L +731.594 161.523 L +731.75 161.734 L +731.906 161.945 L +732.061 162.157 L +732.217 162.37 L +732.373 162.583 L +732.528 162.797 L +732.684 163.011 L +732.84 163.226 L +732.995 163.442 L +733.151 163.659 L +733.307 163.876 L +733.462 164.093 L +733.618 164.312 L +733.774 164.53 L +733.929 164.75 L +734.085 164.97 L +734.241 165.191 L +734.396 165.412 L +734.552 165.634 L +734.708 165.857 L +734.863 166.08 L +735.019 166.304 L +735.175 166.528 L +735.33 166.753 L +735.486 166.979 L +735.642 167.205 L +735.797 167.432 L +735.953 167.659 L +736.109 167.887 L +736.264 168.116 L +736.42 168.345 L +736.576 168.575 L +736.731 168.805 L +736.887 169.036 L +737.043 169.268 L +737.198 169.5 L +737.354 169.732 L +737.51 169.966 L +737.665 170.199 L +737.821 170.434 L +737.977 170.669 L +738.132 170.904 L +738.288 171.14 L +738.444 171.377 L +738.599 171.614 L +738.755 171.852 L +738.911 172.09 L +739.066 172.329 L +739.222 172.568 L +739.378 172.808 L +739.533 173.049 L +739.689 173.29 L +739.845 173.531 L +740 173.773 L +740.156 174.016 L +740.312 174.259 L +740.467 174.503 L +740.623 174.747 L +740.779 174.992 L +740.934 175.237 L +741.09 175.483 L +741.245 175.729 L +741.401 175.976 L +741.557 176.223 L +741.713 176.471 L +741.868 176.719 L +742.024 176.968 L +742.18 177.217 L +742.335 177.467 L +742.491 177.717 L +742.646 177.968 L +742.802 178.22 L +742.958 178.471 L +743.113 178.724 L +743.269 178.977 L +743.425 179.23 L +743.58 179.484 L +743.736 179.738 L +743.892 179.993 L +744.047 180.248 L +744.203 180.504 L +744.359 180.76 L +744.514 181.016 L +744.67 181.273 L +744.826 181.531 L +744.981 181.789 L +745.137 182.047 L +745.293 182.306 L +745.448 182.566 L +745.604 182.825 L +745.76 183.086 L +745.915 183.346 L +746.071 183.608 L +746.227 183.869 L +746.382 184.131 L +746.538 184.394 L +746.694 184.657 L +746.849 184.92 L +747.005 185.184 L +747.161 185.448 L +747.316 185.713 L +747.472 185.978 L +747.628 186.243 L +747.783 186.509 L +747.939 186.775 L +748.095 187.042 L +748.25 187.309 L +748.406 187.577 L +748.562 187.845 L +748.717 188.113 L +748.873 188.382 L +749.029 188.651 L +749.184 188.92 L +749.34 189.19 L +749.496 189.46 L +749.651 189.731 L +749.807 190.002 L +749.963 190.274 L +750.118 190.546 L +750.274 190.818 L +750.43 191.09 L +750.585 191.363 L +750.741 191.637 L +750.897 191.91 L +751.052 192.184 L +751.208 192.459 L +751.364 192.733 L +751.519 193.009 L +751.675 193.284 L +751.831 193.56 L +751.986 193.836 L +752.142 194.113 L +752.298 194.389 L +752.453 194.667 L +752.609 194.944 L +752.765 195.222 L +752.92 195.5 L +753.076 195.779 L +753.232 196.058 L +753.387 196.337 L +753.543 196.616 L +753.699 196.896 L +753.854 197.176 L +754.01 197.457 L +754.166 197.737 L +754.321 198.019 L +754.477 198.3 L +754.633 198.582 L +754.788 198.864 L +754.944 199.146 L +755.1 199.428 L +755.255 199.711 L +755.411 199.994 L +755.567 200.278 L +755.722 200.562 L +755.878 200.846 L +756.034 201.13 L +756.189 201.414 L +756.345 201.699 L +756.501 201.984 L +756.656 202.27 L +756.812 202.555 L +756.968 202.841 L +757.123 203.128 L +757.279 203.414 L +757.435 203.701 L +757.59 203.988 L +757.746 204.275 L +757.902 204.562 L +758.057 204.85 L +758.213 205.138 L +758.369 205.426 L +758.524 205.714 L +758.68 206.003 L +758.836 206.292 L +758.991 206.581 L +759.147 206.87 L +759.303 207.16 L +759.458 207.449 L +759.614 207.739 L +759.77 208.03 L +759.925 208.32 L +760.081 208.611 L +760.237 208.901 L +760.392 209.192 L +760.548 209.484 L +760.703 209.775 L +760.859 210.067 L +761.015 210.358 L +761.171 210.65 L +761.326 210.943 L +761.482 211.235 L +761.638 211.527 L +761.793 211.82 L +761.949 212.113 L +762.104 212.406 L +762.26 212.699 L +762.416 212.993 L +762.571 213.286 L +762.727 213.58 L +762.883 213.874 L +763.038 214.168 L +763.194 214.462 L +763.35 214.757 L +763.505 215.051 L +763.661 215.346 L +763.817 215.64 L +763.972 215.935 L +764.128 216.23 L +764.284 216.526 L +764.439 216.821 L +764.595 217.116 L +764.751 217.412 L +764.906 217.708 L +765.062 218.004 L +765.218 218.299 L +765.373 218.596 L +765.529 218.892 L +765.685 219.188 L +765.84 219.484 L +765.996 219.781 L +766.152 220.077 L +766.307 220.374 L +766.463 220.671 L +766.619 220.968 L +766.774 221.265 L +766.93 221.562 L +767.086 221.859 L +767.241 222.156 L +767.397 222.454 L +767.553 222.751 L +767.708 223.048 L +767.864 223.346 L +768.02 223.643 L +768.175 223.941 L +768.331 224.239 L +768.487 224.537 L +768.642 224.834 L +768.798 225.132 L +768.954 225.43 L +769.109 225.728 L +769.265 226.026 L +769.421 226.324 L +769.576 226.622 L +769.732 226.921 L +769.888 227.219 L +770.043 227.517 L +770.199 227.815 L +770.355 228.113 L +770.51 228.412 L +770.666 228.71 L +770.822 229.008 L +770.977 229.307 L +771.133 229.605 L +771.289 229.903 L +771.444 230.202 L +771.6 230.5 L +771.756 230.798 L +771.911 231.097 L +772.067 231.395 L +772.223 231.693 L +772.378 231.992 L +772.534 232.29 L +772.69 232.588 L +772.845 232.887 L +773.001 233.185 L +773.157 233.483 L +773.312 233.781 L +773.468 234.079 L +773.624 234.378 L +773.779 234.676 L +773.935 234.974 L +774.091 235.272 L +774.246 235.57 L +774.402 235.868 L +774.558 236.166 L +774.713 236.463 L +774.869 236.761 L +775.025 237.059 L +775.18 237.357 L +775.336 237.654 L +775.492 237.952 L +775.647 238.249 L +775.803 238.546 L +775.959 238.844 L +776.114 239.141 L +776.27 239.438 L +776.426 239.735 L +776.581 240.032 L +776.737 240.329 L +776.893 240.626 L +777.048 240.923 L +777.204 241.219 L +777.36 241.516 L +777.515 241.812 L +777.671 242.108 L +777.827 242.404 L +777.982 242.701 L +778.138 242.996 L +778.294 243.292 L +778.449 243.588 L +778.605 243.884 L +778.761 244.179 L +778.916 244.474 L +779.072 244.77 L +779.228 245.065 L +779.383 245.36 L +779.539 245.654 L +779.695 245.949 L +779.85 246.243 L +780.006 246.538 L +780.161 246.832 L +780.317 247.126 L +780.473 247.42 L +780.629 247.714 L +780.784 248.007 L +780.94 248.301 L +781.096 248.594 L +781.251 248.887 L +781.407 249.18 L +781.563 249.473 L +781.718 249.765 L +781.874 250.057 L +782.029 250.35 L +782.185 250.642 L +782.341 250.933 L +782.496 251.225 L +782.652 251.516 L +782.808 251.808 L +782.964 252.099 L +783.119 252.389 L +783.275 252.68 L +783.43 252.97 L +783.586 253.261 L +783.742 253.551 L +783.897 253.84 L +784.053 254.13 L +784.209 254.419 L +784.364 254.708 L +784.52 254.997 L +784.676 255.286 L +784.831 255.574 L +784.987 255.862 L +785.143 256.15 L +785.298 256.438 L +785.454 256.725 L +785.61 257.012 L +785.765 257.299 L +785.921 257.586 L +786.077 257.872 L +786.232 258.159 L +786.388 258.445 L +786.544 258.73 L +786.699 259.016 L +786.855 259.301 L +787.011 259.586 L +787.166 259.87 L +787.322 260.154 L +787.478 260.438 L +787.633 260.722 L +787.789 261.006 L +787.945 261.289 L +788.1 261.572 L +788.256 261.854 L +788.412 262.136 L +788.567 262.418 L +788.723 262.7 L +788.879 262.981 L +789.034 263.263 L +789.19 263.543 L +789.346 263.824 L +789.501 264.104 L +789.657 264.384 L +789.813 264.663 L +789.968 264.942 L +790.124 265.221 L +790.28 265.5 L +790.435 265.778 L +790.591 266.056 L +790.747 266.333 L +790.902 266.611 L +791.058 266.887 L +791.214 267.164 L +791.369 267.44 L +791.525 267.716 L +791.681 267.991 L +791.836 268.267 L +791.992 268.541 L +792.148 268.816 L +792.303 269.09 L +792.459 269.363 L +792.615 269.637 L +792.77 269.91 L +792.926 270.182 L +793.082 270.454 L +793.237 270.726 L +793.393 270.998 L +793.549 271.269 L +793.704 271.54 L +793.86 271.81 L +794.016 272.08 L +794.171 272.349 L +794.327 272.618 L +794.483 272.887 L +794.638 273.155 L +794.794 273.423 L +794.95 273.691 L +795.105 273.958 L +795.261 274.225 L +795.417 274.491 L +795.572 274.757 L +795.728 275.022 L +795.884 275.287 L +796.039 275.552 L +796.195 275.816 L +796.351 276.08 L +796.506 276.343 L +796.662 276.606 L +796.818 276.869 L +796.973 277.131 L +797.129 277.392 L +797.285 277.654 L +797.44 277.914 L +797.596 278.175 L +797.752 278.434 L +797.907 278.694 L +798.063 278.953 L +798.219 279.211 L +798.374 279.469 L +798.53 279.727 L +798.686 279.984 L +798.841 280.24 L +798.997 280.496 L +799.153 280.752 L +799.308 281.007 L +799.464 281.262 L +799.62 281.516 L +799.775 281.77 L +799.931 282.023 L +800.087 282.276 L +800.242 282.529 L +800.398 282.78 L +800.554 283.032 L +800.709 283.283 L +800.865 283.533 L +801.021 283.783 L +801.176 284.032 L +801.332 284.281 L +801.487 284.529 L +801.643 284.777 L +801.799 285.024 L +801.954 285.271 L +802.11 285.517 L +802.266 285.763 L +802.422 286.008 L +802.577 286.253 L +802.733 286.497 L +802.888 286.741 L +803.044 286.984 L +803.2 287.227 L +803.355 287.469 L +803.511 287.71 L +803.667 287.951 L +803.822 288.192 L +803.978 288.432 L +804.134 288.671 L +804.289 288.91 L +804.445 289.148 L +804.601 289.386 L +804.756 289.623 L +804.912 289.86 L +805.068 290.096 L +805.223 290.331 L +805.379 290.566 L +805.535 290.801 L +805.69 291.034 L +805.846 291.268 L +806.002 291.5 L +806.157 291.732 L +806.313 291.964 L +806.469 292.195 L +806.624 292.425 L +806.78 292.655 L +806.936 292.884 L +807.091 293.113 L +807.247 293.341 L +807.403 293.568 L +807.558 293.795 L +807.714 294.021 L +807.87 294.247 L +808.025 294.472 L +808.181 294.696 L +808.337 294.92 L +808.492 295.143 L +808.648 295.366 L +808.804 295.588 L +808.959 295.809 L +809.115 296.03 L +809.271 296.25 L +809.426 296.47 L +809.582 296.688 L +809.738 296.907 L +809.893 297.124 L +810.049 297.341 L +810.205 297.558 L +810.36 297.774 L +810.516 297.989 L +810.672 298.203 L +810.827 298.417 L +810.983 298.63 L +811.139 298.843 L +811.294 299.055 L +811.45 299.266 L +811.606 299.477 L +811.761 299.687 L +811.917 299.896 L +812.073 300.105 L +812.228 300.313 L +812.384 300.52 L +812.54 300.727 L +812.695 300.933 L +812.851 301.138 L +813.007 301.343 L +813.162 301.547 L +813.318 301.751 L +813.474 301.953 L +813.629 302.155 L +813.785 302.357 L +813.941 302.557 L +814.096 302.758 L +814.252 302.957 L +814.408 303.156 L +814.563 303.354 L +814.719 303.551 L +814.875 303.747 L +815.03 303.943 L +815.186 304.139 L +815.342 304.333 L +815.497 304.527 L +815.653 304.72 L +815.809 304.913 L +815.964 305.104 L +816.12 305.295 L +816.276 305.486 L +816.431 305.675 L +816.587 305.864 L +816.743 306.052 L +816.898 306.24 L +817.054 306.427 L +817.21 306.613 L +817.365 306.798 L +817.521 306.983 L +817.677 307.167 L +817.832 307.35 L +817.988 307.532 L +818.144 307.714 L +818.299 307.895 L +818.455 308.075 L +818.611 308.255 L +818.766 308.434 L +818.922 308.612 L +819.078 308.789 L +819.233 308.966 L +819.389 309.142 L +819.545 309.317 L +819.7 309.491 L +819.856 309.665 L +820.012 309.838 L +820.167 310.01 L +820.323 310.182 L +820.479 310.352 L +820.634 310.522 L +820.79 310.691 L +820.945 310.86 L +821.101 311.027 L +821.257 311.194 L +821.412 311.36 L +821.568 311.526 L +821.724 311.69 L +821.88 311.854 L +822.035 312.017 L +822.191 312.18 L +822.346 312.341 L +822.502 312.502 L +822.658 312.662 L +822.813 312.821 L +822.969 312.98 L +823.125 313.137 L +823.28 313.294 L +823.436 313.45 L +823.592 313.606 L +823.747 313.76 L +823.903 313.914 L +824.059 314.067 L +824.214 314.219 L +824.37 314.371 L +824.526 314.521 L +824.681 314.671 L +824.837 314.82 L +824.993 314.969 L +825.148 315.116 L +825.304 315.263 L +825.46 315.408 L +825.615 315.554 L +825.771 315.698 L +825.927 315.841 L +826.082 315.984 L +826.238 316.126 L +826.394 316.267 L +826.549 316.407 L +826.705 316.547 L +826.861 316.685 L +827.016 316.823 L +827.172 316.96 L +827.328 317.096 L +827.483 317.232 L +827.639 317.366 L +827.795 317.5 L +827.95 317.633 L +828.106 317.765 L +828.262 317.896 L +828.417 318.027 L +828.573 318.156 L +828.729 318.285 L +828.884 318.413 L +829.04 318.54 L +829.196 318.666 L +829.351 318.792 L +829.507 318.917 L +829.663 319.04 L +829.818 319.163 L +829.974 319.286 L +830.13 319.407 L +830.285 319.527 L +830.441 319.647 L +830.597 319.766 L +830.752 319.884 L +830.908 320.001 L +831.064 320.117 L +831.219 320.233 L +831.375 320.347 L +831.531 320.461 L +831.686 320.574 L +831.842 320.686 L +831.998 320.797 L +832.153 320.908 L +832.309 321.017 L +832.465 321.126 L +832.62 321.234 L +832.776 321.34 L +832.932 321.447 L +833.087 321.552 L +833.243 321.656 L +833.399 321.76 L +833.554 321.862 L +833.71 321.964 L +833.866 322.065 L +834.021 322.165 L +834.177 322.264 L +834.333 322.363 L +834.488 322.46 L +834.644 322.557 L +834.8 322.653 L +834.955 322.748 L +835.111 322.842 L +835.267 322.935 L +835.422 323.027 L +835.578 323.118 L +835.734 323.209 L +835.889 323.299 L +836.045 323.387 L +836.201 323.475 L +836.356 323.562 L +836.512 323.649 L +836.668 323.734 L +836.823 323.818 L +836.979 323.902 L +837.135 323.985 L +837.29 324.066 L +837.446 324.147 L +837.602 324.227 L +837.757 324.306 L +837.913 324.385 L +838.069 324.462 L +838.224 324.538 L +838.38 324.614 L +838.536 324.689 L +838.691 324.763 L +838.847 324.836 L +839.003 324.908 L +839.158 324.979 L +839.314 325.049 L +839.47 325.118 L +839.625 325.187 L +839.781 325.255 L +839.937 325.321 L +840.092 325.387 L +840.248 325.452 L +840.404 325.516 L +840.559 325.579 L +840.715 325.641 L +840.87 325.703 L +841.026 325.763 L +841.182 325.823 L +841.338 325.881 L +841.493 325.939 L +841.649 325.996 L +841.805 326.052 L +841.96 326.107 L +842.116 326.161 L +842.271 326.214 L +842.427 326.267 L +842.583 326.318 L +842.738 326.369 L +842.894 326.418 L +843.05 326.467 L +843.205 326.515 L +843.361 326.562 L +843.517 326.608 L +843.672 326.653 L +843.828 326.697 L +843.984 326.741 L +844.139 326.783 L +844.295 326.825 L +844.451 326.865 L +844.606 326.905 L +844.762 326.944 L +844.918 326.982 L +845.073 327.019 L +845.229 327.055 L +845.385 327.09 L +845.54 327.124 L +845.696 327.157 L +845.852 327.19 L +846.007 327.221 L +846.163 327.252 L +846.319 327.282 L +846.474 327.311 L +846.63 327.338 L +846.786 327.365 L +846.941 327.391 L +847.097 327.417 L +847.253 327.441 L +847.408 327.464 L +847.564 327.486 L +847.72 327.508 L +847.875 327.529 L +848.031 327.548 L +848.187 327.567 L +848.342 327.585 L +848.498 327.602 L +848.654 327.618 L +848.809 327.633 L +848.965 327.647 L +849.121 327.66 L +849.276 327.673 L +849.432 327.684 L +849.588 327.695 L +849.743 327.704 L +849.899 327.713 L +850.055 327.721 L +850.21 327.728 L +850.366 327.734 L +850.522 327.739 L +850.677 327.743 L +850.833 327.746 L +850.989 327.748 L +851.144 327.75 L +851.3 327.75 L +851.456 327.75 L +851.611 327.748 L +851.767 327.746 L +851.923 327.743 L +852.078 327.739 L +852.234 327.734 L +852.39 327.728 L +852.545 327.721 L +852.701 327.713 L +852.857 327.704 L +853.012 327.695 L +853.168 327.684 L +853.324 327.673 L +853.479 327.66 L +853.635 327.647 L +853.791 327.633 L +853.946 327.618 L +854.102 327.602 L +854.258 327.585 L +854.413 327.567 L +854.569 327.548 L +854.725 327.529 L +854.88 327.508 L +855.036 327.486 L +855.192 327.464 L +855.347 327.441 L +855.503 327.417 L +855.659 327.391 L +855.814 327.365 L +855.97 327.338 L +856.126 327.311 L +856.281 327.282 L +856.437 327.252 L +856.593 327.221 L +856.748 327.19 L +856.904 327.157 L +857.06 327.124 L +857.215 327.09 L +857.371 327.055 L +857.527 327.019 L +857.682 326.982 L +857.838 326.944 L +857.994 326.905 L +858.149 326.865 L +858.305 326.825 L +858.461 326.783 L +858.616 326.741 L +858.772 326.697 L +858.928 326.653 L +859.083 326.608 L +859.239 326.562 L +859.395 326.515 L +859.55 326.467 L +859.706 326.418 L +859.862 326.369 L +860.017 326.318 L +860.173 326.267 L +860.328 326.214 L +860.484 326.161 L +860.64 326.107 L +860.796 326.052 L +860.951 325.996 L +861.107 325.939 L +861.263 325.881 L +861.418 325.823 L +861.574 325.763 L +861.729 325.703 L +861.885 325.641 L +862.041 325.579 L +862.196 325.516 L +862.352 325.452 L +862.508 325.387 L +862.663 325.321 L +862.819 325.255 L +862.975 325.187 L +863.13 325.118 L +863.286 325.049 L +863.442 324.979 L +863.597 324.908 L +863.753 324.836 L +863.909 324.763 L +864.064 324.689 L +864.22 324.614 L +864.376 324.538 L +864.531 324.462 L +864.687 324.385 L +864.843 324.306 L +864.998 324.227 L +865.154 324.147 L +865.31 324.066 L +865.465 323.985 L +865.621 323.902 L +865.777 323.818 L +865.932 323.734 L +866.088 323.649 L +866.244 323.562 L +866.399 323.475 L +866.555 323.387 L +866.711 323.299 L +866.866 323.209 L +867.022 323.118 L +867.178 323.027 L +867.333 322.935 L +867.489 322.842 L +867.645 322.748 L +867.8 322.653 L +867.956 322.557 L +868.112 322.46 L +868.267 322.363 L +868.423 322.264 L +868.579 322.165 L +868.734 322.065 L +868.89 321.964 L +869.046 321.862 L +869.201 321.76 L +869.357 321.656 L +869.513 321.552 L +869.668 321.447 L +869.824 321.34 L +869.98 321.234 L +870.135 321.126 L +870.291 321.017 L +870.447 320.908 L +870.602 320.797 L +870.758 320.686 L +870.914 320.574 L +871.069 320.461 L +871.225 320.347 L +871.381 320.233 L +871.536 320.117 L +871.692 320.001 L +871.848 319.884 L +872.003 319.766 L +872.159 319.647 L +872.315 319.527 L +872.47 319.407 L +872.626 319.286 L +872.782 319.163 L +872.937 319.04 L +873.093 318.917 L +873.249 318.792 L +873.404 318.666 L +873.56 318.54 L +873.716 318.413 L +873.871 318.285 L +874.027 318.156 L +874.183 318.027 L +874.338 317.896 L +874.494 317.765 L +874.65 317.633 L +874.805 317.5 L +874.961 317.366 L +875.117 317.232 L +875.272 317.096 L +875.428 316.96 L +875.584 316.823 L +875.739 316.685 L +875.895 316.547 L +876.051 316.407 L +876.206 316.267 L +876.362 316.126 L +876.518 315.984 L +876.673 315.841 L +876.829 315.698 L +876.985 315.554 L +877.14 315.408 L +877.296 315.263 L +877.452 315.116 L +877.607 314.969 L +877.763 314.82 L +877.919 314.671 L +878.074 314.521 L +878.23 314.371 L +878.386 314.219 L +878.541 314.067 L +878.697 313.914 L +878.853 313.76 L +879.008 313.606 L +879.164 313.45 L +879.32 313.294 L +879.475 313.137 L +879.631 312.98 L +879.786 312.821 L +879.942 312.662 L +880.098 312.502 L +880.254 312.341 L +880.409 312.18 L +880.565 312.017 L +880.721 311.854 L +880.876 311.69 L +881.032 311.526 L +881.188 311.36 L +881.343 311.194 L +881.499 311.027 L +881.654 310.86 L +881.81 310.691 L +881.966 310.522 L +882.121 310.352 L +882.277 310.182 L +882.433 310.01 L +882.589 309.838 L +882.744 309.665 L +882.9 309.491 L +883.055 309.317 L +883.211 309.142 L +883.367 308.966 L +883.522 308.789 L +883.678 308.612 L +883.834 308.434 L +883.989 308.255 L +884.145 308.075 L +884.301 307.895 L +884.456 307.714 L +884.612 307.532 L +884.768 307.35 L +884.923 307.167 L +885.079 306.983 L +885.235 306.798 L +885.39 306.613 L +885.546 306.427 L +885.702 306.24 L +885.857 306.052 L +886.013 305.864 L +886.169 305.675 L +886.324 305.486 L +886.48 305.295 L +886.636 305.104 L +886.791 304.913 L +886.947 304.72 L +887.103 304.527 L +887.258 304.333 L +887.414 304.139 L +887.57 303.943 L +887.725 303.747 L +887.881 303.551 L +888.037 303.354 L +888.192 303.156 L +888.348 302.957 L +888.504 302.758 L +888.659 302.557 L +888.815 302.357 L +888.971 302.155 L +889.126 301.953 L +889.282 301.751 L +889.438 301.547 L +889.593 301.343 L +889.749 301.138 L +889.905 300.933 L +890.06 300.727 L +890.216 300.52 L +890.372 300.313 L +890.527 300.105 L +890.683 299.896 L +890.839 299.687 L +890.994 299.477 L +891.15 299.266 L +891.306 299.055 L +891.461 298.843 L +891.617 298.63 L +891.773 298.417 L +891.928 298.203 L +892.084 297.989 L +892.24 297.774 L +892.395 297.558 L +892.551 297.341 L +892.707 297.124 L +892.862 296.907 L +893.018 296.688 L +893.174 296.47 L +893.329 296.25 L +893.485 296.03 L +893.641 295.809 L +893.796 295.588 L +893.952 295.366 L +894.108 295.143 L +894.263 294.92 L +894.419 294.696 L +894.575 294.472 L +894.73 294.247 L +894.886 294.021 L +895.042 293.795 L +895.197 293.568 L +895.353 293.341 L +895.509 293.113 L +895.664 292.884 L +895.82 292.655 L +895.976 292.425 L +896.131 292.195 L +896.287 291.964 L +896.443 291.732 L +896.598 291.5 L +896.754 291.268 L +896.91 291.034 L +897.065 290.801 L +897.221 290.566 L +897.377 290.331 L +897.532 290.096 L +897.688 289.86 L +897.844 289.623 L +897.999 289.386 L +898.155 289.148 L +898.311 288.91 L +898.466 288.671 L +898.622 288.432 L +898.778 288.192 L +898.933 287.951 L +899.089 287.71 L +899.245 287.469 L +899.4 287.227 L +899.556 286.984 L +899.712 286.741 L +899.867 286.497 L +900.023 286.253 L +900.179 286.008 L +900.334 285.763 L +900.49 285.517 L +900.646 285.271 L +900.801 285.024 L +900.957 284.777 L +901.112 284.529 L +901.268 284.281 L +901.424 284.032 L +901.579 283.783 L +901.735 283.533 L +901.891 283.283 L +902.047 283.032 L +902.202 282.78 L +902.358 282.529 L +902.513 282.276 L +902.669 282.023 L +902.825 281.77 L +902.98 281.516 L +903.136 281.262 L +903.292 281.007 L +903.447 280.752 L +903.603 280.496 L +903.759 280.24 L +903.914 279.984 L +904.07 279.727 L +904.226 279.469 L +904.381 279.211 L +904.537 278.953 L +904.693 278.694 L +904.848 278.434 L +905.004 278.175 L +905.16 277.914 L +905.315 277.654 L +905.471 277.392 L +905.627 277.131 L +905.782 276.869 L +905.938 276.606 L +906.094 276.343 L +906.249 276.08 L +906.405 275.816 L +906.561 275.552 L +906.716 275.287 L +906.872 275.022 L +907.028 274.757 L +907.183 274.491 L +907.339 274.225 L +907.495 273.958 L +907.65 273.691 L +907.806 273.423 L +907.962 273.155 L +908.117 272.887 L +908.273 272.618 L +908.429 272.349 L +908.584 272.08 L +908.74 271.81 L +908.896 271.54 L +909.051 271.269 L +909.207 270.998 L +909.363 270.726 L +909.518 270.454 L +909.674 270.182 L +909.83 269.91 L +909.985 269.637 L +910.141 269.363 L +910.297 269.09 L +910.452 268.816 L +910.608 268.541 L +910.764 268.267 L +910.919 267.991 L +911.075 267.716 L +911.231 267.44 L +911.386 267.164 L +911.542 266.887 L +911.698 266.611 L +911.853 266.333 L +912.009 266.056 L +912.165 265.778 L +912.32 265.5 L +912.476 265.221 L +912.632 264.942 L +912.787 264.663 L +912.943 264.384 L +913.099 264.104 L +913.254 263.824 L +913.41 263.543 L +913.566 263.263 L +913.721 262.981 L +913.877 262.7 L +914.033 262.418 L +914.188 262.136 L +914.344 261.854 L +914.5 261.572 L +914.655 261.289 L +914.811 261.006 L +914.967 260.722 L +915.122 260.438 L +915.278 260.154 L +915.434 259.87 L +915.589 259.586 L +915.745 259.301 L +915.901 259.016 L +916.056 258.73 L +916.212 258.445 L +916.368 258.159 L +916.523 257.872 L +916.679 257.586 L +916.835 257.299 L +916.99 257.012 L +917.146 256.725 L +917.302 256.438 L +917.457 256.15 L +917.613 255.862 L +917.769 255.574 L +917.924 255.286 L +918.08 254.997 L +918.236 254.708 L +918.391 254.419 L +918.547 254.13 L +918.703 253.84 L +918.858 253.551 L +919.014 253.261 L +919.17 252.97 L +919.325 252.68 L +919.481 252.389 L +919.637 252.099 L +919.792 251.808 L +919.948 251.516 L +920.104 251.225 L +920.259 250.933 L +920.415 250.642 L +920.57 250.35 L +920.726 250.057 L +920.882 249.765 L +921.037 249.473 L +921.193 249.18 L +921.349 248.887 L +921.505 248.594 L +921.66 248.301 L +921.816 248.007 L +921.971 247.714 L +922.127 247.42 L +922.283 247.126 L +922.438 246.832 L +922.594 246.538 L +922.75 246.243 L +922.905 245.949 L +923.061 245.654 L +923.217 245.36 L +923.372 245.065 L +923.528 244.77 L +923.684 244.474 L +923.839 244.179 L +923.995 243.884 L +924.151 243.588 L +924.306 243.292 L +924.462 242.996 L +924.618 242.701 L +924.773 242.404 L +924.929 242.108 L +925.085 241.812 L +925.24 241.516 L +925.396 241.219 L +925.552 240.923 L +925.707 240.626 L +925.863 240.329 L +926.019 240.032 L +926.174 239.735 L +926.33 239.438 L +926.486 239.141 L +926.641 238.844 L +926.797 238.546 L +926.953 238.249 L +927.108 237.952 L +927.264 237.654 L +927.42 237.357 L +927.575 237.059 L +927.731 236.761 L +927.887 236.463 L +928.042 236.166 L +928.198 235.868 L +928.354 235.57 L +928.509 235.272 L +928.665 234.974 L +928.821 234.676 L +928.976 234.378 L +929.132 234.079 L +929.288 233.781 L +929.443 233.483 L +929.599 233.185 L +929.755 232.887 L +929.91 232.588 L +930.066 232.29 L +930.222 231.992 L +930.377 231.693 L +930.533 231.395 L +930.689 231.097 L +930.844 230.798 L +931 230.5 L +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +1 GC +N +767 126 M +767 49 L +918 49 L +918 126 L +cp +f +GR +GS +[0.75 0 0 0.75 603 60.625] CT +/Helvetica 14.4 F +GS +[1 0 0 1 0 0] CT +0 4.5 moveto +1 -1 scale +(0.5 Hz + 2.0 Hz) t +GR +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0 0.447 0.741 RC +1 LJ +2.667 LW +N +771 80.5 M +801 80.5 L +S +GR +GS +[0.75 0 0 0.75 603 73.75] CT +/Helvetica 14.4 F +GS +[1 0 0 1 0 0] CT +0 4.5 moveto +1 -1 scale +(2.0 Hz) t +GR +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.851 0.325 0.098 RC +1 LJ +2.667 LW +N +771 98 M +801 98 L +S +GR +GS +[0.75 0 0 0.75 603 86.875] CT +/Helvetica 14.4 F +GS +[1 0 0 1 0 0] CT +0 4.5 moveto +1 -1 scale +(0.5 Hz) t +GR +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.929 0.694 0.125 RC +1 LJ +2.667 LW +N +771 115.5 M +801 115.5 L +S +GR +GS +[0.75 0 0 0.75 631.875 44.875] CT +/Helvetica-Bold 14.4 F +GS +[1 0 0 1 0 0] CT +-57.5 4.5 moveto +1 -1 scale +(Stimulus: Sine) t +GR +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +10.0 ML +0.667 LW +N +767 126 M +767 49 L +918 49 L +918 126 L +cp +S +GR +GS +[0.75 0 0 0.75 0 0.25] CT +0.149 GC +1 LJ +0.667 LW +N +767 70 M +918 70 L +S +GR +%%Trailer +%%Pages: 1 +%%EOF diff --git a/doc/noise.lyx b/doc/noise.lyx index 2afd1c9..e02f717 100644 --- a/doc/noise.lyx +++ b/doc/noise.lyx @@ -65,7 +65,7 @@ \begin_body \begin_layout Title -Noise Amplitude in NeuroField +Noise Amplitude in NFTsim \end_layout \begin_layout Author @@ -81,8 +81,8 @@ Introduction \end_layout \begin_layout Standard -Correctly calculating the noise amplitude for NeuroField is critical when - comparing the power spectrum in NeuroField to analytic predictions. +Correctly calculating the noise amplitude for NFTsim is critical when + comparing the power spectrum in NFTsim to analytic predictions. In the analytic work, we work almost exclusively in Fourier space, and use white noise with \end_layout @@ -135,10 +135,10 @@ s \end_layout \begin_layout Standard -In NeuroField, white noise is drawn from a Gaussian distribution at each +In NFTsim, white noise is drawn from a Gaussian distribution at each node, at each point in time. There is a relationship between the mean and standard deviation of the - Gaussian distribution used in NeuroField, and between + Gaussian distribution used in NFTsim, and between \begin_inset Formula $\phi_{n}^{(0)}$ \end_inset @@ -156,7 +156,7 @@ In NeuroField, white noise is drawn from a Gaussian distribution at each \begin_inset Formula $\phi_{n}(k,\omega)$ \end_inset - which are related to the standard deviation of the NeuroField Gaussian + which are related to the standard deviation of the NFTsim Gaussian distribution. \end_layout @@ -721,7 +721,7 @@ When a plot of the power spectrum is made in Matlab, dividing by the transfer ). Also, this value corresponds to the single sided power spectral density. - In NeuroField, we require the full power spectrum including negative frequency + In NFTsim, we require the full power spectrum including negative frequency components. Therefore, the value of \begin_inset Formula $\phi_{n}^{2}(f)$ @@ -754,7 +754,7 @@ Therefore, once we have chosen \begin_inset Formula $\phi_{n}^{2}(\omega)$ \end_inset - we are able to calculate the appropriate noise amplitude in NeuroField + we are able to calculate the appropriate noise amplitude in NFTsim using the relation \end_layout @@ -949,7 +949,7 @@ s \end_inset we can calculate the corresponding standard deviation for the noise in - NeuroField using the previously derived correspondance. + NFTsim using the previously derived correspondance. At a sampling rate of 10000 Hz, we find \end_layout @@ -982,7 +982,7 @@ s \begin_inset Formula $^{-1}$ \end_inset - compared with NeuroField using the above noise amplitud and sampling rates. + compared with NFTsim using the above noise amplitud and sampling rates. In this cortical network, the parameter values used were \begin_inset Formula $\nu_{ee}=1$ \end_inset @@ -1205,12 +1205,12 @@ The end result is that Parseval's theorem is satisfied in Matlab as a direct \begin_layout Standard The same problem exists when considering spatial sampling. The size of the cortex is assumed to be 50 x 50cm, which is discretized - in NeuroField when solving the wave equation for propagation of + in NFTsim when solving the wave equation for propagation of \begin_inset Formula $\phi_{e}$ \end_inset in the cortex. - NeuroField allows the user to pick the number of nodes in each direction + NFTsim allows the user to pick the number of nodes in each direction along the grid, subject to the constraints \end_layout @@ -1248,7 +1248,7 @@ However, an additional effect is that the noise amplitude depends on the \end_inset decreased as the sampling rate increased for the same standard deviation - of noise in NeuroField. + of noise in NFTsim. This is in fact exactly the same scenario, because when the physical size of the cortex is fixed, changing the number of nodes alters the spatial sampling frequency (samples per meter). @@ -1384,7 +1384,7 @@ Cortex only network (3D) \begin_layout Standard We now consider the same cortical-only network, only now allowing for spatial variation. - This was achieved by running NeuroField with 400 nodes, such that + This was achieved by running NFTsim with 400 nodes, such that \begin_inset Formula $\Delta x=0.025$ \end_inset @@ -1402,7 +1402,7 @@ s \end_inset . - Numerical integration was performed using NeuroField in exactly the same + Numerical integration was performed using NFTsim in exactly the same way as the 1D case, and the power spectral density was evaluted consistent with the scalings required by Parseval's theorem (dividing by total number of elements, dividing by the frequency bin size, summing over angular wavenumbe @@ -1516,7 +1516,7 @@ Finally, we can test this noise amplitude for the full corticothalamic model. \end_inset . - Also, in NeuroField we replace the sigmoid response with a linearized response, + Also, in NFTsim we replace the sigmoid response with a linearized response, to eliminate nonlinear effects that are not included in the analytic power spectrum. Comparing the resulting power spectra shows an excellent match between @@ -1578,11 +1578,11 @@ When solving over a 2D grid, users can specify \begin_inset Formula $\Delta x$ \end_inset - in the NeuroField configuration file. - In this case, NeuroField will perform the rescaling appropriately. + in the NFTsim configuration file. + In this case, NFTsim will perform the rescaling appropriately. For a 1D system with only a single node (which is incapable of using the wave propagator), users should use the conversion formula in this document. - The calculation of the power spectrum based on NeuroField output is included + The calculation of the power spectrum based on NFTsim output is included in the helper script \family typewriter nf_spatial_spectrum.m @@ -1594,7 +1594,7 @@ nf_spatial_spectrum.m \end_inset -values included, and how to implement volume conduction filtering. - It accepts a NeuroField output object, and parameters for segmenting, limiting + It accepts a NFTsim output object, and parameters for segmenting, limiting \begin_inset Formula $k$ \end_inset diff --git a/nf_conf.vim b/nf_conf.vim index 22a7a64..d785ec9 100644 --- a/nf_conf.vim +++ b/nf_conf.vim @@ -27,4 +27,4 @@ hi def link CntKey preproc hi def link CntI preproc hi def link Choice statement -let b:current_syntax = "neurofield" +let b:current_syntax = "nftsim" diff --git a/nf_configs b/nf_configs index 572e4cb..5db031b 100755 --- a/nf_configs +++ b/nf_configs @@ -6,7 +6,7 @@ # ./nf_configs --help # #DESCRIPTION: -# A script for checking the output from the neurofield repo's .conf files +# A script for checking the output from the nftsim repo's .conf files # against their expected test output. The expected/test output is stored in # the directory # ./test/data/configs/ @@ -32,11 +32,11 @@ declare -r INPUTARG1 INPUTARG2 SCRIPTDIR="$(dirname "${BASH_SOURCE[0]}")" -neurofield_exists(){ - if [[ -e "$SCRIPTDIR"/bin/neurofield ]]; then +nftsim_exists(){ + if [[ -e "$SCRIPTDIR"/bin/nftsim ]]; then return 0 else - printf '%s\n' "The neurofield executable doesn't exist, run make." + printf '%s\n' "The nftsim executable doesn't exist, run make." return 1 fi } @@ -46,12 +46,12 @@ parse_command_flags(){ #check for command line switches case "$INPUTARG1" in --regenerate|-r) - neurofield_exists || return 1 + nftsim_exists || return 1 regenerate_output_file "$INPUTARG2" return "$?" ;; --check|-c) - neurofield_exists || return 1 + nftsim_exists || return 1 if [[ "$INPUTARG2" = 'all' ]]; then check_all return "$?" @@ -63,7 +63,7 @@ parse_command_flags(){ ;; --clean) #Remove files left around by calls to --check that found differences. - rm -f /tmp/neurofield_* + rm -f /tmp/nftsim_* return "$?" ;; --help|-h|-?) @@ -80,7 +80,7 @@ msg_help(){ printf ' %s\n\n' "nf_configs -- ''" printf ' %s\n' "Modes:" printf '\n%s\n' " --check" - printf '%s\n' " Check if the output from neurofield has changed for a specified config file." + printf '%s\n' " Check if the output from nftsim has changed for a specified config file." printf '%s\n' " For example, to check the output of the 'example.conf' file, run:" printf '%s\n' " ./nf_configs --check 'example'" printf '%s\n' " or:" @@ -116,11 +116,11 @@ set_output_file(){ } # Run the config file provided as an argument, the first arg is expected -# to be a relative(to neurofield) path to the config file. +# to be a relative(to nftsim) path to the config file. run_config(){ local config_file="$1" local output_file - local neurofield_status + local nftsim_status #If run_config() was called with a second arg use it as the output_file if (( $# > 1 )); then @@ -133,18 +133,18 @@ run_config(){ [[ -d "$output_dir" ]] || mkdir --parents "$output_dir" fi - #Run neurofield for the requested config file - "$SCRIPTDIR/bin/neurofield" -i "$config_file" -o "$output_file" - neurofield_status="$?" + #Run nftsim for the requested config file + "$SCRIPTDIR/bin/nftsim" -i "$config_file" -o "$output_file" + nftsim_status="$?" #If the run was successful then gzip the resulting file. - if ((neurofield_status == 0)); then + if ((nftsim_status == 0)); then gzip --force "$output_file" else - printf "$ERROR_CLR %s\n" "Failed running: $SCRIPTDIR/bin/neurofield -i $config_file -o $output_file" + printf "$ERROR_CLR %s\n" "Failed running: $SCRIPTDIR/bin/nftsim -i $config_file -o $output_file" fi - return "$neurofield_status" + return "$nftsim_status" } get_all_config_files(){ @@ -166,7 +166,7 @@ regenerate_output_file(){ done return 0 elif [[ "$config_file" == "changed" ]]; then - [[ -f "/tmp/neurofield_changed_output_list_$(whoami).txt" ]] || { printf '%s\n' 'No changed list.'; return 1; } + [[ -f "/tmp/nftsim_changed_output_list_$(whoami).txt" ]] || { printf '%s\n' 'No changed list.'; return 1; } local regen_file local -i regen_errors=0 while read -r output_to_regenerate ; do @@ -176,7 +176,7 @@ regenerate_output_file(){ printf '%s\n' "Regenerating '$regen_file'..." set_output_file "$regen_file" if ! run_config "$regen_file"; then ((++regen_errors)); fi - done < "/tmp/neurofield_changed_output_list_$(whoami).txt" + done < "/tmp/nftsim_changed_output_list_$(whoami).txt" if ((regen_errors!=0)); then printf '%s\n' "There were '$regen_errors' errors while regenerating changed output." return "$regen_errors" @@ -199,7 +199,7 @@ regenerate_output_file(){ } check_all(){ - local -r changed_ouput_list="/tmp/neurofield_changed_output_list_$(whoami).txt" + local -r changed_ouput_list="/tmp/nftsim_changed_output_list_$(whoami).txt" [[ -f "$changed_ouput_list" ]] && rm -f "$changed_ouput_list" local error_count=0 local conf_count=0 @@ -223,7 +223,7 @@ check_all(){ } #Generates a temporary output file in /tmp/ for a specified config file and -#compares it to the corresponding output file in neurofield/test/data/configs/ +#compares it to the corresponding output file in nftsim/test/data/configs/ check_output_file(){ local config_file="$1" local config_file_name @@ -234,14 +234,14 @@ check_output_file(){ config_file="$(find "$SCRIPTDIR/configs" -maxdepth 3 -type f -name "${config_file}.conf")" fi - #Compare the current output of neurofield against stored output. + #Compare the current output of nftsim against stored output. if [[ -f "$config_file" ]]; then set_output_file "$config_file" [[ -f "${OUTPUT_FILE}.gz" ]] || { printf "$ERROR_CLR %s\n" "No existing file to check against."; return 1; } config_file_name="$(basename "$config_file")" - #Path to file containing output of current neurofield. - OUTPUT_FILE_TMP="$(mktemp --tmpdir="/tmp" --suffix=.output neurofield_"$config_file_name"-XXXX 2>/dev/null \ - || mktemp /tmp/neurofield_"$config_file_name".XXXX)" #Alternative for OSX + #Path to file containing output of current nftsim. + OUTPUT_FILE_TMP="$(mktemp --tmpdir="/tmp" --suffix=.output nftsim_"$config_file_name"-XXXX 2>/dev/null \ + || mktemp /tmp/nftsim_"$config_file_name".XXXX)" #Alternative for OSX run_config "$config_file" "$OUTPUT_FILE_TMP" || return 1 diff -q <(zcat "${OUTPUT_FILE_TMP}.gz") <(zcat "${OUTPUT_FILE}.gz") &> /dev/null DIFF_STATUS="$?" #NOTE: No-diff = 0; diff = 1; error = 2 diff --git a/src/array.h b/src/array.h index 0378caf..d9e69f5 100644 --- a/src/array.h +++ b/src/array.h @@ -6,8 +6,8 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_ARRAY_H -#define NEUROFIELD_SRC_ARRAY_H +#ifndef NFTSIM_SRC_ARRAY_H +#define NFTSIM_SRC_ARRAY_H // C++ standard library headers #include // std::vector; @@ -88,4 +88,4 @@ typename Array::size_type Array::size() const { return m.size(); } -#endif //NEUROFIELD_SRC_ARRAY_H +#endif //NFTSIM_SRC_ARRAY_H diff --git a/src/bcm.cpp b/src/bcm.cpp index 71fcedc..9cb84d7 100644 --- a/src/bcm.cpp +++ b/src/bcm.cpp @@ -9,7 +9,7 @@ // Main module header #include "bcm.h" // BCM; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "de.h" // RK4; diff --git a/src/bcm.h b/src/bcm.h index 0b3c656..fbb940c 100644 --- a/src/bcm.h +++ b/src/bcm.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_BCM_H -#define NEUROFIELD_SRC_BCM_H +#ifndef NFTSIM_SRC_BCM_H +#define NFTSIM_SRC_BCM_H -// Other neurofield headers +// Other nftsim headers #include "cadp.h" // CaDP; #include "configf.h" // Configf; #include "output.h" // Output; @@ -70,4 +70,4 @@ class BCM : public CaDP { void output( Output& output ) const override; }; -#endif //NEUROFIELD_SRC_BCM_H +#endif //NFTSIM_SRC_BCM_H diff --git a/src/bcmlong.cpp b/src/bcmlong.cpp index ecea3e7..ddc940a 100644 --- a/src/bcmlong.cpp +++ b/src/bcmlong.cpp @@ -9,7 +9,7 @@ // Main module header #include "bcmlong.h" // BCMLong; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "de.h" // RK4; #include "output.h" // Output; diff --git a/src/bcmlong.h b/src/bcmlong.h index 93e980f..ca4adc8 100644 --- a/src/bcmlong.h +++ b/src/bcmlong.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_BCMLONG_H -#define NEUROFIELD_SRC_BCMLONG_H +#ifndef NFTSIM_SRC_BCMLONG_H +#define NFTSIM_SRC_BCMLONG_H -// Other neurofield headers +// Other nftsim headers #include "bcm.h" // BCM; #include "configf.h" // Configf; #include "de.h" // RK4; @@ -38,4 +38,4 @@ class BCMLong : public BCM { void output( Output& output ) const override; }; -#endif //NEUROFIELD_SRC_BCMLONG_H +#endif //NFTSIM_SRC_BCMLONG_H diff --git a/src/burst.cpp b/src/burst.cpp index 7f612b0..2a6ecdf 100644 --- a/src/burst.cpp +++ b/src/burst.cpp @@ -9,7 +9,7 @@ // Main module header #include "burst.h" // BurstResponse; -// Other neurofield headers +// Other nftsim headers #include "array.h" // Array; #include "configf.h" // Configf; #include "dendrite.h" // Dendrite; diff --git a/src/burst.h b/src/burst.h index b888b01..4808a22 100644 --- a/src/burst.h +++ b/src/burst.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_BURST_H -#define NEUROFIELD_SRC_BURST_H +#ifndef NFTSIM_SRC_BURST_H +#define NFTSIM_SRC_BURST_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "de.h" // DE; RK4; #include "output.h" // Output; @@ -64,5 +64,5 @@ class BurstResponse : public FiringResponse { //derived class; constructor initi void output( Output& output ) const override; //vector of Output ptrs filled by }; -#endif //NEUROFIELD_SRC_BURST_H +#endif //NFTSIM_SRC_BURST_H diff --git a/src/cadp.cpp b/src/cadp.cpp index 601ce75..3b37fd5 100644 --- a/src/cadp.cpp +++ b/src/cadp.cpp @@ -9,7 +9,7 @@ // Main module header #include "cadp.h" // CaDP; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "output.h" // Output; #include "population.h" // Population; diff --git a/src/cadp.h b/src/cadp.h index 47a22a4..9a5ada5 100644 --- a/src/cadp.h +++ b/src/cadp.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_CADP_H -#define NEUROFIELD_SRC_CADP_H +#ifndef NFTSIM_SRC_CADP_H +#define NFTSIM_SRC_CADP_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "de.h" // DE; RK4; @@ -72,4 +72,4 @@ class CaDP : public Coupling { void output( Output& output ) const override; }; -#endif //NEUROFIELD_SRC_CADP_H +#endif //NFTSIM_SRC_CADP_H diff --git a/src/configf.h b/src/configf.h index ba5982e..934af11 100644 --- a/src/configf.h +++ b/src/configf.h @@ -6,8 +6,8 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_CONFIGF_H -#define NEUROFIELD_SRC_CONFIGF_H +#ifndef NFTSIM_SRC_CONFIGF_H +#define NFTSIM_SRC_CONFIGF_H // C++ standard library headers #include // std::ifstream; tellg; seekg; @@ -109,4 +109,4 @@ template bool Configf::optional( const std::string& param, T& ret, int return false; } -#endif //NEUROFIELD_SRC_CONFIGF_H +#endif //NFTSIM_SRC_CONFIGF_H diff --git a/src/coupling.cpp b/src/coupling.cpp index 4b9cf53..8e9bbe9 100644 --- a/src/coupling.cpp +++ b/src/coupling.cpp @@ -9,7 +9,7 @@ // Main module header #include "coupling.h" // Coupling; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "output.h" // Output; #include "population.h" // Population; diff --git a/src/coupling.h b/src/coupling.h index 1c67132..3e910a1 100644 --- a/src/coupling.h +++ b/src/coupling.h @@ -6,13 +6,13 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_COUPLING_H -#define NEUROFIELD_SRC_COUPLING_H +#ifndef NFTSIM_SRC_COUPLING_H +#define NFTSIM_SRC_COUPLING_H // Forward declaration to break circular collaboration class Coupling; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "nf.h" // NF; #include "output.h" // Output; @@ -52,4 +52,4 @@ double Coupling::operator[]( size_type node ) const { return P[node]; } -#endif //NEUROFIELD_SRC_COUPLING_H +#endif //NFTSIM_SRC_COUPLING_H diff --git a/src/coupling_diff_arctan.cpp b/src/coupling_diff_arctan.cpp index a85a6d0..3af8e4c 100644 --- a/src/coupling_diff_arctan.cpp +++ b/src/coupling_diff_arctan.cpp @@ -11,7 +11,7 @@ // Main module header #include "coupling_diff_arctan.h" // CouplingDiffArctan; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "population.h" // Population; diff --git a/src/coupling_diff_arctan.h b/src/coupling_diff_arctan.h index 3da196e..e480172 100644 --- a/src/coupling_diff_arctan.h +++ b/src/coupling_diff_arctan.h @@ -11,7 +11,7 @@ #ifndef COUPLING_DIFF_ARCTAN_H #define COUPLING_DIFF_ARCTAN_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling #include "propagator.h" // Propagator; diff --git a/src/coupling_ramp.cpp b/src/coupling_ramp.cpp index 9f00f38..78b88b1 100644 --- a/src/coupling_ramp.cpp +++ b/src/coupling_ramp.cpp @@ -16,7 +16,7 @@ // Main module header #include "coupling_ramp.h" // CouplingRamp; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; #include "propagator.h" // Propagator; diff --git a/src/coupling_ramp.h b/src/coupling_ramp.h index 5860b60..69e2b05 100644 --- a/src/coupling_ramp.h +++ b/src/coupling_ramp.h @@ -16,10 +16,10 @@ + param[in] pairs : total number of pairs of (nu, time) to define the segments */ -#ifndef NEUROFIELD_SRC_COUPLINGRAMP_H -#define NEUROFIELD_SRC_COUPLINGRAMP_H +#ifndef NFTSIM_SRC_COUPLINGRAMP_H +#define NFTSIM_SRC_COUPLINGRAMP_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "population.h" // Population; @@ -46,4 +46,4 @@ class CouplingRamp : public Coupling { ~CouplingRamp() override; }; -#endif // NEUROFIELD_SRC_COUPLINGRAMP_H +#endif // NFTSIM_SRC_COUPLINGRAMP_H diff --git a/src/de.h b/src/de.h index b72f9ee..8430dba 100644 --- a/src/de.h +++ b/src/de.h @@ -6,8 +6,8 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_DE_H -#define NEUROFIELD_SRC_DE_H +#ifndef NFTSIM_SRC_DE_H +#define NFTSIM_SRC_DE_H // C++ standard library headers #include // std::vector; @@ -129,4 +129,4 @@ class RK4 : public Integrator { } }; -#endif //NEUROFIELD_SRC_DE_H +#endif //NFTSIM_SRC_DE_H diff --git a/src/dendrite.cpp b/src/dendrite.cpp index f32a68b..28aa051 100644 --- a/src/dendrite.cpp +++ b/src/dendrite.cpp @@ -9,7 +9,7 @@ // Main module header #include "dendrite.h" // Dendrite; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "de.h" // RK4; diff --git a/src/dendrite.h b/src/dendrite.h index 19dd961..7ca6af8 100644 --- a/src/dendrite.h +++ b/src/dendrite.h @@ -6,13 +6,13 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_DENDRITE_H -#define NEUROFIELD_SRC_DENDRITE_H +#ifndef NFTSIM_SRC_DENDRITE_H +#define NFTSIM_SRC_DENDRITE_H // Forward declaration to break circular collaboration class Dendrite; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "de.h" // DE; RK4; diff --git a/src/dendrite_integral.cpp b/src/dendrite_integral.cpp index acd0fc3..8ba9134 100644 --- a/src/dendrite_integral.cpp +++ b/src/dendrite_integral.cpp @@ -10,7 +10,7 @@ // Main module header #include "dendrite_integral.h" // DendriteIntegral; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "propagator.h" // Propagator; diff --git a/src/dendrite_integral.h b/src/dendrite_integral.h index 95e097d..4632b0d 100644 --- a/src/dendrite_integral.h +++ b/src/dendrite_integral.h @@ -8,10 +8,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_DENDRITE_INTEGRAL_H -#define NEUROFIELD_SRC_DENDRITE_INTEGRAL_H +#ifndef NFTSIM_SRC_DENDRITE_INTEGRAL_H +#define NFTSIM_SRC_DENDRITE_INTEGRAL_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "dendrite.h" // Dendrite; @@ -51,4 +51,4 @@ class DendriteIntegral : public Dendrite { void step() override; }; -#endif //NEUROFIELD_SRC_DENDRITE_INTEGRAL_H +#endif //NFTSIM_SRC_DENDRITE_INTEGRAL_H diff --git a/src/dendriteramp.cpp b/src/dendriteramp.cpp index 8df4d1b..3fefa05 100644 --- a/src/dendriteramp.cpp +++ b/src/dendriteramp.cpp @@ -9,7 +9,7 @@ // Main module header #include "dendriteramp.h" // DendriteRamp; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "de.h" // RK4; diff --git a/src/dendriteramp.h b/src/dendriteramp.h index 55d2cfe..083d106 100644 --- a/src/dendriteramp.h +++ b/src/dendriteramp.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_DENDRITERAMP_H -#define NEUROFIELD_SRC_DENDRITERAMP_H +#ifndef NFTSIM_SRC_DENDRITERAMP_H +#define NFTSIM_SRC_DENDRITERAMP_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "de.h" // DE; RK4; @@ -53,4 +53,4 @@ class DendriteRamp : public Dendrite { void output( Output& output ) const override; }; -#endif //NEUROFIELD_SRC_DENDRITERAMP_H +#endif //NFTSIM_SRC_DENDRITERAMP_H diff --git a/src/dumpf.cpp b/src/dumpf.cpp index 29baf79..459f918 100644 --- a/src/dumpf.cpp +++ b/src/dumpf.cpp @@ -9,7 +9,7 @@ // Main module header #include "dumpf.h" // Dumpf; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; // C++ standard library headers diff --git a/src/dumpf.h b/src/dumpf.h index 6dcf042..2dbac47 100644 --- a/src/dumpf.h +++ b/src/dumpf.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_DUMPF_H -#define NEUROFIELD_SRC_DUMPF_H +#ifndef NFTSIM_SRC_DUMPF_H +#define NFTSIM_SRC_DUMPF_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; // C++ standard library headers diff --git a/src/firing_response.cpp b/src/firing_response.cpp index 80603ce..53b5b6a 100644 --- a/src/firing_response.cpp +++ b/src/firing_response.cpp @@ -4,7 +4,7 @@ Each neural population is associated with a FiringResponse object which produces the soma response governed by a specified equation, for example Sigmoid: \f[ - Insert equation 9 from draft neurofield paper here. + Insert equation 9 from draft nftsim paper here. \f] @author Peter Drysdale, Felix Fung, @@ -13,7 +13,7 @@ // Main module header #include "firing_response.h" // FiringResponse; -// Other neurofield headers +// Other nftsim headers #include "array.h" // Array; #include "configf.h" // Configf; #include "coupling.h" // Coupling; diff --git a/src/firing_response.h b/src/firing_response.h index 13757c5..cbb7bec 100644 --- a/src/firing_response.h +++ b/src/firing_response.h @@ -7,13 +7,13 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_FIRING_RESPONSE_H -#define NEUROFIELD_SRC_FIRING_RESPONSE_H +#ifndef NFTSIM_SRC_FIRING_RESPONSE_H +#define NFTSIM_SRC_FIRING_RESPONSE_H // Forward declaration to break circular collaboration class FiringResponse; -// Other neurofield headers +// Other nftsim headers #include "array.h" // Array; #include "configf.h" // Configf; #include "coupling.h" // Coupling; @@ -62,4 +62,4 @@ const std::vector& FiringResponse::V() const { return v; } -#endif //NEUROFIELD_SRC_FIRING_RESPONSE_H +#endif //NFTSIM_SRC_FIRING_RESPONSE_H diff --git a/src/glutamate_response.cpp b/src/glutamate_response.cpp index aead7db..3653931 100644 --- a/src/glutamate_response.cpp +++ b/src/glutamate_response.cpp @@ -7,7 +7,7 @@ // Main module header #include "glutamate_response.h" // GlutamateResponse; -// Other neurofield headers +// Other nftsim headers #include "array.h" // Array; #include "configf.h" // Configf; #include "dendrite.h" // Dendrite; diff --git a/src/glutamate_response.h b/src/glutamate_response.h index bf4bc53..c2aaf3b 100644 --- a/src/glutamate_response.h +++ b/src/glutamate_response.h @@ -4,13 +4,13 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_GLUTAMATE_RESPONSE_H -#define NEUROFIELD_SRC_GLUTAMATE_RESPONSE_H +#ifndef NFTSIM_SRC_GLUTAMATE_RESPONSE_H +#define NFTSIM_SRC_GLUTAMATE_RESPONSE_H // Forward declaration to break circular collaboration class GlutamateResponse; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "de.h" // DE; RK4; #include "firing_response.h" // FiringResponse; @@ -45,4 +45,4 @@ class GlutamateResponse : public FiringResponse { const std::vector& glu() const; }; -#endif //NEUROFIELD_SRC_GLUTAMATE_RESPONSE_H +#endif //NFTSIM_SRC_GLUTAMATE_RESPONSE_H diff --git a/src/harmonic.cpp b/src/harmonic.cpp index b0ba10a..d214afb 100644 --- a/src/harmonic.cpp +++ b/src/harmonic.cpp @@ -9,7 +9,7 @@ // Main module header #include "harmonic.h" // Harmonic; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; diff --git a/src/harmonic.h b/src/harmonic.h index 1cd5a55..9217655 100644 --- a/src/harmonic.h +++ b/src/harmonic.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_HARMONIC_H -#define NEUROFIELD_SRC_HARMONIC_H +#ifndef NFTSIM_SRC_HARMONIC_H +#define NFTSIM_SRC_HARMONIC_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "de.h" // DE; RK4; #include "population.h" // Population; @@ -49,4 +49,4 @@ class Harmonic : public virtual Propagator { void step() override; }; -#endif //NEUROFIELD_SRC_HARMONIC_H +#endif //NFTSIM_SRC_HARMONIC_H diff --git a/src/harmonic_integral.cpp b/src/harmonic_integral.cpp index 7fea146..7c5c493 100644 --- a/src/harmonic_integral.cpp +++ b/src/harmonic_integral.cpp @@ -9,7 +9,7 @@ // Main module header #include "harmonic_integral.h" // HarmonicIntegral; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; diff --git a/src/harmonic_integral.h b/src/harmonic_integral.h index bbaf4f6..f74fe23 100644 --- a/src/harmonic_integral.h +++ b/src/harmonic_integral.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_HARMONIC_INTEGRAL_H -#define NEUROFIELD_SRC_HARMONIC_INTEGRAL_H +#ifndef NFTSIM_SRC_HARMONIC_INTEGRAL_H +#define NFTSIM_SRC_HARMONIC_INTEGRAL_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; #include "propagator.h" // Propagator; @@ -47,4 +47,4 @@ class HarmonicIntegral : public virtual Propagator { void step() override; }; -#endif //NEUROFIELD_SRC_HARMONIC_INTEGRAL_H +#endif //NFTSIM_SRC_HARMONIC_INTEGRAL_H diff --git a/src/long_coupling.cpp b/src/long_coupling.cpp index 9fa1652..0ae7e7e 100644 --- a/src/long_coupling.cpp +++ b/src/long_coupling.cpp @@ -9,7 +9,7 @@ // Main module header #include "long_coupling.h" // LongCoupling; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "output.h" // Output; #include "population.h" // Population; diff --git a/src/long_coupling.h b/src/long_coupling.h index 6c7f492..29f3b78 100644 --- a/src/long_coupling.h +++ b/src/long_coupling.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_LONGCOUPLING_H -#define NEUROFIELD_SRC_LONGCOUPLING_H +#ifndef NFTSIM_SRC_LONGCOUPLING_H +#define NFTSIM_SRC_LONGCOUPLING_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "output.h" // Output; @@ -36,4 +36,4 @@ class LongCoupling : public Coupling { void output( Output& output ) const override; }; -#endif //NEUROFIELD_SRC_LONGCOUPLING_H +#endif //NFTSIM_SRC_LONGCOUPLING_H diff --git a/src/main.cpp b/src/main.cpp index a63c0cb..ded9b07 100644 --- a/src/main.cpp +++ b/src/main.cpp @@ -1,7 +1,7 @@ /** @file main.cpp - @brief Implements the main entry point for Neurofield, a multiscale neural field software. + @brief Implements the main entry point for NFTsim, a multiscale neural field software. - NeuroField is capable of simulating scales from a few tenths of a millimetre + NFTsim is capable of simulating scales from a few tenths of a millimetre and a few milliseconds upward. It allows for the specification of models with: + an arbitrary number of neural populations, of different types and with different parameters; @@ -12,7 +12,7 @@ @author Peter Drysdale, Felix Fung, */ -// Neurofield headers +// NFTsim headers #include "configf.h" // Configf; #include "dumpf.h" // Dumpf; #include "solver.h" // Solver; @@ -36,10 +36,10 @@ int main(int argc, char* argv[]) { for( int i=1; i2 ) { @@ -68,9 +68,9 @@ int main(int argc, char* argv[]) { } } } - const string confname = string(iconfarg != 0?argv[iconfarg]:"neurofield.conf"); + const string confname = string(iconfarg != 0?argv[iconfarg]:"nftsim.conf"); if(iconfarg == 0) { - cerr << "Warning: Using neurofield.conf for input by default" << endl; + cerr << "Warning: Using nftsim.conf for input by default" << endl; } auto inputf = new Configf(confname); @@ -95,7 +95,7 @@ int main(int argc, char* argv[]) { } // open file for outputting data - default is confname with .conf suffix - // replaced by .output, so neurofield.conf => neurofield.output. + // replaced by .output, so nftsim.conf => nftsim.output. Dumpf dumpf; int ioutarg = 0; if( argc>2 ) { @@ -120,9 +120,9 @@ int main(int argc, char* argv[]) { } // construct, initialize and solve the neural field theory - Solver neurofield(dumpf); - *inputf>>neurofield; - neurofield.solve(); + Solver nftsim(dumpf); + *inputf>>nftsim; + nftsim.solve(); delete inputf; return EXIT_SUCCESS; diff --git a/src/nf.cpp b/src/nf.cpp index 058e1d1..520426a 100644 --- a/src/nf.cpp +++ b/src/nf.cpp @@ -9,7 +9,7 @@ // Main module header #include "nf.h" // NF; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "output.h" // Output; diff --git a/src/nf.h b/src/nf.h index 4bcf495..d6497e2 100644 --- a/src/nf.h +++ b/src/nf.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_NF_H -#define NEUROFIELD_SRC_NF_H +#ifndef NFTSIM_SRC_NF_H +#define NFTSIM_SRC_NF_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; //#include "dumpf.h" // Dumpf; #include "output.h" // Output; @@ -39,4 +39,4 @@ class NF { virtual ~NF(); }; -#endif //NEUROFIELD_SRC_NF_H +#endif //NFTSIM_SRC_NF_H diff --git a/src/output.cpp b/src/output.cpp index 17f288e..4fc4a59 100644 --- a/src/output.cpp +++ b/src/output.cpp @@ -9,7 +9,7 @@ // Main module header #include "output.h" // Output; Outlet; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "dumpf.h" // Dumpf; diff --git a/src/output.h b/src/output.h index 80b8eb6..925ae35 100644 --- a/src/output.h +++ b/src/output.h @@ -6,8 +6,8 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_OUTPUT_H -#define NEUROFIELD_SRC_OUTPUT_H +#ifndef NFTSIM_SRC_OUTPUT_H +#define NFTSIM_SRC_OUTPUT_H // C++ standard library headers #include // std::string; @@ -38,4 +38,4 @@ class Output { operator std::vector() const; }; -#endif //NEUROFIELD_SRC_OUTPUT_H +#endif //NFTSIM_SRC_OUTPUT_H diff --git a/src/population.cpp b/src/population.cpp index 86e9f36..4d350f6 100644 --- a/src/population.cpp +++ b/src/population.cpp @@ -9,7 +9,7 @@ // Main module header #include "population.h" // Population; -// Other neurofield headers +// Other nftsim headers #include "burst.h" // BurstResponse; #include "configf.h" // Configf; #include "coupling.h" // Coupling; diff --git a/src/population.h b/src/population.h index 872a6e7..f60b1c7 100644 --- a/src/population.h +++ b/src/population.h @@ -6,13 +6,13 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_POPULATION_H -#define NEUROFIELD_SRC_POPULATION_H +#ifndef NFTSIM_SRC_POPULATION_H +#define NFTSIM_SRC_POPULATION_H // Forward declaration to break circular collaboration class Population; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "coupling.h" // Coupling; #include "nf.h" // NF; @@ -60,4 +60,4 @@ class Population : public NF { virtual void outputDendrite( size_type index, Output& output ) const; }; -#endif //NEUROFIELD_SRC_POPULATION_H +#endif //NFTSIM_SRC_POPULATION_H diff --git a/src/propagator.cpp b/src/propagator.cpp index 7a4d2e4..302489a 100644 --- a/src/propagator.cpp +++ b/src/propagator.cpp @@ -9,7 +9,7 @@ // Main module header #include "propagator.h" // Propagator; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "output.h" // Output; #include "population.h" // Population; diff --git a/src/propagator.h b/src/propagator.h index f9b10a4..3c758dc 100644 --- a/src/propagator.h +++ b/src/propagator.h @@ -7,13 +7,13 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_PROPAGATOR_H -#define NEUROFIELD_SRC_PROPAGATOR_H +#ifndef NFTSIM_SRC_PROPAGATOR_H +#define NFTSIM_SRC_PROPAGATOR_H // Forward declaration to break circular collaboration class Propagator; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "nf.h" // NF; #include "output.h" // Output; Outlet; @@ -59,4 +59,4 @@ double Propagator::operator[]( size_type node ) const { return p[node]; } -#endif //NEUROFIELD_SRC_PROPAGATOR_H +#endif //NFTSIM_SRC_PROPAGATOR_H diff --git a/src/random.h b/src/random.h index cd1bcb0..4ab8116 100644 --- a/src/random.h +++ b/src/random.h @@ -6,8 +6,8 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_RANDOM_H -#define NEUROFIELD_SRC_RANDOM_H +#ifndef NFTSIM_SRC_RANDOM_H +#define NFTSIM_SRC_RANDOM_H // C++ standard library headers #include // std::mt19937_64; std::normal_distribution; @@ -29,4 +29,4 @@ class Random { ~Random(); }; -#endif // NEUROFIELD_SRC_RANDOM_H +#endif // NFTSIM_SRC_RANDOM_H diff --git a/src/solver.cpp b/src/solver.cpp index 38a4171..3b37feb 100644 --- a/src/solver.cpp +++ b/src/solver.cpp @@ -5,7 +5,7 @@ If you define your own Propagators or Couplings, then, it is in the init member-function of this class that you must create appropriate entries in - order to make those Propagators and Couplings specifiable via neurofield's + order to make those Propagators and Couplings specifiable via nftsim's configuration (.conf) files. @author Peter Drysdale, Felix Fung, @@ -14,7 +14,7 @@ // Main module header #include "solver.h" // Solver; -// Other neurofield headers +// Other nftsim headers #include "bcm.h" // BCM; #include "bcmlong.h" // BCMLong; #include "cadp.h" // CaDP; diff --git a/src/solver.h b/src/solver.h index f82dba5..be4a394 100644 --- a/src/solver.h +++ b/src/solver.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_SOLVER_H -#define NEUROFIELD_SRC_SOLVER_H +#ifndef NFTSIM_SRC_SOLVER_H +#define NFTSIM_SRC_SOLVER_H -// Other neurofield headers +// Other nftsim headers #include "array.h" // Array; #include "configf.h" // Configf; #include "coupling.h" // Coupling; @@ -100,4 +100,4 @@ class Solver : public NF { void step() override; }; -#endif //NEUROFIELD_SRC_SOLVER_H +#endif //NFTSIM_SRC_SOLVER_H diff --git a/src/stencil.h b/src/stencil.h index b4f8048..379f542 100644 --- a/src/stencil.h +++ b/src/stencil.h @@ -18,8 +18,8 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_STENCIL_H -#define NEUROFIELD_SRC_STENCIL_H +#ifndef NFTSIM_SRC_STENCIL_H +#define NFTSIM_SRC_STENCIL_H // C++ standard library headers #include // std::string; @@ -77,4 +77,4 @@ void Stencil::operator++ (int) const { } } -#endif //NEUROFIELD_SRC_STENCIL_H +#endif //NFTSIM_SRC_STENCIL_H diff --git a/src/stencil_legacy.h b/src/stencil_legacy.h index 9cb8336..faa34b1 100644 --- a/src/stencil_legacy.h +++ b/src/stencil_legacy.h @@ -12,8 +12,8 @@ @author Peter Drysdale, Felix Fung. */ -#ifndef NEUROFIELD_SRC_STENCIL_LEGACY_H -#define NEUROFIELD_SRC_STENCIL_LEGACY_H +#ifndef NFTSIM_SRC_STENCIL_LEGACY_H +#define NFTSIM_SRC_STENCIL_LEGACY_H // C++ standard library headers #include // std::string; @@ -71,4 +71,4 @@ void StencilLegacy::operator++ (int) const { } } -#endif //NEUROFIELD_SRC_STENCIL_LEGACY_H +#endif //NFTSIM_SRC_STENCIL_LEGACY_H diff --git a/src/tau.cpp b/src/tau.cpp index 6595088..508bc44 100644 --- a/src/tau.cpp +++ b/src/tau.cpp @@ -9,7 +9,7 @@ // Main module header #include "tau.h" // Tau; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; // C++ standard library headers diff --git a/src/tau.h b/src/tau.h index f5ba5b4..8589b9f 100644 --- a/src/tau.h +++ b/src/tau.h @@ -6,10 +6,10 @@ @author Peter Drysdale, Felix Fung, */ -#ifndef NEUROFIELD_SRC_TAU_H -#define NEUROFIELD_SRC_TAU_H +#ifndef NFTSIM_SRC_TAU_H +#define NFTSIM_SRC_TAU_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "nf.h" // NF; @@ -34,4 +34,4 @@ class Tau : public NF { friend class Population; }; -#endif //NEUROFIELD_SRC_TAU_H +#endif //NFTSIM_SRC_TAU_H diff --git a/src/timeseries.cpp b/src/timeseries.cpp index 366a2b1..537c01f 100644 --- a/src/timeseries.cpp +++ b/src/timeseries.cpp @@ -1,26 +1,42 @@ /** @file timeseries.cpp - @brief A brief, one sentence description. - - A more detailed multiline description... - - @author Peter Drysdale, Felix Fung, + @brief A collection of time-series definitions, primarily for use as stimuli. + + The currently implemented time-series include: + + TIMESERIES::Const: A constant value. + + TIMESERIES::PulseRect: A rectangular pulse train. + + TIMESERIES::PulseSine: A pulsed sine wave. + + TIMESERIES::PulseSigmoid: A sigmoidal pulse train. + + TIMESERIES::White: Gaussian amplitude distribution white noise. + + TIMESERIES::WhiteCoherent: . + + TIMESERIES::PAS: Paired Associative Stimulation. + + TIMESERIES::Burst: . + + Multiple `Timeseries` can be combined using the `Superimpose` keyword in + the configuration file. + + @author Peter Drysdale, Felix Fung, Stuart A. Knock, */ // Main module header #include "timeseries.h" // Timeseries; TIMESERIES::; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "random.h" // Random; // C++ standard library headers -#include // std::pow; std::sqrt; std::sin; std::fmod; M_PI; +#include // std::min; std::max +#include // std::pow; std::sqrt; std::sin; std::fmod; M_PI; std::ceil; std::exp #include // std::cerr; std::endl; #include // std::string; #include // std::vector; using std::cerr; +using std::ceil; +using std::exp; using std::endl; using std::fmod; +using std::max; +using std::min; using std::pow; using std::sin; using std::sqrt; @@ -30,8 +46,6 @@ using std::vector; void Timeseries::init( Configf& configf ) { series_size_type superimpose = 1; configf.optional("Superimpose", superimpose); - double duration = 0.0; // Duration of the stimulus. - double onset = 0.0; // Onset time for the stimulus. for( series_size_type i=0; i 0 ) { configf.next("Stimulus"); @@ -42,55 +56,63 @@ void Timeseries::init( Configf& configf ) { if(!configf.optional("Onset", onset)){ onset = 0.0; } - t = -onset; //Initialise stimulus time relative to onset. // Set stimulus duration. if(!configf.optional("Duration", duration) ) { - duration = inf; //Unspecified => whole simulation. + duration = inf; // Unspecified => whole simulation. } - vector temp_node; + // Get any user specified Node indices to apply stimulus. + vector temp_node; //TODO(stuart-knock): Should be vector, see issue #142 on GitHub. if( configf.next("Node") ) { temp_node = configf.numbers(); } - if( temp_node.empty() ) { - for( size_type j=1; j<=nodes; j++ ) { - temp_node.push_back(j); - } - } - for(double j : temp_node) { + + // Check user supplied Node indices are valid. + for(size_type j : temp_node) { if( j > nodes ) { cerr<<"Trying to plot node number "<t = t; + series[i]->onset = onset; + series[i]->t = -onset; // Initialise stimulus time relative to onset. series[i]->duration = duration; - for(double j : temp_node) { + for(size_type j : temp_node) { series[i]->node.push_back( j-1 ); } series[i]->init(configf); @@ -99,7 +121,7 @@ void Timeseries::init( Configf& configf ) { } Timeseries::Timeseries( size_type nodes, double deltat, size_type index ) - : NF(nodes,deltat,index), series() { + : NF(nodes,deltat,index) { } Timeseries::~Timeseries() { @@ -110,15 +132,14 @@ Timeseries::~Timeseries() { void Timeseries::fire( vector& Q ) const { vector temp(nodes, 0.0); - Q.clear(); - Q.resize(nodes, 0.0); + Q.assign(nodes, 0.0); // Zero the Q vector we were provided. for(auto serie : series) { // for each timeseries // if the timeseries is active - if( (serie->t >= 0) && (serie->t < serie->duration) ) { - temp.assign(nodes, 0.0); + if( (serie->t >= 0.0) && (serie->t < serie->duration) ) { + temp.assign(nodes, 0.0); // re-zero temp vector. serie->fire(temp); // then copy the temporary firing to the final firing - for(double j : serie->node) { + for(size_type j : serie->node) { Q[j] += temp[j]; } } @@ -131,176 +152,307 @@ void Timeseries::step() { } } + +/** @brief Contains time-series that can be combined to form a stimulus. + + **NOTE:** Timeseries::fire handles Onset and Duration. +*/ namespace TIMESERIES { -void Const::init( Configf& configf ) { - // Mean: 0 - configf.param("Mean",mean); -} + /** @brief Initialise the value returned by Const from the .conf file.*/ + void Const::init( Configf& configf ) { + configf.param("Mean", mean); + } -void Const::fire( vector& Q ) const { - for( size_type i=0; i& Q ) const { + Q.assign(nodes, mean); // assign nodes instances of mean to Q. } -} -void Pulse::init( Configf& configf ) { - period = 1000.0; - pulses = 1; - // Amplitude: 1 Width: .5e-3 "Period/Frequency": 1 "Pulses": 1 - configf.param("Amplitude",amp); - configf.param("Width",width); - if( !configf.optional("Period",period) ) { - if( configf.optional("Frequency",period) ) { - period = 1.0/period; + + /** @brief Parameter initialisation of a rectangular Pulse train. + + The .conf file is required to specify Amplitude and Width, eg: + Amplitude: 1.0 Width: 0.5e-3 + with Period, Frequency, and Pulses being optional. Period and Frequency are + mutually exclusive with Period taking precedence if both are specified. + */ + void PulseRect::init( Configf& configf ) { + // Set default values for optional parameters. + period = inf; + pulses = 1; + configf.param("Amplitude", amp); + configf.param("Width", width); + if( !configf.optional("Period", period) ) { + double freq; + if( configf.optional("Frequency", freq) ) { + period = 1.0/freq; + } } + configf.optional("Pulses", pulses); } - configf.optional("Pulses",pulses); -} -void Pulse::fire( vector& Q ) const { - if( fmod(t,period)>=0 && fmod(t,period)& Q ) const { + // Between start of each pulse and start plus width && as long as we have + // not reached the maximum number of pulses. + if((fmod(t, period) <= width) && (t/period < pulses) ) { + Q.assign(nodes, amp); // assign nodes instances of amp to Q. } } -} -void White::init( Configf& configf ) { - // Mean: 1 Std: 1 Ranseed: 1 - // Mean: 1 Psd: 1 Ranseed: 1 - configf.param("Mean",mean); - if( !configf.optional("Std",amp) ) { - configf.param("Psd",amp); - // index of timeseries the same as that of population - - if(nodes>1) { - deltax = atof(configf.find( - label("Population ",index+1)+"*Length").c_str()) /sqrt(nodes); - amp = sqrt(4.0*pow(M_PI,3)*pow(amp,2)/deltat/pow(deltax,2)); - } else { - amp = sqrt(M_PI*pow(amp,2)/deltat); - } + /** @brief Initialises a pulsed sine wave. + + The .conf file is required to specify Amplitude and Width, eg: + Amplitude: 1.0 Width: 0.5e-3 + with Period, phase, and Pulses being optional. + */ + void PulseSine::init( Configf& configf ) { + // Amplitude: 1 Width: .5 Period: 1 Phase: 0 + configf.param("Amplitude", amp); + configf.param("Width", width); + period = 1.0; + configf.optional("Period", period); + phase = 0.0; + configf.optional("Phase", phase); + pulses = 1; + configf.optional("Pulses", pulses); } - if(configf.optional("Ranseed",seed)) { - random = new Random(seed,mean,amp); - } else { - random = new Random(mean,amp); + + /** @brief Generate a train of sine wave pulses.*/ + void PulseSine::fire( vector& Q ) const { + if( fmod(t,period)>=0 && fmod(t,period)& Q ) const { - for(double& x : Q) { - random->get(x); + + /** @brief Parameter initialisation of a sigmoidal Pulse train. + + The .conf file is required to specify Amplitude and Width, eg: + Amplitude: 1.0 Width: 0.5e-3 + with Period, Frequency, and Pulses being optional. Period and Frequency are + mutually exclusive with Period taking precedence if both are specified. + Finally, Sigma can be specified to adjust the width of the transition from + zero to Amplitude. + + NOTE: Unlike other Timeseries, onset here is taken to be the mid-point of + the onset of the first pulse. That is, the initial rise begins before + onset. This is to make PulseSigmoid and PulseRect equivalent in the + limit as sigma approaches zero. + */ + void PulseSigmoid::init( Configf& configf ) { + // Set default values for optional parameters. + period = inf; // Time between the start of each pulse [s]. + pulses = 1.0; // Maximum number of pulses. + sigma = 0.03125; // Width of transition. + configf.param("Amplitude", amp); + configf.param("Width", width); + if( !configf.optional("Period", period) ) { + double freq; + if( configf.optional("Frequency", freq) ) { + period = 1.0 / freq; + } + } + configf.optional("Pulses", pulses); + configf.optional("Sigma", sigma); + pulse_count = min(pulses, duration/period); + + first_pulse_mid = onset + (width / 2.0); + + onset_midpoints.assign(pulse_count, 0.0); + for( size_type i=0; i& Q ) const { + double tsy = 0.0; // Value of the Timeseries at the current time-point. + size_type p1; // index of the first active pulse. + size_type p2; // index of the second active pulse. + + // At each point in time after the mid-point of the first pulse, the two + // nearest pulses contribute to the returned value. + p2 = static_cast(max(ceil((t - first_pulse_mid) / period), 1.0)); + p1 = p2 - static_cast(1); + + if (p1 < pulse_count){ + tsy = amp / ((1.0 + exp(-pi_on_sqrt3 * (t-onset_midpoints[p1])/sigma)) * + ((1.0 + exp(-pi_on_sqrt3 * ((onset_midpoints[p1]+width)-t)/sigma)))); + } + + if (p2 < pulse_count){ + tsy += amp / ((1.0 + exp(-pi_on_sqrt3 * (t-onset_midpoints[p2])/sigma)) * + ((1.0 + exp(-pi_on_sqrt3 * ((onset_midpoints[p2]+width)-t)/sigma)))); + } + + Q.assign(nodes, tsy); // assign nodes instances to Q. } - if(configf.optional("Ranseed",seed)) { - random = new Random(seed,mean,amp); - } else { - random = new Random(mean,amp); + + /** @brief Parameter initialisation of a simple sine function. + + The .conf file is required to specify Amplitude and frequency eg: + Amplitude: 512.0 Frequency: 4.0 + */ + void Sine::init( Configf& configf ) { + configf.param("Amplitude", amp); + configf.param("Frequency", freq); } -} -void WhiteCoherent::fire( vector& Q ) const { - double v; - random->get(v); - for( double& x : Q) { - x = v; + /** @brief Generate a sine wave.*/ + void Sine::fire( vector& Q ) const { + // Assign nodes instances of the sine wave to Q. + Q.assign(nodes, amp*sin( 2.0 * M_PI * t * freq)); } -} -void PAS::init( Configf& configf ) { - // ISI: 10e-3 - // N20 width: 2.5e-3 N20 height: 5 - // P25 width: 3.5e-3 P25 height: 5 - // TMS width: 0.5e-3 TMS height: 3 - configf.param("ISI",isi); - configf.param("N20 width", n20w); - configf.param("N20 height",n20h); - configf.param("P25 width", p25w); - configf.param("P25 height",p25h); - configf.param("TMS width", tmsw); - configf.param("TMS height",tmsh); - if( isi<0 ) { - t -= isi; - t_mns = -isi; - } else { - t_mns = 0.0; + /** @brief Initialises white noise.*/ + void White::init( Configf& configf ) { + // Mean: 1 StdDev: 1 Ranseed: 1 + // Mean: 1 PSD: 1 Ranseed: 1 + configf.param("Mean", mean); + if( !configf.optional("StdDev", stddev) ) { + configf.param("PSD", psd); + // index of timeseries the same as that of population + + if(nodes>1) { + deltax = atof(configf.find( + label("Population ",index+1)+"*Length").c_str()) /sqrt(nodes); + stddev = sqrt(4.0*pow(M_PI,3)*pow(psd,2)/deltat/pow(deltax,2)); + } else { + stddev = sqrt(M_PI*pow(psd,2)/deltat); + } + + } + if(configf.optional("Ranseed", seed)) { + random = new Random(seed, mean, stddev); + } else { + random = new Random(mean, stddev); + } } -} -void PAS::fire( vector& Q ) const { - // MNS - if( t_mns<=t && t& Q ) const { + for(double& x : Q) { + random->get(x); } - } else if( t_mns+n20w<=t && t& Q ) const { + double v; + random->get(v); // get a single random value for this time-step. + Q.assign(nodes, v); // assign nodes instances of v to Q. + } + + /** @brief Parameter initialisation of Paired Associative Stimulation (PAS). + + The .conf file is required to specify all parameters, example values are: + ISI: 10.0e-3 + N20 width: 2.5e-3 N20 height: 5.0 + P25 width: 3.5e-3 P25 height: 5.0 + TMS width: 0.5e-3 TMS height: 3.0 + */ + void PAS::init( Configf& configf ) { + // Load parameter values from the conf file. + configf.param("ISI", isi); + configf.param("N20 width", n20w); + configf.param("N20 height", n20h); + configf.param("P25 width", p25w); + configf.param("P25 height", p25h); + configf.param("TMS width", tmsw); + configf.param("TMS height", tmsh); + // Adjust time... negative ISI...??? + if( isi<0 ) { + t -= isi; + t_mns = -isi; + } else { + t_mns = 0.0; } } -} -void Burst::init( Configf& configf ) { - // Amplitude: 10 Width: .5e-3 Bursts: 3 Burst Frequency: 50 On: 2 Off: 8 Total Pulses: 1000 - configf.param("Amplitude",amp); - configf.param("Width",width); - configf.param("Bursts",bursts); - configf.param("Burst Frequency",freq); - configf.param("Oscillation Frequency",oscillation_freq); - configf.param("On",on); - configf.param("Off",off); -} + /** @brief Paired Associative Stimulation (PAS). + + PAS is a Transcranial Magnetic Stimulation (TMS) protocol that consists + of electrical stimulation of the median nerve at the wrist (MNS) followed + by TMS of the contralateral primary motor region (M1). + + Wolters, Alexander, et al. "Timing‐dependent plasticity in human primary + somatosensory cortex." The Journal of physiology 565.3 (2005): 1039-1052. + + Müller-Dahlhaus, Florian, Ulf Ziemann, and Joseph Classen. "Plasticity + resembling spike-timing dependent synaptic plasticity: the evidence in + human cortex." Frontiers in synaptic neuroscience 2 (2010). + */ + void PAS::fire( vector& Q ) const { + // Median Nerve-evoked SomatoSensory-Evoked Potential (MN-SSEP). + double amp; + if( t_mns<=t && t& Q ) const { - if( fmod(t,on+off)>=0 && fmod(t,on+off)=0 && fmod(t,1/oscillation_freq)=0 && fmod(t,1/freq)& Q ) const { - if( fmod(t,period)>=0 && fmod(t,period)& Q ) const { + if( fmod(t,on+off)>=0 && fmod(t,on+off)=0 && fmod(t,1/oscillation_freq)=0 && fmod(t,1/freq) series; - std::vector node; + std::vector node; double inf = std::numeric_limits::infinity(); ///< Infinity double t = 0.0; ///< Current time relative to stimulus onset. + double onset = 0.0; ///< Onset time for the stimulus. double duration = inf; ///< Duration of the stimulus. public: - Timeseries(const Timeseries&) = delete; // No copy constructor allowed. - Timeseries() = delete; // No default constructor allowed. + Timeseries(const Timeseries&) = delete; // No copy constructor allowed. + Timeseries() = delete; // No default constructor allowed. Timeseries( size_type nodes, double deltat, size_type index ); ~Timeseries() override; @@ -40,67 +41,115 @@ class Timeseries : public NF { namespace TIMESERIES { -struct Const : public Timeseries { - double mean = 0.0; - Const(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; - -struct Pulse : public Timeseries { - double amp = 0.0, width = 0.0, period = 0.0, pulses = 0.0; - Pulse(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; - -struct White : public Timeseries { - uint_fast64_t seed=0; - double amp = 0.0, mean = 0.0, deltax = 0.0; - Random* random; - White(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - ~White() override { - delete random; - } - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; - -struct WhiteCoherent : public Timeseries { - uint_fast64_t seed=0; - double amp = 0.0, mean = 0.0; - Random* random; - WhiteCoherent(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - ~WhiteCoherent() override { - delete random; - } - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; - -struct PAS : public Timeseries { - double n20w = 0.0, n20h = 0.0, p25w = 0.0, p25h = 0.0; - double tmsw = 0.0, tmsh = 0.0, t_mns = 0.0, isi = 0.0; - PAS(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; - -struct Burst : public Timeseries { - double amp = 0.0, width = 0.0, bursts = 0.0, freq = 0.0; - double oscillation_freq = 0.0, on = 0.0, off = 0.0, total = 0.0; - Burst(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; - -struct Sine : public Timeseries { - double amp = 0.0, width = 0.0, period = 0.0, phase = 0.0, pulses = 0.0; - Sine(size_type nodes,double deltat,size_type index) : Timeseries(nodes,deltat,index) {} - ~Sine() override = default; - void init( Configf& configf ) override; - void fire( std::vector& Q ) const override; -}; + struct Const : public Timeseries { + double mean = 0.0; ///< + Const(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct PulseRect : public Timeseries { + double amp = 0.0; ///< Amplitude of the pulse. + double width = 0.0; ///< Width of the pulse [s]. + double period = 0.0; ///< Time between the start of each pulse [s]. + double pulses = 0.0; ///< Maximum number of pulses. + PulseRect(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct PulseSine : public Timeseries { + double amp = 0.0; ///< Amplitude of the pulse. + double width = 0.0; ///< Width of the pulse [s], wavelength of sine. + double period = 0.0; ///< Time between the start of each pulse [s]. + double phase = 0.0; ///< Phase of the sine wave in [degrees]. + double pulses = 0.0; ///< Maximum number of pulses. + PulseSine(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + ~PulseSine() override = default; + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct PulseSigmoid : public Timeseries { + double amp = 0.0; ///< Amplitude of the pulse. + double width = 0.0; ///< Width of the pulse [s]. + double period = 0.0; ///< Time between the start of each pulse [s]. + double pulses = 0.0; ///< Maximum number of pulses. + double sigma = 0.03125; ///< Width of transition. + PulseSigmoid(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + std::vector onset_midpoints; + double first_pulse_mid = 0.0; ///< Mid-point of the first pulse. + static constexpr double pi_on_sqrt3 = 1.813799364234217836866491779801435768604278564; //M_PI / std::sqrt(3.0); + size_type pulse_count = 0; ///< Number of pulses, min of pulses and number of pulses that fit in duration. + }; + + struct Sine : public Timeseries { + double amp = 0.0; ///< Amplitude of the sine wave. + double freq = 0.0; ///< Frequency of the sine wave [s^-1]. + Sine(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + ~Sine() override = default; + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct White : public Timeseries { + uint_fast64_t seed = 0; ///< + double stddev = 0.0; ///< + double psd = 0.0; ///< + double mean = 0.0; ///< + double deltax = 0.0; ///< + Random* random; + White(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + ~White() override { + delete random; + } + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct WhiteCoherent : public Timeseries { + uint_fast64_t seed = 0; ///< + double stddev = 0.0; ///< + double psd = 0.0; ///< + double mean = 0.0; ///< + Random* random; + WhiteCoherent(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + ~WhiteCoherent() override { + delete random; + } + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct PAS : public Timeseries { + double n20w = 0.0; ///< Width of the negative amplitude response at around 20 ms. + double n20h = 0.0; ///< Height of the negative amplitude response at around 20 ms. + double p25w = 0.0; ///< Width of the positive amplitude response at around 25 ms. + double p25h = 0.0; ///< Height of the positive amplitude response at around 25 ms. + double tmsw = 0.0; ///< Width of the Transcranial Magnetic Stimulation(TMS). + double tmsh = 0.0; ///< Height of the Transcranial Magnetic Stimulation(TMS). + double t_mns = 0.0; ///< + double isi = 0.0; ///< Inter-Stimulus-Interval. + PAS(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; + + struct Burst : public Timeseries { + double amp = 0.0; ///< + double width = 0.0; ///< + double bursts = 0.0; ///< + double freq = 0.0; ///< + double oscillation_freq = 0.0; ///< + double on = 0.0; ///< + double off = 0.0; ///< + double total = 0.0; ///< + Burst(size_type nodes, double deltat, size_type index) : Timeseries(nodes, deltat, index) {} + void init( Configf& configf ) override; + void fire( std::vector& Q ) const override; + }; } // namespace TIMESERIES -#endif //NEUROFIELD_SRC_TIMESERIES_H +#endif //NFTSIM_SRC_TIMESERIES_H diff --git a/src/wave.cpp b/src/wave.cpp index 87974b0..eaac64f 100644 --- a/src/wave.cpp +++ b/src/wave.cpp @@ -17,7 +17,7 @@ // Main module header #include "wave.h" // Wave; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; #include "stencil.h" // Stencil; diff --git a/src/wave.h b/src/wave.h index 63e94f4..c6cc986 100644 --- a/src/wave.h +++ b/src/wave.h @@ -10,10 +10,10 @@ * */ -#ifndef NEUROFIELD_SRC_WAVE_H -#define NEUROFIELD_SRC_WAVE_H +#ifndef NFTSIM_SRC_WAVE_H +#define NFTSIM_SRC_WAVE_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; #include "propagator.h" // Propagator; @@ -58,4 +58,4 @@ class Wave : public Propagator { void step() override; }; -#endif //NEUROFIELD_SRC_WAVE_H +#endif //NFTSIM_SRC_WAVE_H diff --git a/src/wave_legacy.cpp b/src/wave_legacy.cpp index 71ca8cc..f48621b 100644 --- a/src/wave_legacy.cpp +++ b/src/wave_legacy.cpp @@ -16,7 +16,7 @@ // Main module header #include "wave_legacy.h" // WaveLegacy; -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; #include "stencil_legacy.h" // StencilLegacy; diff --git a/src/wave_legacy.h b/src/wave_legacy.h index d80d056..2ab0d51 100644 --- a/src/wave_legacy.h +++ b/src/wave_legacy.h @@ -10,10 +10,10 @@ * */ -#ifndef NEUROFIELD_SRC_WAVE_LEGACY_H -#define NEUROFIELD_SRC_WAVE_LEGACY_H +#ifndef NFTSIM_SRC_WAVE_LEGACY_H +#define NFTSIM_SRC_WAVE_LEGACY_H -// Other neurofield headers +// Other nftsim headers #include "configf.h" // Configf; #include "population.h" // Population; #include "propagator.h" // Propagator; @@ -58,4 +58,4 @@ class WaveLegacy : public Propagator { void step() override; }; -#endif //NEUROFIELD_SRC_WAVE_LEGACY_H +#endif //NFTSIM_SRC_WAVE_LEGACY_H diff --git a/test/data/configs/README.md b/test/data/configs/README.md index e3dedcf..d5a4f89 100644 --- a/test/data/configs/README.md +++ b/test/data/configs/README.md @@ -1,7 +1,7 @@ -#Configs data (neurofield/test/data/configs/) +# Configs data (nftsim/test/data/configs/) This directory contains output files for each of the configuration files -found in the neurofield/configs directory. They are intended to be used +found in the nftsim/configs directory. They are intended to be used as a check of consistent behaviour following code modifications. To check that any modifications that you have made to the code haven't @@ -9,7 +9,7 @@ inadvertently altered its functionality, run: nf_configs --check -where ``nf_configs`` is a bash script found in the neurofield/ directory. +where ``nf_configs`` is a bash script found in the nftsim/ directory. When a --check reveals a difference from the expected output the temporary file used for the check is not removed, this makes it easy to look at the diff --git a/test/numerical/eirs_eyes_closed.conf b/test/numerical/eirs_eyes_closed.conf index 76a6e2f..6f9ba13 100644 --- a/test/numerical/eirs_eyes_closed.conf +++ b/test/numerical/eirs_eyes_closed.conf @@ -55,7 +55,7 @@ Population 4: Relay Population 5: Stimulation Length: .5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0001 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0001 Propagator 1: Wave - Range: 0.086 gamma: 116 Propagator 2: Map - diff --git a/test/numerical/eirs_eyes_closed_2.conf b/test/numerical/eirs_eyes_closed_2.conf index cf80f90..eea1135 100644 --- a/test/numerical/eirs_eyes_closed_2.conf +++ b/test/numerical/eirs_eyes_closed_2.conf @@ -55,7 +55,7 @@ Population 4: Relay Population 5: Stimulation Length: .5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0006 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0006 Propagator 1: Wave - Range: 0.086 gamma: 116 Propagator 2: Map - diff --git a/test/numerical/eirs_spindles.conf b/test/numerical/eirs_spindles.conf index 36795be..4b7f9b6 100644 --- a/test/numerical/eirs_spindles.conf +++ b/test/numerical/eirs_spindles.conf @@ -55,7 +55,7 @@ Population 4: Relay Population 5: Stimulation Length: .5 - Stimulus: White - Onset: 0 Mean: 1 Psd: 0.0003 + Stimulus: White - Onset: 0 Mean: 1 PSD: 0.0003 Propagator 1: Wave - Range: 0.086 gamma: 116 Propagator 2: Map - diff --git a/test/numerical/test_eirs_spectrum.m b/test/numerical/test_eirs_spectrum.m index c02997a..ba5ac6c 100644 --- a/test/numerical/test_eirs_spectrum.m +++ b/test/numerical/test_eirs_spectrum.m @@ -1,5 +1,5 @@ function test_output(save_new) - % This function tests the latest neurofield against known results + % This function tests the latest nftsim against known results % nf_run, nf_read and nf_spatial_spectrum need to be on the path if nargin < 1 || isempty(save_new) save_new = 0; diff --git a/test/numerical/wave_basic.conf b/test/numerical/wave_basic.conf index 4ca806e..296c326 100644 --- a/test/numerical/wave_basic.conf +++ b/test/numerical/wave_basic.conf @@ -18,7 +18,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 2: Stimulation Length: 0.5 - Stimulus: Pulse - Onset: 0.75625 Node: 2048 Amplitude: 0.06125 Width: 0.00390625 + Stimulus: PulseRect - Onset: 0.75625 Node: 2048 Amplitude: 0.06125 Width: 0.00390625 Propagator 1: Wave - Tau: 0 Range: 0.2 gamma: 30 Propagator 2: Map - diff --git a/test/numerical/wave_basic_legacy.conf b/test/numerical/wave_basic_legacy.conf index f50ba5a..6604b05 100644 --- a/test/numerical/wave_basic_legacy.conf +++ b/test/numerical/wave_basic_legacy.conf @@ -18,7 +18,7 @@ Firing: Function: Sigmoid Theta: 0.01292 Sigma: 0.0038 Qmax: 340 Population 2: Stimulation Length: 0.5 - Stimulus: Pulse - Onset: 0.75625 Node: 2048 Amplitude: 0.06125 Width: 0.00390625 + Stimulus: PulseRect - Onset: 0.75625 Node: 2048 Amplitude: 0.06125 Width: 0.00390625 Propagator 1: WaveLegacy - Tau: 0 Range: 0.2 gamma: 30 Propagator 2: Map - diff --git a/utils/configs_compare.py b/utils/configs_compare.py index e1b6008..645e7c3 100755 --- a/utils/configs_compare.py +++ b/utils/configs_compare.py @@ -2,7 +2,7 @@ # -*- coding: utf-8 -*- """ -Compare the current output of neurofield against the stored data for the +Compare the current output of nftsim against the stored data for the configuration files in configs/. USAGE: @@ -23,7 +23,7 @@ #is 'propagator.1.phi', the default node index is 0, so to show an overlay #and difference (current Vs stored) plot for the first output node of the #first propagator's phi for the onepop.conf configuration file, from the main - #neurofield directory just run: + #nftsim directory just run: ./utils/configs_compare.py --diff --overlay #To compare 'example.conf', plotting an overlay and diff, of the 73rd output @@ -64,9 +64,9 @@ # Then, try importing less reliable packages try: - import neurofield + import nftsim except ImportError: - LOG.error("Failed to import neurofield.py...") + LOG.error("Failed to import nftsim.py...") raise ########################################################################### @@ -111,7 +111,7 @@ def find_file(filename, path): #Parse arguments import argparse PARSER = argparse.ArgumentParser( - description="Compare the current output of neurofield to stored output.") + description="Compare the current output of nftsim to stored output.") #Configuration file PARSER.add_argument('-c', '--conf', @@ -182,15 +182,15 @@ def find_file(filename, path): stored_filepath = find_file(stored_filename, test_data_dir) #Copy the stored data to a temporary file - tmp_stored_filepath = '/tmp/neurofield_stored_%s.output' % config_name + tmp_stored_filepath = '/tmp/nftsim_stored_%s.output' % config_name with gzip.open(stored_filepath, 'rb') as f_in, open(tmp_stored_filepath, 'wb') as f_out: shutil.copyfileobj(f_in, f_out) - #Load the stored data into a neurofield object. - stored = neurofield.NF(tmp_stored_filepath) + #Load the stored data into a nftsim object. + stored = nftsim.NF(tmp_stored_filepath) - #Run the config file with the current version, and load data to a neurofield object. - current = neurofield.run(config_filepath) + #Run the config file with the current version, and load data to a nftsim object. + current = nftsim.run(config_filepath) #If requested, plot overlay of stored and current traces. if ARGS.overlay is True: diff --git a/utils/neurofield.py b/utils/nftsim.py similarity index 85% rename from utils/neurofield.py rename to utils/nftsim.py index 9f6ee1d..7ce416a 100644 --- a/utils/neurofield.py +++ b/utils/nftsim.py @@ -1,13 +1,13 @@ # -*- coding: utf-8 -*- """ - Defines a NeuroField Python class that supports + Defines a NFTsim Python class that supports + running a configuration file + loading the output file for visualization and analysis USAGE: - import neurofield - nfobj = neurofield.run('filename.conf','path_to_neurofield_executable') + import nftsim + nfobj = nftsim.run('filename.conf','path_to_nftsim_executable') print(nfobj) this_trace = 'propagator.1.phi' # traces have the form class.obj_index.variable nfobj.plot(this_trace) @@ -15,9 +15,9 @@ OPTIONS: EXAMPLES: - # From the root neurofield directory - import utils.neurofield as neurofield - nfobj = neurofield.run('configs/example.conf', './bin/neurofield') + # From the root nftsim directory + import utils.nftsim as nftsim + nfobj = nftsim.run('configs/example.conf', './bin/nftsim') print(nfobj) nfobj.plot('propagator.1.phi') @@ -34,7 +34,7 @@ __version__ = '0.1.4' import logging -logging.basicConfig(filename='neurofield.log', level=logging.INFO, +logging.basicConfig(filename='nftsim.log', level=logging.INFO, format='%(asctime)s:%(levelname)s:%(message)s') LOG = logging.getLogger(__name__) import os @@ -90,7 +90,7 @@ def __init__(self, nf_output_file): def __repr__(self): out = '' - out += 'NeuroField output\n' + out += 'NFTsim output\n' out += 'Traces: %s\n' % (', '.join(self.fields)) out += 'Start time: %f\n' % (self.time[0]) out += 'Stop time: %f\n' % (self.time[-1]) @@ -139,17 +139,17 @@ def read_conf(self, fid): conf = {} return (conf, skiprows) -def run(filename, neurofield_path='./bin/neurofield'): +def run(filename, nftsim_path='./bin/nftsim'): """ - Run neurofield and store output in NF object... + Run nftsim and store output in NF object... """ filename = filename.replace('.conf', '') - cmd = '%s -i %s.conf -o %s.output' % (neurofield_path, filename, filename) - LOG.info('Running neurofield with command: \n %s \n' % cmd) + cmd = '%s -i %s.conf -o %s.output' % (nftsim_path, filename, filename) + LOG.info('Running nftsim with command: \n %s \n' % cmd) result = os.system(cmd) if result: - LOG.error('The execution of NeuroField did not finish cleanly.') + LOG.error('The execution of NFTsim did not finish cleanly.') sys.exit() else: LOG.info('\nFinished. Output file was written to %s.output\n' % filename)