From 3eea0c4c055bf6100055a87c22aee9ada3810cdf Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Fri, 22 Nov 2024 13:35:22 -0700 Subject: [PATCH 01/12] working on differencing two temperatures --- .../src/fastsim_api/fastsim_api_utils.rs | 6 + fastsim-core/src/air_properties.rs | 407 ------------------ fastsim-core/src/lib.rs | 2 +- fastsim-core/src/prelude.rs | 2 +- fastsim-core/src/si.rs | 1 + fastsim-core/src/simdrive.rs | 6 +- fastsim-core/src/uc.rs | 2 + fastsim-core/src/vehicle/conv.rs | 1 + .../src/vehicle/powertrain/fuel_converter.rs | 127 +++++- .../powertrain/reversible_energy_storage.rs | 2 +- fastsim-core/src/vehicle/vehicle_model.rs | 6 + .../vehicle_model/fastsim2_interface.rs | 4 +- pyproject.toml | 2 +- 13 files changed, 140 insertions(+), 428 deletions(-) delete mode 100644 fastsim-core/src/air_properties.rs diff --git a/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs b/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs index d87da669..e25f276f 100755 --- a/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs +++ b/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs @@ -341,6 +341,12 @@ pub(crate) fn impl_getters_and_setters( "Pressure" => extract_units!(uom::si::pressure::kilopascal, uom::si::pressure::bar), "Ratio" => extract_units!(uom::si::ratio::ratio), "Time" => extract_units!(uom::si::time::second, uom::si::time::hour), + "HeatCapacity" => { + extract_units!( + uom::si::heat_capacity::joule_per_kelvin, + uom::si::heat_capacity::joule_per_degree_celsius + ) + } "ThermodynamicTemperature" => extract_units!( uom::si::thermodynamic_temperature::degree_celsius, uom::si::thermodynamic_temperature::kelvin diff --git a/fastsim-core/src/air_properties.rs b/fastsim-core/src/air_properties.rs deleted file mode 100644 index 918a608f..00000000 --- a/fastsim-core/src/air_properties.rs +++ /dev/null @@ -1,407 +0,0 @@ -use super::imports::*; -use super::*; - -lazy_static! { - /// room temperature - pub static ref TE_STD_AIR: si::ThermodynamicTemperature = (22. + 273.15) * uc::KELVIN; - /// pressure of air at 180 m and 22 C - pub static ref STD_PRESSURE_AIR: si::Pressure = 99_346.3 * uc::PASCAL; - /// density of air at 180 m ASL and 22 C - pub static ref STD_DENSITY_AIR: si::MassDensity = 1.172 * uc::KGPM3; - /// ideal gas constant for air - pub static ref R_AIR: si::SpecificHeatCapacity = 287.0 * uc::J_PER_KG_K; - /// standard elevation above sea level - pub static ref H_STD: si::Length = 180.0 * uc::M; -} - -#[fastsim_api( - /// Returns density of air [kg/m^3] - /// Source: - /// - /// # Equations used - /// T = 15.04 - .00649 * h - /// p = 101.29 * [(T + 273.1)/288.08]^5.256 - /// - /// # Arguments - /// * `te_air_deg_c` - optional ambient temperature [°C] of air, defaults to 22 C - /// * `h_m` - optional elevation [m] above sea level, defaults to 180 m - #[staticmethod] - #[pyo3(name = "get_density")] - pub fn get_density_py(te_air_deg_c: Option, h_m: Option) -> f64 { - Self::get_density( - te_air_deg_c.map(|te_air_deg_c| (te_air_deg_c + 273.15) * uc::KELVIN), - h_m.map(|h_m| h_m * uc::M), - ) - .get::() - } - - /// Returns thermal conductivity [W/(m*K)] of air - /// # Arguments - /// - `te_air`: temperature [°C] of air - #[pyo3(name = "get_therm_cond")] - #[staticmethod] - pub fn get_therm_cond_py(te_air: f64) -> anyhow::Result { - Ok(Self::get_therm_cond(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) - } - - /// Returns constant pressure specific heat [J/(kg*K)] of air - /// # Arguments - /// - `te_air`: temperature [°C] of air - #[pyo3(name = "get_specific_heat_cp")] - #[staticmethod] - pub fn get_specific_heat_cp_py(te_air: f64) -> anyhow::Result { - Ok(Self::get_specific_heat_cp(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) - } - - /// Returns specific enthalpy [J/kg] of air - /// # Arguments - /// - `te_air`: temperature [°C] of air - #[pyo3(name = "get_specific_enthalpy")] - #[staticmethod] - pub fn get_specific_enthalpy_py(te_air: f64) -> anyhow::Result { - Ok(Self::get_specific_enthalpy(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) - } - - /// Returns thermal Prandtl number of air - /// # Arguments - /// - `te_air`: temperature [°C] of air - #[pyo3(name = "get_pr")] - #[staticmethod] - pub fn get_pr_py(te_air: f64) -> anyhow::Result { - Ok(Self::get_pr(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) - } - - /// Returns dynamic viscosity \[Pa*s\] of air - /// # Arguments - /// te_air: temperature [°C] of air - #[pyo3(name = "get_dyn_visc")] - #[staticmethod] - pub fn get_dyn_visc_py(te_air: f64) -> anyhow::Result { - Ok(Self::get_dyn_visc(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) - } - - /// Returns temperature [°C] of air - /// # Arguments - /// - `h`: specific enthalpy of air \[J/kg\] - #[pyo3(name = "get_te_from_h")] - #[staticmethod] - pub fn get_te_from_h_py(h: f64) -> anyhow::Result { - Ok(Self::get_te_from_h(h * uc::J_PER_KG)?.get::()) - } - -)] -#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -pub struct Air {} -impl Init for Air {} -impl SerdeAPI for Air {} - -impl Air { - /// Returns density of air - /// Source: - /// Note that if `None` is passed for either argument, function evaluation should be faster - /// - /// # Equations used - /// - T = 15.04 - 0.00649 * h - /// - p = 101.29 * ((T + 273.1) / 288.08) ^ 5.256 - /// - /// # Arguments - /// * `te_air` - ambient temperature of air, defaults to 22 C - /// * `h` - elevation above sea level, defaults to 180 m - pub fn get_density( - te_air: Option, - h: Option, - ) -> si::MassDensity { - let std_pressure_at_elev = |h: si::Length| -> si::Pressure { - let std_temp_at_elev = (15.04 - 0.00649 * h.get::() + 273.15) * uc::KELVIN; - (101.29e3 * uc::PASCAL) - * ((std_temp_at_elev / (288.08 * uc::KELVIN)) - .get::() - .powf(5.256)) - }; - match (h, te_air) { - (None, None) => *STD_DENSITY_AIR, - (None, Some(te_air)) => *STD_PRESSURE_AIR / *R_AIR / te_air, - (Some(h_val), None) => std_pressure_at_elev(h_val) / *R_AIR / *TE_STD_AIR, - (Some(h_val), Some(te_air)) => std_pressure_at_elev(h_val) / *R_AIR / te_air, - } - } - - /// Returns thermal conductivity of air - /// # Arguments - /// - `te_air`: temperature of air - pub fn get_therm_cond( - te_air: si::ThermodynamicTemperature, - ) -> anyhow::Result { - Ok( - THERMAL_CONDUCTIVITY_INTERP.interpolate(&[te_air.get::()])? - * uc::WATT_PER_METER_KELVIN, - ) - } - - /// Returns constant pressure specific heat of air - /// # Arguments - /// - `te_air`: temperature of air - pub fn get_specific_heat_cp( - te_air: si::ThermodynamicTemperature, - ) -> anyhow::Result { - Ok(C_P_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG_K) - } - - /// Returns specific enthalpy of air - /// # Arguments - /// - `te_air`: temperature of air - pub fn get_specific_enthalpy( - te_air: si::ThermodynamicTemperature, - ) -> anyhow::Result { - Ok(ENTHALPY_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG) - } - - /// Returns thermal Prandtl number of air - /// # Arguments - /// - `te_air`: temperature of air - pub fn get_pr(te_air: si::ThermodynamicTemperature) -> anyhow::Result { - Ok(PRANDTL_INTERP.interpolate(&[te_air.get::()])? * uc::R) - } - - /// Returns dynamic viscosity \[Pa*s\] of air - /// # Arguments - /// te_air: temperature of air - pub fn get_dyn_visc( - te_air: si::ThermodynamicTemperature, - ) -> anyhow::Result { - Ok(DYN_VISC_INTERP.interpolate(&[te_air.get::()])? * uc::PASCAL_SECOND) - } - - /// Returns temperature of air - /// # Arguments - /// `h`: specific enthalpy of air \[J/kg\] - pub fn get_te_from_h(h: si::SpecificEnergy) -> anyhow::Result { - Ok(TEMP_FROM_ENTHALPY.interpolate(&[h.get::()])? * uc::KELVIN) - } -} - -use air_static_props::*; - -/// Fluid properties for calculations. -/// -/// Values obtained via (in Python): -/// ```python -/// >>> from CoolProp.CoolProp import PropsSI -/// >>> import numpy as np -/// >>> import pandas as pd -/// >>> T_degC = np.logspace(1, np.log10(5e3 + 70), 25) - 70 -/// >>> T = T_degC + 273.15 -/// >>> prop_dict = { -/// >>> 'T [°C]': T_degC, -/// >>> 'h [J/kg]': [0] * len(T), -/// >>> 'k [W/(m*K)]': [0] * len(T), -/// >>> 'rho [kg/m^3]': [0] * len(T), -/// >>> 'c_p [J/(kg*K)]': [0] * len(T), -/// >>> 'mu [Pa*s]': [0] * len(T), -/// >>> } -/// -/// >>> for i, _ in enumerate(T_degC): -/// >>> prop_dict['h [J/kg]'][i] = f"{PropsSI('H', 'P', 101325, 'T', T[i], 'Air'):.5g}" # specific enthalpy [J/(kg*K)] -/// >>> prop_dict['k [W/(m*K)]'][i] = f"{PropsSI('L', 'P', 101325, 'T', T[i], 'Air'):.5g}" # thermal conductivity [W/(m*K)] -/// >>> prop_dict['rho [kg/m^3]'][i] = f"{PropsSI('D', 'P', 101325, 'T', T[i], 'Air'):.5g}" # density [kg/m^3] -/// >>> prop_dict['c_p [J/(kg*K)]'][i] = f"{PropsSI('C', 'P', 101325, 'T', T[i], 'Air'):.5g}" # density [kg/m^3] -/// >>> prop_dict['mu [Pa*s]'][i] = f"{PropsSI('V', 'P', 101325, 'T', T[i], 'Air'):.5g}" # viscosity [Pa*s] -/// -/// >>> prop_df = pd.DataFrame(data=prop_dict) -/// >>> pd.set_option('display.float_format', lambda x: '%.3g' % x) -/// >>> prop_df = prop_df.apply(np.float64) -/// ``` -mod air_static_props { - use super::*; - lazy_static! { - /// Array of temperatures at which properties are evaluated - static ref TEMPERATURE_VALUES: Vec = [-60., - -57.03690616, - -53.1958198, - -48.21658352, - -41.7619528, - -33.39475442, - -22.54827664, - -8.48788571, - 9.73873099, - 33.36606527, - 63.99440042, - 103.69819869, - 155.16660498, - 221.88558305, - 308.37402042, - 420.48979341, - 565.82652205, - 754.22788725, - 998.45434496, - 1315.04739396, - 1725.44993435, - 2257.45859876, - 2947.10642291, - 3841.10336915, - 5000.] - .iter() - .map(|x| *x * uc::KELVIN + *uc::CELSIUS_TO_KELVIN) - .collect(); - pub static ref TEMP_FROM_ENTHALPY: Interp1D = Interp1D::new( - ENTHALPY_VALUES.iter().map(|x| x.get::()).collect::>(), - TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), - Strategy::Linear, - Extrapolate::Error - ).unwrap(); - /// Thermal conductivity values of air corresponding to temperature values - static ref THERMAL_CONDUCTIVITY_VALUES: Vec = [ - 0.019597, - 0.019841, - 0.020156, - 0.020561, - 0.021083, - 0.021753, - 0.022612, - 0.023708, - 0.025102, - 0.026867, - 0.02909, - 0.031875, - 0.035342, - 0.039633, - 0.044917, - 0.051398, - 0.059334, - 0.069059, - 0.081025, - 0.095855, - 0.11442, - 0.13797, - 0.16828, - 0.20795, - 0.26081] - .iter() - .map(|x| *x * uc::WATT_PER_METER_KELVIN) - .collect(); - pub static ref THERMAL_CONDUCTIVITY_INTERP: Interp1D = Interp1D::new( - TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), - THERMAL_CONDUCTIVITY_VALUES.iter().map(|x| x.get::()).collect::>(), - Strategy::Linear, - Extrapolate::Error - ).unwrap(); - /// Specific heat values of air corresponding to temperature values - static ref C_P_VALUES: Vec = [ - 1006.2, - 1006.1, - 1006., - 1005.9, - 1005.7, - 1005.6, - 1005.5, - 1005.6, - 1005.9, - 1006.6, - 1008.3, - 1011.6, - 1017.9, - 1028.9, - 1047., - 1073.4, - 1107.6, - 1146.1, - 1184.5, - 1219.5, - 1250.1, - 1277.1, - 1301.7, - 1324.5, - 1347.] - .iter() - .map(|x| *x * uc::J_PER_KG_K) - .collect(); - pub static ref C_P_INTERP: Interp1D = Interp1D::new( - TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), - C_P_VALUES.iter().map(|x| x.get::()).collect::>(), - Strategy::Linear, - Extrapolate::Error - ).unwrap(); - static ref ENTHALPY_VALUES: Vec = [ - 338940., - 341930., - 345790., - 350800., - 357290., - 365710., - 376610., - 390750., - 409080., - 432860., - 463710., - 503800., - 556020., - 624280., - 714030., - 832880., - 991400., - 1203800., - 1488700., - 1869600., - 2376700., - 3049400., - 3939100., - 5113600., - 6662000.] - .iter() - .map(|x| *x * uc::J_PER_KG) - .collect(); - pub static ref ENTHALPY_INTERP: Interp1D = Interp1D::new( - TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), - ENTHALPY_VALUES.iter().map(|x| x.get::()).collect::>(), - Strategy::Linear, - Extrapolate::Error - ).unwrap(); - static ref DYN_VISCOSITY_VALUES: Vec = [ - 1.4067e-05, - 1.4230e-05, - 1.4440e-05, - 1.4711e-05, - 1.5058e-05, - 1.5502e-05, - 1.6069e-05, - 1.6791e-05, - 1.7703e-05, - 1.8850e-05, - 2.0283e-05, - 2.2058e-05, - 2.4240e-05, - 2.6899e-05, - 3.0112e-05, - 3.3966e-05, - 3.8567e-05, - 4.4049e-05, - 5.0595e-05, - 5.8464e-05, - 6.8036e-05, - 7.9878e-05, - 9.4840e-05, - 1.1423e-04, - 1.4006e-04] - .iter() - .map(|x| *x * uc::PASCAL_SECOND) - .collect(); - pub static ref DYN_VISC_INTERP: Interp1D = Interp1D::new( - TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), - DYN_VISCOSITY_VALUES.iter().map(|x| x.get::()).collect::>(), - Strategy::Linear, - Extrapolate::Error - ).unwrap(); - static ref PRANDTL_VALUES: Vec = DYN_VISCOSITY_VALUES - .iter() - .zip(C_P_VALUES.iter()) - .zip(THERMAL_CONDUCTIVITY_VALUES.iter()) - .map(|((mu, c_p), k)| -> si::Ratio {*mu * *c_p / *k}) - .collect::>(); - pub static ref PRANDTL_INTERP: Interp1D = Interp1D::new( - TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), - PRANDTL_VALUES.iter().map(|x| x.get::()).collect::>(), - Strategy::Linear, - Extrapolate::Error - ).unwrap(); - } -} diff --git a/fastsim-core/src/lib.rs b/fastsim-core/src/lib.rs index dc502c38..53ce43d4 100755 --- a/fastsim-core/src/lib.rs +++ b/fastsim-core/src/lib.rs @@ -11,8 +11,8 @@ #[macro_use] pub mod macros; -pub mod air_properties; pub mod drive_cycle; +pub mod gas_properties; pub mod imports; pub mod prelude; // #[cfg(feature = "pyo3")] -- feature gate provided inside module diff --git a/fastsim-core/src/prelude.rs b/fastsim-core/src/prelude.rs index 21b2a3c9..43da7f28 100755 --- a/fastsim-core/src/prelude.rs +++ b/fastsim-core/src/prelude.rs @@ -1,8 +1,8 @@ //! Convenience module for exposing commonly used structs // NOTE: consider exposing more structs and other stuff here -pub use crate::air_properties::Air; pub use crate::drive_cycle::{Cycle, CycleElement}; +pub use crate::gas_properties::{Air, Octane, TE_STD_AIR}; pub use crate::simdrive::{SimDrive, SimParams}; pub use crate::utils::{Pyo3Vec2Wrapper, Pyo3Vec3Wrapper, Pyo3VecBoolWrapper, Pyo3VecWrapper}; pub use crate::vehicle::cabin::{CabinOption, SingleCapacitanceCabin}; diff --git a/fastsim-core/src/si.rs b/fastsim-core/src/si.rs index 2ec9b703..e23e778a 100644 --- a/fastsim-core/src/si.rs +++ b/fastsim-core/src/si.rs @@ -16,6 +16,7 @@ pub use si::f64::{ Velocity, Volume, }; pub use si::force::{newton, pound_force}; +pub use si::heat_capacity::{joule_per_degree_celsius, joule_per_kelvin}; pub use si::length::{foot, kilometer, meter}; pub use si::mass::{kilogram, megagram}; pub use si::mass_density::kilogram_per_cubic_meter; diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index 8878e6e5..abb8d0bd 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -17,7 +17,7 @@ pub struct SimParams { #[api(skip_get, skip_set)] pub trace_miss_opts: TraceMissOptions, /// whether to use FASTSim-2 style air density - pub f2_air_density: bool, + pub f2_const_air_density: bool, } impl SerdeAPI for SimParams {} @@ -31,7 +31,7 @@ impl Default for SimParams { ach_speed_solver_gain: 0.9, trace_miss_tol: Default::default(), trace_miss_opts: Default::default(), - f2_air_density: true, + f2_const_air_density: true, } } } @@ -240,7 +240,7 @@ impl SimDrive { .interpolate(&[vs.dist.get::()])? }; - vs.air_density = if self.sim_params.f2_air_density { + vs.air_density = if self.sim_params.f2_const_air_density { 1.2 * uc::KGPM3 } else { let te_amb_air = match &self.cyc.temp_amb_air { diff --git a/fastsim-core/src/uc.rs b/fastsim-core/src/uc.rs index 08421595..5f737f42 100644 --- a/fastsim-core/src/uc.rs +++ b/fastsim-core/src/uc.rs @@ -43,6 +43,8 @@ unit_const!(MI, Length, 1.609_344_E3); unit_const!(M2, Area, 1.0); unit_const!(FT2, Area, 9.290_304_E-2); unit_const!(M3, Volume, 1.0); +unit_const!(L, Volume, 1.0E-3); +unit_const!(GALLON, Volume, 0.003785); unit_const!(S, Time, 1.0); unit_const!(MIN, Time, 60.0); diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index ba355ed7..2ed39e36 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -53,6 +53,7 @@ impl Powertrain for Box { Ok(()) } + fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { Ok((self.fc.state.pwr_prop_max, si::Power::ZERO)) } diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index 1377d004..584df6c7 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -1,3 +1,5 @@ +use crate::prelude::{Air, Octane, TE_STD_AIR}; + use super::*; // TODO: think about how to incorporate life modeling for Fuel Cells and other tech @@ -52,7 +54,7 @@ pub struct FuelConverter { /// [Self] Thermal plant, including thermal management controls #[serde(default, skip_serializing_if = "FuelConverterThermalOption::is_none")] #[api(skip_get, skip_set)] - pub thermal_plant: FuelConverterThermalOption, + pub thrml: FuelConverterThermalOption, /// [Self] mass #[serde(default)] #[api(skip_get, skip_set)] @@ -103,7 +105,7 @@ impl SerdeAPI for FuelConverter {} impl Init for FuelConverter { fn init(&mut self) -> anyhow::Result<()> { let _ = self.mass().with_context(|| anyhow!(format_dbg!()))?; - self.thermal_plant.init()?; + self.thrml.init()?; self.state.init().with_context(|| anyhow!(format_dbg!()))?; let eff_max = self.eff_max()?; self.pwr_for_peak_eff = *self @@ -245,6 +247,7 @@ impl FuelConverter { fc_on: bool, dt: si::Time, ) -> anyhow::Result<()> { + self.thrml.solve().with_context(|| format_dbg!())?; self.state.fc_on = fc_on; if fc_on { self.state.time_on += dt; @@ -392,39 +395,139 @@ impl Init for FuelConverterThermalOption { } } impl SerdeAPI for FuelConverterThermalOption {} +impl FuelConverterThermalOption { + fn solve( + &mut self, + te_amb: si::ThermodynamicTemperature, + heat_demand: si::Power, + heat_gen: si::Power, + dt: si::Time, + ) -> anyhow::Result<()> { + match self { + Self::FuelConverterThermal(fct) => fct + .solve(te_amb, heat_demand, heat_gen, dt) + .with_context(|| format_dbg!())?, + Self::None => {} + } + Ok(()) + } +} #[fastsim_api] #[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] /// Struct for modeling Fuel Converter (e.g. engine, fuel cell.) pub struct FuelConverterThermal { /// [FuelConverter] thermal capacitance - pub heat_capacitance: si::SpecificEnergy, + pub heat_capacitance: si::HeatCapacity, /// parameter for engine characteristic length for heat transfer calcs pub length_for_convection: si::Length, /// parameter for heat transfer coeff from [FuelConverter] to ambient during vehicle stop pub htc_to_amb_stop: si::ThermalConductance, - - /// coefficient for fraction of combustion heat that goes to [FuelConverter] + /// Coefficient for max fraction of combustion heat minus shaft power + /// that goes to [FuelConverter] (engine) thermal mass. Remainder goes to + /// environment via tailpipe. + pub max_coeff_from_comb: si::Ratio, + /// heat transfer coefficient for combustion heat that goes to [FuelConverter] /// (engine) thermal mass. Remainder goes to environment (e.g. via tailpipe). - pub coeff_from_comb: si::Ratio, + pub htc_from_comb: si::ThermalConductance, /// parameter for temperature at which thermostat starts to open #[api(skip_get, skip_set)] - pub tstat_te_sto_deg_c: Option, + pub tstat_te_sto: Option, /// temperature delta over which thermostat is partially open #[api(skip_get, skip_set)] - pub tstat_te_delta_deg_c: Option, + pub tstat_te_delta: Option, /// radiator effectiveness -- ratio of active heat rejection from /// radiator to passive heat rejection - pub rad_eps: si::Ratio, + pub radiator_effectiveness: si::Ratio, + /// struct for tracking current state + #[serde(default)] + #[serde(skip_serializing_if = "EqDefault::eq_default")] + pub state: FuelConverterThermalState, + /// Custom vector of [Self::state] + #[serde(default)] + #[serde(skip_serializing_if = "FuelConverterThermalStateHistoryVec::is_empty")] + pub history: FuelConverterThermalStateHistoryVec, +} + +lazy_static! { + /// gasoline stoichiometric air-fuel ratio https://en.wikipedia.org/wiki/Air%E2%80%93fuel_ratio + pub static ref AFR_STOICH_GASOLINE: si::Ratio = uc::R * 14.7; + /// gasoline density in https://inchem.org/documents/icsc/icsc/eics1400.htm + /// This is reasonably constant with respect to temperature and pressure + pub static ref GASOLINE_DENSITY: si::MassDensity = 0.75 * uc::KG / uc::L; + /// TODO: find a source for this value + pub static ref GASOLINE_LHV: si::SpecificEnergy = 33.7 * uc::KWH / uc::GALLON / *GASOLINE_DENSITY; + pub static ref TE_ADIABATIC_STD: si::ThermodynamicTemperature = Air::get_te_from_u( + Air::get_specific_energy(*TE_STD_AIR).with_context(|| format_dbg!()).unwrap() + + (Octane::get_specific_energy(*TE_STD_AIR).with_context(|| format_dbg!()).unwrap() + + *GASOLINE_LHV) + / *AFR_STOICH_GASOLINE, + ) + .with_context(|| format_dbg!()).unwrap(); } +impl FuelConverterThermal { + /// Solve change in temperature and other thermal effects + /// # Arguments + /// - `te_amb`: ambient temperature + /// - `heat_demand`: heat demand from HVAC system + /// - `heat_gen`: total combustion heat minus shaft power + fn solve( + &mut self, + te_amb: si::ThermodynamicTemperature, + heat_demand: si::Power, + heat_gen: si::Power, + dt: si::Time, + ) -> anyhow::Result<()> { + // assumes fuel/air mixture is entering combustion chamber at block temperature + // assumes stoichiometric combustion + self.state.te_adiabatic = Air::get_te_from_u( + Air::get_specific_energy(self.state.temp).with_context(|| format_dbg!())? + + (Octane::get_specific_energy(self.state.temp).with_context(|| format_dbg!())? + + *GASOLINE_LHV) + / *AFR_STOICH_GASOLINE, + ) + .with_context(|| format_dbg!())?; + self.state.temp = self.state.temp + + (((self.htc_from_comb * (self.state.te_adiabatic - self.state.temp)) + .min(self.max_coeff_from_comb * heat_gen) + - heat_demand) + * dt) + / self.heat_capacitance; + Ok(()) + } +} impl SerdeAPI for FuelConverterThermal {} impl Init for FuelConverterThermal { fn init(&mut self) -> anyhow::Result<()> { - self.tstat_te_sto_deg_c = self - .tstat_te_sto_deg_c + self.tstat_te_sto = self + .tstat_te_sto .or(Some(85. * uc::KELVIN + *uc::CELSIUS_TO_KELVIN)); - self.tstat_te_delta_deg_c = self.tstat_te_delta_deg_c.or(Some(5. * uc::KELVIN_INT)); + self.tstat_te_delta = self.tstat_te_delta.or(Some(5. * uc::KELVIN_INT)); Ok(()) } } + +#[fastsim_api] +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative)] +pub struct FuelConverterThermalState { + /// time step index + pub i: usize, + /// Adiabatic flame temperature assuming complete (i.e. all fuel is consumed + /// if fuel lean or stoich or all air is consumed if fuel rich) combustion + pub te_adiabatic: si::ThermodynamicTemperature, + /// Current engine thermal mass temperature (lumped engine block and coolant) + pub temp: si::ThermodynamicTemperature, +} + +impl Init for FuelConverterThermalState {} +impl SerdeAPI for FuelConverterThermalState {} +impl Default for FuelConverterThermalState { + fn default() -> Self { + Self { + i: Default::default(), + te_adiabatic: *TE_ADIABATIC_STD, + temp: *TE_STD_AIR, + } + } +} diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index f4962306..a9c1bdc1 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -583,7 +583,7 @@ impl Default for ReversibleEnergyStorageState { energy_aux: si::Energy::ZERO, energy_loss: si::Energy::ZERO, energy_out_chemical: si::Energy::ZERO, - temperature: *crate::air_properties::TE_STD_AIR, + temperature: *crate::gas_properties::TE_STD_AIR, } } } diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index f0e8aa95..3d4dd9b8 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -426,6 +426,12 @@ impl Vehicle { Ok(()) } + + pub fn solve_thermal(&mut self) -> anyhow::Result<()> { + self.pt_type.solve_thermal(); + todo!(); + Ok(()) + } } /// Vehicle state for current time step diff --git a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs index a8935d17..54910d09 100644 --- a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs +++ b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs @@ -57,7 +57,7 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { fc: { let mut fc = FuelConverter { state: Default::default(), - thermal_plant: Default::default(), + thrml: Default::default(), mass: None, specific_pwr: Some(f2veh.fc_kw_per_kg * uc::KW / uc::KG), pwr_out_max: f2veh.fc_max_kw * uc::KW, @@ -130,7 +130,7 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { fc: { let mut fc = FuelConverter { state: Default::default(), - thermal_plant: Default::default(), + thrml: Default::default(), mass: None, specific_pwr: Some(f2veh.fc_kw_per_kg * uc::KW / uc::KG), pwr_out_max: f2veh.fc_max_kw * uc::KW, diff --git a/pyproject.toml b/pyproject.toml index a9a24dea..6a8f386b 100644 --- a/pyproject.toml +++ b/pyproject.toml @@ -25,7 +25,7 @@ dependencies = [ "seaborn>=0.10", "typing_extensions", "pypi-multi-versions", - "PyYAML==6.0.2" + "PyYAML==6.0.2", ] [project.urls] From 890d9da3a4208af0a2074e6a58698bfdc00a85fa Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Mon, 25 Nov 2024 12:43:11 -0700 Subject: [PATCH 02/12] FC and cabin thermal models are built and being implemented next step: battery thermal model and HVAC controls --- .../src/fastsim_api/fastsim_api_utils.rs | 8 +- fastsim-core/src/drive_cycle.rs | 5 +- fastsim-core/src/gas_properties.rs | 663 ++++++++++++++++++ fastsim-core/src/imports.rs | 1 + fastsim-core/src/prelude.rs | 2 +- fastsim-core/src/si.rs | 12 +- fastsim-core/src/simdrive.rs | 14 + fastsim-core/src/uc.rs | 5 +- fastsim-core/src/vehicle/bev.rs | 4 + fastsim-core/src/vehicle/conv.rs | 9 + fastsim-core/src/vehicle/hev.rs | 14 + .../src/vehicle/powertrain/fuel_converter.rs | 163 ++++- .../powertrain/reversible_energy_storage.rs | 14 +- fastsim-core/src/vehicle/powertrain/traits.rs | 8 + fastsim-core/src/vehicle/powertrain_type.rs | 14 + fastsim-core/src/vehicle/vehicle_model.rs | 12 +- python/fastsim/demos/demo_conv.py | 4 +- 17 files changed, 895 insertions(+), 57 deletions(-) create mode 100644 fastsim-core/src/gas_properties.rs diff --git a/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs b/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs index e25f276f..6b95d6e7 100755 --- a/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs +++ b/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs @@ -341,16 +341,16 @@ pub(crate) fn impl_getters_and_setters( "Pressure" => extract_units!(uom::si::pressure::kilopascal, uom::si::pressure::bar), "Ratio" => extract_units!(uom::si::ratio::ratio), "Time" => extract_units!(uom::si::time::second, uom::si::time::hour), + "HeatTransferCoeff" => extract_units!( + uom::si::heat_transfer::watt_per_square_meter_degree_celsius, + uom::si::heat_transfer::watt_per_square_meter_kelvin + ), "HeatCapacity" => { extract_units!( uom::si::heat_capacity::joule_per_kelvin, uom::si::heat_capacity::joule_per_degree_celsius ) } - "ThermodynamicTemperature" => extract_units!( - uom::si::thermodynamic_temperature::degree_celsius, - uom::si::thermodynamic_temperature::kelvin - ), "TemperatureInterval" => extract_units!( uom::si::temperature_interval::degree_celsius, uom::si::temperature_interval::kelvin diff --git a/fastsim-core/src/drive_cycle.rs b/fastsim-core/src/drive_cycle.rs index f390b3ca..5c67944c 100644 --- a/fastsim-core/src/drive_cycle.rs +++ b/fastsim-core/src/drive_cycle.rs @@ -54,7 +54,7 @@ pub struct Cycle { pub elev_interp: Option, /// ambient air temperature w.r.t. to time (rather than spatial position) #[api(skip_get, skip_set)] - pub temp_amb_air: Option>, + pub temp_amb_air: Option>, } lazy_static! { @@ -68,6 +68,9 @@ impl Init for Cycle { fn init(&mut self) -> anyhow::Result<()> { ensure!(self.time.len() == self.speed.len()); ensure!(self.grade.len() == self.len()); + if let Some(te_amb_air) = &self.temp_amb_air { + ensure!(te_amb_air.len() == self.time.len()); + } // TODO: figure out if this should be uncommented -- probably need to use a `match` // somewhere to fix this ensure!(self.pwr_max_chrg.len() == self.len()); diff --git a/fastsim-core/src/gas_properties.rs b/fastsim-core/src/gas_properties.rs new file mode 100644 index 00000000..324d4f30 --- /dev/null +++ b/fastsim-core/src/gas_properties.rs @@ -0,0 +1,663 @@ +use crate::imports::*; + +lazy_static! { + /// room temperature + pub static ref TE_STD_AIR: si::TemperatureInterval= (22. + 273.15) * uc::KELVIN; + /// pressure of air at 180 m and 22 C + pub static ref STD_PRESSURE_AIR: si::Pressure = 99_346.3 * uc::PASCAL; + /// density of air at 180 m ASL and 22 C + pub static ref STD_DENSITY_AIR: si::MassDensity = 1.172 * uc::KGPM3; + /// ideal gas constant for air + pub static ref R_AIR: si::SpecificHeatCapacity = 287.0 * uc::J_PER_KG_K; + /// standard elevation above sea level + pub static ref H_STD: si::Length = 180.0 * uc::M; +} + +#[fastsim_api( + /// Returns density of air [kg/m^3] + /// Source: + /// + /// # Equations used + /// T = 15.04 - .00649 * h + /// p = 101.29 * [(T + 273.1)/288.08]^5.256 + /// + /// # Arguments + /// * `te_air_deg_c` - optional ambient temperature [°C] of air, defaults to 22 C + /// * `h_m` - optional elevation [m] above sea level, defaults to 180 m + #[staticmethod] + #[pyo3(name = "get_density")] + pub fn get_density_py(te_air_deg_c: Option, h_m: Option) -> f64 { + Self::get_density( + te_air_deg_c.map(|te_air_deg_c| (te_air_deg_c + 273.15) * uc::KELVIN), + h_m.map(|h_m| h_m * uc::M), + ) + .get::() + } + + /// Returns thermal conductivity [W/(m*K)] of air + /// # Arguments + /// - `te_air`: temperature [°C] of air + #[pyo3(name = "get_therm_cond")] + #[staticmethod] + pub fn get_therm_cond_py(te_air: f64) -> anyhow::Result { + Ok(Self::get_therm_cond(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns constant pressure specific heat [J/(kg*K)] of air + /// # Arguments + /// - `te_air`: temperature [°C] of air + #[pyo3(name = "get_specific_heat_cp")] + #[staticmethod] + pub fn get_specific_heat_cp_py(te_air: f64) -> anyhow::Result { + Ok(Self::get_specific_heat_cp(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns specific enthalpy [J/kg] of air + /// # Arguments + /// - `te_air`: temperature [°C] of air + #[pyo3(name = "get_specific_enthalpy")] + #[staticmethod] + pub fn get_specific_enthalpy_py(te_air: f64) -> anyhow::Result { + Ok(Self::get_specific_enthalpy(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns specific energy [J/kg] of air + /// # Arguments + /// - `te_air`: temperature [°C] of air + #[pyo3(name = "get_specific_energy")] + #[staticmethod] + pub fn get_specific_energy_py(te_air: f64) -> anyhow::Result { + Ok(Self::get_specific_energy(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns thermal Prandtl number of air + /// # Arguments + /// - `te_air`: temperature [°C] of air + #[pyo3(name = "get_pr")] + #[staticmethod] + pub fn get_pr_py(te_air: f64) -> anyhow::Result { + Ok(Self::get_pr(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns dynamic viscosity \[Pa*s\] of air + /// # Arguments + /// te_air: temperature [°C] of air + #[pyo3(name = "get_dyn_visc")] + #[staticmethod] + pub fn get_dyn_visc_py(te_air: f64) -> anyhow::Result { + Ok(Self::get_dyn_visc(te_air * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns temperature [°C] of air + /// # Arguments + /// - `h`: specific enthalpy of air \[J/kg\] + #[pyo3(name = "get_te_from_h")] + #[staticmethod] + pub fn get_te_from_h_py(h: f64) -> anyhow::Result { + Ok(Self::get_te_from_h(h * uc::J_PER_KG)?.get::()) + } + + /// Returns temperature [°C] of air + /// # Arguments + /// - `u`: specific energy of air \[J/kg\] + #[pyo3(name = "get_te_from_u")] + #[staticmethod] + pub fn get_te_from_u_py(u: f64) -> anyhow::Result { + Ok(Self::get_te_from_u(u * uc::J_PER_KG)?.get::()) + } + +)] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +pub struct Air {} +impl Init for Air {} +impl SerdeAPI for Air {} + +impl Air { + /// Returns density of air + /// Source: + /// Note that if `None` is passed for either argument, function evaluation should be faster + /// + /// # Equations used + /// - T = 15.04 - 0.00649 * h + /// - p = 101.29 * ((T + 273.1) / 288.08) ^ 5.256 + /// + /// # Arguments + /// * `te_air` - ambient temperature of air, defaults to 22 C + /// * `h` - elevation above sea level, defaults to 180 m + pub fn get_density( + te_air: Option, + h: Option, + ) -> si::MassDensity { + let std_pressure_at_elev = |h: si::Length| -> si::Pressure { + let std_temp_at_elev = (15.04 - 0.00649 * h.get::() + 273.15) * uc::KELVIN; + (101.29e3 * uc::PASCAL) + * ((std_temp_at_elev / (288.08 * uc::KELVIN)) + .get::() + .powf(5.256)) + }; + match (h, te_air) { + (None, None) => *STD_DENSITY_AIR, + (None, Some(te_air)) => *STD_PRESSURE_AIR / *R_AIR / te_air, + (Some(h_val), None) => std_pressure_at_elev(h_val) / *R_AIR / *TE_STD_AIR, + (Some(h_val), Some(te_air)) => std_pressure_at_elev(h_val) / *R_AIR / te_air, + } + } + + /// Returns thermal conductivity of air + /// # Arguments + /// - `te_air`: temperature of air + pub fn get_therm_cond( + te_air: si::TemperatureInterval, + ) -> anyhow::Result { + Ok( + asp::THERMAL_CONDUCTIVITY_INTERP.interpolate(&[te_air.get::()])? + * uc::WATT_PER_METER_KELVIN, + ) + } + + /// Returns constant pressure specific heat of air + /// # Arguments + /// - `te_air`: temperature of air + pub fn get_specific_heat_cp( + te_air: si::TemperatureInterval, + ) -> anyhow::Result { + Ok(asp::C_P_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG_K) + } + + /// Returns specific enthalpy of air + /// # Arguments + /// - `te_air`: temperature of air + pub fn get_specific_enthalpy( + te_air: si::TemperatureInterval, + ) -> anyhow::Result { + Ok(asp::ENTHALPY_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG) + } + + /// Returns specific energy of air + /// # Arguments + /// - `te_air`: temperature of air + pub fn get_specific_energy( + te_air: si::TemperatureInterval, + ) -> anyhow::Result { + Ok(asp::ENERGY_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG) + } + + /// Returns thermal Prandtl number of air + /// # Arguments + /// - `te_air`: temperature of air + pub fn get_pr(te_air: si::TemperatureInterval) -> anyhow::Result { + Ok(asp::PRANDTL_INTERP.interpolate(&[te_air.get::()])? * uc::R) + } + + /// Returns dynamic viscosity \[Pa*s\] of air + /// # Arguments + /// te_air: temperature of air + pub fn get_dyn_visc(te_air: si::TemperatureInterval) -> anyhow::Result { + Ok(asp::DYN_VISC_INTERP.interpolate(&[te_air.get::()])? * uc::PASCAL_SECOND) + } + + /// Returns temperature of air + /// # Arguments + /// `h`: specific enthalpy of air \[J/kg\] + pub fn get_te_from_h(h: si::SpecificEnergy) -> anyhow::Result { + Ok(asp::TEMP_FROM_ENTHALPY.interpolate(&[h.get::()])? * uc::KELVIN) + } + + /// Returns temperature of air + /// # Arguments + /// `u`: specific energy of air \[J/kg\] + pub fn get_te_from_u(u: si::SpecificEnergy) -> anyhow::Result { + Ok(asp::TEMP_FROM_ENERGY.interpolate(&[u.get::()])? * uc::KELVIN) + } +} + +use air_static_props as asp; + +/// Air fluid properties for calculations. +/// +/// Values obtained via (in Python, after running `pip install CoolProp`): +/// ```python +/// from CoolProp.CoolProp import PropsSI +/// import numpy as np +/// import pandas as pd +/// T_degC = np.logspace(1, np.log10(5e3 + 70), 25) - 70 +/// T = T_degC + 273.15 +/// prop_dict = { +/// 'T [°C]': T_degC, +/// 'h [J/kg]': [0] * len(T), +/// 'u [J/kg]': [0] * len(T), +/// 'k [W/(m*K)]': [0] * len(T), +/// 'rho [kg/m^3]': [0] * len(T), +/// 'c_p [J/(kg*K)]': [0] * len(T), +/// 'mu [Pa*s]': [0] * len(T), +/// } +/// +/// species = "Air" +/// +/// for i, _ in enumerate(T_degC): +/// prop_dict['h [J/kg]'][i] = f"{PropsSI('H', 'P', 101325, 'T', T[i], species):.5g}" # specific enthalpy [J/(kg*K)] +/// prop_dict['u [J/kg]'][i] = f"{PropsSI('U', 'P', 101325, 'T', T[i], species):.5g}" # specific enthalpy [J/(kg*K)] +/// prop_dict['k [W/(m*K)]'][i] = f"{PropsSI('L', 'P', 101325, 'T', T[i], species):.5g}" # thermal conductivity [W/(m*K)] +/// prop_dict['rho [kg/m^3]'][i] = f"{PropsSI('D', 'P', 101325, 'T', T[i], species):.5g}" # density [kg/m^3] +/// prop_dict['c_p [J/(kg*K)]'][i] = f"{PropsSI('C', 'P', 101325, 'T', T[i], species):.5g}" # density [kg/m^3] +/// prop_dict['mu [Pa*s]'][i] = f"{PropsSI('V', 'P', 101325, 'T', T[i], species):.5g}" # viscosity [Pa*s] +/// +/// prop_df = pd.DataFrame(data=prop_dict) +/// pd.set_option('display.float_format', lambda x: '%.3g' % x) +/// prop_df = prop_df.apply(np.float64) +/// ``` +mod air_static_props { + use super::*; + lazy_static! { + /// Array of temperatures at which properties are evaluated + static ref TEMPERATURE_VALUES: Vec = [ + -60., + -57.03690616, + -53.1958198, + -48.21658352, + -41.7619528, + -33.39475442, + -22.54827664, + -8.48788571, + 9.73873099, + 33.36606527, + 63.99440042, + 103.69819869, + 155.16660498, + 221.88558305, + 308.37402042, + 420.48979341, + 565.82652205, + 754.22788725, + 998.45434496, + 1315.04739396, + 1725.44993435, + 2257.45859876, + 2947.10642291, + 3841.10336915, + 5000. + ] + .iter() + .map(|x| *x * uc::KELVIN + *uc::CELSIUS_TO_KELVIN) + .collect(); + pub static ref TEMP_FROM_ENTHALPY: Interp1D = Interp1D::new( + ENTHALPY_VALUES.iter().map(|x| x.get::()).collect::>(), + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + pub static ref TEMP_FROM_ENERGY: Interp1D = Interp1D::new( + ENERGY_VALUES.iter().map(|x| x.get::()).collect::>(), + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + /// Thermal conductivity values of air corresponding to temperature values + static ref THERMAL_CONDUCTIVITY_VALUES: Vec = [ + 0.019597, + 0.019841, + 0.020156, + 0.020561, + 0.021083, + 0.021753, + 0.022612, + 0.023708, + 0.025102, + 0.026867, + 0.02909, + 0.031875, + 0.035342, + 0.039633, + 0.044917, + 0.051398, + 0.059334, + 0.069059, + 0.081025, + 0.095855, + 0.11442, + 0.13797, + 0.16828, + 0.20795, + 0.26081 + ] + .iter() + .map(|x| *x * uc::WATT_PER_METER_KELVIN) + .collect(); + pub static ref THERMAL_CONDUCTIVITY_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + THERMAL_CONDUCTIVITY_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + /// Specific heat values of air corresponding to temperature values + static ref C_P_VALUES: Vec = [ + 1006.2, + 1006.1, + 1006., + 1005.9, + 1005.7, + 1005.6, + 1005.5, + 1005.6, + 1005.9, + 1006.6, + 1008.3, + 1011.6, + 1017.9, + 1028.9, + 1047., + 1073.4, + 1107.6, + 1146.1, + 1184.5, + 1219.5, + 1250.1, + 1277.1, + 1301.7, + 1324.5, + 1347. + ] + .iter() + .map(|x| *x * uc::J_PER_KG_K) + .collect(); + pub static ref C_P_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + C_P_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + static ref ENTHALPY_VALUES: Vec = [ + 338940., + 341930., + 345790., + 350800., + 357290., + 365710., + 376610., + 390750., + 409080., + 432860., + 463710., + 503800., + 556020., + 624280., + 714030., + 832880., + 991400., + 1203800., + 1488700., + 1869600., + 2376700., + 3049400., + 3939100., + 5113600., + 6662000. + ] + .iter() + .map(|x| *x * uc::J_PER_KG) + .collect(); + pub static ref ENTHALPY_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + ENTHALPY_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + pub static ref ENERGY_VALUES: Vec = [ + 277880., + 280000., + 282760., + 286330., + 290960., + 296960., + 304750., + 314840., + 327920., + 344890., + 366940., + 395620., + 433040., + 482140., + 547050., + 633700., + 750490., + 908830., + 1123600., + 1413600., + 1802900., + 2322900., + 3014700., + 3932500., + 5148300. + ] + .iter() + .map(|x| *x * uc::J_PER_KG) + .collect(); + pub static ref ENERGY_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + ENERGY_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + static ref DYN_VISCOSITY_VALUES: Vec = [ + 1.4067e-05, + 1.4230e-05, + 1.4440e-05, + 1.4711e-05, + 1.5058e-05, + 1.5502e-05, + 1.6069e-05, + 1.6791e-05, + 1.7703e-05, + 1.8850e-05, + 2.0283e-05, + 2.2058e-05, + 2.4240e-05, + 2.6899e-05, + 3.0112e-05, + 3.3966e-05, + 3.8567e-05, + 4.4049e-05, + 5.0595e-05, + 5.8464e-05, + 6.8036e-05, + 7.9878e-05, + 9.4840e-05, + 1.1423e-04, + 1.4006e-04 + ] + .iter() + .map(|x| *x * uc::PASCAL_SECOND) + .collect(); + pub static ref DYN_VISC_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + DYN_VISCOSITY_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + static ref PRANDTL_VALUES: Vec = DYN_VISCOSITY_VALUES + .iter() + .zip(C_P_VALUES.iter()) + .zip(THERMAL_CONDUCTIVITY_VALUES.iter()) + .map(|((mu, c_p), k)| -> si::Ratio {*mu * *c_p / *k}) + .collect::>(); + pub static ref PRANDTL_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + PRANDTL_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + } +} + +use octane_static_props as osp; + +/// Octane (as a surrogate for gasoline) fluid properties for calculations. +/// +/// Values obtained via (in Python, after running `pip install CoolProp`): +/// ```python +/// from CoolProp.CoolProp import PropsSI +/// import numpy as np +/// import pandas as pd +/// T_degC = np.logspace(1, np.log10(5e3 + 70), 25) - 50 +/// T = T_degC + 273.15 +/// prop_dict = { +/// 'T [°C]': T_degC, +/// 'h [J/kg]': [0] * len(T), +/// 'u [J/kg]': [0] * len(T), +/// 'k [W/(m*K)]': [0] * len(T), +/// 'rho [kg/m^3]': [0] * len(T), +/// 'c_p [J/(kg*K)]': [0] * len(T), +/// 'mu [Pa*s]': [0] * len(T), +/// } +/// +/// species = "Octane" +/// +/// for i, _ in enumerate(T_degC): +/// prop_dict['h [J/kg]'][i] = f"{PropsSI('H', 'P', 101325, 'T', T[i], species):.5g}" # specific enthalpy [J/(kg*K)] +/// prop_dict['u [J/kg]'][i] = f"{PropsSI('U', 'P', 101325, 'T', T[i], species):.5g}" # specific enthalpy [J/(kg*K)] +/// prop_dict['k [W/(m*K)]'][i] = f"{PropsSI('L', 'P', 101325, 'T', T[i], species):.5g}" # thermal conductivity [W/(m*K)] +/// prop_dict['rho [kg/m^3]'][i] = f"{PropsSI('D', 'P', 101325, 'T', T[i], species):.5g}" # density [kg/m^3] +/// prop_dict['c_p [J/(kg*K)]'][i] = f"{PropsSI('C', 'P', 101325, 'T', T[i], species):.5g}" # density [kg/m^3] +/// prop_dict['mu [Pa*s]'][i] = f"{PropsSI('V', 'P', 101325, 'T', T[i], species):.5g}" # viscosity [Pa*s] +/// +/// prop_df = pd.DataFrame(data=prop_dict) +/// pd.set_option('display.float_format', lambda x: '%.3g' % x) +/// prop_df = prop_df.apply(np.float64) +/// ``` +mod octane_static_props { + use super::*; + lazy_static! { + /// Array of temperatures at which properties are evaluated + static ref TEMPERATURE_VALUES: Vec = [ + -4.00000000e+01, + -3.70369062e+01, + -3.31958198e+01, + -2.82165835e+01, + -2.17619528e+01, + -1.33947544e+01, + -2.54827664e+00, + 1.15121143e+01, + 2.97387310e+01, + 5.33660653e+01, + 8.39944004e+01, + 1.23698199e+02, + 1.75166605e+02, + 2.41885583e+02, + 3.28374020e+02, + 4.40489793e+02, + 5.85826522e+02, + 7.74227887e+02, + 1.01845434e+03, + 1.33504739e+03, + 1.74544993e+03, + 2.27745860e+03, + 2.96710642e+03, + 3.86110337e+03, + 5.02000000e+03 + ] + .iter() + .map(|x| *x * uc::KELVIN + *uc::CELSIUS_TO_KELVIN) + .collect(); + pub static ref TEMP_FROM_ENERGY: Interp1D = Interp1D::new( + ENERGY_VALUES.iter().map(|x| x.get::()).collect::>(), + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + pub static ref ENERGY_VALUES: Vec = [ + -3.8247e+05, + -3.7645e+05, + -3.6862e+05, + -3.5841e+05, + -3.4507e+05, + -3.2760e+05, + -3.0464e+05, + -2.7432e+05, + -2.3400e+05, + -1.7991e+05, + -1.0649e+05, + -5.3074e+03, + 3.8083e+05, + 5.3958e+05, + 7.6926e+05, + 1.1024e+06, + 1.5836e+06, + 2.2729e+06, + 3.2470e+06, + 4.6015e+06, + 6.4541e+06, + 8.9500e+06, + 1.2272e+07, + 1.6654e+07, + 2.2399e+07 + ] + .iter() + .map(|x| *x * uc::J_PER_KG) + .collect(); + pub static ref ENERGY_INTERP: Interp1D = Interp1D::new( + TEMPERATURE_VALUES.iter().map(|x| x.get::()).collect::>(), + ENERGY_VALUES.iter().map(|x| x.get::()).collect::>(), + Strategy::Linear, + Extrapolate::Error + ).unwrap(); + } +} + +#[fastsim_api( + /// Returns specific energy [J/kg] of octane + /// # Arguments + /// - `te_octane`: temperature [°C] of octane + #[pyo3(name = "get_specific_energy")] + #[staticmethod] + pub fn get_specific_energy_py(te_octane: f64) -> anyhow::Result { + Ok(Self::get_specific_energy(te_octane * uc::KELVIN - *uc::CELSIUS_TO_KELVIN)?.get::()) + } + + /// Returns temperature [°C] of octane + /// # Arguments + /// - `u`: specific energy of octane \[J/kg\] + #[pyo3(name = "get_te_from_u")] + #[staticmethod] + pub fn get_te_from_u_py(u: f64) -> anyhow::Result { + Ok(Self::get_te_from_u(u * uc::J_PER_KG)?.get::()) + } +)] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +pub struct Octane {} +impl Init for Octane {} +impl SerdeAPI for Octane {} + +impl Octane { + /// Returns specific energy of octane + /// # Arguments + /// - `te_octane`: temperature of octane + pub fn get_specific_energy( + te_octane: si::TemperatureInterval, + ) -> anyhow::Result { + Ok(osp::ENERGY_INTERP.interpolate(&[te_octane.get::()])? * uc::J_PER_KG) + } + + /// Returns temperature of octane + /// # Arguments + /// `u`: specific energy of octane \[J/kg\] + pub fn get_te_from_u(u: si::SpecificEnergy) -> anyhow::Result { + Ok(osp::TEMP_FROM_ENERGY.interpolate(&[u.get::()])? * uc::KELVIN) + } +} + +/// Given Reynolds number `re`, return C and m to calculate Nusselt number for +/// sphere, from Incropera's Intro to Heat Transfer, 5th Ed., eq. 7.44 +pub fn get_sphere_conv_params(re: f64) -> (f64, f64) { + let (c, m) = if re < 4.0 { + (0.989, 0.330) + } else if re < 40.0 { + (0.911, 0.385) + } else if re < 4e3 { + (0.683, 0.466) + } else if re < 40e3 { + (0.193, 0.618) + } else { + (0.027, 0.805) + }; + (c, m) +} diff --git a/fastsim-core/src/imports.rs b/fastsim-core/src/imports.rs index ca8b970a..e7945e68 100644 --- a/fastsim-core/src/imports.rs +++ b/fastsim-core/src/imports.rs @@ -31,6 +31,7 @@ pub(crate) use serde::{Deserialize, Serialize}; pub(crate) use std::cmp::{self, Ordering}; pub(crate) use std::collections::{BinaryHeap, HashMap, HashSet, VecDeque}; pub(crate) use std::error::Error; +pub(crate) use std::f64::consts::PI; pub(crate) use std::ffi::OsStr; pub(crate) use std::fmt; pub(crate) use std::fs::File; diff --git a/fastsim-core/src/prelude.rs b/fastsim-core/src/prelude.rs index 43da7f28..9d13967d 100755 --- a/fastsim-core/src/prelude.rs +++ b/fastsim-core/src/prelude.rs @@ -2,7 +2,7 @@ // NOTE: consider exposing more structs and other stuff here pub use crate::drive_cycle::{Cycle, CycleElement}; -pub use crate::gas_properties::{Air, Octane, TE_STD_AIR}; +pub use crate::gas_properties::{get_sphere_conv_params, Air, Octane, TE_STD_AIR}; pub use crate::simdrive::{SimDrive, SimParams}; pub use crate::utils::{Pyo3Vec2Wrapper, Pyo3Vec3Wrapper, Pyo3VecBoolWrapper, Pyo3VecWrapper}; pub use crate::vehicle::cabin::{CabinOption, SingleCapacitanceCabin}; diff --git a/fastsim-core/src/si.rs b/fastsim-core/src/si.rs index e23e778a..672f4b38 100644 --- a/fastsim-core/src/si.rs +++ b/fastsim-core/src/si.rs @@ -10,13 +10,14 @@ pub use si::dynamic_viscosity::pascal_second; pub use si::energy::{joule, kilowatt_hour, watt_hour}; pub use si::f64::{ Acceleration, Angle, Area, AvailableEnergy as SpecificEnergy, Curvature, DynamicViscosity, - Energy, Force, Frequency, HeatCapacity, InverseVelocity, Length, Mass, MassDensity, - MomentOfInertia, Power, PowerRate, Pressure, Ratio, SpecificHeatCapacity, SpecificPower, - TemperatureInterval, ThermalConductance, ThermalConductivity, ThermodynamicTemperature, Time, - Velocity, Volume, + Energy, Force, Frequency, HeatCapacity, HeatTransfer as HeatTransferCoeff, InverseVelocity, + Length, Mass, MassDensity, MomentOfInertia, Power, PowerRate, Pressure, Ratio, + SpecificHeatCapacity, SpecificPower, TemperatureInterval, ThermalConductance, + ThermalConductivity, Time, Velocity, Volume, }; pub use si::force::{newton, pound_force}; pub use si::heat_capacity::{joule_per_degree_celsius, joule_per_kelvin}; +pub use si::heat_transfer::{watt_per_square_meter_degree_celsius, watt_per_square_meter_kelvin}; pub use si::length::{foot, kilometer, meter}; pub use si::mass::{kilogram, megagram}; pub use si::mass_density::kilogram_per_cubic_meter; @@ -29,10 +30,9 @@ pub use si::specific_heat_capacity::{ joule_per_kilogram_degree_celsius, joule_per_kilogram_kelvin, }; pub use si::specific_power::{kilowatt_per_kilogram, watt_per_kilogram}; -pub use si::temperature_interval::{degree_celsius as degree_celsius_int, kelvin as kelvin_int}; +pub use si::temperature_interval::{degree_celsius, kelvin}; pub use si::thermal_conductance::watt_per_kelvin; pub use si::thermal_conductivity::{watt_per_meter_degree_celsius, watt_per_meter_kelvin}; -pub use si::thermodynamic_temperature::{degree_celsius, kelvin}; pub use si::time::{hour, second}; pub use si::velocity::{meter_per_second, mile_per_hour}; pub use si::volume::cubic_meter; diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index abb8d0bd..0db2116c 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -199,6 +199,20 @@ impl SimDrive { self.veh .solve_powertrain(dt) .with_context(|| anyhow!(format_dbg!()))?; + self.veh + .solve_thermal( + self.cyc.temp_amb_air.with_context(|| { + format!( + "{}\n{}", + format_dbg!(), + "Expected to have `te_amb_air` provided in `Cycle`" + ) + })?[i] + .clone(), + self.veh.state.speed_ach, + dt, + ) + .with_context(|| format_dbg!())?; self.veh.set_cumulative(dt); Ok(()) } diff --git a/fastsim-core/src/uc.rs b/fastsim-core/src/uc.rs index 5f737f42..2db96fec 100644 --- a/fastsim-core/src/uc.rs +++ b/fastsim-core/src/uc.rs @@ -86,10 +86,9 @@ unit_const!( ); lazy_static::lazy_static! { - pub static ref CELSIUS_TO_KELVIN: crate::si::TemperatureInterval = 273.15 * KELVIN_INT; + pub static ref CELSIUS_TO_KELVIN: crate::si::TemperatureInterval = 273.15 * KELVIN; } -unit_const!(KELVIN, ThermodynamicTemperature, 1.0); -unit_const!(KELVIN_INT, TemperatureInterval, 1.0); +unit_const!(KELVIN, TemperatureInterval, 1.0); unit_const!(J_PER_KG_K, SpecificHeatCapacity, 1.0); unit_const!(J_PER_K, HeatCapacity, 1.0); unit_const!(J_PER_KG, SpecificEnergy, 1.0); diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index 36a34b37..c0becc42 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -138,6 +138,10 @@ impl Powertrain for BatteryElectricVehicle { Ok(()) } + fn solve_thermal(&mut self) -> anyhow::Result<()> { + todo!() + } + fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { Ok(( self.em.state.pwr_mech_fwd_out_max, diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index 2ed39e36..7d7d7d6e 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -53,6 +53,15 @@ impl Powertrain for Box { Ok(()) } + fn solve_thermal( + &mut self, + te_amb: si::TemperatureInterval, + heat_demand: si::Power, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()> { + self.fc.solve_thermal(te_amb, heat_demand, veh_speed, dt) + } fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { Ok((self.fc.state.pwr_prop_max, si::Power::ZERO)) diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index f73d3b2b..dc5e554e 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -199,6 +199,20 @@ impl Powertrain for Box { Ok(()) } + fn solve_thermal( + &mut self, + te_amb: si::TemperatureInterval, + heat_demand: si::Power, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()> { + self.fc + .solve_thermal(te_amb, heat_demand, veh_speed, dt) + .with_context(|| format_dbg!())?; + todo!(); + self.res.solve_thermal() + } + fn pwr_regen(&self) -> si::Power { // When `pwr_mech_prop_out` is negative, regen is happening. First, clip it at 0, and then negate it. // see https://play.rust-lang.org/?version=stable&mode=debug&edition=2021&gist=e8f7af5a6e436dd1163fa3c70931d18d diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index 584df6c7..7f8f086c 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -1,6 +1,6 @@ -use crate::prelude::{Air, Octane, TE_STD_AIR}; - use super::*; +use crate::prelude::*; +use serde::Deserializer; // TODO: think about how to incorporate life modeling for Fuel Cells and other tech @@ -211,11 +211,10 @@ impl FuelConverter { // TODO: think about how to initialize power self.pwr_out_max_init = self.pwr_out_max / 10. }; - self.state.pwr_out_max = (self.state.pwr_propulsion - + self.state.pwr_aux - + self.pwr_out_max / self.pwr_ramp_lag * dt) - .min(self.pwr_out_max) - .max(self.pwr_out_max_init); + self.state.pwr_out_max = + (self.state.pwr_prop + self.state.pwr_aux + self.pwr_out_max / self.pwr_ramp_lag * dt) + .min(self.pwr_out_max) + .max(self.pwr_out_max_init); Ok(()) } @@ -247,7 +246,6 @@ impl FuelConverter { fc_on: bool, dt: si::Time, ) -> anyhow::Result<()> { - self.thrml.solve().with_context(|| format_dbg!())?; self.state.fc_on = fc_on; if fc_on { self.state.time_on += dt; @@ -276,7 +274,7 @@ impl FuelConverter { self.state.pwr_aux.get::() ) ); - self.state.pwr_propulsion = pwr_out_req; + self.state.pwr_prop = pwr_out_req; self.state.eff = if fc_on { uc::R * self @@ -309,7 +307,7 @@ impl FuelConverter { } else { si::Power::ZERO }; - self.state.pwr_loss = self.state.pwr_fuel - self.state.pwr_propulsion; + self.state.pwr_loss = self.state.pwr_fuel - self.state.pwr_prop; // TODO: put this in `SetCumulative::set_custom_cumulative` // ensure!( @@ -322,6 +320,19 @@ impl FuelConverter { Ok(()) } + pub fn solve_thermal( + &mut self, + te_amb: si::TemperatureInterval, + heat_demand: si::Power, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()> { + self.thrml + .solve(&self.state, te_amb, heat_demand, veh_speed, dt) + .with_context(|| format_dbg!())?; + Ok(()) + } + pub fn eff_max(&self) -> anyhow::Result { Ok(self .eff_interp_from_pwr_out @@ -352,9 +363,9 @@ pub struct FuelConverterState { /// efficiency evaluated at current demand pub eff: si::Ratio, /// instantaneous power going to drivetrain, not including aux - pub pwr_propulsion: si::Power, + pub pwr_prop: si::Power, /// integral of [Self::pwr_propulsion] - pub energy_propulsion: si::Energy, + pub energy_prop: si::Energy, /// power going to auxiliaries pub pwr_aux: si::Power, /// Integral of [Self::pwr_aux] @@ -396,16 +407,23 @@ impl Init for FuelConverterThermalOption { } impl SerdeAPI for FuelConverterThermalOption {} impl FuelConverterThermalOption { + /// Solve change in temperature and other thermal effects + /// # Arguments + /// - `fc_state`: [FuelConverter] state + /// - `te_amb`: ambient temperature + /// - `heat_demand`: heat demand from HVAC system + /// - `veh_speed`: current achieved speed fn solve( &mut self, - te_amb: si::ThermodynamicTemperature, + fc_state: &FuelConverterState, + te_amb: si::TemperatureInterval, heat_demand: si::Power, - heat_gen: si::Power, + veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { match self { Self::FuelConverterThermal(fct) => fct - .solve(te_amb, heat_demand, heat_gen, dt) + .solve(fc_state, te_amb, heat_demand, veh_speed, dt) .with_context(|| format_dbg!())?, Self::None => {} } @@ -419,25 +437,30 @@ impl FuelConverterThermalOption { pub struct FuelConverterThermal { /// [FuelConverter] thermal capacitance pub heat_capacitance: si::HeatCapacity, - /// parameter for engine characteristic length for heat transfer calcs + /// Parameter for engine characteristic length for heat transfer calcs. For + /// these calculations, the engine is treated as a sphere to enable speed-dependent + /// calculations that don't require a large number of parameters. pub length_for_convection: si::Length, /// parameter for heat transfer coeff from [FuelConverter] to ambient during vehicle stop - pub htc_to_amb_stop: si::ThermalConductance, + pub htc_to_amb_stop: si::HeatTransferCoeff, /// Coefficient for max fraction of combustion heat minus shaft power /// that goes to [FuelConverter] (engine) thermal mass. Remainder goes to /// environment via tailpipe. - pub max_coeff_from_comb: si::Ratio, + pub max_frac_from_comb: si::Ratio, /// heat transfer coefficient for combustion heat that goes to [FuelConverter] /// (engine) thermal mass. Remainder goes to environment (e.g. via tailpipe). pub htc_from_comb: si::ThermalConductance, /// parameter for temperature at which thermostat starts to open #[api(skip_get, skip_set)] - pub tstat_te_sto: Option, + pub tstat_te_sto: Option, /// temperature delta over which thermostat is partially open #[api(skip_get, skip_set)] pub tstat_te_delta: Option, - /// radiator effectiveness -- ratio of active heat rejection from - /// radiator to passive heat rejection + #[serde(skip_serializing, deserialize_with = "tstat_interp_default")] + #[api(skip_get, skip_set)] + pub tstat_interp: Interp1D, + /// Radiator effectiveness -- ratio of active heat rejection from + /// radiator to passive heat rejection, always greater than 1 pub radiator_effectiveness: si::Ratio, /// struct for tracking current state #[serde(default)] @@ -449,6 +472,21 @@ pub struct FuelConverterThermal { pub history: FuelConverterThermalStateHistoryVec, } +/// Dummy interpolator that will be overridden in [FuelConverterThermal::init] +fn tstat_interp_default<'de, D>(_deserializer: D) -> Result +where + D: Deserializer<'de>, +{ + Ok(Interp1D::new( + vec![85.0, 90.0], + vec![0.0, 1.0], + Strategy::Linear, + Extrapolate::Clamp, + ) + .with_context(|| format_dbg!()) + .unwrap()) +} + lazy_static! { /// gasoline stoichiometric air-fuel ratio https://en.wikipedia.org/wiki/Air%E2%80%93fuel_ratio pub static ref AFR_STOICH_GASOLINE: si::Ratio = uc::R * 14.7; @@ -457,7 +495,7 @@ lazy_static! { pub static ref GASOLINE_DENSITY: si::MassDensity = 0.75 * uc::KG / uc::L; /// TODO: find a source for this value pub static ref GASOLINE_LHV: si::SpecificEnergy = 33.7 * uc::KWH / uc::GALLON / *GASOLINE_DENSITY; - pub static ref TE_ADIABATIC_STD: si::ThermodynamicTemperature = Air::get_te_from_u( + pub static ref TE_ADIABATIC_STD: si::TemperatureInterval= Air::get_te_from_u( Air::get_specific_energy(*TE_STD_AIR).with_context(|| format_dbg!()).unwrap() + (Octane::get_specific_energy(*TE_STD_AIR).with_context(|| format_dbg!()).unwrap() + *GASOLINE_LHV) @@ -469,16 +507,61 @@ lazy_static! { impl FuelConverterThermal { /// Solve change in temperature and other thermal effects /// # Arguments + /// - `fc_state`: [FuelConverter] state /// - `te_amb`: ambient temperature /// - `heat_demand`: heat demand from HVAC system - /// - `heat_gen`: total combustion heat minus shaft power + /// - `veh_speed`: current achieved speed + /// - `dt`: simulation time step size fn solve( &mut self, - te_amb: si::ThermodynamicTemperature, + fc_state: &FuelConverterState, + te_amb: si::TemperatureInterval, heat_demand: si::Power, - heat_gen: si::Power, + veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { + // film temperature for external convection calculations + let te_air_film = 0.5 * (self.state.temp + te_amb); + // Reynolds number = density * speed * diameter / dynamic viscosity + // NOTE: might be good to pipe in elevation + let fc_air_film_re = + Air::get_density(Some(te_air_film), None) * veh_speed * self.length_for_convection + / Air::get_dyn_visc(te_air_film).with_context(|| format_dbg!())?; + + // calculate heat transfer coeff. from engine to ambient [W / (m ** 2 * K)] + self.state.htc_to_amb = if veh_speed < 1.0 * uc::MPS { + // if stopped, scale based on thermostat opening and constant convection + (uc::R + + self + .tstat_interp + .interpolate(&[self.state.temp.get::()]) + .with_context(|| format_dbg!())? + * self.radiator_effectiveness) + * self.htc_to_amb_stop + } else { + // Calculate heat transfer coefficient for sphere, + // from Incropera's Intro to Heat Transfer, 5th Ed., eq. 7.44 + let sphere_conv_params = get_sphere_conv_params(fc_air_film_re.get::()); + let htc_to_amb_sphere: si::HeatTransferCoeff = sphere_conv_params.0 + * fc_air_film_re.get::().powf(sphere_conv_params.1) + * Air::get_pr(te_air_film) + .with_context(|| format_dbg!())? + .get::() + .powf(1.0 / 3.0) + * Air::get_therm_cond(te_air_film).with_context(|| format_dbg!())? + / self.length_for_convection; + // if stopped, scale based on thermostat opening and constant convection + self.tstat_interp + .interpolate(&[self.state.temp.get::()]) + .with_context(|| format_dbg!())? + * htc_to_amb_sphere + }; + + self.state.heat_to_amb = + self.state.htc_to_amb * PI * self.length_for_convection.powi(typenum::P2::new()) / 4.0 + * (self.state.temp - te_amb); + + // let heat_to_amb = ; // assumes fuel/air mixture is entering combustion chamber at block temperature // assumes stoichiometric combustion self.state.te_adiabatic = Air::get_te_from_u( @@ -488,10 +571,13 @@ impl FuelConverterThermal { / *AFR_STOICH_GASOLINE, ) .with_context(|| format_dbg!())?; + // heat that will go both to the block and out the exhaust port + let heat_gen = fc_state.pwr_fuel - fc_state.pwr_prop; self.state.temp = self.state.temp + (((self.htc_from_comb * (self.state.te_adiabatic - self.state.temp)) - .min(self.max_coeff_from_comb * heat_gen) - - heat_demand) + .min(self.max_frac_from_comb * heat_gen) + - heat_demand + - self.state.heat_to_amb) * dt) / self.heat_capacitance; Ok(()) @@ -503,7 +589,18 @@ impl Init for FuelConverterThermal { self.tstat_te_sto = self .tstat_te_sto .or(Some(85. * uc::KELVIN + *uc::CELSIUS_TO_KELVIN)); - self.tstat_te_delta = self.tstat_te_delta.or(Some(5. * uc::KELVIN_INT)); + self.tstat_te_delta = self.tstat_te_delta.or(Some(5. * uc::KELVIN)); + self.tstat_interp = Interp1D::new( + vec![ + self.tstat_te_sto.unwrap().get::(), + self.tstat_te_sto.unwrap().get::() + + self.tstat_te_delta.unwrap().get::(), + ], + vec![0.0, 1.0], + Strategy::Linear, + Extrapolate::Clamp, + ) + .with_context(|| format_dbg!())?; Ok(()) } } @@ -515,9 +612,13 @@ pub struct FuelConverterThermalState { pub i: usize, /// Adiabatic flame temperature assuming complete (i.e. all fuel is consumed /// if fuel lean or stoich or all air is consumed if fuel rich) combustion - pub te_adiabatic: si::ThermodynamicTemperature, + pub te_adiabatic: si::TemperatureInterval, /// Current engine thermal mass temperature (lumped engine block and coolant) - pub temp: si::ThermodynamicTemperature, + pub temp: si::TemperatureInterval, + /// Current heat transfer coefficient from [FuelConverter] to ambient + pub htc_to_amb: si::HeatTransferCoeff, + /// Current heat transfer to ambient + pub heat_to_amb: si::Power, } impl Init for FuelConverterThermalState {} @@ -528,6 +629,8 @@ impl Default for FuelConverterThermalState { i: Default::default(), te_adiabatic: *TE_ADIABATIC_STD, temp: *TE_STD_AIR, + htc_to_amb: Default::default(), + heat_to_amb: Default::default(), } } } diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index a9c1bdc1..7b6541b5 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -117,8 +117,8 @@ impl ReversibleEnergyStorage { state.soc.get::() ); - state.pwr_out_propulsion = pwr_out_req; - state.pwr_out_electrical = state.pwr_out_propulsion + state.pwr_aux; + state.pwr_out_prop = pwr_out_req; + state.pwr_out_electrical = state.pwr_out_prop + state.pwr_aux; if pwr_out_req + state.pwr_aux >= si::Power::ZERO { // discharging @@ -536,7 +536,7 @@ pub struct ReversibleEnergyStorageState { /// total electrical power; positive is discharging pub pwr_out_electrical: si::Power, /// electrical power going to propulsion - pub pwr_out_propulsion: si::Power, + pub pwr_out_prop: si::Power, /// electrical power going to aux loads pub pwr_aux: si::Power, /// power dissipated as loss @@ -548,7 +548,7 @@ pub struct ReversibleEnergyStorageState { /// cumulative total electrical energy; positive is discharging pub energy_out_electrical: si::Energy, /// cumulative electrical energy going to propulsion - pub energy_out_propulsion: si::Energy, + pub energy_out_prop: si::Energy, /// cumulative electrical energy going to aux loads pub energy_aux: si::Energy, /// cumulative energy dissipated as loss @@ -557,7 +557,7 @@ pub struct ReversibleEnergyStorageState { pub energy_out_chemical: si::Energy, /// component temperature - pub temperature: si::ThermodynamicTemperature, + pub temperature: si::TemperatureInterval, } impl Default for ReversibleEnergyStorageState { @@ -574,12 +574,12 @@ impl Default for ReversibleEnergyStorageState { eff: si::Ratio::ZERO, soh: 0., pwr_out_electrical: si::Power::ZERO, - pwr_out_propulsion: si::Power::ZERO, + pwr_out_prop: si::Power::ZERO, pwr_aux: si::Power::ZERO, pwr_loss: si::Power::ZERO, pwr_out_chemical: si::Power::ZERO, energy_out_electrical: si::Energy::ZERO, - energy_out_propulsion: si::Energy::ZERO, + energy_out_prop: si::Energy::ZERO, energy_aux: si::Energy::ZERO, energy_loss: si::Energy::ZERO, energy_out_chemical: si::Energy::ZERO, diff --git a/fastsim-core/src/vehicle/powertrain/traits.rs b/fastsim-core/src/vehicle/powertrain/traits.rs index 8ffcc5c4..cf7209a2 100644 --- a/fastsim-core/src/vehicle/powertrain/traits.rs +++ b/fastsim-core/src/vehicle/powertrain/traits.rs @@ -35,6 +35,14 @@ pub trait Powertrain { dt: si::Time, ) -> anyhow::Result<()>; + fn solve_thermal( + &mut self, + te_amb: si::TemperatureInterval, + heat_demand: si::Power, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()>; + /// Returns regen power after `Powertrain::solve` has been called fn pwr_regen(&self) -> si::Power; } diff --git a/fastsim-core/src/vehicle/powertrain_type.rs b/fastsim-core/src/vehicle/powertrain_type.rs index 475588c8..0dfaa03c 100644 --- a/fastsim-core/src/vehicle/powertrain_type.rs +++ b/fastsim-core/src/vehicle/powertrain_type.rs @@ -47,6 +47,20 @@ impl Powertrain for PowertrainType { } } + fn solve_thermal( + &mut self, + te_amb: si::TemperatureInterval, + heat_demand: si::Power, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()> { + match self { + Self::ConventionalVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_speed, dt), + Self::HybridElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_speed, dt), + Self::BatteryElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_speed, dt), + } + } + fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { match self { Self::ConventionalVehicle(v) => v.get_curr_pwr_prop_out_max(), diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index 3d4dd9b8..5254bb36 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -427,9 +427,15 @@ impl Vehicle { Ok(()) } - pub fn solve_thermal(&mut self) -> anyhow::Result<()> { - self.pt_type.solve_thermal(); - todo!(); + pub fn solve_thermal( + &mut self, + te_amb: si::TemperatureInterval, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()> { + let heat_demand = si::Power::ZERO; + self.pt_type + .solve_thermal(te_amb, heat_demand, veh_speed, dt); Ok(()) } } diff --git a/python/fastsim/demos/demo_conv.py b/python/fastsim/demos/demo_conv.py index 8b465341..5c4500a8 100644 --- a/python/fastsim/demos/demo_conv.py +++ b/python/fastsim/demos/demo_conv.py @@ -159,7 +159,7 @@ def plot_fc_energy() -> Tuple[Figure, Axes]: ax[0].set_prop_cycle(get_paired_cycler()) ax[0].plot( np.array(sd.cyc.time_seconds)[::veh.save_interval], - (np.array(sd.veh.fc.history.energy_propu_on_joules) + + (np.array(sd.veh.fc.history.energy_prop_on_joules) + np.array(sd.veh.fc.history.energy_aux_joules)) / 1e6, label="f3 shaft", ) @@ -184,7 +184,7 @@ def plot_fc_energy() -> Tuple[Figure, Axes]: ax[1].set_prop_cycle(get_uni_cycler()) ax[1].plot( np.array(sd.cyc.time_seconds)[::veh.save_interval], - (np.array(sd.veh.fc.history.energy_propu_on_joules) + + (np.array(sd.veh.fc.history.energy_prop_on_joules) + np.array(sd.veh.fc.history.energy_aux_joules)) / 1e6 - np.array(sd2.fc_cumu_mj_out_ach.tolist()), label="shaft", ) From b4a7d8701d9be476625f5e54ba47491e5aa7f74f Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Wed, 27 Nov 2024 12:50:56 -0700 Subject: [PATCH 03/12] cabin and hvac are mostly implemented. no errors but failing tests --- Cargo.lock | 1 - fastsim-core/Cargo.toml | 4 - .../fastsim-proc-macros/src/fastsim_api.rs | 20 -- .../src/fastsim_api/fastsim_api_utils.rs | 2 +- fastsim-core/fastsim-proc-macros/src/lib.rs | 3 +- fastsim-core/src/drive_cycle.rs | 16 +- fastsim-core/src/gas_properties.rs | 43 ++- fastsim-core/src/lib.rs | 2 - fastsim-core/src/prelude.rs | 2 +- fastsim-core/src/si.rs | 3 +- fastsim-core/src/simdrive.rs | 31 +-- fastsim-core/src/traits.rs | 27 -- fastsim-core/src/uc.rs | 8 +- fastsim-core/src/utils/mod.rs | 1 + fastsim-core/src/vehicle/bev.rs | 10 +- fastsim-core/src/vehicle/cabin.rs | 253 +++++++++++++++++- fastsim-core/src/vehicle/conv.rs | 2 +- fastsim-core/src/vehicle/hev.rs | 10 +- fastsim-core/src/vehicle/mod.rs | 1 + .../src/vehicle/powertrain/fuel_converter.rs | 49 ++-- .../powertrain/reversible_energy_storage.rs | 6 +- fastsim-core/src/vehicle/powertrain/traits.rs | 2 +- fastsim-core/src/vehicle/powertrain_type.rs | 2 +- fastsim-core/src/vehicle/traits.rs | 2 +- fastsim-core/src/vehicle/vehicle_model.rs | 7 +- .../to_dataframe_expected.csv | 2 +- .../variable_path_list_expected.txt | 8 +- 27 files changed, 349 insertions(+), 168 deletions(-) diff --git a/Cargo.lock b/Cargo.lock index 9e14f4a3..62388736 100644 --- a/Cargo.lock +++ b/Cargo.lock @@ -608,7 +608,6 @@ name = "fastsim-core" version = "1.0.0" dependencies = [ "anyhow", - "bincode", "csv", "derive_more", "document-features", diff --git a/fastsim-core/Cargo.toml b/fastsim-core/Cargo.toml index d843a4e1..23c7d380 100644 --- a/fastsim-core/Cargo.toml +++ b/fastsim-core/Cargo.toml @@ -15,7 +15,6 @@ paste = "1.0.7" easy-ext = "1.0.0" rayon = "1.5.3" document-features = { workspace = true } -bincode = { version = "1.3.3", optional = true } anyhow = { workspace = true } readonly = "0.2.3" duplicate = "0.4.1" @@ -50,9 +49,6 @@ resources = ["dep:include_dir"] web = ["dep:ureq", "dep:url"] ## Enables several text file formats for serialization and deserialization serde-default = ["csv", "json", "toml", "yaml"] -## Enables binary serialization and deserialization -- somewhat experimental and -## may eventually be deprecated -bincode = ["dep:bincode"] ## Enables csv serialization and deserialization csv = ["dep:csv"] ## Enables json serialization and deserialization diff --git a/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs b/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs index 835ecde9..6c06f41d 100644 --- a/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs +++ b/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs @@ -159,26 +159,6 @@ fn add_serde_methods(py_impl_block: &mut TokenStream2) { Self::from_str(contents, format, skip_init.unwrap_or_default()).map_err(|e| PyIOError::new_err(format!("{:?}", e))) } - /// Write (serialize) an object to bincode-encoded `bytes` - #[cfg(feature = "bincode")] - #[pyo3(name = "to_bincode")] - pub fn to_bincode_py<'py>(&self, py: Python<'py>) -> PyResult<&'py PyBytes> { - PyResult::Ok(PyBytes::new(py, &self.to_bincode()?)).map_err(|e| PyIOError::new_err(format!("{:?}", e))) - } - - /// Read (deserialize) an object from bincode-encoded `bytes` - /// - /// # Arguments - /// - /// * `encoded`: `bytes` - Encoded bytes to deserialize from - /// - #[cfg(feature = "bincode")] - #[staticmethod] - #[pyo3(name = "from_bincode")] - pub fn from_bincode_py(encoded: &PyBytes, skip_init: Option) -> PyResult { - Self::from_bincode(encoded.as_bytes(), skip_init.unwrap_or_default()).map_err(|e| PyIOError::new_err(format!("{:?}", e))) - } - /// Write (serialize) an object to a JSON string #[cfg(feature = "json")] #[pyo3(name = "to_json")] diff --git a/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs b/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs index 6b95d6e7..affde322 100755 --- a/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs +++ b/fastsim-core/fastsim-proc-macros/src/fastsim_api/fastsim_api_utils.rs @@ -351,7 +351,7 @@ pub(crate) fn impl_getters_and_setters( uom::si::heat_capacity::joule_per_degree_celsius ) } - "TemperatureInterval" => extract_units!( + "Temperature" => extract_units!( uom::si::temperature_interval::degree_celsius, uom::si::temperature_interval::kelvin ), diff --git a/fastsim-core/fastsim-proc-macros/src/lib.rs b/fastsim-core/fastsim-proc-macros/src/lib.rs index 697b91a2..981c12c0 100755 --- a/fastsim-core/fastsim-proc-macros/src/lib.rs +++ b/fastsim-core/fastsim-proc-macros/src/lib.rs @@ -39,7 +39,8 @@ pub fn history_vec_derive(input: TokenStream) -> TokenStream { } #[proc_macro_derive(SetCumulative)] -/// generate method to implement `SetCumulative` trait +/// generate method to implement `SetCumulative` trait for all `pwr_*` and +/// corresponding `energy_*` fields pub fn cumu_method_derive(input: TokenStream) -> TokenStream { cumu_method_derive::cumu_method_derive(input) } diff --git a/fastsim-core/src/drive_cycle.rs b/fastsim-core/src/drive_cycle.rs index 5c67944c..6497c04f 100644 --- a/fastsim-core/src/drive_cycle.rs +++ b/fastsim-core/src/drive_cycle.rs @@ -1,4 +1,5 @@ use crate::imports::*; +use crate::prelude::*; use fastsim_2::cycle::RustCycle as Cycle2; #[fastsim_api( @@ -53,8 +54,9 @@ pub struct Cycle { #[api(skip_get, skip_set)] pub elev_interp: Option, /// ambient air temperature w.r.t. to time (rather than spatial position) + #[serde(default)] #[api(skip_get, skip_set)] - pub temp_amb_air: Option>, + pub temp_amb_air: Vec, } lazy_static! { @@ -68,8 +70,10 @@ impl Init for Cycle { fn init(&mut self) -> anyhow::Result<()> { ensure!(self.time.len() == self.speed.len()); ensure!(self.grade.len() == self.len()); - if let Some(te_amb_air) = &self.temp_amb_air { - ensure!(te_amb_air.len() == self.time.len()); + if !self.temp_amb_air.is_empty() { + ensure!(self.temp_amb_air.len() == self.time.len()); + } else { + self.temp_amb_air = vec![*TE_STD_AIR; self.time.len()]; } // TODO: figure out if this should be uncommented -- probably need to use a `match` // somewhere to fix this ensure!(self.pwr_max_chrg.len() == self.len()); @@ -124,8 +128,6 @@ impl Init for Cycle { impl SerdeAPI for Cycle { const ACCEPTED_BYTE_FORMATS: &'static [&'static str] = &[ - #[cfg(feature = "bincode")] - "bin", #[cfg(feature = "csv")] "csv", #[cfg(feature = "json")] @@ -157,8 +159,6 @@ impl SerdeAPI for Cycle { /// fn to_writer(&self, mut wtr: W, format: &str) -> anyhow::Result<()> { match format.trim_start_matches('.').to_lowercase().as_str() { - #[cfg(feature = "bincode")] - "bin" | "bincode" => bincode::serialize_into(wtr, self)?, #[cfg(feature = "csv")] "csv" => { let mut wtr = csv::Writer::from_writer(wtr); @@ -202,8 +202,6 @@ impl SerdeAPI for Cycle { skip_init: bool, ) -> anyhow::Result { let mut deserialized: Self = match format.trim_start_matches('.').to_lowercase().as_str() { - #[cfg(feature = "bincode")] - "bin" | "bincode" => bincode::deserialize_from(rdr)?, #[cfg(feature = "csv")] "csv" => { // Create empty cycle to be populated diff --git a/fastsim-core/src/gas_properties.rs b/fastsim-core/src/gas_properties.rs index 324d4f30..08b8e03a 100644 --- a/fastsim-core/src/gas_properties.rs +++ b/fastsim-core/src/gas_properties.rs @@ -2,7 +2,7 @@ use crate::imports::*; lazy_static! { /// room temperature - pub static ref TE_STD_AIR: si::TemperatureInterval= (22. + 273.15) * uc::KELVIN; + pub static ref TE_STD_AIR: si::Temperature = (22. + 273.15) * uc::KELVIN; /// pressure of air at 180 m and 22 C pub static ref STD_PRESSURE_AIR: si::Pressure = 99_346.3 * uc::PASCAL; /// density of air at 180 m ASL and 22 C @@ -124,10 +124,7 @@ impl Air { /// # Arguments /// * `te_air` - ambient temperature of air, defaults to 22 C /// * `h` - elevation above sea level, defaults to 180 m - pub fn get_density( - te_air: Option, - h: Option, - ) -> si::MassDensity { + pub fn get_density(te_air: Option, h: Option) -> si::MassDensity { let std_pressure_at_elev = |h: si::Length| -> si::Pressure { let std_temp_at_elev = (15.04 - 0.00649 * h.get::() + 273.15) * uc::KELVIN; (101.29e3 * uc::PASCAL) @@ -146,9 +143,7 @@ impl Air { /// Returns thermal conductivity of air /// # Arguments /// - `te_air`: temperature of air - pub fn get_therm_cond( - te_air: si::TemperatureInterval, - ) -> anyhow::Result { + pub fn get_therm_cond(te_air: si::Temperature) -> anyhow::Result { Ok( asp::THERMAL_CONDUCTIVITY_INTERP.interpolate(&[te_air.get::()])? * uc::WATT_PER_METER_KELVIN, @@ -159,7 +154,7 @@ impl Air { /// # Arguments /// - `te_air`: temperature of air pub fn get_specific_heat_cp( - te_air: si::TemperatureInterval, + te_air: si::Temperature, ) -> anyhow::Result { Ok(asp::C_P_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG_K) } @@ -167,46 +162,42 @@ impl Air { /// Returns specific enthalpy of air /// # Arguments /// - `te_air`: temperature of air - pub fn get_specific_enthalpy( - te_air: si::TemperatureInterval, - ) -> anyhow::Result { + pub fn get_specific_enthalpy(te_air: si::Temperature) -> anyhow::Result { Ok(asp::ENTHALPY_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG) } /// Returns specific energy of air /// # Arguments /// - `te_air`: temperature of air - pub fn get_specific_energy( - te_air: si::TemperatureInterval, - ) -> anyhow::Result { + pub fn get_specific_energy(te_air: si::Temperature) -> anyhow::Result { Ok(asp::ENERGY_INTERP.interpolate(&[te_air.get::()])? * uc::J_PER_KG) } /// Returns thermal Prandtl number of air /// # Arguments /// - `te_air`: temperature of air - pub fn get_pr(te_air: si::TemperatureInterval) -> anyhow::Result { + pub fn get_pr(te_air: si::Temperature) -> anyhow::Result { Ok(asp::PRANDTL_INTERP.interpolate(&[te_air.get::()])? * uc::R) } /// Returns dynamic viscosity \[Pa*s\] of air /// # Arguments /// te_air: temperature of air - pub fn get_dyn_visc(te_air: si::TemperatureInterval) -> anyhow::Result { + pub fn get_dyn_visc(te_air: si::Temperature) -> anyhow::Result { Ok(asp::DYN_VISC_INTERP.interpolate(&[te_air.get::()])? * uc::PASCAL_SECOND) } /// Returns temperature of air /// # Arguments /// `h`: specific enthalpy of air \[J/kg\] - pub fn get_te_from_h(h: si::SpecificEnergy) -> anyhow::Result { + pub fn get_te_from_h(h: si::SpecificEnergy) -> anyhow::Result { Ok(asp::TEMP_FROM_ENTHALPY.interpolate(&[h.get::()])? * uc::KELVIN) } /// Returns temperature of air /// # Arguments /// `u`: specific energy of air \[J/kg\] - pub fn get_te_from_u(u: si::SpecificEnergy) -> anyhow::Result { + pub fn get_te_from_u(u: si::SpecificEnergy) -> anyhow::Result { Ok(asp::TEMP_FROM_ENERGY.interpolate(&[u.get::()])? * uc::KELVIN) } } @@ -250,9 +241,9 @@ mod air_static_props { use super::*; lazy_static! { /// Array of temperatures at which properties are evaluated - static ref TEMPERATURE_VALUES: Vec = [ + static ref TEMPERATURE_VALUES: Vec = [ -60., - -57.03690616, + -57.03690616, -53.1958198, -48.21658352, -41.7619528, @@ -528,9 +519,9 @@ mod octane_static_props { use super::*; lazy_static! { /// Array of temperatures at which properties are evaluated - static ref TEMPERATURE_VALUES: Vec = [ + static ref TEMPERATURE_VALUES: Vec = [ -4.00000000e+01, - -3.70369062e+01, + -3.70369062e+01, -3.31958198e+01, -2.82165835e+01, -2.17619528e+01, @@ -631,16 +622,14 @@ impl Octane { /// Returns specific energy of octane /// # Arguments /// - `te_octane`: temperature of octane - pub fn get_specific_energy( - te_octane: si::TemperatureInterval, - ) -> anyhow::Result { + pub fn get_specific_energy(te_octane: si::Temperature) -> anyhow::Result { Ok(osp::ENERGY_INTERP.interpolate(&[te_octane.get::()])? * uc::J_PER_KG) } /// Returns temperature of octane /// # Arguments /// `u`: specific energy of octane \[J/kg\] - pub fn get_te_from_u(u: si::SpecificEnergy) -> anyhow::Result { + pub fn get_te_from_u(u: si::SpecificEnergy) -> anyhow::Result { Ok(osp::TEMP_FROM_ENERGY.interpolate(&[u.get::()])? * uc::KELVIN) } } diff --git a/fastsim-core/src/lib.rs b/fastsim-core/src/lib.rs index 53ce43d4..980ae30b 100755 --- a/fastsim-core/src/lib.rs +++ b/fastsim-core/src/lib.rs @@ -37,8 +37,6 @@ pub fn enabled_features() -> Vec { "web".into(), #[cfg(feature = "serde-default")] "serde-default".into(), - #[cfg(feature = "bincode")] - "bincode".into(), #[cfg(feature = "csv")] "csv".into(), #[cfg(feature = "json")] diff --git a/fastsim-core/src/prelude.rs b/fastsim-core/src/prelude.rs index 9d13967d..1c9d58dc 100755 --- a/fastsim-core/src/prelude.rs +++ b/fastsim-core/src/prelude.rs @@ -5,7 +5,7 @@ pub use crate::drive_cycle::{Cycle, CycleElement}; pub use crate::gas_properties::{get_sphere_conv_params, Air, Octane, TE_STD_AIR}; pub use crate::simdrive::{SimDrive, SimParams}; pub use crate::utils::{Pyo3Vec2Wrapper, Pyo3Vec3Wrapper, Pyo3VecBoolWrapper, Pyo3VecWrapper}; -pub use crate::vehicle::cabin::{CabinOption, SingleCapacitanceCabin}; +pub use crate::vehicle::cabin::{CabinOption, LumpedCabin}; pub use crate::vehicle::powertrain::electric_machine::{ ElectricMachine, ElectricMachineState, ElectricMachineStateHistoryVec, }; diff --git a/fastsim-core/src/si.rs b/fastsim-core/src/si.rs index 672f4b38..32560b45 100644 --- a/fastsim-core/src/si.rs +++ b/fastsim-core/src/si.rs @@ -12,11 +12,10 @@ pub use si::f64::{ Acceleration, Angle, Area, AvailableEnergy as SpecificEnergy, Curvature, DynamicViscosity, Energy, Force, Frequency, HeatCapacity, HeatTransfer as HeatTransferCoeff, InverseVelocity, Length, Mass, MassDensity, MomentOfInertia, Power, PowerRate, Pressure, Ratio, - SpecificHeatCapacity, SpecificPower, TemperatureInterval, ThermalConductance, + SpecificHeatCapacity, SpecificPower, TemperatureInterval as Temperature, ThermalConductance, ThermalConductivity, Time, Velocity, Volume, }; pub use si::force::{newton, pound_force}; -pub use si::heat_capacity::{joule_per_degree_celsius, joule_per_kelvin}; pub use si::heat_transfer::{watt_per_square_meter_degree_celsius, watt_per_square_meter_kelvin}; pub use si::length::{foot, kilometer, meter}; pub use si::mass::{kilogram, megagram}; diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index 0db2116c..56325bc9 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -200,18 +200,7 @@ impl SimDrive { .solve_powertrain(dt) .with_context(|| anyhow!(format_dbg!()))?; self.veh - .solve_thermal( - self.cyc.temp_amb_air.with_context(|| { - format!( - "{}\n{}", - format_dbg!(), - "Expected to have `te_amb_air` provided in `Cycle`" - ) - })?[i] - .clone(), - self.veh.state.speed_ach, - dt, - ) + .solve_thermal(self.cyc.temp_amb_air[i], self.veh.state.speed_ach, dt) .with_context(|| format_dbg!())?; self.veh.set_cumulative(dt); Ok(()) @@ -257,11 +246,19 @@ impl SimDrive { vs.air_density = if self.sim_params.f2_const_air_density { 1.2 * uc::KGPM3 } else { - let te_amb_air = match &self.cyc.temp_amb_air { - Some(t) => Some(t.get(i).with_context(|| format_dbg!())?), - None => None, + let te_amb_air = { + let te_amb_air = self + .cyc + .temp_amb_air + .get(i) + .with_context(|| format_dbg!())?; + if *te_amb_air == *TE_STD_AIR { + None + } else { + Some(te_amb_air) + } }; - Air::get_density(te_amb_air.cloned(), Some(elev_curr)) + Air::get_density(te_amb_air.copied(), Some(elev_curr)) }; let mass = self.veh.mass.with_context(|| { @@ -510,7 +507,7 @@ impl Default for TraceMissTolerance { } } -#[derive(Clone, Default, Debug, Deserialize, Serialize, PartialEq)] +#[derive(Clone, Default, Debug, Deserialize, Serialize, PartialEq, IsVariant)] pub enum TraceMissOptions { /// Allow trace miss without any fanfare Allow, diff --git a/fastsim-core/src/traits.rs b/fastsim-core/src/traits.rs index 1b701f9a..1eccfd84 100644 --- a/fastsim-core/src/traits.rs +++ b/fastsim-core/src/traits.rs @@ -81,8 +81,6 @@ pub trait SerdeAPI: Serialize + for<'a> Deserialize<'a> + Init { "json", #[cfg(feature = "toml")] "toml", - #[cfg(feature = "bincode")] - "bin", ]; const ACCEPTED_STR_FORMATS: &'static [&'static str] = &[ #[cfg(feature = "yaml")] @@ -190,8 +188,6 @@ pub trait SerdeAPI: Serialize + for<'a> Deserialize<'a> + Init { let toml_string = self.to_toml()?; wtr.write_all(toml_string.as_bytes())?; } - #[cfg(feature = "bincode")] - "bin" => bincode::serialize_into(wtr, self)?, _ => bail!( "Unsupported format {format:?}, must be one of {:?}", Self::ACCEPTED_BYTE_FORMATS @@ -223,8 +219,6 @@ pub trait SerdeAPI: Serialize + for<'a> Deserialize<'a> + Init { rdr.read_to_string(&mut buf)?; Self::from_toml(buf, skip_init)? } - #[cfg(feature = "bincode")] - "bin" => bincode::deserialize_from(rdr)?, _ => bail!( "Unsupported format {format:?}, must be one of {:?}", Self::ACCEPTED_BYTE_FORMATS @@ -281,27 +275,6 @@ pub trait SerdeAPI: Serialize + for<'a> Deserialize<'a> + Init { ) } - /// Write (serialize) an object to bincode-encoded bytes - #[cfg(feature = "bincode")] - fn to_bincode(&self) -> anyhow::Result> { - Ok(bincode::serialize(&self)?) - } - - /// Read (deserialize) an object from bincode-encoded bytes - /// - /// # Arguments - /// - /// * `encoded` - Encoded bytes to deserialize from - /// - #[cfg(feature = "bincode")] - fn from_bincode(encoded: &[u8], skip_init: bool) -> anyhow::Result { - let mut bincode_de: Self = bincode::deserialize(encoded)?; - if !skip_init { - bincode_de.init()?; - } - Ok(bincode_de) - } - /// Write (serialize) an object to a JSON string #[cfg(feature = "json")] fn to_json(&self) -> anyhow::Result { diff --git a/fastsim-core/src/uc.rs b/fastsim-core/src/uc.rs index 2db96fec..e310cf72 100644 --- a/fastsim-core/src/uc.rs +++ b/fastsim-core/src/uc.rs @@ -43,8 +43,8 @@ unit_const!(MI, Length, 1.609_344_E3); unit_const!(M2, Area, 1.0); unit_const!(FT2, Area, 9.290_304_E-2); unit_const!(M3, Volume, 1.0); -unit_const!(L, Volume, 1.0E-3); -unit_const!(GALLON, Volume, 0.003785); +unit_const!(L, Volume, 1.0e-3); +unit_const!(GALLON, Volume, 3.785e-3); unit_const!(S, Time, 1.0); unit_const!(MIN, Time, 60.0); @@ -86,9 +86,9 @@ unit_const!( ); lazy_static::lazy_static! { - pub static ref CELSIUS_TO_KELVIN: crate::si::TemperatureInterval = 273.15 * KELVIN; + pub static ref CELSIUS_TO_KELVIN: crate::si::Temperature = 273.15 * KELVIN; } -unit_const!(KELVIN, TemperatureInterval, 1.0); +unit_const!(KELVIN, Temperature, 1.0); unit_const!(J_PER_KG_K, SpecificHeatCapacity, 1.0); unit_const!(J_PER_K, HeatCapacity, 1.0); unit_const!(J_PER_KG, SpecificEnergy, 1.0); diff --git a/fastsim-core/src/utils/mod.rs b/fastsim-core/src/utils/mod.rs index 850907cb..6c7c32d6 100755 --- a/fastsim-core/src/utils/mod.rs +++ b/fastsim-core/src/utils/mod.rs @@ -222,6 +222,7 @@ impl From>>> for Pyo3Vec3Wrapper { impl SerdeAPI for Pyo3Vec3Wrapper {} impl Init for Pyo3Vec3Wrapper {} +#[derive(IsVariant)] pub(crate) enum InterpRange { ZeroThroughOne, NegativeOneThroughOne, diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index c0becc42..9113eed3 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -138,8 +138,14 @@ impl Powertrain for BatteryElectricVehicle { Ok(()) } - fn solve_thermal(&mut self) -> anyhow::Result<()> { - todo!() + fn solve_thermal( + &mut self, + te_amb: si::Temperature, + heat_demand: si::Power, + veh_speed: si::Velocity, + dt: si::Time, + ) -> anyhow::Result<()> { + todo!(); } fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index 286a220f..dd30c9ff 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -5,9 +5,9 @@ use super::*; pub enum CabinOption { /// Basic single thermal capacitance cabin thermal model, including HVAC /// system and controls - SingleCapacitanceCabin(Box), + LumpedCabin(Box), /// Cabin with interior and shell capacitances - SingleCapacitanceCabinWithShell, + LumpedCabinWithShell, /// no cabin thermal model #[default] None, @@ -15,8 +15,8 @@ pub enum CabinOption { impl Init for CabinOption { fn init(&mut self) -> anyhow::Result<()> { match self { - Self::SingleCapacitanceCabin(scc) => scc.init()?, - Self::SingleCapacitanceCabinWithShell => {} + Self::LumpedCabin(scc) => scc.init()?, + Self::LumpedCabinWithShell => {} Self::None => {} } Ok(()) @@ -28,20 +28,255 @@ impl SerdeAPI for CabinOption {} #[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] /// Basic single thermal capacitance cabin thermal model, including HVAC /// system and controls -pub struct SingleCapacitanceCabin { +pub struct LumpedCabin { /// cabin shell thermal resistance \[m **2 * K / W\] pub cab_r_to_amb: f64, /// parameter for heat transfer coeff \[W / (m ** 2 * K)\] from cabin to ambient during /// vehicle stop pub cab_htc_to_amb_stop: f64, - /// cabin thermal capacitance - pub heat_capacitance: si::SpecificEnergy, + pub heat_capacitance: si::HeatCapacity, /// cabin length, modeled as a flat plate pub length: si::Length, /// cabin width, modeled as a flat plate pub width: si::Length, + /// HVAC model + pub hvac: HVACSystemForSCC, + pub state: LumpedCabinState, + #[serde(default)] + #[serde(skip_serializing_if = "LumpedCabinStateHistoryVec::is_empty")] + pub history: LumpedCabinStateHistoryVec, +} + +impl SerdeAPI for LumpedCabin {} +impl Init for LumpedCabin {} +impl SetCumulative for LumpedCabin { + fn set_cumulative(&mut self, dt: si::Time) { + self.state.set_cumulative(dt); + } } -impl SerdeAPI for SingleCapacitanceCabin {} -impl Init for SingleCapacitanceCabin {} +impl LumpedCabin { + /// Solve temperatures, powers, and cumulative energies of cabin and HVAC system + /// Arguments: + /// - `te_amb_air`: ambient air temperature + /// - `te_fc`: [FuelConverter] temperature, as appropriate for [PowertrainType] + /// - `dt`: simulation time step size + fn solve( + &mut self, + te_amb_air: si::Temperature, + te_fc: Option, + dt: si::Time, + ) -> anyhow::Result<()> { + if self.state.temp <= self.hvac.te_set + self.hvac.te_deadband + && self.state.temp >= self.hvac.te_set - self.hvac.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_thermal_from_hvac = si::Power::ZERO; + self.hvac.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.hvac.state.pwr_p = si::Power::ZERO; + self.hvac.state.pwr_d = si::Power::ZERO; + } else { + let te_delta_vs_set = self.state.temp - self.hvac.te_set; + let te_delta_vs_amb: si::Temperature = self.state.temp - te_amb_air; + + self.hvac.state.pwr_p = self.hvac.p * te_delta_vs_set; + self.hvac.state.pwr_i += + (self.hvac.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt) + .max(self.hvac.pwr_i_max); + self.hvac.state.pwr_d = + self.hvac.d * uc::J / uc::KELVIN * ((self.state.temp - self.state.temp_prev) / dt); + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + self.state.temp / (5.0 * uc::KELVIN) + } else { + self.state.temp / te_delta_vs_amb.abs() + }; + self.hvac.state.cop = cop_ideal * self.hvac.frac_of_ideal_cop; + assert!(self.hvac.state.cop > 0.0 * uc::R); + + if self.state.temp > self.hvac.te_set + self.hvac.te_deadband { + // COOLING MODE; cabin is hotter than set point + + if self.hvac.state.pwr_i < si::Power::ZERO { + // reset to switch from heating to cooling + self.hvac.state.pwr_i = si::Power::ZERO; + } + self.state.pwr_thermal_from_hvac = + (-self.hvac.state.pwr_p - self.hvac.state.pwr_i - self.hvac.state.pwr_d) + .max(-self.hvac.pwr_thermal_max); + + if (-self.state.pwr_thermal_from_hvac / self.hvac.state.cop) > self.hvac.pwr_aux_max + { + self.hvac.state.pwr_aux = self.hvac.pwr_aux_max; + // correct if limit is exceeded + self.state.pwr_thermal_from_hvac = + -self.hvac.state.pwr_aux * self.hvac.state.cop; + } + } else { + // HEATING MODE; cabin is colder than set point + + if self.hvac.state.pwr_i > si::Power::ZERO { + // reset to switch from cooling to heating + self.hvac.state.pwr_i = si::Power::ZERO; + } + self.hvac.state.pwr_i = self.hvac.state.pwr_i.max(-self.hvac.pwr_i_max); + + self.state.pwr_thermal_from_hvac = + (-self.hvac.state.pwr_p - self.hvac.state.pwr_i - self.hvac.state.pwr_d) + .min(self.hvac.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + match self.hvac.heat_source { + HeatSource::FuelConverter => { + ensure!( + te_fc.is_some(), + "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", + format_dbg!() + ); + // limit heat transfer to be substantially less than what is physically possible + // i.e. the engine can't drop below cabin temperature to heat the cabin + self.state.pwr_thermal_from_hvac = self + .state + .pwr_thermal_from_hvac + .min( + self.heat_capacitance * + (te_fc.unwrap() - self.state.temp) + * 0.1 // so that it's substantially less + / dt, + ) + .max(si::Power::ZERO); + // TODO: think about what to do for PHEV, which needs careful consideration here + // HEV probably also needs careful consideration + // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on + } + HeatSource::ResistanceHeater => {} + HeatSource::HeatPump => {} + } + } + } + Ok(()) + } +} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct LumpedCabinState { + /// time step counter + pub i: u32, + /// lumped cabin temperature + // TODO: make sure this gets updated + temp: si::Temperature, + /// lumped cabin temperature at previous simulation time step + // TODO: make sure this gets updated + temp_prev: si::Temperature, + /// Thermal power coming to cabin from HVAC system. Positive indicates + /// heating, and negative indicates cooling. + pwr_thermal_from_hvac: si::Power, + /// Cumulative thermal energy coming to cabin from HVAC system. Positive indicates + /// heating, and negative indicates cooling. + energy_thermal_from_hvac: si::Energy, + /// Thermal power coming to cabin from ambient air. Positive indicates + /// heating, and negative indicates cooling. + pwr_thermal_from_amb: si::Power, + /// Cumulative thermal energy coming to cabin from ambient air. Positive indicates + /// heating, and negative indicates cooling. + energy_thermal_from_amb: si::Energy, +} + +impl Init for LumpedCabinState {} +impl SerdeAPI for LumpedCabinState {} + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// HVAC system for [LumpedCabin] +pub struct HVACSystemForSCC { + /// set point temperature + pub te_set: si::Temperature, + /// deadband range. any cabin temperature within this range of + /// `te_set` results in no HVAC power draw + pub te_deadband: si::Temperature, + /// HVAC proportional gain + pub p: si::ThermalConductance, + /// HVAC integral gain [W / K / s], resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i: f64, + /// value at which [Self::i] stops accumulating + pub pwr_i_max: si::Power, + /// HVAC derivative gain [W / K * s] + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d: f64, + /// max HVAC thermal power + pub pwr_thermal_max: si::Power, + /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by + /// coefficient of performance (COP) + pub frac_of_ideal_cop: f64, + // TODO: make sure this is plumbed up + /// heat source + #[api(skip_get, skip_set)] + pub heat_source: HeatSource, + /// max allowed aux load + pub pwr_aux_max: si::Power, + /// coefficient of performance of vapor compression cycle + pub state: HVACSystemForSCCState, + #[serde(default)] + #[serde(skip_serializing_if = "HVACSystemForSCCStateHistoryVec::is_empty")] + pub history: HVACSystemForSCCStateHistoryVec, +} +impl Init for HVACSystemForSCC {} +impl SerdeAPI for HVACSystemForSCC {} + +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] +pub enum HeatSource { + /// [FuelConverter], if applicable, provides heat for HVAC system + FuelConverter, + /// Resistance heater provides heat for HVAC system + ResistanceHeater, + /// Heat pump provides heat for HVAC system + HeatPump, +} +impl Init for HeatSource {} +impl SerdeAPI for HeatSource {} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct HVACSystemForSCCState { + /// time step counter + pub i: u32, + /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain + pwr_p: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain + energy_p: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain + pwr_i: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain + energy_i: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain + pwr_d: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain + energy_d: si::Energy, + /// input power required + pwr_in: si::Power, + /// input cumulative energy required + energy_in: si::Energy, + /// coefficient of performance (i.e. efficiency) of vapor compression cycle + cop: si::Ratio, + /// Aux power demand from HVAC system + pwr_aux: si::Power, + /// Cumulative aux energy for HVAC system + energy_aux: si::Energy, +} +impl Init for HVACSystemForSCCState {} +impl SerdeAPI for HVACSystemForSCCState {} diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index 7d7d7d6e..8fa7ac9a 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -55,7 +55,7 @@ impl Powertrain for Box { fn solve_thermal( &mut self, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index dc5e554e..ff422376 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -201,7 +201,7 @@ impl Powertrain for Box { fn solve_thermal( &mut self, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, @@ -209,8 +209,8 @@ impl Powertrain for Box { self.fc .solve_thermal(te_amb, heat_demand, veh_speed, dt) .with_context(|| format_dbg!())?; - todo!(); - self.res.solve_thermal() + self.res.solve_thermal().with_context(|| format_dbg!())?; + Ok(()) } fn pwr_regen(&self) -> si::Power { @@ -365,7 +365,7 @@ impl std::fmt::Display for FCOnCauses { } #[fastsim_enum_api] -#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq, IsVariant)] pub enum FCOnCause { /// Engine must be on to self heat if thermal model is enabled FCTemperatureTooLow, @@ -417,7 +417,7 @@ impl Default for HEVSimulationParams { } } -#[derive(Clone, Debug, PartialEq, Deserialize, Serialize, Default)] +#[derive(Clone, Debug, PartialEq, Deserialize, Serialize, Default, IsVariant)] pub enum HEVAuxControls { /// If feasible, use [ReversibleEnergyStorage] to handle aux power demand #[default] diff --git a/fastsim-core/src/vehicle/mod.rs b/fastsim-core/src/vehicle/mod.rs index ca96efb2..968f4980 100755 --- a/fastsim-core/src/vehicle/mod.rs +++ b/fastsim-core/src/vehicle/mod.rs @@ -4,6 +4,7 @@ //! Module containing submodules for vehicle and powertrain models pub(crate) use crate::imports::*; +pub use crate::prelude::*; // powertrain types pub mod bev; diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index 7f8f086c..ab82624c 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -1,6 +1,7 @@ use super::*; use crate::prelude::*; use serde::Deserializer; +use std::f64::consts::PI; // TODO: think about how to incorporate life modeling for Fuel Cells and other tech @@ -322,7 +323,7 @@ impl FuelConverter { pub fn solve_thermal( &mut self, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, @@ -364,7 +365,7 @@ pub struct FuelConverterState { pub eff: si::Ratio, /// instantaneous power going to drivetrain, not including aux pub pwr_prop: si::Power, - /// integral of [Self::pwr_propulsion] + /// integral of [Self::pwr_prop] pub energy_prop: si::Energy, /// power going to auxiliaries pub pwr_aux: si::Power, @@ -416,7 +417,7 @@ impl FuelConverterThermalOption { fn solve( &mut self, fc_state: &FuelConverterState, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, @@ -437,25 +438,22 @@ impl FuelConverterThermalOption { pub struct FuelConverterThermal { /// [FuelConverter] thermal capacitance pub heat_capacitance: si::HeatCapacity, - /// Parameter for engine characteristic length for heat transfer calcs. For - /// these calculations, the engine is treated as a sphere to enable speed-dependent - /// calculations that don't require a large number of parameters. + /// parameter for engine characteristic length for heat transfer calcs pub length_for_convection: si::Length, /// parameter for heat transfer coeff from [FuelConverter] to ambient during vehicle stop pub htc_to_amb_stop: si::HeatTransferCoeff, - /// Coefficient for max fraction of combustion heat minus shaft power - /// that goes to [FuelConverter] (engine) thermal mass. Remainder goes to - /// environment via tailpipe. - pub max_frac_from_comb: si::Ratio, - /// heat transfer coefficient for combustion heat that goes to [FuelConverter] - /// (engine) thermal mass. Remainder goes to environment (e.g. via tailpipe). + + /// Heat transfer coefficient between adiabatic flame temperature and [FuelConverterThermal] temperature pub htc_from_comb: si::ThermalConductance, + /// Max coefficient for fraction of combustion heat that goes to [FuelConverter] + /// (engine) thermal mass. Remainder goes to environment (e.g. via tailpipe). + pub max_frac_from_comb: si::Ratio, /// parameter for temperature at which thermostat starts to open #[api(skip_get, skip_set)] - pub tstat_te_sto: Option, + pub tstat_te_sto: Option, /// temperature delta over which thermostat is partially open #[api(skip_get, skip_set)] - pub tstat_te_delta: Option, + pub tstat_te_delta: Option, #[serde(skip_serializing, deserialize_with = "tstat_interp_default")] #[api(skip_get, skip_set)] pub tstat_interp: Interp1D, @@ -495,7 +493,7 @@ lazy_static! { pub static ref GASOLINE_DENSITY: si::MassDensity = 0.75 * uc::KG / uc::L; /// TODO: find a source for this value pub static ref GASOLINE_LHV: si::SpecificEnergy = 33.7 * uc::KWH / uc::GALLON / *GASOLINE_DENSITY; - pub static ref TE_ADIABATIC_STD: si::TemperatureInterval= Air::get_te_from_u( + pub static ref TE_ADIABATIC_STD: si::Temperature= Air::get_te_from_u( Air::get_specific_energy(*TE_STD_AIR).with_context(|| format_dbg!()).unwrap() + (Octane::get_specific_energy(*TE_STD_AIR).with_context(|| format_dbg!()).unwrap() + *GASOLINE_LHV) @@ -515,7 +513,7 @@ impl FuelConverterThermal { fn solve( &mut self, fc_state: &FuelConverterState, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, @@ -573,13 +571,14 @@ impl FuelConverterThermal { .with_context(|| format_dbg!())?; // heat that will go both to the block and out the exhaust port let heat_gen = fc_state.pwr_fuel - fc_state.pwr_prop; - self.state.temp = self.state.temp - + (((self.htc_from_comb * (self.state.te_adiabatic - self.state.temp)) - .min(self.max_frac_from_comb * heat_gen) - - heat_demand - - self.state.heat_to_amb) - * dt) - / self.heat_capacitance; + let delta_temp: si::Temperature = (((self.htc_from_comb + * (self.state.te_adiabatic - self.state.temp)) + .min(self.max_frac_from_comb * heat_gen) + - heat_demand + - self.state.heat_to_amb) + * dt) + / self.heat_capacitance; + self.state.temp = self.state.temp + delta_temp; Ok(()) } } @@ -612,9 +611,9 @@ pub struct FuelConverterThermalState { pub i: usize, /// Adiabatic flame temperature assuming complete (i.e. all fuel is consumed /// if fuel lean or stoich or all air is consumed if fuel rich) combustion - pub te_adiabatic: si::TemperatureInterval, + pub te_adiabatic: si::Temperature, /// Current engine thermal mass temperature (lumped engine block and coolant) - pub temp: si::TemperatureInterval, + pub temp: si::Temperature, /// Current heat transfer coefficient from [FuelConverter] to ambient pub htc_to_amb: si::HeatTransferCoeff, /// Current heat transfer to ambient diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index 7b6541b5..3c7f2725 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -225,6 +225,10 @@ impl ReversibleEnergyStorage { Ok(()) } + pub fn solve_thermal(&mut self) -> anyhow::Result<()> { + todo!() + } + /// Sets and returns max output and max regen power based on current state /// # Arguments /// - `dt`: time step size @@ -557,7 +561,7 @@ pub struct ReversibleEnergyStorageState { pub energy_out_chemical: si::Energy, /// component temperature - pub temperature: si::TemperatureInterval, + pub temperature: si::Temperature, } impl Default for ReversibleEnergyStorageState { diff --git a/fastsim-core/src/vehicle/powertrain/traits.rs b/fastsim-core/src/vehicle/powertrain/traits.rs index cf7209a2..043ee00d 100644 --- a/fastsim-core/src/vehicle/powertrain/traits.rs +++ b/fastsim-core/src/vehicle/powertrain/traits.rs @@ -37,7 +37,7 @@ pub trait Powertrain { fn solve_thermal( &mut self, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, diff --git a/fastsim-core/src/vehicle/powertrain_type.rs b/fastsim-core/src/vehicle/powertrain_type.rs index 0dfaa03c..4c117c90 100644 --- a/fastsim-core/src/vehicle/powertrain_type.rs +++ b/fastsim-core/src/vehicle/powertrain_type.rs @@ -49,7 +49,7 @@ impl Powertrain for PowertrainType { fn solve_thermal( &mut self, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, heat_demand: si::Power, veh_speed: si::Velocity, dt: si::Time, diff --git a/fastsim-core/src/vehicle/traits.rs b/fastsim-core/src/vehicle/traits.rs index 7757830b..e00e309e 100644 --- a/fastsim-core/src/vehicle/traits.rs +++ b/fastsim-core/src/vehicle/traits.rs @@ -2,7 +2,7 @@ use super::*; -#[derive(Default, Deserialize, Serialize, Debug, Clone, PartialEq)] +#[derive(Default, Deserialize, Serialize, Debug, Clone, PartialEq, IsVariant)] /// Governs which side effect to trigger when setting mass pub enum MassSideEffect { /// To be used when [MassSideEffect] is not applicable diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index 5254bb36..7463f5fb 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -282,6 +282,11 @@ impl SetCumulative for Vehicle { if let Some(em) = self.em_mut() { em.set_cumulative(dt); } + match &mut self.cabin { + CabinOption::LumpedCabin(lumped_cabin) => lumped_cabin.set_cumulative(dt), + CabinOption::LumpedCabinWithShell => todo!(), + CabinOption::None => {} + } self.state.dist += self.state.speed_ach * dt; } } @@ -429,7 +434,7 @@ impl Vehicle { pub fn solve_thermal( &mut self, - te_amb: si::TemperatureInterval, + te_amb: si::Temperature, veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { diff --git a/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv b/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv index dc5b03c0..18d9be0f 100644 --- a/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv +++ b/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv @@ -1,4 +1,4 @@ -veh.pt_type.ConventionalVehicle.fc.history.i,veh.pt_type.ConventionalVehicle.fc.history.pwr_out_max_watts,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_max_watts,veh.pt_type.ConventionalVehicle.fc.history.eff,veh.pt_type.ConventionalVehicle.fc.history.pwr_propulsion_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_propulsion_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_aux_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_aux_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_fuel_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_fuel_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_loss_joules,veh.pt_type.ConventionalVehicle.fc.history.fc_on,veh.pt_type.ConventionalVehicle.fc.history.time_on_seconds,veh.pt_type.ConventionalVehicle.transmission.history.i,veh.pt_type.ConventionalVehicle.transmission.history.eff,veh.pt_type.ConventionalVehicle.transmission.history.pwr_out_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_in_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.transmission.history.energy_out_joules,veh.pt_type.ConventionalVehicle.transmission.history.energy_loss_joules,veh.history.i,veh.history.pwr_prop_fwd_max_watts,veh.history.pwr_prop_bwd_max_watts,veh.history.pwr_tractive_watts,veh.history.pwr_tractive_for_cyc_watts,veh.history.energy_tractive_joules,veh.history.pwr_aux_watts,veh.history.energy_aux_joules,veh.history.pwr_drag_watts,veh.history.energy_drag_joules,veh.history.pwr_accel_watts,veh.history.energy_accel_joules,veh.history.pwr_ascent_watts,veh.history.energy_ascent_joules,veh.history.pwr_rr_watts,veh.history.energy_rr_joules,veh.history.pwr_whl_inertia_watts,veh.history.energy_whl_inertia_joules,veh.history.pwr_brake_watts,veh.history.energy_brake_joules,veh.history.cyc_met,veh.history.cyc_met_overall,veh.history.speed_ach_meters_per_second,veh.history.dist_meters,veh.history.grade_curr,veh.history.mass_kilograms,cyc.time_seconds,cyc.speed_meters_per_second,cyc.dist_meters,cyc.grade,cyc.elev_meters,cyc.pwr_max_chrg_watts +veh.pt_type.ConventionalVehicle.fc.history.i,veh.pt_type.ConventionalVehicle.fc.history.pwr_out_max_watts,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_max_watts,veh.pt_type.ConventionalVehicle.fc.history.eff,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_prop_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_aux_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_aux_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_fuel_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_fuel_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_loss_joules,veh.pt_type.ConventionalVehicle.fc.history.fc_on,veh.pt_type.ConventionalVehicle.fc.history.time_on_seconds,veh.pt_type.ConventionalVehicle.transmission.history.i,veh.pt_type.ConventionalVehicle.transmission.history.eff,veh.pt_type.ConventionalVehicle.transmission.history.pwr_out_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_in_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.transmission.history.energy_out_joules,veh.pt_type.ConventionalVehicle.transmission.history.energy_loss_joules,veh.history.i,veh.history.pwr_prop_fwd_max_watts,veh.history.pwr_prop_bwd_max_watts,veh.history.pwr_tractive_watts,veh.history.pwr_tractive_for_cyc_watts,veh.history.energy_tractive_joules,veh.history.pwr_aux_watts,veh.history.energy_aux_joules,veh.history.pwr_drag_watts,veh.history.energy_drag_joules,veh.history.pwr_accel_watts,veh.history.energy_accel_joules,veh.history.pwr_ascent_watts,veh.history.energy_ascent_joules,veh.history.pwr_rr_watts,veh.history.energy_rr_joules,veh.history.pwr_whl_inertia_watts,veh.history.energy_whl_inertia_joules,veh.history.pwr_brake_watts,veh.history.energy_brake_joules,veh.history.cyc_met,veh.history.cyc_met_overall,veh.history.speed_ach_meters_per_second,veh.history.dist_meters,veh.history.grade_curr,veh.history.mass_kilograms,cyc.time_seconds,cyc.speed_meters_per_second,cyc.dist_meters,cyc.grade,cyc.elev_meters,cyc.pwr_max_chrg_watts 0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,false,0.0,0,0.0,0.0,0.0,0.0,0.0,0.0,0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,0.0,0.0,0.0,0.0,121.92,0.0 1,21750.0,21050.0,0.12,0.0,0.0,700.0,700.0,5833.333333333334,5833.333333333334,5833.333333333334,5833.333333333334,true,1.0,1,0.875,0.0,0.0,0.0,0.0,0.0,1,21050.0,0.0,0.0,0.0,0.0,700.0,700.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,1.0,0.0,0.0,0.0,121.92,0.0 2,22450.0,21750.0,0.12,0.0,0.0,700.0,1400.0,5833.333333333334,11666.666666666668,5833.333333333334,11666.666666666668,true,2.0,2,0.875,0.0,0.0,0.0,0.0,0.0,2,21750.0,0.0,0.0,0.0,0.0,700.0,1400.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,2.0,0.0,0.0,0.0,121.92,0.0 diff --git a/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt b/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt index 4ad325e9..c9a85765 100644 --- a/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt +++ b/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt @@ -15,8 +15,8 @@ ['veh']['pt_type']['ConventionalVehicle']['fc']['state']['pwr_out_max_watts'] ['veh']['pt_type']['ConventionalVehicle']['fc']['state']['pwr_prop_max_watts'] ['veh']['pt_type']['ConventionalVehicle']['fc']['state']['eff'] -['veh']['pt_type']['ConventionalVehicle']['fc']['state']['pwr_propulsion_watts'] -['veh']['pt_type']['ConventionalVehicle']['fc']['state']['energy_propulsion_joules'] +['veh']['pt_type']['ConventionalVehicle']['fc']['state']['pwr_prop_watts'] +['veh']['pt_type']['ConventionalVehicle']['fc']['state']['energy_prop_joules'] ['veh']['pt_type']['ConventionalVehicle']['fc']['state']['pwr_aux_watts'] ['veh']['pt_type']['ConventionalVehicle']['fc']['state']['energy_aux_joules'] ['veh']['pt_type']['ConventionalVehicle']['fc']['state']['pwr_fuel_watts'] @@ -29,8 +29,8 @@ ['veh']['pt_type']['ConventionalVehicle']['fc']['history']['pwr_out_max_watts'] ['veh']['pt_type']['ConventionalVehicle']['fc']['history']['pwr_prop_max_watts'] ['veh']['pt_type']['ConventionalVehicle']['fc']['history']['eff'] -['veh']['pt_type']['ConventionalVehicle']['fc']['history']['pwr_propulsion_watts'] -['veh']['pt_type']['ConventionalVehicle']['fc']['history']['energy_propulsion_joules'] +['veh']['pt_type']['ConventionalVehicle']['fc']['history']['pwr_prop_watts'] +['veh']['pt_type']['ConventionalVehicle']['fc']['history']['energy_prop_joules'] ['veh']['pt_type']['ConventionalVehicle']['fc']['history']['pwr_aux_watts'] ['veh']['pt_type']['ConventionalVehicle']['fc']['history']['energy_aux_joules'] ['veh']['pt_type']['ConventionalVehicle']['fc']['history']['pwr_fuel_watts'] From 41d9c29fa11269ab6f99ce17f3da260b78183c04 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Wed, 4 Dec 2024 10:29:32 -0700 Subject: [PATCH 04/12] cabin is hypothetically set up correctly --- .../f3-vehicles/2010 Mazda 3 i-Stop.yaml | 1 + cal_and_val/f3-vehicles/2012 Ford Focus.yaml | 1 + cal_and_val/f3-vehicles/2012 Ford Fusion.yaml | 1 + .../f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml | 1 + .../f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml | 1 + .../2016 CHEVROLET Malibu 4cyl 2WD.yaml | 1 + .../f3-vehicles/2016 CHEVROLET Spark EV.yaml | 1 + .../f3-vehicles/2016 FORD C-MAX HEV.yaml | 1 + .../2016 FORD Escape 4cyl 2WD.yaml | 1 + .../2016 FORD Explorer 4cyl 2WD.yaml | 1 + .../2016 HYUNDAI Elantra 4cyl 2WD.yaml | 1 + .../2016 Hyundai Tucson Fuel Cell.yaml | 1 + .../f3-vehicles/2016 KIA Optima Hybrid.yaml | 1 + cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml | 1 + .../f3-vehicles/2016 MITSUBISHI i-MiEV.yaml | 1 + .../f3-vehicles/2016 Nissan Leaf 30 kWh.yaml | 1 + .../f3-vehicles/2016 TESLA Model S60 2WD.yaml | 1 + .../2016 TOYOTA Camry 4cyl 2WD.yaml | 1 + .../2016 TOYOTA Corolla 4cyl 2WD.yaml | 1 + .../2016 TOYOTA Highlander Hybrid.yaml | 1 + .../2016 Toyota Prius Two FWD.yaml | 1 + .../f3-vehicles/2017 CHEVROLET Bolt.yaml | 1 + .../f3-vehicles/2017 Maruti Dzire VDI.yaml | 1 + .../2017 Toyota Highlander 3.5 L.yaml | 1 + .../2020 Chevrolet Colorado 2WD Diesel.yaml | 1 + .../2020 Hero Splendor+ 100cc.yaml | 1 + .../f3-vehicles/2020 VW Golf 1.5TSI.yaml | 1 + .../f3-vehicles/2020 VW Golf 2.0TDI.yaml | 1 + .../f3-vehicles/2021 BMW iX xDrive40.yaml | 1 + cal_and_val/f3-vehicles/2021 Cupra Born.yaml | 1 + .../2021 Fiat Panda Mild Hybrid.yaml | 1 + .../f3-vehicles/2021 Honda N-Box G.yaml | 1 + cal_and_val/f3-vehicles/2021 Peugot 3008.yaml | 1 + .../2022 Ford F-150 Lightning 4WD.yaml | 1 + .../2022 MINI Cooper SE Hardtop 2 door.yaml | 1 + .../2022 Renault Megane E-Tech.yaml | 1 + .../2022 Renault Zoe ZE50 R135.yaml | 1 + .../f3-vehicles/2022 Tesla Model 3 RWD.yaml | 1 + .../f3-vehicles/2022 Tesla Model Y RWD.yaml | 1 + .../2022 Toyota RAV4 Hybrid LE.yaml | 1 + .../2022 Toyota Yaris Hybrid Mid.yaml | 1 + .../2022 Volvo XC40 Recharge twin.yaml | 1 + .../2023 Mitsubishi Pajero Sport.yaml | 1 + ...2023 Polestar 2 Long range Dual motor.yaml | 1 + .../f3-vehicles/2023 Volvo C40 Recharge.yaml | 1 + .../f3-vehicles/2024 BYD Dolphin Active.yaml | 1 + .../f3-vehicles/2024 Toyota Vios 1.5 G.yaml | 1 + .../f3-vehicles/2024 VinFast VF e34.yaml | 1 + .../2024 Volkswagen Polo 1.0 MPI.yaml | 1 + cal_and_val/f3-vehicles/BYD ATTO 3.yaml | 1 + cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml | 1 + .../Class 4 Truck (Isuzu NPR HD).yaml | 1 + cal_and_val/f3-vehicles/Line Haul Conv.yaml | 1 + .../f3-vehicles/Maruti Swift 4cyl 2WD.yaml | 1 + cal_and_val/f3-vehicles/Nissan Navara.yaml | 1 + .../Regional Delivery Class 8 Truck.yaml | 1 + .../f3-vehicles/Renault Clio IV diesel.yaml | 1 + .../Renault Megane 1.5 dCi Authentique.yaml | 1 + .../Toyota Corolla Cross Hybrid.yaml | 1 + .../f3-vehicles/Toyota Etios Liva diesel.yaml | 1 + .../Toyota Hilux Double Cab 4WD.yaml | 1 + cal_and_val/f3-vehicles/Toyota Mirai.yaml | 1 + .../resources/vehicles/2012_Ford_Fusion.yaml | 1 + .../vehicles/2016_TOYOTA_Prius_Two.yaml | 1 + .../vehicles/2022_Renault_Zoe_ZE50_R135.yaml | 56 +++ fastsim-core/src/si.rs | 1 + fastsim-core/src/simdrive.rs | 22 +- fastsim-core/src/vehicle/bev.rs | 6 +- fastsim-core/src/vehicle/cabin.rs | 333 ++++++++++++------ fastsim-core/src/vehicle/conv.rs | 8 +- fastsim-core/src/vehicle/hev.rs | 10 +- .../src/vehicle/powertrain/fuel_converter.rs | 32 +- fastsim-core/src/vehicle/powertrain/traits.rs | 6 +- fastsim-core/src/vehicle/powertrain_type.rs | 12 +- fastsim-core/src/vehicle/vehicle_model.rs | 34 +- 75 files changed, 422 insertions(+), 162 deletions(-) diff --git a/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml b/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml index 99f8dcef..91a3af7d 100644 --- a/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml +++ b/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2012 Ford Focus.yaml b/cal_and_val/f3-vehicles/2012 Ford Focus.yaml index 724ec038..e3f965d8 100644 --- a/cal_and_val/f3-vehicles/2012 Ford Focus.yaml +++ b/cal_and_val/f3-vehicles/2012 Ford Focus.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml b/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml index 2c8261a2..ef7878b8 100644 --- a/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml +++ b/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml index 473221e1..ad074b26 100644 --- a/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml index 05597964..f7c3db1d 100644 --- a/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml index 71543888..45720a15 100644 --- a/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml b/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml index 3a427629..217443a0 100644 --- a/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml +++ b/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml b/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml index fa6f7af9..e2207b95 100644 --- a/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml index 7f073003..809bbd60 100644 --- a/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml index 5e837ec8..2991531d 100644 --- a/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml index 1e540f1e..0bda4355 100644 --- a/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml b/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml index a2ba7f3f..432bcb31 100644 --- a/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml +++ b/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml b/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml index 5a0a2c5f..d179c7a2 100644 --- a/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml b/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml index 45cfa1b6..0ae3798b 100644 --- a/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml +++ b/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml b/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml index cfdb8e1e..22a2ca47 100644 --- a/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml +++ b/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml b/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml index 831d42cb..6bb1cfc0 100644 --- a/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml +++ b/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml b/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml index f2e75854..fbe0aebf 100644 --- a/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml index 720b0d3f..0fd7503e 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml index 0d918d41..836cb58f 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml index 3ef0f8ba..f998533e 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml b/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml index b2728c70..ce192f9c 100644 --- a/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml +++ b/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml b/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml index bcba8d64..206cbc86 100644 --- a/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml +++ b/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml b/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml index 806e8274..e7f48e0a 100644 --- a/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml +++ b/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml b/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml index c8249627..aacd8de1 100644 --- a/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml +++ b/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml b/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml index cda04fcf..bdb67fd1 100644 --- a/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml +++ b/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml b/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml index 4411c37d..64f2b923 100644 --- a/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml +++ b/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml b/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml index 8f369109..aef5a30d 100644 --- a/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml +++ b/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml b/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml index 6339d212..b8bfb817 100644 --- a/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml +++ b/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml b/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml index 88d274fe..6f004fa0 100644 --- a/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml +++ b/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2021 Cupra Born.yaml b/cal_and_val/f3-vehicles/2021 Cupra Born.yaml index 64df373e..cd33e08e 100644 --- a/cal_and_val/f3-vehicles/2021 Cupra Born.yaml +++ b/cal_and_val/f3-vehicles/2021 Cupra Born.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml b/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml index d63071f8..25653249 100644 --- a/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml b/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml index 9a6381d6..3c1dad23 100644 --- a/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml +++ b/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml b/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml index fee6c8f8..d7405cd9 100644 --- a/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml +++ b/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml b/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml index 58778890..a8ad6a20 100644 --- a/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml +++ b/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml b/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml index 3db837d3..86b3be93 100644 --- a/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml +++ b/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml b/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml index 2dfc95e5..f26b7864 100644 --- a/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml +++ b/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml b/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml index db17fb47..f78aaf22 100644 --- a/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml +++ b/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml b/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml index 6e29ff57..eb12d59f 100644 --- a/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml +++ b/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml b/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml index 40a1fc64..1b9ebcd5 100644 --- a/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml +++ b/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml b/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml index 1e935e79..a9442796 100644 --- a/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml +++ b/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml b/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml index 8bfa3422..ac093c06 100644 --- a/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml +++ b/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml b/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml index 8344d281..4eac9129 100644 --- a/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml +++ b/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml b/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml index 37241c46..4bfca504 100644 --- a/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml +++ b/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml b/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml index b6836ff5..dddf6378 100644 --- a/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml +++ b/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml b/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml index b2a4e5ea..1da8a26c 100644 --- a/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml +++ b/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml b/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml index eaf31676..13c3e94e 100644 --- a/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml +++ b/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml b/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml index 948a6b59..63d9d04f 100644 --- a/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml +++ b/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml b/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml index 726386d4..4d06af0d 100644 --- a/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml +++ b/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml b/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml index 6ca0aa2e..5788ac9e 100644 --- a/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml +++ b/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/BYD ATTO 3.yaml b/cal_and_val/f3-vehicles/BYD ATTO 3.yaml index 58c278ab..e51b5ef0 100644 --- a/cal_and_val/f3-vehicles/BYD ATTO 3.yaml +++ b/cal_and_val/f3-vehicles/BYD ATTO 3.yaml @@ -122,4 +122,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml b/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml index 0a95b960..91365dd8 100644 --- a/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml +++ b/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml b/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml index d2a1dd9e..245d5389 100644 --- a/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml +++ b/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Line Haul Conv.yaml b/cal_and_val/f3-vehicles/Line Haul Conv.yaml index b587b59a..92d71057 100644 --- a/cal_and_val/f3-vehicles/Line Haul Conv.yaml +++ b/cal_and_val/f3-vehicles/Line Haul Conv.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml index 03ba6fa5..4489b46f 100644 --- a/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Nissan Navara.yaml b/cal_and_val/f3-vehicles/Nissan Navara.yaml index 0479be47..df1ac1c5 100644 --- a/cal_and_val/f3-vehicles/Nissan Navara.yaml +++ b/cal_and_val/f3-vehicles/Nissan Navara.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml b/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml index 7438765f..cad5d07a 100644 --- a/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml +++ b/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml b/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml index 5291a163..f8e2bdae 100644 --- a/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml +++ b/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml b/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml index 6670d133..550155b8 100644 --- a/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml +++ b/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml b/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml index 24ed348e..dc81f2f4 100644 --- a/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml +++ b/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml b/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml index 76e5508e..a3e144dd 100644 --- a/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml +++ b/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml b/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml index 55e7bd52..a037262f 100644 --- a/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml +++ b/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/cal_and_val/f3-vehicles/Toyota Mirai.yaml b/cal_and_val/f3-vehicles/Toyota Mirai.yaml index 30ddfc71..3a3d221f 100644 --- a/cal_and_val/f3-vehicles/Toyota Mirai.yaml +++ b/cal_and_val/f3-vehicles/Toyota Mirai.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml b/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml index 2c8261a2..ef7878b8 100755 --- a/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml +++ b/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml @@ -270,4 +270,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml b/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml index b2728c70..ce192f9c 100755 --- a/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml +++ b/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml @@ -714,4 +714,5 @@ state: speed_ach_meters_per_second: 0.0 dist_meters: 0.0 grade_curr: 0.0 + elev_curr_meters: .nan mass_kilograms: .nan diff --git a/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml b/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml index edd920e6..f78aaf22 100644 --- a/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml +++ b/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml @@ -42,6 +42,34 @@ pt_type: - 0.93 strategy: LeftNearest extrapolate: Error + eff_interp_at_max_input: + Interp1D: + x: + - 0.0 + - 0.023255813953488372 + - 0.045454545454545456 + - 0.06666666666666667 + - 0.0879120879120879 + - 0.10869565217391304 + - 0.2127659574468085 + - 0.4210526315789474 + - 0.631578947368421 + - 0.851063829787234 + - 1.075268817204301 + f_x: + - 0.84 + - 0.86 + - 0.88 + - 0.9 + - 0.91 + - 0.92 + - 0.9400000000000001 + - 0.95 + - 0.95 + - 0.9400000000000001 + - 0.93 + strategy: LeftNearest + extrapolate: Error pwr_out_max_watts: 100000.0 specific_pwr_watts_per_kilogram: ~ mass_kilograms: ~ @@ -68,3 +96,31 @@ mass_kilograms: 1600.0 pwr_aux_watts: 250.0 trans_eff: 0.92 save_interval: 1 +state: + i: 0 + pwr_prop_fwd_max_watts: 0.0 + pwr_prop_bwd_max_watts: 0.0 + pwr_tractive_watts: 0.0 + pwr_tractive_for_cyc_watts: 0.0 + energy_tractive_joules: 0.0 + pwr_aux_watts: 0.0 + energy_aux_joules: 0.0 + pwr_drag_watts: 0.0 + energy_drag_joules: 0.0 + pwr_accel_watts: 0.0 + energy_accel_joules: 0.0 + pwr_ascent_watts: 0.0 + energy_ascent_joules: 0.0 + pwr_rr_watts: 0.0 + energy_rr_joules: 0.0 + pwr_whl_inertia_watts: 0.0 + energy_whl_inertia_joules: 0.0 + pwr_brake_watts: 0.0 + energy_brake_joules: 0.0 + cyc_met: true + cyc_met_overall: true + speed_ach_meters_per_second: 0.0 + dist_meters: 0.0 + grade_curr: 0.0 + elev_curr_meters: .nan + mass_kilograms: .nan diff --git a/fastsim-core/src/si.rs b/fastsim-core/src/si.rs index 32560b45..6abb4254 100644 --- a/fastsim-core/src/si.rs +++ b/fastsim-core/src/si.rs @@ -16,6 +16,7 @@ pub use si::f64::{ ThermalConductivity, Time, Velocity, Volume, }; pub use si::force::{newton, pound_force}; +pub use si::heat_capacity::{joule_per_degree_celsius, joule_per_kelvin}; pub use si::heat_transfer::{watt_per_square_meter_degree_celsius, watt_per_square_meter_kelvin}; pub use si::length::{foot, kilometer, meter}; pub use si::mass::{kilogram, megagram}; diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index 56325bc9..b160e5c5 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -200,7 +200,7 @@ impl SimDrive { .solve_powertrain(dt) .with_context(|| anyhow!(format_dbg!()))?; self.veh - .solve_thermal(self.cyc.temp_amb_air[i], self.veh.state.speed_ach, dt) + .solve_thermal(self.cyc.temp_amb_air[i], self.veh.state, dt) .with_context(|| format_dbg!())?; self.veh.set_cumulative(dt); Ok(()) @@ -231,7 +231,7 @@ impl SimDrive { .with_context(|| format_dbg!("You might have somehow bypassed `init()`"))? .interpolate(&[vs.dist.get::()])? }; - let elev_curr = if vs.cyc_met_overall { + vs.elev_curr = if vs.cyc_met_overall { *self.cyc.elev.get(i).with_context(|| format_dbg!())? } else { uc::M @@ -258,7 +258,7 @@ impl SimDrive { Some(te_amb_air) } }; - Air::get_density(te_amb_air.copied(), Some(elev_curr)) + Air::get_density(te_amb_air.copied(), Some(vs.elev_curr)) }; let mass = self.veh.mass.with_context(|| { @@ -557,6 +557,22 @@ mod tests { assert!(sd.veh.res().unwrap().state.energy_out_chemical != si::Energy::ZERO); } + #[test] + #[cfg(feature = "resources")] + fn test_sim_drive_bev() { + let _veh = mock_bev(); + let _cyc = Cycle::from_resource("udds.csv", false).unwrap(); + let mut sd = SimDrive { + veh: _veh, + cyc: _cyc, + sim_params: Default::default(), + }; + sd.walk().unwrap(); + assert!(sd.veh.state.i == sd.cyc.len()); + assert!(sd.veh.fc().unwrap().state.energy_fuel > si::Energy::ZERO); + assert!(sd.veh.res().unwrap().state.energy_out_chemical != si::Energy::ZERO); + } + #[test] fn delete_me() { use fastsim_2::traits::SerdeAPI; diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index 9113eed3..0d837b6e 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -120,7 +120,7 @@ impl Powertrain for BatteryElectricVehicle { fn solve( &mut self, pwr_out_req: si::Power, - _veh_state: &VehicleState, + _veh_state: VehicleState, _enabled: bool, dt: si::Time, ) -> anyhow::Result<()> { @@ -142,7 +142,7 @@ impl Powertrain for BatteryElectricVehicle { &mut self, te_amb: si::Temperature, heat_demand: si::Power, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { todo!(); @@ -159,7 +159,7 @@ impl Powertrain for BatteryElectricVehicle { &mut self, pwr_aux: si::Power, dt: si::Time, - _veh_state: &VehicleState, + _veh_state: VehicleState, ) -> anyhow::Result<()> { // TODO: account for transmission efficiency in here // TODO: change these to something other than zero diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index dd30c9ff..1e815553 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -29,11 +29,11 @@ impl SerdeAPI for CabinOption {} /// Basic single thermal capacitance cabin thermal model, including HVAC /// system and controls pub struct LumpedCabin { - /// cabin shell thermal resistance \[m **2 * K / W\] - pub cab_r_to_amb: f64, - /// parameter for heat transfer coeff \[W / (m ** 2 * K)\] from cabin to ambient during + /// Inverse of cabin shell thermal resistance + pub cab_htc_to_amb: si::HeatTransferCoeff, + /// parameter for heat transfer coeff from cabin to ambient during /// vehicle stop - pub cab_htc_to_amb_stop: f64, + pub cab_htc_to_amb_stop: si::HeatTransferCoeff, /// cabin thermal capacitance pub heat_capacitance: si::HeatCapacity, /// cabin length, modeled as a flat plate @@ -57,112 +57,70 @@ impl SetCumulative for LumpedCabin { } impl LumpedCabin { - /// Solve temperatures, powers, and cumulative energies of cabin and HVAC system + /// Solve temperatures, HVAC powers, and cumulative energies of cabin and HVAC system /// Arguments: /// - `te_amb_air`: ambient air temperature /// - `te_fc`: [FuelConverter] temperature, as appropriate for [PowertrainType] /// - `dt`: simulation time step size - fn solve( + pub fn solve( &mut self, te_amb_air: si::Temperature, te_fc: Option, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { - if self.state.temp <= self.hvac.te_set + self.hvac.te_deadband - && self.state.temp >= self.hvac.te_set - self.hvac.te_deadband - { - // inside deadband; no hvac power is needed - - self.state.pwr_thermal_from_hvac = si::Power::ZERO; - self.hvac.state.pwr_i = si::Power::ZERO; // reset to 0.0 - self.hvac.state.pwr_p = si::Power::ZERO; - self.hvac.state.pwr_d = si::Power::ZERO; - } else { - let te_delta_vs_set = self.state.temp - self.hvac.te_set; - let te_delta_vs_amb: si::Temperature = self.state.temp - te_amb_air; + self.state.pwr_thermal_from_hvac = self.hvac.get_pwr_thermal_from_hvac( + te_amb_air, + te_fc, + self.state, + self.heat_capacitance, + dt, + )?; - self.hvac.state.pwr_p = self.hvac.p * te_delta_vs_set; - self.hvac.state.pwr_i += - (self.hvac.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt) - .max(self.hvac.pwr_i_max); - self.hvac.state.pwr_d = - self.hvac.d * uc::J / uc::KELVIN * ((self.state.temp - self.state.temp_prev) / dt); - - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling + // flat plate model for isothermal, mixed-flow from Incropera and deWitt, Fundamentals of Heat and Mass + // Transfer, 7th Edition + let cab_te_film_ext = 0.5 * (self.state.temp + te_amb_air); + self.state.reynolds_for_plate = + Air::get_density(Some(cab_te_film_ext), Some(veh_state.elev_curr)) + * veh_state.speed_ach + * self.length + / Air::get_dyn_visc(cab_te_film_ext).with_context(|| format_dbg!())?; + let re_l_crit = 5.0e5 * uc::R; // critical Re for transition to turbulence - // divide-by-zero protection and realistic limit on COP - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - self.state.temp / (5.0 * uc::KELVIN) - } else { - self.state.temp / te_delta_vs_amb.abs() - }; - self.hvac.state.cop = cop_ideal * self.hvac.frac_of_ideal_cop; - assert!(self.hvac.state.cop > 0.0 * uc::R); - - if self.state.temp > self.hvac.te_set + self.hvac.te_deadband { - // COOLING MODE; cabin is hotter than set point - - if self.hvac.state.pwr_i < si::Power::ZERO { - // reset to switch from heating to cooling - self.hvac.state.pwr_i = si::Power::ZERO; - } - self.state.pwr_thermal_from_hvac = - (-self.hvac.state.pwr_p - self.hvac.state.pwr_i - self.hvac.state.pwr_d) - .max(-self.hvac.pwr_thermal_max); - - if (-self.state.pwr_thermal_from_hvac / self.hvac.state.cop) > self.hvac.pwr_aux_max - { - self.hvac.state.pwr_aux = self.hvac.pwr_aux_max; - // correct if limit is exceeded - self.state.pwr_thermal_from_hvac = - -self.hvac.state.pwr_aux * self.hvac.state.cop; - } - } else { - // HEATING MODE; cabin is colder than set point - - if self.hvac.state.pwr_i > si::Power::ZERO { - // reset to switch from cooling to heating - self.hvac.state.pwr_i = si::Power::ZERO; - } - self.hvac.state.pwr_i = self.hvac.state.pwr_i.max(-self.hvac.pwr_i_max); + let nu_l_bar: si::Ratio = if self.state.reynolds_for_plate < re_l_crit { + // equation 7.30 + 0.664 + * self.state.reynolds_for_plate.get::().powf(0.5) + * Air::get_pr(cab_te_film_ext) + .with_context(|| format_dbg!())? + .get::() + .powf(1.0 / 3.0) + * uc::R + } else { + // equation 7.38 + let a = 871.0; // equation 7.39 + (0.037 * self.state.reynolds_for_plate.get::().powf(0.8) - a) + * Air::get_pr(cab_te_film_ext).with_context(|| format_dbg!())? + }; - self.state.pwr_thermal_from_hvac = - (-self.hvac.state.pwr_p - self.hvac.state.pwr_i - self.hvac.state.pwr_d) - .min(self.hvac.pwr_thermal_max); + self.state.pwr_thermal_from_amb = if veh_state.speed_ach > 2.0 * uc::MPH { + let htc_overall_moving: si::HeatTransferCoeff = 1.0 + / (1.0 + / (nu_l_bar + * Air::get_therm_cond(cab_te_film_ext).with_context(|| format_dbg!())? + / self.length) + + 1.0 / self.cab_htc_to_amb); + (self.length * self.width) * htc_overall_moving * (te_amb_air - self.state.temp) + } else { + (self.length * self.width) + / (1.0 / self.cab_htc_to_amb_stop + 1.0 / self.cab_htc_to_amb) + * (te_amb_air - self.state.temp) + }; - // Assumes blower has negligible impact on aux load, may want to revise later - match self.hvac.heat_source { - HeatSource::FuelConverter => { - ensure!( - te_fc.is_some(), - "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", - format_dbg!() - ); - // limit heat transfer to be substantially less than what is physically possible - // i.e. the engine can't drop below cabin temperature to heat the cabin - self.state.pwr_thermal_from_hvac = self - .state - .pwr_thermal_from_hvac - .min( - self.heat_capacitance * - (te_fc.unwrap() - self.state.temp) - * 0.1 // so that it's substantially less - / dt, - ) - .max(si::Power::ZERO); - // TODO: think about what to do for PHEV, which needs careful consideration here - // HEV probably also needs careful consideration - // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on - } - HeatSource::ResistanceHeater => {} - HeatSource::HeatPump => {} - } - } - } + self.state.temp_prev = self.state.temp; + self.state.temp += (self.state.pwr_thermal_from_hvac + self.state.pwr_thermal_from_amb) + / self.heat_capacitance + * dt; Ok(()) } } @@ -176,22 +134,24 @@ pub struct LumpedCabinState { pub i: u32, /// lumped cabin temperature // TODO: make sure this gets updated - temp: si::Temperature, + pub temp: si::Temperature, /// lumped cabin temperature at previous simulation time step // TODO: make sure this gets updated - temp_prev: si::Temperature, + pub temp_prev: si::Temperature, /// Thermal power coming to cabin from HVAC system. Positive indicates /// heating, and negative indicates cooling. - pwr_thermal_from_hvac: si::Power, + pub pwr_thermal_from_hvac: si::Power, /// Cumulative thermal energy coming to cabin from HVAC system. Positive indicates /// heating, and negative indicates cooling. - energy_thermal_from_hvac: si::Energy, + pub energy_thermal_from_hvac: si::Energy, /// Thermal power coming to cabin from ambient air. Positive indicates /// heating, and negative indicates cooling. - pwr_thermal_from_amb: si::Power, + pub pwr_thermal_from_amb: si::Power, /// Cumulative thermal energy coming to cabin from ambient air. Positive indicates /// heating, and negative indicates cooling. - energy_thermal_from_amb: si::Energy, + pub energy_thermal_from_amb: si::Energy, + /// Reynolds number for flow over cabin, treating cabin as a flat plate + pub reynolds_for_plate: si::Ratio, } impl Init for LumpedCabinState {} @@ -221,7 +181,6 @@ pub struct HVACSystemForSCC { /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by /// coefficient of performance (COP) pub frac_of_ideal_cop: f64, - // TODO: make sure this is plumbed up /// heat source #[api(skip_get, skip_set)] pub heat_source: HeatSource, @@ -235,6 +194,146 @@ pub struct HVACSystemForSCC { } impl Init for HVACSystemForSCC {} impl SerdeAPI for HVACSystemForSCC {} +impl HVACSystemForSCC { + pub fn get_pwr_thermal_from_hvac( + &mut self, + te_amb_air: si::Temperature, + te_fc: Option, + cab_state: LumpedCabinState, + cab_heat_cap: si::HeatCapacity, + dt: si::Time, + ) -> anyhow::Result { + let pwr_from_hvac = if cab_state.temp <= self.te_set + self.te_deadband + && cab_state.temp >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p = si::Power::ZERO; + self.state.pwr_d = si::Power::ZERO; + si::Power::ZERO + } else { + let te_delta_vs_set = cab_state.temp - self.te_set; + let te_delta_vs_amb: si::Temperature = cab_state.temp - te_amb_air; + + self.state.pwr_p = -self.p * te_delta_vs_set; + self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); + self.state.pwr_d = + -self.d * uc::J / uc::KELVIN * ((cab_state.temp - cab_state.temp_prev) / dt); + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temp / (5.0 * uc::KELVIN) + } else { + cab_state.temp / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + + if cab_state.temp > self.te_set + self.te_deadband { + // COOLING MODE; cabin is hotter than set point + + if self.state.pwr_i > si::Power::ZERO { + // If `pwr_i` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thermal_from_hvac = + (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) + .max(-self.pwr_thermal_max); + + if (-pwr_thermal_from_hvac / self.state.cop) > self.pwr_aux_max { + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + pwr_thermal_from_hvac = -self.state.pwr_aux * self.state.cop; + } else { + self.state.pwr_aux = pwr_thermal_from_hvac / self.state.cop; + } + self.state.pwr_thermal_req = si::Power::ZERO; + pwr_thermal_from_hvac + } else { + // HEATING MODE; cabin is colder than set point + + if self.state.pwr_i < si::Power::ZERO { + // If `pwr_i` is less than zero reset to switch from cooling to heating + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thermal_from_hvac = + (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) + .min(self.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + match self.heat_source { + HeatSource::FuelConverter => { + ensure!( + te_fc.is_some(), + "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", + format_dbg!() + ); + // limit heat transfer to be substantially less than what is physically possible + // i.e. the engine can't drop below cabin temperature to heat the cabin + pwr_thermal_from_hvac = pwr_thermal_from_hvac + .min( + cab_heat_cap * + (te_fc.unwrap() - cab_state.temp) + * 0.1 // so that it's substantially less + / dt, + ) + .max(si::Power::ZERO); + self.state.cop = f64::NAN * uc::R; + self.state.pwr_thermal_req = pwr_thermal_from_hvac; + // Assumes aux power needed for heating is incorporated into based aux load. + // TODO: refine this, perhaps by making aux power + // proportional to heating power, to account for blower power + self.state.pwr_aux = si::Power::ZERO; + // TODO: think about what to do for PHEV, which needs careful consideration here + // HEV probably also needs careful consideration + // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on + } + HeatSource::ResistanceHeater => { + self.state.cop = uc::R; + self.state.pwr_thermal_req = si::Power::ZERO; + self.state.pwr_aux = pwr_thermal_from_hvac; + } + HeatSource::HeatPump => { + self.state.pwr_thermal_req = si::Power::ZERO; + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + // TODO: make sure this is right for heating! + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temp / (5.0 * uc::KELVIN) + } else { + cab_state.temp / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + self.state.pwr_thermal_req = si::Power::ZERO; + if (pwr_thermal_from_hvac / self.state.cop) > self.pwr_aux_max { + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + pwr_thermal_from_hvac = -self.state.pwr_aux * self.state.cop; + } else { + self.state.pwr_aux = pwr_thermal_from_hvac / self.state.cop; + } + } + } + pwr_thermal_from_hvac + } + }; + Ok(pwr_from_hvac) + } +} #[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] pub enum HeatSource { @@ -256,27 +355,27 @@ pub struct HVACSystemForSCCState { /// time step counter pub i: u32, /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain - pwr_p: si::Power, + pub pwr_p: si::Power, /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain - energy_p: si::Energy, + pub energy_p: si::Energy, /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain - pwr_i: si::Power, + pub pwr_i: si::Power, /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain - energy_i: si::Energy, + pub energy_i: si::Energy, /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain - pwr_d: si::Power, + pub pwr_d: si::Power, /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain - energy_d: si::Energy, - /// input power required - pwr_in: si::Power, - /// input cumulative energy required - energy_in: si::Energy, + pub energy_d: si::Energy, /// coefficient of performance (i.e. efficiency) of vapor compression cycle - cop: si::Ratio, + pub cop: si::Ratio, /// Aux power demand from HVAC system - pwr_aux: si::Power, + pub pwr_aux: si::Power, /// Cumulative aux energy for HVAC system - energy_aux: si::Energy, + pub energy_aux: si::Energy, + /// Thermal power demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub pwr_thermal_req: si::Power, + /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub energy_thermal_req: si::Energy, } impl Init for HVACSystemForSCCState {} impl SerdeAPI for HVACSystemForSCCState {} diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index 8fa7ac9a..73da4c32 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -41,7 +41,7 @@ impl Powertrain for Box { &mut self, pwr_aux: si::Power, dt: si::Time, - _veh_state: &VehicleState, + _veh_state: VehicleState, ) -> anyhow::Result<()> { // TODO: account for transmission efficiency in here self.fc @@ -57,10 +57,10 @@ impl Powertrain for Box { &mut self, te_amb: si::Temperature, heat_demand: si::Power, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { - self.fc.solve_thermal(te_amb, heat_demand, veh_speed, dt) + self.fc.solve_thermal(te_amb, heat_demand, veh_state, dt) } fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { @@ -70,7 +70,7 @@ impl Powertrain for Box { fn solve( &mut self, pwr_out_req: si::Power, - _veh_state: &VehicleState, + _veh_state: VehicleState, _enabled: bool, dt: si::Time, ) -> anyhow::Result<()> { diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index ff422376..d38199aa 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -66,7 +66,7 @@ impl Powertrain for Box { &mut self, pwr_aux: si::Power, dt: si::Time, - veh_state: &VehicleState, + veh_state: VehicleState, ) -> anyhow::Result<()> { // TODO: account for transmission efficiency in here self.state.fc_on_causes.clear(); @@ -169,7 +169,7 @@ impl Powertrain for Box { fn solve( &mut self, pwr_out_req: si::Power, - veh_state: &VehicleState, + veh_state: VehicleState, _enabled: bool, dt: si::Time, ) -> anyhow::Result<()> { @@ -203,11 +203,11 @@ impl Powertrain for Box { &mut self, te_amb: si::Temperature, heat_demand: si::Power, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { self.fc - .solve_thermal(te_amb, heat_demand, veh_speed, dt) + .solve_thermal(te_amb, heat_demand, veh_state, dt) .with_context(|| format_dbg!())?; self.res.solve_thermal().with_context(|| format_dbg!())?; Ok(()) @@ -456,7 +456,7 @@ impl HEVPowertrainControls { fn get_pwr_fc_and_em( &self, pwr_out_req: si::Power, - veh_state: &VehicleState, + veh_state: VehicleState, hev_state: &mut HEVState, fc: &FuelConverter, em_state: &ElectricMachineState, diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index 9ddb1c2d..5ca78a69 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -325,9 +325,10 @@ impl FuelConverter { &mut self, te_amb: si::Temperature, heat_demand: si::Power, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { + let veh_speed = veh_state.speed_ach; self.thrml .solve(&self.state, te_amb, heat_demand, veh_speed, dt) .with_context(|| format_dbg!())?; @@ -343,6 +344,14 @@ impl FuelConverter { .fold(f64::NEG_INFINITY, |acc, &curr| acc.max(curr)) * uc::R) } + + /// If thermal model is appropriately configured, returns current lumped engine temperature + pub fn temperature(&self) -> Option { + match &self.thrml { + FuelConverterThermalOption::FuelConverterThermal(fct) => Some(fct.state.temperature), + FuelConverterThermalOption::None => None, + } + } } // impl FuelConverter { @@ -519,7 +528,7 @@ impl FuelConverterThermal { dt: si::Time, ) -> anyhow::Result<()> { // film temperature for external convection calculations - let te_air_film = 0.5 * (self.state.temp + te_amb); + let te_air_film = 0.5 * (self.state.temperature + te_amb); // Reynolds number = density * speed * diameter / dynamic viscosity // NOTE: might be good to pipe in elevation let fc_air_film_re = @@ -532,7 +541,7 @@ impl FuelConverterThermal { (uc::R + self .tstat_interp - .interpolate(&[self.state.temp.get::()]) + .interpolate(&[self.state.temperature.get::()]) .with_context(|| format_dbg!())? * self.radiator_effectiveness) * self.htc_to_amb_stop @@ -550,21 +559,22 @@ impl FuelConverterThermal { / self.length_for_convection; // if stopped, scale based on thermostat opening and constant convection self.tstat_interp - .interpolate(&[self.state.temp.get::()]) + .interpolate(&[self.state.temperature.get::()]) .with_context(|| format_dbg!())? * htc_to_amb_sphere }; self.state.heat_to_amb = self.state.htc_to_amb * PI * self.length_for_convection.powi(typenum::P2::new()) / 4.0 - * (self.state.temp - te_amb); + * (self.state.temperature - te_amb); // let heat_to_amb = ; // assumes fuel/air mixture is entering combustion chamber at block temperature // assumes stoichiometric combustion self.state.te_adiabatic = Air::get_te_from_u( - Air::get_specific_energy(self.state.temp).with_context(|| format_dbg!())? - + (Octane::get_specific_energy(self.state.temp).with_context(|| format_dbg!())? + Air::get_specific_energy(self.state.temperature).with_context(|| format_dbg!())? + + (Octane::get_specific_energy(self.state.temperature) + .with_context(|| format_dbg!())? + *GASOLINE_LHV) / *AFR_STOICH_GASOLINE, ) @@ -572,13 +582,13 @@ impl FuelConverterThermal { // heat that will go both to the block and out the exhaust port let heat_gen = fc_state.pwr_fuel - fc_state.pwr_prop; let delta_temp: si::Temperature = (((self.htc_from_comb - * (self.state.te_adiabatic - self.state.temp)) + * (self.state.te_adiabatic - self.state.temperature)) .min(self.max_frac_from_comb * heat_gen) - heat_demand - self.state.heat_to_amb) * dt) / self.heat_capacitance; - self.state.temp += delta_temp; + self.state.temperature += delta_temp; Ok(()) } } @@ -613,7 +623,7 @@ pub struct FuelConverterThermalState { /// if fuel lean or stoich or all air is consumed if fuel rich) combustion pub te_adiabatic: si::Temperature, /// Current engine thermal mass temperature (lumped engine block and coolant) - pub temp: si::Temperature, + pub temperature: si::Temperature, /// Current heat transfer coefficient from [FuelConverter] to ambient pub htc_to_amb: si::HeatTransferCoeff, /// Current heat transfer to ambient @@ -627,7 +637,7 @@ impl Default for FuelConverterThermalState { Self { i: Default::default(), te_adiabatic: *TE_ADIABATIC_STD, - temp: *TE_STD_AIR, + temperature: *TE_STD_AIR, htc_to_amb: Default::default(), heat_to_amb: Default::default(), } diff --git a/fastsim-core/src/vehicle/powertrain/traits.rs b/fastsim-core/src/vehicle/powertrain/traits.rs index 043ee00d..72e8ed53 100644 --- a/fastsim-core/src/vehicle/powertrain/traits.rs +++ b/fastsim-core/src/vehicle/powertrain/traits.rs @@ -14,7 +14,7 @@ pub trait Powertrain { &mut self, pwr_aux: si::Power, dt: si::Time, - veh_state: &VehicleState, + veh_state: VehicleState, ) -> anyhow::Result<()>; /// Returns maximum achievable positive and negative propulsion powers after @@ -30,7 +30,7 @@ pub trait Powertrain { fn solve( &mut self, pwr_out_req: si::Power, - veh_state: &VehicleState, + veh_state: VehicleState, enabled: bool, dt: si::Time, ) -> anyhow::Result<()>; @@ -39,7 +39,7 @@ pub trait Powertrain { &mut self, te_amb: si::Temperature, heat_demand: si::Power, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()>; diff --git a/fastsim-core/src/vehicle/powertrain_type.rs b/fastsim-core/src/vehicle/powertrain_type.rs index 4c117c90..b0e11f13 100644 --- a/fastsim-core/src/vehicle/powertrain_type.rs +++ b/fastsim-core/src/vehicle/powertrain_type.rs @@ -24,7 +24,7 @@ impl Powertrain for PowertrainType { &mut self, pwr_aux: si::Power, dt: si::Time, - veh_state: &VehicleState, + veh_state: VehicleState, ) -> anyhow::Result<()> { match self { Self::ConventionalVehicle(v) => v.set_curr_pwr_prop_out_max(pwr_aux, dt, veh_state), @@ -36,7 +36,7 @@ impl Powertrain for PowertrainType { fn solve( &mut self, pwr_out_req: si::Power, - veh_state: &VehicleState, + veh_state: VehicleState, enabled: bool, dt: si::Time, ) -> anyhow::Result<()> { @@ -51,13 +51,13 @@ impl Powertrain for PowertrainType { &mut self, te_amb: si::Temperature, heat_demand: si::Power, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { match self { - Self::ConventionalVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_speed, dt), - Self::HybridElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_speed, dt), - Self::BatteryElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_speed, dt), + Self::ConventionalVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_state, dt), + Self::HybridElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_state, dt), + Self::BatteryElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_state, dt), } } diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index cc873604..45a07a74 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -1,6 +1,4 @@ -use cabin::CabinOption; - -use crate::prelude::Air; +use crate::prelude::*; use super::{hev::HEVPowertrainControls, *}; pub mod fastsim2_interface; @@ -405,7 +403,7 @@ impl Vehicle { self.pt_type .solve( self.state.pwr_tractive, - &self.state, + self.state, true, // `enabled` should always be true at the powertrain level dt, ) @@ -421,7 +419,7 @@ impl Vehicle { // TODO: account for traction limits here self.pt_type - .set_curr_pwr_prop_out_max(self.pwr_aux, dt, &self.state) + .set_curr_pwr_prop_out_max(self.pwr_aux, dt, self.state) .with_context(|| anyhow!(format_dbg!()))?; (self.state.pwr_prop_fwd_max, self.state.pwr_prop_bwd_max) = self @@ -435,12 +433,23 @@ impl Vehicle { pub fn solve_thermal( &mut self, te_amb: si::Temperature, - veh_speed: si::Velocity, + veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { - let heat_demand = si::Power::ZERO; + let te_fc: Option = self.fc().and_then(|fc| fc.temperature()); + let heat_demand = match &mut self.cabin { + CabinOption::LumpedCabin(lc) => { + lc.solve(te_amb, te_fc, veh_state, dt) + .with_context(|| format_dbg!())?; + lc.hvac.state.pwr_thermal_req + } + CabinOption::LumpedCabinWithShell => { + bail!("{}\nNot yet implemented.", format_dbg!()) + } + CabinOption::None => si::Power::ZERO, + }; self.pt_type - .solve_thermal(te_amb, heat_demand, veh_speed, dt) + .solve_thermal(te_amb, heat_demand, veh_state, dt) .with_context(|| format_dbg!())?; Ok(()) } @@ -506,6 +515,9 @@ pub struct VehicleState { pub dist: si::Length, /// current grade pub grade_curr: si::Ratio, + /// current grade + #[serde(skip_deserializing, default)] + pub elev_curr: si::Length, /// current air density #[serde(skip_serializing, default)] pub air_density: si::MassDensity, @@ -544,6 +556,8 @@ impl Default for VehicleState { speed_ach: si::Velocity::ZERO, dist: si::Length::ZERO, grade_curr: si::Ratio::ZERO, + // note that this value will be overwritten + elev_curr: f64::NAN * uc::M, air_density: Air::get_density(None, None), mass: uc::KG * f64::NAN, } @@ -601,8 +615,8 @@ pub(crate) mod tests { veh.unwrap() }; - // veh.to_file(vehicles_dir().join("2022_Renault_Zoe_ZE50_R135.yaml")) - // .unwrap(); + veh.to_file(vehicles_dir().join("2022_Renault_Zoe_ZE50_R135.yaml")) + .unwrap(); assert!(veh.pt_type.is_battery_electric_vehicle()); veh } From 71361af103965d8452857d8d1e537b14b3e0e4f2 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Wed, 4 Dec 2024 13:53:10 -0700 Subject: [PATCH 05/12] added various TODO comments --- fastsim-core/src/drive_cycle.rs | 1 + fastsim-core/src/vehicle/cabin.rs | 1 + fastsim-core/src/vehicle/powertrain/fuel_converter.rs | 5 ++++- 3 files changed, 6 insertions(+), 1 deletion(-) diff --git a/fastsim-core/src/drive_cycle.rs b/fastsim-core/src/drive_cycle.rs index 6497c04f..06640f6e 100644 --- a/fastsim-core/src/drive_cycle.rs +++ b/fastsim-core/src/drive_cycle.rs @@ -413,6 +413,7 @@ pub struct CycleElement { #[api(skip_get, skip_set)] /// road charging/discharing capacity pub pwr_max_charge: Option, + // TODO: make sure all fields in cycle are represented here, as appropriate } impl SerdeAPI for CycleElement {} diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index 1e815553..4c5d90a0 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -1,4 +1,5 @@ use super::*; +// TODO: add parameters and/or cabin model variant for solar heat load /// Options for handling cabin thermal model #[derive(Clone, Default, Debug, Serialize, Deserialize, PartialEq, IsVariant)] diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index 5ca78a69..e14547fc 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -435,7 +435,9 @@ impl FuelConverterThermalOption { Self::FuelConverterThermal(fct) => fct .solve(fc_state, te_amb, heat_demand, veh_speed, dt) .with_context(|| format_dbg!())?, - Self::None => {} + Self::None => { + // TODO: make sure this triggers error if appropriate + } } Ok(()) } @@ -575,6 +577,7 @@ impl FuelConverterThermal { Air::get_specific_energy(self.state.temperature).with_context(|| format_dbg!())? + (Octane::get_specific_energy(self.state.temperature) .with_context(|| format_dbg!())? + // TODO: make config. for other fuels -- e.g. with enum for specific fuels and/or fuel properties + *GASOLINE_LHV) / *AFR_STOICH_GASOLINE, ) From 55e494c33533fe2ef6a8ecee760ece214a5b3462 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Wed, 4 Dec 2024 15:49:49 -0700 Subject: [PATCH 06/12] battery thermal model is mostly implemented. Controls still need work. all tests pass --- fastsim-core/src/drive_cycle.rs | 1 - fastsim-core/src/lib.rs | 1 + fastsim-core/src/simdrive.rs | 3 +- fastsim-core/src/vehicle/bev.rs | 9 +- fastsim-core/src/vehicle/cabin.rs | 15 +- fastsim-core/src/vehicle/hev.rs | 4 +- .../src/vehicle/powertrain/fuel_converter.rs | 8 +- .../powertrain/reversible_energy_storage.rs | 301 +- .../vehicle_model/fastsim2_interface.rs | 2 + .../to_dataframe_expected.csv | 2742 ++++++++--------- .../variable_path_list_expected.txt | 4 +- python/fastsim/tests/test_speedup.py | 2 +- 12 files changed, 1695 insertions(+), 1397 deletions(-) diff --git a/fastsim-core/src/drive_cycle.rs b/fastsim-core/src/drive_cycle.rs index 06640f6e..763d9a2f 100644 --- a/fastsim-core/src/drive_cycle.rs +++ b/fastsim-core/src/drive_cycle.rs @@ -409,7 +409,6 @@ pub struct CycleElement { /// road grade #[serde(skip_serializing_if = "Option::is_none", alias = "cycGrade")] pub grade: Option, - // TODO: make `fastsim_api` handle Option or write custom getter/setter #[api(skip_get, skip_set)] /// road charging/discharing capacity pub pwr_max_charge: Option, diff --git a/fastsim-core/src/lib.rs b/fastsim-core/src/lib.rs index 980ae30b..58e71b67 100755 --- a/fastsim-core/src/lib.rs +++ b/fastsim-core/src/lib.rs @@ -1,3 +1,4 @@ +#![allow(non_local_definitions)] // see https://github.com/PyO3/pyo3/discussions/4083 as this is a `pyo3` problem #![allow(clippy::field_reassign_with_default)] // TODO: uncomment when docs are somewhat mature to check for missing docs // #![warn(missing_docs)] diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index b160e5c5..89344a8a 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -539,6 +539,7 @@ mod tests { sd.walk().unwrap(); assert!(sd.veh.state.i == sd.cyc.len()); assert!(sd.veh.fc().unwrap().state.energy_fuel > si::Energy::ZERO); + assert!(sd.veh.res().is_none()); } #[test] @@ -569,7 +570,7 @@ mod tests { }; sd.walk().unwrap(); assert!(sd.veh.state.i == sd.cyc.len()); - assert!(sd.veh.fc().unwrap().state.energy_fuel > si::Energy::ZERO); + assert!(sd.veh.fc().is_none()); assert!(sd.veh.res().unwrap().state.energy_out_chemical != si::Energy::ZERO); } diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index 0d837b6e..9c30d2a2 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -141,11 +141,14 @@ impl Powertrain for BatteryElectricVehicle { fn solve_thermal( &mut self, te_amb: si::Temperature, - heat_demand: si::Power, - veh_state: VehicleState, + _heat_demand: si::Power, + _veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { - todo!(); + self.res + .solve_thermal(te_amb, dt) + .with_context(|| format_dbg!())?; + Ok(()) } fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index 4c5d90a0..a33551a8 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -47,6 +47,7 @@ pub struct LumpedCabin { #[serde(default)] #[serde(skip_serializing_if = "LumpedCabinStateHistoryVec::is_empty")] pub history: LumpedCabinStateHistoryVec, + // TODO: add `save_interval` and associated method } impl SerdeAPI for LumpedCabin {} @@ -184,7 +185,7 @@ pub struct HVACSystemForSCC { pub frac_of_ideal_cop: f64, /// heat source #[api(skip_get, skip_set)] - pub heat_source: HeatSource, + pub heat_source: CabinHeatSource, /// max allowed aux load pub pwr_aux_max: si::Power, /// coefficient of performance of vapor compression cycle @@ -271,7 +272,7 @@ impl HVACSystemForSCC { // Assumes blower has negligible impact on aux load, may want to revise later match self.heat_source { - HeatSource::FuelConverter => { + CabinHeatSource::FuelConverter => { ensure!( te_fc.is_some(), "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", @@ -297,12 +298,12 @@ impl HVACSystemForSCC { // HEV probably also needs careful consideration // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on } - HeatSource::ResistanceHeater => { + CabinHeatSource::ResistanceHeater => { self.state.cop = uc::R; self.state.pwr_thermal_req = si::Power::ZERO; self.state.pwr_aux = pwr_thermal_from_hvac; } - HeatSource::HeatPump => { + CabinHeatSource::HeatPump => { self.state.pwr_thermal_req = si::Power::ZERO; // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits // cop_ideal is t_h / (t_h - t_c) for heating @@ -337,7 +338,7 @@ impl HVACSystemForSCC { } #[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] -pub enum HeatSource { +pub enum CabinHeatSource { /// [FuelConverter], if applicable, provides heat for HVAC system FuelConverter, /// Resistance heater provides heat for HVAC system @@ -345,8 +346,8 @@ pub enum HeatSource { /// Heat pump provides heat for HVAC system HeatPump, } -impl Init for HeatSource {} -impl SerdeAPI for HeatSource {} +impl Init for CabinHeatSource {} +impl SerdeAPI for CabinHeatSource {} #[fastsim_api] #[derive( diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index d38199aa..47b2b098 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -209,7 +209,9 @@ impl Powertrain for Box { self.fc .solve_thermal(te_amb, heat_demand, veh_state, dt) .with_context(|| format_dbg!())?; - self.res.solve_thermal().with_context(|| format_dbg!())?; + self.res + .solve_thermal(te_amb, dt) + .with_context(|| format_dbg!())?; Ok(()) } diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index e14547fc..bd9cc1bc 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -50,7 +50,7 @@ use std::f64::consts::PI; } )] #[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -/// Struct for modeling Fuel Converter (e.g. engine, fuel cell.) +/// Struct for modeling [FuelConverter] (e.g. engine, fuel cell.) thermal plant pub struct FuelConverter { /// [Self] Thermal plant, including thermal management controls #[serde(default, skip_serializing_if = "FuelConverterThermalOption::is_none")] @@ -331,8 +331,7 @@ impl FuelConverter { let veh_speed = veh_state.speed_ach; self.thrml .solve(&self.state, te_amb, heat_demand, veh_speed, dt) - .with_context(|| format_dbg!())?; - Ok(()) + .with_context(|| format_dbg!()) } pub fn eff_max(&self) -> anyhow::Result { @@ -345,7 +344,7 @@ impl FuelConverter { * uc::R) } - /// If thermal model is appropriately configured, returns current lumped engine temperature + /// If thermal model is appropriately configured, returns current lumped [Self] temperature pub fn temperature(&self) -> Option { match &self.thrml { FuelConverterThermalOption::FuelConverterThermal(fct) => Some(fct.state.temperature), @@ -479,6 +478,7 @@ pub struct FuelConverterThermal { #[serde(default)] #[serde(skip_serializing_if = "FuelConverterThermalStateHistoryVec::is_empty")] pub history: FuelConverterThermalStateHistoryVec, + // TODO: add `save_interval` and associated methods } /// Dummy interpolator that will be overridden in [FuelConverterThermal::init] diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index 3c7f2725..894b8631 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -61,6 +61,10 @@ const TOL: f64 = 1e-3; #[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] /// Struct for modeling technology-naive Reversible Energy Storage (e.g. battery, flywheel). pub struct ReversibleEnergyStorage { + /// [Self] Thermal plant, including thermal management controls + #[serde(default, skip_serializing_if = "RESThermalOption::is_none")] + #[api(skip_get, skip_set)] + pub thrml: RESThermalOption, /// ReversibleEnergyStorage mass #[serde(default)] #[api(skip_get, skip_set)] @@ -102,6 +106,7 @@ pub struct ReversibleEnergyStorage { impl ReversibleEnergyStorage { pub fn solve(&mut self, pwr_out_req: si::Power, dt: si::Time) -> anyhow::Result<()> { + let te_res = self.temperature(); let state = &mut self.state; ensure!( @@ -194,7 +199,9 @@ impl ReversibleEnergyStorage { interp3d.interpolate(&[ state.pwr_out_electrical.get::(), state.soc.get::(), - state.temperature.get::(), + te_res + .with_context(|| format_dbg!("Expected thermal model to be configured"))? + .get::(), ])? * uc::R } _ => bail!("Invalid interpolator. See docs for `ReversibleEnergyStorage::eff_interp`"), @@ -225,8 +232,16 @@ impl ReversibleEnergyStorage { Ok(()) } - pub fn solve_thermal(&mut self) -> anyhow::Result<()> { - todo!() + /// Solve change in temperature and other thermal effects + /// # Arguments + /// - `fc_state`: [ReversibleEnergyStorage] state + /// - `te_amb`: ambient temperature + /// - `heat_demand`: heat demand from HVAC system + /// - `veh_speed`: current achieved speed + pub fn solve_thermal(&mut self, te_amb: si::Temperature, dt: si::Time) -> anyhow::Result<()> { + self.thrml + .solve(self.state, te_amb, dt) + .with_context(|| format_dbg!()) } /// Sets and returns max output and max regen power based on current state @@ -407,6 +422,14 @@ impl ReversibleEnergyStorage { pub fn energy_capacity_usable(&self) -> si::Energy { self.energy_capacity * (self.max_soc - self.min_soc) } + + /// If thermal model is appropriately configured, returns current lumped [Self] temperature + pub fn temperature(&self) -> Option { + match &self.thrml { + RESThermalOption::RESThermal(rest) => Some(rest.state.temperature), + RESThermalOption::None => None, + } + } } impl SetCumulative for ReversibleEnergyStorage { @@ -559,9 +582,6 @@ pub struct ReversibleEnergyStorageState { pub energy_loss: si::Energy, /// cumulative chemical energy; positive is discharging pub energy_out_chemical: si::Energy, - - /// component temperature - pub temperature: si::Temperature, } impl Default for ReversibleEnergyStorageState { @@ -587,10 +607,277 @@ impl Default for ReversibleEnergyStorageState { energy_aux: si::Energy::ZERO, energy_loss: si::Energy::ZERO, energy_out_chemical: si::Energy::ZERO, - temperature: *crate::gas_properties::TE_STD_AIR, } } } impl Init for ReversibleEnergyStorageState {} impl SerdeAPI for ReversibleEnergyStorageState {} + +#[derive(Clone, Default, Debug, Serialize, Deserialize, PartialEq, IsVariant)] +pub enum RESThermalOption { + /// Basic thermal plant for [ReversibleEnergyStorage] + RESThermal(Box), + /// no thermal plant for [ReversibleEnergyStorage] + #[default] + None, +} +impl Init for RESThermalOption { + fn init(&mut self) -> anyhow::Result<()> { + match self { + Self::RESThermal(rest) => rest.init()?, + Self::None => {} + } + Ok(()) + } +} +impl SerdeAPI for RESThermalOption {} +impl RESThermalOption { + /// Solve change in temperature and other thermal effects + /// # Arguments + /// - `fc_state`: [ReversibleEnergyStorage] state + /// - `te_amb`: ambient temperature + /// - `heat_demand`: heat demand from HVAC system + /// - `veh_speed`: current achieved speed + fn solve( + &mut self, + res_state: ReversibleEnergyStorageState, + te_amb: si::Temperature, + dt: si::Time, + ) -> anyhow::Result<()> { + match self { + Self::RESThermal(rest) => rest + .solve(res_state, te_amb, dt) + .with_context(|| format_dbg!())?, + Self::None => { + // TODO: make sure this triggers error if appropriate + } + } + Ok(()) + } +} + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// Struct for modeling [ReversibleEnergyStorage] (e.g. battery) thermal plant +pub struct RESThermal { + /// [ReversibleEnergyStorage] thermal capacitance + pub heat_capacitance: si::HeatCapacity, + /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml]to ambient + pub htc_to_amb: si::HeatTransferCoeff, + /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml]to cabin + pub htc_to_cab: si::HeatTransferCoeff, + /// Thermal management system + pub cntrl_sys: RESThermalControlSystem, + /// current state + pub state: RESThermalState, + /// history of state + pub history: RESThermalStateHistoryVec, + // TODO: add `save_interval` and associated methods +} + +impl SerdeAPI for RESThermal {} +impl Init for RESThermal {} +impl RESThermal { + fn solve( + &mut self, + res_state: ReversibleEnergyStorageState, + te_amb: si::Temperature, + dt: si::Time, + ) -> anyhow::Result<()> { + todo!(); + Ok(()) + } +} + +#[fastsim_api] +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative)] +pub struct RESThermalState { + /// time step index + pub i: usize, + /// Current thermal mass temperature + pub temperature: si::Temperature, + /// Thermal mass temperature at previous time step + pub temp_prev: si::Temperature, +} + +impl Init for RESThermalState {} +impl SerdeAPI for RESThermalState {} +impl Default for RESThermalState { + fn default() -> Self { + Self { + i: Default::default(), + temperature: *TE_STD_AIR, + temp_prev: *TE_STD_AIR, + } + } +} + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// HVAC system for [LumpedCabin] +pub struct RESThermalControlSystem { + /// set point temperature + pub te_set: si::Temperature, + /// deadband range. any cabin temperature within this range of + /// `te_set` results in no HVAC power draw + pub te_deadband: si::Temperature, + /// HVAC proportional gain + pub p: si::ThermalConductance, + /// HVAC integral gain [W / K / s], resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i: f64, + /// value at which [Self::i] stops accumulating + pub pwr_i_max: si::Power, + /// HVAC derivative gain [W / K * s] + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d: f64, + /// max HVAC thermal power + pub pwr_thermal_max: si::Power, + /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by + /// coefficient of performance (COP) + pub frac_of_ideal_cop: f64, + /// heat source + #[api(skip_get, skip_set)] + pub heat_source: RESHeatSource, + /// max allowed aux load + pub pwr_aux_max: si::Power, + /// coefficient of performance of vapor compression cycle + pub state: RESThermalControlSystemState, + #[serde(default)] + #[serde(skip_serializing_if = "RESThermalControlSystemStateHistoryVec::is_empty")] + pub history: RESThermalControlSystemStateHistoryVec, + // TODO: add `save_interval` and associated methods +} +impl Init for RESThermalControlSystem {} +impl SerdeAPI for RESThermalControlSystem {} +impl RESThermalControlSystem { + pub fn get_pwr_thermal( + &mut self, + te_amb_air: si::Temperature, + res_thrml_state: RESThermalState, + dt: si::Time, + ) -> anyhow::Result { + let pwr_from_hvac = if res_thrml_state.temperature <= self.te_set + self.te_deadband + && res_thrml_state.temperature >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p = si::Power::ZERO; + self.state.pwr_d = si::Power::ZERO; + si::Power::ZERO + } else { + let te_delta_vs_set = res_thrml_state.temperature - self.te_set; + let te_delta_vs_amb: si::Temperature = res_thrml_state.temperature - te_amb_air; + + self.state.pwr_p = -self.p * te_delta_vs_set; + self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); + self.state.pwr_d = -self.d * uc::J / uc::KELVIN + * ((res_thrml_state.temperature - res_thrml_state.temp_prev) / dt); + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + res_thrml_state.temperature / (5.0 * uc::KELVIN) + } else { + res_thrml_state.temperature / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + + if res_thrml_state.temperature > self.te_set + self.te_deadband { + // COOLING MODE; cabin is hotter than set point + + if self.state.pwr_i > si::Power::ZERO { + // If `pwr_i` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thermal_from_hvac = + (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) + .max(-self.pwr_thermal_max); + + if (-pwr_thermal_from_hvac / self.state.cop) > self.pwr_aux_max { + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + pwr_thermal_from_hvac = -self.state.pwr_aux * self.state.cop; + } else { + self.state.pwr_aux = pwr_thermal_from_hvac / self.state.cop; + } + pwr_thermal_from_hvac + } else { + // HEATING MODE; cabin is colder than set point + + if self.state.pwr_i < si::Power::ZERO { + // If `pwr_i` is less than zero reset to switch from cooling to heating + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thermal_from_hvac = + (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) + .min(self.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + match &self.heat_source { + RESHeatSource::SelfHeating => { + todo!() + } + RESHeatSource::HeatPump => { + todo!() + } + RESHeatSource::None => {} + } + pwr_thermal_from_hvac + } + }; + Ok(pwr_from_hvac) + } +} + +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] +pub enum RESHeatSource { + /// Self heating + SelfHeating, + /// Heat pump provides heat for HVAC system + HeatPump, + /// No active heat source for [RESThermal] + None, +} +impl Init for RESHeatSource {} +impl SerdeAPI for RESHeatSource {} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct RESThermalControlSystemState { + /// time step counter + pub i: u32, + /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain + pub pwr_p: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain + pub energy_p: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain + pub pwr_i: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain + pub energy_i: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain + pub pwr_d: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain + pub energy_d: si::Energy, + /// coefficient of performance (i.e. efficiency) of vapor compression cycle + pub cop: si::Ratio, + /// Aux power demand from HVAC system + pub pwr_aux: si::Power, + /// Cumulative aux energy for HVAC system + pub energy_aux: si::Energy, + /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub energy_thermal_req: si::Energy, +} +impl Init for RESThermalControlSystemState {} +impl SerdeAPI for RESThermalControlSystemState {} diff --git a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs index 54910d09..802d2408 100644 --- a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs +++ b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs @@ -156,6 +156,7 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { fc }, res: ReversibleEnergyStorage { + thrml: Default::default(), state: Default::default(), mass: None, specific_energy: None, @@ -205,6 +206,7 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { BEV => { let bev = BatteryElectricVehicle { res: ReversibleEnergyStorage { + thrml: Default::default(), state: Default::default(), mass: None, specific_energy: None, diff --git a/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv b/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv index 18d9be0f..f3a9a372 100644 --- a/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv +++ b/python/fastsim/resources/demos/demo_variable_paths/to_dataframe_expected.csv @@ -1,1371 +1,1371 @@ -veh.pt_type.ConventionalVehicle.fc.history.i,veh.pt_type.ConventionalVehicle.fc.history.pwr_out_max_watts,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_max_watts,veh.pt_type.ConventionalVehicle.fc.history.eff,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_prop_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_aux_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_aux_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_fuel_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_fuel_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_loss_joules,veh.pt_type.ConventionalVehicle.fc.history.fc_on,veh.pt_type.ConventionalVehicle.fc.history.time_on_seconds,veh.pt_type.ConventionalVehicle.transmission.history.i,veh.pt_type.ConventionalVehicle.transmission.history.eff,veh.pt_type.ConventionalVehicle.transmission.history.pwr_out_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_in_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.transmission.history.energy_out_joules,veh.pt_type.ConventionalVehicle.transmission.history.energy_loss_joules,veh.history.i,veh.history.pwr_prop_fwd_max_watts,veh.history.pwr_prop_bwd_max_watts,veh.history.pwr_tractive_watts,veh.history.pwr_tractive_for_cyc_watts,veh.history.energy_tractive_joules,veh.history.pwr_aux_watts,veh.history.energy_aux_joules,veh.history.pwr_drag_watts,veh.history.energy_drag_joules,veh.history.pwr_accel_watts,veh.history.energy_accel_joules,veh.history.pwr_ascent_watts,veh.history.energy_ascent_joules,veh.history.pwr_rr_watts,veh.history.energy_rr_joules,veh.history.pwr_whl_inertia_watts,veh.history.energy_whl_inertia_joules,veh.history.pwr_brake_watts,veh.history.energy_brake_joules,veh.history.cyc_met,veh.history.cyc_met_overall,veh.history.speed_ach_meters_per_second,veh.history.dist_meters,veh.history.grade_curr,veh.history.mass_kilograms,cyc.time_seconds,cyc.speed_meters_per_second,cyc.dist_meters,cyc.grade,cyc.elev_meters,cyc.pwr_max_chrg_watts -0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,false,0.0,0,0.0,0.0,0.0,0.0,0.0,0.0,0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,0.0,0.0,0.0,0.0,121.92,0.0 -1,21750.0,21050.0,0.12,0.0,0.0,700.0,700.0,5833.333333333334,5833.333333333334,5833.333333333334,5833.333333333334,true,1.0,1,0.875,0.0,0.0,0.0,0.0,0.0,1,21050.0,0.0,0.0,0.0,0.0,700.0,700.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,1.0,0.0,0.0,0.0,121.92,0.0 -2,22450.0,21750.0,0.12,0.0,0.0,700.0,1400.0,5833.333333333334,11666.666666666668,5833.333333333334,11666.666666666668,true,2.0,2,0.875,0.0,0.0,0.0,0.0,0.0,2,21750.0,0.0,0.0,0.0,0.0,700.0,1400.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,2.0,0.0,0.0,0.0,121.92,0.0 -3,22450.0,21750.0,0.12,0.0,0.0,700.0,2100.0,5833.333333333334,17500.0,5833.333333333334,17500.0,true,3.0,3,0.875,0.0,0.0,0.0,0.0,0.0,3,21750.0,0.0,0.0,0.0,0.0,700.0,2100.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,3.0,0.0,0.0,0.0,121.92,0.0 -4,22450.0,21750.0,0.12,0.0,0.0,700.0,2800.0,5833.333333333334,23333.333333333336,5833.333333333334,23333.333333333336,true,4.0,4,0.875,0.0,0.0,0.0,0.0,0.0,4,21750.0,0.0,0.0,0.0,0.0,700.0,2800.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,4.0,0.0,0.0,0.0,121.92,0.0 -5,22450.0,21750.0,0.12,0.0,0.0,700.0,3500.0,5833.333333333334,29166.66666666667,5833.333333333334,29166.66666666667,true,5.0,5,0.875,0.0,0.0,0.0,0.0,0.0,5,21750.0,0.0,0.0,0.0,0.0,700.0,3500.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,5.0,0.0,0.0,0.0,121.92,0.0 -6,22450.0,21750.0,0.12,0.0,0.0,700.0,4200.0,5833.333333333334,35000.00000000001,5833.333333333334,35000.00000000001,true,6.0,6,0.875,0.0,0.0,0.0,0.0,0.0,6,21750.0,0.0,0.0,0.0,0.0,700.0,4200.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,6.0,0.0,0.0,0.0,121.92,0.0 -7,22450.0,21750.0,0.12,0.0,0.0,700.0,4900.0,5833.333333333334,40833.33333333334,5833.333333333334,40833.33333333334,true,7.0,7,0.875,0.0,0.0,0.0,0.0,0.0,7,21750.0,0.0,0.0,0.0,0.0,700.0,4900.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,7.0,0.0,0.0,0.0,121.92,0.0 -8,22450.0,21750.0,0.12,0.0,0.0,700.0,5600.0,5833.333333333334,46666.66666666668,5833.333333333334,46666.66666666668,true,8.0,8,0.875,0.0,0.0,0.0,0.0,0.0,8,21750.0,0.0,0.0,0.0,0.0,700.0,5600.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,8.0,0.0,0.0,0.0,121.92,0.0 -9,22450.0,21750.0,0.12,0.0,0.0,700.0,6300.0,5833.333333333334,52500.000000000015,5833.333333333334,52500.000000000015,true,9.0,9,0.875,0.0,0.0,0.0,0.0,0.0,9,21750.0,0.0,0.0,0.0,0.0,700.0,6300.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,9.0,0.0,0.0,0.0,121.92,0.0 -10,22450.0,21750.0,0.12,0.0,0.0,700.0,7000.0,5833.333333333334,58333.33333333335,5833.333333333334,58333.33333333335,true,10.0,10,0.875,0.0,0.0,0.0,0.0,0.0,10,21750.0,0.0,0.0,0.0,0.0,700.0,7000.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,10.0,0.0,0.0,0.0,121.92,0.0 -11,22450.0,21750.0,0.12,0.0,0.0,700.0,7700.0,5833.333333333334,64166.666666666686,5833.333333333334,64166.666666666686,true,11.0,11,0.875,0.0,0.0,0.0,0.0,0.0,11,21750.0,0.0,0.0,0.0,0.0,700.0,7700.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,11.0,0.0,0.0,0.0,121.92,0.0 -12,22450.0,21750.0,0.12,0.0,0.0,700.0,8400.0,5833.333333333334,70000.00000000001,5833.333333333334,70000.00000000001,true,12.0,12,0.875,0.0,0.0,0.0,0.0,0.0,12,21750.0,0.0,0.0,0.0,0.0,700.0,8400.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,12.0,0.0,0.0,0.0,121.92,0.0 -13,22450.0,21750.0,0.12,0.0,0.0,700.0,9100.0,5833.333333333334,75833.33333333334,5833.333333333334,75833.33333333334,true,13.0,13,0.875,0.0,0.0,0.0,0.0,0.0,13,21750.0,0.0,0.0,0.0,0.0,700.0,9100.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,13.0,0.0,0.0,0.0,121.92,0.0 -14,22450.0,21750.0,0.12,0.0,0.0,700.0,9800.0,5833.333333333334,81666.66666666667,5833.333333333334,81666.66666666667,true,14.0,14,0.875,0.0,0.0,0.0,0.0,0.0,14,21750.0,0.0,0.0,0.0,0.0,700.0,9800.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,14.0,0.0,0.0,0.0,121.92,0.0 -15,22450.0,21750.0,0.12,0.0,0.0,700.0,10500.0,5833.333333333334,87500.0,5833.333333333334,87500.0,true,15.0,15,0.875,0.0,0.0,0.0,0.0,0.0,15,21750.0,0.0,0.0,0.0,0.0,700.0,10500.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,15.0,0.0,0.0,0.0,121.92,0.0 -16,22450.0,21750.0,0.12,0.0,0.0,700.0,11200.0,5833.333333333334,93333.33333333333,5833.333333333334,93333.33333333333,true,16.0,16,0.875,0.0,0.0,0.0,0.0,0.0,16,21750.0,0.0,0.0,0.0,0.0,700.0,11200.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,16.0,0.0,0.0,0.0,121.92,0.0 -17,22450.0,21750.0,0.12,0.0,0.0,700.0,11900.0,5833.333333333334,99166.66666666666,5833.333333333334,99166.66666666666,true,17.0,17,0.875,0.0,0.0,0.0,0.0,0.0,17,21750.0,0.0,0.0,0.0,0.0,700.0,11900.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,17.0,0.0,0.0,0.0,121.92,0.0 -18,22450.0,21750.0,0.12,0.0,0.0,700.0,12600.0,5833.333333333334,104999.99999999999,5833.333333333334,104999.99999999999,true,18.0,18,0.875,0.0,0.0,0.0,0.0,0.0,18,21750.0,0.0,0.0,0.0,0.0,700.0,12600.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,18.0,0.0,0.0,0.0,121.92,0.0 -19,22450.0,21750.0,0.12,0.0,0.0,700.0,13300.0,5833.333333333334,110833.33333333331,5833.333333333334,110833.33333333331,true,19.0,19,0.875,0.0,0.0,0.0,0.0,0.0,19,21750.0,0.0,0.0,0.0,0.0,700.0,13300.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,19.0,0.0,0.0,0.0,121.92,0.0 -20,22450.0,21750.0,0.12,0.0,0.0,700.0,14000.0,5833.333333333334,116666.66666666664,5833.333333333334,116666.66666666664,true,20.0,20,0.875,0.0,0.0,0.0,0.0,0.0,20,21750.0,0.0,0.0,0.0,0.0,700.0,14000.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,1644.2724500334996,20.0,0.0,0.0,0.0,121.92,0.0 -21,22450.0,21750.0,0.1696,1808.327174958617,1808.327174958617,700.0,14700.0,14789.664946689958,131456.3316133566,12981.337771731341,129648.00443839798,true,21.0,21,0.875,1582.28627808879,1808.327174958617,226.04089686982707,0.0,0.0,21,21750.0,0.0,1582.28627808879,1582.28627808879,1582.28627808879,700.0,14700.0,0.14721772299579924,0.14721772299579924,1478.7445436315438,1478.7445436315438,0.0,0.0,75.63844389482165,75.63844389482165,27.75607283942872,27.75607283942872,-1582.28627808879,-1582.28627808879,true,true,1.341141759,1.341141759,0.0,1644.2724500334996,21.0,1.341141759,1.341141759,0.0,121.92,0.0 -22,24258.327174958617,23558.327174958617,0.23500000000000001,5198.339298863856,7006.666473822474,700.0,15400.0,25099.31616537811,156555.6477787347,19900.976866514255,149548.98130491225,true,22.0,22,0.875,4548.546886505874,5198.339298863856,649.7924123579824,0.0,0.0,22,23558.327174958617,0.0,4548.546886505874,4548.546886505874,6130.833164594664,700.0,15400.0,3.843849292883245,3.991067015879044,4240.710738200853,5719.455281832396,0.0,0.0,224.3940501818252,300.03249407664686,79.59824883031244,107.35432166974117,-4548.546886505874,-6130.833164594664,true,true,2.637578792,3.978720551,0.0,1644.2724500334996,22.0,2.637578792,3.978720551,0.0,121.92,0.0 -23,27648.339298863855,26948.339298863855,0.28625,7926.2698795919205,14932.936353414394,700.0,16100.0,30135.440627395354,186691.08840613006,22209.170747803433,171758.15205271568,true,23.0,23,0.875,6935.48614464293,7926.2698795919205,990.7837349489901,0.0,0.0,23,26948.339298863855,0.0,6935.48614464293,6935.48614464293,13066.319309237595,700.0,16100.0,16.62265297987032,20.613719995749364,6432.538762775781,12151.994044608178,0.0,0.0,365.5858120737068,665.6183061503536,120.7389168135726,228.09323848331377,-6935.48614464293,-13066.319309237595,true,true,3.844606375,7.823326926,0.0,1644.2724500334996,23.0,3.844606375,7.823326926,0.0,121.92,0.0 -24,30376.26987959192,29676.26987959192,0.3175,11780.751469940089,26713.687823354485,700.0,16800.0,39309.4534486302,226000.54185476026,27528.70197869011,199286.8540314058,true,24.0,24,0.875,10308.157536197577,11780.751469940089,1472.5939337425116,0.0,0.0,24,29676.26987959192,0.0,10308.157536197577,10308.157536197577,23374.476845435172,700.0,16800.0,44.27764398738515,64.89136398313451,9577.335486630982,21729.32953123916,0.0,0.0,506.7775739655883,1172.395880115942,179.7668316136226,407.8600700969364,-10308.157536197577,-23374.476845435172,true,true,5.141043408,12.964370334,0.0,1644.2724500334996,24.0,5.141043408,12.964370334,0.0,121.92,0.0 -25,34230.75146994009,33530.75146994009,0.335,14670.065836971798,41383.753660326285,700.0,17500.0,45880.7935431994,271881.3353979597,31210.727706227597,230497.5817376334,true,25.0,25,0.875,12836.307607350323,14670.065836971798,1833.758229621475,0.0,0.0,25,33530.75146994009,0.0,12836.307607350323,12836.307607350323,36210.7844527855,700.0,17500.0,93.63871593500616,158.53007991814067,11869.389529590659,33598.71906082982,0.0,0.0,650.4906173037111,1822.886497419653,222.788744520946,630.6488146178824,-12836.307607350323,-36210.7844527855,true,true,6.392775716,19.35714605,0.0,1644.2724500334996,25.0,6.392775716,19.35714605,0.0,121.92,0.0 -26,37120.0658369718,36420.0658369718,0.345,16606.665091304716,57990.418751631005,700.0,18200.0,50164.24664146295,322045.58203942265,33557.58155015824,264055.16328779166,true,26.0,26,0.875,14530.831954891626,16606.665091304716,2075.83313641309,0.0,0.0,26,36420.0658369718,0.0,14530.831954891626,14530.831954891626,50741.616407677124,700.0,18200.0,165.59991663172076,324.1299965498614,13328.417485452268,46927.13654628208,0.0,0.0,786.6398163031103,2609.5263137227635,250.17473650452703,880.8235511224094,-14530.831954891626,-50741.616407677124,true,true,7.555098574,26.912244624,0.0,1644.2724500334996,26.0,7.555098574,26.912244624,0.0,121.92,0.0 -27,39056.66509130472,38356.66509130472,0.196,3851.7356893457522,61842.15444097676,700.0,18900.0,23223.141272172208,345268.72331159486,19371.405582826457,283426.5688706181,true,27.0,27,0.875,3370.2687281775334,3851.7356893457522,481.46696116821886,0.0,0.0,27,38356.66509130472,0.0,3370.2687281775334,3370.2687281775334,54111.88513585466,700.0,18900.0,218.10953404401812,542.2395305938795,2247.691703276772,49174.82824955886,0.0,0.0,862.278260197932,3471.8045739206955,42.1892306588113,923.0127817812207,-3370.2687281775334,-54111.88513585466,true,true,7.733917475,34.646162099,0.0,1644.2724500334996,27.0,7.733917475,34.646162099,0.0,121.92,0.0 -28,26301.735689345755,25601.735689345755,0.265,6714.13981026355,68556.29425124031,700.0,19600.0,27977.886076466228,373246.6093880611,21263.746266202677,304690.3151368208,true,28.0,28,0.875,5874.8723339806065,6714.13981026355,839.2674762829438,0.0,0.0,28,25601.735689345755,0.0,5874.8723339806065,5874.8723339806065,59986.75746983527,700.0,19600.0,241.8834296566501,784.1229602505296,4653.116157521396,53827.94440708026,0.0,0.0,892.5336377220215,4364.3382116427165,87.33910908053836,1010.3518908617591,-5874.8723339806065,-59986.75746983527,true,true,8.091555277,42.737717376,0.0,1644.2724500334996,28.0,8.091555277,42.737717376,0.0,121.92,0.0 -29,29164.13981026355,28464.13981026355,0.35333333333333333,20780.50523360775,89336.79948484806,700.0,20300.0,60793.88273662571,434040.49212468683,40013.37750301796,344703.69263983873,true,29.0,29,0.875,18182.94207940678,20780.50523360775,2597.5631542009687,0.0,0.0,29,28464.13981026355,0.0,18182.94207940678,18182.94207940678,78169.69954924205,700.0,20300.0,318.4868522607286,1102.609812511258,16575.083283264168,70403.02769034443,0.0,0.0,978.2572074582062,5342.595419100922,311.11473642367656,1321.4666272854356,-18182.94207940678,-78169.69954924205,true,true,9.253878135,51.991595511,0.0,1644.2724500334996,29.0,9.253878135,51.991595511,0.0,121.92,0.0 -30,43230.50523360775,42530.50523360775,0.30500000000000005,9807.923090693579,99144.72257554164,700.0,21000.0,34452.20685473304,468492.6989794199,24644.283764039465,369347.9764038782,true,30.0,30,0.875,8581.932704356881,9807.923090693579,1225.990386336698,0.0,0.0,30,42530.50523360775,0.0,8581.932704356881,8581.932704356881,86751.63225359893,700.0,21000.0,415.61757263409874,1518.2273851453567,6966.5298484538425,77369.55753879827,0.0,0.0,1069.023340143272,6411.618759244195,130.76194312566773,1452.2285704111034,-8581.932704356881,-86751.63225359893,true,true,9.700925388,61.692520899,0.0,1644.2724500334996,30.0,9.700925388,61.692520899,0.0,121.92,0.0 -31,32257.923090693577,31557.923090693577,0.28,7710.654440017892,106855.37701555954,700.0,21700.0,30038.05157149247,498530.75055091234,22327.39713147458,391675.37353535276,true,31.0,31,0.875,6746.822635015656,7710.654440017892,963.8318050022363,0.0,0.0,31,31557.923090693577,0.0,6746.822635015656,6746.822635015656,93498.4548886146,700.0,21700.0,467.6404824419889,1985.8678675873457,5072.0936996015325,82441.6512383998,0.0,0.0,1111.8851247293717,7523.503883973566,95.2033282427622,1547.4318986538656,-6746.822635015656,-93498.4548886146,true,true,10.01385846,71.706379359,0.0,1644.2724500334996,31.0,10.01385846,71.706379359,0.0,121.92,0.0 -32,30160.65444001789,29460.65444001789,0.1864,2716.7847369011556,109572.1617524607,700.0,22400.0,18330.3902194268,516861.1407703392,15613.605482525645,407288.9790178784,true,32.0,32,0.875,2377.1866447885113,2716.7847369011556,339.5980921126443,0.0,0.0,32,29460.65444001789,0.0,2377.1866447885113,2377.1866447885113,95875.6415334031,700.0,22400.0,493.55477106152716,2479.4226386488726,737.729299526981,83179.38053792679,0.0,0.0,1132.055376412098,8655.559260385664,13.847197787905301,1561.279096441771,-2377.1866447885113,-95875.6415334031,true,true,10.05856319,81.764942549,0.0,1644.2724500334996,32.0,10.05856319,81.764942549,0.0,121.92,0.0 -33,25166.784736901154,24466.784736901154,0.12,0.0,109572.1617524607,700.0,23100.0,5833.333333333334,522694.4741036725,5833.333333333334,413122.31235121173,true,33.0,33,0.875,0.0,0.0,0.0,0.0,0.0,33,24466.784736901154,0.0,-1377.999818492709,-1377.999818492709,94497.6417149104,700.0,23100.0,483.72764490970684,2963.1502835585793,-2931.2002913922315,80248.18024653455,0.0,0.0,1124.4915322989687,9780.050792684633,-55.01870430915308,1506.2603921326179,-0.0,-95875.6415334031,true,true,9.879744289,91.644686838,0.0,1644.2724500334996,33.0,9.879744289,91.644686838,0.0,121.92,0.0 -34,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,23800.0,5833.333333333334,528527.8074370058,5833.333333333334,418955.64568454504,true,34.0,34,0.875,0.0,0.0,0.0,0.0,0.0,34,21750.0,0.0,-2827.7024056923065,-2827.7024056923065,91669.93930921808,700.0,23800.0,451.91400403597083,3415.06428759455,-4298.217475635412,75949.96277089915,0.0,0.0,1099.2787176673617,10879.329510351994,-80.67765176022748,1425.5827403723904,-0.0,-95875.6415334031,true,true,9.611515937,101.25620277499999,0.0,1644.2724500334996,34.0,9.611515937,101.25620277499999,0.0,121.92,0.0 -35,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,24500.0,5833.333333333334,534361.1407703392,5833.333333333334,424788.97901787836,true,35.0,35,0.875,0.0,0.0,0.0,0.0,0.0,35,21750.0,0.0,-2773.7341652430473,-2773.7341652430473,88896.20514397504,700.0,24500.0,415.61757256831817,3830.6818601628684,-4179.917911968478,71770.04485893066,0.0,0.0,1069.0233400868733,11948.352850438867,-78.4571659297614,1347.125574442629,-0.0,-95875.6415334031,true,true,9.343287585,110.59949035999999,0.0,1644.2724500334996,35.0,9.343287585,110.59949035999999,0.0,121.92,0.0 -36,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,25200.0,5833.333333333334,540194.4741036725,5833.333333333334,430622.3123512117,true,36.0,36,0.875,0.0,0.0,0.0,0.0,0.0,36,21750.0,0.0,-2031.1907897063204,-2031.1907897063204,86865.01435426871,700.0,25200.0,384.10192764921766,4214.783787812086,-3392.8971943978986,68377.14766453276,0.0,0.0,1041.2892440090252,12989.642094447892,-63.6847669666647,1283.4408074759642,-0.0,-95875.6415334031,true,true,9.119763959,119.71925431899999,0.0,1644.2724500334996,36.0,9.119763959,119.71925431899999,0.0,121.92,0.0 -37,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,25900.0,5833.333333333334,546027.8074370059,5833.333333333334,436455.645684545,true,37.0,37,0.875,0.0,0.0,0.0,0.0,0.0,37,21750.0,0.0,-2669.645354288944,-2669.645354288944,84195.36899997976,700.0,25900.0,354.2211518990812,4569.004939711167,-3963.035378873108,64414.112285659656,0.0,0.0,1013.5551479311766,14003.197242379068,-74.3862752460937,1209.0545322298706,-0.0,-95875.6415334031,true,true,8.851535607,128.57078992599997,0.0,1644.2724500334996,37.0,8.851535607,128.57078992599997,0.0,121.92,0.0 -38,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,26600.0,5833.333333333334,551861.1407703393,5833.333333333334,442288.9790178783,true,38.0,38,0.875,0.0,0.0,0.0,0.0,0.0,38,21750.0,0.0,-16048.195204836218,-16048.195204836218,68147.17379514355,700.0,26600.0,271.731375862927,4840.736315574094,-16929.98196515015,47484.1303205095,0.0,0.0,927.8315781949918,14931.02882057406,-317.7761937439876,891.278338485883,-0.0,-95875.6415334031,true,true,7.599803299,136.17059322499998,0.0,1644.2724500334996,38.0,7.599803299,136.17059322499998,0.0,121.92,0.0 -39,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,27300.0,5833.333333333334,557694.4741036727,5833.333333333334,448122.3123512116,true,39.0,39,0.875,0.0,0.0,0.0,0.0,0.0,39,21750.0,0.0,-10232.0994533186,-10232.0994533186,57915.07434182495,700.0,27300.0,176.99800891476542,5017.73432448886,-11006.788546724434,36477.34177378507,0.0,0.0,804.2887865395954,15735.317607113655,-206.59770204852575,684.6806364373572,-0.0,-95875.6415334031,true,true,6.661004068,142.831597293,0.0,1644.2724500334996,39.0,6.661004068,142.831597293,0.0,121.92,0.0 -40,22450.0,21750.0,0.15200000000000002,1023.5826624745278,110595.74441493522,700.0,28000.0,11339.359621542944,569033.8337252156,10315.776959068417,458438.08931028005,true,40.0,40,0.875,895.6348296652118,1023.5826624745278,127.94783280931597,0.0,0.0,40,21750.0,0.0,895.6348296652118,895.6348296652118,58810.70917149016,700.0,28000.0,144.29295383507196,5162.027278323932,0.0,36477.34177378507,0.0,0.0,751.3418758301399,16486.659482943796,0.0,684.6806364373572,-895.6348296652118,-96771.27636306832,true,true,6.661004068,149.492601361,0.0,1644.2724500334996,40.0,6.661004068,149.492601361,0.0,121.92,0.0 -41,23473.582662474528,22773.582662474528,0.1864,2764.7117931433886,113360.45620807861,700.0,28700.0,18587.509619867964,587621.3433450836,15822.797826724574,474260.88713700464,true,41.0,41,0.875,2419.122819000465,2764.7117931433886,345.5889741429237,0.0,0.0,41,22773.582662474528,0.0,2419.122819000465,2419.122819000465,61229.831990490624,700.0,28700.0,148.69481282630025,5310.722091150232,1483.673692852741,37961.01546663781,0.0,0.0,758.9057202252619,17245.56520316906,27.848593096162,712.5292295335191,-2419.122819000465,-99190.39918206878,true,true,6.795118244,156.287719605,0.0,1644.2724500334996,41.0,6.795118244,156.287719605,0.0,121.92,0.0 -42,25214.71179314339,24514.71179314339,0.1888,2826.801139042185,116187.2573471208,700.0,29400.0,18680.09077882513,606301.4341239088,15853.289639782946,490114.1767767876,true,42.0,42,0.875,2473.4509966619116,2826.801139042185,353.35014238027316,0.0,0.0,42,24514.71179314339,0.0,2473.4509966619116,2473.4509966619116,63703.28298715253,700.0,29400.0,157.76528932315836,5468.48738047339,1513.2485837694687,39474.26405040728,0.0,0.0,774.0334090155059,18019.598612184564,28.40371455377847,740.9329440872976,-2473.4509966619116,-101663.85017873069,true,true,6.92923242,163.216952025,0.0,1644.2724500334996,42.0,6.92923242,163.216952025,0.0,121.92,0.0 -43,25276.801139042185,24576.801139042185,0.20800000000000002,4115.431599343782,120302.68894646458,700.0,30100.0,23151.113458383566,629452.5475822923,19035.681859039785,509149.8586358274,true,43.0,43,0.875,3601.002649425809,4115.431599343782,514.4289499179731,0.0,0.0,43,24576.801139042185,0.0,3601.002649425809,3601.002649425809,67304.28563657834,700.0,30100.0,170.4229164559391,5638.910296929329,2587.802944923363,42062.06699533064,0.0,0.0,794.2036606982323,18813.802272882796,48.573127348274625,789.5060714355723,-3601.002649425809,-105264.8528281565,true,true,7.152756046,170.36970807100002,0.0,1644.2724500334996,43.0,7.152756046,170.36970807100002,0.0,121.92,0.0 -44,26565.43159934378,25865.43159934378,0.28625,8145.039570291977,128447.72851675656,700.0,30800.0,30899.701555605163,660352.2491378975,22754.661985313185,531904.5206211406,true,44.0,44,0.875,7126.90962400548,8145.039570291977,1018.1299462864972,0.0,0.0,44,25865.43159934378,0.0,7126.90962400548,7126.90962400548,74431.19526058382,700.0,30800.0,197.73352701896206,5836.643823948291,5982.34319834801,48044.410193678654,0.0,0.0,834.544164063685,19648.346436946482,112.28873457482169,901.7948060103939,-7126.90962400548,-112391.76245216197,true,true,7.644508024,178.01421609500002,0.0,1644.2724500334996,44.0,7.644508024,178.01421609500002,0.0,121.92,0.0 -45,30595.039570291978,29895.039570291978,0.33999999999999997,15188.937251058542,143636.6657678151,700.0,31500.0,46732.168385466306,707084.4175233638,31543.231134407764,563447.7517555484,true,45.0,45,0.875,13290.320094676224,15188.937251058542,1898.6171563823173,0.0,0.0,45,29895.039570291978,0.0,13290.320094676224,13290.320094676224,87721.51535526004,700.0,31500.0,258.65569399419934,6095.299517942491,11895.678325388006,59940.08851906666,0.0,0.0,912.703889404748,20561.05032635123,223.28218588927055,1125.0769918996646,-13290.320094676224,-125682.0825468382,true,true,8.53860253,186.55281862500001,0.0,1644.2724500334996,45.0,8.53860253,186.55281862500001,0.0,121.92,0.0 -46,37638.93725105854,36938.93725105854,0.345,16943.826823077517,160580.49259089262,700.0,32200.0,51141.527023413095,758225.9445467769,34197.700200335574,597645.451955884,true,46.0,46,0.875,14825.848470192828,16943.826823077517,2117.9783528846892,0.0,0.0,46,36938.93725105854,0.0,14825.848470192828,14825.848470192828,102547.36382545286,700.0,32200.0,354.2211518990812,6449.520669841571,13210.117919727141,73150.2064387938,0.0,0.0,1013.5551479311766,21574.605474282405,247.95425063542908,1373.0312425350937,-14825.848470192828,-140507.93101703102,true,true,9.432697036,195.98551566100002,0.0,1644.2724500334996,46.0,9.432697036,195.98551566100002,0.0,121.92,0.0 -47,39393.826823077514,38693.826823077514,0.33999999999999997,15192.115397698453,175772.60798859107,700.0,32900.0,46741.51587558369,804967.4604223606,31549.400477885236,629194.8524337693,true,47.0,47,0.875,13293.100972986147,15192.115397698453,1899.0144247123062,0.0,0.0,47,38693.826823077514,0.0,13293.100972986147,13293.100972986147,115840.464798439,700.0,32900.0,458.1615751941962,6907.682245035768,11514.490830357088,84664.69726915089,0.0,0.0,1104.3212805598437,22678.92675484225,216.12728687502045,1589.1585294101142,-13293.100972986147,-153801.03199001716,true,true,10.14797264,206.13348830100003,0.0,1644.2724500334996,47.0,10.14797264,206.13348830100003,0.0,121.92,0.0 -48,37642.11539769845,36942.11539769845,0.196,3649.4765762998713,179422.08456489095,700.0,33600.0,22191.207021938117,827158.6674442987,18541.730445638244,647736.5828794076,true,48.0,48,0.875,3193.2920042623873,3649.4765762998713,456.18457203748403,0.0,0.0,48,36942.11539769845,0.0,3193.2920042623873,3193.2920042623873,119033.75680270139,700.0,33600.0,517.0003768410601,7424.682621876827,1498.4611269910556,86163.15839614194,0.0,0.0,1149.704346817779,23828.63110166003,28.126153612492594,1617.2846830226067,-3193.2920042623873,-156994.32399427955,true,true,10.23738209,216.37087039100004,0.0,1644.2724500334996,48.0,10.23738209,216.37087039100004,0.0,121.92,0.0 -49,26099.476576299872,25399.476576299872,0.124,160.13422063461817,179582.21878552556,700.0,34300.0,6936.566295440469,834095.2337397392,6776.432074805851,654513.0149542134,true,49.0,49,0.875,140.1174430552909,160.13422063461817,20.016777579327282,0.0,0.0,49,25399.476576299872,0.0,140.1174430552909,140.1174430552909,119173.87424575668,700.0,34300.0,517.0003768410601,7941.682998717887,-1498.4611269910556,84664.69726915089,0.0,0.0,1149.704346817779,24978.33544847781,-28.126153612492594,1589.1585294101142,-140.1174430552909,-157134.44143733484,true,true,10.14797264,226.51884303100005,0.0,1644.2724500334996,49.0,10.14797264,226.51884303100005,0.0,121.92,0.0 -50,22610.13422063462,21910.13422063462,0.15200000000000002,1017.9794540270638,180600.1982395526,700.0,35000.0,11302.496408072786,845397.7301478119,10284.516954045723,664797.5319082591,true,50.0,50,0.875,890.7320222736807,1017.9794540270638,127.24743175338301,0.0,0.0,50,21910.13422063462,0.0,890.7320222736807,890.7320222736807,120064.60626803036,700.0,35000.0,506.8634065385323,8448.54640525642,-744.301332020297,83920.39593713058,0.0,0.0,1142.140502761048,26120.47595123886,-13.970555005602682,1575.1879744045116,-890.7320222736807,-158025.17345960852,true,true,10.10326792,236.62211095100005,0.0,1644.2724500334996,50.0,10.10326792,236.62211095100005,0.0,121.92,0.0 -51,23467.979454027063,22767.979454027063,0.12,0.0,180600.1982395526,700.0,35700.0,5833.333333333334,851231.0634811453,5833.333333333334,670630.8652415925,true,51.0,51,0.875,0.0,0.0,0.0,0.0,0.0,51,22767.979454027063,0.0,-7984.7384645693055,-7984.7384645693055,112079.86780346105,700.0,35700.0,461.30683862614904,8909.85324388257,-9376.883522412647,74543.51241471793,0.0,0.0,1106.8425623444764,27227.318513583334,-176.00434312728353,1399.183631277228,-0.0,-158025.17345960852,true,true,9.522106487,246.14421743800006,0.0,1644.2724500334996,51.0,9.522106487,246.14421743800006,0.0,121.92,0.0 -52,22450.0,21750.0,0.12,0.0,180600.1982395526,700.0,36400.0,5833.333333333334,857064.3968144787,5833.333333333334,676464.1985749259,true,52.0,52,0.875,0.0,0.0,0.0,0.0,0.0,52,21750.0,0.0,-14142.334854242756,-14142.334854242756,97937.5329492183,700.0,36400.0,356.8711745509055,9266.724418433476,-15229.425748096373,59314.08666662156,0.0,0.0,1016.0764294338162,28243.39494301715,-285.8567101311042,1113.3269211461238,-0.0,-158025.17345960852,true,true,8.493897805,254.63811524300004,0.0,1644.2724500334996,52.0,8.493897805,254.63811524300004,0.0,121.92,0.0 -53,22450.0,21750.0,0.12,0.0,180600.1982395526,700.0,37100.0,5833.333333333334,862897.730147812,5833.333333333334,682297.5319082593,true,53.0,53,0.875,0.0,0.0,0.0,0.0,0.0,53,21750.0,0.0,-10314.507925615877,-10314.507925615877,87623.02502360241,700.0,37100.0,256.5180545042647,9523.24247293774,-11269.676472942918,48044.41019367864,0.0,0.0,910.1826079585067,29153.577550975657,-211.53211513572967,901.7948060103942,-0.0,-158025.17345960852,true,true,7.644508024,262.282623267,0.0,1644.2724500334996,53.0,7.644508024,262.282623267,0.0,121.92,0.0 -54,22450.0,21750.0,0.12,0.0,180600.1982395526,700.0,37800.0,5833.333333333334,868731.0634811454,5833.333333333334,688130.8652415926,true,54.0,54,0.875,0.0,0.0,0.0,0.0,0.0,54,21750.0,0.0,-6135.553246082382,-6135.553246082382,81487.47177752003,700.0,37800.0,194.1708472432873,9717.413320181027,-7027.322668585171,41017.08752509347,0.0,0.0,829.5016011712027,29983.07915214686,-131.90302591170146,769.8917800986927,-0.0,-158025.17345960852,true,true,7.063346596,269.345969863,0.0,1644.2724500334996,54.0,7.063346596,269.345969863,0.0,121.92,0.0 -55,22450.0,21750.0,0.15200000000000002,1107.1726767433381,181707.37091629594,700.0,38500.0,11889.293925943011,880620.3574070884,10782.121249199674,698912.9864907924,true,55.0,55,0.875,968.7760921504209,1107.1726767433381,138.39658459291718,0.0,0.0,55,21750.0,0.0,968.7760921504209,968.7760921504209,82456.24786967045,700.0,38500.0,172.051149949549,9889.464470130577,0.0,41017.08752509347,0.0,0.0,796.724942200872,30779.80409434773,0.0,769.8917800986927,-968.7760921504209,-158993.94955175894,true,true,7.063346596,276.40931645899997,0.0,1644.2724500334996,55.0,7.063346596,276.40931645899997,0.0,121.92,0.0 -56,23557.17267674334,22857.17267674334,0.33,13375.9148672416,195083.28578353755,700.0,39200.0,42654.28747648969,923274.6448835781,29278.372609248094,728191.3591000405,true,56.0,56,0.875,11703.925508836399,13375.9148672416,1671.9893584052006,0.0,0.0,56,22857.17267674334,0.0,11703.925508836399,11703.925508836399,94160.17337850685,700.0,39200.0,204.98909254787833,10094.453562678455,10458.010011398097,51475.097536491565,0.0,0.0,844.6292899614467,31624.433384309177,196.297114928978,966.1888950276707,-11703.925508836399,-170697.87506059534,true,true,7.912736376,284.32205283499997,0.0,1644.2724500334996,56.0,7.912736376,284.32205283499997,0.0,121.92,0.0 -57,35825.9148672416,35125.9148672416,0.345,16474.166342624427,211557.45212616198,700.0,39900.0,49780.19229746211,973054.8371810402,33306.025954837685,761497.3850548782,true,57.0,57,0.875,14414.895549796373,16474.166342624427,2059.2707928280543,0.0,0.0,57,35125.9148672416,0.0,14414.895549796373,14414.895549796373,108575.06892830323,700.0,39900.0,287.5346149946233,10381.988177673078,12939.014749168073,64414.112285659634,0.0,0.0,945.480548431477,32569.913932740656,242.86563720220002,1209.0545322298708,-14414.895549796373,-185112.77061039172,true,true,8.851535607,293.173588442,0.0,1644.2724500334996,57.0,8.851535607,293.173588442,0.0,121.92,0.0 -58,38924.16634262443,38224.16634262443,0.33999999999999997,15890.896470636682,227448.34859679866,700.0,40600.0,48796.75432540201,1021851.5915064422,32905.85785476533,794403.2429096436,true,58.0,58,0.875,13904.534411807097,15890.896470636682,1986.3620588295853,0.0,0.0,58,38224.16634262443,0.0,13904.534411807097,13904.534411807097,122479.60334011032,700.0,40600.0,386.89877544561716,10768.886953118696,12244.004827620138,76658.11711327978,0.0,0.0,1043.8105255116648,33613.72445825232,229.82028322967764,1438.8748154595485,-13904.534411807097,-199017.30502219882,true,true,9.656220663,302.829809105,0.0,1644.2724500334996,58.0,9.656220663,302.829809105,0.0,121.92,0.0 -59,38340.89647063668,37640.89647063668,0.33999999999999997,15563.701730610828,243012.0503274095,700.0,41300.0,47834.416854737734,1069686.0083611798,32270.715124126906,826673.9580337704,true,59.0,59,0.875,13618.239014284474,15563.701730610828,1945.462716326354,0.0,0.0,59,37640.89647063668,0.0,13618.239014284474,13618.239014284474,136097.8423543948,700.0,41300.0,490.2644173977315,11259.151370516427,11777.378800679639,88435.49591395941,0.0,0.0,1129.5340954170451,34743.258553669366,221.0617007900585,1659.936516249607,-13618.239014284474,-212635.5440364833,true,true,10.37149627,313.201305375,0.0,1644.2724500334996,59.0,10.37149627,313.201305375,0.0,121.92,0.0 -60,38013.70173061083,37313.70173061083,0.3175,11097.13893790936,254109.18926531886,700.0,42000.0,37156.343111525544,1106842.3514727054,26059.204173616185,852733.1622073866,true,60.0,60,0.875,9709.99657067069,11097.13893790936,1387.14236723867,0.0,0.0,60,37313.70173061083,0.0,9709.99657067069,9709.99657067069,145807.83892506547,700.0,42000.0,580.6726312441465,11839.824001760573,7788.054543387607,96223.55045734702,0.0,0.0,1195.0874134141052,35938.34596708347,146.18198262483082,1806.1184988744378,-9709.99657067069,-222345.540607154,true,true,10.81854352,324.019848895,0.0,1644.2724500334996,60.0,10.81854352,324.019848895,0.0,121.92,0.0 -61,33547.13893790936,32847.13893790936,0.25,5864.545207191273,259973.7344725101,700.0,42700.0,26258.180828765093,1133100.5323014704,20393.63562157382,873126.7978289603,true,61.0,61,0.875,5131.477056292364,5864.545207191273,733.0681508989092,0.0,0.0,61,32847.13893790936,0.0,5131.477056292364,5131.477056292364,150939.31598135782,700.0,42700.0,633.6592773480427,12473.483279108616,3207.232587723856,99430.78304507089,0.0,0.0,1230.3853536614813,37168.731320744955,60.19983755898447,1866.3183364334222,-5131.477056292364,-227477.01766344634,true,true,10.99736242,335.017211315,0.0,1644.2724500334996,61.0,10.99736242,335.017211315,0.0,121.92,0.0 -62,28314.545207191273,27614.545207191273,0.22,5022.94952050384,264996.6839930139,700.0,43400.0,26013.40691138109,1159113.9392128515,20990.45739087725,894117.2552198377,true,62.0,62,0.875,4395.08083044086,5022.94952050384,627.86869006298,0.0,0.0,62,27614.545207191273,0.0,4395.08083044086,4395.08083044086,155334.39681179868,700.0,43400.0,661.3204135987122,13134.803692707328,2439.9285711970974,101870.71161626799,0.0,0.0,1248.0343240671623,38416.76564481212,45.79752157788761,1912.11585801131,-4395.08083044086,-231872.0984938872,true,true,11.1314766,346.148687915,0.0,1644.2724500334996,62.0,11.1314766,346.148687915,0.0,121.92,0.0 -63,27472.94952050384,26772.94952050384,0.1936,3166.7115109483248,268163.39550396224,700.0,44100.0,19972.68342431986,1179086.6226371713,16805.971913371537,910923.2271332092,true,63.0,63,0.875,2770.8725720797843,3166.7115109483248,395.8389388685405,0.0,0.0,63,26772.94952050384,0.0,2770.8725720797843,2770.8725720797843,158105.26938387848,700.0,44100.0,677.4823240752954,13812.286016782624,819.8815995946654,102690.59321586265,0.0,0.0,1258.1194498521265,39674.88509466425,15.389198557696954,1927.505056569007,-2770.8725720797843,-234642.971065967,true,true,11.17618132,357.324869235,0.0,1644.2724500334996,63.0,11.17618132,357.324869235,0.0,121.92,0.0 -64,25616.711510948324,24916.711510948324,0.12,0.0,268163.39550396224,700.0,44800.0,5833.333333333334,1184919.9559705046,5833.333333333334,916756.5604665426,true,64.0,64,0.875,0.0,0.0,0.0,0.0,0.0,64,24916.711510948324,0.0,-1405.1047676397538,-1405.1047676397538,156700.16461623873,700.0,44800.0,665.3365180561832,14477.622534838807,-3259.8101707917626,99430.78304507089,0.0,0.0,1250.5556052314105,40925.44069989566,-61.18672013558456,1866.3183364334222,-0.0,-234642.971065967,true,true,10.99736242,368.322231655,0.0,1644.2724500334996,64.0,10.99736242,368.322231655,0.0,121.92,0.0 -65,22450.0,21750.0,0.15600000000000003,1213.128138690647,269376.5236426529,700.0,45500.0,12263.641914683632,1197183.5978851882,11050.513775992986,927807.0742425356,true,65.0,65,0.875,1061.487121354316,1213.128138690647,151.64101733633083,0.0,0.0,65,21750.0,0.0,1061.487121354316,1061.487121354316,157761.65173759306,700.0,45500.0,645.4176063110823,15123.04014114989,-806.7372052978224,98624.04583977307,0.0,0.0,1237.9491982821974,42163.38989817786,-15.142477941141186,1851.1758584922811,-1061.487121354316,-235704.45818732132,true,true,10.9526577,379.27488935499997,0.0,1644.2724500334996,65.0,10.9526577,379.27488935499997,0.0,121.92,0.0 -66,23663.12813869065,22963.12813869065,0.20800000000000002,4042.225076533021,273418.74871918594,700.0,46200.0,22799.159021793366,1219982.7569069816,18756.933945260345,946564.008187796,true,66.0,66,0.875,3536.9469419663933,4042.225076533021,505.2781345666276,0.0,0.0,66,22963.12813869065,0.0,3536.9469419663933,3536.9469419663933,161298.59867955945,700.0,46200.0,649.3691321545542,15772.409273304444,1616.7606903639685,100240.80653013704,0.0,0.0,1240.4704800104312,43403.86037818829,30.346639437439478,1881.5224979297207,-3536.9469419663933,-239241.4051292877,true,true,11.04206715,390.31695650499995,0.0,1644.2724500334996,66.0,11.04206715,390.31695650499995,0.0,121.92,0.0 -67,26492.22507653302,25792.22507653302,0.1936,3129.062832413186,276547.8115515991,700.0,46900.0,19778.21710957224,1239760.9740165537,16649.154277159054,963213.162464955,true,67.0,67,0.875,2737.9299783615375,3129.062832413186,391.13285405164834,0.0,0.0,67,25792.22507653302,0.0,2737.9299783615375,2737.9299783615375,164036.52865792098,700.0,46900.0,661.3204135987122,16433.729686903156,813.3094024462439,101054.11593258329,0.0,0.0,1248.0343240671623,44651.89470225546,15.265838249418884,1896.7883361791396,-2737.9299783615375,-241979.33510764924,true,true,11.08677187,401.40372837499996,0.0,1644.2724500334996,67.0,11.08677187,401.40372837499996,0.0,121.92,0.0 -68,25579.062832413187,24879.062832413187,0.15600000000000003,1235.1765679659563,277782.98811956507,700.0,47600.0,12404.97799978177,1252165.9520163354,11169.801431815813,974382.9638967708,true,68.0,68,0.875,1080.7794969702118,1235.1765679659563,154.39707099574457,0.0,0.0,68,24879.062832413187,0.0,1080.7794969702118,1080.7794969702118,165117.3081548912,700.0,47600.0,661.3204135987122,17095.050100501867,-813.3094024462439,100240.80653013704,0.0,0.0,1248.0343240671623,45899.92902632262,-15.265838249418884,1881.5224979297207,-1080.7794969702118,-243060.11460461945,true,true,11.04206715,412.44579552499994,0.0,1644.2724500334996,68.0,11.04206715,412.44579552499994,0.0,121.92,0.0 -69,23685.176567965955,22985.176567965955,0.15600000000000003,1224.1152771756674,279007.10339674074,700.0,48300.0,12334.07228958761,1264500.0243059231,11109.957012411942,985492.9209091828,true,69.0,69,0.875,1071.100867528709,1224.1152771756674,153.01440964695848,0.0,0.0,69,22985.176567965955,0.0,1071.100867528709,1071.100867528709,166188.4090224199,700.0,48300.0,653.3367529164735,17748.386853418342,-810.0234850661462,99430.78304507089,0.0,0.0,1242.9917611746798,47142.9207874973,-15.204161496298292,1866.3183364334225,-1071.100867528709,-244131.21547214815,true,true,10.99736242,423.44315794499994,0.0,1644.2724500334996,69.0,10.99736242,423.44315794499994,0.0,121.92,0.0 -70,23674.115277175668,22974.115277175668,0.1744,2159.816697960325,281166.92009470105,700.0,49000.0,16398.031525001865,1280898.055830925,14238.21482704154,999731.1357362242,true,70.0,70,0.875,1889.8396107152846,2159.816697960325,269.9770872450406,0.0,0.0,70,22974.115277175668,0.0,1889.8396107152846,1889.8396107152846,168078.24863313517,700.0,49000.0,649.3691312688386,18397.75598468718,0.0,99430.78304507089,0.0,0.0,1240.470479446446,48383.39126694375,0.0,1866.3183364334225,-1889.8396107152846,-246021.05508286343,true,true,10.99736242,434.44052036499994,0.0,1644.2724500334996,70.0,10.99736242,434.44052036499994,0.0,121.92,0.0 -71,24609.816697960327,23909.816697960327,0.265,6950.927305641732,288117.8474003428,700.0,49700.0,28871.42379487446,1309769.4796257995,21920.496489232726,1021651.632225457,true,71.0,71,0.875,6082.061392436516,6950.927305641732,868.8659132052162,0.0,0.0,71,23909.816697960327,0.0,6082.061392436516,6082.061392436516,174160.31002557167,700.0,49700.0,669.368850078189,19067.12483476537,4082.9780530950543,103513.76109816594,0.0,0.0,1253.0768869596443,49636.46815390339,76.63760230362826,1942.9559387370507,-6082.061392436516,-252103.11647529993,true,true,11.22088605,445.66140641499993,0.0,1644.2724500334996,71.0,11.22088605,445.66140641499993,0.0,121.92,0.0 -72,29400.927305641733,28700.927305641733,0.265,7122.504544083483,295240.3519444263,700.0,50400.0,29518.88507201314,1339288.3646978126,22396.380527929658,1044048.0127533866,true,72.0,72,0.875,6232.191476073048,7122.504544083483,890.313068010435,0.0,0.0,72,28700.927305641733,0.0,6232.191476073048,6232.191476073048,180392.50150164473,700.0,50400.0,710.5918296478434,19777.716664413216,4165.130342136687,107678.89144030263,0.0,0.0,1278.2897014220562,50914.75785532545,78.17960286646121,2021.135541603512,-6232.191476073048,-258335.307951373,true,true,11.44440967,457.10581608499996,0.0,1644.2724500334996,72.0,11.44440967,457.10581608499996,0.0,121.92,0.0 -73,29572.504544083484,28872.504544083484,0.196,3300.848581137842,298541.20052556414,700.0,51100.0,20412.492760907357,1359700.85745872,17111.644179769515,1061159.656933156,true,73.0,73,0.875,2888.2425084956117,3300.848581137842,412.6060726422302,0.0,0.0,73,28872.504544083484,0.0,2888.2425084956117,2888.2425084956117,183280.74401014033,700.0,51100.0,736.1196770615325,20513.836341474747,842.8844781589164,108521.77591846154,0.0,0.0,1293.417390099503,52208.17524542495,15.820963175659735,2036.9565047791716,-2888.2425084956117,-261223.5504598686,true,true,11.4891144,468.59493048499996,0.0,1644.2724500334996,73.0,11.4891144,468.59493048499996,0.0,121.92,0.0 -74,25750.84858113784,25050.84858113784,0.12,0.0,298541.20052556414,700.0,51800.0,5833.333333333334,1365534.1907920532,5833.333333333334,1066992.9902664893,true,74.0,74,0.875,0.0,0.0,0.0,0.0,0.0,74,25050.84858113784,0.0,-550.154354760106,-550.154354760106,182730.58965538023,700.0,51800.0,727.543612270065,21241.379953744814,-2518.7949487392134,106002.98096972232,0.0,0.0,1288.3748272070206,53496.55007263197,-47.27784549797812,1989.6786592811934,-0.0,-261223.5504598686,true,true,11.35500022,479.949930705,0.0,1644.2724500334996,74.0,11.35500022,479.949930705,0.0,121.92,0.0 -75,22450.0,21750.0,0.12,0.0,298541.20052556414,700.0,52500.0,5833.333333333334,1371367.5241253865,5833.333333333334,1072826.3235998226,true,75.0,75,0.875,0.0,0.0,0.0,0.0,0.0,75,21750.0,0.0,-2247.7221475831757,-2247.7221475831757,180482.86750779705,700.0,52500.0,693.905431503963,21935.285385248775,-4132.269353454347,101870.71161626797,0.0,0.0,1268.2045756370915,54764.75464826907,-77.56280126988347,1912.11585801131,-0.0,-261223.5504598686,true,true,11.1314766,491.08140730499997,0.0,1644.2724500334996,75.0,11.1314766,491.08140730499997,0.0,121.92,0.0 -76,22450.0,21750.0,0.1936,3166.7115109483248,301707.91203651245,700.0,53200.0,19972.68342431986,1391340.2075497063,16805.971913371537,1089632.295513194,true,76.0,76,0.875,2770.8725720797843,3166.7115109483248,395.8389388685405,0.0,0.0,76,21750.0,0.0,2770.8725720797843,2770.8725720797843,183253.74007987685,700.0,53200.0,677.4823240752954,22612.76770932407,819.8815995946654,102690.59321586264,0.0,0.0,1258.1194498521265,56022.874098121196,15.389198557696954,1927.505056569007,-2770.8725720797843,-263994.4230319484,true,true,11.17618132,502.257588625,0.0,1644.2724500334996,76.0,11.17618132,502.257588625,0.0,121.92,0.0 -77,25616.711510948324,24916.711510948324,0.25,6106.673689892849,307814.5857264053,700.0,53900.0,27226.694759571397,1418566.9023092778,21120.021069678547,1110752.3165828725,true,77.0,77,0.875,5343.339478656243,6106.673689892849,763.3342112366063,0.0,0.0,77,24916.711510948324,0.0,5343.339478656243,5343.339478656243,188597.0795585331,700.0,53900.0,698.0522652830352,23310.819974607108,3312.3877538596817,106002.98096972232,0.0,0.0,1270.7258568013397,57293.59995492254,62.173602712186515,1989.6786592811934,-5343.339478656243,-269337.76251060463,true,true,11.35500022,513.612588845,0.0,1644.2724500334996,77.0,11.35500022,513.612588845,0.0,121.92,0.0 -78,28556.67368989285,27856.67368989285,0.28625,8227.025305471001,316041.6110318763,700.0,54600.0,31186.114604265505,1449753.0169135432,22959.089298794504,1133711.405881667,true,78.0,78,0.875,7198.6471422871255,8227.025305471001,1028.3781631838756,0.0,0.0,78,27856.67368989285,0.0,7198.6471422871255,7198.6471422871255,195795.7267008202,700.0,54600.0,740.4328678133747,24051.252842420483,5067.164790159327,111070.14575988165,0.0,0.0,1295.938671827737,58589.538626750276,95.110812486687,2084.7894717678805,-7198.6471422871255,-276536.40965289174,true,true,11.62322858,525.235817425,0.0,1644.2724500334996,78.0,11.62322858,525.235817425,0.0,121.92,0.0 -79,30677.025305471,29977.025305471,0.1792,2374.5515917268317,318416.16262360313,700.0,55300.0,17157.095935975623,1466910.112849519,14782.544344248792,1148493.9502259158,true,79.0,79,0.875,2077.732642760978,2374.5515917268317,296.8189489658539,0.0,0.0,79,29977.025305471,0.0,2077.732642760978,2077.732642760978,197873.45934358117,700.0,55300.0,766.6662816918084,24817.91912411229,0.0,111070.14575988165,0.0,0.0,1311.0663610691693,59900.604987819446,0.0,2084.7894717678805,-2077.732642760978,-278614.1422956527,true,true,11.62322858,536.8590460050001,0.0,1644.2724500334996,79.0,11.62322858,536.8590460050001,0.0,121.92,0.0 -80,24824.55159172683,24124.55159172683,0.12,0.0,318416.16262360313,700.0,56000.0,5833.333333333334,1472743.4461828521,5833.333333333334,1154327.283559249,true,80.0,80,0.875,0.0,0.0,0.0,0.0,0.0,80,24124.55159172683,0.0,-539.2268287752191,-539.2268287752191,197334.23251480595,700.0,56000.0,753.4734631851496,25571.39258729744,-2548.369841420113,108521.77591846154,0.0,0.0,1303.5025164484532,61204.1075042679,-47.832966988708876,2036.9565047791716,-0.0,-278614.1422956527,true,true,11.4891144,548.348160405,0.0,1644.2724500334996,80.0,11.4891144,548.348160405,0.0,121.92,0.0 -81,22450.0,21750.0,0.25,6322.488093666218,324738.65071726934,700.0,56700.0,28089.952374664874,1500833.398557517,21767.464280998654,1176094.7478402476,true,81.0,81,0.875,5532.1770819579415,6322.488093666218,790.311011708277,0.0,0.0,81,21750.0,0.0,5532.1770819579415,5532.1770819579415,202866.4095967639,700.0,56700.0,757.8541113977777,26329.246698695217,3404.3985256986293,111926.17444416018,0.0,0.0,1306.0237976127014,62510.1313018806,63.9006472488328,2100.8571520280043,-5532.1770819579415,-284146.31937761063,true,true,11.6679333,560.016093705,0.0,1644.2724500334996,81.0,11.6679333,560.016093705,0.0,121.92,0.0 -82,28772.48809366622,28072.48809366622,0.29250000000000004,8499.104905972637,333237.755623242,700.0,57400.0,31449.93130247055,1532283.3298599876,22950.826396497912,1199045.5742367455,true,82.0,82,0.875,7436.716792726057,8499.104905972637,1062.3881132465804,0.0,0.0,82,28072.48809366622,0.0,7436.716792726057,7436.716792726057,210303.12638948995,700.0,57400.0,802.5980481462836,27131.8447468415,5205.180756800284,117131.35520096046,0.0,0.0,1331.236612075113,63841.36791395571,97.70137570437558,2198.55852773238,-7436.716792726057,-291583.0361703367,true,true,11.93616165,571.952255355,0.0,1644.2724500334996,82.0,11.93616165,571.952255355,0.0,121.92,0.0 -83,30949.104905972636,30249.104905972636,0.30500000000000005,10848.764040645998,344086.51966388803,700.0,58100.0,37864.80013326556,1570148.1299932532,27016.036092619564,1226061.6103293651,true,83.0,83,0.875,9492.668535565248,10848.764040645998,1356.0955050807497,0.0,0.0,83,30249.104905972636,0.0,9492.668535565248,9492.668535565248,219795.7949250552,700.0,58100.0,868.1488434808566,27999.993590322356,7124.262549804632,124255.61775076509,0.0,0.0,1366.5345523224894,65207.9024662782,133.72258995727063,2332.2811176896503,-9492.668535565248,-301075.70470590197,true,true,12.29379945,584.2460548050001,0.0,1644.2724500334996,83.0,12.29379945,584.2460548050001,0.0,121.92,0.0 -84,33298.764040646,32598.764040645998,0.335,14521.940645622575,358608.4603095106,700.0,58800.0,45438.628792903204,1615586.7587861563,30916.688147280627,1256978.2984766457,true,84.0,84,0.875,12706.698064919754,14521.940645622575,1815.2425807028212,0.0,0.0,84,32598.764040645998,0.0,12706.698064919754,12706.698064919754,232502.49298997497,700.0,58800.0,962.6865743357127,28962.680164658068,10139.258450508301,134394.87620127338,0.0,0.0,1414.438900083064,66622.34136636127,190.31413999267747,2522.595257682328,-12706.698064919754,-313782.4027708217,true,true,12.78555143,597.0316062350001,0.0,1644.2724500334996,84.0,12.78555143,597.0316062350001,0.0,121.92,0.0 -85,36971.94064562258,36271.94064562258,0.30500000000000005,10631.374938366644,369239.8352478772,700.0,59500.0,37152.04897825128,1652738.8077644075,26520.674039884638,1283498.9725165304,true,85.0,85,0.875,9302.453071070813,10631.374938366644,1328.9218672958305,0.0,0.0,85,36271.94064562258,0.0,9302.453071070813,9302.453071070813,241804.94606104578,700.0,59500.0,1058.3566009598244,30021.036765617893,6659.2796542950355,141054.15585556842,0.0,0.0,1459.8219666793902,68082.16333304066,124.99484913656153,2647.5901068188896,-9302.453071070813,-323084.85584189254,true,true,13.09848451,610.1300907450002,0.0,1644.2724500334996,85.0,13.09848451,610.1300907450002,0.0,121.92,0.0 -86,33081.37493836664,32381.374938366644,0.29250000000000004,8642.234876097113,377882.07012397435,700.0,60200.0,31939.264533665337,1684678.0722980727,23297.029657568222,1306796.0021740987,true,86.0,86,0.875,7561.955516584974,8642.234876097113,1080.2793595121384,0.0,0.0,86,32381.374938366644,0.0,7561.955516584974,7561.955516584974,249366.90157763075,700.0,60200.0,1125.534404219617,31146.57116983751,4855.211327191917,145909.36718276032,0.0,0.0,1490.0773445982697,69572.24067763893,91.13244057516951,2738.722547394059,-7561.955516584974,-330646.8113584775,true,true,13.32200814,623.4520988850002,0.0,1644.2724500334996,86.0,13.32200814,623.4520988850002,0.0,121.92,0.0 -87,31092.234876097114,30392.234876097114,0.265,6502.9598983135575,384385.0300222879,700.0,60900.0,27180.980748353046,1711859.0530464258,20678.020850039487,1327474.0230241383,true,87.0,87,0.875,5690.089911024363,6502.9598983135575,812.8699872891948,0.0,0.0,87,30392.234876097114,0.0,5690.089911024363,5690.089911024363,255056.9914886551,700.0,60900.0,1171.8628834918766,32318.434053329387,2952.5598083759955,148861.9269911363,0.0,0.0,1510.247596168199,71082.48827380712,55.419622988292,2794.1421703823507,-5690.089911024363,-336336.9012695019,true,true,13.45612231,636.9082211950001,0.0,1644.2724500334996,87.0,13.45612231,636.9082211950001,0.0,121.92,0.0 -88,28952.95989831356,28252.95989831356,0.265,6595.332943626811,390980.3629659147,700.0,61600.0,27529.558277837023,1739388.6113242628,20934.225334210212,1348408.2483583486,true,88.0,88,0.875,5770.91632567346,6595.332943626811,824.4166179533513,0.0,0.0,88,28252.95989831356,0.0,5770.91632567346,5770.91632567346,260827.90781432856,700.0,61600.0,1207.4313721302067,33525.8654254596,2982.134920107009,151844.0619112433,0.0,0.0,1525.3752848456459,72607.86355865277,55.97474859059799,2850.116918972949,-5770.91632567346,-342107.81759517535,true,true,13.59023649,650.4984576850002,0.0,1644.2724500334996,88.0,13.59023649,650.4984576850002,0.0,121.92,0.0 -89,29045.33294362681,28345.33294362681,0.265,6688.519795461676,397668.8827613764,700.0,62300.0,27881.20677532708,1767269.8180995898,21192.6869798654,1369600.935338214,true,89.0,89,0.875,5852.454821028967,6688.519795461676,836.0649744327093,0.0,0.0,89,28345.33294362681,0.0,5852.454821028967,5852.454821028967,266680.36263535754,700.0,62300.0,1243.712394538102,34769.5778199977,3011.7095871221964,154855.7714983655,0.0,0.0,1540.5029735230928,74148.36653217586,56.52986584557609,2906.6467848185252,-5852.454821028967,-347960.27241620433,true,true,13.72435066,664.2228083450002,0.0,1644.2724500334996,89.0,13.72435066,664.2228083450002,0.0,121.92,0.0 -90,29138.519795461674,28438.519795461674,0.1936,3211.644721213193,400880.5274825896,700.0,63000.0,20204.776452547485,1787474.5945521372,16993.13173133429,1386594.0670695484,true,90.0,90,0.875,2810.189131061544,3211.644721213193,401.4555901516492,0.0,0.0,90,28438.519795461674,0.0,2810.189131061544,2810.189131061544,269490.5517664191,700.0,63000.0,1262.1223134817203,36031.70013347942,0.0,154855.7714983655,0.0,0.0,1548.0668175798237,75696.43334975568,0.0,2906.6467848185252,-2810.189131061544,-350770.4615472659,true,true,13.72435066,677.9471590050002,0.0,1644.2724500334996,90.0,13.72435066,677.9471590050002,0.0,121.92,0.0 -91,25661.644721213193,24961.644721213193,0.14400000000000002,850.2999225942492,401730.82740518387,700.0,63700.0,10765.971684682285,1798240.5662368194,9915.671762088035,1396509.7388316365,true,91.0,91,0.875,744.012432269968,850.2999225942492,106.28749032428118,0.0,0.0,91,24961.644721213193,0.0,744.012432269968,744.012432269968,270234.56419868907,700.0,63700.0,1249.8290012155803,37281.529134694996,-2011.0925648434115,152844.67893352208,0.0,0.0,1543.0242546873412,77239.45760444301,-37.748258789542064,2868.8985260289833,-744.012432269968,-351514.47397953586,true,true,13.63494121,691.5821002150002,0.0,1644.2724500334996,91.0,13.63494121,691.5821002150002,0.0,121.92,0.0 -92,23300.299922594248,22600.299922594248,0.17200000000000001,1997.2581658039267,403728.0855709878,700.0,64400.0,15681.733522115852,1813922.299758935,13684.475356311925,1410194.2141879485,true,92.0,92,0.875,1747.6008950784358,1997.2581658039267,249.6572707254909,0.0,0.0,92,22600.299922594248,0.0,1747.6008950784358,1747.6008950784358,271982.1650937675,700.0,64400.0,1231.539113782644,38513.06824847764,-1000.6170222787847,151844.0619112433,0.0,0.0,1535.4604106306106,78774.91801507362,-18.781607056034026,2850.1169189729494,-1747.6008950784358,-353262.0748746143,true,true,13.59023649,705.1723367050002,0.0,1644.2724500334996,92.0,13.59023649,705.1723367050002,0.0,121.92,0.0 -93,24447.258165803927,23747.258165803927,0.17200000000000001,1981.4997677005383,405709.58533868834,700.0,65100.0,15590.114928491503,1829512.4146874265,13608.615160790965,1423802.8293487395,true,93.0,93,0.875,1733.812296737971,1981.4997677005383,247.6874709625672,0.0,0.0,93,23747.258165803927,0.0,1733.812296737971,1733.812296737971,273715.9773905055,700.0,65100.0,1219.4455268868091,39732.51377536445,-997.3311467976091,150846.7307644457,0.0,0.0,1530.417847738128,80305.33586281174,-18.719931089357086,2831.3969878835924,-1733.812296737971,-354995.8871713523,true,true,13.54553176,718.7178684650003,0.0,1644.2724500334996,93.0,13.54553176,718.7178684650003,0.0,121.92,0.0 -94,24431.499767700538,23731.499767700538,0.20800000000000002,4303.902231442175,410013.4875701305,700.0,65800.0,24057.222266548917,1853569.6369539755,19753.320035106743,1443556.1493838462,true,94.0,94,0.875,3765.914452511903,4303.902231442175,537.9877789302723,0.0,0.0,94,23731.499767700538,0.0,3765.914452511903,3765.914452511903,277481.89184301737,700.0,65800.0,1219.4455268868091,40951.95930225126,997.3311467976091,151844.0619112433,0.0,0.0,1530.417847738128,81835.75371054986,18.719931089357086,2850.1169189729494,-3765.914452511903,-358761.80162386416,true,true,13.59023649,732.3081049550003,0.0,1644.2724500334996,94.0,13.59023649,732.3081049550003,0.0,121.92,0.0 -95,26753.902231442175,26053.902231442175,0.28625,7874.897036115319,417888.3846062458,700.0,66500.0,29955.972178568798,1883525.6091325444,22081.07514245348,1465637.2245262996,true,95.0,95,0.875,6890.534906600904,7874.897036115319,984.3621295144148,0.0,0.0,95,26053.902231442175,0.0,6890.534906600904,6890.534906600904,284372.42674961826,700.0,66500.0,1249.8290025860426,42201.788304837304,4022.1851311568576,155866.24704240015,0.0,0.0,1543.0242552513266,83378.77796580119,75.49651760667783,2925.6134365796274,-6890.534906600904,-365652.33653046505,true,true,13.76905539,746.0771603450003,0.0,1644.2724500334996,95.0,13.76905539,746.0771603450003,0.0,121.92,0.0 -96,30324.89703611532,29624.89703611532,0.12,0.0,417888.3846062458,700.0,67200.0,5833.333333333334,1889358.9424658776,5833.333333333334,1471470.557859633,true,96.0,96,0.875,0.0,0.0,0.0,0.0,0.0,96,29624.89703611532,0.0,-1304.828390926166,-1304.828390926166,283067.5983586921,700.0,67200.0,1249.8290025860426,43451.617307423345,-4022.1851311568576,151844.0619112433,0.0,0.0,1543.0242552513266,84921.80222105251,-75.49651760667783,2850.1169189729494,-0.0,-365652.33653046505,true,true,13.59023649,759.6673968350003,0.0,1644.2724500334996,96.0,13.59023649,759.6673968350003,0.0,121.92,0.0 -97,22450.0,21750.0,0.12,0.0,417888.3846062458,700.0,67900.0,5833.333333333334,1895192.2757992109,5833.333333333334,1477303.8911929661,true,97.0,97,0.875,0.0,0.0,0.0,0.0,0.0,97,21750.0,0.0,-2330.948033351541,-2330.948033351541,280736.6503253405,700.0,67900.0,1195.4963877924445,44647.11369521579,-4953.7942976494605,146890.26761359384,0.0,0.0,1520.3327219531636,86442.13494300567,-92.98284544768867,2757.1340735252606,-0.0,-365652.33653046505,true,true,13.36671286,773.0341096950003,0.0,1644.2724500334996,97.0,13.36671286,773.0341096950003,0.0,121.92,0.0 -98,22450.0,21750.0,0.12,0.0,417888.3846062458,700.0,68600.0,5833.333333333334,1901025.6091325441,5833.333333333334,1483137.2245262994,true,98.0,98,0.875,0.0,0.0,0.0,0.0,0.0,98,21750.0,0.0,-1336.7587367285128,-1336.7587367285128,279399.891588612,700.0,68600.0,1142.7616741821616,45789.87536939795,-3903.885567783944,142986.3820458099,0.0,0.0,1497.6411886550004,87939.77613166068,-73.27603178173038,2683.85804174353,-0.0,-365652.33653046505,true,true,13.18789396,786.2220036550003,0.0,1644.2724500334996,98.0,13.18789396,786.2220036550003,0.0,121.92,0.0 -99,22450.0,21750.0,0.25,6411.393614016264,424299.77822026203,700.0,69300.0,28445.574456065056,1929471.183588609,22034.180842048794,1505171.4053683481,true,99.0,99,0.875,5609.969412264231,6411.393614016264,801.4242017520328,0.0,0.0,99,21750.0,0.0,5609.969412264231,5609.969412264231,285009.86100087623,700.0,69300.0,1136.9998621725501,46926.875231570506,2922.985136950401,145909.3671827603,0.0,0.0,1495.1199074907518,89434.89603915143,54.864505650529075,2738.7225473940593,-5609.969412264231,-371262.3059427293,true,true,13.32200814,799.5440117950003,0.0,1644.2724500334996,99.0,13.32200814,799.5440117950003,0.0,121.92,0.0 -100,28861.393614016262,28161.393614016262,0.29250000000000004,8833.106849587131,433132.88506984914,700.0,70000.0,32591.81828918677,1962063.001877796,23758.71143959964,1528930.1168079479,true,100.0,100,0.875,7728.96849338874,8833.106849587131,1104.1383561983912,0.0,0.0,100,28161.393614016262,0.0,7728.96849338874,7728.96849338874,292738.82949426497,700.0,70000.0,1183.640312153131,48110.51554372364,4937.363581685395,150846.7307644457,0.0,0.0,1515.2901590606812,90950.1861982121,92.6744404895329,2831.3969878835924,-7728.96849338874,-378991.274436118,true,true,13.54553176,813.0895435550003,0.0,1644.2724500334996,100.0,13.54553176,813.0895435550003,0.0,121.92,0.0 -101,31283.10684958713,30583.10684958713,0.28625,7839.8719977591245,440972.7570676083,700.0,70700.0,29833.61396597074,1991896.6158437666,21993.741968211616,1550923.8587761596,true,101.0,101,0.875,6859.887998039234,7839.8719977591245,979.9839997198906,0.0,0.0,101,30583.10684958713,0.0,6859.887998039234,6859.887998039234,299598.7174923042,700.0,70700.0,1237.6157753896364,49348.13131911327,4009.0407339198055,154855.7714983655,0.0,0.0,1537.981691794859,92488.16789000697,75.24979693493317,2906.6467848185257,-6859.887998039234,-385851.1624341573,true,true,13.72435066,826.8138942150003,0.0,1644.2724500334996,101.0,13.72435066,826.8138942150003,0.0,121.92,0.0 -102,30289.871997759124,29589.871997759124,0.23500000000000001,5588.385479342606,446561.1425469509,700.0,71400.0,26759.087146138747,2018655.7029899054,21170.70166679614,1572094.5604429557,true,102.0,102,0.875,4889.83729442478,5588.385479342606,698.5481849178259,0.0,0.0,102,29589.871997759124,0.0,4889.83729442478,4889.83729442478,304488.554786729,700.0,71400.0,1274.495973908446,50622.62729302172,2024.2369606103357,156880.00845897585,0.0,0.0,1553.109380472306,94041.27727047927,37.99497943369265,2944.6417642522183,-4889.83729442478,-390740.99972858204,true,true,13.81376011,840.6276543250003,0.0,1644.2724500334996,102.0,13.81376011,840.6276543250003,0.0,121.92,0.0 -103,28038.385479342607,27338.385479342607,0.20800000000000002,4445.73562332253,451006.87817027344,700.0,72100.0,24739.113573666007,2043394.8165635713,20293.377950343478,1592387.9383932992,true,103.0,103,0.875,3890.018670407214,4445.73562332253,555.7169529153161,0.0,0.0,103,27338.385479342607,0.0,3890.018670407214,3890.018670407214,308378.5734571362,700.0,72100.0,1293.207690563985,51915.8349835857,1017.0477426532339,157897.05620162908,0.0,0.0,1560.673225093022,95601.9504955723,19.09001209697313,2963.7317763491915,-3890.018670407214,-394631.0183989893,true,true,13.85846484,854.4861191650003,0.0,1644.2724500334996,103.0,13.85846484,854.4861191650003,0.0,121.92,0.0 -104,26895.73562332253,26195.73562332253,0.1744,2077.420755322057,453084.2989255955,700.0,72800.0,15925.577725470512,2059320.3942890419,13848.156970148455,1606236.0953634477,true,104.0,104,0.875,1817.7431609067999,2077.420755322057,259.6775944152573,0.0,0.0,104,26195.73562332253,0.0,1817.7431609067999,1817.7431609067999,310196.316618043,700.0,72800.0,1293.207690563985,53209.042674149685,-1017.0477426532339,156880.00845897585,0.0,0.0,1560.673225093022,97162.62372066532,-19.09001209697313,2944.6417642522183,-1817.7431609067999,-396448.76155989605,true,true,13.81376011,868.2998792750003,0.0,1644.2724500334996,104.0,13.81376011,868.2998792750003,0.0,121.92,0.0 -105,24527.42075532206,23827.42075532206,0.12,0.0,453084.2989255955,700.0,73500.0,5833.333333333334,2065153.7276223751,5833.333333333334,1612069.428696781,true,105.0,105,0.875,0.0,0.0,0.0,0.0,0.0,105,23827.42075532206,0.0,-2328.960225722652,-2328.960225722652,307867.35639232036,700.0,73500.0,1255.9656308735734,54465.00830502326,-5035.946547732532,151844.0619112433,0.0,0.0,1545.545536415575,98708.1692570809,-94.52484527926875,2850.1169189729494,-0.0,-396448.76155989605,true,true,13.59023649,881.8901157650004,0.0,1644.2724500334996,105.0,13.59023649,881.8901157650004,0.0,121.92,0.0 -106,22450.0,21750.0,0.12,0.0,453084.2989255955,700.0,74200.0,5833.333333333334,2070987.0609557084,5833.333333333334,1617902.7620301142,true,106.0,106,0.875,0.0,0.0,0.0,0.0,0.0,106,21750.0,0.0,-3338.719155866952,-3338.719155866952,304528.6372364534,700.0,74200.0,1189.5585034060268,55654.566808429285,-5934.694728483004,145909.3671827603,0.0,0.0,1517.8114407889152,100225.98069786982,-111.39437157888999,2738.7225473940593,-0.0,-396448.76155989605,true,true,13.32200814,895.2121239050003,0.0,1644.2724500334996,106.0,13.32200814,895.2121239050003,0.0,121.92,0.0 -107,22450.0,21750.0,0.20800000000000002,4188.206663232858,457272.50558882835,700.0,74900.0,23500.993573234893,2094488.0545289433,19312.786910002036,1637215.5489401163,true,107.0,107,0.875,3664.6808303287507,4188.206663232858,523.5258329041071,0.0,0.0,107,21750.0,0.0,3664.6808303287507,3664.6808303287507,308193.31806678214,700.0,74900.0,1160.1638400882891,56814.73064851757,980.9004308335434,146890.26761359384,0.0,0.0,1505.2050332757167,101731.18573114554,18.411526131201306,2757.1340735252606,-3664.6808303287507,-400113.4423902248,true,true,13.36671286,908.5788367650003,0.0,1644.2724500334996,107.0,13.36671286,908.5788367650003,0.0,121.92,0.0 -108,26638.206663232857,25938.206663232857,0.265,6533.661102338143,463806.1666911665,700.0,75600.0,27296.83434844582,2121784.888877389,20763.173246107675,1657978.722186224,true,108.0,108,0.875,5716.953464545875,6533.661102338143,816.7076377922676,0.0,0.0,108,25938.206663232857,0.0,5716.953464545875,5716.953464545875,313910.27153132804,700.0,75600.0,1183.6403121531314,57998.370960670705,2962.418325721488,149852.68593931533,0.0,0.0,1515.2901590606812,103246.47589020622,55.60466761057527,2812.738741135836,-5716.953464545875,-405830.3958547707,true,true,13.50082704,922.0796638050003,0.0,1644.2724500334996,108.0,13.50082704,922.0796638050003,0.0,121.92,0.0 -109,28983.66110233814,28283.66110233814,0.29250000000000004,8987.420716738416,472793.5874079049,700.0,76300.0,33119.38706577236,2154904.2759431615,24131.966349033944,1682110.688535258,true,109.0,109,0.875,7863.993127146114,8987.420716738416,1123.427589592302,0.0,0.0,109,28283.66110233814,0.0,7863.993127146114,7863.993127146114,321774.26465847413,700.0,76300.0,1231.5391137826448,59229.91007445335,5003.085559050169,154855.7714983655,0.0,0.0,1535.4604106306106,104781.93630083682,93.90804368268951,2906.6467848185252,-7863.993127146114,-413694.38898191677,true,true,13.72435066,935.8040144650004,0.0,1644.2724500334996,109.0,13.72435066,935.8040144650004,0.0,121.92,0.0 -110,31437.420716738416,30737.420716738416,0.29250000000000004,9182.364829555214,481975.9522374601,700.0,77000.0,33785.86266514603,2188690.1386083076,24603.497835590817,1706714.1863708487,true,110.0,110,0.875,8034.569225860812,9182.364829555214,1147.7956036944015,0.0,0.0,110,30737.420716738416,0.0,8034.569225860812,8034.569225860812,329808.83388433495,700.0,77000.0,1293.207690563985,60523.117765017334,5085.2382582594255,159941.00975662493,0.0,0.0,1560.673225093022,106342.60952592985,95.45005194438004,3002.0968367629052,-8034.569225860812,-421728.9582077776,true,true,13.94787429,949.7518887550003,0.0,1644.2724500334996,110.0,13.94787429,949.7518887550003,0.0,121.92,0.0 -111,31632.364829555212,30932.364829555212,0.30500000000000005,10604.677939812895,492580.630177273,700.0,77700.0,37064.517835452105,2225754.65644376,26459.839895639212,1733174.0262664878,true,111.0,111,0.875,9279.093197336282,10604.677939812895,1325.5847424766125,0.0,0.0,111,30932.364829555212,0.0,9279.093197336282,9279.093197336282,339087.92708167125,700.0,77700.0,1363.3833313570601,61886.50109637439,6210.72703958951,166151.73679621445,0.0,0.0,1588.4073212836674,107931.01684721351,116.57550510604513,3118.6723418689503,-9279.093197336282,-431008.0514051139,true,true,14.21610264,963.9679913950004,0.0,1644.2724500334996,111.0,14.21610264,963.9679913950004,0.0,121.92,0.0 -112,33054.67793981289,32354.677939812893,0.28625,8374.993985761574,500955.6241630346,700.0,78400.0,31703.035758119033,2257457.692201879,23328.041772357457,1756502.0680388452,true,112.0,112,0.875,7328.119737541377,8374.993985761574,1046.874248220197,0.0,0.0,112,32354.677939812893,0.0,7328.119737541377,7328.119737541377,346416.0468192126,700.0,78400.0,1429.3423232759949,63315.84341965039,4206.206671894521,170357.94346810898,0.0,0.0,1613.620135746079,109544.6369829596,78.95060662478151,3197.6229484937317,-7328.119737541377,-438336.17114265525,true,true,14.39492154,978.3629129350004,0.0,1644.2724500334996,112.0,14.39492154,978.3629129350004,0.0,121.92,0.0 -113,30824.993985761575,30124.993985761575,0.25,6012.952879168578,506968.57704220316,700.0,79100.0,26851.811516674312,2284309.503718553,20838.858637505735,1777340.9266763509,true,113.0,113,0.875,5261.333769272505,6012.952879168578,751.6191098960726,0.0,0.0,113,30124.993985761575,0.0,5261.333769272505,5261.333769272505,351677.3805884851,700.0,79100.0,1469.9206309726349,64785.764050623024,2122.8199295977283,172480.7633977067,0.0,0.0,1628.7478244235263,111173.38480738312,39.84538427861551,3237.4683327723474,-5261.333769272505,-443597.50491192774,true,true,14.48433099,992.8472439250004,0.0,1644.2724500334996,113.0,14.48433099,992.8472439250004,0.0,121.92,0.0 -114,28462.952879168577,27762.952879168577,0.15200000000000002,1069.7178760226484,508038.2949182258,700.0,79800.0,11642.880763306895,2295952.38448186,10573.162887284247,1787914.0895636352,true,114.0,114,0.875,936.0031415198173,1069.7178760226484,133.7147345028311,0.0,0.0,114,27762.952879168577,0.0,936.0031415198173,936.0031415198173,352613.3837300049,700.0,79800.0,1469.9206309726349,66255.68468159565,-2122.8199295977283,170357.94346810898,0.0,0.0,1628.7478244235263,112802.13263180664,-39.84538427861551,3197.6229484937317,-936.0031415198173,-444533.5080534476,true,true,14.39492154,1007.2421654650004,0.0,1644.2724500334996,114.0,14.39492154,1007.2421654650004,0.0,121.92,0.0 -115,23519.71787602265,22819.71787602265,0.12,0.0,508038.2949182258,700.0,80500.0,5833.333333333334,2301785.7178151933,5833.333333333334,1793747.4228969684,true,115.0,115,0.875,0.0,0.0,0.0,0.0,0.0,115,22819.71787602265,0.0,-2314.3254318272693,-2314.3254318272693,350299.0582981776,700.0,80500.0,1422.6527452880216,67678.33742688368,-5249.542976005601,165108.40049210336,0.0,0.0,1611.098854581831,114413.23148638847,-98.53405569152058,3099.088892802211,-0.0,-444533.5080534476,true,true,14.17139792,1021.4135633850004,0.0,1644.2724500334996,115.0,14.17139792,1021.4135633850004,0.0,121.92,0.0 -116,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,81200.0,5833.333333333334,2307619.051148527,5833.333333333334,1799580.7562303017,true,116.0,116,0.875,0.0,0.0,0.0,0.0,0.0,116,21750.0,0.0,-28574.188816204285,-28574.188816204285,321724.86948197335,700.0,81200.0,1195.4963877924445,68873.83381467612,-30713.52429083001,134394.87620127335,0.0,0.0,1520.3327219531636,115933.56420834163,-576.4936351198833,2522.5952576823274,-0.0,-444533.5080534476,true,true,12.78555143,1034.1991148150005,0.0,1644.2724500334996,116.0,12.78555143,1034.1991148150005,0.0,121.92,0.0 -117,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,81900.0,5833.333333333334,2313452.3844818603,5833.333333333334,1805414.089563635,true,117.0,117,0.875,0.0,0.0,0.0,0.0,0.0,117,21750.0,0.0,-27560.6903015671,-27560.6903015671,294164.17918040627,700.0,81900.0,853.812733185085,69727.64654786121,-29224.92122544256,105169.9549758308,0.0,0.0,1358.9707082657585,117292.53491660739,-548.5525175753874,1974.04274010694,-0.0,-444533.5080534476,true,true,11.3102955,1045.5094103150004,0.0,1644.2724500334996,117.0,11.3102955,1045.5094103150004,0.0,121.92,0.0 -118,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,82600.0,5833.333333333334,2319285.717815194,5833.333333333334,1811247.4228969682,true,118.0,118,0.875,0.0,0.0,0.0,0.0,0.0,118,21750.0,0.0,-24358.171006350192,-24358.171006350192,269806.00817405607,700.0,82600.0,577.005235964974,70304.65178382618,-25646.359550655226,79523.59542517558,0.0,0.0,1192.5661319114654,118485.10104851885,-481.38282357140747,1492.6599165355326,-0.0,-444533.5080534476,true,true,9.835039564,1055.3444498790004,0.0,1644.2724500334996,118.0,9.835039564,1055.3444498790004,0.0,121.92,0.0 -119,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,83300.0,5833.333333333334,2325119.0511485273,5833.333333333334,1817080.7562303015,true,119.0,119,0.875,0.0,0.0,0.0,0.0,0.0,119,21750.0,0.0,-21088.24587387048,-21088.24587387048,248717.7623001856,700.0,83300.0,367.6034337806858,70672.25521760687,-22067.79773598453,57455.797689191044,0.0,0.0,1026.1615552751796,119511.26260379402,-414.21312694181347,1078.4467895937191,-0.0,-444533.5080534476,true,true,8.359783629,1063.7042335080005,0.0,1644.2724500334996,119.0,8.359783629,1063.7042335080005,0.0,121.92,0.0 -120,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,84000.0,5833.333333333334,2330952.384481861,5833.333333333334,1822914.0895636347,true,120.0,120,0.875,0.0,0.0,0.0,0.0,0.0,120,21750.0,0.0,-17760.32049893756,-17760.32049893756,230957.44180124803,700.0,84000.0,216.20188135059425,70888.45709895747,-18489.23592859103,38966.561760600016,0.0,0.0,859.7569787516909,120371.0195825457,-347.0434304488127,731.4033591449064,-0.0,-444533.5080534476,true,true,6.884527695,1070.5887612030006,0.0,1644.2724500334996,120.0,6.884527695,1070.5887612030006,0.0,121.92,0.0 -121,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,84700.0,5833.333333333334,2336785.7178151943,5833.333333333334,1828747.422896968,true,121.0,121,0.875,0.0,0.0,0.0,0.0,0.0,121,21750.0,0.0,-14383.800345829519,-14383.800345829519,216573.64145541852,700.0,84700.0,113.3951326318685,71001.85223158934,-14910.674146263293,24055.887614336723,0.0,0.0,693.352402228202,121064.37198477391,-279.87373442629723,451.52962471860917,-0.0,-444533.5080534476,true,true,5.40927176,1075.9980329630005,0.0,1644.2724500334996,121.0,5.40927176,1075.9980329630005,0.0,121.92,0.0 -122,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,85400.0,5833.333333333334,2342619.051148528,5833.333333333334,1834580.7562303012,true,122.0,122,0.875,0.0,0.0,0.0,0.0,0.0,122,21750.0,0.0,-10968.09082095786,-10968.09082095786,205605.55063446067,700.0,85400.0,49.777741729420754,71051.62997331876,-11332.11235018982,12723.775264146903,0.0,0.0,526.9478256483147,121591.31981042222,-212.70403814577358,238.8255865728356,-0.0,-444533.5080534476,true,true,3.934015825,1079.9320487880004,0.0,1644.2724500334996,122.0,3.934015825,1079.9320487880004,0.0,121.92,0.0 -123,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,86100.0,5833.333333333334,2348452.3844818613,5833.333333333334,1840414.0895636345,true,123.0,123,0.875,0.0,0.0,0.0,0.0,0.0,123,21750.0,0.0,-7522.59737993339,-7522.59737993339,198082.95325452727,700.0,86100.0,15.944262804612375,71067.57423612337,-7753.5505500734635,4970.22471407344,0.0,0.0,360.54324912482593,121951.86305954705,-145.534341789365,93.2912447834706,-0.0,-444533.5080534476,true,true,2.458759891,1082.3908086790004,0.0,1644.2724500334996,123.0,2.458759891,1082.3908086790004,0.0,121.92,0.0 -124,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,86800.0,5833.333333333334,2354285.7178151947,5833.333333333334,1846247.4228969677,true,124.0,124,0.875,0.0,0.0,0.0,0.0,0.0,124,21750.0,0.0,-4056.725483546832,-4056.725483546832,194026.22777098045,700.0,86800.0,2.489249950667005,71070.06348607404,-4174.988760468579,795.2359536048607,0.0,0.0,194.13867260133713,122146.00173214839,-78.36464563025704,14.926599153213559,-0.0,-444533.5080534476,true,true,0.983503956,1083.3743126350005,0.0,1644.2724500334996,124.0,0.983503956,1083.3743126350005,0.0,121.92,0.0 -125,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,87500.0,5833.333333333334,2360119.0511485282,5833.333333333334,1852080.756230301,true,125.0,125,0.875,0.0,0.0,0.0,0.0,0.0,125,21750.0,0.0,-754.636302294577,-754.636302294577,193271.59146868586,700.0,87500.0,0.05805830783667814,71070.12154438188,-795.2359536048966,-3.5925040720030665e-11,0.0,0.0,55.46819215569674,122201.46992430408,-14.926599153213761,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,125.0,0.0,1083.3743126350005,0.0,121.92,0.0 -126,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,88200.0,5833.333333333334,2365952.3844818617,5833.333333333334,1857914.0895636342,true,126.0,126,0.875,0.0,0.0,0.0,0.0,0.0,126,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,88200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,126.0,0.0,1083.3743126350005,0.0,121.92,0.0 -127,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,88900.0,5833.333333333334,2371785.717815195,5833.333333333334,1863747.4228969675,true,127.0,127,0.875,0.0,0.0,0.0,0.0,0.0,127,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,88900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,127.0,0.0,1083.3743126350005,0.0,121.92,0.0 -128,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,89600.0,5833.333333333334,2377619.0511485287,5833.333333333334,1869580.7562303008,true,128.0,128,0.875,0.0,0.0,0.0,0.0,0.0,128,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,89600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,128.0,0.0,1083.3743126350005,0.0,121.92,0.0 -129,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,90300.0,5833.333333333334,2383452.384481862,5833.333333333334,1875414.089563634,true,129.0,129,0.875,0.0,0.0,0.0,0.0,0.0,129,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,90300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,129.0,0.0,1083.3743126350005,0.0,121.92,0.0 -130,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,91000.0,5833.333333333334,2389285.7178151957,5833.333333333334,1881247.4228969673,true,130.0,130,0.875,0.0,0.0,0.0,0.0,0.0,130,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,91000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,130.0,0.0,1083.3743126350005,0.0,121.92,0.0 -131,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,91700.0,5833.333333333334,2395119.051148529,5833.333333333334,1887080.7562303005,true,131.0,131,0.875,0.0,0.0,0.0,0.0,0.0,131,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,91700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,131.0,0.0,1083.3743126350005,0.0,121.92,0.0 -132,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,92400.0,5833.333333333334,2400952.3844818627,5833.333333333334,1892914.0895636338,true,132.0,132,0.875,0.0,0.0,0.0,0.0,0.0,132,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,92400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,132.0,0.0,1083.3743126350005,0.0,121.92,0.0 -133,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,93100.0,5833.333333333334,2406785.717815196,5833.333333333334,1898747.422896967,true,133.0,133,0.875,0.0,0.0,0.0,0.0,0.0,133,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,93100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,133.0,0.0,1083.3743126350005,0.0,121.92,0.0 -134,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,93800.0,5833.333333333334,2412619.0511485296,5833.333333333334,1904580.7562303003,true,134.0,134,0.875,0.0,0.0,0.0,0.0,0.0,134,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,93800.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,134.0,0.0,1083.3743126350005,0.0,121.92,0.0 -135,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,94500.0,5833.333333333334,2418452.384481863,5833.333333333334,1910414.0895636335,true,135.0,135,0.875,0.0,0.0,0.0,0.0,0.0,135,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,94500.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,135.0,0.0,1083.3743126350005,0.0,121.92,0.0 -136,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,95200.0,5833.333333333334,2424285.7178151966,5833.333333333334,1916247.4228969668,true,136.0,136,0.875,0.0,0.0,0.0,0.0,0.0,136,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,95200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,136.0,0.0,1083.3743126350005,0.0,121.92,0.0 -137,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,95900.0,5833.333333333334,2430119.05114853,5833.333333333334,1922080.7562303,true,137.0,137,0.875,0.0,0.0,0.0,0.0,0.0,137,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,95900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,137.0,0.0,1083.3743126350005,0.0,121.92,0.0 -138,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,96600.0,5833.333333333334,2435952.3844818636,5833.333333333334,1927914.0895636333,true,138.0,138,0.875,0.0,0.0,0.0,0.0,0.0,138,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,96600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,138.0,0.0,1083.3743126350005,0.0,121.92,0.0 -139,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,97300.0,5833.333333333334,2441785.717815197,5833.333333333334,1933747.4228969666,true,139.0,139,0.875,0.0,0.0,0.0,0.0,0.0,139,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,97300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,139.0,0.0,1083.3743126350005,0.0,121.92,0.0 -140,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,98000.0,5833.333333333334,2447619.0511485306,5833.333333333334,1939580.7562302998,true,140.0,140,0.875,0.0,0.0,0.0,0.0,0.0,140,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,98000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,140.0,0.0,1083.3743126350005,0.0,121.92,0.0 -141,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,98700.0,5833.333333333334,2453452.384481864,5833.333333333334,1945414.089563633,true,141.0,141,0.875,0.0,0.0,0.0,0.0,0.0,141,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,98700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,141.0,0.0,1083.3743126350005,0.0,121.92,0.0 -142,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,99400.0,5833.333333333334,2459285.7178151975,5833.333333333334,1951247.4228969663,true,142.0,142,0.875,0.0,0.0,0.0,0.0,0.0,142,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,99400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,142.0,0.0,1083.3743126350005,0.0,121.92,0.0 -143,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,100100.0,5833.333333333334,2465119.051148531,5833.333333333334,1957080.7562302996,true,143.0,143,0.875,0.0,0.0,0.0,0.0,0.0,143,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,100100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,143.0,0.0,1083.3743126350005,0.0,121.92,0.0 -144,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,100800.0,5833.333333333334,2470952.3844818645,5833.333333333334,1962914.0895636328,true,144.0,144,0.875,0.0,0.0,0.0,0.0,0.0,144,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,100800.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,144.0,0.0,1083.3743126350005,0.0,121.92,0.0 -145,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,101500.0,5833.333333333334,2476785.717815198,5833.333333333334,1968747.422896966,true,145.0,145,0.875,0.0,0.0,0.0,0.0,0.0,145,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,101500.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,145.0,0.0,1083.3743126350005,0.0,121.92,0.0 -146,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,102200.0,5833.333333333334,2482619.0511485315,5833.333333333334,1974580.7562302994,true,146.0,146,0.875,0.0,0.0,0.0,0.0,0.0,146,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,102200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,146.0,0.0,1083.3743126350005,0.0,121.92,0.0 -147,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,102900.0,5833.333333333334,2488452.384481865,5833.333333333334,1980414.0895636326,true,147.0,147,0.875,0.0,0.0,0.0,0.0,0.0,147,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,102900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,147.0,0.0,1083.3743126350005,0.0,121.92,0.0 -148,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,103600.0,5833.333333333334,2494285.7178151985,5833.333333333334,1986247.4228969659,true,148.0,148,0.875,0.0,0.0,0.0,0.0,0.0,148,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,103600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,148.0,0.0,1083.3743126350005,0.0,121.92,0.0 -149,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,104300.0,5833.333333333334,2500119.051148532,5833.333333333334,1992080.7562302991,true,149.0,149,0.875,0.0,0.0,0.0,0.0,0.0,149,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,104300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,149.0,0.0,1083.3743126350005,0.0,121.92,0.0 -150,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,105000.0,5833.333333333334,2505952.3844818654,5833.333333333334,1997914.0895636324,true,150.0,150,0.875,0.0,0.0,0.0,0.0,0.0,150,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,105000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,150.0,0.0,1083.3743126350005,0.0,121.92,0.0 -151,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,105700.0,5833.333333333334,2511785.717815199,5833.333333333334,2003747.4228969656,true,151.0,151,0.875,0.0,0.0,0.0,0.0,0.0,151,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,105700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,151.0,0.0,1083.3743126350005,0.0,121.92,0.0 -152,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,106400.0,5833.333333333334,2517619.0511485324,5833.333333333334,2009580.756230299,true,152.0,152,0.875,0.0,0.0,0.0,0.0,0.0,152,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,106400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,152.0,0.0,1083.3743126350005,0.0,121.92,0.0 -153,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,107100.0,5833.333333333334,2523452.384481866,5833.333333333334,2015414.0895636322,true,153.0,153,0.875,0.0,0.0,0.0,0.0,0.0,153,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,107100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,153.0,0.0,1083.3743126350005,0.0,121.92,0.0 -154,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,107800.0,5833.333333333334,2529285.7178151994,5833.333333333334,2021247.4228969654,true,154.0,154,0.875,0.0,0.0,0.0,0.0,0.0,154,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,107800.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,154.0,0.0,1083.3743126350005,0.0,121.92,0.0 -155,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,108500.0,5833.333333333334,2535119.051148533,5833.333333333334,2027080.7562302987,true,155.0,155,0.875,0.0,0.0,0.0,0.0,0.0,155,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,108500.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,155.0,0.0,1083.3743126350005,0.0,121.92,0.0 -156,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,109200.0,5833.333333333334,2540952.3844818664,5833.333333333334,2032914.089563632,true,156.0,156,0.875,0.0,0.0,0.0,0.0,0.0,156,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,109200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,156.0,0.0,1083.3743126350005,0.0,121.92,0.0 -157,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,109900.0,5833.333333333334,2546785.7178152,5833.333333333334,2038747.4228969652,true,157.0,157,0.875,0.0,0.0,0.0,0.0,0.0,157,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,109900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,157.0,0.0,1083.3743126350005,0.0,121.92,0.0 -158,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,110600.0,5833.333333333334,2552619.0511485334,5833.333333333334,2044580.7562302984,true,158.0,158,0.875,0.0,0.0,0.0,0.0,0.0,158,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,110600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,158.0,0.0,1083.3743126350005,0.0,121.92,0.0 -159,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,111300.0,5833.333333333334,2558452.384481867,5833.333333333334,2050414.0895636317,true,159.0,159,0.875,0.0,0.0,0.0,0.0,0.0,159,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,111300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,159.0,0.0,1083.3743126350005,0.0,121.92,0.0 -160,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,112000.0,5833.333333333334,2564285.7178152003,5833.333333333334,2056247.422896965,true,160.0,160,0.875,0.0,0.0,0.0,0.0,0.0,160,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,112000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,160.0,0.0,1083.3743126350005,0.0,121.92,0.0 -161,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,112700.0,5833.333333333334,2570119.051148534,5833.333333333334,2062080.7562302982,true,161.0,161,0.875,0.0,0.0,0.0,0.0,0.0,161,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,112700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,161.0,0.0,1083.3743126350005,0.0,121.92,0.0 -162,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,113400.0,5833.333333333334,2575952.3844818673,5833.333333333334,2067914.0895636315,true,162.0,162,0.875,0.0,0.0,0.0,0.0,0.0,162,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,113400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,162.0,0.0,1083.3743126350005,0.0,121.92,0.0 -163,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,114100.0,5833.333333333334,2581785.717815201,5833.333333333334,2073747.4228969647,true,163.0,163,0.875,0.0,0.0,0.0,0.0,0.0,163,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,114100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,1644.2724500334996,163.0,0.0,1083.3743126350005,0.0,121.92,0.0 -164,22450.0,21750.0,0.1768,2178.5874071500493,510216.88232537586,700.0,114800.0,16281.602981617925,2598067.320796819,14103.015574467876,2087850.4384714325,true,164.0,164,0.875,1906.2639812562932,2178.5874071500493,272.32342589375617,0.0,0.0,164,21750.0,0.0,1906.2639812562932,1906.2639812562932,195177.85544994214,700.0,114800.0,0.19594678934725546,71070.31749117123,1789.2808980367404,1789.2808980367045,0.0,0.0,83.20228828994367,122284.67221259403,33.58484814026184,33.58484814026164,-1906.2639812562932,-446439.77203470387,true,true,1.475255935,1084.8495685700004,0.0,1644.2724500334996,164.0,1.475255935,1084.8495685700004,0.0,121.92,0.0 -165,24628.58740715005,23928.58740715005,0.265,6541.136756240824,516758.01908161666,700.0,115500.0,27325.04436317292,2625392.3651599917,20783.907606932098,2108634.3460783646,true,165.0,165,0.875,5723.494661710721,6541.136756240824,817.6420945301033,0.0,0.0,165,23928.58740715005,0.0,5723.494661710721,5723.494661710721,200901.35011165286,700.0,115500.0,5.290563308789698,71075.60805448002,5367.842689258775,7157.123587295479,0.0,0.0,249.60686481343245,122534.27907740747,100.75454432972379,134.33939246998543,-5723.494661710721,-452163.2666964146,true,true,2.950511869,1087.8000804390003,0.0,1644.2724500334996,165.0,2.950511869,1087.8000804390003,0.0,121.92,0.0 -166,28991.136756240823,28291.136756240823,0.30500000000000005,10919.809735313333,527677.82881693,700.0,116200.0,38097.73683709289,2663490.1019970844,27177.927101779555,2135812.2731801444,true,166.0,166,0.875,9554.833518399166,10919.809735313333,1364.9762169141668,0.0,0.0,166,28291.136756240823,0.0,9554.833518399166,9554.833518399166,210456.18363005202,700.0,116200.0,24.493348648483604,71100.1014031285,8946.404487757982,16103.528075053462,0.0,0.0,416.0114413369212,122950.29051874438,167.9242406557784,302.2636331257638,-9554.833518399166,-461718.1002148138,true,true,4.425767804,1092.2258482430004,0.0,1644.2724500334996,166.0,4.425767804,1092.2258482430004,0.0,121.92,0.0 -167,33369.809735313334,32669.809735313334,0.33999999999999997,15325.35540277793,543003.1842197079,700.0,116900.0,47133.39824346451,2710623.500240549,31808.042840686576,2167620.316020831,true,167.0,167,0.875,13409.685977430689,15325.35540277793,1915.6694253472415,0.0,0.0,167,32669.809735313334,0.0,13409.685977430689,13409.685977430689,223865.86960748272,700.0,116900.0,67.20974868753402,71167.31115181603,12524.966274128567,28628.49434918203,0.0,0.0,582.41601786041,123532.70653660479,235.09393675417851,537.3575698799423,-13409.685977430689,-475127.78619224444,true,true,5.901023738,1098.1268719810005,0.0,1644.2724500334996,167.0,5.901023738,1098.1268719810005,0.0,121.92,0.0 -168,37775.35540277793,37075.35540277793,0.3516666666666666,19768.52287353081,562771.7070932387,700.0,117600.0,58204.330446059175,2768827.8306866083,38435.80757252837,2206056.1235933593,true,168.0,168,0.875,17297.457514339458,19768.52287353081,2471.0653591913506,0.0,0.0,168,37075.35540277793,0.0,17297.457514339458,17297.457514339458,241163.32712182216,700.0,117600.0,142.84520930504598,71310.15636112107,16103.528077479215,44732.02242666125,0.0,0.0,748.8205943838988,124281.52713098869,302.2636331712946,839.6212030512369,-17297.457514339458,-492425.2437065839,true,true,7.376279673,1105.5031516540005,0.0,1644.2724500334996,168.0,7.376279673,1105.5031516540005,0.0,121.92,0.0 -169,42218.522873530805,41518.522873530805,0.35833333333333334,24260.06118338802,587031.7682766267,700.0,118300.0,69655.98469782704,2838483.8153844355,45395.92351443901,2251452.047107798,true,169.0,169,0.875,21227.553535464518,24260.06118338802,3032.507647923503,0.0,0.0,169,41518.522873530805,0.0,21227.553535464518,21227.553535464518,262390.8806572867,700.0,118300.0,260.8051763801247,71570.96153750119,19682.089858998374,64414.11228565962,0.0,0.0,915.2251709073876,125196.75230189608,369.43332917863336,1209.0545322298703,-21227.553535464518,-513652.79724204843,true,true,8.851535607,1114.3546872610004,0.0,1644.2724500334996,169.0,8.851535607,1114.3546872610004,0.0,121.92,0.0 -170,46710.061183388025,46010.061183388025,0.35333333333333333,20955.097763039685,607986.8660396663,700.0,119000.0,61288.01253690477,2899771.8279213402,40332.91477386508,2291784.961881663,true,170.0,170,0.875,18335.710542659723,20955.097763039685,2619.387220379962,0.0,0.0,170,46010.061183388025,0.0,18335.710542659723,18335.710542659723,280726.5911999464,700.0,119000.0,403.96543157774795,71974.92696907894,16561.938881175596,80976.05116683521,0.0,0.0,1058.9382142455102,126255.69051614159,310.86801566086996,1519.9225478907404,-18335.710542659723,-531988.5077847082,true,true,9.924449014,1124.2791362750004,0.0,1644.2724500334996,170.0,9.924449014,1124.2791362750004,0.0,121.92,0.0 -171,43405.09776303968,42705.09776303968,0.35333333333333333,20647.026341339464,628633.8923810058,700.0,119700.0,60416.1122868098,2960187.94020815,39769.08594547034,2331554.0478271334,true,171.0,171,0.875,18066.148048672032,20647.026341339464,2580.878292667432,0.0,0.0,171,42705.09776303968,0.0,18066.148048672032,18066.148048672032,298792.7392486184,700.0,119700.0,548.2203981814235,72523.14736726036,16044.378378340822,97020.42954517604,0.0,0.0,1172.3958803415362,127428.08639648312,301.15339180825026,1821.0759396989906,-18066.148048672032,-550054.6558333802,true,true,10.86324825,1135.1423845250004,0.0,1644.2724500334996,171.0,10.86324825,1135.1423845250004,0.0,121.92,0.0 -172,43097.026341339464,42397.026341339464,0.345,16603.546373028403,645237.4387540342,700.0,120400.0,50155.2068783432,3010343.147086493,33551.660505314794,2365105.7083324483,true,172.0,172,0.875,14528.103076399851,16603.546373028403,2075.4432966285513,0.0,0.0,172,42397.026341339464,0.0,14528.103076399851,14528.103076399851,313320.84232501825,700.0,120400.0,685.6610973104235,73208.80846457079,12347.51676147383,109367.94630664987,0.0,0.0,1263.1620127446092,128691.24840922773,231.76320487098926,2052.83914456998,-14528.103076399851,-564582.7589097801,true,true,11.53381912,1146.6762036450004,0.0,1644.2724500334996,172.0,11.53381912,1146.6762036450004,0.0,121.92,0.0 -173,39053.5463730284,38353.5463730284,0.28625,8382.031685502983,653619.4704395372,700.0,121100.0,31727.621608744044,3042070.768695237,23345.58992324106,2388451.2982556894,true,173.0,173,0.875,7334.27772481511,8382.031685502983,1047.7539606878736,0.0,0.0,173,38353.5463730284,0.0,7334.27772481511,7334.27772481511,320655.1200498334,700.0,121100.0,775.5464973091873,73984.35496187997,5146.031167701478,114513.97747435136,0.0,0.0,1316.1089233976663,130007.3573326254,96.59113640677788,2149.430280976758,-7334.27772481511,-571917.0366345951,true,true,11.80204748,1158.4782511250005,0.0,1644.2724500334996,173.0,11.80204748,1158.4782511250005,0.0,121.92,0.0 -174,30832.03168550298,30132.03168550298,0.12,0.0,653619.4704395372,700.0,121800.0,5833.333333333334,3047904.1020285706,5833.333333333334,2394284.631589023,true,174.0,174,0.875,0.0,0.0,0.0,0.0,0.0,174,30132.03168550298,0.0,-4019.9898226218893,-4019.9898226218893,316635.1302272115,700.0,121800.0,771.09786723211,74755.45282911208,-5992.20155588983,108521.77591846153,0.0,0.0,1313.5876422334177,131320.9449748588,-112.47377619758674,2036.9565047791712,-0.0,-571917.0366345951,true,true,11.4891144,1169.9673655250006,0.0,1644.2724500334996,174.0,11.4891144,1169.9673655250006,0.0,121.92,0.0 -175,22450.0,21750.0,0.12,0.0,653619.4704395372,700.0,122500.0,5833.333333333334,3053737.435361904,5833.333333333334,2400117.9649223564,true,175.0,175,0.875,0.0,0.0,0.0,0.0,0.0,175,21750.0,0.0,-3106.3995889943726,-3106.3995889943726,313528.7306382171,700.0,122500.0,714.8048141930619,75470.25764330514,-5008.014820295603,103513.76109816592,0.0,0.0,1280.81098315029,132601.7559580091,-94.00056604212095,1942.9559387370502,-0.0,-571917.0366345951,true,true,11.22088605,1181.1882515750005,0.0,1644.2724500334996,175.0,11.22088605,1181.1882515750005,0.0,121.92,0.0 -176,22450.0,21750.0,0.12,0.0,653619.4704395372,700.0,123200.0,5833.333333333334,3059570.7686952376,5833.333333333334,2405951.29825569,true,176.0,176,0.875,0.0,0.0,0.0,0.0,0.0,176,21750.0,0.0,-1405.3723986651207,-1405.3723986651207,312123.358239552,700.0,123200.0,673.4174414832393,76143.67508478838,-3272.9545680289084,100240.80653013702,0.0,0.0,1255.5981686878783,133857.35412669697,-61.43344080732996,1881.5224979297202,-0.0,-571917.0366345951,true,true,11.04206715,1192.2303187250006,0.0,1644.2724500334996,176.0,11.04206715,1192.2303187250006,0.0,121.92,0.0 -177,22450.0,21750.0,0.22,5049.388550174555,658668.8589897117,700.0,123900.0,26133.584318975252,3085704.353014213,21084.195768800695,2427035.4940244905,true,177.0,177,0.875,4418.214981402736,5049.388550174555,631.1735687718192,0.0,0.0,177,21750.0,0.0,4418.214981402736,4418.214981402736,316541.57322095474,700.0,123900.0,669.368850078189,76813.04393486657,2449.7866857256167,102690.59321586264,0.0,0.0,1253.0768869596443,135110.4310136566,45.98255863928627,1927.5050565690065,-4418.214981402736,-576335.2516159979,true,true,11.17618132,1203.4065000450007,0.0,1644.2724500334996,177.0,11.17618132,1203.4065000450007,0.0,121.92,0.0 -178,27499.388550174554,26799.388550174554,0.20800000000000002,4155.478247380607,662824.3372370923,700.0,124600.0,23343.64542009907,3109047.998434312,19188.167172718462,2446223.661197209,true,178.0,178,0.875,3636.0434664580316,4155.478247380607,519.4347809225756,0.0,0.0,178,26799.388550174554,0.0,3636.0434664580316,3636.0434664580316,320177.6166874128,700.0,124600.0,689.7750524688241,77502.8189873354,1649.621679046332,104340.21489490898,0.0,0.0,1265.6832939088576,136376.11430756547,30.96344103401797,1958.4684976030244,-3636.0434664580316,-579971.2950824559,true,true,11.26559077,1214.6720908150007,0.0,1644.2724500334996,178.0,11.26559077,1214.6720908150007,0.0,121.92,0.0 -179,26605.478247380608,25905.478247380608,0.20800000000000002,4201.302957510367,667025.6401946027,700.0,125300.0,23563.956526492148,3132611.9549608044,19362.65356898178,2465586.3147661905,true,179.0,179,0.875,3676.1400878215713,4201.302957510367,525.162869688796,0.0,0.0,179,25905.478247380608,0.0,3676.1400878215713,3676.1400878215713,323853.75677523436,700.0,125300.0,706.3954316362309,78209.21441897163,1662.7660748133496,106002.98096972232,0.0,0.0,1275.7684196938221,137651.8827272593,31.21016167816855,1989.678659281193,-3676.1400878215713,-583647.4351702774,true,true,11.35500022,1226.0270910350007,0.0,1644.2724500334996,179.0,11.35500022,1226.0270910350007,0.0,121.92,0.0 -180,26651.30295751037,25951.30295751037,0.25,6229.5373711100065,673255.1775657127,700.0,126000.0,27718.149484440026,3160330.1044452447,21488.61211333002,2487074.9268795205,true,180.0,180,0.875,5450.845199721256,6229.5373711100065,778.6921713887505,0.0,0.0,180,25951.30295751037,0.0,5450.845199721256,5450.845199721256,329304.60197495564,700.0,126000.0,731.823269133634,78941.03768810527,3364.965336927565,109367.94630664989,0.0,0.0,1290.896108371269,138942.77883563057,63.16048528878698,2052.83914456998,-5450.845199721256,-589098.2803699987,true,true,11.53381912,1237.5609101550008,0.0,1644.2724500334996,180.0,11.53381912,1237.5609101550008,0.0,121.92,0.0 -181,28679.537371110007,27979.537371110007,0.345,16649.477708036586,689904.6552737493,700.0,126700.0,50288.34118271474,3210618.4456279594,33638.86347467816,2520713.790354199,true,181.0,181,0.875,14568.292994532014,16649.477708036586,2081.184713504572,0.0,0.0,181,27979.537371110007,0.0,14568.292994532014,14568.292994532014,343872.8949694877,700.0,126700.0,811.7530711655426,79752.7907592708,12191.42734584454,121559.37365249443,0.0,0.0,1336.2791749675955,140279.05801059815,228.83340255433612,2281.672547124316,-14568.292994532014,-603666.5733645307,true,true,12.15968528,1249.7205954350009,0.0,1644.2724500334996,181.0,12.15968528,1249.7205954350009,0.0,121.92,0.0 -182,39099.47770803659,38399.47770803659,0.12,0.0,689904.6552737493,700.0,127400.0,5833.333333333334,3216451.778961293,5833.333333333334,2526547.1236875323,true,182.0,182,0.875,0.0,0.0,0.0,0.0,0.0,182,38399.47770803659,0.0,-4093.879271919988,-4093.879271919988,339779.01569756767,700.0,127400.0,844.3435475453647,80597.13430681617,-6176.223099567749,115383.15055292667,0.0,0.0,1353.9281453732763,141632.98615597142,-115.92786527087931,2165.7446818534368,-0.0,-603666.5733645307,true,true,11.8467522,1261.567347635001,0.0,1644.2724500334996,182.0,11.8467522,1261.567347635001,0.0,121.92,0.0 -183,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,128100.0,5833.333333333334,3222285.1122946264,5833.333333333334,2532380.4570208658,true,183.0,183,0.875,0.0,0.0,0.0,0.0,0.0,183,21750.0,0.0,-19157.39308967751,-19157.39308967751,320621.62260789017,700.0,128100.0,702.2155883763056,81299.34989519247,-20743.499795791122,94639.65075713555,0.0,0.0,1273.2471385295737,142906.233294501,-389.3560207922659,1776.3886610611708,-0.0,-603666.5733645307,true,true,10.72913407,1272.296481705001,0.0,1644.2724500334996,183.0,10.72913407,1272.296481705001,0.0,121.92,0.0 -184,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,128800.0,5833.333333333334,3228118.44562796,5833.333333333334,2538213.7903541992,true,184.0,184,0.875,0.0,0.0,0.0,0.0,0.0,184,21750.0,0.0,-8429.420498607207,-8429.420498607207,312192.20210928295,700.0,128800.0,555.3246780201065,81854.67457321257,-9974.953487984681,84664.69726915087,0.0,0.0,1177.4384430084242,144083.67173750943,-187.23013165105692,1589.1585294101137,-0.0,-603666.5733645307,true,true,10.14797264,1282.444454345001,0.0,1644.2724500334996,184.0,10.14797264,1282.444454345001,0.0,121.92,0.0 -185,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,129500.0,5833.333333333334,3233951.7789612934,5833.333333333334,2544047.1236875327,true,185.0,185,0.875,0.0,0.0,0.0,0.0,0.0,185,21750.0,0.0,-21787.030558622064,-21787.030558622064,290405.17155066086,700.0,129500.0,406.85777454038606,82261.53234775296,-22826.886584838263,61837.81068431261,0.0,0.0,1061.4594956917515,145145.1312332012,-428.46124401593653,1160.6972853941772,-0.0,-603666.5733645307,true,true,8.672716706,1291.1171710510012,0.0,1644.2724500334996,185.0,8.672716706,1291.1171710510012,0.0,121.92,0.0 -186,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,130200.0,5833.333333333334,3239785.112294627,5833.333333333334,2549880.457020866,true,186.0,186,0.875,0.0,0.0,0.0,0.0,0.0,186,21750.0,0.0,-9343.394812086932,-9343.394812086932,281061.7767385739,700.0,130200.0,278.4313035105071,82539.96365126346,-10362.713147821047,51475.097536491565,0.0,0.0,935.3954225901139,146080.5266557913,-194.50839036650697,966.1888950276702,-0.0,-603666.5733645307,true,true,7.912736376,1299.0299074270013,0.0,1644.2724500334996,186.0,7.912736376,1299.0299074270013,0.0,121.92,0.0 -187,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,130900.0,5833.333333333334,3245618.4456279604,5833.333333333334,2555713.7903541997,true,187.0,187,0.875,0.0,0.0,0.0,0.0,0.0,187,21750.0,0.0,-1809.2318543787503,-1809.2318543787503,279252.54488419514,700.0,130900.0,231.7782143401148,82771.74186560357,-2867.121358058867,48607.9761784327,0.0,0.0,879.9272304344172,146960.4538862257,-53.81594109441542,912.3729539332548,-0.0,-603666.5733645307,true,true,7.68921275,1306.7191201770013,0.0,1644.2724500334996,187.0,7.68921275,1306.7191201770013,0.0,121.92,0.0 -188,22450.0,21750.0,0.28,7368.913002353727,697273.568276103,700.0,131600.0,28817.546436977595,3274435.992064938,21448.633434623865,2577162.4237888237,true,188.0,188,0.875,6447.798877059511,7368.913002353727,921.1141252942161,0.0,0.0,188,21750.0,0.0,6447.798877059511,6447.798877059511,285700.3437612547,700.0,131600.0,239.83935520768443,83011.58122081126,5219.968228647543,53827.94440708024,0.0,0.0,890.0123562757803,147850.46624250148,97.97893692850403,1010.3518908617589,-6447.798877059511,-610114.3722415902,true,true,8.091555277,1314.8106754540013,0.0,1644.2724500334996,188.0,8.091555277,1314.8106754540013,0.0,121.92,0.0 -189,29818.91300235373,29118.91300235373,0.22,4875.908410787412,702149.4766868905,700.0,132300.0,25345.038230851875,3299781.0302957897,20469.129820064463,2597631.5536088883,true,189.0,189,0.875,4266.419859438985,4875.908410787412,609.4885513484269,0.0,0.0,189,29118.91300235373,0.0,4266.419859438985,4266.419859438985,289966.76362069364,700.0,132300.0,269.52218856006243,83281.10340937132,3014.9958255062224,56842.940232586465,0.0,0.0,925.3102967487507,148775.77653925025,56.59154862394952,1066.9434394857085,-4266.419859438985,-614380.7921010292,true,true,8.315078904,1323.1257543580014,0.0,1644.2724500334996,189.0,8.315078904,1323.1257543580014,0.0,121.92,0.0 -190,27325.90841078741,26625.90841078741,0.3175,11808.57261478694,713958.0493016774,700.0,133000.0,39397.07910169115,3339178.1093974807,27588.50648690421,2625220.0600957926,true,190.0,190,0.875,10332.501037938573,11808.57261478694,1476.0715768483678,0.0,0.0,190,26625.90841078741,0.0,10332.501037938573,10332.501037938573,300299.2646586322,700.0,133000.0,313.58714113416886,83594.69055050549,8879.039454968335,65721.9796875548,0.0,0.0,973.214644565724,149748.99118381596,166.65979727034525,1233.6032367560538,-10332.501037938573,-624713.2931389677,true,true,8.940945058,1332.0666994160013,0.0,1644.2724500334996,190.0,8.940945058,1332.0666994160013,0.0,121.92,0.0 -191,34258.57261478694,33558.57261478694,0.3516666666666666,19444.726237958144,733402.7755396356,700.0,133700.0,57283.581719312264,3396461.691116793,37838.85548135412,2663058.9155771467,true,191.0,191,0.875,17014.135458213375,19444.726237958144,2430.590779744769,0.0,0.0,191,33558.57261478694,0.0,17014.135458213375,17014.135458213375,317313.4001168456,700.0,133700.0,409.7638906038589,84004.45444110935,15254.071479280437,80976.05116683524,0.0,0.0,1063.980777194391,150812.97196101036,286.31931113468664,1519.9225478907404,-17014.135458213375,-641727.4285971811,true,true,9.924449014,1341.9911484300012,0.0,1644.2724500334996,191.0,9.924449014,1341.9911484300012,0.0,121.92,0.0 -192,41894.726237958144,41194.726237958144,0.355,22528.012691557353,755930.788231193,700.0,134400.0,65431.02166635874,3461892.712783152,42903.008974801385,2705961.924551948,true,192.0,192,0.875,19712.011105112684,22528.012691557353,2816.0015864446686,0.0,0.0,192,41194.726237958144,0.0,19712.011105112684,19712.011105112684,337025.4112219583,700.0,134400.0,555.3246783393029,84559.77911944865,17647.99467293782,98624.04583977305,0.0,0.0,1177.4384432340185,151990.41040424438,331.25331060154025,1851.1758584922807,-19712.011105112684,-661439.4397022938,true,true,10.9526577,1352.9438061300011,0.0,1644.2724500334996,192.0,10.9526577,1352.9438061300011,0.0,121.92,0.0 -193,44978.01269155735,44278.01269155735,0.3585,30105.1109938774,786035.8992250704,700.0,135100.0,85927.78519910014,3547820.497982252,55822.674205222735,2761784.5987571706,true,193.0,193,0.875,26341.972119642724,30105.1109938774,3763.1388742346753,0.0,0.0,193,44278.01269155735,0.0,26341.972119642724,26341.972119642724,363367.383341601,700.0,135100.0,757.8541113977777,85317.63323084643,23830.78967989042,122454.83551966347,0.0,0.0,1306.0237976127014,153296.43420185708,447.3045307418266,2298.4803892341074,-26341.972119642724,-687781.4118219366,true,true,12.20439,1365.1481961300012,0.0,1644.2724500334996,193.0,12.20439,1365.1481961300012,0.0,121.92,0.0 -194,52555.1109938774,51855.1109938774,0.3555,38251.936672667565,824287.8358977379,700.0,135800.0,109569.44211720835,3657389.94009946,71317.50544454079,2833102.1042017112,true,194.0,194,0.875,33470.44458858412,38251.936672667565,4781.492084083446,0.0,0.0,194,51855.1109938774,0.0,33470.44458858412,33470.44458858412,396837.8279301851,700.0,135800.0,1052.882352979438,86370.51558382587,30389.84341385865,152844.6789335221,0.0,0.0,1457.3006849511562,154753.73488680823,570.4181367948753,2868.898526028983,-33470.44458858412,-721251.8564105207,true,true,13.63494121,1378.7831373400013,0.0,1644.2724500334996,194.0,13.63494121,1378.7831373400013,0.0,121.92,0.0 -195,60701.936672667565,60001.936672667565,0.3545,40207.59118577558,864495.4270835135,700.0,136500.0,115395.17964957851,3772785.1197490385,75187.58846380294,2908289.692665514,true,195.0,195,0.875,35181.64228755363,40207.59118577558,5025.948898221948,0.0,0.0,195,60001.936672667565,0.0,35181.64228755363,35181.64228755363,432019.47021773877,700.0,136500.0,1429.3423232759949,87799.85790710186,31546.550274430578,184391.22920795268,0.0,0.0,1613.620135746079,156367.35502255431,592.1295541009748,3461.0280801299577,-35181.64228755363,-756433.4986980744,true,true,14.97608297,1393.7592203100014,0.0,1644.2724500334996,195.0,14.97608297,1393.7592203100014,0.0,121.92,0.0 -196,62657.59118577558,61957.59118577558,0.3545,40119.46131246792,904614.8883959814,700.0,137200.0,115146.5763398249,3887931.6960888635,75027.11502735698,2983316.807692871,true,196.0,196,0.875,35104.52864840943,40119.46131246792,5014.932664058491,0.0,0.0,196,61957.59118577558,0.0,35104.52864840943,35104.52864840943,467123.9988661482,700.0,137200.0,1846.2676741318962,89646.12558123376,30920.5483139305,215311.7775218832,0.0,0.0,1757.3331790278032,158124.68820158212,580.3794813192384,4041.4075614491962,-35104.52864840943,-791538.0273464838,true,true,16.18311055,1409.9423308600014,0.0,1644.2724500334996,196.0,16.18311055,1409.9423308600014,0.0,121.92,0.0 -197,62569.46131246792,61869.46131246792,0.3516666666666666,20058.904403552944,924673.7927995344,700.0,137900.0,59030.05991531644,3946961.75600418,38971.15551176349,3022287.9632046344,true,197.0,197,0.875,17551.541353108827,20058.904403552944,2507.363050444117,0.0,0.0,197,61869.46131246792,0.0,17551.541353108827,17551.541353108827,484675.540219257,700.0,137900.0,2165.0022335277254,91811.1278147615,13284.055189946921,228595.83271183012,0.0,0.0,1853.1418745489523,159977.83007613107,249.34205508522933,4290.7496165344255,-17551.541353108827,-809089.5686995926,true,true,16.67486253,1426.6171933900014,0.0,1644.2724500334996,197.0,16.67486253,1426.6171933900014,0.0,121.92,0.0 -198,42508.904403552944,41808.904403552944,0.357,34315.36868575039,958989.1614852848,700.0,138600.0,98082.26522619158,4045044.021230371,63766.89654044119,3086054.8597450755,true,198.0,198,0.875,30025.94760003159,34315.36868575039,4289.421085718801,0.0,0.0,198,41808.904403552944,0.0,30025.94760003159,30025.94760003159,514701.4878192886,700.0,138600.0,2450.657620932225,94261.78543569372,25171.51833700349,253767.3510488336,0.0,0.0,1931.3016002284066,161909.13167635948,472.4700418674672,4763.219658401893,-30025.94760003159,-839115.5162996242,true,true,17.56895704,1444.1861504300014,0.0,1644.2724500334996,198.0,17.56895704,1444.1861504300014,0.0,121.92,0.0 -199,56765.36868575039,56065.36868575039,0.35666666666666663,23785.083371140277,982774.2448564251,700.0,139300.0,68649.76646114097,4113693.787691512,44864.68309000069,3130919.5428350763,true,199.0,199,0.875,20811.947949747744,23785.083371140277,2973.1354213925333,0.0,0.0,199,56065.36868575039,0.0,20811.947949747744,20811.947949747744,535513.4357690364,700.0,139300.0,2770.7988952150754,97032.5843309088,15733.84183450869,269501.1928833423,0.0,0.0,2011.9826070721094,163921.11428343158,295.3246129518697,5058.544271353762,-20811.947949747744,-859927.464249372,true,true,18.10541374,1462.2915641700013,0.0,1644.2724500334996,199.0,18.10541374,1462.2915641700013,0.0,121.92,0.0 -200,46235.08337114028,45535.08337114028,0.358,31174.307056075904,1013948.551912501,700.0,140000.0,89034.37725160868,4202728.16494312,57860.07019553277,3188779.613030609,true,200.0,200,0.875,27277.518674066418,31174.307056075904,3896.7883820094867,0.0,0.0,200,45535.08337114028,0.0,27277.518674066418,27277.518674066418,562790.9544431028,700.0,140000.0,3072.8154216930316,100105.39975260182,21714.542251758998,291215.73513510125,0.0,0.0,2082.578488130847,166003.69277156243,407.582512483542,5466.126783837304,-27277.518674066418,-887204.9829234384,true,true,18.82068935,1481.1122535200013,0.0,1644.2724500334996,200.0,18.82068935,1481.1122535200013,0.0,121.92,0.0 -201,53624.30705607591,52924.30705607591,0.359,29300.62019166626,1043249.1721041673,700.0,140700.0,83567.18716341577,4286295.352106536,54266.56697174951,3243046.1800023587,true,201.0,201,0.875,25638.042667707978,29300.62019166626,3662.5775239582836,0.0,0.0,201,52924.30705607591,0.0,25638.042667707978,25638.042667707978,588428.9971108108,700.0,140700.0,3419.933220708514,103525.33297331033,19690.304987565803,310906.04012266704,0.0,0.0,2158.216932082067,168161.9097036445,369.58752735159464,5835.714311188899,-25638.042667707978,-912843.0255911464,true,true,19.4465555,1500.5588090200013,0.0,1644.2724500334996,201.0,19.4465555,1500.5588090200013,0.0,121.92,0.0 -202,51750.62019166626,51050.62019166626,0.357,34005.907243420355,1077255.0793475877,700.0,141400.0,97215.42645215786,4383510.778558694,63209.5192087375,3306255.6992110964,true,202.0,202,0.875,29755.168837992813,34005.907243420355,4250.738405427543,0.0,0.0,202,51050.62019166626,0.0,29755.168837992813,29755.168837992813,618184.1659488037,700.0,141400.0,3792.254693933985,107317.58766724431,23291.869777609292,334197.90990027634,0.0,0.0,2233.8553760332875,170395.76507967777,437.1889904162494,6272.903301605148,-29755.168837992813,-942598.1944291393,true,true,20.16183111,1520.7206401300014,0.0,1644.2724500334996,202.0,20.16183111,1520.7206401300014,0.0,121.92,0.0 -203,56455.907243420355,55755.907243420355,0.35666666666666663,23021.16619307473,1100276.2455406624,700.0,142100.0,66507.94259740578,4450018.7211561,43486.77640433105,3349742.4756154274,true,203.0,203,0.875,20143.52041894039,23021.16619307473,2877.64577413434,0.0,0.0,203,55755.907243420355,0.0,20143.52041894039,20143.52041894039,638327.686367744,700.0,142100.0,4122.412655868708,111440.00032311302,13471.362531923885,347669.2724322002,0.0,0.0,2296.8874124713093,172692.6524921491,252.85781867648708,6525.761120281635,-20143.52041894039,-962741.7148480796,true,true,20.56417363,1541.2848137600013,0.0,1644.2724500334996,203.0,20.56417363,1541.2848137600013,0.0,121.92,0.0 -204,45471.16619307473,44771.16619307473,0.355,21856.267883826073,1122132.5134244885,700.0,142800.0,63538.78277134105,4513557.503927441,41682.514887514975,3391424.9905029424,true,204.0,204,0.875,19124.234398347813,21856.267883826073,2732.0334854782595,0.0,0.0,204,44771.16619307473,0.0,19124.234398347813,19124.234398347813,657451.9207660918,700.0,142800.0,4357.528743133255,115797.52906624628,12197.999692211702,359867.2721244119,0.0,0.0,2339.7491973394017,175032.4016894885,228.95676566345475,6754.71788594509,-19124.234398347813,-981865.9492464274,true,true,20.92181144,1562.2066252000013,0.0,1644.2724500334996,204.0,20.92181144,1562.2066252000013,0.0,121.92,0.0 -205,44306.267883826076,43606.267883826076,0.35333333333333333,20570.489622222016,1142703.0030467105,700.0,143500.0,60199.498930817026,4573757.002858259,39629.00930859501,3431053.9998115376,true,205.0,205,0.875,17999.178419444263,20570.489622222016,2571.3112027777534,0.0,0.0,205,43606.267883826076,0.0,17999.178419444263,17999.178419444263,675451.099185536,700.0,143500.0,4572.2651758659185,120369.7942421122,10845.769454683572,370713.0415790955,0.0,0.0,2377.5684193150114,177409.9701088035,203.57536957976183,6958.293255524852,-17999.178419444263,-999865.1276658716,true,true,21.23474451,1583.4413697100013,0.0,1644.2724500334996,205.0,21.23474451,1583.4413697100013,0.0,121.92,0.0 -206,43020.48962222201,42320.48962222201,0.28625,8080.0704604026605,1150783.0735071131,700.0,144200.0,30672.735232847725,4604429.7380911065,22592.664772445063,3453646.6645839824,true,206.0,206,0.875,7070.061652852328,8080.0704604026605,1010.0088075503327,0.0,0.0,206,42320.48962222201,0.0,7070.061652852328,7070.061652852328,682521.1608383884,700.0,144200.0,4674.8442636956215,125044.63850580782,0.0,370713.0415790955,0.0,0.0,2395.2173891567068,179805.1874979602,0.0,6958.293255524852,-7070.061652852328,-1006935.189318724,true,true,21.23474451,1604.6761142200012,0.0,1644.2724500334996,206.0,21.23474451,1604.6761142200012,0.0,121.92,0.0 -207,30530.07046040266,29830.07046040266,0.20800000000000002,4413.55572945483,1155196.629236568,700.0,144900.0,24584.40254545591,4629014.140636562,20170.846816001078,3473817.5113999834,true,207.0,207,0.875,3861.861263272976,4413.55572945483,551.6944661818538,0.0,0.0,207,29830.07046040266,0.0,3861.861263272976,3861.861263272976,686383.0221016613,700.0,144900.0,4645.3810466648,129690.01955247262,-3115.2218166199136,367597.81976247556,0.0,0.0,2390.1748262642245,182195.36232422444,-58.47279303613522,6899.820462488717,-3861.861263272976,-1010797.0505819969,true,true,21.14533506,1625.8214492800012,0.0,1644.2724500334996,207.0,21.14533506,1625.8214492800012,0.0,121.92,0.0 -208,26863.55572945483,26163.55572945483,0.25,6173.947734548011,1161370.576971116,700.0,145600.0,27495.790938192044,4656509.931574754,21321.84320364403,3495139.354603627,true,208.0,208,0.875,5402.204267729509,6173.947734548011,771.7434668185015,0.0,0.0,208,26163.55572945483,0.0,5402.204267729509,5402.204267729509,691785.2263693908,700.0,145600.0,4601.418744963874,134291.43829743649,-1552.6815864214939,366045.13817605405,0.0,0.0,2382.610982207494,184577.97330643193,-29.143873020364406,6870.676589468352,-5402.204267729509,-1016199.2548497265,true,true,21.10063034,1646.922079620001,0.0,1644.2724500334996,208.0,21.10063034,1646.922079620001,0.0,121.92,0.0 -209,28623.94773454801,27923.94773454801,0.20800000000000002,4319.055870968466,1165689.6328420844,700.0,146300.0,24130.076302733007,4680640.007877488,19811.02043176454,3514950.3750353917,true,209.0,209,0.875,3779.1738870974073,4319.055870968466,539.8819838710583,0.0,0.0,209,27923.94773454801,0.0,3779.1738870974073,3779.1738870974073,695564.4002564882,700.0,146300.0,4557.734684734872,138849.17298217135,-3095.505223704521,362949.63295234955,0.0,0.0,2375.047138150763,186953.02044458268,-58.10271208370657,6812.573877384646,-3779.1738870974073,-1019978.4287368238,true,true,21.01122089,1667.9333005100011,0.0,1644.2724500334996,209.0,21.01122089,1667.9333005100011,0.0,121.92,0.0 -210,26769.055870968466,26069.055870968466,0.28625,7884.3093651326035,1173573.942207217,700.0,147000.0,29988.853677319137,4710628.861554807,22104.544312186532,3537054.919347578,true,210.0,210,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,210,26069.055870968466,0.0,6898.770694491028,6898.770694491028,702463.1709509792,700.0,147000.0,4528.766119232747,143377.9391014041,0.0,362949.63295234955,0.0,0.0,2370.004575258281,189323.02501984098,0.0,6812.573877384646,-6898.770694491028,-1026877.1994313148,true,true,21.01122089,1688.9445214000011,0.0,1644.2724500334996,210.0,21.01122089,1688.9445214000011,0.0,121.92,0.0 -211,30334.309365132605,29634.309365132605,0.28625,7884.3093651326035,1181458.2515723496,700.0,147700.0,29988.853677319137,4740617.715232126,22104.544312186532,3559159.4636597647,true,211.0,211,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,211,29634.309365132605,0.0,6898.770694491028,6898.770694491028,709361.9416454702,700.0,147700.0,4528.766119232747,147906.70522063685,0.0,362949.63295234955,0.0,0.0,2370.004575258281,191693.02959509927,0.0,6812.573877384646,-6898.770694491028,-1033775.9701258058,true,true,21.01122089,1709.9557422900011,0.0,1644.2724500334996,211.0,21.01122089,1709.9557422900011,0.0,121.92,0.0 -212,30334.309365132605,29634.309365132605,0.28625,7884.3093651326035,1189342.5609374822,700.0,148400.0,29988.853677319137,4770606.568909446,22104.544312186532,3581264.0079719513,true,212.0,212,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,212,29634.309365132605,0.0,6898.770694491028,6898.770694491028,716260.7123399612,700.0,148400.0,4528.766119232747,152435.4713398696,0.0,362949.63295234955,0.0,0.0,2370.004575258281,194063.03417035757,0.0,6812.573877384646,-6898.770694491028,-1040674.7408202968,true,true,21.01122089,1730.9669631800011,0.0,1644.2724500334996,212.0,21.01122089,1730.9669631800011,0.0,121.92,0.0 -213,30334.309365132605,29634.309365132605,0.28625,7884.3093651326035,1197226.8703026148,700.0,149100.0,29988.853677319137,4800595.422586765,22104.544312186532,3603368.552284138,true,213.0,213,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,213,29634.309365132605,0.0,6898.770694491028,6898.770694491028,723159.4830344522,700.0,149100.0,4528.766119232747,156964.23745910235,0.0,362949.63295234955,0.0,0.0,2370.004575258281,196433.03874561586,0.0,6812.573877384646,-6898.770694491028,-1047573.5115147878,true,true,21.01122089,1751.9781840700011,0.0,1644.2724500334996,213.0,21.01122089,1751.9781840700011,0.0,121.92,0.0 -214,30334.309365132605,29634.309365132605,0.3175,11527.302581341559,1208754.1728839562,700.0,149800.0,38511.189232571836,4839106.611819337,26983.886651230277,3630352.4389353683,true,214.0,214,0.875,10086.389758673864,11527.302581341559,1440.9128226676949,0.0,0.0,214,29634.309365132605,0.0,10086.389758673864,10086.389758673864,733245.872793126,700.0,149800.0,4557.734684734872,161521.97214383722,3095.505223704521,366045.13817605405,0.0,0.0,2375.047138150763,198808.08588376662,58.10271208370657,6870.676589468352,-10086.389758673864,-1057659.9012734618,true,true,21.10063034,1773.078814410001,0.0,1644.2724500334996,214.0,21.10063034,1773.078814410001,0.0,121.92,0.0 -215,33977.30258134156,33277.30258134156,0.3175,11620.769376582699,1220374.942260539,700.0,150500.0,38805.57283963055,4877912.184658968,27184.80346304785,3657537.242398416,true,215.0,215,0.875,10168.173204509862,11620.769376582699,1452.5961720728374,0.0,0.0,215,33277.30258134156,0.0,10168.173204509862,10168.173204509862,743414.0459976359,700.0,150500.0,4616.041888374692,166138.0140322119,3108.649619471585,369153.7877955256,0.0,0.0,2385.1322639357277,201193.21814770234,58.349432727857526,6929.02602219621,-10168.173204509862,-1067828.0744779715,true,true,21.19003979,1794.268854200001,0.0,1644.2724500334996,215.0,21.19003979,1794.268854200001,0.0,121.92,0.0 -216,34070.7693765827,33370.7693765827,0.345,17255.013813299836,1237629.9560738388,700.0,151200.0,52043.51829941982,4929955.702958387,34788.504486119986,3692325.746884536,true,216.0,216,0.875,15098.137086637356,17255.013813299836,2156.87672666248,0.0,0.0,216,33370.7693765827,0.0,15098.137086637356,15098.137086637356,758512.1830842732,700.0,151200.0,4719.272267415918,170857.28629962783,7829.130604110655,376982.9183996363,0.0,0.0,2402.781233777423,203595.99938147975,146.95298133336095,7075.979003529571,-15098.137086637356,-1082926.2115646088,true,true,21.41356341,1815.682417610001,0.0,1644.2724500334996,216.0,21.41356341,1815.682417610001,0.0,121.92,0.0 -217,39705.01381329984,39005.01381329984,0.3516666666666666,19425.000277654424,1257054.9563514933,700.0,151900.0,57227.48894119742,4987183.191899585,37802.488663543,3730128.235548079,true,217.0,217,0.875,16996.875242947623,19425.000277654424,2428.1250347068017,0.0,0.0,217,39005.01381329984,0.0,16996.875242947623,16996.875242947623,775509.0583272208,700.0,151900.0,4884.582323878252,175741.86862350607,9503.398555571433,386486.31695520773,0.0,0.0,2430.5153299680687,206026.51471144782,178.37903352986842,7254.358037059439,-16996.875242947623,-1099923.0868075565,true,true,21.68179177,1837.364209380001,0.0,1644.2724500334996,217.0,21.68179177,1837.364209380001,0.0,121.92,0.0 -218,41875.00027765443,41175.00027765443,0.3516666666666666,19808.391095145107,1276863.3474466384,700.0,152600.0,58317.699796621164,5045500.891696205,38509.30870147605,3768637.544249555,true,218.0,218,0.875,17332.34220825197,19808.391095145107,2476.048886893139,0.0,0.0,218,41175.00027765443,0.0,17332.34220825197,17332.34220825197,792841.4005354728,700.0,152600.0,5069.274222269831,180811.1428457759,9621.69776537684,396108.01472058456,0.0,0.0,2460.770707886948,208487.28541933477,180.599512718346,7434.957549777785,-17332.34220825197,-1117255.4290158085,true,true,21.95002012,1859.3142295000011,0.0,1644.2724500334996,218.0,21.95002012,1859.3142295000011,0.0,121.92,0.0 -219,42258.39109514511,41558.39109514511,0.345,16359.42626262878,1293222.7737092671,700.0,153300.0,49447.61235544575,5094948.504051651,33088.18609281697,3801725.730342372,true,219.0,219,0.875,14314.497979800182,16359.42626262878,2044.9282828285977,0.0,0.0,219,41558.39109514511,0.0,14314.497979800182,14314.497979800182,807155.898515273,700.0,153300.0,5226.694023331791,186037.8368691077,6480.187155752717,402588.2018763373,0.0,0.0,2485.98352234936,210973.26894168413,121.6332783663133,7556.590828144098,-14314.497979800182,-1131569.9269956087,true,true,22.12883902,1881.4430685200011,0.0,1644.2724500334996,219.0,22.12883902,1881.4430685200011,0.0,121.92,0.0 -220,38809.42626262878,38109.42626262878,0.35,18522.747802527214,1311745.5215117943,700.0,154000.0,54922.13657864919,5149870.6406303,36399.388776121974,3838125.119118494,true,220.0,220,0.875,16207.404327211312,18522.747802527214,2315.3434753159017,0.0,0.0,220,38109.42626262878,0.0,16207.404327211312,16207.404327211312,823363.3028424843,700.0,154000.0,5371.128886882622,191408.96575599033,8174.170987113224,410762.3728634505,0.0,0.0,2508.6750550835372,213481.94399676766,153.42939813192748,7710.020226276026,-16207.404327211312,-1147777.33132282,true,true,22.35236264,1903.795431160001,0.0,1644.2724500334996,220.0,22.35236264,1903.795431160001,0.0,121.92,0.0 -221,40972.747802527214,40272.747802527214,0.35333333333333333,20790.000431234697,1332535.521943029,700.0,154700.0,60820.75593745669,5210691.396567757,40030.75550622199,3878155.874624716,true,221.0,221,0.875,18191.25037733036,20790.000431234697,2598.750053904336,0.0,0.0,221,40272.747802527214,0.0,18191.25037733036,18191.25037733036,841554.5532198147,700.0,154700.0,5551.243452031704,196960.20920802205,9917.447039872739,420679.81990332325,0.0,0.0,2536.409151274183,216018.35314804185,186.15073415173518,7896.170960427761,-18191.25037733036,-1165968.5817001504,true,true,22.620591,1926.4160221600011,0.0,1644.2724500334996,221.0,22.620591,1926.4160221600011,0.0,121.92,0.0 -222,43240.0004312347,42540.0004312347,0.345,17237.42589900422,1349772.9478420333,700.0,155400.0,51992.5388376934,5262683.935405451,34755.11293868918,3912910.987563405,true,222.0,222,0.875,15082.747661628693,17237.42589900422,2154.6782373755286,0.0,0.0,222,42540.0004312347,0.0,15082.747661628693,15082.747661628693,856637.3008814433,700.0,155400.0,5718.438513544495,202678.64772156655,6677.353093727456,427357.1729970507,0.0,0.0,2561.62196630058,218579.97511434244,125.33408805616126,8021.505048483922,-15082.747661628693,-1181051.3293617791,true,true,22.7994099,1949.2154320600011,0.0,1644.2724500334996,222.0,22.7994099,1949.2154320600011,0.0,121.92,0.0 -223,39687.42589900422,38987.42589900422,0.3516666666666666,19468.288383317395,1369241.2362253508,700.0,156100.0,57350.5830805234,5320034.5184859745,37882.294697206,3950793.282260611,true,223.0,223,0.875,17034.75233540272,19468.288383317395,2433.536047914673,0.0,0.0,223,38987.42589900422,0.0,17034.75233540272,17034.75233540272,873672.0532168461,700.0,156100.0,5871.755022158502,208550.40274372505,8420.628404068704,435777.8014011194,0.0,0.0,2584.313499034757,221164.2886133772,158.05541014075965,8179.560458624682,-17034.75233540272,-1198086.0816971818,true,true,23.02293352,1972.238365580001,0.0,1644.2724500334996,223.0,23.02293352,1972.238365580001,0.0,121.92,0.0 -224,41918.2883833174,41218.2883833174,0.35666666666666663,23823.70252371239,1393064.938749063,700.0,156800.0,68758.0444590067,5388792.562944981,44934.34193529432,3995727.6241959054,true,224.0,224,0.875,20845.73970824834,23823.70252371239,2977.9628154640486,0.0,0.0,224,41218.2883833174,0.0,20845.73970824834,20845.73970824834,894517.7929250944,700.0,156800.0,6080.4063068501555,214630.8090505752,11926.8963755212,447704.6977766406,0.0,0.0,2614.5688763896515,223778.85748976684,223.86814948733362,8403.428608112015,-20845.73970824834,-1218931.82140543,true,true,23.3358666,1995.574232180001,0.0,1644.2724500334996,224.0,23.3358666,1995.574232180001,0.0,121.92,0.0 -225,46273.70252371239,45573.70252371239,0.3585,30496.68383057132,1423561.6225796344,700.0,157500.0,87020.0385789995,5475812.6015239805,56523.35474842819,4052250.9789443337,true,225.0,225,0.875,26684.598351749904,30496.68383057132,3812.0854788214165,0.0,0.0,225,45573.70252371239,0.0,26684.598351749904,26684.598351749904,921202.3912768443,700.0,157500.0,6384.371706504551,221015.18075707974,17317.741533250064,465022.4393098907,0.0,0.0,2657.430661257744,226436.28815102458,325.05445073754447,8728.48305884956,-26684.598351749904,-1245616.41975718,true,true,23.78291385,2019.3571460300009,0.0,1644.2724500334996,225.0,23.78291385,2019.3571460300009,0.0,121.92,0.0 -226,52946.68383057132,52246.68383057132,0.359,29263.98244472508,1452825.6050243594,700.0,158200.0,83465.13215800858,5559277.733681989,54201.1497132835,4106452.128657617,true,226.0,226,0.875,25605.984639134444,29263.98244472508,3657.997805590636,0.0,0.0,226,52246.68383057132,0.0,25605.984639134444,25605.984639134444,946808.3759159788,700.0,158200.0,6735.8979286715885,227751.07868575133,15866.92903827989,480889.36834817054,0.0,0.0,2705.3350090183185,229141.6231600429,297.82266316464796,9026.30572201421,-25605.984639134444,-1271222.4043963144,true,true,24.18525638,2043.542402410001,0.0,1644.2724500334996,226.0,24.18525638,2043.542402410001,0.0,121.92,0.0 -227,51713.98244472508,51013.98244472508,0.355,21532.841636721954,1474358.4466610814,700.0,158900.0,62627.722920343534,5621905.456602332,41094.88128362158,4147547.009941239,true,227.0,227,0.875,18841.23643213171,21532.841636721954,2691.6052045902434,0.0,0.0,227,51013.98244472508,0.0,18841.23643213171,18841.23643213171,965649.6123481105,700.0,158900.0,7003.0135080163955,234754.09219376772,8929.974131830124,489819.3424800007,0.0,0.0,2740.63294982968,231882.25610987257,167.61584245551103,9193.92156446972,-18841.23643213171,-1290063.640828446,true,true,24.40878001,2067.951182420001,0.0,1644.2724500334996,227.0,24.40878001,2067.951182420001,0.0,121.92,0.0 -228,43982.841636721954,43282.841636721954,0.35,17620.919794868005,1491979.3664559494,700.0,159600.0,52345.485128194305,5674250.941730526,34724.5653333263,4182271.5752745653,true,228.0,228,0.875,15418.304820509504,17620.919794868005,2202.614974358501,0.0,0.0,228,43282.841636721954,0.0,15418.304820509504,15418.304820509504,981067.91716862,700.0,159600.0,7158.774612409318,241912.86680617704,5397.417345321454,495216.75982532214,0.0,0.0,2760.80320139961,234643.05931127217,101.30966137912259,9295.231225848842,-15418.304820509504,-1305481.9456489554,true,true,24.54289418,2092.494076600001,0.0,1644.2724500334996,228.0,24.54289418,2092.494076600001,0.0,121.92,0.0 -229,40070.91979486801,39370.91979486801,0.33,13540.579463911852,1505519.9459198613,700.0,160300.0,43153.27110276319,5717404.212833289,29612.691638851335,4211884.266913417,true,229.0,229,0.875,11848.00703092287,13540.579463911852,1692.5724329889817,0.0,0.0,229,39370.91979486801,0.0,11848.00703092287,11848.00703092287,992915.924199543,700.0,160300.0,7237.513869214731,249150.3806753918,1805.7115820253287,497022.4714073475,0.0,0.0,2770.8883271845743,237413.94763845674,33.893252498236684,9329.12447834708,-11848.00703092287,-1317329.9526798783,true,true,24.58759891,2117.081675510001,0.0,1644.2724500334996,229.0,24.58759891,2117.081675510001,0.0,121.92,0.0 -230,35990.579463911854,35290.579463911854,0.29250000000000004,9335.768413572276,1514855.7143334337,700.0,161000.0,34310.31936264026,5751714.532195929,24974.550949067983,4236858.817862485,true,230.0,230,0.875,8168.7973618757405,9335.768413572276,1166.9710516965351,0.0,0.0,230,35290.579463911854,0.0,8168.7973618757405,8168.7973618757405,1001084.7215614187,700.0,161000.0,7237.513869214731,256387.89454460653,-1805.7115820253287,495216.75982532214,0.0,0.0,2770.8883271845743,240184.8359656413,-33.893252498236684,9295.231225848842,-8168.7973618757405,-1325498.750041754,true,true,24.54289418,2141.624569690001,0.0,1644.2724500334996,230.0,24.54289418,2141.624569690001,0.0,121.92,0.0 -231,31785.768413572274,31085.768413572274,0.22,5052.400922409543,1519908.1152558431,700.0,161700.0,26147.27692004338,5777861.809115972,21094.875997633837,4257953.693860118,true,231.0,231,0.875,4420.850807108351,5052.400922409543,631.5501153011928,0.0,0.0,231,31085.768413572274,0.0,4420.850807108351,4420.850807108351,1005505.5723685271,700.0,161700.0,7158.774612409318,263546.66915701586,-5397.417345321454,489819.3424800007,0.0,0.0,2760.80320139961,242945.6391670409,-101.30966137912259,9193.92156446972,-4420.850807108351,-1329919.6008488624,true,true,24.40878001,2166.033349700001,0.0,1644.2724500334996,231.0,24.40878001,2166.033349700001,0.0,121.92,0.0 -232,27502.400922409543,26802.400922409543,0.3175,11260.95518298232,1531169.0704388255,700.0,162400.0,37672.29978892069,5815534.1089048935,26411.34460593837,4284365.038466057,true,232.0,232,0.875,9853.33578510953,11260.95518298232,1407.6193978727897,0.0,0.0,232,26802.400922409543,0.0,9853.33578510953,9853.33578510953,1015358.9081536366,700.0,162400.0,7100.096427766651,270646.7655847825,0.0,489819.3424800007,0.0,0.0,2753.239357342879,245698.8785243838,0.0,9193.92156446972,-9853.33578510953,-1339772.936633972,true,true,24.40878001,2190.442129710001,0.0,1644.2724500334996,232.0,24.40878001,2190.442129710001,0.0,121.92,0.0 -233,33710.95518298232,33010.95518298232,0.33999999999999997,15497.0648254559,1546666.1352642814,700.0,163100.0,47638.42595722324,5863172.534862117,32141.361131767342,4316506.399597825,true,233.0,233,0.875,13559.931722273912,15497.0648254559,1937.1331031819882,0.0,0.0,233,33010.95518298232,0.0,13559.931722273912,13559.931722273912,1028918.8398759105,700.0,163100.0,7139.179439632134,277785.9450244146,3594.9922657898123,493414.3347457905,0.0,0.0,2758.281920235361,248457.16044461916,67.47809661660416,9261.399661086323,-13559.931722273912,-1353332.8683562458,true,true,24.49818946,2214.940319170001,0.0,1644.2724500334996,233.0,24.49818946,2214.940319170001,0.0,121.92,0.0 -234,37947.0648254559,37247.0648254559,0.35,17745.389573677432,1564411.5248379589,700.0,163800.0,52701.11306764981,5915873.647929767,34955.72349397237,4351462.123091797,true,234.0,234,0.875,15527.215876967752,17745.389573677432,2218.1736967096804,0.0,0.0,234,37247.0648254559,0.0,15527.215876967752,15527.215876967752,1044446.0557528783,700.0,163800.0,7237.513869214731,285023.4588936294,5417.133938236893,498831.46868402744,0.0,0.0,2770.8883271845743,251228.04877180373,101.67974233155273,9363.079403417876,-15527.215876967752,-1368860.0842332134,true,true,24.63230363,2239.572622800001,0.0,1644.2724500334996,234.0,24.63230363,2239.572622800001,0.0,121.92,0.0 -235,40195.38957367743,39495.38957367743,0.3516666666666666,20080.592215067383,1584492.1170530263,700.0,164500.0,59091.73141725323,5974965.379347021,39011.13920218585,4390473.262293983,true,235.0,235,0.875,17570.51818818396,20080.592215067383,2510.0740268834234,0.0,0.0,235,39495.38957367743,0.0,17570.51818818396,17570.51818818396,1062016.5739410622,700.0,164500.0,7376.693053191742,292400.15194682113,7268.851312673977,506100.31999670144,0.0,0.0,2788.5372975902546,254016.586069394,136.43652472798456,9499.51592814586,-17570.51818818396,-1386430.6024213973,true,true,24.81112254,2264.383745340001,0.0,1644.2724500334996,235.0,24.81112254,2264.383745340001,0.0,121.92,0.0 -236,42530.59221506739,41830.59221506739,0.33999999999999997,16027.194947086708,1600519.312000113,700.0,165200.0,49197.63219731385,6024163.011544335,33170.43725022714,4423643.69954421,true,236.0,236,0.875,14023.795578700869,16027.194947086708,2003.399368385839,0.0,0.0,236,41830.59221506739,0.0,14023.795578700869,14023.795578700869,1076040.3695197632,700.0,165200.0,7497.400204863716,299897.5521516848,3654.142047476386,509754.4620441778,0.0,0.0,2803.6649868316877,256820.25105622568,68.58833952907825,9568.104267674938,-14023.795578700869,-1400454.3980000983,true,true,24.90053199,2289.2842773300013,0.0,1644.2724500334996,236.0,24.90053199,2289.2842773300013,0.0,121.92,0.0 -237,38477.19494708671,37777.19494708671,0.35333333333333333,20484.392913896423,1621003.7049140094,700.0,165900.0,59955.82900159365,6084118.840545928,39471.43608769723,4463115.135631907,true,237.0,237,0.875,17923.84379965937,20484.392913896423,2560.549114237052,0.0,0.0,237,37777.19494708671,0.0,17923.84379965937,17923.84379965937,1093964.2133194224,700.0,165900.0,7619.417000905944,307516.9691525908,7347.717282253684,517102.1793264315,0.0,0.0,2818.7926755091344,259639.04373173483,137.91684099060788,9706.021108665547,-17923.84379965937,-1418378.2417997576,true,true,25.07935089,2314.3636282200014,0.0,1644.2724500334996,237.0,25.07935089,2314.3636282200014,0.0,121.92,0.0 -238,42934.39291389642,42234.39291389642,0.345,16388.085271623022,1637391.7901856324,700.0,166600.0,49530.6819467334,6133649.522492661,33142.59667511038,4496257.732307017,true,238.0,238,0.875,14339.574612670145,16388.085271623022,2048.510658952877,0.0,0.0,238,42234.39291389642,0.0,14339.574612670145,14339.574612670145,1108303.7879320926,700.0,166600.0,7742.75051224483,315259.7196648356,3693.575234777205,520795.75456120865,0.0,0.0,2833.920364186581,262472.96409592143,69.32850146152813,9775.349610127076,-14339.574612670145,-1432717.8164124277,true,true,25.16876034,2339.5323885600014,0.0,1644.2724500334996,238.0,25.16876034,2339.5323885600014,0.0,121.92,0.0 -239,38838.08527162302,38138.08527162302,0.35,18700.03413159407,1656091.8243172264,700.0,167300.0,55428.668947411636,6189078.191440073,36728.63481581757,4532986.367122835,true,239.0,239,0.875,16362.529865144814,18700.03413159407,2337.5042664492576,0.0,0.0,239,38138.08527162302,0.0,16362.529865144814,16362.529865144814,1124666.3177972373,700.0,167300.0,7846.539358308673,323106.25902314426,5565.008386204887,526360.7629474135,0.0,0.0,2846.526771135794,265319.49086705723,104.45534949545944,9879.804959622536,-16362.529865144814,-1449080.3462775724,true,true,25.30287451,2364.8352630700015,0.0,1644.2724500334996,239.0,25.30287451,2364.8352630700015,0.0,121.92,0.0 -240,41150.034131594075,40450.034131594075,0.335,14495.2732101463,1670587.0975273727,700.0,168000.0,45359.024507899405,6234437.215947973,30863.751297753104,4563850.118420588,true,240.0,240,0.875,12683.364058878013,14495.2732101463,1811.909151268288,0.0,0.0,240,40450.034131594075,0.0,12683.364058878013,12683.364058878013,1137349.6818561153,700.0,168000.0,7930.2350759464825,331036.49409909075,1861.5752706507171,528222.3382180642,0.0,0.0,2856.6118969207587,268176.102763978,34.94181536005417,9914.74677498259,-12683.364058878013,-1461763.7103364505,true,true,25.34757924,2390.1828423100014,0.0,1644.2724500334996,240.0,25.34757924,2390.1828423100014,0.0,121.92,0.0 -241,36945.273210146304,36245.273210146304,0.33,12354.725451367505,1682941.82297874,700.0,168700.0,39559.77409505304,6273996.990043025,27205.048643685535,4591055.167064274,true,241.0,241,0.875,10810.384769946568,12354.725451367505,1544.3406814209375,0.0,0.0,241,36245.273210146304,0.0,10810.384769946568,10810.384769946568,1148160.066626062,700.0,168700.0,7951.251591297574,338987.7456903883,0.0,528222.3382180642,0.0,0.0,2859.133178648993,271035.235942627,0.0,9914.74677498259,-10810.384769946568,-1472574.095106397,true,true,25.34757924,2415.5304215500014,0.0,1644.2724500334996,241.0,25.34757924,2415.5304215500014,0.0,121.92,0.0 -242,34804.72545136751,34104.72545136751,0.28625,7969.897460729621,1690911.7204394697,700.0,169400.0,30287.851391195185,6304284.841434221,22317.953930465563,4613373.120994739,true,242.0,242,0.875,6973.660278138419,7969.897460729621,996.2371825912023,0.0,0.0,242,34104.72545136751,0.0,6973.660278138419,6973.660278138419,1155133.7269042004,700.0,169400.0,7909.255631443072,346897.00132183137,-3719.864026311334,524502.4741917528,0.0,0.0,2854.0906157565105,273889.32655838353,-69.82194274983004,9844.92483223276,-6973.660278138419,-1479547.7553845355,true,true,25.25816979,2440.7885913400014,0.0,1644.2724500334996,242.0,25.25816979,2440.7885913400014,0.0,121.92,0.0 -243,30419.897460729622,29719.897460729622,0.3175,12247.378123651391,1703159.0985631212,700.0,170100.0,40779.14369653982,6345063.985130761,28531.765572888427,4641904.886567628,true,243.0,243,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,243,29719.897460729622,0.0,10716.455858194968,10716.455858194968,1165850.1827623954,700.0,170100.0,7867.407805330939,354764.4091271623,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,276738.37461124756,0.0,9844.92483223276,-10716.455858194968,-1490264.2112427305,true,true,25.25816979,2466.0467611300014,0.0,1644.2724500334996,243.0,25.25816979,2466.0467611300014,0.0,121.92,0.0 -244,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1715406.4766867727,700.0,170800.0,40779.14369653982,6385843.128827301,28531.765572888427,4670436.652140517,true,244.0,244,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,244,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1176566.6386205903,700.0,170800.0,7867.407805330939,362631.81693249324,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,279587.4226641116,0.0,9844.92483223276,-10716.455858194968,-1500980.6671009255,true,true,25.25816979,2491.3049309200014,0.0,1644.2724500334996,244.0,25.25816979,2491.3049309200014,0.0,121.92,0.0 -245,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1727653.8548104241,700.0,171500.0,40779.14369653982,6426622.272523841,28531.765572888427,4698968.417713406,true,245.0,245,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,245,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1187283.0944787853,700.0,171500.0,7867.407805330939,370499.2247378242,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,282436.47071697563,0.0,9844.92483223276,-10716.455858194968,-1511697.1229591204,true,true,25.25816979,2516.5631007100014,0.0,1644.2724500334996,245.0,25.25816979,2516.5631007100014,0.0,121.92,0.0 -246,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1739901.2329340756,700.0,172200.0,40779.14369653982,6467401.416220381,28531.765572888427,4727500.183286294,true,246.0,246,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,246,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1197999.5503369803,700.0,172200.0,7867.407805330939,378366.6325431551,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,285285.51876983966,0.0,9844.92483223276,-10716.455858194968,-1522413.5788173154,true,true,25.25816979,2541.8212705000014,0.0,1644.2724500334996,246.0,25.25816979,2541.8212705000014,0.0,121.92,0.0 -247,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1752148.6110577271,700.0,172900.0,40779.14369653982,6508180.559916921,28531.765572888427,4756031.948859183,true,247.0,247,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,247,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1208716.0061951752,700.0,172900.0,7867.407805330939,386234.04034848604,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,288134.5668227037,0.0,9844.92483223276,-10716.455858194968,-1533130.0346755104,true,true,25.25816979,2567.0794402900015,0.0,1644.2724500334996,247.0,25.25816979,2567.0794402900015,0.0,121.92,0.0 -248,34697.37812365139,33997.37812365139,0.30500000000000005,10060.85097415801,1762209.462031885,700.0,173600.0,35281.47860379674,6543462.038520718,25220.627629638733,4781252.576488822,true,248.0,248,0.875,8803.244602388258,10060.85097415801,1257.6063717697507,0.0,0.0,248,33997.37812365139,0.0,8803.244602388258,8803.244602388258,1217519.2507975635,700.0,173600.0,7846.539358308673,394080.5797067947,-1855.0030720320276,522647.47111972084,0.0,0.0,2846.526771135794,290981.0935938395,-34.8184550241824,9810.106377208578,-8803.244602388258,-1541933.2792778986,true,true,25.21346506,2592.2929053500015,0.0,1644.2724500334996,248.0,25.21346506,2592.2929053500015,0.0,121.92,0.0 -249,32510.85097415801,31810.85097415801,0.23500000000000001,5657.713358670035,1767867.175390555,700.0,174300.0,27054.099398595892,6570516.137919314,21396.386039925856,4802648.9625287475,true,249.0,249,0.875,4950.49918883628,5657.713358670035,707.2141698337546,0.0,0.0,249,31810.85097415801,0.0,4950.49918883628,4950.49918883628,1222469.7499863997,700.0,174300.0,7763.434605317927,401844.01431211265,-5545.291793289447,517102.1793264314,0.0,0.0,2836.4416453508297,293817.5352391903,-104.0852685430293,9706.021108665549,-4950.49918883628,-1546883.7784667348,true,true,25.07935089,2617.3722562400017,0.0,1644.2724500334996,249.0,25.07935089,2617.3722562400017,0.0,121.92,0.0 -250,28107.713358670037,27407.713358670037,0.23500000000000001,5533.654218389586,1773400.8296089447,700.0,175000.0,26526.18816335994,6597042.326082674,20992.533944970353,4823641.4964737175,true,250.0,250,0.875,4841.947441090888,5533.654218389586,691.7067772986984,0.0,0.0,250,27407.713358670037,0.0,4841.947441090888,4841.947441090888,1227311.6974274905,700.0,175000.0,7639.8809544382,409483.8952665508,-5515.717315186754,511586.4620112447,0.0,0.0,2821.313956673383,296638.8491958637,-103.5301548339413,9602.490953831608,-4841.947441090888,-1551725.7259078256,true,true,24.94523671,2642.3174929500015,0.0,1644.2724500334996,250.0,24.94523671,2642.3174929500015,0.0,121.92,0.0 -251,27983.654218389587,27283.654218389587,0.12,0.0,1773400.8296089447,700.0,175700.0,5833.333333333334,6602875.659416007,5833.333333333334,4829474.8298070505,true,251.0,251,0.875,0.0,0.0,0.0,0.0,0.0,251,27283.654218389587,0.0,-2761.4203759212214,-2761.4203759212214,1224550.2770515692,700.0,175700.0,7436.883360062817,416920.77862661367,-12754.993327217295,498831.4686840274,0.0,0.0,2796.1011416469855,299434.9503375107,-239.4115504137294,9363.079403417878,-0.0,-1551725.7259078256,true,true,24.63230363,2666.9497965800015,0.0,1644.2724500334996,251.0,24.63230363,2666.9497965800015,0.0,121.92,0.0 -252,22450.0,21750.0,0.14800000000000002,894.4390689274421,1774295.2686778721,700.0,176400.0,10773.236952212445,6613648.8963682195,9878.797883285002,4839353.627690336,true,252.0,252,0.875,782.6341853115118,894.4390689274421,111.8048836159303,0.0,0.0,252,21750.0,0.0,782.6341853115118,782.6341853115118,1225332.9112368808,700.0,176400.0,7198.072463994284,424118.85109060793,-9012.126204026707,489819.3424800007,0.0,0.0,2765.8457642920916,302200.7961018028,-169.1578389481569,9193.921564469721,-782.6341853115118,-1552508.3600931372,true,true,24.40878001,2691.3585765900016,0.0,1644.2724500334996,252.0,24.40878001,2691.3585765900016,0.0,121.92,0.0 -253,23344.43906892744,22644.43906892744,0.1888,2835.137938625249,1777130.4066164973,700.0,177100.0,18724.2475562778,6632373.143924497,15889.109617652553,4855242.737307988,true,253.0,253,0.875,2480.7456962970928,2835.137938625249,354.39224232815604,0.0,0.0,253,22644.43906892744,0.0,2480.7456962970928,2480.7456962970928,1227813.656933178,700.0,177100.0,7022.358840318837,431141.2099309268,-7150.551344278899,482668.7911357218,0.0,0.0,2743.1542315579145,304943.9503333607,-134.21603130075994,9059.70553316896,-2480.7456962970928,-1554989.1057894344,true,true,24.22996111,2715.588537700002,0.0,1644.2724500334996,253.0,24.22996111,2715.588537700002,0.0,121.92,0.0 -254,25285.13793862525,24585.13793862525,0.265,6871.484747150224,1784001.8913636475,700.0,177800.0,28571.640555283866,6660944.784479781,21700.15580813364,4876942.893116122,true,254.0,254,0.875,6012.549153756447,6871.484747150224,858.9355933937777,0.0,0.0,254,24585.13793862525,0.0,6012.549153756447,6012.549153756447,1233826.2060869343,700.0,177800.0,6906.819624049127,438048.0295549759,-3555.5590784889932,479113.2320572328,0.0,0.0,2728.0265428804673,307671.97687624115,-66.73793468415427,8992.967598484807,-6012.549153756447,-1561001.6549431907,true,true,24.14055166,2739.7290893600016,0.0,1644.2724500334996,254.0,24.14055166,2739.7290893600016,0.0,121.92,0.0 -255,29321.484747150225,28621.484747150225,0.22,4706.963926496867,1788708.8552901444,700.0,178500.0,24577.108756803944,6685521.893236585,19870.144830307076,4896813.037946429,true,255.0,255,0.875,4118.593435684759,4706.963926496867,588.3704908121081,0.0,0.0,255,28621.484747150225,0.0,4118.593435684759,4118.593435684759,1237944.799522619,700.0,178500.0,6811.510677876555,444859.54023285245,-5308.693073036055,473804.5389841968,0.0,0.0,2715.420135367269,310387.3970116084,-99.64430452300941,8893.323293961797,-4118.593435684759,-1565120.2483788754,true,true,24.00643748,2763.7355268400015,0.0,1644.2724500334996,255.0,24.00643748,2763.7355268400015,0.0,121.92,0.0 -256,27156.96392649687,26456.96392649687,0.29250000000000004,8737.313877614573,1797446.1691677591,700.0,179200.0,32264.32094910965,6717786.214185694,23527.007071495078,4920340.045017924,true,256.0,256,0.875,7645.149642912752,8737.313877614573,1092.1642347018214,0.0,0.0,256,26456.96392649687,0.0,7645.149642912752,7645.149642912752,1245589.9491655317,700.0,179200.0,6735.897932884319,451595.4381657368,-1762.9918966410187,472041.54708755575,0.0,0.0,2705.335009582304,313092.7320211907,-33.091402912852246,8860.231891048945,-7645.149642912752,-1572765.398021788,true,true,23.96173276,2787.6972596000014,0.0,1644.2724500334996,256.0,23.96173276,2787.6972596000014,0.0,121.92,0.0 -257,31187.31387761457,30487.31387761457,0.345,17008.348774698465,1814454.5179424577,700.0,179900.0,51328.547173039035,6769114.761358733,34320.198398340566,4954660.243416265,true,257.0,257,0.875,14882.305177861155,17008.348774698465,2126.0435968373095,0.0,0.0,257,30487.31387761457,0.0,14882.305177861155,14882.305177861155,1260472.2543433928,700.0,179900.0,6773.6339680248475,458369.07213376166,5298.834380744538,477340.3814683003,0.0,0.0,2710.377572474786,315803.10959366546,99.4592566169838,8959.691147665928,-14882.305177861155,-1587647.7031996492,true,true,24.09584693,2811.7931065300013,0.0,1644.2724500334996,257.0,24.09584693,2811.7931065300013,0.0,121.92,0.0 -258,39458.34877469846,38758.34877469846,0.33,13001.277785338274,1827455.795727796,700.0,180600.0,41519.023591934165,6810633.784950667,28517.745806595893,4983177.989222861,true,258.0,258,0.875,11376.11806217099,13001.277785338274,1625.159723167284,0.0,0.0,258,38758.34877469846,0.0,11376.11806217099,11376.11806217099,1271848.3724055637,700.0,180600.0,6849.528324159826,465218.6004579215,1772.8505889325352,479113.2320572328,0.0,0.0,2720.462698259751,318523.5722919252,33.276450818877855,8992.967598484805,-11376.11806217099,-1599023.8212618202,true,true,24.14055166,2835.933658190001,0.0,1644.2724500334996,258.0,24.14055166,2835.933658190001,0.0,121.92,0.0 -259,35451.27778533827,34751.27778533827,0.33,13054.476393387953,1840510.2721211838,700.0,181300.0,41680.231495115004,6852314.016445782,28625.755101727053,5011803.744324588,true,259.0,259,0.875,11422.666844214458,13054.476393387953,1631.8095491734948,0.0,0.0,259,34751.27778533827,0.0,11422.666844214458,11422.666844214458,1283271.0392497783,700.0,181300.0,6887.687168595054,472106.28762651654,1776.1362909377685,480889.3683481706,0.0,0.0,2725.5052611522333,321249.0775530774,33.33812352940316,9026.30572201421,-11422.666844214458,-1610446.4881060347,true,true,24.18525638,2860.118914570001,0.0,1644.2724500334996,259.0,24.18525638,2860.118914570001,0.0,121.92,0.0 -260,35504.47639338795,34804.47639338795,0.30500000000000005,11011.252756665037,1851521.5248778488,700.0,182000.0,38397.55002185257,6890711.566467634,27386.29726518753,5039190.041589776,true,260.0,260,0.875,9634.846162081907,11011.252756665037,1376.4065945831298,0.0,0.0,260,34804.47639338795,0.0,9634.846162081907,9634.846162081907,1292905.8854118602,700.0,182000.0,6906.819619765426,479013.107246282,0.0,480889.3683481706,0.0,0.0,2728.0265423164815,323977.1040953939,0.0,9026.30572201421,-9634.846162081907,-1620081.3342681166,true,true,24.18525638,2884.3041709500008,0.0,1644.2724500334996,260.0,24.18525638,2884.3041709500008,0.0,121.92,0.0 -261,33461.25275666504,32761.25275666504,0.22,4744.697955646035,1856266.222833495,700.0,182700.0,24748.62707111834,6915460.193538752,20003.929115472303,5059193.970705248,true,261.0,261,0.875,4151.61071119028,4744.697955646035,593.0872444557544,0.0,0.0,261,32761.25275666504,0.0,4151.61071119028,4151.61071119028,1297057.4961230506,700.0,182700.0,6849.5283241598245,485862.63557044184,-5318.550973659884,475570.8173745107,0.0,0.0,2720.4626982597506,326697.56679365365,-99.82933756941095,8926.476384444799,-4151.61071119028,-1624232.944979307,true,true,24.05114221,2908.3553131600006,0.0,1644.2724500334996,261.0,24.05114221,2908.3553131600006,0.0,121.92,0.0 -262,27194.697955646036,26494.697955646036,0.184,2562.5799635549047,1858828.8027970497,700.0,183400.0,17731.412845407092,6933191.606384159,15168.832881852188,5074362.8035871005,true,262.0,262,0.875,2242.2574681105416,2562.5799635549047,320.3224954443631,0.0,0.0,262,26494.697955646036,0.0,2242.2574681105416,2242.2574681105416,1299299.7535911612,700.0,183400.0,6717.082584440681,492579.71815488255,-7045.3965706689305,468525.4208038418,0.0,0.0,2702.8137278540703,329400.3805215077,-132.24227351527915,8794.23411092952,-2242.2574681105416,-1626475.2024474177,true,true,23.8723233,2932.2276364600007,0.0,1644.2724500334996,262.0,23.8723233,2932.2276364600007,0.0,121.92,0.0 -263,25012.579963554905,24312.579963554905,0.1792,2430.1589723205657,1861258.9617693704,700.0,184100.0,17467.404979467443,6950659.011363626,15037.246007146878,5089400.049594248,true,263.0,263,0.875,2126.389100780495,2430.1589723205657,303.76987154007065,0.0,0.0,263,24312.579963554905,0.0,2126.389100780495,2126.389100780495,1301426.1426919417,700.0,184100.0,6567.8196007111965,499147.5377555937,-6992.818592135086,461532.6022117067,0.0,0.0,2682.6434757201555,332083.02399722784,-131.25538351577077,8662.978727413749,-2126.389100780495,-1628601.5915481981,true,true,23.6935044,2955.921140860001,0.0,1644.2724500334996,263.0,23.6935044,2955.921140860001,0.0,121.92,0.0 -264,24880.158972320565,24180.158972320565,0.1768,2300.283542073498,1863559.245311444,700.0,184800.0,16969.929536614807,6967628.940900241,14669.645994541308,5104069.695588789,true,264.0,264,0.875,2012.7480993143108,2300.283542073498,287.5354427591874,0.0,0.0,264,24180.158972320565,0.0,2012.7480993143108,2012.7480993143108,1303438.890791256,700.0,184800.0,6420.7843851702655,505568.322140764,-6940.241009067015,454592.3612026397,0.0,0.0,2662.4732241502256,334745.4972213781,-130.26850093916545,8532.710226474583,-2012.7480993143108,-1630614.3396475124,true,true,23.5146855,2979.4358263600006,0.0,1644.2724500334996,264.0,23.5146855,2979.4358263600006,0.0,121.92,0.0 -265,24750.2835420735,24050.2835420735,0.124,154.26493346921157,1863713.5102449132,700.0,185500.0,6889.2333344291255,6974518.174234671,6734.968400959914,5110804.663989749,true,265.0,265,0.875,134.9818167855601,154.26493346921157,19.283116683651457,0.0,0.0,265,24050.2835420735,0.0,134.9818167855601,134.9818167855601,1303573.8726080416,700.0,185500.0,6258.011787985309,511826.3339287493,-8601.363843659363,445990.99735898036,0.0,0.0,2639.7816914160485,337385.27891279414,-161.44781895643413,8371.262407518148,-134.9818167855601,-1630749.321464298,true,true,23.29116188,3002.7269882400005,0.0,1644.2724500334996,265.0,23.29116188,3002.7269882400005,0.0,121.92,0.0 -266,22604.26493346921,21904.26493346921,0.33999999999999997,16119.54334734692,1879833.05359226,700.0,186200.0,49469.245139255654,7023987.419373926,33349.70179190874,5144154.365781657,true,266.0,266,0.875,14104.600428928556,16119.54334734692,2014.9429184183646,0.0,0.0,266,21904.26493346921,0.0,14104.600428928556,14104.600428928556,1317678.4730369702,700.0,186200.0,6222.217718175461,518048.55164692475,5150.959932776452,451141.9572917568,0.0,0.0,2634.739128523566,340020.0180413177,96.68364945307559,8467.946056971225,-14104.600428928556,-1644853.9218932267,true,true,23.42527605,3026.1522642900004,0.0,1644.2724500334996,266.0,23.42527605,3026.1522642900004,0.0,121.92,0.0 -267,38569.54334734692,37869.54334734692,0.1744,2110.2023014050033,1881943.255893665,700.0,186900.0,16113.54530622135,7040100.964680147,14003.343004816346,5158157.708786474,true,267.0,267,0.875,1846.427013729378,2110.2023014050033,263.77528767562535,0.0,0.0,267,37869.54334734692,0.0,1846.427013729378,1846.427013729378,1319524.9000506997,700.0,186900.0,6204.3719784734985,524252.92362539825,-6861.374634465189,444280.5826572916,0.0,0.0,2632.2178467953327,342652.23588811303,-128.78817707426418,8339.15787989696,-1846.427013729378,-1646700.3489069561,true,true,23.24645715,3049.3987214400004,0.0,1644.2724500334996,267.0,23.24645715,3049.3987214400004,0.0,121.92,0.0 -268,24560.202301405003,23860.202301405003,0.28625,7995.537524965263,1889938.7934186303,700.0,187600.0,30377.423668000923,7070478.388348148,22381.88614303566,5180539.594929509,true,268.0,268,0.875,6996.095334344605,7995.537524965263,999.442190620658,0.0,0.0,268,23860.202301405003,0.0,6996.095334344605,6996.095334344605,1326520.9953850443,700.0,187600.0,6115.654955296027,530368.5785806943,-1707.12822051195,442573.45443677966,0.0,0.0,2619.611439846119,345271.84732795914,-32.042840285590316,8307.11503961137,-6996.095334344605,-1653696.4442413007,true,true,23.20175243,3072.6004738700003,0.0,1644.2724500334996,268.0,23.20175243,3072.6004738700003,0.0,121.92,0.0 -269,30445.537524965264,29745.537524965264,0.25,5950.378200626575,1895889.1716192567,700.0,188300.0,26601.5128025063,7097079.901150654,20651.134601879723,5201190.729531389,true,269.0,269,0.875,5206.580925548253,5950.378200626575,743.797275078322,0.0,0.0,269,29745.537524965264,0.0,5206.580925548253,5206.580925548253,1331727.5763105925,700.0,188300.0,6062.832891182222,536431.4114718765,-3404.39890646357,439169.0555303161,0.0,0.0,2612.047595225403,347883.89492318453,-63.90065439580226,8243.214385215568,-5206.580925548253,-1658903.025166849,true,true,23.11234297,3095.7128168400004,0.0,1644.2724500334996,269.0,23.11234297,3095.7128168400004,0.0,121.92,0.0 -270,28400.378200626576,27700.378200626576,0.25,5874.208263532774,1901763.3798827894,700.0,189000.0,26296.833054131097,7123376.734204785,20422.624790598322,5221613.354321987,true,270.0,270,0.875,5139.932230591177,5874.208263532774,734.2760329415969,0.0,0.0,270,27700.378200626576,0.0,5139.932230591177,5139.932230591177,1336867.5085411835,700.0,189000.0,5992.877817502228,542424.2892893788,-3391.254129196618,435777.80140111945,0.0,0.0,2601.9624688764525,350485.857392061,-63.65392659088444,8179.560458624684,-5139.932230591177,-1664042.95739744,true,true,23.02293352,3118.7357503600006,0.0,1644.2724500334996,270.0,23.02293352,3118.7357503600006,0.0,121.92,0.0 -271,28324.208263532775,27624.208263532775,0.3175,11772.222923296884,1913535.6028060864,700.0,189700.0,39282.59188439963,7162659.326089185,27510.36896110275,5249123.72328309,true,271.0,271,0.875,10300.695057884774,11772.222923296884,1471.5278654121103,0.0,0.0,271,27624.208263532775,0.0,10300.695057884774,10300.695057884774,1347168.2035990683,700.0,189700.0,5975.473538623031,548399.7628280019,1693.9842047749257,437471.78560589434,0.0,0.0,2599.4411877122043,353085.29857977317,31.796126774612166,8211.356585399295,-10300.695057884774,-1674343.6524553248,true,true,23.06763825,3141.8033886100006,0.0,1644.2724500334996,271.0,23.06763825,3141.8033886100006,0.0,121.92,0.0 -272,34222.22292329688,33522.22292329688,0.335,13824.452969878786,1927360.055775965,700.0,190400.0,43356.57602948891,7206015.902118674,29532.123059610123,5278655.8463427,true,272.0,272,0.875,12096.396348643939,13824.452969878786,1728.0566212348476,0.0,0.0,272,33522.22292329688,0.0,12096.396348643939,12096.396348643939,1359264.5999477124,700.0,190400.0,6027.78770156914,554427.550529571,3397.8263278151207,440869.6119337095,0.0,0.0,2607.0050323329206,355692.3036121061,63.7772869267577,8275.133872326052,-12096.396348643939,-1686440.0488039688,true,true,23.1570477,3164.9604363100007,0.0,1644.2724500334996,272.0,23.1570477,3164.9604363100007,0.0,121.92,0.0 -273,36274.45296987879,35574.45296987879,0.33999999999999997,15946.034692120082,1943306.0904680851,700.0,191100.0,48958.92556505907,7254974.827683733,33012.89087293899,5311668.737215638,true,273.0,273,0.875,13952.780355605071,15946.034692120082,1993.2543365150104,0.0,0.0,273,35574.45296987879,0.0,13952.780355605071,13952.780355605071,1373217.3803033174,700.0,191100.0,6115.654955296027,560543.2054848671,5121.385425270829,445990.9973589803,0.0,0.0,2619.611439846119,358311.9150519522,96.12853519209577,8371.262407518148,-13952.780355605071,-1700392.829159574,true,true,23.29116188,3188.2515981900005,0.0,1644.2724500334996,273.0,23.29116188,3188.2515981900005,0.0,121.92,0.0 -274,38396.03469212008,37696.03469212008,0.35,18149.61369692742,1961455.7041650126,700.0,191800.0,53856.039134078346,7308830.8668178115,35706.42543715093,5347375.162652789,true,274.0,274,0.875,15880.911984811493,18149.61369692742,2268.701712115926,0.0,0.0,274,37696.03469212008,0.0,15880.911984811493,15880.911984811493,1389098.292288129,700.0,191800.0,6240.097645111396,566783.3031299785,6874.519031702288,452865.5163906826,0.0,0.0,2637.2604102518003,360949.175462204,129.03489774600922,8500.297305264157,-15880.911984811493,-1716273.7411443854,true,true,23.46998078,3211.7215789700003,0.0,1644.2724500334996,274.0,23.46998078,3211.7215789700003,0.0,121.92,0.0 -275,40599.61369692742,39899.61369692742,0.35333333333333333,20448.319973537084,1981904.0241385496,700.0,192500.0,59853.735774161556,7368684.602591973,39405.41580062447,5386780.578453413,true,275.0,275,0.875,17892.279976844948,20448.319973537084,2556.039996692136,0.0,0.0,275,39899.61369692742,0.0,17892.279976844948,17892.279976844948,1406990.572264974,700.0,192500.0,6402.560790685292,573185.8639206637,8667.08582102409,461532.6022117067,0.0,0.0,2659.9519429859774,363609.12740518997,162.68142214959036,8662.978727413747,-17892.279976844948,-1734166.0211212304,true,true,23.6935044,3235.4150833700005,0.0,1644.2724500334996,275.0,23.6935044,3235.4150833700005,0.0,121.92,0.0 -276,42898.31997353709,42198.31997353709,0.35333333333333333,20782.836772532737,2002686.8609110822,700.0,193200.0,60800.481431696426,7429485.084023669,40017.64465916369,5426798.223112577,true,276.0,276,0.875,18184.982175966146,20782.836772532737,2597.8545965665908,0.0,0.0,276,42198.31997353709,0.0,18184.982175966146,18184.982175966146,1425175.5544409403,700.0,193200.0,6586.355300875975,579772.2192215397,8749.238684153715,470281.8408958604,0.0,0.0,2685.164757448389,366294.29216263833,164.2234334880662,8827.202160901814,-18184.982175966146,-1752351.0032971967,true,true,23.91702803,3259.3321114000005,0.0,1644.2724500334996,276.0,23.91702803,3259.3321114000005,0.0,121.92,0.0 -277,43232.83677253274,42532.83677253274,0.35333333333333333,21121.335016520046,2023808.1959276022,700.0,193900.0,61758.495329773716,7491243.579353443,40637.16031325367,5467435.38342583,true,277.0,277,0.875,18481.16813945504,21121.335016520046,2640.1668770650067,0.0,0.0,277,42532.83677253274,0.0,18481.16813945504,18481.16813945504,1443656.7225803954,700.0,193900.0,6773.6339680248475,586545.8531895645,8831.391161372416,479113.2320572328,0.0,0.0,2710.377572474786,369004.6697351131,165.7654375829915,8992.967598484805,-18481.16813945504,-1770832.1714366518,true,true,24.14055166,3283.4726630600003,0.0,1644.2724500334996,277.0,24.14055166,3283.4726630600003,0.0,121.92,0.0 -278,43571.335016520046,42871.335016520046,0.3585,29935.093337644474,2053743.2892652466,700.0,194600.0,85453.53790137928,7576697.1172548225,55518.44456373481,5522953.827989565,true,278.0,278,0.875,26193.206670438914,29935.093337644474,3741.886667205559,0.0,0.0,278,42871.335016520046,0.0,26193.206670438914,26193.206670438914,1469849.9292508343,700.0,194600.0,7041.739762263368,593587.5929518279,16103.527768089347,495216.75982532214,0.0,0.0,2745.6755127221627,371750.34524783527,302.2636273640368,9295.231225848842,-26193.206670438914,-1797025.3781070907,true,true,24.54289418,3308.0155572400004,0.0,1644.2724500334996,278.0,24.54289418,3308.0155572400004,0.0,121.92,0.0 -279,52385.093337644474,51685.093337644474,0.355,22090.63197920612,2075833.9212444527,700.0,195300.0,64198.96332170738,7640896.08057653,42108.33134250126,5565062.159332067,true,279.0,279,0.875,19329.302981805355,22090.63197920612,2761.328997400764,0.0,0.0,279,51685.093337644474,0.0,19329.302981805355,19329.302981805355,1489179.2322326396,700.0,195300.0,7316.82838744362,600904.4213392716,9061.418092439995,504278.17791776214,0.0,0.0,2780.973452969539,374531.3187008048,170.08304895220277,9465.314274801045,-19329.302981805355,-1816354.681088896,true,true,24.76641781,3332.7819750500003,0.0,1644.2724500334996,279.0,24.76641781,3332.7819750500003,0.0,121.92,0.0 -280,44540.63197920612,43840.63197920612,0.33999999999999997,15967.630363967744,2091801.5516084204,700.0,196000.0,49022.442246963954,7689918.522823494,33054.81188299621,5598116.971215063,true,280.0,280,0.875,13971.676568471776,15967.630363967744,1995.9537954959687,0.0,0.0,280,43840.63197920612,0.0,13971.676568471776,13971.676568471776,1503150.9088011114,700.0,196000.0,7457.019317045467,608361.440656317,3647.5698488578832,507925.74776662,0.0,0.0,2798.62242337522,377329.94112418,68.464979193205,9533.77925399425,-13971.676568471776,-1830326.3576573678,true,true,24.85582726,3357.63780231,0.0,1644.2724500334996,280.0,24.85582726,3357.63780231,0.0,121.92,0.0 -281,38417.63036396774,37717.63036396774,0.35333333333333333,20416.67645217178,2112218.2280605924,700.0,196700.0,59764.17863822202,7749682.701461716,39347.502186050246,5637464.473401113,true,281.0,281,0.875,17864.59189565031,20416.67645217178,2552.084556521473,0.0,0.0,281,37717.63036396774,0.0,17864.59189565031,17864.59189565031,1521015.5006967618,700.0,196700.0,7578.598778262287,615940.0394345793,7334.572885016492,515260.3206516365,0.0,0.0,2813.7501120526667,380143.69123623264,137.67012031886284,9671.449374313112,-17864.59189565031,-1848190.9495530182,true,true,25.03464616,3382.6724484700003,0.0,1644.2724500334996,281.0,25.03464616,3382.6724484700003,0.0,121.92,0.0 -282,42866.676452171785,42166.676452171785,0.3175,11981.962004502686,2124200.190065095,700.0,197400.0,39943.18741575649,7789625.888877472,27961.225411253803,5665425.698812367,true,282.0,282,0.875,10484.21675393985,11981.962004502686,1497.7452505628353,0.0,0.0,282,42166.676452171785,0.0,10484.21675393985,10484.21675393985,1531499.7174507016,700.0,197400.0,7660.38151610222,623600.4209506816,0.0,515260.3206516365,0.0,0.0,2823.835237837631,382967.52647407027,0.0,9671.449374313112,-10484.21675393985,-1858675.166306958,true,true,25.03464616,3407.7070946300005,0.0,1644.2724500334996,282.0,25.03464616,3407.7070946300005,0.0,121.92,0.0 -283,34431.96200450268,33731.96200450268,0.28,7651.877269033446,2131852.0673341285,700.0,198100.0,29828.133103690878,7819454.021981163,22176.25583465743,5687601.954647025,true,283.0,283,0.875,6695.392610404266,7651.877269033446,956.4846586291806,0.0,0.0,283,33731.96200450268,0.0,6695.392610404266,6695.392610404266,1538195.1100611058,700.0,198100.0,7619.416996332449,631219.837947014,-3673.8586403918252,511586.4620112447,0.0,0.0,2818.7926749451485,385786.3191490154,-68.9584204815069,9602.490953831604,-6695.392610404266,-1865370.5589173622,true,true,24.94523671,3432.6523313400003,0.0,1644.2724500334996,283.0,24.94523671,3432.6523313400003,0.0,121.92,0.0 -284,30101.877269033444,29401.877269033444,0.12,0.0,2131852.0673341285,700.0,198800.0,5833.333333333334,7825287.355314496,5833.333333333334,5693435.287980358,true,284.0,284,0.875,0.0,0.0,0.0,0.0,0.0,284,29401.877269033444,0.0,-892.4627437324007,-892.4627437324007,1537302.6473173734,700.0,198800.0,7457.019317045463,638676.8572640595,-10942.709546573462,500643.7524646712,0.0,0.0,2798.6224233752196,388584.9415723906,-205.39493757962094,9397.096016251984,-0.0,-1865370.5589173622,true,true,24.67700836,3457.3293397,0.0,1644.2724500334996,284.0,24.67700836,3457.3293397,0.0,121.92,0.0 -285,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,199500.0,5833.333333333334,7831120.688647829,5833.333333333334,5699268.621313691,true,285.0,285,0.875,0.0,0.0,0.0,0.0,0.0,285,21750.0,0.0,-2889.8799247811494,-2889.8799247811494,1534412.7673925923,700.0,199500.0,7198.072463994284,645874.9297280537,-12616.977169458767,488026.77529521246,0.0,0.0,2765.8457642920916,391350.7873366827,-236.8209836087585,9160.275032643225,-0.0,-1865370.5589173622,true,true,24.36407528,3481.6934149800004,0.0,1644.2724500334996,285.0,24.36407528,3481.6934149800004,0.0,121.92,0.0 -286,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,200200.0,5833.333333333334,7836954.021981162,5833.333333333334,5705101.954647024,true,286.0,286,0.875,0.0,0.0,0.0,0.0,0.0,286,21750.0,0.0,-6672.0789195037305,-6672.0789195037305,1527740.6884730884,700.0,200200.0,6887.687168595054,652762.6168966488,-15985.228207656735,472041.54708755575,0.0,0.0,2725.5052611522333,394076.29259783495,-300.0431415942827,8860.231891048943,-0.0,-1865370.5589173622,true,true,23.96173276,3505.6551477400003,0.0,1644.2724500334996,286.0,23.96173276,3505.6551477400003,0.0,121.92,0.0 -287,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,200900.0,5833.333333333334,7842787.355314495,5833.333333333334,5710935.287980357,true,287.0,287,0.875,0.0,0.0,0.0,0.0,0.0,287,21750.0,0.0,-10348.464415796621,-10348.464415796621,1517392.2240572919,700.0,200900.0,6512.421234633904,659275.0381312827,-19176.03069687315,452865.5163906826,0.0,0.0,2675.0796322274105,396751.3722300624,-359.9345857847864,8500.297305264157,-0.0,-1865370.5589173622,true,true,23.46998078,3529.12512852,0.0,1644.2724500334996,287.0,23.46998078,3529.12512852,0.0,121.92,0.0 -288,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,201600.0,5833.333333333334,7848620.688647828,5833.333333333334,5716768.62131369,true,288.0,288,0.875,0.0,0.0,0.0,0.0,0.0,288,21750.0,0.0,-8652.988869572982,-8652.988869572982,1508739.2351877189,700.0,201600.0,6133.330245619286,665408.368376902,-17087.714989563163,435777.80140111945,0.0,0.0,2622.1327210103673,399373.50495107274,-320.73684663947483,8179.560458624683,-0.0,-1865370.5589173622,true,true,23.02293352,3552.1480620400002,0.0,1644.2724500334996,288.0,23.02293352,3552.1480620400002,0.0,121.92,0.0 -289,22450.0,21750.0,0.30500000000000005,9777.169018347473,2141629.236352476,700.0,202300.0,34351.37383064745,7882972.062478475,24574.204812299977,5741342.826125991,true,289.0,289,0.875,8555.022891054039,9777.169018347473,1222.146127293434,0.0,0.0,289,21750.0,0.0,8555.022891054039,8555.022891054039,1517294.2580787728,700.0,202300.0,5958.102985070068,671366.471361972,0.0,435777.80140111945,0.0,0.0,2596.9199059839702,401970.4248570567,0.0,8179.560458624683,-8555.022891054039,-1873925.5818084162,true,true,23.02293352,3575.1709955600004,0.0,1644.2724500334996,289.0,23.02293352,3575.1709955600004,0.0,121.92,0.0 -290,32227.16901834747,31527.16901834747,0.30500000000000005,9777.169018347473,2151406.405370823,700.0,203000.0,34351.37383064745,7917323.4363091225,24574.204812299977,5765917.030938291,true,290.0,290,0.875,8555.022891054039,9777.169018347473,1222.146127293434,0.0,0.0,290,31527.16901834747,0.0,8555.022891054039,8555.022891054039,1525849.2809698267,700.0,203000.0,5958.102985070068,677324.5743470421,0.0,435777.80140111945,0.0,0.0,2596.9199059839702,404567.34476304066,0.0,8179.560458624683,-8555.022891054039,-1882480.60469947,true,true,23.02293352,3598.1939290800005,0.0,1644.2724500334996,290.0,23.02293352,3598.1939290800005,0.0,121.92,0.0 -291,32227.16901834747,31527.16901834747,0.1696,1835.5993535425316,2153242.0047243657,700.0,203700.0,14950.467886453605,7932273.904195576,13114.868532911074,5779031.899471202,true,291.0,291,0.875,1606.1494343497152,1835.5993535425316,229.44991919281642,0.0,0.0,291,31527.16901834747,0.0,1606.1494343497152,1606.1494343497152,1527455.4304041765,700.0,203700.0,5888.957416492257,683213.5317635344,-6743.075071092229,429034.7263300272,0.0,0.0,2586.8347801990058,407154.17954323965,-126.56769124931749,8052.9927673753655,-1606.1494343497152,-1884086.7541338198,true,true,22.84411462,3621.0380437000003,0.0,1644.2724500334996,291.0,22.84411462,3621.0380437000003,0.0,121.92,0.0 -292,24285.59935354253,23585.59935354253,0.12,0.0,2153242.0047243657,700.0,204400.0,5833.333333333334,7938107.237528909,5833.333333333334,5784865.232804535,true,292.0,292,0.875,0.0,0.0,0.0,0.0,0.0,292,23585.59935354253,0.0,-8737.062071870416,-8737.062071870416,1518718.3683323062,700.0,204400.0,5651.163456837206,688864.6952203716,-16627.660751808584,412407.0655782186,0.0,0.0,2551.5368399516296,409705.7163831913,-312.1016168506692,7740.891150524696,-0.0,-1884086.7541338198,true,true,22.39706737,3643.4351110700004,0.0,1644.2724500334996,292.0,22.39706737,3643.4351110700004,0.0,121.92,0.0 -293,22450.0,21750.0,0.28,7219.567138277719,2160461.5718626436,700.0,205100.0,28284.16835099185,7966391.405879901,21064.601212714133,5805929.834017249,true,293.0,293,0.875,6317.121245993004,7219.567138277719,902.4458922847152,0.0,0.0,293,21750.0,0.0,6317.121245993004,6317.121245993004,1525035.4895782992,700.0,205100.0,5468.882141248776,694333.5773616204,-1644.6927147680865,410762.3728634505,0.0,0.0,2523.802743760984,412229.5191269523,-30.870924248669432,7710.020226276027,-6317.121245993004,-1890403.875379813,true,true,22.35236264,3665.7874737100005,0.0,1644.2724500334996,293.0,22.35236264,3665.7874737100005,0.0,121.92,0.0 -294,29669.56713827772,28969.56713827772,0.3175,11049.426884601733,2171510.9987472454,700.0,205800.0,37006.068927879474,8003397.47480778,25956.64204327774,5831886.476060526,true,294.0,294,0.875,9668.248524026516,11049.426884601733,1381.178360575217,0.0,0.0,294,28969.56713827772,0.0,9668.248524026516,9668.248524026516,1534703.7381023257,700.0,205800.0,5468.882141248776,699802.4595028692,1644.6927147680865,412407.0655782186,0.0,0.0,2523.802743760984,414753.32187071326,30.870924248669432,7740.891150524696,-9668.248524026516,-1900072.1239038394,true,true,22.39706737,3688.1845410800006,0.0,1644.2724500334996,294.0,22.39706737,3688.1845410800006,0.0,121.92,0.0 -295,33499.42688460174,32799.42688460174,0.28,7219.567138277719,2178730.5658855233,700.0,206500.0,28284.16835099185,8031681.643158772,21064.601212714133,5852951.07727324,true,295.0,295,0.875,6317.121245993004,7219.567138277719,902.4458922847152,0.0,0.0,295,32799.42688460174,0.0,6317.121245993004,6317.121245993004,1541020.8593483188,700.0,206500.0,5468.882141248776,705271.341644118,-1644.6927147680865,410762.3728634505,0.0,0.0,2523.802743760984,417277.12461447425,-30.870924248669432,7710.020226276027,-6317.121245993004,-1906389.2451498325,true,true,22.35236264,3710.5369037200007,0.0,1644.2724500334996,295.0,22.35236264,3710.5369037200007,0.0,121.92,0.0 -296,29669.56713827772,28969.56713827772,0.16240000000000002,1405.439824202442,2180136.005709726,700.0,207200.0,12964.530937207152,8044646.174095979,11559.09111300471,5864510.168386245,true,296.0,296,0.875,1229.7598461771368,1405.439824202442,175.67997802530522,0.0,0.0,296,28969.56713827772,0.0,1229.7598461771368,1229.7598461771368,1542250.619194496,700.0,207200.0,5387.339524606311,710658.6811687243,-6545.9091331174905,404216.463730333,0.0,0.0,2511.1963362477854,419788.32095072203,-122.86688155946955,7587.1533447165575,-1229.7598461771368,-1907619.0049960096,true,true,22.17354374,3732.7104474600005,0.0,1644.2724500334996,296.0,22.17354374,3732.7104474600005,0.0,121.92,0.0 -297,23855.43982420244,23155.43982420244,0.265,7024.430942910579,2187160.4366526366,700.0,207900.0,29148.796010983315,8073794.970106962,22124.365068072737,5886634.533454318,true,297.0,297,0.875,6146.3770750467565,7024.430942910579,878.0538678638222,0.0,0.0,297,23155.43982420244,0.0,6146.3770750467565,6146.3770750467565,1548396.9962695427,700.0,207900.0,5306.611516316375,715965.2926850407,-1628.2618539957336,402588.2018763373,0.0,0.0,2498.5899292985728,422286.9108800206,-30.562516572457934,7556.5908281441,-6146.3770750467565,-1913765.3820710564,true,true,22.12883902,3754.8392864800007,0.0,1644.2724500334996,297.0,22.12883902,3754.8392864800007,0.0,121.92,0.0 -298,29474.430942910578,28774.430942910578,0.29250000000000004,8899.00795077031,2196059.444603407,700.0,208600.0,32817.12119921473,8106612.091306177,23918.113248444417,5910552.646702762,true,298.0,298,0.875,7786.631956924022,8899.00795077031,1112.375993846288,0.0,0.0,298,28774.430942910578,0.0,7786.631956924022,7786.631956924022,1556183.6282264667,700.0,208600.0,5290.563308789698,721255.8559938305,0.0,402588.2018763373,0.0,0.0,2496.0686481343246,424782.9795281549,0.0,7556.5908281441,-7786.631956924022,-1921552.0140279804,true,true,22.12883902,3776.968125500001,0.0,1644.2724500334996,298.0,22.12883902,3776.968125500001,0.0,121.92,0.0 -299,31349.007950770312,30649.007950770312,0.29250000000000004,8899.00795077031,2204958.452554177,700.0,209300.0,32817.12119921473,8139429.212505392,23918.113248444417,5934470.759951206,true,299.0,299,0.875,7786.631956924022,8899.00795077031,1112.375993846288,0.0,0.0,299,30649.007950770312,0.0,7786.631956924022,7786.631956924022,1563970.2601833907,700.0,209300.0,5290.563308789698,726546.4193026202,0.0,402588.2018763373,0.0,0.0,2496.0686481343246,427279.0481762892,0.0,7556.5908281441,-7786.631956924022,-1929338.6459849044,true,true,22.12883902,3799.096964520001,0.0,1644.2724500334996,299.0,22.12883902,3799.096964520001,0.0,121.92,0.0 -300,31349.007950770312,30649.007950770312,0.16,1269.5509846424227,2206228.0035388195,700.0,210000.0,12309.693654015142,8151738.9061594065,11040.142669372719,5945510.902620578,true,300.0,300,0.875,1110.8571115621198,1269.5509846424227,158.69387308030286,0.0,0.0,300,30649.007950770312,0.0,1110.8571115621198,1110.8571115621198,1565081.1172949527,700.0,210000.0,5226.694023331791,731773.113325952,-6480.187155752717,396108.01472058456,0.0,0.0,2485.98352234936,429765.0316986386,-121.6332783663133,7434.957549777787,-1110.8571115621198,-1930449.5030964664,true,true,21.95002012,3821.046984640001,0.0,1644.2724500334996,300.0,21.95002012,3821.046984640001,0.0,121.92,0.0 -301,23719.55098464242,23019.55098464242,0.12,0.0,2206228.0035388195,700.0,210700.0,5833.333333333334,8157572.23949274,5833.333333333334,5951344.235953911,true,301.0,301,0.875,0.0,0.0,0.0,0.0,0.0,301,23019.55098464242,0.0,-628.7867294235994,-628.7867294235994,1564452.3305655292,700.0,210700.0,5084.871976335696,736857.9853022876,-8026.296897123215,388081.71782346134,0.0,0.0,2463.2919890511967,432228.3236876898,-150.65379768727655,7284.30375209051,-0.0,-1930449.5030964664,true,true,21.72649649,3842.773481130001,0.0,1644.2724500334996,301.0,21.72649649,3842.773481130001,0.0,121.92,0.0 -302,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,211400.0,5833.333333333334,8163405.572826073,5833.333333333334,5957177.569287244,true,302.0,302,0.875,0.0,0.0,0.0,0.0,0.0,302,21750.0,0.0,-724.8497054925183,-724.8497054925183,1563727.4808600366,700.0,211400.0,4930.327333979124,741788.3126362667,-7944.144419904093,380137.57340355724,0.0,0.0,2438.0791740247996,434666.4028617146,-149.11179359234828,7135.1919584981615,-0.0,-1930449.5030964664,true,true,21.50297286,3864.276453990001,0.0,1644.2724500334996,302.0,21.50297286,3864.276453990001,0.0,121.92,0.0 -303,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,212100.0,5833.333333333334,8169238.906159406,5833.333333333334,5963010.902620577,true,303.0,303,0.875,0.0,0.0,0.0,0.0,0.0,303,21750.0,0.0,-7234.897095339675,-7234.897095339675,1556492.583764697,700.0,212100.0,4719.272267415918,746507.5849036826,-14092.435227503207,366045.13817605405,0.0,0.0,2402.781233777423,437069.184095492,-264.515369029808,6870.676589468353,-0.0,-1930449.5030964664,true,true,21.10063034,3885.377084330001,0.0,1644.2724500334996,303.0,21.10063034,3885.377084330001,0.0,121.92,0.0 -304,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,212800.0,5833.333333333334,8175072.239492739,5833.333333333334,5968844.23595391,true,304.0,304,0.875,0.0,0.0,0.0,0.0,0.0,304,21750.0,0.0,-10398.430035561676,-10398.430035561676,1546094.1537291352,700.0,212800.0,4428.343113446938,750935.9280171295,-16862.617002191924,349182.52117386216,0.0,0.0,2352.3556048526,439421.5397003446,-316.5117516692918,6554.164837799061,-0.0,-1930449.5030964664,true,true,20.60887836,3905.9859626900006,0.0,1644.2724500334996,304.0,20.60887836,3905.9859626900006,0.0,121.92,0.0 -305,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,213500.0,5833.333333333334,8180905.572826072,5833.333333333334,5974677.569287243,true,305.0,305,0.875,0.0,0.0,0.0,0.0,0.0,305,21750.0,0.0,-10354.74740584708,-10354.74740584708,1535739.406323288,700.0,213500.0,4122.412655868705,755058.3406729982,-16464.999022155116,332717.52215170703,0.0,0.0,2296.887412471309,441718.4271128159,-309.04845203197704,6245.1163857670845,-0.0,-1930449.5030964664,true,true,20.11712638,3926.103089070001,0.0,1644.2724500334996,305.0,20.11712638,3926.103089070001,0.0,121.92,0.0 -306,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,214200.0,5833.333333333334,8186738.906159405,5833.333333333334,5980510.902620576,true,306.0,306,0.875,0.0,0.0,0.0,0.0,0.0,306,21750.0,0.0,-11780.075346034955,-11780.075346034955,1523959.3309772532,700.0,214200.0,3817.993891481396,758876.3345644796,-17508.335276281618,315209.1868754254,0.0,0.0,2238.8979389257697,443957.3250517417,-328.63190016050356,5916.484485606581,-0.0,-1930449.5030964664,true,true,19.58066968,3945.683758750001,0.0,1644.2724500334996,306.0,19.58066968,3945.683758750001,0.0,121.92,0.0 -307,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,214900.0,5833.333333333334,8192572.239492738,5833.333333333334,5986344.235953909,true,307.0,307,0.875,0.0,0.0,0.0,0.0,0.0,307,21750.0,0.0,-11659.782000463774,-11659.782000463774,1512299.5489767895,700.0,214900.0,3516.7181205421844,762393.0526850219,-17035.137341809237,298174.04953361617,0.0,0.0,2178.387183651997,446135.71223539364,-319.74996284871855,5596.734522757863,-0.0,-1930449.5030964664,true,true,19.04421297,3964.727971720001,0.0,1644.2724500334996,307.0,19.04421297,3964.727971720001,0.0,121.92,0.0 -308,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,215600.0,5833.333333333334,8198405.572826071,5833.333333333334,5992177.569287242,true,308.0,308,0.875,0.0,0.0,0.0,0.0,0.0,308,21750.0,0.0,-10121.475404698795,-10121.475404698795,1502178.0735720906,700.0,215600.0,3243.2790685707714,765636.3317535927,-15199.850599538468,282974.1989340777,0.0,0.0,2120.397710106457,448256.1099455001,-285.3015838375548,5311.432938920308,-0.0,-1930449.5030964664,true,true,18.552461,3983.280432720001,0.0,1644.2724500334996,308.0,18.552461,3983.280432720001,0.0,121.92,0.0 -309,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,216300.0,5833.333333333334,8204238.906159404,5833.333333333334,5998010.902620575,true,309.0,309,0.875,0.0,0.0,0.0,0.0,0.0,309,21750.0,0.0,-11384.09743178823,-11384.09743178823,1490793.9761403024,700.0,216300.0,2984.3945822240516,768620.7263358168,-16128.174012570968,266846.0249215067,0.0,0.0,2062.4082365609183,450318.51818206103,-302.7262380022311,5008.706700918076,-0.0,-1930449.5030964664,true,true,18.01600429,4001.2964370100012,0.0,1644.2724500334996,309.0,18.01600429,4001.2964370100012,0.0,121.92,0.0 -310,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,217000.0,5833.333333333334,8210072.239492737,5833.333333333334,6003844.235953908,true,310.0,310,0.875,0.0,0.0,0.0,0.0,0.0,310,21750.0,0.0,-19087.746357493637,-19087.746357493637,1471706.2297828088,700.0,217000.0,2667.933401837301,771288.659737654,-23305.013847006212,243541.01107450048,0.0,0.0,1986.769792609698,452305.2879746707,-437.4357049344245,4571.270995983652,-0.0,-1930449.5030964664,true,true,17.21131924,4018.5077562500014,0.0,1644.2724500334996,310.0,17.21131924,4018.5077562500014,0.0,121.92,0.0 -311,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,217700.0,5833.333333333334,8215905.57282607,5833.333333333334,6009677.569287241,true,311.0,311,0.875,0.0,0.0,0.0,0.0,0.0,311,21750.0,0.0,-14706.642087531278,-14706.642087531278,1456999.5876952775,700.0,217700.0,2346.5898450857985,773635.2495827398,-18607.535520411107,224933.47555408938,0.0,0.0,1903.567504601747,454208.85547927243,-349.26391680771457,4222.007079175937,-0.0,-1930449.5030964664,true,true,16.54074836,4035.0485046100016,0.0,1644.2724500334996,311.0,16.54074836,4035.0485046100016,0.0,121.92,0.0 -312,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,218400.0,5833.333333333334,8221738.906159403,5833.333333333334,6015510.902620574,true,312.0,312,0.875,0.0,0.0,0.0,0.0,0.0,312,21750.0,0.0,-17881.35936930364,-17881.35936930364,1439118.228325974,700.0,218400.0,2052.144436415595,775687.3940191554,-21353.07132773848,203580.4042263509,0.0,0.0,1820.3652160298104,456029.22069530224,-400.7976940105636,3821.2093851653735,-0.0,-1930449.5030964664,true,true,15.7360633,4050.7845679100014,0.0,1644.2724500334996,312.0,15.7360633,4050.7845679100014,0.0,121.92,0.0 -313,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,219100.0,5833.333333333334,8227572.239492736,5833.333333333334,6021344.2359539075,true,313.0,313,0.875,0.0,0.0,0.0,0.0,0.0,313,21750.0,0.0,-12638.890927618613,-12638.890927618613,1426479.3373983554,700.0,219100.0,1791.198034470449,777478.5920536258,-15871.85799153213,187708.54623481876,0.0,0.0,1739.6842091861079,457768.90490448836,-297.91517974304213,3523.2942054223313,-0.0,-1930449.5030964664,true,true,15.11019715,4065.8947650600016,0.0,1644.2724500334996,313.0,15.11019715,4065.8947650600016,0.0,121.92,0.0 -314,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,219800.0,5833.333333333334,8233405.572826069,5833.333333333334,6027177.5692872405,true,314.0,314,0.875,0.0,0.0,0.0,0.0,0.0,314,21750.0,0.0,-11166.597014497831,-11166.597014497831,1415312.7403838576,700.0,219800.0,1589.0476381258886,779067.6396917517,-14161.443604452255,173547.1026303665,0.0,0.0,1671.609609855604,459440.514514344,-265.810658027069,3257.483547395262,-0.0,-1930449.5030964664,true,true,14.52903572,4080.423800780002,0.0,1644.2724500334996,314.0,14.52903572,4080.423800780002,0.0,121.92,0.0 -315,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,220500.0,5833.333333333334,8239238.906159402,5833.333333333334,6033010.9026205735,true,315.0,315,0.875,0.0,0.0,0.0,0.0,0.0,315,21750.0,0.0,-7669.930738957756,-7669.930738957756,1407642.8096448998,700.0,220500.0,1429.3423247747276,780496.9820165264,-10515.51668341161,163031.5859469549,0.0,0.0,1613.6201363100647,461054.13465065404,-197.37651663093877,3060.1070307643236,-0.0,-1930449.5030964664,true,true,14.08198847,4094.5057892500017,0.0,1644.2724500334996,315.0,14.08198847,4094.5057892500017,0.0,121.92,0.0 -316,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,221200.0,5833.333333333334,8245072.239492735,5833.333333333334,6038844.235953907,true,316.0,316,0.875,0.0,0.0,0.0,0.0,0.0,316,21750.0,0.0,-6483.869724942868,-6483.869724942868,1401158.939919957,700.0,221200.0,1305.7833678344905,781802.7653843609,-9183.003668016738,153848.58227893818,0.0,0.0,1565.7157885494898,462619.85043920355,-172.36521331010988,2887.7418174542136,-0.0,-1930449.5030964664,true,true,13.67964594,4108.185435190002,0.0,1644.2724500334996,316.0,13.67964594,4108.185435190002,0.0,121.92,0.0 -317,22450.0,21750.0,0.17200000000000001,2013.1071213940643,2208241.1106602135,700.0,221900.0,15773.878612756185,8260846.118105491,13760.77149136212,6052605.007445268,true,317.0,317,0.875,1761.4687312198062,2013.1071213940643,251.63839017425812,0.0,0.0,317,21750.0,0.0,1761.4687312198062,1761.4687312198062,1402920.4086511768,700.0,221900.0,1243.712394538102,783046.477778899,-1003.9033454161585,152844.67893352202,0.0,0.0,1540.5029735230928,464160.35341272666,-18.843291425230344,2868.8985260289833,-1761.4687312198062,-1932210.9718276863,true,true,13.63494121,4121.820376400002,0.0,1644.2724500334996,317.0,13.63494121,4121.820376400002,0.0,121.92,0.0 -318,24463.107121394063,23763.107121394063,0.12,0.0,2208241.1106602135,700.0,222600.0,5833.333333333334,8266679.451438824,5833.333333333334,6058438.340778601,true,318.0,318,0.875,0.0,0.0,0.0,0.0,0.0,318,23763.107121394063,0.0,-2330.70915547804,-2330.70915547804,1400589.6994956988,700.0,222600.0,1207.4313721302067,784253.9091510292,-4970.224570367782,147874.45436315425,0.0,0.0,1525.3752848456459,465685.7286975723,-93.29124208611101,2775.607283942872,-0.0,-1932210.9718276863,true,true,13.41141759,4135.231793990002,0.0,1644.2724500334996,318.0,13.41141759,4135.231793990002,0.0,121.92,0.0 -319,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,223300.0,5833.333333333334,8272512.784772157,5833.333333333334,6064271.674111934,true,319.0,319,0.875,0.0,0.0,0.0,0.0,0.0,319,21750.0,0.0,-7268.56188204879,-7268.56188204879,1393321.13761365,700.0,223300.0,1119.8306928548616,785373.739843884,-9693.992157469927,138180.4622056843,0.0,0.0,1487.5560628700357,467173.28476044233,-181.95648030376034,2593.650803639112,-0.0,-1932210.9718276863,true,true,12.96437033,4148.196164320002,0.0,1644.2724500334996,319.0,12.96437033,4148.196164320002,0.0,121.92,0.0 -320,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,224000.0,5833.333333333334,8278346.11810549,5833.333333333334,6070105.007445267,true,320.0,320,0.875,0.0,0.0,0.0,0.0,0.0,320,21750.0,0.0,-11778.264140502446,-11778.264140502446,1381542.8734731474,700.0,224000.0,983.4259744983184,786357.1658183823,-13924.844454919332,124255.61775076497,0.0,0.0,1424.5240258680285,468597.8087863104,-261.36968594946114,2332.2811176896507,-0.0,-1932210.9718276863,true,true,12.29379945,4160.489963770002,0.0,1644.2724500334996,320.0,12.29379945,4160.489963770002,0.0,121.92,0.0 -321,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,224700.0,5833.333333333334,8284179.451438823,5833.333333333334,6075938.3407786,true,321.0,321,0.875,0.0,0.0,0.0,0.0,0.0,321,21750.0,0.0,-21538.35219049233,-21538.35219049233,1360004.521282655,700.0,224700.0,780.0122046380777,787137.1780230204,-23201.501818181812,101054.11593258315,0.0,0.0,1318.6302045619145,469916.4389908723,-435.492781510511,1896.7883361791396,-0.0,-1932210.9718276863,true,true,11.08677187,4171.576735640002,0.0,1644.2724500334996,321.0,11.08677187,4171.576735640002,0.0,121.92,0.0 -322,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,225400.0,5833.333333333334,8290012.784772156,5833.333333333334,6081771.674111933,true,322.0,322,0.875,0.0,0.0,0.0,0.0,0.0,322,21750.0,0.0,-23866.8284729708,-23866.8284729708,1336137.6928096842,700.0,225400.0,541.1769674658317,787678.3549904862,-25104.153161684146,75949.962770899,0.0,0.0,1167.353317054264,471083.7923079266,-471.2055958067488,1425.5827403723908,-0.0,-1932210.9718276863,true,true,9.611515937,4181.188251577002,0.0,1644.2724500334996,322.0,9.611515937,4181.188251577002,0.0,121.92,0.0 -323,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,226100.0,5833.333333333334,8295846.118105489,5833.333333333334,6087605.0074452665,true,323.0,323,0.875,0.0,0.0,0.0,0.0,0.0,323,21750.0,0.0,-8307.346648385812,-8307.346648385812,1327830.3461612985,700.0,226100.0,392.5331357196344,788070.8881262058,-9569.120241261311,66380.8425296377,0.0,0.0,1048.853088404147,472132.64539633074,-179.6126312482815,1245.9701091241093,-0.0,-1932210.9718276863,true,true,8.985649783,4190.173901360002,0.0,1644.2724500334996,323.0,8.985649783,4190.173901360002,0.0,121.92,0.0 -324,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,226800.0,5833.333333333334,8301679.451438822,5833.333333333334,6093438.3407785995,true,324.0,324,0.875,0.0,0.0,0.0,0.0,0.0,324,21750.0,0.0,-5244.8659369369325,-5244.8659369369325,1322585.4802243614,700.0,226800.0,328.4388575591084,788399.3269837649,-6440.754010571166,59940.08851906653,0.0,0.0,988.3423332995693,473120.9877296303,-120.89311722444432,1125.076991899665,-0.0,-1932210.9718276863,true,true,8.53860253,4198.712503890002,0.0,1644.2724500334996,324.0,8.53860253,4198.712503890002,0.0,121.92,0.0 -325,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,227500.0,5833.333333333334,8307512.784772155,5833.333333333334,6099271.6741119325,true,325.0,325,0.875,0.0,0.0,0.0,0.0,0.0,325,21750.0,0.0,-2538.452005094139,-2538.452005094139,1320047.0282192673,700.0,227500.0,289.8410314757067,788689.1680152406,-3706.7196441430333,56233.36887492349,0.0,0.0,948.0018299341167,474068.98955956445,-69.57522236092908,1055.501769538736,-0.0,-1932210.9718276863,true,true,8.270374179,4206.982878069002,0.0,1644.2724500334996,325.0,8.270374179,4206.982878069002,0.0,121.92,0.0 -326,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,228200.0,5833.333333333334,8313346.118105488,5833.333333333334,6105105.007445266,true,326.0,326,0.875,0.0,0.0,0.0,0.0,0.0,326,21750.0,0.0,-7774.467980963201,-7774.467980963201,1312272.560238304,700.0,228200.0,243.9390852791123,788933.1071005197,-8749.238554414122,47484.13032050937,0.0,0.0,895.054919224661,474964.0444787891,-164.2234310528525,891.2783384858835,-0.0,-1932210.9718276863,true,true,7.599803299,4214.582681368002,0.0,1644.2724500334996,326.0,7.599803299,4214.582681368002,0.0,121.92,0.0 -327,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,228900.0,5833.333333333334,8319179.451438821,5833.333333333334,6110938.340778599,true,327.0,327,0.875,0.0,0.0,0.0,0.0,0.0,327,21750.0,0.0,-7153.620804224196,-7153.620804224196,1305118.93943408,700.0,228900.0,187.17438494677413,789120.2814854665,-8009.866270102224,39474.264050407146,0.0,0.0,819.4164753298395,475783.4609541189,-150.34539439858528,740.9329440872982,-0.0,-1932210.9718276863,true,true,6.92923242,4221.511913788002,0.0,1644.2724500334996,327.0,6.92923242,4221.511913788002,0.0,121.92,0.0 -328,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,229600.0,5833.333333333334,8325012.784772154,5833.333333333334,6116771.674111932,true,328.0,328,0.875,0.0,0.0,0.0,0.0,0.0,328,21750.0,0.0,-13235.020146292263,-13235.020146292263,1291883.9192877878,700.0,229600.0,119.69346121778386,789239.9749466843,-13801.615737253274,25672.64831315387,0.0,0.0,705.9588095158064,476489.41976363474,-259.05667977258054,481.8762643147177,-0.0,-1932210.9718276863,true,true,5.588090661,4227.100004449002,0.0,1644.2724500334996,328.0,5.588090661,4227.100004449002,0.0,121.92,0.0 -329,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,230300.0,5833.333333333334,8330846.118105487,5833.333333333334,6122605.007445265,true,329.0,329,0.875,0.0,0.0,0.0,0.0,0.0,329,21750.0,0.0,-5973.84740416778,-5973.84740416778,1285910.07188362,700.0,230300.0,68.97061440707887,789308.9455610914,-6508.1190388034165,19164.529274350454,0.0,0.0,587.4585807528923,477076.87834438763,-122.157560524335,359.7187037903827,-0.0,-1932210.9718276863,true,true,4.828110331,4231.928114780002,0.0,1644.2724500334996,329.0,4.828110331,4231.928114780002,0.0,121.92,0.0 -330,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,231000.0,5833.333333333334,8336679.45143882,5833.333333333334,6128438.340778598,true,330.0,330,0.875,0.0,0.0,0.0,0.0,0.0,330,21750.0,0.0,-8301.123667582562,-8301.123667582562,1277608.9482160374,700.0,231000.0,36.23012892799714,789345.1756900194,-8649.012525517928,10515.516748832526,0.0,0.0,474.0009149388592,477550.8792593265,-162.342185931489,197.37651785889366,-0.0,-1932210.9718276863,true,true,3.576378023,4235.504492803002,0.0,1644.2724500334996,330.0,3.576378023,4235.504492803002,0.0,121.92,0.0 -331,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,231700.0,5833.333333333334,8342512.784772153,5833.333333333334,6134271.674111931,true,331.0,331,0.875,0.0,0.0,0.0,0.0,0.0,331,21750.0,0.0,-6683.899627416022,-6683.899627416022,1270925.0485886214,700.0,231700.0,11.16882521881578,789356.3445152382,-6886.020419309164,3629.496329523362,0.0,0.0,320.2027457593732,477871.0820050859,-129.2507790850466,68.12573877384708,-0.0,-1932210.9718276863,true,true,2.101122089,4237.6056148920015,0.0,1644.2724500334996,331.0,2.101122089,4237.6056148920015,0.0,121.92,0.0 -332,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,232400.0,5833.333333333334,8348346.118105486,5833.333333333334,6140105.007445264,true,332.0,332,0.875,0.0,0.0,0.0,0.0,0.0,332,21750.0,0.0,-3214.5039270184884,-3214.5039270184884,1267710.544661603,700.0,232400.0,1.2376157767511555,789357.5821310149,-3307.458629116223,322.0377004071388,0.0,0.0,153.79816923588444,478024.88017432176,-62.081082914900776,6.0446558589462995,-0.0,-1932210.9718276863,true,true,0.625866154,4238.231481046001,0.0,1644.2724500334996,332.0,0.625866154,4238.231481046001,0.0,121.92,0.0 -333,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,233100.0,5833.333333333334,8354179.451438819,5833.333333333334,6145938.340778597,true,333.0,333,0.875,0.0,0.0,0.0,0.0,0.0,333,21750.0,0.0,-292.76945411059955,-292.76945411059955,1267417.7752074923,700.0,233100.0,0.014961682648637148,789357.5970926975,-322.0377004072729,-1.340936250926461e-10,0.0,0.0,35.29794047297039,478060.1781147947,-6.044655858945696,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,333.0,0.0,4238.231481046001,0.0,121.92,0.0 -334,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,233800.0,5833.333333333334,8360012.784772152,5833.333333333334,6151771.67411193,true,334.0,334,0.875,0.0,0.0,0.0,0.0,0.0,334,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,233800.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,334.0,0.0,4238.231481046001,0.0,121.92,0.0 -335,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,234500.0,5833.333333333334,8365846.118105485,5833.333333333334,6157605.007445263,true,335.0,335,0.875,0.0,0.0,0.0,0.0,0.0,335,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,234500.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,335.0,0.0,4238.231481046001,0.0,121.92,0.0 -336,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,235200.0,5833.333333333334,8371679.451438818,5833.333333333334,6163438.340778596,true,336.0,336,0.875,0.0,0.0,0.0,0.0,0.0,336,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,235200.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,336.0,0.0,4238.231481046001,0.0,121.92,0.0 -337,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,235900.0,5833.333333333334,8377512.784772151,5833.333333333334,6169271.674111929,true,337.0,337,0.875,0.0,0.0,0.0,0.0,0.0,337,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,235900.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,337.0,0.0,4238.231481046001,0.0,121.92,0.0 -338,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,236600.0,5833.333333333334,8383346.118105484,5833.333333333334,6175105.007445262,true,338.0,338,0.875,0.0,0.0,0.0,0.0,0.0,338,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,236600.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,338.0,0.0,4238.231481046001,0.0,121.92,0.0 -339,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,237300.0,5833.333333333334,8389179.451438818,5833.333333333334,6180938.340778595,true,339.0,339,0.875,0.0,0.0,0.0,0.0,0.0,339,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,237300.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,339.0,0.0,4238.231481046001,0.0,121.92,0.0 -340,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,238000.0,5833.333333333334,8395012.784772152,5833.333333333334,6186771.674111928,true,340.0,340,0.875,0.0,0.0,0.0,0.0,0.0,340,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,238000.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,340.0,0.0,4238.231481046001,0.0,121.92,0.0 -341,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,238700.0,5833.333333333334,8400846.118105486,5833.333333333334,6192605.007445261,true,341.0,341,0.875,0.0,0.0,0.0,0.0,0.0,341,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,238700.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,341.0,0.0,4238.231481046001,0.0,121.92,0.0 -342,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,239400.0,5833.333333333334,8406679.45143882,5833.333333333334,6198438.340778594,true,342.0,342,0.875,0.0,0.0,0.0,0.0,0.0,342,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,239400.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,342.0,0.0,4238.231481046001,0.0,121.92,0.0 -343,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,240100.0,5833.333333333334,8412512.784772154,5833.333333333334,6204271.674111927,true,343.0,343,0.875,0.0,0.0,0.0,0.0,0.0,343,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,240100.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,343.0,0.0,4238.231481046001,0.0,121.92,0.0 -344,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,240800.0,5833.333333333334,8418346.118105488,5833.333333333334,6210105.00744526,true,344.0,344,0.875,0.0,0.0,0.0,0.0,0.0,344,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,240800.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,344.0,0.0,4238.231481046001,0.0,121.92,0.0 -345,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,241500.0,5833.333333333334,8424179.451438822,5833.333333333334,6215938.340778593,true,345.0,345,0.875,0.0,0.0,0.0,0.0,0.0,345,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,241500.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,345.0,0.0,4238.231481046001,0.0,121.92,0.0 -346,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,242200.0,5833.333333333334,8430012.784772156,5833.333333333334,6221771.674111926,true,346.0,346,0.875,0.0,0.0,0.0,0.0,0.0,346,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,242200.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,1644.2724500334996,346.0,0.0,4238.231481046001,0.0,121.92,0.0 -347,22450.0,21750.0,0.128,220.12254231489132,2208461.233202528,700.0,242900.0,7188.457361835089,8437201.242133992,6968.334819520197,6228740.008931446,true,347.0,347,0.875,192.60722452552992,220.12254231489132,27.515317789361404,0.0,0.0,347,21750.0,0.0,192.60722452552992,192.60722452552992,1267610.3824320177,700.0,242900.0,0.005452508259103674,789357.6025452057,164.30494929239373,164.30494929225964,0.0,0.0,25.212814631607213,478085.3909294263,3.084008093269858,3.084008093270462,-192.60722452552992,-1932403.5790522117,true,true,0.447047253,4238.678528299001,0.0,1644.2724500334996,347.0,0.447047253,4238.678528299001,0.0,121.92,0.0 -348,22670.12254231489,21970.12254231489,0.196,3499.5114655372286,2211960.7446680656,700.0,243600.0,21426.078905802187,8458627.321039794,17926.56744026496,6246666.576371711,true,348.0,348,0.875,3062.072532345075,3499.5114655372286,437.4389331921534,0.0,0.0,348,21970.12254231489,0.0,3062.072532345075,3062.072532345075,1270672.4549643628,700.0,243600.0,0.8117530711655422,789358.4142982769,2873.6935602792555,3037.998509571515,0.0,0.0,133.62791749675952,478219.0188469231,53.93930149789451,57.023309591164974,-3062.072532345075,-1935465.6515845568,true,true,1.922303187,4240.600831486001,0.0,1644.2724500334996,348.0,1.922303187,4240.600831486001,0.0,121.92,0.0 -349,25949.51146553723,25249.51146553723,0.28625,7865.811648293557,2219826.556316359,700.0,244300.0,29924.232832466572,8488551.553872261,22058.421184173014,6268724.997555884,true,349.0,349,0.875,6882.585192256862,7865.811648293557,983.2264560366948,0.0,0.0,349,25249.51146553723,0.0,6882.585192256862,6882.585192256862,1277555.0401566196,700.0,244300.0,9.18834335659429,789367.6026416335,6452.2553570878035,9490.25386665932,0.0,0.0,300.03249402024835,478519.0513409433,121.10899779221543,178.1323073833804,-6882.585192256862,-1942348.2367768136,true,true,3.397559122,4243.998390608001,0.0,1644.2724500334996,349.0,3.397559122,4243.998390608001,0.0,121.92,0.0 -350,30315.81164829356,29615.81164829356,0.3175,12251.492749053057,2232078.049065412,700.0,245000.0,40792.1031466238,8529343.657018885,28540.61039757074,6297265.607953454,true,350.0,350,0.875,10720.056155421426,12251.492749053057,1531.4365936316317,0.0,0.0,350,29615.81164829356,0.0,10720.056155421426,10720.056155421426,1288275.0963120412,700.0,245000.0,34.523237587262855,789402.1258792208,10030.817153161288,19521.071019820607,0.0,0.0,466.43707060013566,478985.4884115435,188.27869407273917,366.4110014561196,-10720.056155421426,-1953068.2929322352,true,true,4.872815057,4248.871205665,0.0,1644.2724500334996,350.0,4.872815057,4248.871205665,0.0,121.92,0.0 -351,34701.49274905305,34001.49274905305,0.345,16667.303837377745,2248745.3529027896,700.0,245700.0,50340.01112283405,8579683.668141719,33672.7072854563,6330938.315238911,true,351.0,351,0.875,14583.890857705528,16667.303837377745,2083.4129796722173,0.0,0.0,351,34001.49274905305,0.0,14583.890857705528,14583.890857705528,1302858.9871697468,700.0,245700.0,86.2218816277595,789488.3477608486,13609.3789387968,33130.449958617406,0.0,0.0,632.8416471236244,479618.3300586671,255.44839015734206,621.8593916134616,-14583.890857705528,-1967652.1837899408,true,true,6.348070991,4255.219276656,0.0,1644.2724500334996,351.0,6.348070991,4255.219276656,0.0,121.92,0.0 -352,39117.303837377745,38417.303837377745,0.3516666666666666,19783.03800944371,2268528.3909122334,700.0,246400.0,58245.60571405795,8637929.273855777,38462.56770461424,6369400.882943525,true,352.0,352,0.875,17310.158258263247,19783.03800944371,2472.8797511804623,0.0,0.0,352,38417.303837377745,0.0,17310.158258263247,17310.158258263247,1320169.14542801,700.0,246400.0,170.4229164559391,789658.7706773045,16044.378290941317,49174.82824955872,0.0,0.0,794.2036606982323,480412.53371936537,301.1533901677597,923.0127817812213,-17310.158258263247,-1984962.342048204,true,true,7.733917475,4262.953194131001,0.0,1644.2724500334996,352.0,7.733917475,4262.953194131001,0.0,121.92,0.0 -353,42233.03800944371,41533.03800944371,0.35333333333333333,20664.158208412446,2289192.549120646,700.0,247100.0,60464.59870305409,8698393.872558832,39800.44049464165,6409201.323438167,true,353.0,353,0.875,18081.13843236089,20664.158208412446,2583.019776051555,0.0,0.0,353,41533.03800944371,0.0,18081.13843236089,18081.13843236089,1338250.283860371,700.0,247100.0,282.9585538511124,789941.7292311556,16547.15143799595,65721.97968755467,0.0,0.0,940.4379855389949,481352.97170490434,310.59045497483316,1233.6032367560545,-18081.13843236089,-2003043.480480565,true,true,8.940945058,4271.894139189,0.0,1644.2724500334996,353.0,8.940945058,4271.894139189,0.0,121.92,0.0 -354,43114.158208412446,42414.158208412446,0.355,22028.784612202908,2311221.333732849,700.0,247800.0,64024.74538648707,8762418.617945319,41995.96077428416,6451197.2842124505,true,354.0,354,0.875,19275.186535677545,22028.784612202908,2753.5980765253626,0.0,0.0,354,42414.158208412446,0.0,19275.186535677545,19275.186535677545,1357525.4703960486,700.0,247800.0,418.56520403034614,790360.294435186,17457.400850371967,83179.38053792664,0.0,0.0,1071.544621589513,482424.5163264939,327.675859685717,1561.2790964417713,-19275.186535677545,-2022318.6670162426,true,true,10.05856319,4281.952702379001,0.0,1644.2724500334996,354.0,10.05856319,4281.952702379001,0.0,121.92,0.0 -355,44478.78461220291,43778.78461220291,0.33,12551.490006862356,2323772.823739711,700.0,248500.0,40156.03032382532,8802574.648269145,27604.540316962964,6478801.824529413,true,355.0,355,0.875,10982.553756004561,12551.490006862356,1568.9362508577942,0.0,0.0,355,43778.78461220291,0.0,10982.553756004561,10982.553756004561,1368508.0241520533,700.0,248500.0,537.677989187874,790897.9724243738,9109.066323849152,92288.4468617758,0.0,0.0,1164.8320354952257,483589.3483619891,170.9774074723095,1732.256503914081,-10982.553756004561,-2033301.2207722473,true,true,10.59501989,4292.547722269001,0.0,1644.2724500334996,355.0,10.59501989,4292.547722269001,0.0,121.92,0.0 -356,35001.490006862354,34301.490006862354,0.33999999999999997,16169.656426097059,2339942.4801658085,700.0,249200.0,49616.63654734429,8852191.284816489,33446.98012124724,6512248.804650661,true,356.0,356,0.875,14148.449372834926,16169.656426097059,2021.2070532621328,0.0,0.0,356,34301.490006862354,0.0,14148.449372834926,14148.449372834926,1382656.4735248883,700.0,249200.0,637.5627111872001,791535.535135561,12051.768033133052,104340.21489490884,0.0,0.0,1232.9066348257297,484822.2549968148,226.2119936889441,1958.468497603025,-14148.449372834926,-2047449.6701450823,true,true,11.26559077,4303.813313039001,0.0,1644.2724500334996,356.0,11.26559077,4303.813313039001,0.0,121.92,0.0 -357,38619.65642609706,37919.65642609706,0.33999999999999997,16231.91452375151,2356174.39468956,700.0,249900.0,49799.74859926916,8901991.033415757,33567.83407551765,6545816.638726179,true,357.0,357,0.875,14202.925208282571,16231.91452375151,2028.989315468938,0.0,0.0,357,37919.65642609706,0.0,14202.925208282571,14202.925208282571,1396859.398733171,700.0,249900.0,757.8541113977777,792293.3892469588,11915.395030327696,116255.60992523654,0.0,0.0,1306.0237976127014,486128.2787944275,223.6522689443973,2182.120766547422,-14202.925208282571,-2061652.595353365,true,true,11.89145693,4315.704769969,0.0,1644.2724500334996,357.0,11.89145693,4315.704769969,0.0,121.92,0.0 -358,38681.91452375151,37981.91452375151,0.35,18292.345548732563,2374466.7402382926,700.0,250600.0,54263.844424950184,8956254.877840707,35971.49887621762,6581788.137602396,true,358.0,358,0.875,16005.802355140991,18292.345548732563,2286.5431935915713,0.0,0.0,358,37981.91452375151,0.0,16005.802355140991,16005.802355140991,1412865.2010883118,700.0,250600.0,892.3974305014219,793185.7866774602,13481.221099989114,129736.83102522565,0.0,0.0,1379.1409603996733,487507.4197548272,253.04286425078251,2435.163630798205,-16005.802355140991,-2077658.3977085059,true,true,12.56202781,4328.266797779,0.0,1644.2724500334996,358.0,12.56202781,4328.266797779,0.0,121.92,0.0 -359,40742.34554873256,40042.34554873256,0.35666666666666663,24014.04968788314,2398480.789926176,700.0,251300.0,69291.72809686862,9025546.605937576,45277.678408985485,6627065.816011381,true,359.0,359,0.875,21012.293476897747,24014.04968788314,3001.7562109853934,0.0,0.0,359,40042.34554873256,0.0,21012.293476897747,21012.293476897747,1433877.4945652096,700.0,251300.0,1069.3619556886626,794255.1486331489,18137.62333792856,147874.45436315422,0.0,0.0,1464.864530135858,488972.2842849631,340.4436531446674,2775.607283942872,-21012.293476897747,-2098670.6911854036,true,true,13.41141759,4341.678215369,0.0,1644.2724500334996,359.0,13.41141759,4341.678215369,0.0,121.92,0.0 -360,46464.04968788314,45764.04968788314,0.33,12457.394670840085,2410938.184597016,700.0,252000.0,39870.89294193965,9065417.498879516,27413.49827109957,6654479.314282481,true,360.0,360,0.875,10900.220336985074,12457.394670840085,1557.1743338550114,0.0,0.0,360,45764.04968788314,0.0,10900.220336985074,10900.220336985074,1444777.7149021947,700.0,252000.0,1225.4823756361013,795480.631008785,7991.792679245855,155866.24704240006,0.0,0.0,1532.939129466362,490505.22341442946,150.00615263675482,2925.613436579627,-10900.220336985074,-2109570.9115223885,true,true,13.76905539,4355.447270759,0.0,1644.2724500334996,360.0,13.76905539,4355.447270759,0.0,121.92,0.0 -361,34907.39467084008,34207.39467084008,0.33,12861.869325852093,2423800.053922868,700.0,252700.0,41096.57371470331,9106514.07259422,28234.704388851213,6682714.018671332,true,361.0,361,0.875,11254.13566012058,12861.869325852093,1607.7336657315118,0.0,0.0,361,34207.39467084008,0.0,11254.13566012058,11254.13566012058,1456031.8505623152,700.0,252700.0,1324.799333053766,796805.4303418387,8202.103011517436,164068.3500539175,0.0,0.0,1573.2796326062205,492078.50304703566,153.95368294315742,3079.567119522784,-11254.13566012058,-2120825.047182509,true,true,14.12669319,4369.573963949,0.0,1644.2724500334996,361.0,14.12669319,4369.573963949,0.0,121.92,0.0 -362,35311.869325852094,34611.869325852094,0.29250000000000004,9539.121070408992,2433339.174993277,700.0,253400.0,35005.54212105638,9141519.614715276,25466.42105064739,6708180.439721979,true,362.0,362,0.875,8346.730936607868,9539.121070408992,1192.3901338011237,0.0,0.0,362,34611.869325852094,0.0,8346.730936607868,8346.730936607868,1464378.581498923,700.0,253400.0,1409.336269847432,798214.7666116862,5233.112715783436,169301.46276970094,0.0,0.0,1606.0562916893482,493684.559338725,98.22565928765192,3177.792778810436,-8346.730936607868,-2129171.778119117,true,true,14.35021682,4383.9241807690005,0.0,1644.2724500334996,362.0,14.35021682,4383.9241807690005,0.0,121.92,0.0 -363,31989.12107040899,31289.12107040899,0.3175,12264.327405576478,2445603.5023988537,700.0,254100.0,40832.5272616582,9182352.141976934,28568.199856081723,6736748.639578061,true,363.0,363,0.875,10731.286479879418,12264.327405576478,1533.0409256970597,0.0,0.0,363,31289.12107040899,0.0,10731.286479879418,10731.286479879418,1475109.8679788024,700.0,254100.0,1490.4946518815846,799705.2612635678,7464.373674501998,176765.83644420293,0.0,0.0,1636.3116690442423,495320.87100776925,140.10648445159347,3317.8992632620298,-10731.286479879418,-2139903.0645989967,true,true,14.66314989,4398.587330659,0.0,1644.2724500334996,363.0,14.66314989,4398.587330659,0.0,121.92,0.0 -364,34714.32740557648,34014.32740557648,0.335,13899.52141955804,2459503.023818412,700.0,254800.0,43580.66095390459,9225932.80293084,29681.13953434655,6766429.779112408,true,364.0,364,0.875,12162.081242113285,13899.52141955804,1737.4401774447542,0.0,0.0,364,34014.32740557648,0.0,12162.081242113285,12162.081242113285,1487271.9492209158,700.0,254800.0,1596.2487485692484,801301.5100121371,8727.879089179143,185493.71553338208,0.0,0.0,1674.1308910198522,496995.0018987891,163.82251334503954,3481.7217766070694,-12162.081242113285,-2152065.14584111,true,true,15.0207877,4413.608118359,0.0,1644.2724500334996,364.0,15.0207877,4413.608118359,0.0,121.92,0.0 -365,36349.52141955804,35649.52141955804,0.33999999999999997,15655.176683377042,2475158.200501789,700.0,255500.0,48103.46083346189,9274036.263764301,32448.284150084848,6798878.063262492,true,365.0,365,0.875,13698.279597954912,15655.176683377042,1956.8970854221297,0.0,0.0,365,35649.52141955804,0.0,13698.279597954912,13698.279597954912,1500970.2288188706,700.0,255500.0,1722.017923374747,803023.5279355119,10070.25014633088,195563.96567971297,0.0,0.0,1716.9926758879446,498711.994574677,189.01885236134012,3670.7406289684095,-13698.279597954912,-2165763.425439065,true,true,15.42313022,4429.031248579,0.0,1644.2724500334996,365.0,15.42313022,4429.031248579,0.0,121.92,0.0 -366,38105.17668337704,37405.17668337704,0.23500000000000001,5368.983371727066,2480527.183873516,700.0,256200.0,25825.461156285386,9299861.724920588,20456.47778455832,6819334.541047051,true,366.0,366,0.875,4697.860450261182,5368.983371727066,671.1229214658833,0.0,0.0,366,37405.17668337704,0.0,4697.860450261182,4697.860450261182,1505668.089269132,700.0,256200.0,1798.9971432320265,804822.5250787439,1135.3473185223263,196699.31299823528,0.0,0.0,1742.2054903503563,500454.2000650274,21.310498156473894,3692.0511271248834,-4697.860450261182,-2170461.285889326,true,true,15.46783495,4444.499083529,0.0,1644.2724500334996,366.0,15.46783495,4444.499083529,0.0,121.92,0.0 -367,27818.983371727067,27118.983371727067,0.28625,8083.166235612963,2488610.350109129,700.0,256900.0,30683.550168080223,9330545.275088668,22600.38393246726,6841934.924979518,true,367.0,367,0.875,7072.770456161343,8083.166235612963,1010.39577945162,0.0,0.0,367,27118.983371727067,0.0,7072.770456161343,7072.770456161343,1512740.8597252932,700.0,256900.0,1830.4199716696303,806652.9450504136,3425.758297089213,200125.0712953245,0.0,0.0,1752.2906166993064,502206.4906817267,64.3015707031929,3756.352697828076,-7072.770456161343,-2177534.0563454875,true,true,15.60194913,4460.101032659,0.0,1644.2724500334996,367.0,15.60194913,4460.101032659,0.0,121.92,0.0 -368,30533.166235612964,29833.166235612964,0.1864,2785.0282285902035,2491395.3783377195,700.0,257600.0,18696.50337226504,9349241.778460933,15911.475143674837,6857846.400123193,true,368.0,368,0.875,2436.899700016428,2785.0282285902035,348.1285285737754,0.0,0.0,368,29833.166235612964,0.0,2436.899700016428,2436.899700016428,1515177.7594253097,700.0,257600.0,1846.2676759094786,808499.212726323,-1145.2056168176591,198979.86567850685,0.0,0.0,1757.3331795917886,503963.8238613185,-21.49553866718006,3734.857159160896,-2436.899700016428,-2179970.9560455037,true,true,15.5572444,4475.658277059,0.0,1644.2724500334996,368.0,15.5572444,4475.658277059,0.0,121.92,0.0 -369,25235.028228590203,24535.028228590203,0.124,93.59398601776749,2491488.972323737,700.0,258300.0,6399.9515001432865,9355641.729961077,6306.357514125519,6864152.757637318,true,369.0,369,0.875,81.89473776554655,93.59398601776749,11.69924825222094,0.0,0.0,369,24535.028228590203,0.0,81.89473776554655,81.89473776554655,1515259.6541630754,700.0,258300.0,1814.6632135090754,810313.8759398321,-3415.8999987938805,195563.96567971297,0.0,0.0,1747.2480532428385,505711.0719145614,-64.11653019248674,3670.7406289684095,-81.89473776554655,-2180052.8507832694,true,true,15.42313022,4491.081407279,0.0,1644.2724500334996,369.0,15.42313022,4491.081407279,0.0,121.92,0.0 -370,22543.593986017768,21843.593986017768,0.265,6706.524623002805,2498195.49694674,700.0,259000.0,27949.149520765302,9383590.879481843,21242.624897762496,6885395.38253508,true,370.0,370,0.875,5868.209045127454,6706.524623002805,838.3155778753508,0.0,0.0,370,21843.593986017768,0.0,5868.209045127454,5868.209045127454,1521127.8632082029,700.0,259000.0,1806.8188598396466,812120.6947996718,2273.980736721436,197837.9464164344,0.0,0.0,1744.7267720785903,507455.79868664,42.68267648778144,3713.423305456191,-5868.209045127454,-2185921.059828397,true,true,15.51253968,4506.593946959,0.0,1644.2724500334996,370.0,15.51253968,4506.593946959,0.0,121.92,0.0 -371,29156.524623002806,28456.524623002806,0.335,14922.04562554899,2513117.542572289,700.0,259700.0,46632.97201656415,9430223.851498406,31710.926391015157,6917106.308926095,true,371.0,371,0.875,13056.789922355367,14922.04562554899,1865.255703193623,0.0,0.0,371,28456.524623002806,0.0,13056.789922355367,13056.789922355367,1534184.6531305583,700.0,259700.0,1886.2865517355772,814006.9813514074,9227.365890162357,207065.31230659675,0.0,0.0,1769.9395871049871,509225.738273745,173.19789335244565,3886.6211988086366,-13056.789922355367,-2198977.849750752,true,true,15.87017748,4522.464124439,0.0,1644.2724500334996,371.0,15.87017748,4522.464124439,0.0,121.92,0.0 -372,37372.04562554899,36672.04562554899,0.3175,11177.033310791041,2524294.57588308,700.0,260400.0,37407.97893162532,9467631.83043003,26230.94562083428,6943337.254546929,true,372.0,372,0.875,9779.90414694216,11177.033310791041,1397.1291638488801,0.0,0.0,372,36672.04562554899,0.0,9779.90414694216,9779.90414694216,1543964.5572775004,700.0,260400.0,1993.0328505765465,816000.0142019839,5873.90176464599,212939.21407124275,0.0,0.0,1802.7162456241294,511028.4545193691,110.25328609549629,3996.8744849041327,-9779.90414694216,-2208757.7538976944,true,true,16.0937011,4538.557825539,0.0,1644.2724500334996,372.0,16.0937011,4538.557825539,0.0,121.92,0.0 -373,33627.03331079104,32927.03331079104,0.20800000000000002,4400.526231122673,2528695.1021142025,700.0,261100.0,24521.76072655131,9492153.591156581,20121.23449542864,6963458.489042358,true,373.0,373,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,373,32927.03331079104,0.0,3850.460452232339,3850.460452232339,1547815.0177297327,700.0,261100.0,2035.1377996589958,818035.152001643,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,512843.77717194246,0.0,3996.8744849041327,-3850.460452232339,-2212608.214349927,true,true,16.0937011,4554.651526639,0.0,1644.2724500334996,373.0,16.0937011,4554.651526639,0.0,121.92,0.0 -374,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2533095.628345325,700.0,261800.0,24521.76072655131,9516675.351883132,20121.23449542864,6983579.723537786,true,374.0,374,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,374,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1551665.478181965,700.0,261800.0,2035.1377996589958,820070.289801302,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,514659.0998245158,0.0,3996.8744849041327,-3850.460452232339,-2216458.6748021594,true,true,16.0937011,4570.745227738999,0.0,1644.2724500334996,374.0,16.0937011,4570.745227738999,0.0,121.92,0.0 -375,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2537496.154576448,700.0,262500.0,24521.76072655131,9541197.112609683,20121.23449542864,7003700.958033214,true,375.0,375,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,375,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1555515.9386341972,700.0,262500.0,2035.1377996589958,822105.4276009611,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,516474.42247708916,0.0,3996.8744849041327,-3850.460452232339,-2220309.135254392,true,true,16.0937011,4586.838928838999,0.0,1644.2724500334996,375.0,16.0937011,4586.838928838999,0.0,121.92,0.0 -376,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2541896.6808075705,700.0,263200.0,24521.76072655131,9565718.873336233,20121.23449542864,7023822.192528643,true,376.0,376,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,376,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1559366.3990864295,700.0,263200.0,2035.1377996589958,824140.5654006201,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,518289.7451296625,0.0,3996.8744849041327,-3850.460452232339,-2224159.5957066244,true,true,16.0937011,4602.932629938999,0.0,1644.2724500334996,376.0,16.0937011,4602.932629938999,0.0,121.92,0.0 -377,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2546297.207038693,700.0,263900.0,24521.76072655131,9590240.634062784,20121.23449542864,7043943.427024071,true,377.0,377,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,377,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1563216.8595386618,700.0,263900.0,2035.1377996589958,826175.7032002792,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,520105.06778223586,0.0,3996.8744849041327,-3850.460452232339,-2228010.056158857,true,true,16.0937011,4619.026331038998,0.0,1644.2724500334996,377.0,16.0937011,4619.026331038998,0.0,121.92,0.0 -378,26850.526231122672,26150.526231122672,0.23500000000000001,5792.397448882797,2552089.604487576,700.0,264600.0,27627.223186735304,9617867.857249519,21834.82573785251,7065778.252761924,true,378.0,378,0.875,5068.347767772448,5792.397448882797,724.0496811103494,0.0,0.0,378,26150.526231122672,0.0,5068.347767772448,5068.347767772448,1568285.2073064342,700.0,264600.0,2043.6293242594552,828219.3325245386,1184.6388085290018,214123.85287977176,0.0,0.0,1817.8439343015766,521922.91171653743,22.23570068241439,4019.1101855865472,-5068.347767772448,-2233078.4039266296,true,true,16.13840583,4635.164736868998,0.0,1644.2724500334996,378.0,16.13840583,4635.164736868998,0.0,121.92,0.0 -379,28242.397448882795,27542.397448882795,0.29250000000000004,8624.53784943239,2560714.1423370084,700.0,265300.0,31878.761878401332,9649746.61912792,23254.224028968943,7089032.476790893,true,379.0,379,0.875,7546.470618253341,8624.53784943239,1078.0672311790495,0.0,0.0,379,27542.397448882795,0.0,7546.470618253341,7546.470618253341,1575831.6779246875,700.0,265300.0,2077.8316234454264,830297.164147984,3573.6327560833283,217697.4856358551,0.0,0.0,1827.929060650527,523750.84077718796,67.0771780740596,4086.187363660607,-7546.470618253341,-2240624.874544883,true,true,16.27252001,4651.437256878999,0.0,1644.2724500334996,379.0,16.27252001,4651.437256878999,0.0,121.92,0.0 -380,31074.53784943239,30374.53784943239,0.25,5909.363378591942,2566623.5057156,700.0,266000.0,26437.453514367768,9676184.072642287,20528.090135775827,7109560.566926668,true,380.0,380,0.875,5170.692956267949,5909.363378591942,738.6704223239931,0.0,0.0,380,30374.53784943239,0.0,5170.692956267949,5170.692956267949,1581002.3708809554,700.0,266000.0,2112.413415299001,832409.577563283,1197.78293820149,218895.2685740566,0.0,0.0,1838.0141864354912,525588.8549636235,22.48241633196647,4108.669779992573,-5170.692956267949,-2245795.567501151,true,true,16.31722473,4667.7544816089985,0.0,1644.2724500334996,380.0,16.31722473,4667.7544816089985,0.0,121.92,0.0 -381,28359.36337859194,27659.36337859194,0.1936,3120.1854253726124,2569743.691140973,700.0,266700.0,19732.36273436267,9695916.43537665,16612.177308990056,7126172.744235658,true,381.0,381,0.875,2730.162247201036,3120.1854253726124,390.02317817157655,0.0,0.0,381,27659.36337859194,0.0,2730.162247201036,2730.162247201036,1583732.5331281563,700.0,266700.0,2112.413415299001,834521.9909785821,-1197.78293820149,217697.4856358551,0.0,0.0,1838.0141864354912,527426.869150059,-22.48241633196647,4086.187363660607,-2730.162247201036,-2248525.729748352,true,true,16.27252001,4684.027001618999,0.0,1644.2724500334996,381.0,16.27252001,4684.027001618999,0.0,121.92,0.0 -382,25570.185425372612,24870.185425372612,0.12,0.0,2569743.691140973,700.0,267400.0,5833.333333333334,9701749.768709984,5833.333333333334,7132006.077568991,true,382.0,382,0.875,0.0,0.0,0.0,0.0,0.0,382,24870.185425372612,0.0,-952.9311121093242,-952.9311121093242,1582779.602016047,700.0,267400.0,2069.245552337187,836591.2365309192,-4758.27156461233,212939.21407124275,0.0,0.0,1825.4077789222927,529252.2769289812,-89.31287875647399,3996.874484904133,-0.0,-2248525.729748352,true,true,16.0937011,4700.1207027189985,0.0,1644.2724500334996,382.0,16.0937011,4700.1207027189985,0.0,121.92,0.0 -383,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,268100.0,5833.333333333334,9707583.102043318,5833.333333333334,7137839.410902324,true,383.0,383,0.875,0.0,0.0,0.0,0.0,0.0,383,21750.0,0.0,-6958.81792595786,-6958.81792595786,1575820.7840900891,700.0,268100.0,1959.7701295241397,838551.0066604434,-10513.873501261145,202425.3405699816,0.0,0.0,1792.631119839165,531044.9080488203,-197.34567406001952,3799.5288108441137,-0.0,-2248525.729748352,true,true,15.69135858,4715.812061298999,0.0,1644.2724500334996,383.0,15.69135858,4715.812061298999,0.0,121.92,0.0 -384,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,268800.0,5833.333333333334,9713416.435376652,5833.333333333334,7143672.744235657,true,384.0,384,0.875,0.0,0.0,0.0,0.0,0.0,384,21750.0,0.0,-8031.770397699034,-8031.770397699034,1567789.0136923902,700.0,268800.0,1806.8188598396466,840357.8255202831,-11369.902666273734,191055.43790370788,0.0,0.0,1744.7267720785903,532789.6348208989,-213.4133633435361,3586.1154475005774,-0.0,-2248525.729748352,true,true,15.24431132,4731.0563726189985,0.0,1644.2724500334996,384.0,15.24431132,4731.0563726189985,0.0,121.92,0.0 -385,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,269500.0,5833.333333333334,9719249.768709986,5833.333333333334,7149506.07756899,true,385.0,385,0.875,0.0,0.0,0.0,0.0,0.0,385,21750.0,0.0,-3400.543976884009,-3400.543976884009,1564388.469715506,700.0,269500.0,1684.3658178671562,842042.1913381502,-6664.208695755293,184391.2292079526,0.0,0.0,1704.3862683747464,534494.0210892736,-125.0873673706192,3461.028080129958,-0.0,-2248525.729748352,true,true,14.97608297,4746.032455588998,0.0,1644.2724500334996,385.0,14.97608297,4746.032455588998,0.0,121.92,0.0 -386,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,270200.0,5833.333333333334,9725083.10204332,5833.333333333334,7155339.410902323,true,386.0,386,0.875,0.0,0.0,0.0,0.0,0.0,386,21750.0,0.0,-19686.63464194825,-19686.63464194825,1544701.835073558,700.0,270200.0,1490.4946518815846,843532.6859900318,-22393.12150056489,161998.1077073877,0.0,0.0,1636.3116690442423,536130.3327583178,-420.3194623091883,3040.70861782077,-0.0,-2248525.729748352,true,true,14.03728374,4760.069739328998,0.0,1644.2724500334996,386.0,14.03728374,4760.069739328998,0.0,121.92,0.0 -387,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,270900.0,5833.333333333334,9730916.435376653,5833.333333333334,7161172.744235656,true,387.0,387,0.875,0.0,0.0,0.0,0.0,0.0,387,21750.0,0.0,-21540.395313418583,-21540.395313418583,1523161.4397601394,700.0,270900.0,1201.4539993490614,844734.1399893808,-23817.6455017034,138180.4622056843,0.0,0.0,1522.854003117412,537653.1867614352,-447.05781418165793,2593.6508036391124,-0.0,-2248525.729748352,true,true,12.96437033,4773.034109658998,0.0,1644.2724500334996,387.0,12.96437033,4773.034109658998,0.0,121.92,0.0 -388,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,271600.0,5833.333333333334,9736749.768709987,5833.333333333334,7167006.077568989,true,388.0,388,0.875,0.0,0.0,0.0,0.0,0.0,388,21750.0,0.0,-27943.84219684052,-27943.84219684052,1495217.597563299,700.0,271600.0,892.3974294066116,845626.5374187875,-29658.686287222878,108521.77591846143,0.0,0.0,1379.1409598356877,539032.327721271,-556.6942988599402,2036.956504779172,-0.0,-2248525.729748352,true,true,11.4891144,4784.5232240589985,0.0,1644.2724500334996,388.0,11.4891144,4784.5232240589985,0.0,121.92,0.0 -389,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,272300.0,5833.333333333334,9742583.102043321,5833.333333333334,7172839.410902322,true,389.0,389,0.875,0.0,0.0,0.0,0.0,0.0,389,21750.0,0.0,-20152.338068054276,-20152.338068054276,1475065.2594952446,700.0,272300.0,629.7718084492777,846256.3092272368,-21604.457725878707,86917.31819258272,0.0,0.0,1227.8640724972329,540260.1917937682,-405.5162231220798,1631.4402816570923,-0.0,-2248525.729748352,true,true,10.28208682,4794.805310878998,0.0,1644.2724500334996,389.0,10.28208682,4794.805310878998,0.0,121.92,0.0 -390,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,273000.0,5833.333333333334,9748416.435376655,5833.333333333334,7178672.744235655,true,390.0,390,0.875,0.0,0.0,0.0,0.0,0.0,390,21750.0,0.0,-18035.07863664031,-18035.07863664031,1457030.1808586044,700.0,273000.0,442.6495439273991,846698.9587711642,-19208.89166703187,67708.42652555085,0.0,0.0,1091.7148734978334,541351.906667266,-360.55138703367516,1270.8888946234172,-0.0,-2248525.729748352,true,true,9.075059234,4803.880370112998,0.0,1644.2724500334996,390.0,9.075059234,4803.880370112998,0.0,121.92,0.0 -391,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,273700.0,5833.333333333334,9754249.76870999,5833.333333333334,7184506.077568988,true,391.0,391,0.875,0.0,0.0,0.0,0.0,0.0,391,21750.0,0.0,-16468.91204791192,-16468.91204791192,1440561.2688106925,700.0,273700.0,294.49079967768796,846993.4495708419,-17390.035824050905,50318.39070149994,0.0,0.0,953.0443928829976,542304.951060149,-326.4114164216998,944.4774782017173,-0.0,-2248525.729748352,true,true,7.823326926,4811.703697038998,0.0,1644.2724500334996,391.0,7.823326926,4811.703697038998,0.0,121.92,0.0 -392,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,274400.0,5833.333333333334,9760083.102043323,5833.333333333334,7190339.410902321,true,392.0,392,0.875,0.0,0.0,0.0,0.0,0.0,392,21750.0,0.0,-15083.86204708968,-15083.86204708968,1425477.4067636027,700.0,274400.0,178.66779052190432,847172.1173613637,-15773.275128762001,34545.11557273794,0.0,0.0,806.8100680422352,543111.7611281913,-296.06477689181855,648.4127013098987,-0.0,-2248525.729748352,true,true,6.482185167,4818.1858822059985,0.0,1644.2724500334996,392.0,6.482185167,4818.1858822059985,0.0,121.92,0.0 -393,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,275100.0,5833.333333333334,9765916.435376657,5833.333333333334,7196172.744235654,true,393.0,393,0.875,0.0,0.0,0.0,0.0,0.0,393,21750.0,0.0,-10319.9096979551,-10319.9096979551,1415157.4970656477,700.0,275100.0,101.46913394708368,847273.5864953108,-10885.202883454172,23659.912689283767,0.0,0.0,668.1395875965949,543779.9007157879,-204.31553604460507,444.0971652652936,-0.0,-2248525.729748352,true,true,5.364567035,4823.550449240998,0.0,1644.2724500334996,393.0,5.364567035,4823.550449240998,0.0,121.92,0.0 -394,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,275800.0,5833.333333333334,9771749.768709991,5833.333333333334,7202006.077568987,true,394.0,394,0.875,0.0,0.0,0.0,0.0,0.0,394,21750.0,0.0,-10864.072067508407,-10864.072067508407,1404293.4249981393,700.0,275800.0,48.362346930702145,847321.9488422414,-11223.671084377205,12436.241604906561,0.0,0.0,521.9052627558324,544301.8059785437,-210.66859281773674,233.42857244755686,-0.0,-2248525.729748352,true,true,3.8893111,4827.439760340998,0.0,1644.2724500334996,394.0,3.8893111,4827.439760340998,0.0,121.92,0.0 -395,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,276500.0,5833.333333333334,9777583.102043325,5833.333333333334,7207839.41090232,true,395.0,395,0.875,0.0,0.0,0.0,0.0,0.0,395,21750.0,0.0,-7417.822908919587,-7417.822908919587,1396875.6020892197,700.0,276500.0,15.284585645136026,847337.2334278866,-7645.109284334358,4791.132320572204,0.0,0.0,355.5006862323436,544657.306664776,-143.49889646270796,89.9296759848489,-0.0,-2248525.729748352,true,true,2.414055166,4829.853815506998,0.0,1644.2724500334996,395.0,2.414055166,4829.853815506998,0.0,121.92,0.0 -396,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,277200.0,5833.333333333334,9783416.435376659,5833.333333333334,7213672.744235653,true,396.0,396,0.875,0.0,0.0,0.0,0.0,0.0,396,21750.0,0.0,-3951.480308328549,-3951.480308328549,1392924.1217808912,700.0,277200.0,2.3002769207802647,847339.5337048074,-4066.547494655964,724.5848259162399,0.0,0.0,189.0961097088548,544846.402774485,-76.32920030222022,13.600475682628684,-0.0,-2248525.729748352,true,true,0.938799231,4830.7926147379985,0.0,1644.2724500334996,396.0,0.938799231,4830.7926147379985,0.0,121.92,0.0 -397,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,277900.0,5833.333333333334,9789249.768709993,5833.333333333334,7219506.077568986,true,397.0,397,0.875,0.0,0.0,0.0,0.0,0.0,397,21750.0,0.0,-685.187895210597,-685.187895210597,1392238.9338856805,700.0,277900.0,0.05049567893915037,847339.5842004863,-724.5848259163639,-1.240323399542831e-10,0.0,0.0,52.94691070945558,544899.3496851944,-13.600475682627815,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,1644.2724500334996,397.0,0.0,4830.7926147379985,0.0,121.92,0.0 -398,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,278600.0,5833.333333333334,9795083.102043327,5833.333333333334,7225339.4109023195,true,398.0,398,0.875,0.0,0.0,0.0,0.0,0.0,398,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,278600.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,1644.2724500334996,398.0,0.0,4830.7926147379985,0.0,121.92,0.0 -399,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,279300.0,5833.333333333334,9800916.43537666,5833.333333333334,7231172.7442356525,true,399.0,399,0.875,0.0,0.0,0.0,0.0,0.0,399,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,279300.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,1644.2724500334996,399.0,0.0,4830.7926147379985,0.0,121.92,0.0 -400,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,280000.0,5833.333333333334,9806749.768709995,5833.333333333334,7237006.0775689855,true,400.0,400,0.875,0.0,0.0,0.0,0.0,0.0,400,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,280000.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,1644.2724500334996,400.0,0.0,4830.7926147379985,0.0,121.92,0.0 -401,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,280700.0,5833.333333333334,9812583.102043329,5833.333333333334,7242839.410902319,true,401.0,401,0.875,0.0,0.0,0.0,0.0,0.0,401,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,280700.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,1644.2724500334996,401.0,0.0,4830.7926147379985,0.0,121.92,0.0 -402,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,281400.0,5833.333333333334,9818416.435376663,5833.333333333334,7248672.744235652,true,402.0,402,0.875,0.0,0.0,0.0,0.0,0.0,402,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,281400.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,1644.2724500334996,402.0,0.0,4830.7926147379985,0.0,121.92,0.0 -403,22450.0,21750.0,0.16,1368.2268613201893,2571111.918002293,700.0,282100.0,12926.417883251184,9831342.853259914,11558.191021930996,7260230.935257583,true,403.0,403,0.875,1197.1985036551657,1368.2268613201893,171.02835766502358,0.0,0.0,403,21750.0,0.0,1197.1985036551657,1197.1985036551657,1393436.1323893357,700.0,282100.0,0.09583328521147606,847339.6800337716,1110.701457598817,1110.7014575986927,0.0,0.0,65.55331805345847,544964.9030032479,20.847894717678805,20.847894717679672,-1197.1985036551657,-2249722.9282520073,true,true,1.162322858,4831.954937595999,0.0,1644.2724500334996,403.0,1.162322858,4831.954937595999,0.0,121.92,0.0 -404,23818.22686132019,23118.22686132019,0.23500000000000001,5614.763082467892,2576726.681084761,700.0,282800.0,26871.332265820813,9858214.185525734,21256.56918335292,7281487.504440936,true,404.0,404,0.875,4912.917697159405,5614.763082467892,701.8453853084866,0.0,0.0,404,23118.22686132019,0.0,4912.917697159405,4912.917697159405,1398349.050086495,700.0,282800.0,3.348521633300225,847343.0285554049,4608.75382423358,5719.455281832274,0.0,0.0,214.30892434046203,545179.2119275883,86.50642695206237,107.35432166974203,-4912.917697159405,-2254635.845949167,true,true,2.637578792,4834.592516387998,0.0,1644.2724500334996,404.0,2.637578792,4834.592516387998,0.0,121.92,0.0 -405,28064.763082467893,27364.763082467893,0.30500000000000005,9989.117674403418,2586715.7987591643,700.0,283500.0,35046.28745706038,9893260.472982794,25057.169782656965,7306544.674223593,true,405.0,405,0.875,8740.477965102991,9989.117674403418,1248.639709300427,0.0,0.0,405,27364.763082467893,0.0,8740.477965102991,8740.477965102991,1407089.528051598,700.0,283500.0,18.772718752343465,847361.8012741572,8187.315622218238,13906.77090405051,0.0,0.0,380.7135008639508,545559.9254284523,153.6761232684589,261.03044493820096,-8740.477965102991,-2263376.32391427,true,true,4.112834727,4838.705351114998,0.0,1644.2724500334996,405.0,4.112834727,4838.705351114998,0.0,121.92,0.0 -406,32439.117674403416,31739.117674403416,0.335,14388.06484783743,2601103.8636070015,700.0,284200.0,45038.99954578337,9938299.472528577,30650.934697945944,7337195.608921539,true,406.0,406,0.875,12589.55674185775,14388.06484783743,1798.5081059796794,0.0,0.0,406,31739.117674403416,0.0,12589.55674185775,12589.55674185775,1419679.0847934557,700.0,284200.0,55.715435990423586,847417.5167101477,11765.87740910337,25672.64831315388,0.0,0.0,547.1180773874396,546107.0435058398,220.845819376517,481.87626431471796,-12589.55674185775,-2275965.880656128,true,true,5.588090661,4844.293441775998,0.0,1644.2724500334996,406.0,5.588090661,4844.293441775998,0.0,121.92,0.0 -407,36838.06484783743,36138.06484783743,0.35,18822.353715269743,2619926.2173222713,700.0,284900.0,55778.153472199265,9994077.626000777,36955.799756929526,7374151.408678468,true,407.0,407,0.875,16469.559500861025,18822.353715269743,2352.7942144087174,0.0,0.0,407,36138.06484783743,0.0,16469.559500861025,16469.559500861025,1436148.6442943166,700.0,284900.0,123.58211922664566,847541.0988293744,15344.439211939476,41017.08752509336,0.0,0.0,713.5226539109283,546820.5661597507,288.0155157839754,769.8917800986933,-16469.559500861025,-2292435.440156989,true,true,7.063346596,4851.356788371998,0.0,1644.2724500334996,407.0,7.063346596,4851.356788371998,0.0,121.92,0.0 -408,41272.35371526974,40572.35371526974,0.35666666666666663,23302.733314912777,2643228.950637184,700.0,285600.0,67297.38312592368,10061375.0091267,43994.649811010895,7418146.058489479,true,408.0,408,0.875,20389.89165054868,23302.733314912777,2912.841664364096,0.0,0.0,408,40572.35371526974,0.0,20389.89165054868,20389.89165054868,1456538.5359448653,700.0,285600.0,231.7782143401148,847772.8770437145,18923.000993973175,59940.088519066536,0.0,0.0,879.9272304344172,547700.4933901851,355.185211800972,1125.0769918996652,-20389.89165054868,-2312825.3318075375,true,true,8.53860253,4859.895390901998,0.0,1644.2724500334996,408.0,8.53860253,4859.895390901998,0.0,121.92,0.0 -409,45752.73331491278,45052.73331491278,0.3595,27839.952685323547,2671068.9033225076,700.0,286300.0,79387.90733052447,10140762.916457225,51547.95464520092,7469694.01313468,true,409.0,409,0.875,24359.958599658105,27839.952685323547,3479.994085665443,0.0,0.0,409,45052.73331491278,0.0,24359.958599658105,24359.958599658105,1480898.4945445235,700.0,286300.0,389.70916689484903,848162.5862106094,22501.562719333142,82441.65123839967,0.0,0.0,1046.3318066759132,548746.8251968609,422.35490675420107,1547.4318986538663,-24359.958599658105,-2337185.2904071957,true,true,10.01385846,4869.909249361998,0.0,1644.2724500334996,409.0,10.01385846,4869.909249361998,0.0,121.92,0.0 -410,50289.952685323544,49589.952685323544,0.36,25605.457347028765,2696674.3606695365,700.0,287000.0,73070.71485285768,10213833.631310083,47465.257505828915,7517159.270640508,true,410.0,410,0.875,22404.77517865017,25605.457347028765,3200.6821683785965,0.0,0.0,410,49589.952685323544,0.0,22404.77517865017,22404.77517865017,1503303.2697231737,700.0,287000.0,580.6726304220535,848743.2588410315,20248.941977462855,102690.59321586252,0.0,0.0,1195.0874128501196,549941.912609711,380.07315791514094,1927.5050565690071,-22404.77517865017,-2359590.065585846,true,true,11.17618132,4881.085430681998,0.0,1644.2724500334996,410.0,11.17618132,4881.085430681998,0.0,121.92,0.0 -411,48055.457347028765,47355.457347028765,0.28625,8073.24864091947,2704747.609310456,700.0,287700.0,30648.90354906365,10244482.534859147,22575.654908144177,7539734.925548652,true,411.0,411,0.875,7064.092560804536,8073.24864091947,1009.1560801149335,0.0,0.0,411,47355.457347028765,0.0,7064.092560804536,7064.092560804536,1510367.3622839781,700.0,287700.0,706.3954316362309,849449.6542726677,4988.298224439979,107678.8914403025,0.0,0.0,1275.7684196938221,551217.6810294049,93.6304850345049,2021.1355416035121,-7064.092560804536,-2366654.1581466505,true,true,11.44440967,4892.529840351998,0.0,1644.2724500334996,411.0,11.44440967,4892.529840351998,0.0,121.92,0.0 -412,30523.248640919468,29823.248640919468,0.355,21763.46161936718,2726511.0709298234,700.0,288400.0,63277.356674273746,10307759.891533421,41513.89505490656,7581248.820603559,true,412.0,412,0.875,19043.02891694628,21763.46161936718,2720.432702420898,0.0,0.0,412,29823.248640919468,0.0,19043.02891694628,19043.02891694628,1529410.3912009245,700.0,288400.0,816.3565742658346,850266.0108469336,16576.72631046246,124255.61775076496,0.0,0.0,1338.800456131844,552556.4814855367,311.14557608613876,2332.2811176896507,-19043.02891694628,-2385697.1870635967,true,true,12.29379945,4904.823639801998,0.0,1644.2724500334996,412.0,12.29379945,4904.823639801998,0.0,121.92,0.0 -413,44213.46161936718,43513.46161936718,0.3516666666666666,18964.759018554443,2745475.829948378,700.0,289100.0,55918.74602432544,10363678.637557747,36953.98700577099,7618202.80760933,true,413.0,413,0.875,16594.16414123514,18964.759018554443,2370.594877319305,0.0,0.0,413,43513.46161936718,0.0,16594.16414123514,16594.16414123514,1546004.5553421597,700.0,289100.0,983.4259744983184,851249.4368214319,13924.844454919332,138180.46220568428,0.0,0.0,1424.5240258680285,553981.0055114047,261.36968594946114,2593.650803639112,-16594.16414123514,-2402291.3512048316,true,true,12.96437033,4917.788010131998,0.0,1644.2724500334996,413.0,12.96437033,4917.788010131998,0.0,121.92,0.0 -414,41414.75901855444,40714.75901855444,0.335,14266.669021141239,2759742.498969519,700.0,289800.0,44676.623943705185,10408355.261501452,30409.954922563946,7648612.762531894,true,414.0,414,0.875,12483.335393498584,14266.669021141239,1783.3336276426544,0.0,0.0,414,40714.75901855444,0.0,12483.335393498584,12483.335393498584,1558487.8907356584,700.0,289800.0,1119.8306928548616,852369.2675142867,9693.992157469927,147874.45436315422,0.0,0.0,1487.5560628700357,555468.5615742748,181.95648030376034,2775.607283942872,-12483.335393498584,-2414774.6865983303,true,true,13.41141759,4931.199427721998,0.0,1644.2724500334996,414.0,13.41141759,4931.199427721998,0.0,121.92,0.0 -415,36716.669021141235,36016.669021141235,0.20800000000000002,4234.214840726034,2763976.713810245,700.0,290500.0,23722.186734259776,10432077.448235711,19487.971893533744,7668100.734425428,true,415.0,415,0.875,3704.93798563528,4234.214840726034,529.276855090754,0.0,0.0,415,36016.669021141235,0.0,3704.93798563528,3704.93798563528,1562192.8287212937,700.0,290500.0,1183.640312153131,853552.9078264398,987.4726279819884,148861.92699113622,0.0,0.0,1515.2901590606812,556983.8517333355,18.534886439479003,2794.142170382351,-3704.93798563528,-2418479.6245839656,true,true,13.45612231,4944.655550031998,0.0,1644.2724500334996,415.0,13.45612231,4944.655550031998,0.0,121.92,0.0 -416,26684.214840726032,25984.214840726032,0.17200000000000001,1934.7690934769655,2765911.482903722,700.0,291200.0,15318.424962075378,10447395.873197787,13383.655868598413,7681484.390294027,true,416.0,416,0.875,1692.9229567923448,1934.7690934769655,241.84613668462066,0.0,0.0,416,25984.214840726032,0.0,1692.9229567923448,1692.9229567923448,1563885.7516780861,700.0,291200.0,1183.640312153131,854736.548138593,-987.4726279819884,147874.45436315422,0.0,0.0,1515.2901590606812,558499.1418923963,-18.534886439479003,2775.607283942872,-1692.9229567923448,-2420172.547540758,true,true,13.41141759,4958.066967621999,0.0,1644.2724500334996,416.0,13.41141759,4958.066967621999,0.0,121.92,0.0 -417,24384.769093476963,23684.769093476963,0.12,0.0,2765911.482903722,700.0,291900.0,5833.333333333334,10453229.20653112,5833.333333333334,7687317.72362736,true,417.0,417,0.875,0.0,0.0,0.0,0.0,0.0,417,23684.769093476963,0.0,-332.5674446024675,-332.5674446024675,1563553.1842334836,700.0,291900.0,1160.1638400882891,855896.7119786813,-2942.7017313359215,144931.7526318183,0.0,0.0,1505.2050332757167,560004.346925672,-55.2345866305518,2720.3726973123203,-0.0,-2420172.547540758,true,true,13.27730341,4971.344271031999,0.0,1644.2724500334996,417.0,13.27730341,4971.344271031999,0.0,121.92,0.0 -418,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,292600.0,5833.333333333334,10459062.539864454,5833.333333333334,7693151.056960693,true,418.0,418,0.875,0.0,0.0,0.0,0.0,0.0,418,21750.0,0.0,-1342.9926110185363,-1342.9926110185363,1562210.1916224652,700.0,292600.0,1119.8306928548616,857016.5426715361,-3877.5967762500027,141054.1558555683,0.0,0.0,1487.5560628700357,561491.9029885421,-72.78259049343072,2647.5901068188896,-0.0,-2420172.547540758,true,true,13.09848451,4984.442755541999,0.0,1644.2724500334996,418.0,13.09848451,4984.442755541999,0.0,121.92,0.0 -419,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,293300.0,5833.333333333334,10464895.873197788,5833.333333333334,7698984.390294026,true,419.0,419,0.875,0.0,0.0,0.0,0.0,0.0,419,21750.0,0.0,-2328.4228024278555,-2328.4228024278555,1559881.7688200374,700.0,293300.0,1069.361954453522,858085.9046259896,-4773.058849973006,136281.0970055953,0.0,0.0,1464.8645295718727,562956.767518114,-89.5904364802446,2557.999670338645,-0.0,-2420172.547540758,true,true,12.87496088,4997.317716421999,0.0,1644.2724500334996,419.0,12.87496088,4997.317716421999,0.0,121.92,0.0 -420,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,294000.0,5833.333333333334,10470729.206531122,5833.333333333334,7704817.723627359,true,420.0,420,0.875,0.0,0.0,0.0,0.0,0.0,420,21750.0,0.0,-5174.891806221283,-5174.891806221283,1554706.877013816,700.0,294000.0,999.174492736611,859085.0791187262,-7466.016842686272,128815.08016290904,0.0,0.0,1432.0878704887448,564388.8553886027,-140.13732676036645,2417.862343578279,-0.0,-2420172.547540758,true,true,12.51732308,5009.835039501999,0.0,1644.2724500334996,420.0,12.51732308,5009.835039501999,0.0,121.92,0.0 -421,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,294700.0,5833.333333333334,10476562.539864456,5833.333333333334,7710651.056960692,true,421.0,421,0.875,0.0,0.0,0.0,0.0,0.0,421,21750.0,0.0,-24466.811987922632,-24466.811987922632,1530240.0650258935,700.0,294700.0,811.7530711655426,859896.8321898917,-26124.4869470465,102690.59321586255,0.0,0.0,1336.2791749675955,565725.1345635703,-490.3572870092716,1927.5050565690071,-0.0,-2420172.547540758,true,true,11.17618132,5021.011220821999,0.0,1644.2724500334996,421.0,11.17618132,5021.011220821999,0.0,121.92,0.0 -422,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,295400.0,5833.333333333334,10482395.87319779,5833.333333333334,7716484.390294025,true,422.0,422,0.875,0.0,0.0,0.0,0.0,0.0,422,21750.0,0.0,-24063.549042466155,-24063.549042466155,1506176.5159834274,700.0,295400.0,555.3246778605084,860452.1568677522,-25321.03567706439,77369.55753879817,0.0,0.0,1177.438442895627,566902.5730064659,-475.27648615790315,1452.228570411104,-0.0,-2420172.547540758,true,true,9.700925388,5030.7121462099985,0.0,1644.2724500334996,422.0,9.700925388,5030.7121462099985,0.0,121.92,0.0 -423,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,296100.0,5833.333333333334,10488229.206531124,5833.333333333334,7722317.723627358,true,423.0,423,0.875,0.0,0.0,0.0,0.0,0.0,423,21750.0,0.0,-20787.962579791783,-20787.962579791783,1485388.5534036355,700.0,296100.0,351.58428075642365,860803.7411485086,-21742.47393612097,55627.0836026772,0.0,0.0,1011.0338664849355,567913.6068729508,-408.1067909121724,1044.1217794989316,-0.0,-2420172.547540758,true,true,8.225669453,5038.937815662998,0.0,1644.2724500334996,423.0,8.225669453,5038.937815662998,0.0,121.92,0.0 -424,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,296800.0,5833.333333333334,10494062.539864458,5833.333333333334,7728151.056960691,true,424.0,424,0.875,0.0,0.0,0.0,0.0,0.0,424,21750.0,0.0,-17455.230840861954,-17455.230840861954,1467933.3225627735,700.0,296800.0,204.98909254787833,861008.7302410565,-18163.91212894797,37463.171473729235,0.0,0.0,844.6292899614467,568758.2361629122,-340.9370944233103,703.1846850756212,-0.0,-2420172.547540758,true,true,6.750413519,5045.688229181998,0.0,1644.2724500334996,424.0,6.750413519,5045.688229181998,0.0,121.92,0.0 -425,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,297500.0,5833.333333333334,10499895.873197792,5833.333333333334,7733984.390294024,true,425.0,425,0.875,0.0,0.0,0.0,0.0,0.0,425,21750.0,0.0,-14074.759363843074,-14074.759363843074,1453858.5631989304,700.0,297500.0,106.1336675153654,861114.8639085719,-14585.35034639974,22877.821127329495,0.0,0.0,678.224713437958,569436.4608763502,-273.76739839665595,429.4172866789653,-0.0,-2420172.547540758,true,true,5.275157584,5050.963386765999,0.0,1644.2724500334996,425.0,5.275157584,5050.963386765999,0.0,121.92,0.0 -426,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,298200.0,5833.333333333334,10505729.206531126,5833.333333333334,7739817.723627357,true,426.0,426,0.875,0.0,0.0,0.0,0.0,0.0,426,21750.0,0.0,-10655.953549382784,-10655.953549382784,1443202.6096495476,700.0,298200.0,45.61255977977984,861160.4764683517,-11006.788544078177,11871.032583251317,0.0,0.0,511.8201369144692,569948.2810132647,-206.59770199885568,222.8195846801096,-0.0,-2420172.547540758,true,true,3.79990165,5054.763288415998,0.0,1644.2724500334996,426.0,3.79990165,5054.763288415998,0.0,121.92,0.0 -427,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,298900.0,5833.333333333334,10511562.53986446,5833.333333333334,7745651.05696069,true,427.0,427,0.875,0.0,0.0,0.0,0.0,0.0,427,21750.0,0.0,-7208.218878706637,-7208.218878706637,1435994.390770841,700.0,298900.0,14.020323462016645,861174.4967918136,-7428.226756678495,4442.805826572822,0.0,0.0,345.41556039098043,570293.6965736557,-139.42800588113943,83.39157879897019,-0.0,-2420172.547540758,true,true,2.324645715,5057.087934130998,0.0,1644.2724500334996,427.0,2.324645715,5057.087934130998,0.0,121.92,0.0 -428,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,299600.0,5833.333333333334,10517395.873197794,5833.333333333334,7751484.390294023,true,428.0,428,0.875,0.0,0.0,0.0,0.0,0.0,428,21750.0,0.0,-3740.960773713411,-3740.960773713411,1432253.4299971275,700.0,299600.0,1.9515126811261934,861176.4483044947,-3849.6649606050146,593.1408659678077,0.0,0.0,179.0109838110931,570472.7075574668,-72.25830960061573,11.133269198354455,-0.0,-2420172.547540758,true,true,0.84938978,5057.937323910998,0.0,1644.2724500334996,428.0,0.84938978,5057.937323910998,0.0,121.92,0.0 -429,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,300300.0,5833.333333333334,10523229.206531128,5833.333333333334,7757317.723627356,true,429.0,429,0.875,0.0,0.0,0.0,0.0,0.0,429,21750.0,0.0,-556.3323886516241,-556.3323886516241,1431697.097608476,700.0,300300.0,0.03739875405672881,861176.4857032488,-593.1408659679017,-9.401901479577646e-11,0.0,0.0,47.90434776057472,570520.6119052274,-11.133269198353863,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,429.0,0.0,5057.937323910998,0.0,121.92,0.0 -430,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,301000.0,5833.333333333334,10529062.539864462,5833.333333333334,7763151.056960689,true,430.0,430,0.875,0.0,0.0,0.0,0.0,0.0,430,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,301000.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,430.0,0.0,5057.937323910998,0.0,121.92,0.0 -431,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,301700.0,5833.333333333334,10534895.873197796,5833.333333333334,7768984.390294022,true,431.0,431,0.875,0.0,0.0,0.0,0.0,0.0,431,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,301700.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,431.0,0.0,5057.937323910998,0.0,121.92,0.0 -432,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,302400.0,5833.333333333334,10540729.20653113,5833.333333333334,7774817.723627355,true,432.0,432,0.875,0.0,0.0,0.0,0.0,0.0,432,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,302400.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,432.0,0.0,5057.937323910998,0.0,121.92,0.0 -433,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,303100.0,5833.333333333334,10546562.539864464,5833.333333333334,7780651.056960688,true,433.0,433,0.875,0.0,0.0,0.0,0.0,0.0,433,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,303100.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,433.0,0.0,5057.937323910998,0.0,121.92,0.0 -434,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,303800.0,5833.333333333334,10552395.873197798,5833.333333333334,7786484.390294021,true,434.0,434,0.875,0.0,0.0,0.0,0.0,0.0,434,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,303800.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,434.0,0.0,5057.937323910998,0.0,121.92,0.0 -435,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,304500.0,5833.333333333334,10558229.206531132,5833.333333333334,7792317.723627354,true,435.0,435,0.875,0.0,0.0,0.0,0.0,0.0,435,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,304500.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,435.0,0.0,5057.937323910998,0.0,121.92,0.0 -436,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,305200.0,5833.333333333334,10564062.539864466,5833.333333333334,7798151.056960687,true,436.0,436,0.875,0.0,0.0,0.0,0.0,0.0,436,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,305200.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,436.0,0.0,5057.937323910998,0.0,121.92,0.0 -437,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,305900.0,5833.333333333334,10569895.8731978,5833.333333333334,7803984.39029402,true,437.0,437,0.875,0.0,0.0,0.0,0.0,0.0,437,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,305900.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,437.0,0.0,5057.937323910998,0.0,121.92,0.0 -438,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,306600.0,5833.333333333334,10575729.206531134,5833.333333333334,7809817.723627353,true,438.0,438,0.875,0.0,0.0,0.0,0.0,0.0,438,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,306600.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,438.0,0.0,5057.937323910998,0.0,121.92,0.0 -439,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,307300.0,5833.333333333334,10581562.539864467,5833.333333333334,7815651.056960686,true,439.0,439,0.875,0.0,0.0,0.0,0.0,0.0,439,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,307300.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,439.0,0.0,5057.937323910998,0.0,121.92,0.0 -440,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,308000.0,5833.333333333334,10587395.873197801,5833.333333333334,7821484.390294019,true,440.0,440,0.875,0.0,0.0,0.0,0.0,0.0,440,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,308000.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,440.0,0.0,5057.937323910998,0.0,121.92,0.0 -441,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,308700.0,5833.333333333334,10593229.206531135,5833.333333333334,7827317.723627352,true,441.0,441,0.875,0.0,0.0,0.0,0.0,0.0,441,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,308700.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,441.0,0.0,5057.937323910998,0.0,121.92,0.0 -442,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,309400.0,5833.333333333334,10599062.53986447,5833.333333333334,7833151.056960685,true,442.0,442,0.875,0.0,0.0,0.0,0.0,0.0,442,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,309400.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,442.0,0.0,5057.937323910998,0.0,121.92,0.0 -443,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,310100.0,5833.333333333334,10604895.873197803,5833.333333333334,7838984.390294018,true,443.0,443,0.875,0.0,0.0,0.0,0.0,0.0,443,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,310100.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,443.0,0.0,5057.937323910998,0.0,121.92,0.0 -444,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,310800.0,5833.333333333334,10610729.206531137,5833.333333333334,7844817.723627351,true,444.0,444,0.875,0.0,0.0,0.0,0.0,0.0,444,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,310800.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,444.0,0.0,5057.937323910998,0.0,121.92,0.0 -445,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,311500.0,5833.333333333334,10616562.539864471,5833.333333333334,7850651.056960684,true,445.0,445,0.875,0.0,0.0,0.0,0.0,0.0,445,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,311500.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,445.0,0.0,5057.937323910998,0.0,121.92,0.0 -446,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,312200.0,5833.333333333334,10622395.873197805,5833.333333333334,7856484.390294017,true,446.0,446,0.875,0.0,0.0,0.0,0.0,0.0,446,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,312200.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,446.0,0.0,5057.937323910998,0.0,121.92,0.0 -447,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,312900.0,5833.333333333334,10628229.20653114,5833.333333333334,7862317.72362735,true,447.0,447,0.875,0.0,0.0,0.0,0.0,0.0,447,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,312900.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,1644.2724500334996,447.0,0.0,5057.937323910998,0.0,121.92,0.0 -448,22450.0,21750.0,0.1768,2178.5874071500493,2768090.070310872,700.0,313600.0,16281.602981617925,10644510.809512757,14103.015574467876,7876420.739201819,true,448.0,448,0.875,1906.2639812562932,2178.5874071500493,272.32342589375617,0.0,0.0,448,21750.0,0.0,1906.2639812562932,1906.2639812562932,1433603.3615897323,700.0,313600.0,0.19594678934725546,861176.6816500381,1789.2808980367404,1789.2808980366462,0.0,0.0,83.20228828994367,570603.8141935173,33.58484814026184,33.58484814026243,-1906.2639812562932,-2422078.811522014,true,true,1.475255935,5059.412579845998,0.0,1644.2724500334996,448.0,1.475255935,5059.412579845998,0.0,121.92,0.0 -449,24628.58740715005,23928.58740715005,0.265,6541.136756240824,2774631.207067113,700.0,314300.0,27325.04436317292,10671835.85387593,20783.907606932098,7897204.646808751,true,449.0,449,0.875,5723.494661710721,6541.136756240824,817.6420945301033,0.0,0.0,449,23928.58740715005,0.0,5723.494661710721,5723.494661710721,1439326.856251443,700.0,314300.0,5.290563308789698,861181.9722133469,5367.842689258775,7157.123587295421,0.0,0.0,249.60686481343245,570853.4210583308,100.75454432972379,134.33939246998622,-5723.494661710721,-2427802.3061837247,true,true,2.950511869,5062.3630917149985,0.0,1644.2724500334996,449.0,2.950511869,5062.3630917149985,0.0,121.92,0.0 -450,28991.136756240823,28291.136756240823,0.30500000000000005,10919.809735313333,2785551.0168024264,700.0,315000.0,38097.73683709289,10709933.590713022,27177.927101779555,7924382.573910531,true,450.0,450,0.875,9554.833518399166,10919.809735313333,1364.9762169141668,0.0,0.0,450,28291.136756240823,0.0,9554.833518399166,9554.833518399166,1448881.6897698422,700.0,315000.0,24.493348648483604,861206.4655619954,8946.404487757982,16103.528075053404,0.0,0.0,416.0114413369212,571269.4324996677,167.9242406557784,302.2636331257646,-9554.833518399166,-2437357.139702124,true,true,4.425767804,5066.788859518999,0.0,1644.2724500334996,450.0,4.425767804,5066.788859518999,0.0,121.92,0.0 -451,33369.809735313334,32669.809735313334,0.33999999999999997,15325.35540277793,2800876.3722052043,700.0,315700.0,47133.39824346451,10757066.988956487,31808.042840686576,7956190.616751217,true,451.0,451,0.875,13409.685977430689,15325.35540277793,1915.6694253472415,0.0,0.0,451,32669.809735313334,0.0,13409.685977430689,13409.685977430689,1462291.375747273,700.0,315700.0,67.20974868753402,861273.675310683,12524.966274128567,28628.494349181972,0.0,0.0,582.41601786041,571851.8485175282,235.09393675417851,537.3575698799432,-13409.685977430689,-2450766.8256795546,true,true,5.901023738,5072.689883256999,0.0,1644.2724500334996,451.0,5.901023738,5072.689883256999,0.0,121.92,0.0 -452,37775.35540277793,37075.35540277793,0.3516666666666666,19768.52287353081,2820644.895078735,700.0,316400.0,58204.330446059175,10815271.319402546,38435.80757252837,7994626.424323746,true,452.0,452,0.875,17297.457514339458,19768.52287353081,2471.0653591913506,0.0,0.0,452,37075.35540277793,0.0,17297.457514339458,17297.457514339458,1479588.8332616123,700.0,316400.0,142.84520930504598,861416.520519988,16103.528077479215,44732.02242666119,0.0,0.0,748.8205943838988,572600.669111912,302.2636331712946,839.6212030512378,-17297.457514339458,-2468064.283193894,true,true,7.376279673,5080.066162929998,0.0,1644.2724500334996,452.0,7.376279673,5080.066162929998,0.0,121.92,0.0 -453,42218.522873530805,41518.522873530805,0.35833333333333334,24260.06118338802,2844904.956262123,700.0,317100.0,69655.98469782704,10884927.304100372,45395.92351443901,8040022.347838185,true,453.0,453,0.875,21227.553535464518,24260.06118338802,3032.507647923503,0.0,0.0,453,41518.522873530805,0.0,21227.553535464518,21227.553535464518,1500816.3867970768,700.0,317100.0,260.8051763801247,861677.3256963681,19682.089858998374,64414.11228565956,0.0,0.0,915.2251709073876,573515.8942828194,369.43332917863336,1209.0545322298713,-21227.553535464518,-2489291.836729359,true,true,8.851535607,5088.917698536999,0.0,1644.2724500334996,453.0,8.851535607,5088.917698536999,0.0,121.92,0.0 -454,46710.061183388025,46010.061183388025,0.359,28810.719430017118,2873715.67569214,700.0,317800.0,82202.56108639867,10967129.865186771,53391.84165638155,8093414.189494566,true,454.0,454,0.875,25209.37950126498,28810.719430017118,3601.339928752139,0.0,0.0,454,46010.061183388025,0.0,25209.37950126498,25209.37950126498,1526025.7662983418,700.0,317800.0,430.49509565719336,862107.8207920253,23260.65163324033,87674.76391889989,0.0,0.0,1081.6297473180794,574597.5240301375,436.60302504937886,1645.65755727925,-25209.37950126498,-2514501.216230624,true,true,10.32679154,5099.244490076999,0.0,1644.2724500334996,454.0,10.32679154,5099.244490076999,0.0,121.92,0.0 -455,51260.71943001712,50560.71943001712,0.357,33431.24687635975,2907146.9225685,700.0,318500.0,95605.73354722619,11062735.598733997,62174.48667086644,8155588.676165433,true,455.0,455,0.875,29252.341016814782,33431.24687635975,4178.905859544968,0.0,0.0,455,50560.71943001712,0.0,29252.341016814782,29252.341016814782,1555278.1073151566,700.0,318500.0,661.3204135987122,862769.141205624,26839.2135554514,114513.97747435128,0.0,0.0,1248.0343240671623,575845.5583542046,503.77272369750847,2149.4302809767587,-29252.341016814782,-2543753.5572474385,true,true,11.80204748,5111.046537556998,0.0,1644.2724500334996,455.0,11.80204748,5111.046537556998,0.0,121.92,0.0 -456,55881.24687635975,55181.24687635975,0.345,17069.894168305917,2924216.816736806,700.0,319200.0,51506.939618278026,11114242.538352275,34437.04544997211,8190025.721615405,true,456.0,456,0.875,14936.157397267676,17069.894168305917,2133.7367710382405,0.0,0.0,456,55181.24687635975,0.0,14936.157397267676,14936.157397267676,1570214.2647124243,700.0,319200.0,868.1488445557435,863637.2900501797,12467.459467303652,126981.43694165493,0.0,0.0,1366.5345528864748,577212.0929070911,234.0145325218045,2383.4448134985632,-14936.157397267676,-2558689.7146447063,true,true,12.42791363,5123.4744511869985,0.0,1644.2724500334996,456.0,12.42791363,5123.4744511869985,0.0,121.92,0.0 -457,39519.89416830592,38819.89416830592,0.345,16938.093109240115,2941154.9098460465,700.0,319900.0,51124.90756301483,11165367.44591529,34186.814453774714,8224212.53606918,true,457.0,457,0.875,14820.8314705851,16938.093109240115,2117.2616386550144,0.0,0.0,457,38819.89416830592,0.0,14820.8314705851,14820.8314705851,1585035.0961830094,700.0,319900.0,1004.461119889405,864641.7511700691,12153.63711943888,139135.07406109382,0.0,0.0,1434.6091522169786,578646.7020593081,228.12407903983691,2611.5688925384,-14820.8314705851,-2573510.5461152913,true,true,13.00907506,5136.483526246999,0.0,1644.2724500334996,457.0,13.00907506,5136.483526246999,0.0,121.92,0.0 -458,39388.093109240115,38688.093109240115,0.358,30955.857289350188,2972110.7671353966,700.0,320600.0,88424.18237248657,11253791.628287775,57468.325083136384,8281680.861152316,true,458.0,458,0.875,27086.375128181415,30955.857289350188,3869.482161168773,0.0,0.0,458,38688.093109240115,0.0,27086.375128181415,27086.375128181415,1612121.4713111909,700.0,320600.0,1213.4285375204897,865855.1797075896,23896.511885861124,163031.58594695496,0.0,0.0,1527.8965665738797,580174.598625882,448.5381382259236,3060.107030764324,-27086.375128181415,-2600596.9212434725,true,true,14.08198847,5150.565514716999,0.0,1644.2724500334996,458.0,14.08198847,5150.565514716999,0.0,121.92,0.0 -459,53405.857289350184,52705.857289350184,0.355,22039.10071064094,2994149.8678460377,700.0,321300.0,64053.80481870688,11317845.433106482,42014.70410806594,8323695.565260382,true,459.0,459,0.875,19284.213121810822,22039.10071064094,2754.887588830119,0.0,0.0,459,52705.857289350184,0.0,19284.213121810822,19284.213121810822,1631405.6844330018,700.0,321300.0,1463.1049380067125,867318.2846455963,15896.503856718986,178928.08980367394,0.0,0.0,1626.2265438232632,581800.8251697052,298.37778326186145,3358.4848140261856,-19284.213121810822,-2619881.1343652834,true,true,14.75255935,5165.3180740669995,0.0,1644.2724500334996,459.0,14.75255935,5165.3180740669995,0.0,121.92,0.0 -460,44489.10071064094,43789.10071064094,0.3175,11404.28836633784,3005554.1562123755,700.0,322000.0,38123.742886103435,11355969.175992586,26719.454519765597,8350415.019780148,true,460.0,460,0.875,9978.75232054561,11404.28836633784,1425.5360457922307,0.0,0.0,460,43789.10071064094,0.0,9978.75232054561,9978.75232054561,1641384.4367535473,700.0,322000.0,1610.7161737802023,868929.0008193764,6565.625729708203,185493.71553338214,0.0,0.0,1679.17345447632,583479.9986241815,123.23696258088448,3481.7217766070703,-9978.75232054561,-2629859.886685829,true,true,15.0207877,5180.338861767,0.0,1644.2724500334996,460.0,15.0207877,5180.338861767,0.0,121.92,0.0 -461,33854.28836633784,33154.28836633784,0.3516666666666666,19667.106652436312,3025221.262864812,700.0,322700.0,57915.94308749663,11413885.119080082,38248.836435060315,8388663.856215209,true,461.0,461,0.875,17208.718320881773,19667.106652436312,2458.388331554539,0.0,0.0,461,33154.28836633784,0.0,17208.718320881773,17208.718320881773,1658593.155074429,700.0,322700.0,1744.8762726945233,870673.877092071,13486.150145124762,198979.8656785069,0.0,0.0,1724.556520508661,585204.5551446902,253.13538255382687,3734.857159160897,-17208.718320881773,-2647068.605006711,true,true,15.5572444,5195.896106167,0.0,1644.2724500334996,461.0,15.5572444,5195.896106167,0.0,121.92,0.0 -462,42117.10665243631,41417.10665243631,0.28625,8153.975857541137,3033375.238722353,700.0,323400.0,30930.92002634458,11444816.039106427,22776.944168803442,8411440.800384013,true,462.0,462,0.875,7134.7288753484945,8153.975857541137,1019.2469821926425,0.0,0.0,462,41417.10665243631,0.0,7134.7288753484945,7134.7288753484945,1665727.8839497776,700.0,323400.0,1862.2065897062491,872536.0836817772,3445.474891474757,202425.34056998166,0.0,0.0,1762.375742484271,586966.9308871744,64.6716516832171,3799.528810844114,-7134.7288753484945,-2654203.3338820594,true,true,15.69135858,5211.587464747,0.0,1644.2724500334996,462.0,15.69135858,5211.587464747,0.0,121.92,0.0 -463,30603.975857541136,29903.975857541136,0.30500000000000005,11001.857187552174,3044377.095909905,700.0,324100.0,38366.74487722023,11483182.783983648,27364.88768966806,8438805.688073682,true,463.0,463,0.875,9626.625039108152,11001.857187552174,1375.2321484440217,0.0,0.0,463,29903.975857541136,0.0,9626.625039108152,9626.625039108152,1675354.5089888857,700.0,324100.0,1926.8795748703742,874462.9632566476,5808.179787281239,208233.5203572629,0.0,0.0,1782.5459940542003,588749.4768812286,109.01968290233931,3908.5484937464535,-9626.625039108152,-2663829.9589211675,true,true,15.9148822,5227.502346947,0.0,1644.2724500334996,463.0,15.9148822,5227.502346947,0.0,121.92,0.0 -464,33451.857187552174,32751.857187552174,0.3175,11221.094229335808,3055598.190139241,700.0,324800.0,37546.753478223014,11520729.537461871,26325.659248887205,8465131.347322568,true,464.0,464,0.875,9818.457450668831,11221.094229335808,1402.6367786669762,0.0,0.0,464,32751.857187552174,0.0,9818.457450668831,9818.457450668831,1685172.9664395545,700.0,324800.0,2009.8044278032182,876472.7676844508,5890.3325225089075,214123.85287977182,0.0,0.0,1807.7588085166117,590557.2356897453,110.5616918400946,4019.110185586548,-9818.457450668831,-2673648.4163718363,true,true,16.13840583,5243.640752777,0.0,1644.2724500334996,464.0,16.13840583,5243.640752777,0.0,121.92,0.0 -465,33671.09422933581,32971.09422933581,0.1912,3033.8271421138465,3058632.017281355,700.0,325500.0,19528.384634486643,11540257.922096359,16494.557492372798,8481625.904814942,true,465.0,465,0.875,2654.598749349616,3033.8271421138465,379.22839276423065,0.0,0.0,465,32971.09422933581,0.0,2654.598749349616,2654.598749349616,1687827.565188904,700.0,325500.0,2043.6293242594552,878516.3970087103,-1184.6388085290018,212939.2140712428,0.0,0.0,1817.8439343015766,592375.0796240468,-22.23570068241439,3996.8744849041336,-2654.598749349616,-2676303.015121186,true,true,16.0937011,5259.734453876999,0.0,1644.2724500334996,465.0,16.0937011,5259.734453876999,0.0,121.92,0.0 -466,25483.827142113845,24783.827142113845,0.23500000000000001,5792.397448882797,3064424.414730238,700.0,326200.0,27627.223186735304,11567885.145283094,21834.82573785251,8503460.730552794,true,466.0,466,0.875,5068.347767772448,5792.397448882797,724.0496811103494,0.0,0.0,466,24783.827142113845,0.0,5068.347767772448,5068.347767772448,1692895.9129566764,700.0,326200.0,2043.6293242594552,880560.0263329698,1184.6388085290018,214123.85287977182,0.0,0.0,1817.8439343015766,594192.9235583483,22.23570068241439,4019.110185586548,-5068.347767772448,-2681371.362888959,true,true,16.13840583,5275.872859706999,0.0,1644.2724500334996,466.0,16.13840583,5275.872859706999,0.0,121.92,0.0 -467,28242.397448882795,27542.397448882795,0.23500000000000001,5821.4762081118115,3070245.8909383495,700.0,326900.0,27750.962587709833,11595636.107870804,21929.48637959802,8525390.216932392,true,467.0,467,0.875,5093.791682097835,5821.4762081118115,727.6845260139762,0.0,0.0,467,27542.397448882795,0.0,5093.791682097835,5093.791682097835,1697989.7046387743,700.0,326900.0,2060.6831669298017,882620.7094998995,1187.9246421113255,215311.77752188314,0.0,0.0,1822.8864971940588,596015.8100555424,22.29737586264917,4041.407561449197,-5093.791682097835,-2686465.154571057,true,true,16.18311055,5292.055970256999,0.0,1644.2724500334996,467.0,16.18311055,5292.055970256999,0.0,121.92,0.0 -468,28271.47620811181,27571.47620811181,0.16720000000000002,1663.3292831870199,3071909.2202215367,700.0,327600.0,14134.744516668778,11609770.852387473,12471.415233481757,8537861.632165873,true,468.0,468,0.875,1455.4131227886423,1663.3292831870199,207.91616039837754,0.0,0.0,468,27571.47620811181,0.0,1455.4131227886423,1455.4131227886423,1699445.1177615628,700.0,327600.0,2052.1444345082086,884672.8539344077,-2372.5634506403276,212939.2140712428,0.0,0.0,1820.3652154658248,597836.1752710082,-44.53307654506356,3996.8744849041336,-1455.4131227886423,-2687920.5676938454,true,true,16.0937011,5308.149671356999,0.0,1644.2724500334996,468.0,16.0937011,5308.149671356999,0.0,121.92,0.0 -469,24113.32928318702,23413.32928318702,0.128,248.0307685541063,3072157.250990091,700.0,328300.0,7406.490379328956,11617177.342766803,7158.459610774849,8545020.091776649,true,469.0,469,0.875,217.026922484843,248.0307685541063,31.00384606926329,0.0,0.0,469,23413.32928318702,0.0,217.026922484843,217.026922484843,1699662.1446840477,700.0,328300.0,2009.8044278032194,886682.658362211,-3534.199302687979,209405.01476855483,0.0,0.0,1807.7588085166121,599643.9340795248,-66.33701114700936,3930.537473757124,-217.026922484843,-2688137.59461633,true,true,15.95958693,5324.109258286999,0.0,1644.2724500334996,469.0,15.95958693,5324.109258286999,0.0,121.92,0.0 -470,22698.030768554105,21998.030768554105,0.29250000000000004,8477.828057319795,3080635.0790474107,700.0,329000.0,31377.189939554853,11648554.532706358,22899.361882235058,8567919.453658884,true,470.0,470,0.875,7418.0995501548205,8477.828057319795,1059.7285071649749,0.0,0.0,470,21998.030768554105,0.0,7418.0995501548205,7418.0995501548205,1707080.2442342024,700.0,329000.0,2009.8044278032194,888692.4627900142,3534.199302687979,212939.2140712428,0.0,0.0,1807.7588085166121,601451.6928880415,66.33701114700936,3996.8744849041336,-7418.0995501548205,-2695555.694166485,true,true,16.0937011,5340.202959386998,0.0,1644.2724500334996,470.0,16.0937011,5340.202959386998,0.0,121.92,0.0 -471,30927.828057319795,30227.828057319795,0.20800000000000002,4400.526231122673,3085035.6052785334,700.0,329700.0,24521.76072655131,11673076.293432908,20121.23449542864,8588040.688154314,true,471.0,471,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,471,30227.828057319795,0.0,3850.460452232339,3850.460452232339,1710930.7046864347,700.0,329700.0,2035.1377996589958,890727.6005896733,0.0,212939.2140712428,0.0,0.0,1815.3226525733428,603267.0155406148,0.0,3996.8744849041336,-3850.460452232339,-2699406.1546187177,true,true,16.0937011,5356.296660486998,0.0,1644.2724500334996,471.0,16.0937011,5356.296660486998,0.0,121.92,0.0 -472,26850.526231122672,26150.526231122672,0.12,0.0,3085035.6052785334,700.0,330400.0,5833.333333333334,11678909.626766242,5833.333333333334,8593874.021487648,true,472.0,472,0.875,0.0,0.0,0.0,0.0,0.0,472,26150.526231122672,0.0,-987.3752520848134,-987.3752520848134,1709943.32943435,700.0,330400.0,2001.4069262643948,892729.0075159377,-4705.693713979906,208233.5203572629,0.0,0.0,1805.2375267883779,605072.2530674032,-88.3259911576802,3908.5484937464535,-0.0,-2699406.1546187177,true,true,15.9148822,5372.211542686998,0.0,1644.2724500334996,472.0,15.9148822,5372.211542686998,0.0,121.92,0.0 -473,22450.0,21750.0,0.1888,2928.303890010748,3087963.909168544,700.0,331100.0,19217.71128183659,11698127.338048078,16289.407391825842,8610163.428879473,true,473.0,473,0.875,2562.2659037594044,2928.303890010748,366.0379862513437,0.0,0.0,473,21750.0,0.0,2562.2659037594044,2562.2659037594044,1712505.5953381094,700.0,331100.0,1959.7701295241397,894688.7776454618,-1168.2080506660843,207065.3123065968,0.0,0.0,1792.631119839165,606864.8841872424,-21.927294937816075,3886.6211988086375,-2562.2659037594044,-2701968.420522477,true,true,15.87017748,5388.081720166998,0.0,1644.2724500334996,473.0,15.87017748,5388.081720166998,0.0,121.92,0.0 -474,25378.30389001075,24678.30389001075,0.1888,2907.519070692719,3090871.428239237,700.0,331800.0,19107.622196465672,11717234.960244544,16200.103125772954,8626363.532005247,true,474.0,474,0.875,2544.079186856129,2907.519070692719,363.43988383659007,0.0,0.0,474,24678.30389001075,0.0,2544.079186856129,2544.079186856129,1715049.6745249655,700.0,331800.0,1943.278462257622,896632.0561077194,-1164.922212673377,205900.39009392343,0.0,0.0,1787.5885569466825,608652.4727441891,-21.865619674798342,3864.755579133839,-2544.079186856129,-2704512.4997093333,true,true,15.82547275,5403.907192916998,0.0,1644.2724500334996,474.0,15.82547275,5403.907192916998,0.0,121.92,0.0 -475,25357.51907069272,24657.51907069272,0.1648,1525.9514191051114,3092397.3796583423,700.0,332500.0,13506.98676641451,11730741.947010959,11981.035347309398,8638344.567352556,true,475.0,475,0.875,1335.2074917169725,1525.9514191051114,190.7439273881389,0.0,0.0,475,24657.51907069272,0.0,1335.2074917169725,1335.2074917169725,1716384.8820166825,700.0,332500.0,1918.7148409319614,898550.7709486514,-2319.9858675724904,203580.40422635095,0.0,0.0,1780.0247123259664,610432.4974565151,-43.546193968464955,3821.209385165374,-1335.2074917169725,-2705847.70720105,true,true,15.7360633,5419.6432562169975,0.0,1644.2724500334996,475.0,15.7360633,5419.6432562169975,0.0,121.92,0.0 -476,23975.951419105113,23275.951419105113,0.20800000000000002,4202.784893801744,3096600.1645521442,700.0,333200.0,23571.081220200693,11754313.028231159,19368.296326398948,8657712.863678955,true,476.0,476,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,476,23275.951419105113,0.0,3677.4367820765265,3677.4367820765265,1720062.318798759,700.0,333200.0,1902.4546326430423,900453.2255812944,0.0,203580.40422635095,0.0,0.0,1774.982149433484,612207.4796059486,0.0,3821.209385165374,-3677.4367820765265,-2709525.1439831266,true,true,15.7360633,5435.379319516997,0.0,1644.2724500334996,476.0,15.7360633,5435.379319516997,0.0,121.92,0.0 -477,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3100802.949445946,700.0,333900.0,23571.081220200693,11777884.10945136,19368.296326398948,8677081.160005353,true,477.0,477,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,477,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1723739.7555808355,700.0,333900.0,1902.4546326430423,902355.6802139374,0.0,203580.40422635095,0.0,0.0,1774.982149433484,613982.461755382,0.0,3821.209385165374,-3677.4367820765265,-2713202.580765203,true,true,15.7360633,5451.115382816997,0.0,1644.2724500334996,477.0,15.7360633,5451.115382816997,0.0,121.92,0.0 -478,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3105005.734339748,700.0,334600.0,23571.081220200693,11801455.19067156,19368.296326398948,8696449.456331752,true,478.0,478,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,478,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1727417.192362912,700.0,334600.0,1902.4546326430423,904258.1348465804,0.0,203580.40422635095,0.0,0.0,1774.982149433484,615757.4439048155,0.0,3821.209385165374,-3677.4367820765265,-2716880.0175472796,true,true,15.7360633,5466.851446116997,0.0,1644.2724500334996,478.0,15.7360633,5466.851446116997,0.0,121.92,0.0 -479,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3109208.51923355,700.0,335300.0,23571.081220200693,11825026.27189176,19368.296326398948,8715817.752658151,true,479.0,479,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,479,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1731094.6291449885,700.0,335300.0,1902.4546326430423,906160.5894792235,0.0,203580.40422635095,0.0,0.0,1774.982149433484,617532.4260542489,0.0,3821.209385165374,-3677.4367820765265,-2720557.454329356,true,true,15.7360633,5482.587509416997,0.0,1644.2724500334996,479.0,15.7360633,5482.587509416997,0.0,121.92,0.0 -480,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3113411.304127352,700.0,336000.0,23571.081220200693,11848597.35311196,19368.296326398948,8735186.04898455,true,480.0,480,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,480,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1734772.065927065,700.0,336000.0,1902.4546326430423,908063.0441118665,0.0,203580.40422635095,0.0,0.0,1774.982149433484,619307.4082036824,0.0,3821.209385165374,-3677.4367820765265,-2724234.8911114326,true,true,15.7360633,5498.323572716997,0.0,1644.2724500334996,480.0,15.7360633,5498.323572716997,0.0,121.92,0.0 -481,26652.784893801745,25952.784893801745,0.16240000000000002,1492.6687901069624,3114903.972917459,700.0,336700.0,13501.655111496075,11862099.008223455,12008.986321389113,8747195.03530594,true,481.0,481,0.875,1306.0851913435922,1492.6687901069624,186.58359876337022,0.0,0.0,481,25952.784893801745,0.0,1306.0851913435922,1306.0851913435922,1736078.1511184087,700.0,336700.0,1886.2865499323998,909949.330661799,-2306.841471805496,201273.56275454545,0.0,0.0,1769.9395865410017,621077.3477902234,-43.299473324313254,3777.909911841061,-1306.0851913435922,-2725540.976302776,true,true,15.64665385,5513.970226566997,0.0,1644.2724500334996,481.0,15.64665385,5513.970226566997,0.0,121.92,0.0 -482,23942.668790106964,23242.668790106964,0.23500000000000001,5507.487993824397,3120411.4609112833,700.0,337400.0,26414.842526912325,11888513.850750368,20907.354533087928,8768102.389839027,true,482.0,482,0.875,4819.051994596347,5507.487993824397,688.4359992280497,0.0,0.0,482,23242.668790106964,0.0,4819.051994596347,4819.051994596347,1740897.203113005,700.0,337400.0,1878.2369747803323,911827.5676365793,1151.7778154362084,202425.34056998166,0.0,0.0,1767.4183053767533,622844.7660956002,21.61889900305332,3799.528810844114,-4819.051994596347,-2730360.028297372,true,true,15.69135858,5529.661585146997,0.0,1644.2724500334996,482.0,15.69135858,5529.661585146997,0.0,121.92,0.0 -483,27957.487993824398,27257.487993824398,0.23500000000000001,5535.501933499318,3125946.9628447825,700.0,338100.0,26534.05078084816,11915047.901531216,20998.548847348844,8789100.938686376,true,483.0,483,0.875,4843.564191811903,5535.501933499318,691.9377416874149,0.0,0.0,483,27257.487993824398,0.0,4843.564191811903,4843.564191811903,1745740.767304817,700.0,338100.0,1894.3590928521196,913721.9267294314,1155.0636563692879,203580.40422635095,0.0,0.0,1772.4608682692356,624617.2269638694,21.680574321259936,3821.209385165374,-4843.564191811903,-2735203.592489184,true,true,15.7360633,5545.397648446997,0.0,1644.2724500334996,483.0,15.7360633,5545.397648446997,0.0,121.92,0.0 -484,27985.50193349932,27285.50193349932,0.28625,8296.851957501378,3134243.814802284,700.0,338800.0,31430.05050655503,11946477.95203777,23133.198549053654,8812234.137235431,true,484.0,484,0.875,7259.745462813706,8296.851957501378,1037.1064946876722,0.0,0.0,484,27285.50193349932,0.0,7259.745462813706,7259.745462813706,1753000.5127676306,700.0,338800.0,1926.8795748703742,915648.8063043017,3484.9080802458675,207065.3123065968,0.0,0.0,1782.5459940542003,626399.7729579236,65.4118136432633,3886.6211988086375,-7259.745462813706,-2742463.3379519978,true,true,15.87017748,5561.267825926997,0.0,1644.2724500334996,484.0,15.87017748,5561.267825926997,0.0,121.92,0.0 -485,30746.851957501378,30046.851957501378,0.124,181.83505718336423,3134425.649859467,700.0,339500.0,7111.5730418013245,11953589.52507957,6929.73798461796,8819163.87522005,true,485.0,485,0.875,159.1056750354437,181.83505718336423,22.729382147920518,0.0,0.0,485,30046.851957501378,0.0,159.1056750354437,159.1056750354437,1753159.618442666,700.0,339500.0,1926.8795748703742,917575.6858791721,-3484.9080802458675,203580.40422635095,0.0,0.0,1782.5459940542003,628182.3189519778,-65.4118136432633,3821.209385165374,-159.1056750354437,-2742622.4436270334,true,true,15.7360633,5577.003889226997,0.0,1644.2724500334996,485.0,15.7360633,5577.003889226997,0.0,121.92,0.0 -486,22631.835057183365,21931.835057183365,0.16240000000000002,1492.6687901069624,3135918.318649574,700.0,340200.0,13501.655111496075,11967091.180191066,12008.986321389113,8831172.861541439,true,486.0,486,0.875,1306.0851913435922,1492.6687901069624,186.58359876337022,0.0,0.0,486,21931.835057183365,0.0,1306.0851913435922,1306.0851913435922,1754465.7036340097,700.0,340200.0,1886.2865499323998,919461.9724291045,-2306.841471805496,201273.56275454545,0.0,0.0,1769.9395865410017,629952.2585385188,-43.299473324313254,3777.909911841061,-1306.0851913435922,-2743928.528818377,true,true,15.64665385,5592.650543076997,0.0,1644.2724500334996,486.0,15.64665385,5592.650543076997,0.0,121.92,0.0 -487,23942.668790106964,23242.668790106964,0.20800000000000002,4154.408405403615,3140072.727054978,700.0,340900.0,23338.501949055837,11990429.682140121,19184.093543652223,8850356.955085091,true,487.0,487,0.875,3635.107354728163,4154.408405403615,519.3010506754517,0.0,0.0,487,23242.668790106964,0.0,3635.107354728163,3635.107354728163,1758100.810988738,700.0,340900.0,1870.2103310796433,921332.1827601842,0.0,201273.56275454545,0.0,0.0,1764.8970236485195,631717.1555621673,0.0,3777.909911841061,-3635.107354728163,-2747563.636173105,true,true,15.64665385,5608.297196926997,0.0,1644.2724500334996,487.0,15.64665385,5608.297196926997,0.0,121.92,0.0 -488,26604.408405403614,25904.408405403614,0.20800000000000002,4154.408405403615,3144227.1354603814,700.0,341600.0,23338.501949055837,12013768.184089176,19184.093543652223,8869541.048628744,true,488.0,488,0.875,3635.107354728163,4154.408405403615,519.3010506754517,0.0,0.0,488,25904.408405403614,0.0,3635.107354728163,3635.107354728163,1761735.9183434662,700.0,341600.0,1870.2103310796433,923202.3930912638,0.0,201273.56275454545,0.0,0.0,1764.8970236485195,633482.0525858158,0.0,3777.909911841061,-3635.107354728163,-2751198.743527833,true,true,15.64665385,5623.943850776996,0.0,1644.2724500334996,488.0,15.64665385,5623.943850776996,0.0,121.92,0.0 -489,26604.408405403614,25904.408405403614,0.16240000000000002,1459.8061101733783,3145686.941570555,700.0,342300.0,13299.298707964152,12027067.48279714,11839.492597790773,8881380.541226534,true,489.0,489,0.875,1277.330346401706,1459.8061101733783,182.4757637716723,0.0,0.0,489,25904.408405403614,0.0,1277.330346401706,1277.330346401706,1763013.248689868,700.0,342300.0,1854.225714364381,925056.6188056283,-2293.6970760385484,198979.8656785069,0.0,0.0,1759.8544607560373,635241.9070465718,-43.05275268016379,3734.857159160897,-1277.330346401706,-2752476.0738742347,true,true,15.5572444,5639.501095176996,0.0,1644.2724500334996,489.0,15.5572444,5639.501095176996,0.0,121.92,0.0 -490,23909.806110173377,23209.806110173377,0.16240000000000002,1427.3609864323184,3147114.3025569874,700.0,343000.0,13099.513463253192,12040166.996260393,11672.152476820873,8893052.693703355,true,490.0,490,0.875,1248.9408631282786,1427.3609864323184,178.42012330403986,0.0,0.0,490,23209.806110173377,0.0,1248.9408631282786,1248.9408631282786,1764262.1895529963,700.0,343000.0,1822.5302404647734,926879.149046093,-2280.5526802715544,196699.31299823534,0.0,0.0,1749.7693349710723,636991.6763815429,-42.80603203601284,3692.0511271248843,-1248.9408631282786,-2753725.014737363,true,true,15.46783495,5654.968930126996,0.0,1644.2724500334996,490.0,15.46783495,5654.968930126996,0.0,121.92,0.0 -491,23877.36098643232,23177.36098643232,0.1864,2725.1940764612373,3149839.4966334486,700.0,343700.0,18375.504702045262,12058542.500962438,15650.310625584025,8908703.00432894,true,491.0,491,0.875,2384.5448169035826,2725.1940764612373,340.64925955765466,0.0,0.0,491,23177.36098643232,0.0,2384.5448169035826,2384.5448169035826,1766646.7343698998,700.0,343700.0,1798.9971432320265,928678.146189325,-1135.3473185223263,195563.96567971303,0.0,0.0,1742.2054903503563,638733.8818718933,-21.310498156473894,3670.7406289684104,-2384.5448169035826,-2756109.5595542667,true,true,15.42313022,5670.392060346996,0.0,1644.2724500334996,491.0,15.42313022,5670.392060346996,0.0,121.92,0.0 -492,25175.194076461237,24475.194076461237,0.12,0.0,3149839.4966334486,700.0,344400.0,5833.333333333334,12064375.834295772,5833.333333333334,8914536.337662274,true,492.0,492,0.875,0.0,0.0,0.0,0.0,0.0,492,24475.194076461237,0.0,-7953.534551881345,-7953.534551881345,1758693.1998180186,700.0,344400.0,1714.4430745577865,930392.5892638828,-11172.73647176039,184391.22920795265,0.0,0.0,1714.4713941597108,640448.353266053,-209.71254883845145,3461.028080129959,-0.0,-2756109.5595542667,true,true,14.97608297,5685.368143316996,0.0,1644.2724500334996,492.0,14.97608297,5685.368143316996,0.0,121.92,0.0 -493,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,345100.0,5833.333333333334,12070209.167629106,5833.333333333334,8920369.670995608,true,493.0,493,0.875,0.0,0.0,0.0,0.0,0.0,493,21750.0,0.0,-13262.308869939168,-13262.308869939168,1745430.8909480795,700.0,345100.0,1532.2168412843002,931924.8061051671,-16142.961273674466,168248.26793427818,0.0,0.0,1651.4393577216892,642099.7926237747,-303.0037952706914,3158.024284859268,-0.0,-2756109.5595542667,true,true,14.30551209,5699.673655406996,0.0,1644.2724500334996,493.0,14.30551209,5699.673655406996,0.0,121.92,0.0 -494,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,345800.0,5833.333333333334,12076042.50096244,5833.333333333334,8926203.004328942,true,494.0,494,0.875,0.0,0.0,0.0,0.0,0.0,494,21750.0,0.0,-16878.72390320989,-16878.72390320989,1728552.1670448696,700.0,345800.0,1305.7833664234245,933230.5894715906,-19386.340943141906,148861.92699113628,0.0,0.0,1565.7157879855042,643665.5084117602,-363.88211447691543,2794.1421703823526,-0.0,-2756109.5595542667,true,true,13.45612231,5713.129777716996,0.0,1644.2724500334996,494.0,13.45612231,5713.129777716996,0.0,121.92,0.0 -495,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,346500.0,5833.333333333334,12081875.834295774,5833.333333333334,8932036.337662276,true,495.0,495,0.875,0.0,0.0,0.0,0.0,0.0,495,21750.0,0.0,-17888.90017100587,-17888.90017100587,1710663.2668738638,700.0,346500.0,1069.361954453522,934299.9514260441,-20046.84682822719,128815.08016290909,0.0,0.0,1464.8645295718727,645130.372941332,-376.27982680407257,2417.86234357828,-0.0,-2756109.5595542667,true,true,12.51732308,5725.647100796996,0.0,1644.2724500334996,495.0,12.51732308,5725.647100796996,0.0,121.92,0.0 -496,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,347200.0,5833.333333333334,12087709.167629108,5833.333333333334,8937869.67099561,true,496.0,496,0.875,0.0,0.0,0.0,0.0,0.0,496,21750.0,0.0,-20204.442778791825,-20204.442778791825,1690458.824095072,700.0,347200.0,834.9446338311274,935134.8960598753,-21975.78691364645,106839.29324926264,0.0,0.0,1348.885582480794,646479.2585238129,-412.4860814572975,2005.3762621209826,-0.0,-2756109.5595542667,true,true,11.39970495,5737.046805746996,0.0,1644.2724500334996,496.0,11.39970495,5737.046805746996,0.0,121.92,0.0 -497,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,347900.0,5833.333333333334,12093542.500962442,5833.333333333334,8943703.004328944,true,497.0,497,0.875,0.0,0.0,0.0,0.0,0.0,497,21750.0,0.0,-22290.790981870003,-22290.790981870003,1668168.033113202,700.0,347900.0,603.0037930535789,935737.8998529288,-23659.912711335925,83179.38053792671,0.0,0.0,1210.2151020915521,647689.4736259044,-444.09716567920975,1561.2790964417727,-0.0,-2756109.5595542667,true,true,10.05856319,5747.1053689369965,0.0,1644.2724500334996,497.0,10.05856319,5747.1053689369965,0.0,121.92,0.0 -498,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,348600.0,5833.333333333334,12099375.834295776,5833.333333333334,8949536.337662278,true,498.0,498,0.875,0.0,0.0,0.0,0.0,0.0,498,21750.0,0.0,-17638.306945485194,-17638.306945485194,1650529.7261677168,700.0,348600.0,412.6838123532025,936150.583665282,-18765.268252267128,64414.11228565959,0.0,0.0,1066.5020586406322,648755.975684545,-352.2245642119004,1209.0545322298724,-0.0,-2756109.5595542667,true,true,8.851535607,5755.956904543997,0.0,1644.2724500334996,498.0,8.851535607,5755.956904543997,0.0,121.92,0.0 -499,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,349300.0,5833.333333333334,12105209.16762911,5833.333333333334,8955369.670995612,true,499.0,499,0.875,0.0,0.0,0.0,0.0,0.0,499,21750.0,0.0,-18875.492840889496,-18875.492840889496,1631654.2333268272,700.0,349300.0,260.8051763801247,936411.3888416621,-19682.089858998374,44732.02242666122,0.0,0.0,915.2251709073876,649671.2008554523,-369.43332917863336,839.621203051239,-0.0,-2756109.5595542667,true,true,7.376279673,5763.333184216996,0.0,1644.2724500334996,499.0,7.376279673,5763.333184216996,0.0,121.92,0.0 -500,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,350000.0,5833.333333333334,12111042.500962444,5833.333333333334,8961203.004328946,true,500.0,500,0.875,0.0,0.0,0.0,0.0,0.0,500,21750.0,0.0,-15514.125906961566,-15514.125906961566,1616140.1074198657,700.0,350000.0,142.84520930504598,936554.2340509671,-16103.528077479215,28628.494349182005,0.0,0.0,748.8205943838988,650420.0214498362,-302.2636331712946,537.3575698799444,-0.0,-2756109.5595542667,true,true,5.901023738,5769.234207954996,0.0,1644.2724500334996,500.0,5.901023738,5769.234207954996,0.0,121.92,0.0 -501,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,350700.0,5833.333333333334,12116875.834295778,5833.333333333334,8967036.33766228,true,501.0,501,0.875,0.0,0.0,0.0,0.0,0.0,501,21750.0,0.0,-10744.29432268456,-10744.29432268456,1605395.813097181,700.0,350700.0,70.76197057259785,936624.9960215398,-11197.382285566087,17431.112063615918,0.0,0.0,592.5011437017731,651012.5225935379,-210.17515139284373,327.1824184871007,-0.0,-2756109.5595542667,true,true,4.604586705,5773.838794659996,0.0,1644.2724500334996,501.0,4.604586705,5773.838794659996,0.0,121.92,0.0 -502,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,351400.0,5833.333333333334,12122709.167629112,5833.333333333334,8972869.670995614,true,502.0,502,0.875,0.0,0.0,0.0,0.0,0.0,502,21750.0,0.0,-8610.404642062516,-8610.404642062516,1596785.4084551185,700.0,351400.0,29.22203643432516,936654.2180579741,-8913.543495473776,8517.568568142142,0.0,0.0,441.22425596852844,651453.7468495065,-167.30743899159344,159.87497949550723,-0.0,-2756109.5595542667,true,true,3.218740221,5777.057534880996,0.0,1644.2724500334996,502.0,3.218740221,5777.057534880996,0.0,121.92,0.0 -503,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,352100.0,5833.333333333334,12128542.500962446,5833.333333333334,8978703.004328948,true,503.0,503,0.875,0.0,0.0,0.0,0.0,0.0,503,21750.0,0.0,-5709.176324106236,-5709.176324106236,1591076.2321310122,700.0,352100.0,7.660381520692089,936661.8784394949,-5888.689379463902,2628.87918867824,0.0,0.0,282.3835238401617,651736.1303733466,-110.53085000318764,49.344129492319595,-0.0,-2756109.5595542667,true,true,1.788189012,5778.845723892996,0.0,1644.2724500334996,503.0,1.788189012,5778.845723892996,0.0,121.92,0.0 -504,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,352800.0,5833.333333333334,12134375.83429578,5833.333333333334,8984536.337662281,true,504.0,504,0.875,0.0,0.0,0.0,0.0,0.0,504,21750.0,0.0,-2384.08872409453,-2384.08872409453,1588692.1434069178,700.0,352800.0,0.6815635323879592,936662.5600030273,-2464.574239385906,164.3049492923342,0.0,0.0,126.06407315803605,651862.1944465047,-46.26012139904787,3.084008093271727,-0.0,-2756109.5595542667,true,true,0.447047253,5779.292771145996,0.0,1644.2724500334996,504.0,0.447047253,5779.292771145996,0.0,121.92,0.0 -505,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,353500.0,5833.333333333334,12140209.167629113,5833.333333333334,8990369.670995615,true,505.0,505,0.875,0.0,0.0,0.0,0.0,0.0,505,21750.0,0.0,-142.17069024579726,-142.17069024579726,1588549.972716672,700.0,353500.0,0.005452508259103674,936662.5654555355,-164.30494929239373,-5.95434812566964e-11,0.0,0.0,25.212814631607213,651887.4072611363,-3.084008093269858,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,1644.2724500334996,505.0,0.0,5779.292771145996,0.0,121.92,0.0 -506,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,354200.0,5833.333333333334,12146042.500962447,5833.333333333334,8996203.00432895,true,506.0,506,0.875,0.0,0.0,0.0,0.0,0.0,506,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,354200.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,1644.2724500334996,506.0,0.0,5779.292771145996,0.0,121.92,0.0 -507,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,354900.0,5833.333333333334,12151875.834295781,5833.333333333334,9002036.337662283,true,507.0,507,0.875,0.0,0.0,0.0,0.0,0.0,507,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,354900.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,1644.2724500334996,507.0,0.0,5779.292771145996,0.0,121.92,0.0 -508,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,355600.0,5833.333333333334,12157709.167629115,5833.333333333334,9007869.670995617,true,508.0,508,0.875,0.0,0.0,0.0,0.0,0.0,508,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,355600.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,1644.2724500334996,508.0,0.0,5779.292771145996,0.0,121.92,0.0 -509,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,356300.0,5833.333333333334,12163542.50096245,5833.333333333334,9013703.004328951,true,509.0,509,0.875,0.0,0.0,0.0,0.0,0.0,509,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,356300.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,1644.2724500334996,509.0,0.0,5779.292771145996,0.0,121.92,0.0 -510,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,357000.0,5833.333333333334,12169375.834295783,5833.333333333334,9019536.337662285,true,510.0,510,0.875,0.0,0.0,0.0,0.0,0.0,510,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,357000.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,1644.2724500334996,510.0,0.0,5779.292771145996,0.0,121.92,0.0 -511,22450.0,21750.0,0.128,310.06274006228875,3150149.559373511,700.0,357700.0,7891.1151567366305,12177266.94945252,7581.052416674342,9027117.39007896,true,511.0,511,0.875,271.30489755450265,310.06274006228875,38.75784250778611,0.0,0.0,511,21750.0,0.0,271.30489755450265,271.30489755450265,1588821.2776142266,700.0,357700.0,0.009421934240117264,936662.5748774698,236.59912645179844,236.5991264517389,0.0,0.0,30.255377524089532,651917.6626386604,4.440971644374586,4.4409716443764555,-271.30489755450265,-2756380.8644518214,true,true,0.536456703,5779.829227848996,0.0,1644.2724500334996,511.0,0.536456703,5779.829227848996,0.0,121.92,0.0 -512,22760.062740062287,22060.062740062287,0.1768,2204.0468034723476,3152353.6061769836,700.0,358400.0,16425.604092038164,12193692.553544557,14221.557288565817,9041338.947367527,true,512.0,512,0.875,1928.5409530383042,2204.0468034723476,275.5058504340434,0.0,0.0,512,22060.062740062287,0.0,1928.5409530383042,1928.5409530383042,1590749.8185672648,700.0,358400.0,0.5660957640958172,936663.1409732339,1776.136501093657,2012.7356275453958,0.0,0.0,118.50022870651551,652036.1628673669,33.33812747403601,37.77909911841246,-1928.5409530383042,-2758309.4054048597,true,true,1.564665385,5781.393893233996,0.0,1644.2724500334996,512.0,1.564665385,5781.393893233996,0.0,121.92,0.0 -513,24654.04680347235,23954.04680347235,0.196,3707.3045055303655,3156060.910682514,700.0,359100.0,22486.247477195742,12216178.801021753,18778.942971665376,9060117.890339192,true,513.0,513,0.875,3243.8914423390697,3707.3045055303655,463.4130631912958,0.0,0.0,513,23954.04680347235,0.0,3243.8914423390697,3243.8914423390697,1593993.710009604,700.0,359100.0,3.974878517922778,936667.1158517518,2957.4890865280204,4970.224714073416,0.0,0.0,226.91533162806638,652263.078198995,55.5121456650602,93.29124478347266,-3243.8914423390697,-2761553.2968471986,true,true,2.458759891,5783.852653124996,0.0,1644.2724500334996,513.0,2.458759891,5783.852653124996,0.0,121.92,0.0 -514,26157.304505530366,25457.304505530366,0.184,2652.16365490615,3158713.07433742,700.0,359800.0,18218.2807331856,12234397.081754938,15566.117078279449,9075684.007417472,true,514.0,514,0.875,2320.643198042881,2652.16365490615,331.5204568632689,0.0,0.0,514,25457.304505530366,0.0,2320.643198042881,2320.643198042881,1596314.3532076469,700.0,359800.0,9.42193426646217,936676.5377860182,1971.6593911411908,6941.884105214607,0.0,0.0,302.55377552288803,652565.6319745178,37.00809711233967,130.29934189581235,-2320.643198042881,-2763873.9400452417,true,true,2.905807144,5786.758460268997,0.0,1644.2724500334996,514.0,2.905807144,5786.758460268997,0.0,121.92,0.0 -515,25102.16365490615,24402.16365490615,0.25,6192.30074926285,3164905.375086683,700.0,360500.0,27569.2029970514,12261966.284751989,21376.902247788552,9097060.90966526,true,515.0,515,0.875,5418.263155604994,6192.30074926285,774.0375936578566,0.0,0.0,515,24402.16365490615,0.0,5418.263155604994,5418.263155604994,1601732.6163632518,700.0,360500.0,18.402215366242118,936694.9400013845,4929.148478036744,11871.032583251352,0.0,0.0,378.1922194177096,652943.8241939355,92.52024278429853,222.8195846801109,-5418.263155604994,-2769292.203200847,true,true,3.79990165,5790.5583619189965,0.0,1644.2724500334996,515.0,3.79990165,5790.5583619189965,0.0,121.92,0.0 -516,28642.30074926285,27942.30074926285,0.20800000000000002,4367.312051999988,3169272.6871386827,700.0,361200.0,24362.077173076865,12286328.361925066,19994.765121076874,9117055.674786337,true,516.0,516,0.875,3821.3980454999896,4367.312051999988,545.9140064999988,0.0,0.0,516,27942.30074926285,0.0,3821.3980454999896,3821.3980454999896,1605554.0144087519,700.0,361200.0,32.33196176126219,936727.2719631457,3271.3115378902767,15142.344121141628,0.0,0.0,456.35194475877245,653400.1761386943,61.40260108967827,284.2221857697892,-3821.3980454999896,-2773113.6012463467,true,true,4.291653628,5794.8500155469965,0.0,1644.2724500334996,516.0,4.291653628,5794.8500155469965,0.0,121.92,0.0 -517,26817.312051999987,26117.312051999987,0.20800000000000002,4090.4245154471905,3173363.11165413,700.0,361900.0,23030.887093496105,12309359.249018561,18940.462578048915,9135996.137364386,true,517.0,517,0.875,3579.1214510162918,4090.4245154471905,511.30306443089876,0.0,0.0,517,26117.312051999987,0.0,3579.1214510162918,3579.1214510162918,1609133.1358597681,700.0,361900.0,44.27764398738515,936771.5496071331,2972.2765267674104,18114.62064790904,0.0,0.0,506.7775739655883,653906.9537126599,55.789706295908026,340.0118920656972,-3579.1214510162918,-2776692.7226973632,true,true,4.693996155,5799.544011701996,0.0,1644.2724500334996,517.0,4.693996155,5799.544011701996,0.0,121.92,0.0 -518,26540.42451544719,25840.42451544719,0.265,6714.706057092393,3180077.817711222,700.0,362600.0,27980.022856952426,12337339.271875514,21265.316799860033,9157261.454164246,true,518.0,518,0.875,5875.367799955844,6714.706057092393,839.3382571365491,0.0,0.0,518,25840.42451544719,0.0,5875.367799955844,5875.367799955844,1615008.503659724,700.0,362600.0,61.28305212881776,936832.832659262,5152.603206516369,23267.223854425407,0.0,0.0,564.7670475675262,654471.7207602274,96.7144937431313,436.7263858088285,-5875.367799955844,-2782568.090497319,true,true,5.319862309,5804.863874010996,0.0,1644.2724500334996,518.0,5.319862309,5804.863874010996,0.0,121.92,0.0 -519,29164.706057092393,28464.706057092393,0.3175,11259.461782403141,3191337.2794936253,700.0,363300.0,37667.59616504926,12375006.868040564,26408.13438264612,9183669.588546893,true,519.0,519,0.875,9852.029059602748,11259.461782403141,1407.432722800393,0.0,0.0,519,28464.706057092393,0.0,9852.029059602748,9852.029059602748,1624860.5327193267,700.0,363300.0,94.73176392472222,936927.5644231867,8936.54619659277,32203.770051018175,0.0,0.0,653.0118988063507,655124.7326590337,167.73920027890438,604.4655860877328,-9852.029059602748,-2792420.119556922,true,true,6.258661541,5811.122535551996,0.0,1644.2724500334996,519.0,6.258661541,5811.122535551996,0.0,121.92,0.0 -520,33709.461782403145,33009.461782403145,0.33,12510.788104384317,3203848.0675980095,700.0,364000.0,40032.69122540702,12415039.559265971,27521.903121022704,9211191.491667915,true,520.0,520,0.875,10946.939591336277,12510.788104384317,1563.8485130480403,0.0,0.0,520,33009.461782403145,0.0,10946.939591336277,10946.939591336277,1635807.472310663,700.0,364000.0,147.21772289700587,937074.7821460837,9858.296944312408,42062.066995330584,0.0,0.0,756.3844387790208,655881.1170978127,185.04048534784127,789.5060714355741,-10946.939591336277,-2803367.059148258,true,true,7.152756046,5818.275291597996,0.0,1644.2724500334996,520.0,7.152756046,5818.275291597996,0.0,121.92,0.0 -521,34960.788104384315,34260.788104384315,0.3175,12169.220250591683,3216017.287848601,700.0,364700.0,40532.9771672179,12455572.536433188,28363.756916626215,9239555.24858454,true,521.0,521,0.875,10648.067719267723,12169.220250591683,1521.15253132396,0.0,0.0,521,34260.788104384315,0.0,10648.067719267723,10648.067719267723,1646455.5400299306,700.0,364700.0,208.6825016607592,937283.4646477444,9413.030541160935,51475.09753649152,0.0,0.0,849.6718528539291,656730.7889506667,176.68282359209823,966.1888950276723,-10648.067719267723,-2814015.1268675257,true,true,7.912736376,5826.188027973996,0.0,1644.2724500334996,521.0,7.912736376,5826.188027973996,0.0,121.92,0.0 -522,34619.22025059168,33919.22025059168,0.30500000000000005,10492.525304636865,3226509.813153238,700.0,365400.0,36696.80427749791,12492269.340710687,26204.278972861044,9265759.527557401,true,522.0,522,0.875,9180.959641557258,10492.525304636865,1311.5656630796075,0.0,0.0,522,33919.22025059168,0.0,9180.959641557258,9180.959641557258,1655636.4996714878,700.0,365400.0,269.52218856006243,937552.9868363045,7838.989130129992,59314.086666621515,0.0,0.0,925.3102967487507,657656.0992474154,147.13802611845313,1113.3269211461254,-9180.959641557258,-2823196.086509083,true,true,8.493897805,5834.681925778997,0.0,1644.2724500334996,522.0,8.493897805,5834.681925778997,0.0,121.92,0.0 -523,32942.52530463687,32242.525304636867,0.29250000000000004,9727.030633639542,3236236.8437868776,700.0,366100.0,35647.96797825484,12527917.30868894,25920.937344615297,9291680.464902015,true,523.0,523,0.875,8511.1518044346,9727.030633639542,1215.878829204943,0.0,0.0,523,32242.525304636867,0.0,8511.1518044346,8511.1518044346,1664147.6514759224,700.0,366100.0,325.9317015870319,937878.9185378916,7066.755863016254,66380.84252963777,0.0,0.0,985.8210518533282,658641.9202992688,132.64318797798518,1245.9701091241106,-8511.1518044346,-2831707.2383135175,true,true,8.985649783,5843.667575561996,0.0,1644.2724500334996,523.0,8.985649783,5843.667575561996,0.0,121.92,0.0 -524,32177.030633639544,31477.030633639544,0.29250000000000004,8693.157658734372,3244930.001445612,700.0,366800.0,32113.359517040582,12560030.66820598,23420.20185830621,9315100.666760322,true,524.0,524,0.875,7606.512951392576,8693.157658734372,1086.6447073417958,0.0,0.0,524,31477.030633639544,0.0,7606.512951392576,7606.512951392576,1671754.1644273151,700.0,366800.0,378.54873341264084,938257.4672713042,6077.640077434978,72458.48260707274,0.0,0.0,1036.2466811165425,659678.1669803853,114.07745942841443,1360.047568552525,-7606.512951392576,-2839313.75126491,true,true,9.387992311,5853.055567872996,0.0,1644.2724500334996,524.0,9.387992311,5853.055567872996,0.0,121.92,0.0 -525,31143.157658734373,30443.157658734373,0.30500000000000005,9960.444307320311,3254890.445752932,700.0,367500.0,34952.27641744364,12594982.944623424,24991.832110123327,9340092.498870445,true,525.0,525,0.875,8715.388768905272,9960.444307320311,1245.0555384150393,0.0,0.0,525,30443.157658734373,0.0,8715.388768905272,8715.388768905272,1680469.5531962204,700.0,367500.0,433.5125738859352,938690.9798451902,7065.112818102812,79523.59542517556,0.0,0.0,1084.151028933516,660762.3180093188,132.6123479830096,1492.6599165355346,-8715.388768905272,-2848029.1400338155,true,true,9.835039564,5862.890607436996,0.0,1644.2724500334996,525.0,9.835039564,5862.890607436996,0.0,121.92,0.0 -526,32410.44430732031,31710.44430732031,0.30500000000000005,10473.073835350215,3265363.5195882823,700.0,368200.0,36633.02896836135,12631615.973591786,26159.955133011135,9366252.454003457,true,526.0,526,0.875,9163.939605931439,10473.073835350215,1309.1342294187762,0.0,0.0,526,31710.44430732031,0.0,9163.939605931439,9163.939605931439,1689633.492802152,700.0,368200.0,496.85981503672747,939187.839660227,7393.722767407227,86917.31819258278,0.0,0.0,1134.5766583659263,661896.8946676847,138.78036512155848,1631.4402816570932,-9163.939605931439,-2857193.079639747,true,true,10.28208682,5873.172694256996,0.0,1644.2724500334996,526.0,10.28208682,5873.172694256996,0.0,121.92,0.0 -527,32923.07383535022,32223.073835350217,0.29250000000000004,9149.602246985864,3274513.121835268,700.0,368900.0,33673.8538358491,12665289.827427635,24524.251588863233,9390776.70559232,true,527.0,527,0.875,8005.90196611263,9149.602246985864,1143.7002808732332,0.0,0.0,527,32223.073835350217,0.0,8005.90196611263,8005.90196611263,1697639.3947682646,700.0,368900.0,558.8997190327635,939746.7393792598,6151.577260108245,93068.89545269102,0.0,0.0,1179.959724736658,663076.8543924213,115.46526223496363,1746.9055438920568,-8005.90196611263,-2865198.9816058595,true,true,10.63972462,5883.812418876996,0.0,1644.2724500334996,527.0,10.63972462,5883.812418876996,0.0,121.92,0.0 -528,31599.602246985865,30899.602246985865,0.29250000000000004,8561.80637102245,3283074.9282062906,700.0,369600.0,31664.295285546836,12696954.122713182,23102.488914524387,9413879.194506845,true,528.0,528,0.875,7491.580574644644,8561.80637102245,1070.2257963778065,0.0,0.0,528,30899.602246985865,0.0,7491.580574644644,7491.580574644644,1705130.9753429093,700.0,369600.0,614.3809262501679,940361.1203055099,5555.1503870819815,98624.04583977301,0.0,0.0,1217.7789467122682,664294.6333391336,104.2703146002258,1851.1758584922827,-7491.580574644644,-2872690.562180504,true,true,10.9526577,5894.765076576996,0.0,1644.2724500334996,528.0,10.9526577,5894.765076576996,0.0,121.92,0.0 -529,31011.806371022452,30311.806371022452,0.25,5954.787796575761,3289029.716002866,700.0,370300.0,26619.151186303043,12723573.273899484,20664.36338972728,9434543.557896571,true,529.0,529,0.875,5210.439322003791,5954.787796575761,744.3484745719697,0.0,0.0,529,30311.806371022452,0.0,5210.439322003791,5210.439322003791,1710341.4146649132,700.0,370300.0,657.320503086928,941018.4408085968,3246.6657764949196,101870.71161626793,0.0,0.0,1245.5130429029136,665540.1463820365,60.939999519028795,1912.1158580113115,-5210.439322003791,-2877901.001502508,true,true,11.1314766,5905.896553176995,0.0,1644.2724500334996,529.0,11.1314766,5905.896553176995,0.0,121.92,0.0 -530,28404.78779657576,27704.78779657576,0.1936,3166.7115109483248,3292196.4275138145,700.0,371000.0,19972.68342431986,12743545.957323804,16805.971913371537,9451349.529809942,true,530.0,530,0.875,2770.8725720797843,3166.7115109483248,395.8389388685405,0.0,0.0,530,27704.78779657576,0.0,2770.8725720797843,2770.8725720797843,1713112.287236993,700.0,371000.0,677.4823240752954,941695.9231326721,819.8815995946654,102690.5932158626,0.0,0.0,1258.1194498521265,666798.2658318887,15.389198557696954,1927.5050565690085,-2770.8725720797843,-2880671.8740745876,true,true,11.17618132,5917.0727344969955,0.0,1644.2724500334996,530.0,11.17618132,5917.0727344969955,0.0,121.92,0.0 -531,25616.711510948324,24916.711510948324,0.1768,2219.6620142738066,3294416.0895280885,700.0,371700.0,16513.925420100713,12760059.882743904,14294.263405826907,9465643.79321577,true,531.0,531,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,531,24916.711510948324,0.0,1942.2042624895807,1942.2042624895807,1715054.4914994827,700.0,371700.0,681.5635314732057,942377.4866641453,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,668058.9065629051,0.0,1927.5050565690085,-1942.2042624895807,-2882614.078337077,true,true,11.17618132,5928.248915816996,0.0,1644.2724500334996,531.0,11.17618132,5928.248915816996,0.0,121.92,0.0 -532,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3296635.7515423624,700.0,372400.0,16513.925420100713,12776573.808164004,14294.263405826907,9479938.056621598,true,532.0,532,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,532,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1716996.6957619723,700.0,372400.0,681.5635314732057,943059.0501956184,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,669319.5472939215,0.0,1927.5050565690085,-1942.2042624895807,-2884556.2825995665,true,true,11.17618132,5939.425097136996,0.0,1644.2724500334996,532.0,11.17618132,5939.425097136996,0.0,121.92,0.0 -533,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3298855.4135566363,700.0,373100.0,16513.925420100713,12793087.733584104,14294.263405826907,9494232.320027426,true,533.0,533,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,533,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1718938.900024462,700.0,373100.0,681.5635314732057,943740.6137270916,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,670580.1880249379,0.0,1927.5050565690085,-1942.2042624895807,-2886498.486862056,true,true,11.17618132,5950.601278456996,0.0,1644.2724500334996,533.0,11.17618132,5950.601278456996,0.0,121.92,0.0 -534,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3301075.0755709102,700.0,373800.0,16513.925420100713,12809601.659004204,14294.263405826907,9508526.583433254,true,534.0,534,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,534,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1720881.1042869517,700.0,373800.0,681.5635314732057,944422.1772585647,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,671840.8287559543,0.0,1927.5050565690085,-1942.2042624895807,-2888440.6911245454,true,true,11.17618132,5961.777459776996,0.0,1644.2724500334996,534.0,11.17618132,5961.777459776996,0.0,121.92,0.0 -535,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3303294.737585184,700.0,374500.0,16513.925420100713,12826115.584424304,14294.263405826907,9522820.846839081,true,535.0,535,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,535,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1722823.3085494414,700.0,374500.0,681.5635314732057,945103.7407900379,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,673101.4694869707,0.0,1927.5050565690085,-1942.2042624895807,-2890382.895387035,true,true,11.17618132,5972.953641096996,0.0,1644.2724500334996,535.0,11.17618132,5972.953641096996,0.0,121.92,0.0 -536,24669.662014273807,23969.662014273807,0.28625,8073.24864091947,3311367.9862261037,700.0,375200.0,30648.90354906365,12856764.487973368,22575.654908144177,9545396.501747226,true,536.0,536,0.875,7064.092560804536,8073.24864091947,1009.1560801149335,0.0,0.0,536,23969.662014273807,0.0,7064.092560804536,7064.092560804536,1729887.4011102458,700.0,375200.0,706.3954316362309,945810.1362216742,4988.298224439979,107678.89144030257,0.0,0.0,1275.7684196938221,674377.2379066645,93.6304850345049,2021.1355416035135,-7064.092560804536,-2897446.9879478393,true,true,11.44440967,5984.398050766996,0.0,1644.2724500334996,536.0,11.44440967,5984.398050766996,0.0,121.92,0.0 -537,30523.248640919468,29823.248640919468,0.20800000000000002,4293.862865627619,3315661.8490917315,700.0,375900.0,24008.956084748166,12880773.444058117,19715.093219120547,9565111.594966346,true,537.0,537,0.875,3757.1300074241663,4293.862865627619,536.7328582034525,0.0,0.0,537,29823.248640919468,0.0,3757.1300074241663,3757.1300074241663,1733644.53111767,700.0,375900.0,740.4328668466779,946550.5690885208,1689.0548663472682,109367.94630664984,0.0,0.0,1295.9386712637515,675673.1765779282,31.703602966468594,2052.839144569982,-3757.1300074241663,-2901204.1179552637,true,true,11.53381912,5995.931869886996,0.0,1644.2724500334996,537.0,11.53381912,5995.931869886996,0.0,121.92,0.0 -538,26743.86286562762,26043.86286562762,0.20800000000000002,4340.603073645875,3320002.4521653773,700.0,376600.0,24233.668623297475,12905007.112681415,19893.0655496516,9585004.660515998,true,538.0,538,0.875,3798.0276894401404,4340.603073645875,542.5753842057347,0.0,0.0,538,26043.86286562762,0.0,3798.0276894401404,3798.0276894401404,1737442.5588071102,700.0,376600.0,757.8541113977777,947308.4231999186,1702.1994532317615,111070.1457598816,0.0,0.0,1306.0237976127014,676979.200375541,31.950327197900013,2084.7894717678823,-3798.0276894401404,-2905002.145644704,true,true,11.62322858,6007.555098466995,0.0,1644.2724500334996,538.0,11.62322858,6007.555098466995,0.0,121.92,0.0 -539,26790.603073645874,26090.603073645874,0.12,0.0,3320002.4521653773,700.0,377300.0,5833.333333333334,12910840.446014749,5833.333333333334,9590837.993849332,true,539.0,539,0.875,0.0,0.0,0.0,0.0,0.0,539,26090.603073645874,0.0,-1404.8172873482827,-1404.8172873482827,1736037.741519762,700.0,377300.0,749.1097276748961,948057.5329275934,-3391.2543195790295,107678.89144030257,0.0,0.0,1300.9812347202192,678280.1816102612,-63.65393016436861,2021.1355416035137,-0.0,-2905002.145644704,true,true,11.44440967,6018.999508136995,0.0,1644.2724500334996,539.0,11.44440967,6018.999508136995,0.0,121.92,0.0 -540,22450.0,21750.0,0.12,0.0,3320002.4521653773,700.0,378000.0,5833.333333333334,12916673.779348083,5833.333333333334,9596671.327182665,true,540.0,540,0.875,0.0,0.0,0.0,0.0,0.0,540,21750.0,0.0,-1405.7277935590275,-1405.7277935590275,1734632.013726203,700.0,378000.0,714.8048132488018,948772.3377408423,-3338.676545393647,104340.21489490892,0.0,0.0,1280.8109825863046,679560.9925928476,-62.66704400048694,1958.468497603027,-0.0,-2905002.145644704,true,true,11.26559077,6030.265098906995,0.0,1644.2724500334996,540.0,11.26559077,6030.265098906995,0.0,121.92,0.0 -541,22450.0,21750.0,0.128,314.1408300540935,3320316.5929954313,700.0,378700.0,7922.9752347976055,12924596.75458288,7608.834404743512,9604280.16158741,true,541.0,541,0.875,274.8732262973318,314.1408300540935,39.26760375676167,0.0,0.0,541,21750.0,0.0,274.8732262973318,274.8732262973318,1734906.8869525003,700.0,378700.0,689.7750524688241,949462.1127933111,-1649.621679046332,102690.59321586258,0.0,0.0,1265.6832939088576,680826.6758867564,-30.96344103401797,1927.505056569009,-274.8732262973318,-2905277.0188710014,true,true,11.17618132,6041.441280226995,0.0,1644.2724500334996,541.0,11.17618132,6041.441280226995,0.0,121.92,0.0 -542,22764.140830054093,22064.140830054093,0.1768,2219.6620142738066,3322536.255009705,700.0,379400.0,16513.925420100713,12941110.68000298,14294.263405826907,9618574.424993237,true,542.0,542,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,542,22064.140830054093,0.0,1942.2042624895807,1942.2042624895807,1736849.09121499,700.0,379400.0,681.5635314732057,950143.6763247843,0.0,102690.59321586258,0.0,0.0,1260.6407310163752,682087.3166177728,0.0,1927.505056569009,-1942.2042624895807,-2907219.223133491,true,true,11.17618132,6052.617461546995,0.0,1644.2724500334996,542.0,11.17618132,6052.617461546995,0.0,121.92,0.0 -543,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3324755.917023979,700.0,380100.0,16513.925420100713,12957624.60542308,14294.263405826907,9632868.688399065,true,543.0,543,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,543,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1738791.2954774797,700.0,380100.0,681.5635314732057,950825.2398562575,0.0,102690.59321586258,0.0,0.0,1260.6407310163752,683347.9573487892,0.0,1927.505056569009,-1942.2042624895807,-2909161.4273959803,true,true,11.17618132,6063.7936428669955,0.0,1644.2724500334996,543.0,11.17618132,6063.7936428669955,0.0,121.92,0.0 -544,24669.662014273807,23969.662014273807,0.12,0.0,3324755.917023979,700.0,380800.0,5833.333333333334,12963457.938756414,5833.333333333334,9638702.0217324,true,544.0,544,0.875,0.0,0.0,0.0,0.0,0.0,544,23969.662014273807,0.0,-3058.5751172414093,-3058.5751172414093,1735732.7203602383,700.0,380800.0,657.3205021939968,951482.5603584514,-4869.998662537182,97820.5945533254,0.0,0.0,1245.5130423389282,684593.4703911281,-91.40999923715228,1836.0950573318567,-0.0,-2909161.4273959803,true,true,10.90795297,6074.701595836996,0.0,1644.2724500334996,544.0,10.90795297,6074.701595836996,0.0,121.92,0.0 -545,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,381500.0,5833.333333333334,12969291.272089748,5833.333333333334,9644535.355065733,true,545.0,545,0.875,0.0,0.0,0.0,0.0,0.0,545,21750.0,0.0,-8554.30390693779,-8554.30390693779,1727178.4164533005,700.0,381500.0,584.3555329619527,952066.9158914133,-10145.83063442549,87674.7639188999,0.0,0.0,1197.6086945783534,685791.0790857065,-190.43750005260483,1645.6575572792517,-0.0,-2909161.4273959803,true,true,10.32679154,6085.028387376996,0.0,1644.2724500334996,545.0,10.32679154,6085.028387376996,0.0,121.92,0.0 -546,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,382200.0,5833.333333333334,12975124.605423082,5833.333333333334,9650368.688399067,true,546.0,546,0.875,0.0,0.0,0.0,0.0,0.0,546,21750.0,0.0,-22185.129815314438,-22185.129815314438,1704993.286637986,700.0,382200.0,430.49509565719336,952497.4109870705,-23260.65163324033,64414.112285659576,0.0,0.0,1081.6297473180794,686872.7088330246,-436.60302504937886,1209.0545322298728,-0.0,-2909161.4273959803,true,true,8.851535607,6093.879922983996,0.0,1644.2724500334996,546.0,8.851535607,6093.879922983996,0.0,121.92,0.0 -547,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,382900.0,5833.333333333334,12980957.938756416,5833.333333333334,9656202.021732401,true,547.0,547,0.875,0.0,0.0,0.0,0.0,0.0,547,21750.0,0.0,-18875.492840889496,-18875.492840889496,1686117.7937970965,700.0,382900.0,260.8051763801247,952758.2161634506,-19682.089858998374,44732.022426661206,0.0,0.0,915.2251709073876,687787.9340039319,-369.43332917863336,839.6212030512395,-0.0,-2909161.4273959803,true,true,7.376279673,6101.256202656996,0.0,1644.2724500334996,547.0,7.376279673,6101.256202656996,0.0,121.92,0.0 -548,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,383600.0,5833.333333333334,12986791.27208975,5833.333333333334,9662035.355065735,true,548.0,548,0.875,0.0,0.0,0.0,0.0,0.0,548,21750.0,0.0,-15514.125906961566,-15514.125906961566,1670603.667890135,700.0,383600.0,142.84520930504598,952901.0613727557,-16103.528077479215,28628.49434918199,0.0,0.0,748.8205943838988,688536.7545983158,-302.2636331712946,537.3575698799449,-0.0,-2909161.4273959803,true,true,5.901023738,6107.157226394996,0.0,1644.2724500334996,548.0,5.901023738,6107.157226394996,0.0,121.92,0.0 -549,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,384300.0,5833.333333333334,12992624.605423084,5833.333333333334,9667868.688399069,true,549.0,549,0.875,0.0,0.0,0.0,0.0,0.0,549,21750.0,0.0,-12110.434444334802,-12110.434444334802,1658493.2334458001,700.0,384300.0,67.20974868753402,952968.2711214432,-12524.966274128567,16103.528075053424,0.0,0.0,582.41601786041,689119.1706161762,-235.09393675417851,302.2636331257664,-0.0,-2909161.4273959803,true,true,4.425767804,6111.582994198996,0.0,1644.2724500334996,549.0,4.425767804,6111.582994198996,0.0,121.92,0.0 -550,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,385000.0,5833.333333333334,12998457.938756417,5833.333333333334,9673702.021732403,true,550.0,550,0.875,0.0,0.0,0.0,0.0,0.0,550,21750.0,0.0,-8673.823938428355,-8673.823938428355,1649819.4095073717,700.0,385000.0,24.493348648483604,952992.7644700918,-8946.404487757982,7157.123587295442,0.0,0.0,416.0114413369212,689535.1820575132,-167.9242406557784,134.33939246998798,-0.0,-2909161.4273959803,true,true,2.950511869,6114.533506067996,0.0,1644.2724500334996,550.0,2.950511869,6114.533506067996,0.0,121.92,0.0 -551,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,385700.0,5833.333333333334,13004291.272089751,5833.333333333334,9679535.355065737,true,551.0,551,0.875,0.0,0.0,0.0,0.0,0.0,551,21750.0,0.0,-5213.699805466277,-5213.699805466277,1644605.7097019055,700.0,385700.0,5.290563308789698,952998.0550334005,-5367.842689258775,1789.2808980366672,0.0,0.0,249.60686481343245,689784.7889223266,-100.75454432972379,33.5848481402642,-0.0,-2909161.4273959803,true,true,1.475255935,6116.008762002996,0.0,1644.2724500334996,551.0,1.475255935,6116.008762002996,0.0,121.92,0.0 -552,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,386400.0,5833.333333333334,13010124.605423085,5833.333333333334,9685368.68839907,true,552.0,552,0.875,0.0,0.0,0.0,0.0,0.0,552,21750.0,0.0,-1739.4675110977112,-1739.4675110977112,1642866.2421908078,700.0,386400.0,0.19594678934725546,952998.2509801899,-1789.2808980367404,-7.321432349272072e-11,0.0,0.0,83.20228828994367,689867.9912106165,-33.58484814026184,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,552.0,0.0,6116.008762002996,0.0,121.92,0.0 -553,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,387100.0,5833.333333333334,13015957.93875642,5833.333333333334,9691202.021732405,true,553.0,553,0.875,0.0,0.0,0.0,0.0,0.0,553,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,387100.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,553.0,0.0,6116.008762002996,0.0,121.92,0.0 -554,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,387800.0,5833.333333333334,13021791.272089753,5833.333333333334,9697035.355065739,true,554.0,554,0.875,0.0,0.0,0.0,0.0,0.0,554,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,387800.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,554.0,0.0,6116.008762002996,0.0,121.92,0.0 -555,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,388500.0,5833.333333333334,13027624.605423087,5833.333333333334,9702868.688399073,true,555.0,555,0.875,0.0,0.0,0.0,0.0,0.0,555,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,388500.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,555.0,0.0,6116.008762002996,0.0,121.92,0.0 -556,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,389200.0,5833.333333333334,13033457.938756421,5833.333333333334,9708702.021732407,true,556.0,556,0.875,0.0,0.0,0.0,0.0,0.0,556,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,389200.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,556.0,0.0,6116.008762002996,0.0,121.92,0.0 -557,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,389900.0,5833.333333333334,13039291.272089755,5833.333333333334,9714535.35506574,true,557.0,557,0.875,0.0,0.0,0.0,0.0,0.0,557,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,389900.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,557.0,0.0,6116.008762002996,0.0,121.92,0.0 -558,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,390600.0,5833.333333333334,13045124.60542309,5833.333333333334,9720368.688399075,true,558.0,558,0.875,0.0,0.0,0.0,0.0,0.0,558,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,390600.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,558.0,0.0,6116.008762002996,0.0,121.92,0.0 -559,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,391300.0,5833.333333333334,13050957.938756423,5833.333333333334,9726202.021732409,true,559.0,559,0.875,0.0,0.0,0.0,0.0,0.0,559,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,391300.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,559.0,0.0,6116.008762002996,0.0,121.92,0.0 -560,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,392000.0,5833.333333333334,13056791.272089757,5833.333333333334,9732035.355065743,true,560.0,560,0.875,0.0,0.0,0.0,0.0,0.0,560,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,392000.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,560.0,0.0,6116.008762002996,0.0,121.92,0.0 -561,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,392700.0,5833.333333333334,13062624.605423091,5833.333333333334,9737868.688399076,true,561.0,561,0.875,0.0,0.0,0.0,0.0,0.0,561,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,392700.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,561.0,0.0,6116.008762002996,0.0,121.92,0.0 -562,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,393400.0,5833.333333333334,13068457.938756425,5833.333333333334,9743702.02173241,true,562.0,562,0.875,0.0,0.0,0.0,0.0,0.0,562,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,393400.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,562.0,0.0,6116.008762002996,0.0,121.92,0.0 -563,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,394100.0,5833.333333333334,13074291.272089759,5833.333333333334,9749535.355065744,true,563.0,563,0.875,0.0,0.0,0.0,0.0,0.0,563,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,394100.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,563.0,0.0,6116.008762002996,0.0,121.92,0.0 -564,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,394800.0,5833.333333333334,13080124.605423093,5833.333333333334,9755368.688399078,true,564.0,564,0.875,0.0,0.0,0.0,0.0,0.0,564,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,394800.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,564.0,0.0,6116.008762002996,0.0,121.92,0.0 -565,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,395500.0,5833.333333333334,13085957.938756427,5833.333333333334,9761202.021732412,true,565.0,565,0.875,0.0,0.0,0.0,0.0,0.0,565,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,395500.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,565.0,0.0,6116.008762002996,0.0,121.92,0.0 -566,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,396200.0,5833.333333333334,13091791.27208976,5833.333333333334,9767035.355065746,true,566.0,566,0.875,0.0,0.0,0.0,0.0,0.0,566,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,396200.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,566.0,0.0,6116.008762002996,0.0,121.92,0.0 -567,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,396900.0,5833.333333333334,13097624.605423095,5833.333333333334,9772868.68839908,true,567.0,567,0.875,0.0,0.0,0.0,0.0,0.0,567,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,396900.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,567.0,0.0,6116.008762002996,0.0,121.92,0.0 -568,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,397600.0,5833.333333333334,13103457.938756429,5833.333333333334,9778702.021732414,true,568.0,568,0.875,0.0,0.0,0.0,0.0,0.0,568,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,397600.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,1644.2724500334996,568.0,0.0,6116.008762002996,0.0,121.92,0.0 -569,22450.0,21750.0,0.1768,2178.5874071500493,3326934.504431129,700.0,398300.0,16281.602981617925,13119739.541738046,14103.015574467876,9792805.037306882,true,569.0,569,0.875,1906.2639812562932,2178.5874071500493,272.32342589375617,0.0,0.0,569,21750.0,0.0,1906.2639812562932,1906.2639812562932,1644772.5061720642,700.0,398300.0,0.19594678934725546,952998.4469269792,1789.2808980367404,1789.2808980366672,0.0,0.0,83.20228828994367,689951.1934989064,33.58484814026184,33.5848481402642,-1906.2639812562932,-2911067.6913772365,true,true,1.475255935,6117.484017937996,0.0,1644.2724500334996,569.0,1.475255935,6117.484017937996,0.0,121.92,0.0 -570,24628.58740715005,23928.58740715005,0.265,6541.136756240824,3333475.64118737,700.0,399000.0,27325.04436317292,13147064.586101219,20783.907606932098,9813588.944913814,true,570.0,570,0.875,5723.494661710721,6541.136756240824,817.6420945301033,0.0,0.0,570,23928.58740715005,0.0,5723.494661710721,5723.494661710721,1650496.000833775,700.0,399000.0,5.290563308789698,953003.737490288,5367.842689258775,7157.123587295442,0.0,0.0,249.60686481343245,690200.8003637199,100.75454432972379,134.33939246998798,-5723.494661710721,-2916791.186038947,true,true,2.950511869,6120.434529806997,0.0,1644.2724500334996,570.0,2.950511869,6120.434529806997,0.0,121.92,0.0 -571,28991.136756240823,28291.136756240823,0.30500000000000005,10919.809735313333,3344395.4509226833,700.0,399700.0,38097.73683709289,13185162.322938312,27177.927101779555,9840766.872015594,true,571.0,571,0.875,9554.833518399166,10919.809735313333,1364.9762169141668,0.0,0.0,571,28291.136756240823,0.0,9554.833518399166,9554.833518399166,1660050.834352174,700.0,399700.0,24.493348648483604,953028.2308389365,8946.404487757982,16103.528075053424,0.0,0.0,416.0114413369212,690616.8118050569,167.9242406557784,302.2636331257664,-9554.833518399166,-2926346.0195573466,true,true,4.425767804,6124.860297610997,0.0,1644.2724500334996,571.0,4.425767804,6124.860297610997,0.0,121.92,0.0 -572,33369.809735313334,32669.809735313334,0.335,14315.193882175934,3358710.644804859,700.0,400400.0,44821.47427515204,13229983.797213463,30506.280392976107,9871273.15240857,true,572.0,572,0.875,12525.794646903942,14315.193882175934,1789.3992352719924,0.0,0.0,572,32669.809735313334,0.0,12525.794646903942,12525.794646903942,1672576.628999078,700.0,400400.0,65.47911167336518,953093.7099506098,11664.00834580517,27767.536420858596,0.0,0.0,577.3734549679277,691194.1852600249,218.93373445747787,521.1973675832443,-12525.794646903942,-2938871.8142042505,true,true,5.811614288,6130.671911898997,0.0,1644.2724500334996,572.0,5.811614288,6130.671911898997,0.0,121.92,0.0 -573,36765.19388217593,36065.19388217593,0.29250000000000004,9374.17909267032,3368084.8238975294,700.0,401100.0,34441.63792365921,13264425.435137123,25067.458830988893,9896340.611239558,true,573.0,573,0.875,8202.406706086529,9374.17909267032,1171.7723865837906,0.0,0.0,573,36065.19388217593,0.0,8202.406706086529,8202.406706086529,1680779.0357051645,700.0,401100.0,114.63667420610881,953208.346624816,7255.706550990407,35023.242971849,0.0,0.0,695.8736836744432,691890.0589436993,136.18979721556966,657.387164798814,-8202.406706086529,-2947074.220910337,true,true,6.526889892,6137.198801790997,0.0,1644.2724500334996,573.0,6.526889892,6137.198801790997,0.0,121.92,0.0 -574,31824.179092670318,31124.179092670318,0.29250000000000004,9255.638494726774,3377340.462392256,700.0,401800.0,34036.370922142814,13298461.806059266,24780.732427416042,9921121.343666974,true,574.0,574,0.875,8098.683682885928,9255.638494726774,1156.9548118408466,0.0,0.0,574,31124.179092670318,0.0,8098.683682885928,8098.683682885928,1688877.7193880505,700.0,401800.0,156.22862525473224,953364.5752500707,7038.8240234815685,42062.06699533057,0.0,0.0,771.5121275128663,692661.5710712122,132.11890663676073,789.5060714355747,-8098.683682885928,-2955172.904593223,true,true,7.152756046,6144.351557836997,0.0,1644.2724500334996,574.0,7.152756046,6144.351557836997,0.0,121.92,0.0 -575,31705.638494726772,31005.638494726772,0.28,7487.7774445653,3384828.2398368213,700.0,402500.0,29242.062302018927,13327703.868361285,21754.284857453626,9942875.628524428,true,575.0,575,0.875,6551.805263994638,7487.7774445653,935.9721805706622,0.0,0.0,575,31005.638494726772,0.0,6551.805263994638,6551.805263994638,1695429.5246520452,700.0,402500.0,195.94678914802216,953560.5220392187,5422.063325178861,47484.13032050943,0.0,0.0,832.022882617444,693493.5939538296,101.77226705031065,891.2783384858853,-6551.805263994638,-2961724.7098572175,true,true,7.599803299,6151.951361135997,0.0,1644.2724500334996,575.0,7.599803299,6151.951361135997,0.0,121.92,0.0 -576,29937.7774445653,29237.7774445653,0.15600000000000003,1224.6183790807647,3386052.858215902,700.0,403200.0,12337.297301799772,13340041.165663084,11112.678922719007,9953988.307447147,true,576.0,576,0.875,1071.5410816956692,1224.6183790807647,153.07729738509556,0.0,0.0,576,29237.7774445653,0.0,1071.5410816956692,1071.5410816956692,1696501.0657337408,700.0,403200.0,214.30538444661804,953774.8274236653,0.0,47484.13032050943,0.0,0.0,857.2356972490511,694350.8296510787,0.0,891.2783384858853,-1071.5410816956692,-2962796.2509389133,true,true,7.599803299,6159.551164434997,0.0,1644.2724500334996,576.0,7.599803299,6159.551164434997,0.0,121.92,0.0 -577,23674.618379080766,22974.618379080766,0.15600000000000003,1224.6183790807647,3387277.4765949827,700.0,403900.0,12337.297301799772,13352378.462964883,11112.678922719007,9965100.986369865,true,577.0,577,0.875,1071.5410816956692,1224.6183790807647,153.07729738509556,0.0,0.0,577,22974.618379080766,0.0,1071.5410816956692,1071.5410816956692,1697572.6068154364,700.0,403900.0,214.30538444661804,953989.132808112,0.0,47484.13032050943,0.0,0.0,857.2356972490511,695208.0653483277,0.0,891.2783384858853,-1071.5410816956692,-2963867.792020609,true,true,7.599803299,6167.150967733997,0.0,1644.2724500334996,577.0,7.599803299,6167.150967733997,0.0,121.92,0.0 -578,23674.618379080766,22974.618379080766,0.22,4549.944433838006,3391827.421028821,700.0,404600.0,23863.383790172757,13376241.846755056,19313.43935633475,9984414.4257262,true,578.0,578,0.875,3981.2013796082556,4549.944433838006,568.7430542297507,0.0,0.0,578,22974.618379080766,0.0,3981.2013796082556,3981.2013796082556,1701553.8081950448,700.0,404600.0,223.89975430880622,954213.0325624208,2834.2603809905618,50318.39070149999,0.0,0.0,869.842104593054,696077.9074529208,53.19913971583344,944.4774782017188,-3981.2013796082556,-2967848.9934002175,true,true,7.823326926,6174.974294659997,0.0,1644.2724500334996,578.0,7.823326926,6174.974294659997,0.0,121.92,0.0 -579,26999.944433838005,26299.944433838005,0.184,2632.8184637920685,3394460.239492613,700.0,405300.0,18113.143824956893,13394354.990580013,15480.325361164825,9999894.751087364,true,579.0,579,0.875,2303.71615581806,2632.8184637920685,329.10230797400845,0.0,0.0,579,26299.944433838005,0.0,2303.71615581806,2303.71615581806,1703857.5243508627,700.0,405300.0,237.80682917105364,954450.8393915918,1156.706834991513,51475.09753649151,0.0,0.0,887.4910748295391,696965.3985277504,21.711416825954146,966.188895027673,-2303.71615581806,-2970152.7095560357,true,true,7.912736376,6182.887031035997,0.0,1644.2724500334996,579.0,7.912736376,6182.887031035997,0.0,121.92,0.0 -580,25082.818463792068,24382.818463792068,0.16,1296.4766484327677,3395756.7161410456,700.0,406000.0,12477.979052704797,13406832.969632719,11181.502404272029,10011076.253491636,true,580.0,580,0.875,1134.4170673786716,1296.4766484327677,162.05958105409604,0.0,0.0,580,24382.818463792068,0.0,1134.4170673786716,1134.4170673786716,1704991.9414182415,700.0,406000.0,241.8834296566501,954692.7228212485,0.0,51475.09753649151,0.0,0.0,892.5336377220215,697857.9321654724,0.0,966.188895027673,-1134.4170673786716,-2971287.1266234145,true,true,7.912736376,6190.799767411997,0.0,1644.2724500334996,580.0,7.912736376,6190.799767411997,0.0,121.92,0.0 -581,23746.476648432767,23046.476648432767,0.12,0.0,3395756.7161410456,700.0,406700.0,5833.333333333334,13412666.302966053,5833.333333333334,10016909.58682497,true,581.0,581,0.875,0.0,0.0,0.0,0.0,0.0,581,23046.476648432767,0.0,-53.12034781687444,-53.12034781687444,1704938.8210704245,700.0,406700.0,237.80682917105364,954930.5296504195,-1156.706834991513,50318.39070149999,0.0,0.0,887.4910748295391,698745.423240302,-21.711416825954146,944.4774782017188,-0.0,-2971287.1266234145,true,true,7.823326926,6198.623094337997,0.0,1644.2724500334996,581.0,7.823326926,6198.623094337997,0.0,121.92,0.0 -582,22450.0,21750.0,0.12,0.0,3395756.7161410456,700.0,407400.0,5833.333333333334,13418499.636299387,5833.333333333334,10022742.920158304,true,582.0,582,0.875,0.0,0.0,0.0,0.0,0.0,582,21750.0,0.0,-1793.717661804535,-1793.717661804535,1703145.10340862,700.0,407400.0,223.89975430880622,955154.4294047283,-2834.2603809905618,47484.13032050943,0.0,0.0,869.842104593054,699615.2653448951,-53.19913971583344,891.2783384858853,-0.0,-2971287.1266234145,true,true,7.599803299,6206.222897636997,0.0,1644.2724500334996,582.0,7.599803299,6206.222897636997,0.0,121.92,0.0 -583,22450.0,21750.0,0.136,571.06955990149,3396327.785700947,700.0,408100.0,9346.099705158014,13427845.736004544,8775.030145256524,10031517.95030356,true,583.0,583,0.875,499.68586491380375,571.06955990149,71.38369498768628,0.0,0.0,583,21750.0,0.0,499.68586491380375,499.68586491380375,1703644.7892735337,700.0,408100.0,212.4200107018856,955366.8494154302,-556.9937742274183,46927.13654628201,0.0,0.0,854.7144158028099,700469.9797606979,-10.454787363473482,880.8235511224119,-499.68586491380375,-2971786.812488328,true,true,7.555098574,6213.777996210997,0.0,1644.2724500334996,583.0,7.555098574,6213.777996210997,0.0,121.92,0.0 -584,23021.06955990149,22321.06955990149,0.12,0.0,3396327.785700947,700.0,408800.0,5833.333333333334,13433679.069337878,5833.333333333334,10037351.283636894,true,584.0,584,0.875,0.0,0.0,0.0,0.0,0.0,584,22321.06955990149,0.0,-632.6406400777848,-632.6406400777848,1703012.1486334559,700.0,408800.0,204.98909254787833,955571.8385079781,-1651.264741233881,45275.871805048126,0.0,0.0,844.6292899614467,701314.6090506593,-30.994281353228892,849.829269769183,-0.0,-2971786.812488328,true,true,7.420984398,6221.198980608997,0.0,1644.2724500334996,584.0,7.420984398,6221.198980608997,0.0,121.92,0.0 -585,22450.0,21750.0,0.196,3775.643950356295,3400103.429651303,700.0,409500.0,22834.91811406273,13456513.98745194,19059.274163706436,10056410.5578006,true,585.0,585,0.875,3303.6884565617584,3775.643950356295,471.9554937945368,0.0,0.0,585,21750.0,0.0,3303.6884565617584,3303.6884565617584,1706315.8370900175,700.0,409500.0,206.8303009760687,955778.6688089542,2208.2585154612993,47484.13032050942,0.0,0.0,847.1505714076878,702161.759622067,41.44906871670238,891.2783384858855,-3303.6884565617584,-2975090.50094489,true,true,7.599803299,6228.798783907997,0.0,1644.2724500334996,585.0,7.599803299,6228.798783907997,0.0,121.92,0.0 -586,26225.643950356294,25525.643950356294,0.1696,1882.0059436537138,3401985.435594957,700.0,410200.0,15224.091648901616,13471738.079100842,13342.085705247902,10069752.643505849,true,586.0,586,0.875,1646.7552006969995,1882.0059436537138,235.25074295671425,0.0,0.0,586,25525.643950356294,0.0,1646.7552006969995,1646.7552006969995,1707962.5922907146,700.0,410200.0,216.20188130804684,955994.8706902622,560.2798731691493,48044.410193678574,0.0,0.0,859.7569786952923,703021.5166007623,10.516467524511034,901.7948060103965,-1646.7552006969995,-2976737.256145587,true,true,7.644508024,6236.443291931997,0.0,1644.2724500334996,586.0,7.644508024,6236.443291931997,0.0,121.92,0.0 -587,24332.005943653712,23632.005943653712,0.136,577.3285934967759,3402562.7641884536,700.0,410900.0,9392.122011005704,13481130.201111848,8814.793417508929,10078567.436923359,true,587.0,587,0.875,505.1625193096788,577.3285934967759,72.16607418709702,0.0,0.0,587,23632.005943653712,0.0,505.1625193096788,505.1625193096788,1708467.7548100243,700.0,410900.0,216.20188130804684,956211.0725715702,-560.2798731691493,47484.13032050942,0.0,0.0,859.7569786952923,703881.2735794575,-10.516467524511034,891.2783384858855,-505.1625193096788,-2977242.418664897,true,true,7.599803299,6244.043095230997,0.0,1644.2724500334996,587.0,7.599803299,6244.043095230997,0.0,121.92,0.0 -588,23027.328593496775,22327.328593496775,0.12,0.0,3402562.7641884536,700.0,411600.0,5833.333333333334,13486963.534445181,5833.333333333334,10084400.770256693,true,588.0,588,0.875,0.0,0.0,0.0,0.0,0.0,588,22327.328593496775,0.0,-1195.7267117942454,-1195.7267117942454,1707272.02809823,700.0,411600.0,206.8303009760687,956417.9028725462,-2208.2585154612993,45275.871805048126,0.0,0.0,847.1505714076878,704728.4241508652,-41.44906871670238,849.829269769183,-0.0,-2977242.418664897,true,true,7.420984398,6251.464079628997,0.0,1644.2724500334996,588.0,7.420984398,6251.464079628997,0.0,121.92,0.0 -589,22450.0,21750.0,0.136,546.5374240848756,3403109.3016125383,700.0,412300.0,9165.71635356526,13496129.250798747,8619.178929480384,10093019.949186172,true,589.0,589,0.875,478.2202460742662,546.5374240848756,68.31717801060944,0.0,0.0,589,21750.0,0.0,478.2202460742662,478.2202460742662,1707750.2483443043,700.0,412300.0,197.73352705905057,956615.6363996053,-543.8493783869245,44732.0224266612,0.0,0.0,834.5441641200836,705562.9683149853,-10.208066717943383,839.6212030512396,-478.2202460742662,-2977720.638910971,true,true,7.376279673,6258.840359301997,0.0,1644.2724500334996,589.0,7.376279673,6258.840359301997,0.0,121.92,0.0 -590,22996.537424084876,22296.537424084876,0.15600000000000003,1174.8224821276701,3404284.124094666,700.0,413000.0,12018.09283415173,13508147.3436329,10843.27035202406,10103863.219538197,true,590.0,590,0.875,1027.9696718617113,1174.8224821276701,146.85281026595885,0.0,0.0,590,22296.537424084876,0.0,1027.9696718617113,1027.9696718617113,1708778.218016166,700.0,413000.0,195.94678918786877,956811.5831887932,0.0,44732.0224266612,0.0,0.0,832.0228826738424,706394.9911976592,0.0,839.6212030512396,-1027.9696718617113,-2978748.608582833,true,true,7.376279673,6266.216638974996,0.0,1644.2724500334996,590.0,7.376279673,6266.216638974996,0.0,121.92,0.0 -591,23624.82248212767,22924.82248212767,0.1696,1812.954441467431,3406097.0785361333,700.0,413700.0,14816.948357708909,13522964.291990608,13003.993916241478,10116867.213454438,true,591.0,591,0.875,1586.3351362840021,1812.954441467431,226.61930518342888,0.0,0.0,591,22924.82248212767,0.0,1586.3351362840021,1586.3351362840021,1710364.55315245,700.0,413700.0,197.73352705905057,957009.3167158522,543.8493783869245,45275.871805048126,0.0,0.0,834.5441641200836,707229.5353617793,10.208066717943383,849.829269769183,-1586.3351362840021,-2980334.943719117,true,true,7.420984398,6273.637623372996,0.0,1644.2724500334996,591.0,7.420984398,6273.637623372996,0.0,121.92,0.0 -592,24262.95444146743,23562.95444146743,0.196,3775.643950356295,3409872.7224864895,700.0,414400.0,22834.91811406273,13545799.21010467,19059.274163706436,10135926.487618145,true,592.0,592,0.875,3303.6884565617584,3775.643950356295,471.9554937945368,0.0,0.0,592,23562.95444146743,0.0,3303.6884565617584,3303.6884565617584,1713668.2416090115,700.0,414400.0,206.8303009760687,957216.1470168283,2208.2585154612993,47484.13032050942,0.0,0.0,847.1505714076878,708076.6859331869,41.44906871670238,891.2783384858855,-3303.6884565617584,-2983638.632175679,true,true,7.599803299,6281.237426671996,0.0,1644.2724500334996,592.0,7.599803299,6281.237426671996,0.0,121.92,0.0 -593,26225.643950356294,25525.643950356294,0.23500000000000001,5226.52628638056,3415099.24877287,700.0,415100.0,25219.260793108766,13571018.470897779,19992.734506728208,10155919.222124873,true,593.0,593,0.875,4573.21050058299,5226.52628638056,653.3157857975702,0.0,0.0,593,25525.643950356294,0.0,4573.21050058299,4573.21050058299,1718241.4521095946,700.0,415100.0,225.85235747995583,957441.9993743083,3410.970749015447,50895.10106952487,0.0,0.0,872.3633860392952,708949.0493192262,64.02400804829202,955.3023465341774,-4573.21050058299,-2988211.842676262,true,true,7.868031651,6289.105458322996,0.0,1644.2724500334996,593.0,7.868031651,6289.105458322996,0.0,121.92,0.0 -594,27676.526286380562,26976.526286380562,0.28,7548.763303965818,3422648.0120768356,700.0,415800.0,29459.868942735062,13600478.339840515,21911.105638769244,10177830.327763641,true,594.0,594,0.875,6605.16789097009,7548.763303965818,943.5954129957272,0.0,0.0,594,26976.526286380562,0.0,6605.16789097009,6605.16789097009,1724846.6200005647,700.0,415800.0,256.5180545519494,957698.5174288602,5338.267805398675,56233.368874923544,0.0,0.0,910.1826080149052,709859.2319272411,100.19942300456049,1055.501769538738,-6605.16789097009,-2994817.010567232,true,true,8.270374179,6297.375832501996,0.0,1644.2724500334996,594.0,8.270374179,6297.375832501996,0.0,121.92,0.0 -595,29998.763303965818,29298.763303965818,0.25,6468.659935355541,3429116.6720121913,700.0,416500.0,28674.639741422165,13629152.979581937,22205.97980606662,10200036.307569709,true,595.0,595,0.875,5660.077443436098,6468.659935355541,808.5824919194429,0.0,0.0,595,29298.763303965818,0.0,5660.077443436098,5660.077443436098,1730506.6974440007,700.0,416500.0,292.1597488158049,957990.677177676,4336.007609643123,60569.37648456667,0.0,0.0,950.5231114367564,710809.7550386778,81.38697354041373,1136.8887430791517,-5660.077443436098,-3000477.0880106683,true,true,8.583307256,6305.959139757996,0.0,1644.2724500334996,595.0,8.583307256,6305.959139757996,0.0,121.92,0.0 -596,28918.659935355543,28218.659935355543,0.29250000000000004,9053.71597267568,3438170.3879848667,700.0,417200.0,33346.03751342112,13662499.017095359,24292.32154074544,10224328.629110454,true,596.0,596,0.875,7922.00147609122,9053.71597267568,1131.71449658446,0.0,0.0,596,28218.659935355543,0.0,7922.00147609122,7922.00147609122,1738428.698920092,700.0,417200.0,333.49167517286133,958324.1688528488,6473.614986095856,67042.99147066253,0.0,0.0,993.3848962484503,711803.1399349263,121.5099185740529,1258.3986616532047,-7922.00147609122,-3008399.0894867596,true,true,9.030354508,6314.989494265996,0.0,1644.2724500334996,596.0,9.030354508,6314.989494265996,0.0,121.92,0.0 -597,31503.71597267568,30803.71597267568,0.28625,7928.258968117846,3446098.6469529844,700.0,417900.0,30142.389408271953,13692641.40650363,22214.130440154106,10246542.759550607,true,597.0,597,0.875,6937.226597103116,7928.258968117846,991.0323710147304,0.0,0.0,597,30803.71597267568,0.0,6937.226597103116,6937.226597103116,1745365.9255171951,700.0,417900.0,381.3185912308131,958705.4874440796,5415.491136410198,72458.48260707273,0.0,0.0,1038.7679625627839,712841.907897489,101.6489068993212,1360.047568552526,-6937.226597103116,-3015336.316083863,true,true,9.387992311,6324.377486576996,0.0,1644.2724500334996,597.0,9.387992311,6324.377486576996,0.0,121.92,0.0 -598,30378.258968117847,29678.258968117847,0.1816,2483.4568869222353,3448582.1038399064,700.0,418600.0,17530.048936796447,13710171.455440428,15046.592049874213,10261589.351600481,true,598.0,598,0.875,2173.024776056956,2483.4568869222353,310.43211086527936,0.0,0.0,598,29678.258968117847,0.0,2173.024776056956,2173.024776056956,1747538.950293252,700.0,418600.0,406.8577746052386,959112.3452186849,691.7238317209973,73150.20643879373,0.0,0.0,1061.4594957481497,713903.3673932372,12.983673982570316,1373.0312425350962,-2173.024776056956,-3017509.34085992,true,true,9.432697036,6333.810183612995,0.0,1644.2724500334996,598.0,9.432697036,6333.810183612995,0.0,121.92,0.0 -599,24933.456886922235,24233.456886922235,0.1816,2499.7041780573245,3451081.8080179635,700.0,419300.0,17619.516398994077,13727790.971839422,15119.812220936754,10276709.163821418,true,599.0,599,0.875,2187.241155800159,2499.7041780573245,312.46302225716545,0.0,0.0,599,24233.456886922235,0.0,2187.241155800159,2187.241155800159,1749726.1914490522,700.0,419300.0,412.6838123532025,959525.029031038,695.0099306627167,73845.21636945645,0.0,0.0,1066.5020586406322,714969.8694518778,13.045354143607682,1386.076596678704,-2187.241155800159,-3019696.5820157197,true,true,9.477401761,6343.287585373995,0.0,1644.2724500334996,599.0,9.477401761,6343.287585373995,0.0,121.92,0.0 -600,24949.704178057324,24249.704178057324,0.22,4996.91323555462,3456078.721253518,700.0,420000.0,25895.06016161191,13753686.032001033,20898.14692605729,10297607.310747474,true,600.0,600,0.875,4372.299081110293,4996.91323555462,624.6141544443271,0.0,0.0,600,24249.704178057324,0.0,4372.299081110293,4372.299081110293,1754098.4905301626,700.0,420000.0,427.491652521537,959952.5206835596,2812.900743823274,76658.11711327973,0.0,0.0,1079.1084659846351,716048.9779178624,52.79821878084691,1438.8748154595507,-4372.299081110293,-3024068.88109683,true,true,9.656220663,6352.943806036995,0.0,1644.2724500334996,600.0,9.656220663,6352.943806036995,0.0,121.92,0.0 -601,27446.91323555462,26746.91323555462,0.22,5109.092725486967,3461187.813979005,700.0,420700.0,26404.966934031665,13780090.998935064,21295.874208544697,10318903.18495602,true,601.0,601,0.875,4470.456134801096,5109.092725486967,638.6365906858709,0.0,0.0,601,26746.91323555462,0.0,4470.456134801096,4470.456134801096,1758568.9466649636,700.0,420700.0,451.91400410552706,960404.4346876651,2865.478311895824,79523.59542517556,0.0,0.0,1099.2787177237599,717148.2566355861,53.7851010759847,1492.6599165355356,-4470.456134801096,-3028539.3372316314,true,true,9.835039564,6362.778845600995,0.0,1644.2724500334996,601.0,9.835039564,6362.778845600995,0.0,121.92,0.0 -602,27559.092725486968,26859.092725486968,0.23500000000000001,5222.315429107876,3466410.1294081127,700.0,421400.0,25201.342251522878,13805292.341186587,19979.026822415002,10338882.211778434,true,602.0,602,0.875,4569.526000469392,5222.315429107876,652.7894286384844,0.0,0.0,602,26859.092725486968,0.0,4569.526000469392,4569.526000469392,1763138.472665433,700.0,421400.0,477.2492360023803,960881.6839236674,2918.055813224185,82441.65123839975,0.0,0.0,1119.4489691244937,718267.7056047106,54.77198211833273,1547.4318986538683,-4569.526000469392,-3033108.863232101,true,true,10.01385846,6372.792704060995,0.0,1644.2724500334996,602.0,10.01385846,6372.792704060995,0.0,121.92,0.0 -603,27672.315429107875,26972.315429107875,0.1864,2716.7847369011556,3469126.914145014,700.0,422100.0,18330.3902194268,13823622.731406014,15613.605482525645,10354495.81726096,true,603.0,603,0.875,2377.1866447885113,2716.7847369011556,339.5980921126443,0.0,0.0,603,26972.315429107875,0.0,2377.1866447885113,2377.1866447885113,1765515.6593102217,700.0,422100.0,493.55477106152716,961375.2386947289,737.729299526981,83179.38053792673,0.0,0.0,1132.055376412098,719399.7609811227,13.847197787905301,1561.2790964417736,-2377.1866447885113,-3035486.049876889,true,true,10.05856319,6382.851267250995,0.0,1644.2724500334996,603.0,10.05856319,6382.851267250995,0.0,121.92,0.0 -604,25166.784736901154,24466.784736901154,0.1696,1864.4988261493472,3470991.412971163,700.0,422800.0,15120.865720220208,13838743.597126234,13256.366894070861,10367752.18415503,true,604.0,604,0.875,1631.4364728806788,1864.4988261493472,233.0623532686684,0.0,0.0,604,24466.784736901154,0.0,1631.4364728806788,1631.4364728806788,1767147.0957831023,700.0,422800.0,496.8598147403471,961872.0985094693,0.0,83179.38053792673,0.0,0.0,1134.5766581403318,720534.337639263,0.0,1561.2790964417736,-1631.4364728806788,-3037117.48634977,true,true,10.05856319,6392.909830440995,0.0,1644.2724500334996,604.0,10.05856319,6392.909830440995,0.0,121.92,0.0 -605,24314.49882614935,23614.49882614935,0.1696,1864.4988261493472,3472855.9117973126,700.0,423500.0,15120.865720220208,13853864.462846454,13256.366894070861,10381008.5510491,true,605.0,605,0.875,1631.4364728806788,1864.4988261493472,233.0623532686684,0.0,0.0,605,23614.49882614935,0.0,1631.4364728806788,1631.4364728806788,1768778.532255983,700.0,423500.0,496.8598147403471,962368.9583242097,0.0,83179.38053792673,0.0,0.0,1134.5766581403318,721668.9142974033,0.0,1561.2790964417736,-1631.4364728806788,-3038748.9228226505,true,true,10.05856319,6402.968393630996,0.0,1644.2724500334996,605.0,10.05856319,6402.968393630996,0.0,121.92,0.0 -606,24314.49882614935,23614.49882614935,0.196,3607.2336967050687,3476463.1454940178,700.0,424200.0,21975.682126046268,13875840.144972501,18368.4484293412,10399376.99947844,true,606.0,606,0.875,3156.329484616935,3607.2336967050687,450.9042120881336,0.0,0.0,606,23614.49882614935,0.0,3156.329484616935,3156.329484616935,1771934.8617405999,700.0,424200.0,503.5140993916699,962872.4724236013,1485.316731224108,84664.69726915084,0.0,0.0,1139.6192210328143,722808.5335184361,27.879432968343128,1589.1585294101167,-3156.329484616935,-3041905.2523072674,true,true,10.14797264,6413.116366270996,0.0,1644.2724500334996,606.0,10.14797264,6413.116366270996,0.0,121.92,0.0 -607,26057.23369670507,25357.23369670507,0.30500000000000005,10835.900866302274,3487299.04636032,700.0,424900.0,37822.62579115499,13913662.770763656,26986.724924852715,10426363.724403294,true,607.0,607,0.875,9481.41325801449,10835.900866302274,1354.4876082877836,0.0,0.0,607,25357.23369670507,0.0,9481.41325801449,9481.41325801449,1781416.2749986143,700.0,424900.0,544.6910924977716,963417.1635160991,7623.749592625046,92288.44686177588,0.0,0.0,1169.8745983877081,723978.4081168239,143.09797450396636,1732.256503914083,-9481.41325801449,-3051386.665565282,true,true,10.59501989,6423.711386160996,0.0,1644.2724500334996,607.0,10.59501989,6423.711386160996,0.0,121.92,0.0 -608,33285.900866302276,32585.900866302276,0.33999999999999997,15200.066631111436,3502499.1129914313,700.0,425600.0,46764.90185621011,13960427.672619866,31564.835225098675,10457928.559628392,true,608.0,608,0.875,13300.058302222507,15200.066631111436,1900.008328888929,0.0,0.0,608,32585.900866302276,0.0,13300.058302222507,13300.058302222507,1794716.3333008368,700.0,425600.0,633.6592773480427,964050.8227934472,11225.314236390013,103513.7610981659,0.0,0.0,1230.3853536614813,725208.7934704854,210.69943482296983,1942.9559387370527,-13300.058302222507,-3064686.7238675044,true,true,11.22088605,6434.932272210996,0.0,1644.2724500334996,608.0,11.22088605,6434.932272210996,0.0,121.92,0.0 -609,37650.06663111143,36950.06663111143,0.3175,11101.870440849216,3513600.9834322804,700.0,426300.0,37171.24548298965,13997598.918102857,26069.375042140437,10483997.934670532,true,609.0,609,0.875,9714.136635743063,11101.870440849216,1387.7338051061524,0.0,0.0,609,36950.06663111143,0.0,9714.136635743063,9714.136635743063,1804430.46993658,700.0,426300.0,727.5436132255105,964778.3664066726,7556.384661715717,111070.1457598816,0.0,0.0,1288.374827771006,726497.1682982564,141.8335330308298,2084.789471767883,-9714.136635743063,-3074400.8605032475,true,true,11.62322858,6446.555500790996,0.0,1644.2724500334996,609.0,11.62322858,6446.555500790996,0.0,121.92,0.0 -610,33551.87044084922,32851.87044084922,0.28,7436.1460058028015,3521037.129438083,700.0,427000.0,29057.664306438575,14026656.582409296,21621.518300635773,10505619.452971168,true,610.0,610,0.875,6506.627755077451,7436.1460058028015,929.5182507253503,0.0,0.0,610,32851.87044084922,0.0,6506.627755077451,6506.627755077451,1810937.0976916575,700.0,427000.0,788.9949839284826,965567.3613906011,4313.004793045029,115383.15055292663,0.0,0.0,1323.6727680183824,727820.8410662747,80.95521008555681,2165.7446818534395,-6506.627755077451,-3080907.488258325,true,true,11.8467522,6458.402252990996,0.0,1644.2724500334996,610.0,11.8467522,6458.402252990996,0.0,121.92,0.0 -611,29886.146005802802,29186.146005802802,0.28,7613.125594812821,3528650.255032896,700.0,427700.0,29689.73426718864,14056346.316676484,22076.60867237582,10527696.061643545,true,611.0,611,0.875,6661.484895461218,7613.125594812821,951.640699351603,0.0,0.0,611,29186.146005802802,0.0,6661.484895461218,6661.484895461218,1817598.5825871187,700.0,427700.0,834.9446338311269,966402.3060244323,4395.157461381533,119778.30801430816,0.0,0.0,1348.8855824807938,729169.7266487555,82.49721776776443,2248.241899621204,-6661.484895461218,-3087568.9731537863,true,true,12.07027583,6470.472528820997,0.0,1644.2724500334996,611.0,12.07027583,6470.472528820997,0.0,121.92,0.0 -612,30063.12559481282,29363.12559481282,0.12,0.0,3528650.255032896,700.0,428400.0,5833.333333333334,14062179.650009818,5833.333333333334,10533529.394976879,true,612.0,612,0.875,0.0,0.0,0.0,0.0,0.0,612,29363.12559481282,0.0,-5844.36128574788,-5844.36128574788,1811754.2213013708,700.0,428400.0,816.356575297534,967218.6625997298,-7852.133570148046,111926.17444416012,0.0,0.0,1338.8004566958293,730508.5271054513,-147.38474759319732,2100.8571520280066,-0.0,-3087568.9731537863,true,true,11.6679333,6482.140462120997,0.0,1644.2724500334996,612.0,11.6679333,6482.140462120997,0.0,121.92,0.0 -613,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,429100.0,5833.333333333334,14068012.983343152,5833.333333333334,10539362.728310212,true,613.0,613,0.875,0.0,0.0,0.0,0.0,0.0,613,21750.0,0.0,-25141.08661405436,-25141.08661405436,1786613.1346873164,700.0,429100.0,637.5627120621475,967856.225311792,-26513.889577186943,85412.28486697318,0.0,0.0,1232.9066353897151,731741.433740841,-497.6663843192779,1603.1907677087288,-0.0,-3087568.9731537863,true,true,10.19267737,6492.3331394909965,0.0,1644.2724500334996,613.0,10.19267737,6492.3331394909965,0.0,121.92,0.0 -614,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,429800.0,5833.333333333334,14073846.316676486,5833.333333333334,10545196.061643546,true,614.0,614,0.875,0.0,0.0,0.0,0.0,0.0,614,21750.0,0.0,-21886.638753809224,-21886.638753809224,1764726.495933507,700.0,429800.0,412.683812615084,968268.9091244071,-22935.327934375055,62476.95693259812,0.0,0.0,1066.5020588662264,732807.9357997072,-430.4966909154778,1172.694076793251,-0.0,-3087568.9731537863,true,true,8.717421431,6501.050560921996,0.0,1644.2724500334996,614.0,8.717421431,6501.050560921996,0.0,121.92,0.0 -615,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,430500.0,5833.333333333334,14079679.65000982,5833.333333333334,10551029.39497688,true,615.0,615,0.875,0.0,0.0,0.0,0.0,0.0,615,21750.0,0.0,-18571.91029971662,-18571.91029971662,1746154.5856337906,700.0,430500.0,248.08527067467958,968516.9943950818,-19356.766059355312,43120.19087324281,0.0,0.0,900.0974821171435,733708.0332818243,-363.3269931531311,809.36708364012,-0.0,-3087568.9731537863,true,true,7.242165497,6508.292726418997,0.0,1644.2724500334996,615.0,7.242165497,6508.292726418997,0.0,121.92,0.0 -616,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,431200.0,5833.333333333334,14085512.983343154,5833.333333333334,10556862.728310214,true,616.0,616,0.875,0.0,0.0,0.0,0.0,0.0,616,21750.0,0.0,-15206.307028366156,-15206.307028366156,1730948.2786054243,700.0,431200.0,134.36164079749489,968651.3560358792,-15778.204277615652,27341.98659562716,0.0,0.0,733.6929055936547,734441.726187418,-296.15729714165326,513.2097864984667,-0.0,-3087568.9731537863,true,true,5.766909562,6514.059635980997,0.0,1644.2724500334996,616.0,5.766909562,6514.059635980997,0.0,121.92,0.0 -617,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,431900.0,5833.333333333334,14091346.316676488,5833.333333333334,10562696.061643548,true,617.0,617,0.875,0.0,0.0,0.0,0.0,0.0,617,21750.0,0.0,-11799.234269301498,-11799.234269301498,1719149.044336123,700.0,431900.0,62.10747684254341,968713.4635127218,-12199.642474485532,15142.344121141628,0.0,0.0,567.288329070166,735009.0145164882,-228.9876007286765,284.22218576979014,-0.0,-3087568.9731537863,true,true,4.291653628,6518.351289608997,0.0,1644.2724500334996,617.0,4.291653628,6518.351289608997,0.0,121.92,0.0 -618,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,432600.0,5833.333333333334,14097179.650009822,5833.333333333334,10568529.394976882,true,618.0,618,0.875,0.0,0.0,0.0,0.0,0.0,618,21750.0,0.0,-8360.097507043152,-8360.097507043152,1710788.9468290799,700.0,432600.0,21.917332930719994,968735.3808456525,-8621.080687894411,6521.263433247217,0.0,0.0,400.88375254667716,735409.8982690348,-161.81790462613696,122.40428114365318,-0.0,-3087568.9731537863,true,true,2.816397693,6521.167687301997,0.0,1644.2724500334996,618.0,2.816397693,6521.167687301997,0.0,121.92,0.0 -619,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,433300.0,5833.333333333334,14103012.983343156,5833.333333333334,10574362.728310216,true,619.0,619,0.875,0.0,0.0,0.0,0.0,0.0,619,21750.0,0.0,-4898.302158713845,-4898.302158713845,1705890.644670366,700.0,433300.0,4.385763182919641,968739.7666088354,-5042.518889615731,1478.7445436314865,0.0,0.0,234.4791760231884,735644.377445058,-94.6482083042216,27.75607283943158,-0.0,-3087568.9731537863,true,true,1.341141759,6522.5088290609965,0.0,1644.2724500334996,619.0,1.341141759,6522.5088290609965,0.0,121.92,0.0 -620,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,434000.0,5833.333333333334,14108846.31667649,5833.333333333334,10580196.06164355,true,620.0,620,0.875,0.0,0.0,0.0,0.0,0.0,620,21750.0,0.0,-1430.7149548531552,-1430.7149548531552,1704459.929715513,700.0,434000.0,0.14721772299579924,968739.9138265584,-1478.7445436315438,-5.729816621169448e-11,0.0,0.0,75.63844389482165,735720.0158889528,-27.75607283942872,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,620.0,0.0,6522.5088290609965,0.0,121.92,0.0 -621,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,434700.0,5833.333333333334,14114679.650009824,5833.333333333334,10586029.394976884,true,621.0,621,0.875,0.0,0.0,0.0,0.0,0.0,621,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,434700.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,621.0,0.0,6522.5088290609965,0.0,121.92,0.0 -622,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,435400.0,5833.333333333334,14120512.983343158,5833.333333333334,10591862.728310218,true,622.0,622,0.875,0.0,0.0,0.0,0.0,0.0,622,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,435400.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,622.0,0.0,6522.5088290609965,0.0,121.92,0.0 -623,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,436100.0,5833.333333333334,14126346.316676492,5833.333333333334,10597696.061643552,true,623.0,623,0.875,0.0,0.0,0.0,0.0,0.0,623,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,436100.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,623.0,0.0,6522.5088290609965,0.0,121.92,0.0 -624,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,436800.0,5833.333333333334,14132179.650009826,5833.333333333334,10603529.394976886,true,624.0,624,0.875,0.0,0.0,0.0,0.0,0.0,624,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,436800.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,624.0,0.0,6522.5088290609965,0.0,121.92,0.0 -625,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,437500.0,5833.333333333334,14138012.98334316,5833.333333333334,10609362.72831022,true,625.0,625,0.875,0.0,0.0,0.0,0.0,0.0,625,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,437500.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,625.0,0.0,6522.5088290609965,0.0,121.92,0.0 -626,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,438200.0,5833.333333333334,14143846.316676494,5833.333333333334,10615196.061643554,true,626.0,626,0.875,0.0,0.0,0.0,0.0,0.0,626,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,438200.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,626.0,0.0,6522.5088290609965,0.0,121.92,0.0 -627,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,438900.0,5833.333333333334,14149679.650009828,5833.333333333334,10621029.394976888,true,627.0,627,0.875,0.0,0.0,0.0,0.0,0.0,627,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,438900.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,627.0,0.0,6522.5088290609965,0.0,121.92,0.0 -628,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,439600.0,5833.333333333334,14155512.983343162,5833.333333333334,10626862.728310222,true,628.0,628,0.875,0.0,0.0,0.0,0.0,0.0,628,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,439600.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,628.0,0.0,6522.5088290609965,0.0,121.92,0.0 -629,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,440300.0,5833.333333333334,14161346.316676496,5833.333333333334,10632696.061643556,true,629.0,629,0.875,0.0,0.0,0.0,0.0,0.0,629,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,440300.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,629.0,0.0,6522.5088290609965,0.0,121.92,0.0 -630,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,441000.0,5833.333333333334,14167179.65000983,5833.333333333334,10638529.39497689,true,630.0,630,0.875,0.0,0.0,0.0,0.0,0.0,630,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,441000.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,630.0,0.0,6522.5088290609965,0.0,121.92,0.0 -631,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,441700.0,5833.333333333334,14173012.983343164,5833.333333333334,10644362.728310224,true,631.0,631,0.875,0.0,0.0,0.0,0.0,0.0,631,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,441700.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,631.0,0.0,6522.5088290609965,0.0,121.92,0.0 -632,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,442400.0,5833.333333333334,14178846.316676497,5833.333333333334,10650196.061643558,true,632.0,632,0.875,0.0,0.0,0.0,0.0,0.0,632,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,442400.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,632.0,0.0,6522.5088290609965,0.0,121.92,0.0 -633,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,443100.0,5833.333333333334,14184679.650009831,5833.333333333334,10656029.394976892,true,633.0,633,0.875,0.0,0.0,0.0,0.0,0.0,633,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,443100.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,633.0,0.0,6522.5088290609965,0.0,121.92,0.0 -634,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,443800.0,5833.333333333334,14190512.983343165,5833.333333333334,10661862.728310226,true,634.0,634,0.875,0.0,0.0,0.0,0.0,0.0,634,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,443800.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,634.0,0.0,6522.5088290609965,0.0,121.92,0.0 -635,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,444500.0,5833.333333333334,14196346.3166765,5833.333333333334,10667696.06164356,true,635.0,635,0.875,0.0,0.0,0.0,0.0,0.0,635,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,444500.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,635.0,0.0,6522.5088290609965,0.0,121.92,0.0 -636,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,445200.0,5833.333333333334,14202179.650009833,5833.333333333334,10673529.394976893,true,636.0,636,0.875,0.0,0.0,0.0,0.0,0.0,636,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,445200.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,636.0,0.0,6522.5088290609965,0.0,121.92,0.0 -637,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,445900.0,5833.333333333334,14208012.983343167,5833.333333333334,10679362.728310227,true,637.0,637,0.875,0.0,0.0,0.0,0.0,0.0,637,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,445900.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,637.0,0.0,6522.5088290609965,0.0,121.92,0.0 -638,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,446600.0,5833.333333333334,14213846.316676501,5833.333333333334,10685196.061643561,true,638.0,638,0.875,0.0,0.0,0.0,0.0,0.0,638,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,446600.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,638.0,0.0,6522.5088290609965,0.0,121.92,0.0 -639,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,447300.0,5833.333333333334,14219679.650009835,5833.333333333334,10691029.394976895,true,639.0,639,0.875,0.0,0.0,0.0,0.0,0.0,639,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,447300.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,639.0,0.0,6522.5088290609965,0.0,121.92,0.0 -640,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,448000.0,5833.333333333334,14225512.98334317,5833.333333333334,10696862.72831023,true,640.0,640,0.875,0.0,0.0,0.0,0.0,0.0,640,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,448000.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,640.0,0.0,6522.5088290609965,0.0,121.92,0.0 -641,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,448700.0,5833.333333333334,14231346.316676503,5833.333333333334,10702696.061643563,true,641.0,641,0.875,0.0,0.0,0.0,0.0,0.0,641,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,448700.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,641.0,0.0,6522.5088290609965,0.0,121.92,0.0 -642,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,449400.0,5833.333333333334,14237179.650009837,5833.333333333334,10708529.394976897,true,642.0,642,0.875,0.0,0.0,0.0,0.0,0.0,642,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,449400.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,642.0,0.0,6522.5088290609965,0.0,121.92,0.0 -643,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,450100.0,5833.333333333334,14243012.983343171,5833.333333333334,10714362.728310231,true,643.0,643,0.875,0.0,0.0,0.0,0.0,0.0,643,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,450100.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,643.0,0.0,6522.5088290609965,0.0,121.92,0.0 -644,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,450800.0,5833.333333333334,14248846.316676505,5833.333333333334,10720196.061643565,true,644.0,644,0.875,0.0,0.0,0.0,0.0,0.0,644,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,450800.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,644.0,0.0,6522.5088290609965,0.0,121.92,0.0 -645,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,451500.0,5833.333333333334,14254679.650009839,5833.333333333334,10726029.394976899,true,645.0,645,0.875,0.0,0.0,0.0,0.0,0.0,645,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,451500.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,1644.2724500334996,645.0,0.0,6522.5088290609965,0.0,121.92,0.0 -646,22450.0,21750.0,0.14400000000000002,822.8858044250761,3529473.140837321,700.0,452200.0,10575.595864063027,14265255.245873902,9752.710059637951,10735782.105036536,true,646.0,646,0.875,720.0250788719416,822.8858044250761,102.86072555313456,0.0,0.0,646,21750.0,0.0,720.0250788719416,720.0250788719416,1705179.954794385,700.0,452200.0,0.043620066072829394,968739.9574466244,657.2197971695749,657.2197971695176,0.0,0.0,50.425629263214425,735770.4415182159,12.336032373079432,12.336032373082292,-720.0250788719416,-3088288.998232658,true,true,0.894094506,6523.402923566997,0.0,1644.2724500334996,646.0,0.894094506,6523.402923566997,0.0,121.92,0.0 -647,23272.885804425077,22572.885804425077,0.196,3297.658566844822,3532770.7994041657,700.0,452900.0,20396.217177779705,14285651.463051682,17098.558610934884,10752880.663647471,true,647.0,647,0.875,2885.4512459892194,3297.658566844822,412.2073208556026,0.0,0.0,647,22572.885804425077,0.0,2885.4512459892194,2885.4512459892194,1708065.4060403742,700.0,452900.0,1.4973950798833802,968741.4548417043,2669.955424347497,3327.1752215170145,0.0,0.0,163.88329507724762,735934.3248132932,50.11513148459141,62.4511638576737,-2885.4512459892194,-3091174.449478647,true,true,2.011712638,6525.414636204997,0.0,1644.2724500334996,647.0,2.011712638,6525.414636204997,0.0,121.92,0.0 -648,25747.65856684482,25047.65856684482,0.28625,8130.950619693936,3540901.7500238596,700.0,453600.0,30850.482514214626,14316501.945565896,22719.53189452069,10775600.19554199,true,648.0,648,0.875,7114.581792232194,8130.950619693936,1016.3688274617416,0.0,0.0,648,25047.65856684482,0.0,7114.581792232194,7114.581792232194,1715179.9878326063,700.0,453600.0,10.146392681611328,968751.601234386,6669.137891138753,9996.313112655767,0.0,0.0,310.11761991801,736244.4424332111,125.17988849381992,187.63105235149362,-7114.581792232194,-3098289.0312708793,true,true,3.486968573,6528.901604777997,0.0,1644.2724500334996,648.0,3.486968573,6528.901604777997,0.0,121.92,0.0 -649,30580.950619693936,29880.950619693936,0.29250000000000004,8819.237312322106,3549720.9873361816,700.0,454300.0,32544.401067767878,14349046.346633663,23725.16375544577,10799325.359297438,true,649.0,649,0.875,7716.832648281843,8819.237312322106,1102.404664040263,0.0,0.0,649,29880.950619693936,0.0,7716.832648281843,7716.832648281843,1722896.8204808882,700.0,454300.0,31.799028155237433,968783.4002625413,7097.973807226208,17094.286919881975,0.0,0.0,453.8306633125313,736698.2730965237,133.2291495878662,320.86020193935985,-7716.832648281843,-3106005.8639191613,true,true,4.55988198,6533.461486757997,0.0,1644.2724500334996,649.0,4.55988198,6533.461486757997,0.0,121.92,0.0 -650,31269.237312322104,30569.237312322104,0.30500000000000005,10714.84204490481,3560435.8293810864,700.0,455000.0,37425.711622638715,14386472.058256302,26710.869577733905,10826036.228875171,true,650.0,650,0.875,9375.486789291708,10714.84204490481,1339.3552556131017,0.0,0.0,650,30569.237312322104,0.0,9375.486789291708,9375.486789291708,1732272.30727018,700.0,455000.0,63.77844162532666,968847.1787041666,8578.361393271975,25672.64831315395,0.0,0.0,572.3308920190467,737270.6039885428,161.01606237536012,481.87626431471995,-9375.486789291708,-3115381.350708453,true,true,5.588090661,6539.049577418997,0.0,1644.2724500334996,650.0,5.588090661,6539.049577418997,0.0,121.92,0.0 -651,33164.84204490481,32464.842044904814,0.29250000000000004,8483.79403563534,3568919.623416722,700.0,455700.0,31397.58644661654,14417869.644702919,22913.7924109812,10848950.021286152,true,651.0,651,0.875,7423.319781180922,8483.79403563534,1060.474254454417,0.0,0.0,651,32464.842044904814,0.0,7423.319781180922,7423.319781180922,1739695.627051361,700.0,455700.0,101.46913394708368,968948.6478381136,6531.1217378642295,32203.77005101818,0.0,0.0,668.1395875965949,737938.7435761394,122.58932177301392,604.4655860877339,-7423.319781180922,-3122804.670489634,true,true,6.258661541,6545.308238959997,0.0,1644.2724500334996,651.0,6.258661541,6545.308238959997,0.0,121.92,0.0 -652,30933.79403563534,30233.79403563534,0.28625,8287.693613458236,3577207.3170301802,700.0,456400.0,31398.056291557154,14449267.700994477,23110.362678098918,10872060.383964252,true,652.0,652,0.875,7251.731911775956,8287.693613458236,1035.9617016822795,0.0,0.0,652,30233.79403563534,0.0,7251.731911775956,7251.731911775956,1746947.3589631368,700.0,456400.0,137.1510676988913,969085.7989058124,6258.375507469806,38462.14555848799,0.0,0.0,738.7354685425356,738677.479044682,117.46986806472437,721.9354541524582,-7251.731911775956,-3130056.40240141,true,true,6.839822969,6552.148061928997,0.0,1644.2724500334996,652.0,6.839822969,6552.148061928997,0.0,121.92,0.0 -653,30737.693613458236,30037.693613458236,0.33999999999999997,14969.34074900109,3592176.6577791814,700.0,457100.0,46086.29632059145,14495353.997315068,31116.95557159036,10903177.339535842,true,653.0,653,0.875,13098.173155375955,14969.34074900109,1871.1675936251359,0.0,0.0,653,30037.693613458236,0.0,13098.173155375955,13098.173155375955,1760045.5321185128,700.0,457100.0,192.4056685897089,969278.2045744022,11856.245143012024,50318.390701500015,0.0,0.0,826.9803197249615,739504.459364407,222.542024049261,944.4774782017191,-13098.173155375955,-3143154.575556786,true,true,7.823326926,6559.971388854997,0.0,1644.2724500334996,653.0,7.823326926,6559.971388854997,0.0,121.92,0.0 -654,37419.34074900109,36719.34074900109,0.345,16291.543302128222,3608468.2010813095,700.0,457800.0,49250.8501510963,14544604.847466163,32959.30684896808,10936136.64638481,true,654.0,654,0.875,14255.100389362195,16291.543302128222,2036.4429127660278,0.0,0.0,654,36719.34074900109,0.0,14255.100389362195,14255.100389362195,1774300.6325078749,700.0,457800.0,278.4313035608702,969556.635877963,12800.998592732745,63119.38929423276,0.0,0.0,935.3954226465124,740439.8547870535,240.27507042206602,1184.752548623785,-14255.100389362195,-3157409.675946148,true,true,8.762126157,6568.733515011997,0.0,1644.2724500334996,654.0,8.762126157,6568.733515011997,0.0,121.92,0.0 -655,38741.54330212822,38041.54330212822,0.33,12460.49038266961,3620928.691463979,700.0,458500.0,39880.27388687761,14584485.121353041,27419.783504207997,10963556.429889018,true,655.0,655,0.875,10902.929084835909,12460.49038266961,1557.5612978337012,0.0,0.0,655,38041.54330212822,0.0,10902.929084835909,10902.929084835909,1785203.5615927107,700.0,458500.0,364.90047823823903,969921.5363562013,9339.09331283999,72458.48260707274,0.0,0.0,1023.6402738289385,741463.4950608825,175.29501992874089,1360.047568552526,-10902.929084835909,-3168312.605030984,true,true,9.387992311,6578.121507322997,0.0,1644.2724500334996,655.0,9.387992311,6578.121507322997,0.0,121.92,0.0 -656,34910.49038266961,34210.49038266961,0.3175,11664.259309707926,3632592.950773687,700.0,459200.0,38942.5490069541,14623427.670359995,27278.28969724617,10990834.719586264,true,656.0,656,0.875,10206.226895994436,11664.259309707926,1458.0324137134903,0.0,0.0,656,34210.49038266961,0.0,10206.226895994436,10206.226895994436,1795409.7884887052,700.0,459200.0,439.58976506777304,970361.1261212691,8517.568559762447,80976.05116683518,0.0,0.0,1089.1935918259985,742552.6886527085,159.87497933821726,1519.9225478907433,-10206.226895994436,-3178518.8319269787,true,true,9.924449014,6588.045956336997,0.0,1644.2724500334996,656.0,9.924449014,6588.045956336997,0.0,121.92,0.0 -657,34114.25930970792,33414.25930970792,0.3175,11472.693545475633,3644065.6443191627,700.0,459900.0,38339.19226921459,14661766.86262921,26866.498723738958,11017701.218310004,true,657.0,657,0.875,10038.60685229118,11472.693545475633,1434.086693184454,0.0,0.0,657,33414.25930970792,0.0,10038.60685229118,10038.60685229118,1805448.3953409963,700.0,459900.0,513.6065120969963,970874.732633366,8223.46267058974,89199.51383742492,0.0,0.0,1147.1830653151392,743699.8717180237,154.35460428930247,1674.2771521800457,-10038.60685229118,-3188557.43877927,true,true,10.41620099,6598.462157326997,0.0,1644.2724500334996,657.0,10.41620099,6598.462157326997,0.0,121.92,0.0 -658,33922.69354547563,33222.69354547563,0.33,13030.972407286916,3657096.6167264497,700.0,460600.0,41609.007294808835,14703375.86992402,28578.03488752192,11046279.253197527,true,658.0,658,0.875,11402.100856376052,13030.972407286916,1628.8715509108642,0.0,0.0,658,33222.69354547563,0.0,11402.100856376052,11402.100856376052,1816850.4961973724,700.0,460600.0,595.497608516666,971470.2302418827,9424.532002348078,98624.045839773,0.0,0.0,1205.1725391990697,744905.0442572228,176.89870631223778,1851.1758584922836,-11402.100856376052,-3199959.5396356457,true,true,10.9526577,6609.414815026997,0.0,1644.2724500334996,658.0,10.9526577,6609.414815026997,0.0,121.92,0.0 -659,35480.972407286914,34780.972407286914,0.30500000000000005,9826.047574678338,3666922.664301128,700.0,461300.0,34511.631392387986,14737887.501316408,24685.58381770965,11070964.837015236,true,659.0,659,0.875,8597.791627843546,9826.047574678338,1228.2559468347918,0.0,0.0,659,34780.972407286914,0.0,8597.791627843546,8597.791627843546,1825448.287825216,700.0,461300.0,673.4174414832393,972143.647683366,6545.9091360577695,105169.95497583077,0.0,0.0,1255.5981686878783,746160.6424259107,122.86688161465955,1974.0427401069433,-8597.791627843546,-3208557.331263489,true,true,11.3102955,6620.725110526997,0.0,1644.2724500334996,659.0,11.3102955,6620.725110526997,0.0,121.92,0.0 -660,32276.047574678338,31576.047574678338,0.23500000000000001,5209.595368367851,3672132.2596694957,700.0,462000.0,25147.214333480213,14763034.715649888,19937.618965112364,11090902.455980347,true,660.0,660,0.875,4558.395947321869,5209.595368367851,651.1994210459816,0.0,0.0,660,31576.047574678338,0.0,4558.395947321869,4558.395947321869,1830006.6837725379,700.0,462000.0,719.0344170389658,972862.682100405,2508.9364644717944,107678.89144030257,0.0,0.0,1283.3322643145384,747443.9746902252,47.092801496571106,2021.1355416035144,-4558.395947321869,-3213115.727210811,true,true,11.44440967,6632.169520196997,0.0,1644.2724500334996,660.0,11.44440967,6632.169520196997,0.0,121.92,0.0 -661,27659.595368367853,26959.595368367853,0.25,6291.427671015444,3678423.687340511,700.0,462700.0,27965.710684061774,14791000.426333949,21674.28301304633,11112576.738993393,true,661.0,661,0.875,5504.999212138513,6291.427671015444,786.4284588769306,0.0,0.0,661,26959.595368367853,0.0,5504.999212138513,5504.999212138513,1835511.6829846764,700.0,462700.0,749.1097276748961,973611.7918280798,3391.2543195790295,111070.1457598816,0.0,0.0,1300.9812347202192,748744.9559249454,63.65393016436861,2084.7894717678832,-5504.999212138513,-3218620.726422949,true,true,11.62322858,6643.792748776997,0.0,1644.2724500334996,661.0,11.62322858,6643.792748776997,0.0,121.92,0.0 -662,28741.427671015445,28041.427671015445,0.196,3379.1792845761915,3681802.8666250873,700.0,463400.0,20812.139207021384,14811812.565540971,17432.959922445192,11130009.69891584,true,662.0,662,0.875,2956.7818740041675,3379.1792845761915,422.397410572024,0.0,0.0,662,28041.427671015445,0.0,2956.7818740041675,2956.7818740041675,1838468.4648586805,700.0,463400.0,771.0978672321098,974382.889695312,856.0286842785162,111926.17444416012,0.0,0.0,1313.5876422334175,750058.5435671789,16.067680260123925,2100.857152028007,-2956.7818740041675,-3221577.5082969535,true,true,11.6679333,6655.460682076997,0.0,1644.2724500334996,662.0,11.6679333,6655.460682076997,0.0,121.92,0.0 -663,25829.179284576192,25129.179284576192,0.196,3398.95628555421,3685201.8229106413,700.0,464100.0,20913.042273235766,14832725.607814208,17514.085987681556,11147523.78490352,true,663.0,663,0.875,2974.0867498599337,3398.95628555421,424.86953569427624,0.0,0.0,663,25129.179284576192,0.0,2974.0867498599337,2974.0867498599337,1841442.5516085404,700.0,464100.0,780.0122056389245,975162.9019009509,859.3149750728685,112785.48941923298,0.0,0.0,1318.6302051259001,751377.1737723048,16.129364022240278,2116.9865160502472,-2974.0867498599337,-3224551.5950468136,true,true,11.71263803,6667.1733201069965,0.0,1644.2724500334996,663.0,11.71263803,6667.1733201069965,0.0,121.92,0.0 -664,25848.95628555421,25148.95628555421,0.1792,2406.4531551969244,3687608.276065838,700.0,464800.0,17335.118053554266,14850060.725867761,14928.664898357341,11162452.449801877,true,664.0,664,0.875,2105.646510797309,2406.4531551969244,300.8066443996154,0.0,0.0,664,25148.95628555421,0.0,2105.646510797309,2105.646510797309,1843548.1981193377,700.0,464800.0,784.4950239431748,975947.3969248941,0.0,112785.48941923298,0.0,0.0,1321.151486854134,752698.325259159,0.0,2116.9865160502472,-2105.646510797309,-3226657.2415576107,true,true,11.71263803,6678.885958136996,0.0,1644.2724500334996,664.0,11.71263803,6678.885958136996,0.0,121.92,0.0 -665,24856.453155196923,24156.453155196923,0.20800000000000002,4435.014845845207,3692043.2909116833,700.0,465500.0,24687.5713742558,14874748.297242017,20252.556528410594,11182705.006330287,true,665.0,665,0.875,3880.6379901145556,4435.014845845207,554.3768557306512,0.0,0.0,665,24156.453155196923,0.0,3880.6379901145556,3880.6379901145556,1847428.8361094522,700.0,465500.0,793.5121203230937,976740.9090452172,1728.488055118332,114513.97747435131,0.0,0.0,1326.1940497466162,754024.5193089056,32.443764926513666,2149.430280976761,-3880.6379901145556,-3230537.8795477254,true,true,11.80204748,6690.688005616996,0.0,1644.2724500334996,665.0,11.80204748,6690.688005616996,0.0,121.92,0.0 -666,26885.014845845206,26185.014845845206,0.196,3458.7568917631256,3695502.0478034467,700.0,466200.0,21218.14740695472,14895966.444648972,17759.390515191593,11200464.396845479,true,666.0,666,0.875,3026.412280292735,3458.7568917631256,432.34461147039065,0.0,0.0,666,26185.014845845206,0.0,3026.412280292735,3026.412280292735,1850455.248389745,700.0,466200.0,807.1669070373962,977548.0759522546,869.1730785753125,115383.15055292663,0.0,0.0,1333.7578938033469,755358.2772027089,16.314400876678945,2165.74468185344,-3026.412280292735,-3233564.291828018,true,true,11.8467522,6702.534757816996,0.0,1644.2724500334996,666.0,11.8467522,6702.534757816996,0.0,121.92,0.0 -667,25908.756891763125,25208.756891763125,0.1816,2454.8939955807286,3697956.9417990274,700.0,466900.0,17372.764292845422,14913339.208941817,14917.870297264693,11215382.267142743,true,667.0,667,0.875,2148.0322461331375,2454.8939955807286,306.86174944759114,0.0,0.0,667,25208.756891763125,0.0,2148.0322461331375,2148.0322461331375,1852603.280635878,700.0,466900.0,811.7530711655421,978359.8290234201,0.0,115383.15055292663,0.0,0.0,1336.2791749675953,756694.5563776764,0.0,2165.74468185344,-2148.0322461331375,-3235712.3240741515,true,true,11.8467522,6714.381510016996,0.0,1644.2724500334996,667.0,11.8467522,6714.381510016996,0.0,121.92,0.0 -668,24904.89399558073,24204.89399558073,0.12,0.0,3697956.9417990274,700.0,467600.0,5833.333333333334,14919172.542275151,5833.333333333334,11221215.600476077,true,668.0,668,0.875,0.0,0.0,0.0,0.0,0.0,668,24204.89399558073,0.0,-2281.292251183721,-2281.292251183721,1850321.9883846943,700.0,467600.0,788.9949839284826,979148.8240073486,-4313.004793045029,111070.1457598816,0.0,0.0,1323.6727680183824,758018.2291456948,-80.95521008555681,2084.7894717678832,-0.0,-3235712.3240741515,true,true,11.62322858,6726.004738596996,0.0,1644.2724500334996,668.0,11.62322858,6726.004738596996,0.0,121.92,0.0 -669,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,468300.0,5833.333333333334,14925005.875608485,5833.333333333334,11227048.93380941,true,669.0,669,0.875,0.0,0.0,0.0,0.0,0.0,669,21750.0,0.0,-2267.0428926056675,-2267.0428926056675,1848054.9454920886,700.0,468300.0,744.7628741042208,979893.5868814528,-4230.85251061896,106839.29324926264,0.0,0.0,1298.4599535559707,759316.6890992507,-79.4132096468994,2005.376262120984,-0.0,-3235712.3240741515,true,true,11.39970495,6737.404443546996,0.0,1644.2724500334996,669.0,11.39970495,6737.404443546996,0.0,121.92,0.0 -670,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,469000.0,5833.333333333334,14930839.20894182,5833.333333333334,11232882.267142745,true,670.0,670,0.875,0.0,0.0,0.0,0.0,0.0,670,21750.0,0.0,-13732.349015409776,-13732.349015409776,1834322.5964766787,700.0,469000.0,645.4176063110823,980539.0044877639,-15328.008705249164,91511.28454401348,0.0,0.0,1237.9491982821974,760554.6382975329,-287.70711475389254,1717.6691473670915,-0.0,-3235712.3240741515,true,true,10.55031517,6747.954758716996,0.0,1644.2724500334996,670.0,10.55031517,6747.954758716996,0.0,121.92,0.0 -671,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,469700.0,5833.333333333334,14936672.542275153,5833.333333333334,11238715.600476079,true,671.0,671,0.875,0.0,0.0,0.0,0.0,0.0,671,21750.0,0.0,-14940.070329157013,-14940.070329157013,1819382.5261475218,700.0,469700.0,496.8598148885372,981035.8643026524,-16266.190000675882,75245.0945433376,0.0,0.0,1134.576658253129,761689.214955786,-305.31680162279815,1412.3523457442934,-0.0,-3235712.3240741515,true,true,9.566811212,6757.5215699289965,0.0,1644.2724500334996,671.0,9.566811212,6757.5215699289965,0.0,121.92,0.0 -672,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,470400.0,5833.333333333334,14942505.875608487,5833.333333333334,11244548.933809413,true,672.0,672,0.875,0.0,0.0,0.0,0.0,0.0,672,21750.0,0.0,-18016.235079067,-18016.235079067,1801366.2910684547,700.0,470400.0,346.3498619601361,981382.2141646126,-19011.725668414034,56233.36887492357,0.0,0.0,1005.991303592453,762695.2062593785,-356.8505762055545,1055.501769538739,-0.0,-3235712.3240741515,true,true,8.270374179,6765.791944107997,0.0,1644.2724500334996,672.0,8.270374179,6765.791944107997,0.0,121.92,0.0 -673,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,471100.0,5833.333333333334,14948339.208941821,5833.333333333334,11250382.267142747,true,673.0,673,0.875,0.0,0.0,0.0,0.0,0.0,673,21750.0,0.0,-11156.23124825878,-11156.23124825878,1790210.059820196,700.0,471100.0,231.77821434011472,981613.9923789527,-12041.909739762634,44191.45913516094,0.0,0.0,879.9272304344171,763575.1334898128,-226.02695327067863,829.4748162680603,-0.0,-3235712.3240741515,true,true,7.331574947,6773.123519054997,0.0,1644.2724500334996,673.0,7.331574947,6773.123519054997,0.0,121.92,0.0 -674,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,471800.0,5833.333333333334,14954172.542275155,5833.333333333334,11256215.60047608,true,674.0,674,0.875,0.0,0.0,0.0,0.0,0.0,674,21750.0,0.0,-8887.460924806332,-8887.460924806332,1781322.5988953896,700.0,471800.0,160.8687806667652,981774.8611596194,-9646.343562422926,34545.11557273802,0.0,0.0,779.0759719079883,764354.2094617208,-181.062114958159,648.4127013099013,-0.0,-3235712.3240741515,true,true,6.482185167,6779.605704221997,0.0,1644.2724500334996,674.0,6.482185167,6779.605704221997,0.0,121.92,0.0 -675,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,472500.0,5833.333333333334,14960005.875608489,5833.333333333334,11262048.933809415,true,675.0,675,0.875,0.0,0.0,0.0,0.0,0.0,675,21750.0,0.0,-11914.67240123873,-11914.67240123873,1769407.926494151,700.0,472500.0,96.94331218857396,981871.804471808,-12436.241602774991,22108.873969963024,0.0,0.0,658.0544617552316,765012.263923476,-233.42857240754407,414.98412890235727,-0.0,-3235712.3240741515,true,true,5.185748134,6784.7914523559975,0.0,1644.2724500334996,675.0,5.185748134,6784.7914523559975,0.0,121.92,0.0 -676,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,473200.0,5833.333333333334,14965839.208941823,5833.333333333334,11267882.267142748,true,676.0,676,0.875,0.0,0.0,0.0,0.0,0.0,676,21750.0,0.0,-9296.755224816934,-9296.755224816934,1760111.171269334,700.0,473200.0,45.61255977977984,981917.4170315878,-9672.632365056386,12436.241604906638,0.0,0.0,511.8201369144692,765524.0840603905,-181.55555645479774,233.42857244755953,-0.0,-3235712.3240741515,true,true,3.8893111,6788.680763455997,0.0,1644.2724500334996,676.0,3.8893111,6788.680763455997,0.0,121.92,0.0 -677,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,473900.0,5833.333333333334,14971672.542275157,5833.333333333334,11273715.600476082,true,677.0,677,0.875,0.0,0.0,0.0,0.0,0.0,677,21750.0,0.0,-6656.497187584309,-6656.497187584309,1753454.6740817495,700.0,473900.0,16.62265297987032,981934.0396845677,-6909.023112415919,5527.218492490719,0.0,0.0,365.5858120737068,765889.6698724641,-129.68254022196757,103.74603222559196,-0.0,-3235712.3240741515,true,true,2.592874067,6791.273637522997,0.0,1644.2724500334996,677.0,2.592874067,6791.273637522997,0.0,121.92,0.0 -678,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,474600.0,5833.333333333334,14977505.87560849,5833.333333333334,11279548.933809416,true,678.0,678,0.875,0.0,0.0,0.0,0.0,0.0,678,21750.0,0.0,-3341.5848588463828,-3341.5848588463828,1750113.0892229031,700.0,474600.0,4.385763182919641,981938.4254477506,-3514.482864945313,2012.7356275454058,0.0,0.0,234.4791760231884,766124.1490484873,-65.96693310717784,37.77909911841412,-0.0,-3235712.3240741515,true,true,1.564665385,6792.838302907997,0.0,1644.2724500334996,678.0,1.564665385,6792.838302907997,0.0,121.92,0.0 -679,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,475300.0,5833.333333333334,14983339.208941825,5833.333333333334,11285382.26714275,true,679.0,679,0.875,0.0,0.0,0.0,0.0,0.0,679,21750.0,0.0,-1241.3812556145165,-1241.3812556145165,1748871.7079672886,700.0,475300.0,0.9071610610549482,981939.3326088117,-1355.5158303758806,657.2197971695252,0.0,0.0,138.6704804456404,766262.8195289329,-25.443066745331166,12.336032373082958,-0.0,-3235712.3240741515,true,true,0.894094506,6793.732397413997,0.0,1644.2724500334996,679.0,0.894094506,6793.732397413997,0.0,121.92,0.0 -680,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,476000.0,5833.333333333334,14989172.542275159,5833.333333333334,11291215.600476084,true,680.0,680,0.875,0.0,0.0,0.0,0.0,0.0,680,21750.0,0.0,-619.0865802133671,-619.0865802133671,1748252.6213870752,700.0,476000.0,0.043620066072829394,981939.3762288777,-657.2197971695749,-4.9681148084346205e-11,0.0,0.0,50.425629263214425,766313.2451581961,-12.336032373079432,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,680.0,0.0,6793.732397413997,0.0,121.92,0.0 -681,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,476700.0,5833.333333333334,14995005.875608493,5833.333333333334,11297048.933809418,true,681.0,681,0.875,0.0,0.0,0.0,0.0,0.0,681,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,476700.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,681.0,0.0,6793.732397413997,0.0,121.92,0.0 -682,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,477400.0,5833.333333333334,15000839.208941827,5833.333333333334,11302882.267142752,true,682.0,682,0.875,0.0,0.0,0.0,0.0,0.0,682,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,477400.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,682.0,0.0,6793.732397413997,0.0,121.92,0.0 -683,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,478100.0,5833.333333333334,15006672.54227516,5833.333333333334,11308715.600476086,true,683.0,683,0.875,0.0,0.0,0.0,0.0,0.0,683,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,478100.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,683.0,0.0,6793.732397413997,0.0,121.92,0.0 -684,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,478800.0,5833.333333333334,15012505.875608495,5833.333333333334,11314548.93380942,true,684.0,684,0.875,0.0,0.0,0.0,0.0,0.0,684,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,478800.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,684.0,0.0,6793.732397413997,0.0,121.92,0.0 -685,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,479500.0,5833.333333333334,15018339.208941828,5833.333333333334,11320382.267142754,true,685.0,685,0.875,0.0,0.0,0.0,0.0,0.0,685,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,479500.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,685.0,0.0,6793.732397413997,0.0,121.92,0.0 -686,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,480200.0,5833.333333333334,15024172.542275162,5833.333333333334,11326215.600476088,true,686.0,686,0.875,0.0,0.0,0.0,0.0,0.0,686,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,480200.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,686.0,0.0,6793.732397413997,0.0,121.92,0.0 -687,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,480900.0,5833.333333333334,15030005.875608496,5833.333333333334,11332048.933809422,true,687.0,687,0.875,0.0,0.0,0.0,0.0,0.0,687,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,480900.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,687.0,0.0,6793.732397413997,0.0,121.92,0.0 -688,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,481600.0,5833.333333333334,15035839.20894183,5833.333333333334,11337882.267142756,true,688.0,688,0.875,0.0,0.0,0.0,0.0,0.0,688,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,481600.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,688.0,0.0,6793.732397413997,0.0,121.92,0.0 -689,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,482300.0,5833.333333333334,15041672.542275164,5833.333333333334,11343715.60047609,true,689.0,689,0.875,0.0,0.0,0.0,0.0,0.0,689,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,482300.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,689.0,0.0,6793.732397413997,0.0,121.92,0.0 -690,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,483000.0,5833.333333333334,15047505.875608498,5833.333333333334,11349548.933809424,true,690.0,690,0.875,0.0,0.0,0.0,0.0,0.0,690,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,483000.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,690.0,0.0,6793.732397413997,0.0,121.92,0.0 -691,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,483700.0,5833.333333333334,15053339.208941832,5833.333333333334,11355382.267142758,true,691.0,691,0.875,0.0,0.0,0.0,0.0,0.0,691,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,483700.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,691.0,0.0,6793.732397413997,0.0,121.92,0.0 -692,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,484400.0,5833.333333333334,15059172.542275166,5833.333333333334,11361215.600476092,true,692.0,692,0.875,0.0,0.0,0.0,0.0,0.0,692,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,484400.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,692.0,0.0,6793.732397413997,0.0,121.92,0.0 -693,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,485100.0,5833.333333333334,15065005.8756085,5833.333333333334,11367048.933809426,true,693.0,693,0.875,0.0,0.0,0.0,0.0,0.0,693,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,485100.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,1644.2724500334996,693.0,0.0,6793.732397413997,0.0,121.92,0.0 -694,22450.0,21750.0,0.132,415.3088667678144,3698372.250665795,700.0,485800.0,8449.309596725867,15073455.185205227,8034.000729958052,11375082.934539383,true,694.0,694,0.875,363.3952584218376,415.3088667678144,51.9136083459768,0.0,0.0,694,21750.0,0.0,363.3952584218376,363.3952584218376,1748616.016645497,700.0,485800.0,0.014961682648637148,981939.3911905603,322.0377004072729,322.0377004072232,0.0,0.0,35.29794047297039,766348.543098669,6.044655858945696,6.044655858949222,-363.3952584218376,-3236075.7193325735,true,true,0.625866154,6794.358263567997,0.0,1644.2724500334996,694.0,0.625866154,6794.358263567997,0.0,121.92,0.0 -695,22865.308866767813,22165.308866767813,0.1696,1844.3996736441163,3700216.650339439,700.0,486500.0,15002.356566297856,15088457.541771526,13157.95689265374,11388240.891432038,true,695.0,695,0.875,1613.8497144386017,1844.3996736441163,230.5499592055146,0.0,0.0,695,22165.308866767813,0.0,1613.8497144386017,1613.8497144386017,1750229.8663599356,700.0,486500.0,0.5660957649040933,981939.9572863252,1467.2431976294674,1789.2808980366906,0.0,0.0,118.50022876291405,766467.0433274319,27.540192281316145,33.584848140265365,-1613.8497144386017,-3237689.569047012,true,true,1.475255935,6795.833519502997,0.0,1644.2724500334996,695.0,1.475255935,6795.833519502997,0.0,121.92,0.0 -696,24294.399673644115,23594.399673644115,0.1696,1845.0427322983046,3702061.6930717374,700.0,487200.0,15006.148185721135,15103463.689957246,13161.10545342283,11401401.99688546,true,696.0,696,0.875,1614.4123907610165,1845.0427322983046,230.63034153728813,0.0,0.0,696,23594.399673644115,0.0,1614.4123907610165,1614.4123907610165,1751844.2787506967,700.0,487200.0,2.489249952836435,981942.446536278,1391.6629196171434,3180.9438176538342,0.0,0.0,194.1386726577357,766661.1820000897,26.121548533301038,59.7063966735664,-1614.4123907610165,-3239303.981437773,true,true,1.967007913,6797.800527415997,0.0,1644.2724500334996,696.0,1.967007913,6797.800527415997,0.0,121.92,0.0 -697,24295.042732298305,23595.042732298305,0.22,4701.0446497637795,3706762.7377215014,700.0,487900.0,24550.202953471726,15128013.892910717,19849.158303707947,11421251.155189168,true,697.0,697,0.875,4113.414068543307,4701.0446497637795,587.6305812204728,0.0,0.0,697,23595.042732298305,0.0,4113.414068543307,4113.414068543307,1755957.69281924,700.0,487900.0,7.061156315235682,981949.5076925933,3760.940287560783,6941.884105214617,0.0,0.0,274.81967944503964,766936.0016795347,70.5929452222476,130.299341895814,-4113.414068543307,-3243417.3955063163,true,true,2.905807144,6800.706334559997,0.0,1644.2724500334996,697.0,2.905807144,6800.706334559997,0.0,121.92,0.0 -698,27151.04464976378,26451.04464976378,0.29250000000000004,8585.78253150512,3715348.5202530064,700.0,488600.0,31746.265064974763,15159760.157975692,23160.482533469643,11444411.637722638,true,698.0,698,0.875,7512.559715066979,8585.78253150512,1073.2228164381404,0.0,0.0,698,26451.04464976378,0.0,7512.559715066979,7512.559715066979,1763470.252534307,700.0,488600.0,21.10062353442648,981970.6083161277,6964.886798835968,13906.770904050585,0.0,0.0,395.84118965419486,767331.8428691889,130.7311030423896,261.0304449382036,-7512.559715066979,-3250929.9552213834,true,true,4.112834727,6804.819169286997,0.0,1644.2724500334996,698.0,4.112834727,6804.819169286997,0.0,121.92,0.0 -699,31035.78253150512,30335.78253150512,0.29250000000000004,8879.921545173249,3724228.4417981794,700.0,489300.0,32751.86853050683,15192512.026506199,23871.94698533358,11468283.584707972,true,699.0,699,0.875,7769.931352026593,8879.921545173249,1109.9901931466557,0.0,0.0,699,30335.78253150512,0.0,7769.931352026593,7769.931352026593,1771240.1838863336,700.0,489300.0,46.97404019264503,982017.5823563203,7073.328063619489,20980.098967670074,0.0,0.0,516.86269986335,767848.7055690523,132.7665483511102,393.7969932893138,-7769.931352026593,-3258699.88657341,true,true,5.051633958,6809.870803244997,0.0,1644.2724500334996,699.0,5.051633958,6809.870803244997,0.0,121.92,0.0 -700,31329.92154517325,30629.92154517325,0.3175,11247.07014279289,3735475.5119409724,700.0,490000.0,37628.56737887525,15230140.593885073,26381.497236082356,11494665.081944054,true,700.0,700,0.875,9841.18637494378,11247.07014279289,1405.8837678491109,0.0,0.0,700,30629.92154517325,0.0,9841.18637494378,9841.18637494378,1781081.3702612773,700.0,490000.0,83.1670648020317,982100.7494211224,8964.478025983519,29944.576993653594,0.0,0.0,625.2778027285024,768473.9833717807,168.26348142972716,562.0604747190409,-9841.18637494378,-3268541.072948354,true,true,6.035137914,6815.905941158997,0.0,1644.2724500334996,700.0,6.035137914,6815.905941158997,0.0,121.92,0.0 -701,33697.07014279289,32997.07014279289,0.265,6861.089412511706,3742336.601353484,700.0,490700.0,28532.41287740266,15258673.006762477,21671.323464890957,11516336.405408945,true,701.0,701,0.875,6003.4532359477425,6861.089412511706,857.6361765639631,0.0,0.0,701,32997.07014279289,0.0,6003.4532359477425,6003.4532359477425,1787084.823497225,700.0,490700.0,120.98047671048755,982221.7298978328,5078.665978195433,35023.24297184903,0.0,0.0,708.4800909620475,769182.4634627427,95.32669007977408,657.387164798815,-6003.4532359477425,-3274544.5261843014,true,true,6.526889892,6822.432831050997,0.0,1644.2724500334996,701.0,6.526889892,6822.432831050997,0.0,121.92,0.0 -702,29311.089412511705,28611.089412511705,0.3175,11753.52770461908,3754090.129058103,700.0,491400.0,39223.70930588687,15297896.716068363,27470.18160126779,11543806.587010212,true,702.0,702,0.875,10284.336741541696,11753.52770461908,1469.1909630773844,0.0,0.0,702,28611.089412511705,0.0,10284.336741541696,10284.336741541696,1797369.1602387668,700.0,491400.0,162.43567340630506,982384.1655712392,9168.216163311916,44191.45913516095,0.0,0.0,781.5972533542295,769964.060716097,172.08765146924523,829.4748162680602,-10284.336741541696,-3284828.862925843,true,true,7.331574947,6829.7644059979975,0.0,1644.2724500334996,702.0,7.331574947,6829.7644059979975,0.0,121.92,0.0 -703,34203.52770461908,33503.52770461908,0.1912,3079.37147277558,3757169.5005308785,700.0,492100.0,19766.5872007091,15317663.303269072,16687.21572793352,11560493.802738145,true,703.0,703,0.875,2694.4500386786326,3079.37147277558,384.92143409694745,0.0,0.0,703,33503.52770461908,0.0,2694.4500386786326,2694.4500386786326,1800063.6102774455,700.0,492100.0,197.73352701896206,982581.8990982581,1631.548147215881,45823.00728237683,0.0,0.0,834.544164063685,770798.6048801607,30.624200380104874,860.099016648165,-2694.4500386786326,-3287523.3129645213,true,true,7.465689123,6837.230095120997,0.0,1644.2724500334996,703.0,7.465689123,6837.230095120997,0.0,121.92,0.0 -704,25529.37147277558,24829.37147277558,0.12,0.0,3757169.5005308785,700.0,492800.0,5833.333333333334,15323496.636602405,5833.333333333334,11566327.136071479,true,704.0,704,0.875,0.0,0.0,0.0,0.0,0.0,704,24829.37147277558,0.0,-74.86613013470463,-74.86613013470463,1799988.7441473107,700.0,492800.0,199.53109361148717,982781.4301918696,-1090.984855715592,44732.022426661235,0.0,0.0,837.0654455663247,771635.670325727,-20.477813596924506,839.6212030512405,-0.0,-3287523.3129645213,true,true,7.376279673,6844.606374793997,0.0,1644.2724500334996,704.0,7.376279673,6844.606374793997,0.0,121.92,0.0 -705,22450.0,21750.0,0.15600000000000003,1174.8224821276701,3758344.3230130062,700.0,493500.0,12018.09283415173,15335514.729436558,10843.27035202406,11577170.406423504,true,705.0,705,0.875,1027.9696718617113,1174.8224821276701,146.85281026595885,0.0,0.0,705,21750.0,0.0,1027.9696718617113,1027.9696718617113,1801016.7138191725,700.0,493500.0,195.94678918786877,982977.3769810575,0.0,44732.022426661235,0.0,0.0,832.0228826738424,772467.6932084009,0.0,839.6212030512405,-1027.9696718617113,-3288551.282636383,true,true,7.376279673,6851.982654466997,0.0,1644.2724500334996,705.0,7.376279673,6851.982654466997,0.0,121.92,0.0 -706,23624.82248212767,22924.82248212767,0.33,12545.114903487829,3770889.437916494,700.0,494200.0,40136.711828750995,15375651.44126531,27591.596925263166,11604762.003348766,true,706.0,706,0.875,10976.97554055185,12545.114903487829,1568.139362935979,0.0,0.0,706,22924.82248212767,0.0,10976.97554055185,10976.97554055185,1811993.6893597243,700.0,494200.0,227.8162801021545,983205.1932611596,9692.348955546064,54424.3713822073,0.0,0.0,874.8846675419347,773342.5778759428,181.92563736169512,1021.5468404129356,-10976.97554055185,-3299528.258176935,true,true,8.136260003,6860.1189144699965,0.0,1644.2724500334996,706.0,8.136260003,6860.1189144699965,0.0,121.92,0.0 -707,34995.11490348783,34295.11490348783,0.29250000000000004,8558.33913008814,3779447.777046582,700.0,494900.0,31652.4414703868,15407303.882735696,23094.10234029866,11627856.105689064,true,707.0,707,0.875,7488.546738827123,8558.33913008814,1069.7923912610167,0.0,0.0,707,34295.11490348783,0.0,7488.546738827123,7488.546738827123,1819482.2360985514,700.0,494900.0,285.2404667598656,983490.4337279195,6145.005102359405,60569.3764845667,0.0,0.0,942.9592670416345,774285.5371429845,115.34190266621687,1136.8887430791524,-7488.546738827123,-3307016.804915762,true,true,8.583307256,6868.702221725996,0.0,1644.2724500334996,707.0,8.583307256,6868.702221725996,0.0,121.92,0.0 -708,31008.33913008814,30308.33913008814,0.28625,8276.994130063078,3787724.771176645,700.0,495600.0,31360.678183626474,15438664.560919322,23083.684053563396,11650939.789742626,true,708.0,708,0.875,7242.369863805193,8276.994130063078,1034.6242662578852,0.0,0.0,708,30308.33913008814,0.0,7242.369863805193,7242.369863805193,1826724.6059623566,700.0,495600.0,330.95883788694795,983821.3925658064,5811.466045071076,66380.84252963778,0.0,0.0,990.863614802209,775276.4007577867,109.08136604495968,1245.970109124112,-7242.369863805193,-3314259.1747795674,true,true,8.985649783,6877.687871508996,0.0,1644.2724500334996,708.0,8.985649783,6877.687871508996,0.0,121.92,0.0 -709,30726.994130063078,30026.994130063078,0.33,12788.70753900957,3800513.4787156545,700.0,496300.0,40874.87133033203,15479539.432249654,28086.163791322462,11679025.95353395,true,709.0,709,0.875,11190.119096633374,12788.70753900957,1598.5884423761963,0.0,0.0,709,30026.994130063078,0.0,11190.119096633374,11190.119096633374,1837914.7250589898,700.0,496300.0,392.5331357196344,984213.925701526,9569.120241261311,75949.96277089909,0.0,0.0,1048.853088404147,776325.2538461909,179.6126312482815,1425.5827403723936,-11190.119096633374,-3325449.293876201,true,true,9.611515937,6887.299387445996,0.0,1644.2724500334996,709.0,9.611515937,6887.299387445996,0.0,121.92,0.0 -710,35238.70753900957,34538.70753900957,0.30500000000000005,10215.936491194336,3810729.4152068486,700.0,497000.0,35789.955708833884,15515329.387958487,25574.01921763955,11704599.97275159,true,710.0,710,0.875,8938.944429795043,10215.936491194336,1276.9920613992927,0.0,0.0,710,34538.70753900957,0.0,8938.944429795043,8938.944429795043,1846853.6694887849,700.0,497000.0,464.4664631892949,984678.3921647153,7229.417767027643,83179.38053792673,0.0,0.0,1109.3638435087248,777434.6176896996,135.69635606938056,1561.279096441774,-8938.944429795043,-3334388.238305996,true,true,10.05856319,6897.3579506359965,0.0,1644.2724500334996,710.0,10.05856319,6897.3579506359965,0.0,121.92,0.0 -711,32665.936491194334,31965.936491194334,0.1696,1864.4988261493472,3812593.914032998,700.0,497700.0,15120.865720220208,15530450.253678707,13256.366894070861,11717856.33964566,true,711.0,711,0.875,1631.4364728806788,1864.4988261493472,233.0623532686684,0.0,0.0,711,31965.936491194334,0.0,1631.4364728806788,1631.4364728806788,1848485.1059616655,700.0,497700.0,496.8598147403471,985175.2519794557,0.0,83179.38053792673,0.0,0.0,1134.5766581403318,778569.1943478399,0.0,1561.279096441774,-1631.4364728806788,-3336019.674778877,true,true,10.05856319,6907.416513825997,0.0,1644.2724500334996,711.0,10.05856319,6907.416513825997,0.0,121.92,0.0 -712,24314.49882614935,23614.49882614935,0.12,0.0,3812593.914032998,700.0,498400.0,5833.333333333334,15536283.587012041,5833.333333333334,11723689.672978994,true,712.0,712,0.875,0.0,0.0,0.0,0.0,0.0,712,23614.49882614935,0.0,-1377.999818492709,-1377.999818492709,1847107.1061431728,700.0,498400.0,483.72764490970684,985658.9796243655,-2931.2002913922315,80248.1802465345,0.0,0.0,1124.4915322989687,779693.6858801389,-55.01870430915308,1506.260392132621,-0.0,-3336019.674778877,true,true,9.879744289,6917.296258114997,0.0,1644.2724500334996,712.0,9.879744289,6917.296258114997,0.0,121.92,0.0 -713,22450.0,21750.0,0.265,6993.387053930591,3819587.3010869287,700.0,499100.0,29031.649260115435,15565315.236272156,22038.262206184845,11745727.93518518,true,713.0,713,0.875,6119.213672189267,6993.387053930591,874.1733817413242,0.0,0.0,713,21750.0,0.0,6119.213672189267,6119.213672189267,1853226.319815362,700.0,499100.0,490.2644171039799,986149.2440414694,4416.517022616339,84664.69726915084,0.0,0.0,1129.5340951914511,780823.2199753303,82.8981372774962,1589.1585294101174,-6119.213672189267,-3342138.888451066,true,true,10.14797264,6927.444230754997,0.0,1644.2724500334996,713.0,10.14797264,6927.444230754997,0.0,121.92,0.0 -714,29443.38705393059,28743.38705393059,0.28,7211.942865069134,3826799.2439519977,700.0,499800.0,28256.938803818335,15593572.175075974,21044.9959387492,11766772.93112393,true,714.0,714,0.875,6310.450006935493,7211.942865069134,901.4928581336417,0.0,0.0,714,28743.38705393059,0.0,6310.450006935493,6310.450006935493,1859536.7698222976,700.0,499800.0,530.7253432887172,986679.9693847582,4534.816568274103,89199.51383742495,0.0,0.0,1159.7894726027434,781983.0094479331,85.11862276992896,1674.2771521800464,-6310.450006935493,-3348449.338458001,true,true,10.41620099,6937.860431744997,0.0,1644.2724500334996,714.0,10.41620099,6937.860431744997,0.0,121.92,0.0 -715,29661.942865069133,28961.942865069133,0.196,3777.8515111325114,3830577.09546313,700.0,500500.0,22846.181179247505,15616418.356255222,19068.329668114995,11785841.260792045,true,715.0,715,0.875,3305.6200722409476,3777.8515111325114,472.2314388915638,0.0,0.0,715,28961.942865069133,0.0,3305.6200722409476,3305.6200722409476,1862842.3898945386,700.0,500500.0,558.8997182313515,987238.8691029896,1537.89431429198,90737.40815171693,0.0,0.0,1179.9597241726726,783162.9691721058,28.86631554494378,1703.1434677249902,-3305.6200722409476,-3351754.958530242,true,true,10.50561044,6948.366042184997,0.0,1644.2724500334996,715.0,10.50561044,6948.366042184997,0.0,121.92,0.0 -716,26227.85151113251,25527.85151113251,0.12,0.0,3830577.09546313,700.0,501200.0,5833.333333333334,15622251.689588556,5833.333333333334,11791674.594125379,true,716.0,716,0.875,0.0,0.0,0.0,0.0,0.0,716,25527.85151113251,0.0,-6009.377169181946,-6009.377169181946,1856833.0127253565,700.0,501200.0,530.7253432887172,987769.5944462783,-7558.027613790191,83179.38053792673,0.0,0.0,1159.7894726027434,784322.7586447085,-141.8643712832159,1561.2790964417743,-0.0,-3351754.958530242,true,true,10.05856319,6958.424605374998,0.0,1644.2724500334996,716.0,10.05856319,6958.424605374998,0.0,121.92,0.0 -717,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,501900.0,5833.333333333334,15628085.02292189,5833.333333333334,11797507.927458713,true,717.0,717,0.875,0.0,0.0,0.0,0.0,0.0,717,21750.0,0.0,-5064.142097820055,-5064.142097820055,1851768.8706275364,700.0,501900.0,467.6404827977933,988237.234929076,-6521.26342464699,76658.11711327973,0.0,0.0,1111.8851250113644,785434.6437697199,-122.40428098222273,1438.8748154595517,-0.0,-3351754.958530242,true,true,9.656220663,6968.080826037997,0.0,1644.2724500334996,717.0,9.656220663,6968.080826037997,0.0,121.92,0.0 -718,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,502600.0,5833.333333333334,15633918.356255224,5833.333333333334,11803341.260792047,true,718.0,718,0.875,0.0,0.0,0.0,0.0,0.0,718,21750.0,0.0,-6283.465355440145,-6283.465355440145,1845485.4052720964,700.0,502600.0,406.8577746052386,988644.0927036813,-7608.962210823534,69049.1549024562,0.0,0.0,1061.4594957481497,786496.103265468,-142.8204149699991,1296.0544004895526,-0.0,-3351754.958530242,true,true,9.164468684,6977.245294721997,0.0,1644.2724500334996,718.0,9.164468684,6977.245294721997,0.0,121.92,0.0 -719,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,503300.0,5833.333333333334,15639751.689588558,5833.333333333334,11809174.59412538,true,719.0,719,0.875,0.0,0.0,0.0,0.0,0.0,719,21750.0,0.0,-14829.337529999224,-14829.337529999224,1830656.0677420972,700.0,503300.0,311.1562438876115,988955.2489475689,-15814.351358183105,53234.80354427309,0.0,0.0,970.6933630630843,787466.7966285311,-296.8357787668156,999.218621722737,-0.0,-3351754.958530242,true,true,8.046850552,6985.292145273997,0.0,1644.2724500334996,719.0,8.046850552,6985.292145273997,0.0,121.92,0.0 -720,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,504000.0,5833.333333333334,15645585.022921892,5833.333333333334,11815007.927458715,true,720.0,720,0.875,0.0,0.0,0.0,0.0,0.0,720,21750.0,0.0,-15543.537104922045,-15543.537104922045,1815112.530637175,700.0,504000.0,195.94678914802216,989151.195736717,-16266.189975536578,36968.61356873652,0.0,0.0,832.022882617444,788298.8195111485,-305.31680115093235,693.9018205718046,-0.0,-3351754.958530242,true,true,6.705708793,6991.997854066997,0.0,1644.2724500334996,720.0,6.705708793,6991.997854066997,0.0,121.92,0.0 -721,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,504700.0,5833.333333333334,15651418.356255226,5833.333333333334,11820841.260792049,true,721.0,721,0.875,0.0,0.0,0.0,0.0,0.0,721,21750.0,0.0,-12770.437819891076,-12770.437819891076,1802342.092817284,700.0,504700.0,107.32171998391497,989258.5174567009,-13308.700879452681,23659.912689283836,0.0,0.0,680.7459948841991,788979.5655060327,-249.80465530650835,444.0971652652962,-0.0,-3351754.958530242,true,true,5.364567035,6997.362421101997,0.0,1644.2724500334996,721.0,5.364567035,6997.362421101997,0.0,121.92,0.0 -722,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,505400.0,5833.333333333334,15657251.68958856,5833.333333333334,11826674.594125383,true,722.0,722,0.875,0.0,0.0,0.0,0.0,0.0,722,21750.0,0.0,-9965.539526943972,-9965.539526943972,1792376.55329034,700.0,505400.0,50.49567895528665,989309.0131356562,-10351.211803215605,13308.70088606823,0.0,0.0,529.4691071509544,789509.0346131836,-194.29250983460938,249.80465543068684,-0.0,-3351754.958530242,true,true,4.023425276,7001.385846377997,0.0,1644.2724500334996,722.0,4.023425276,7001.385846377997,0.0,121.92,0.0 -723,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,506100.0,5833.333333333334,15663085.022921894,5833.333333333334,11832507.927458717,true,723.0,723,0.875,0.0,0.0,0.0,0.0,0.0,723,21750.0,0.0,-6721.691077958786,-6721.691077958786,1785654.862212381,700.0,506100.0,19.1481621108603,989328.1612977671,-6992.818638003123,6315.882248065108,0.0,0.0,383.234782310192,789892.2693954938,-131.2553843767157,118.54927105397113,-0.0,-3351754.958530242,true,true,2.771692968,7004.157539345997,0.0,1644.2724500334996,723.0,2.771692968,7004.157539345997,0.0,121.92,0.0 -724,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,506800.0,5833.333333333334,15668918.356255228,5833.333333333334,11838341.26079205,true,724.0,724,0.875,0.0,0.0,0.0,0.0,0.0,724,21750.0,0.0,-2768.3484601775813,-2768.3484601775813,1782886.5137522034,700.0,506800.0,6.679557070649019,989334.8408548377,-2988.7070265480925,3327.1752215170154,0.0,0.0,269.7771164961588,790162.0465119899,-56.098107196296795,62.45116385767433,-0.0,-3351754.958530242,true,true,2.011712638,7006.169251983997,0.0,1644.2724500334996,724.0,2.011712638,7006.169251983997,0.0,121.92,0.0 -725,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,507500.0,5833.333333333334,15674751.689588562,5833.333333333334,11844174.594125384,true,725.0,725,0.875,0.0,0.0,0.0,0.0,0.0,725,21750.0,0.0,-1691.7293822741349,-1691.7293822741349,1781194.7843699292,700.0,507500.0,2.300276920780265,989337.1411317585,-1848.430677885528,1478.7445436314874,0.0,0.0,189.09610970885484,790351.1426216988,-34.69509101824212,27.756072839432214,-0.0,-3351754.958530242,true,true,1.341141759,7007.510393742997,0.0,1644.2724500334996,725.0,1.341141759,7007.510393742997,0.0,121.92,0.0 -726,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,508200.0,5833.333333333334,15680585.022921896,5833.333333333334,11850007.927458718,true,726.0,726,0.875,0.0,0.0,0.0,0.0,0.0,726,21750.0,0.0,-639.0066795949109,-639.0066795949109,1780555.7776903342,700.0,508200.0,0.7232806727928487,989337.8644124313,-754.15971771518,724.5848259163074,0.0,0.0,128.58535460427723,790479.7279763031,-14.155597156800908,13.600475682631306,-0.0,-3351754.958530242,true,true,0.938799231,7008.449192973997,0.0,1644.2724500334996,726.0,0.938799231,7008.449192973997,0.0,121.92,0.0 -727,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,508900.0,5833.333333333334,15686418.35625523,5833.333333333334,11855841.260792052,true,727.0,727,0.875,0.0,0.0,0.0,0.0,0.0,727,21750.0,0.0,-630.688911157768,-630.688911157768,1779925.0887791766,700.0,508900.0,0.09583328496412666,989337.9602457163,-683.5085887770323,41.07623713927512,0.0,0.0,65.55331799705992,790545.2812943001,-12.829473662759659,0.7710020198716467,-0.0,-3351754.958530242,true,true,0.223523626,7008.672716599997,0.0,1644.2724500334996,727.0,0.223523626,7008.672716599997,0.0,121.92,0.0 -728,22450.0,21750.0,0.12,28.820876666778496,3830605.916339797,700.0,509600.0,6073.507305556488,15692491.863560786,6044.6864288897095,11861885.947220942,true,728.0,728,0.875,25.218267083431183,28.820876666778496,3.602609583347313,0.0,0.0,728,21750.0,0.0,25.218267083431183,25.218267083431183,1779950.30704626,700.0,509600.0,0.0054525082225135284,989337.9656982245,0.0,41.07623713927512,0.0,0.0,25.212814575208668,790570.4941088753,0.0,0.7710020198716467,-25.218267083431183,-3351780.1767973257,true,true,0.223523626,7008.896240225998,0.0,1644.2724500334996,728.0,0.223523626,7008.896240225998,0.0,121.92,0.0 -729,22478.820876666778,21778.820876666778,0.17200000000000001,2018.0334662941502,3832623.949806091,700.0,510300.0,15802.520152872967,15708294.383713659,13784.486686578817,11875670.43390752,true,729.0,729,0.875,1765.7792830073815,2018.0334662941502,252.2541832867687,0.0,0.0,729,21778.820876666778,0.0,1765.7792830073815,1765.7792830073815,1781716.0863292674,700.0,510300.0,0.2761859002973675,989338.2418841248,1641.4064422034514,1682.4826793427264,0.0,0.0,93.2874140749083,790663.7815229502,30.809240828724494,31.580242848596143,-1765.7792830073815,-3353545.9560803333,true,true,1.430551209,7010.326791434998,0.0,1644.2724500334996,729.0,1.430551209,7010.326791434998,0.0,121.92,0.0 -730,24468.03346629415,23768.03346629415,0.25,6408.755638685973,3839032.705444777,700.0,511000.0,28435.022554743893,15736729.406268403,22026.26691605792,11897696.700823577,true,730.0,730,0.875,5607.661183850227,6408.755638685973,801.0944548357465,0.0,0.0,730,23768.03346629415,0.0,5607.661183850227,5607.661183850227,1787323.7475131175,700.0,511000.0,4.976357066573887,989343.2182411914,5259.4014258718835,6941.88410521461,0.0,0.0,244.5643018645516,790908.3458248148,98.71909904721781,130.29934189581394,-5607.661183850227,-3359153.6172641837,true,true,2.905807144,7013.2325985789985,0.0,1644.2724500334996,730.0,2.905807144,7013.2325985789985,0.0,121.92,0.0 -731,28858.755638685972,28158.755638685972,0.30500000000000005,10037.78745646204,3849070.492901239,700.0,511700.0,35205.860512990286,15771935.266781393,25168.073056528247,11922864.773880105,true,731.0,731,0.875,8783.064024404284,10037.78745646204,1254.7234320577554,0.0,0.0,731,28158.755638685972,0.0,8783.064024404284,8783.064024404284,1796106.811537522,700.0,511700.0,22.75484910773055,989365.973090299,8200.46001592702,15142.344121141628,0.0,0.0,405.926315495558,791314.2721403103,153.9228438739768,284.2221857697907,-8783.064024404284,-3367936.681288588,true,true,4.291653628,7017.524252206998,0.0,1644.2724500334996,731.0,4.291653628,7017.524252206998,0.0,121.92,0.0 -732,32487.78745646204,31787.78745646204,0.33,12964.588674280076,3862035.081575519,700.0,512400.0,41407.84446751538,15813343.111248909,28443.255793235305,11951308.029673342,true,732.0,732,0.875,11344.015089995066,12964.588674280076,1620.57358428501,0.0,0.0,732,31787.78745646204,0.0,11344.015089995066,11344.015089995066,1807450.826627517,700.0,512400.0,58.853616209013765,989424.826706508,10530.30419201232,25672.64831315395,0.0,0.0,557.2032032288027,791871.475343539,197.6540785449298,481.8762643147205,-11344.015089995066,-3379280.696378583,true,true,5.588090661,7023.112342867998,0.0,1644.2724500334996,732.0,5.588090661,7023.112342867998,0.0,121.92,0.0 -733,35414.58867428008,34714.58867428008,0.29250000000000004,8483.79403563534,3870518.8756111544,700.0,513100.0,31397.58644661654,15844740.697695525,22913.7924109812,11974221.822084323,true,733.0,733,0.875,7423.319781180922,8483.79403563534,1060.474254454417,0.0,0.0,733,34714.58867428008,0.0,7423.319781180922,7423.319781180922,1814874.1464086978,700.0,513100.0,101.46913394708368,989526.2958404551,6531.1217378642295,32203.77005101818,0.0,0.0,668.1395875965949,792539.6149311357,122.58932177301392,604.4655860877344,-7423.319781180922,-3386704.016159764,true,true,6.258661541,7029.3710044089985,0.0,1644.2724500334996,733.0,6.258661541,7029.3710044089985,0.0,121.92,0.0 -734,30933.79403563534,30233.79403563534,0.33,12510.788104384317,3883029.6637155386,700.0,513800.0,40032.69122540702,15884773.388920933,27521.903121022704,12001743.725205345,true,734.0,734,0.875,10946.939591336277,12510.788104384317,1563.8485130480403,0.0,0.0,734,30233.79403563534,0.0,10946.939591336277,10946.939591336277,1825821.0860000341,700.0,513800.0,147.21772289700587,989673.513563352,9858.296944312408,42062.066995330584,0.0,0.0,756.3844387790208,793295.9993699146,185.04048534784127,789.5060714355757,-10946.939591336277,-3397650.9557511,true,true,7.152756046,7036.523760454998,0.0,1644.2724500334996,734.0,7.152756046,7036.523760454998,0.0,121.92,0.0 -735,34960.788104384315,34260.788104384315,0.335,14233.131635343245,3897262.7953508818,700.0,514500.0,44576.51234430819,15929349.901265241,30343.380708964945,12032087.10591431,true,735.0,735,0.875,12453.990180925339,14233.131635343245,1779.141454417906,0.0,0.0,735,34260.788104384315,0.0,12453.990180925339,12453.990180925339,1838275.0761809594,700.0,514500.0,214.30538444661804,989887.8189477987,11172.736548942508,53234.80354427309,0.0,0.0,857.2356972490511,794153.2350671637,209.71255028716118,999.2186217227369,-12453.990180925339,-3410104.9459320256,true,true,8.046850552,7044.570611006999,0.0,1644.2724500334996,735.0,8.046850552,7044.570611006999,0.0,121.92,0.0 -736,36683.13163534325,35983.13163534325,0.33,12923.385758023465,3910186.181108905,700.0,515200.0,41282.98714552565,15970632.888410768,28359.601387502185,12060446.707301812,true,736.0,736,0.875,11307.962538270533,12923.385758023465,1615.4232197529327,0.0,0.0,736,35983.13163534325,0.0,11307.962538270533,11307.962538270533,1849583.0387192299,700.0,515200.0,289.8410314757067,990177.6599792744,9884.58574995966,63119.38929423275,0.0,0.0,948.0018299341167,795101.2368970978,185.53392690104894,1184.7525486237857,-11307.962538270533,-3421412.9084702963,true,true,8.762126157,7053.332737163999,0.0,1644.2724500334996,736.0,8.762126157,7053.332737163999,0.0,121.92,0.0 -737,35373.38575802346,34673.38575802346,0.345,16555.656094793278,3926741.837203698,700.0,515900.0,50016.39447766168,16020649.28288843,33460.738382868396,12093907.44568468,true,737.0,737,0.875,14486.199082944117,16555.656094793278,2069.457011849161,0.0,0.0,737,34673.38575802346,0.0,14486.199082944117,14486.199082944117,1864069.237802174,700.0,515900.0,378.5487334126411,990556.208712687,12830.573476666324,75949.96277089907,0.0,0.0,1036.2466811165427,796137.4835782143,240.83019174860794,1425.5827403723938,-14486.199082944117,-3435899.1075532404,true,true,9.611515937,7062.944253100999,0.0,1644.2724500334996,737.0,9.611515937,7062.944253100999,0.0,121.92,0.0 -738,39005.656094793274,38305.656094793274,0.33999999999999997,15489.251590694874,3942231.088794393,700.0,516600.0,47615.44585498493,16068264.728743413,32126.194264290054,12126033.639948972,true,738.0,738,0.875,13553.095141858015,15489.251590694874,1936.1564488368585,0.0,0.0,738,38305.656094793274,0.0,13553.095141858015,13553.095141858015,1877622.332944032,700.0,516600.0,483.7276447641398,991039.9363574511,11724.801148000844,87674.76391889992,0.0,0.0,1124.4915321861718,797261.9751104005,220.07481690685907,1645.6575572792528,-13553.095141858015,-3449452.2026950982,true,true,10.32679154,7073.271044640999,0.0,1644.2724500334996,738.0,10.32679154,7073.271044640999,0.0,121.92,0.0 -739,37939.251590694876,37239.251590694876,0.335,14791.98191262441,3957023.0707070176,700.0,517300.0,46244.72212723704,16114509.45087065,31452.740214612626,12157486.380163584,true,739.0,739,0.875,12942.984173546358,14791.98191262441,1848.9977390780514,0.0,0.0,739,37239.251590694876,0.0,12942.984173546358,12942.984173546358,1890565.3171175784,700.0,517300.0,588.0539751536522,991627.9903326047,10949.281920873087,98624.045839773,0.0,0.0,1200.1299763065874,798462.105086707,205.51830121303135,1851.175858492284,-12942.984173546358,-3462395.186868645,true,true,10.9526577,7084.223702340999,0.0,1644.2724500334996,739.0,10.9526577,7084.223702340999,0.0,121.92,0.0 -740,37241.98191262441,36541.98191262441,0.3175,11784.745230956176,3968807.8159379736,700.0,518000.0,39322.03222348402,16153831.483094133,27537.286992527843,12185023.667156111,true,740.0,740,0.875,10311.652077086654,11784.745230956176,1473.0931538695222,0.0,0.0,740,36541.98191262441,0.0,10311.652077086654,10311.652077086654,1900876.969194665,700.0,518000.0,681.5635323879594,992309.5538649927,8215.247409489633,106839.29324926263,0.0,0.0,1260.6407315803606,799722.7458182874,154.20040362869986,2005.376262120984,-10311.652077086654,-3472706.8389457315,true,true,11.39970495,7095.623407290999,0.0,1644.2724500334996,740.0,11.39970495,7095.623407290999,0.0,121.92,0.0 -741,34234.74523095618,33534.74523095618,0.3175,12322.238130976048,3981130.0540689495,700.0,518700.0,41014.923247168656,16194846.406341301,28692.68511619261,12213716.352272304,true,741.0,741,0.875,10781.958364604041,12322.238130976048,1540.2797663720066,0.0,0.0,741,33534.74523095618,0.0,10781.958364604041,10781.958364604041,1911658.9275592691,700.0,518700.0,766.6662807024107,993076.2201456951,8543.85730366399,115383.15055292661,0.0,0.0,1311.0663605051836,801033.8121787925,160.3684197324562,2165.74468185344,-10781.958364604041,-3483488.7973103356,true,true,11.8467522,7107.470159490999,0.0,1644.2724500334996,741.0,11.8467522,7107.470159490999,0.0,121.92,0.0 -742,34772.238130976046,34072.238130976046,0.29250000000000004,8656.30973388106,3989786.3638028307,700.0,519400.0,31987.38370557627,16226833.790046878,23331.07397169521,12237047.426243998,true,742.0,742,0.875,7574.2710171459275,8656.30973388106,1082.0387167351328,0.0,0.0,742,34072.238130976046,0.0,7574.2710171459275,7574.2710171459275,1919233.198576415,700.0,519400.0,839.6353225294749,993915.8554682246,5284.047131402133,120667.19768432874,0.0,0.0,1351.4068636450422,802385.2190424376,99.18169956927721,2264.926381422717,-7574.2710171459275,-3491063.0683274814,true,true,12.11498055,7119.585140040999,0.0,1644.2724500334996,742.0,12.11498055,7119.585140040999,0.0,121.92,0.0 -743,31106.309733881062,30406.309733881062,0.28625,7828.144507110386,3997614.5083099413,700.0,520100.0,29792.644566324492,16256626.434613202,21964.500059214108,12259011.926303212,true,743.0,743,0.875,6849.626443721588,7828.144507110386,978.5180633887985,0.0,0.0,743,30406.309733881062,0.0,6849.626443721588,6849.626443721588,1926082.8250201365,700.0,520100.0,892.3974294066116,994808.2528976313,4493.740431839006,125160.93811616774,0.0,0.0,1379.1409598356877,803764.3600022733,84.3476226402821,2349.274004062999,-6849.626443721588,-3497912.694771203,true,true,12.33850418,7131.923644220999,0.0,1644.2724500334996,743.0,12.33850418,7131.923644220999,0.0,121.92,0.0 -744,30278.144507110388,29578.144507110388,0.25,5849.674117335693,4003464.182427277,700.0,520800.0,26198.696469342773,16282825.131082544,20349.02235200708,12279360.948655218,true,744.0,744,0.875,5118.4648526687315,5849.674117335693,731.2092646669616,0.0,0.0,744,29578.144507110388,0.0,5118.4648526687315,5118.4648526687315,1931201.2898728054,700.0,520800.0,932.1274151942171,995740.3803128254,2735.677489185292,127896.61560535304,0.0,0.0,1399.3112119696025,805163.6712142429,51.34873631961953,2400.6227403826188,-5118.4648526687315,-3503031.159623872,true,true,12.47261836,7144.396262580999,0.0,1644.2724500334996,744.0,12.47261836,7144.396262580999,0.0,121.92,0.0 -745,28299.674117335693,27599.674117335693,0.265,7025.951695967306,4010490.1341232443,700.0,521500.0,29154.534701763416,16311979.665784307,22128.58300579611,12301489.531661013,true,745.0,745,0.875,6147.707733971392,7025.951695967306,878.2439619959132,0.0,0.0,745,27599.674117335693,0.0,6147.707733971392,6147.707733971392,1937348.9976067767,700.0,521500.0,967.8438146084426,996708.2241274338,3693.575235512339,131590.19084086537,0.0,0.0,1416.9601823752832,806580.6313966182,69.32850147532703,2469.9512418579457,-6147.707733971392,-3509178.8673578436,true,true,12.65143726,7157.0476998409995,0.0,1644.2724500334996,745.0,12.65143726,7157.0476998409995,0.0,121.92,0.0 -746,29475.951695967306,28775.951695967306,0.25,6053.028169529944,4016543.1622927743,700.0,522200.0,27012.112678119775,16338991.778462427,20959.084508589833,12322448.616169604,true,746.0,746,0.875,5296.399648338701,6053.028169529944,756.6285211912427,0.0,0.0,746,28775.951695967306,0.0,5296.399648338701,5296.399648338701,1942645.3972551154,700.0,522200.0,1004.461119889405,997712.6852473232,2804.685360407932,134394.8762012733,0.0,0.0,1434.6091522169786,808015.2405488351,52.64401582438491,2522.5952576823306,-5296.399648338701,-3514475.267006182,true,true,12.78555143,7169.833251270999,0.0,1644.2724500334996,746.0,12.78555143,7169.833251270999,0.0,121.92,0.0 -747,28503.02816952994,27803.02816952994,0.1864,2814.4066460457516,4019357.56893882,700.0,522900.0,18854.112907970768,16357845.891370397,16039.706261925017,12338488.322431529,true,747.0,747,0.875,2462.6058152900328,2814.4066460457516,351.80083075571883,0.0,0.0,747,27803.02816952994,0.0,2462.6058152900328,2462.6058152900328,1945108.0030704055,700.0,522900.0,1020.4328190163234,998733.1180663395,0.0,134394.8762012733,0.0,0.0,1442.1729962737095,809457.4135451089,0.0,2522.5952576823306,-2462.6058152900328,-3516937.872821472,true,true,12.78555143,7182.618802700999,0.0,1644.2724500334996,747.0,12.78555143,7182.618802700999,0.0,121.92,0.0 -748,25264.40664604575,24564.40664604575,0.12,0.0,4019357.56893882,700.0,523600.0,5833.333333333334,16363679.224703731,5833.333333333334,12344321.655764863,true,748.0,748,0.875,0.0,0.0,0.0,0.0,0.0,748,24564.40664604575,0.0,-418.2591041259333,-418.2591041259333,1944689.7439662796,700.0,523600.0,1004.461119889405,999737.5791862289,-2804.685360407932,131590.19084086537,0.0,0.0,1434.6091522169786,810892.0226973258,-52.64401582438491,2469.9512418579457,-0.0,-3516937.872821472,true,true,12.65143726,7195.270239961,0.0,1644.2724500334996,748.0,12.65143726,7195.270239961,0.0,121.92,0.0 -749,22450.0,21750.0,0.16720000000000002,1671.0883355512772,4021028.6572743715,700.0,524300.0,14181.150332244479,16377860.375035975,12510.0619966932,12356831.717761556,true,749.0,749,0.875,1462.2022936073674,1671.0883355512772,208.88604194390973,0.0,0.0,749,21750.0,0.0,1462.2022936073674,1462.2022936073674,1946151.946259887,700.0,524300.0,983.4259756663673,1000721.0051618953,-928.3230609352154,130661.86777993015,0.0,0.0,1424.5240264320141,812316.5467237578,-17.424647555798682,2452.526594302147,-1462.2022936073674,-3518400.0751150795,true,true,12.60673253,7207.876972491,0.0,1644.2724500334996,749.0,12.60673253,7207.876972491,0.0,121.92,0.0 -750,24121.088335551278,23421.088335551278,0.136,575.2595743075456,4021603.916848679,700.0,525000.0,9376.908634614305,16387237.28367059,8801.64906030676,12365633.366821863,true,750.0,750,0.875,503.3521275191024,575.2595743075456,71.90744678844317,0.0,0.0,750,23421.088335551278,0.0,503.3521275191024,503.3521275191024,1946655.2983874062,700.0,525000.0,967.8438134527646,1001688.848975348,-1846.787617021094,128815.08016290906,0.0,0.0,1416.9601818112978,813733.506905569,-34.664250723865926,2417.862343578281,-503.3521275191024,-3518903.4272425985,true,true,12.51732308,7220.394295571,0.0,1644.2724500334996,750.0,12.51732308,7220.394295571,0.0,121.92,0.0 -751,23025.259574307547,22325.259574307547,0.12,0.0,4021603.916848679,700.0,525700.0,5833.333333333334,16393070.617003923,5833.333333333334,12371466.700155197,true,751.0,751,0.875,0.0,0.0,0.0,0.0,0.0,751,22325.259574307547,0.0,-2313.6050125599213,-2313.6050125599213,1944341.6933748461,700.0,525700.0,932.127414067149,1002620.9763894152,-4559.462412144059,124255.617750765,0.0,0.0,1399.311211405617,815132.8181169747,-85.58122588862797,2332.281117689653,-0.0,-3518903.4272425985,true,true,12.29379945,7232.688095021,0.0,1644.2724500334996,751.0,12.29379945,7232.688095021,0.0,121.92,0.0 -752,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,526400.0,5833.333333333334,16398903.950337257,5833.333333333334,12377300.03348853,true,752.0,752,0.875,0.0,0.0,0.0,0.0,0.0,752,21750.0,0.0,-4120.435322630293,-4120.435322630293,1940221.258052216,700.0,526400.0,872.9629671225366,1003493.9393565378,-6245.230978876139,118010.38677188887,0.0,0.0,1369.0558340507232,816501.8739510254,-117.2231449274143,2215.057972762239,-0.0,-3518903.4272425985,true,true,11.98086638,7244.668961401,0.0,1644.2724500334996,752.0,11.98086638,7244.668961401,0.0,121.92,0.0 -753,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,527100.0,5833.333333333334,16404737.283670591,5833.333333333334,12383133.366821865,true,753.0,753,0.875,0.0,0.0,0.0,0.0,0.0,753,21750.0,0.0,-9282.132822502685,-9282.132822502685,1930939.1252297133,700.0,527100.0,780.0122056389245,1004273.9515621767,-11171.093522626254,106839.29324926261,0.0,0.0,1318.6302051259001,817820.5041561513,-209.68171064125522,2005.3762621209837,-0.0,-3518903.4272425985,true,true,11.39970495,7256.0686663510005,0.0,1644.2724500334996,753.0,11.39970495,7256.0686663510005,0.0,121.92,0.0 -754,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,527800.0,5833.333333333334,16410570.617003925,5833.333333333334,12388966.700155199,true,754.0,754,0.875,0.0,0.0,0.0,0.0,0.0,754,21750.0,0.0,-14527.207831827445,-14527.207831827445,1916411.9173978858,700.0,527800.0,641.4821435603176,1004915.433705737,-16101.885097545732,90737.40815171688,0.0,0.0,1235.4279165539635,819055.9320727052,-302.23279439599384,1703.14346772499,-0.0,-3518903.4272425985,true,true,10.50561044,7266.574276791001,0.0,1644.2724500334996,754.0,10.50561044,7266.574276791001,0.0,121.92,0.0 -755,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,528500.0,5833.333333333334,16416403.95033726,5833.333333333334,12394800.033488533,true,755.0,755,0.875,0.0,0.0,0.0,0.0,0.0,755,21750.0,0.0,-13433.569635681231,-13433.569635681231,1902978.3477622045,700.0,528500.0,496.85981451806185,1005412.293520255,-14787.445380817833,75949.96277089904,0.0,0.0,1134.5766579711362,820190.5087306764,-277.5607273525964,1425.5827403723936,-0.0,-3518903.4272425985,true,true,9.611515937,7276.185792728001,0.0,1644.2724500334996,755.0,9.611515937,7276.185792728001,0.0,121.92,0.0 -756,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,529200.0,5833.333333333334,16422237.283670593,5833.333333333334,12400633.366821866,true,756.0,756,0.875,0.0,0.0,0.0,0.0,0.0,756,21750.0,0.0,-15564.802126231822,-15564.802126231822,1887413.5456359726,700.0,529200.0,362.21080494571305,1005774.5043252007,-16635.876104277566,59314.08666662148,0.0,0.0,1021.1189923262987,821211.6277230027,-312.2558192262667,1113.326921146127,-0.0,-3518903.4272425985,true,true,8.493897805,7284.679690533001,0.0,1644.2724500334996,756.0,8.493897805,7284.679690533001,0.0,121.92,0.0 -757,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,529900.0,5833.333333333334,16428070.617003927,5833.333333333334,12406466.7001552,true,757.0,757,0.875,0.0,0.0,0.0,0.0,0.0,757,21750.0,0.0,-13716.775953551403,-13716.775953551403,1873696.7696824213,700.0,529900.0,243.9390852791123,1006018.4434104798,-14582.064239960291,44732.02242666119,0.0,0.0,895.054919224661,822106.6826422274,-273.7057180948865,839.6212030512405,-0.0,-3518903.4272425985,true,true,7.376279673,7292.055970206001,0.0,1644.2724500334996,757.0,7.376279673,7292.055970206001,0.0,121.92,0.0 -758,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,530600.0,5833.333333333334,16433903.950337261,5833.333333333334,12412300.033488534,true,758.0,758,0.875,0.0,0.0,0.0,0.0,0.0,758,21750.0,0.0,-7449.133851998764,-7449.133851998764,1866247.6358304226,700.0,530600.0,168.80498823933542,1006187.2483987191,-8254.68065287621,36477.34177378498,0.0,0.0,791.6823792519912,822898.3650214794,-154.94056661387998,684.6806364373606,-0.0,-3518903.4272425985,true,true,6.661004068,7298.716974274001,0.0,1644.2724500334996,758.0,6.661004068,7298.716974274001,0.0,121.92,0.0 -759,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,531300.0,5833.333333333334,16439737.283670595,5833.333333333334,12418133.366821868,true,759.0,759,0.875,0.0,0.0,0.0,0.0,0.0,759,21750.0,0.0,-10204.504124359479,-10204.504124359479,1856043.1317060632,700.0,531300.0,112.16258766866275,1006299.4109863878,-10804.693460631064,25672.648313153917,0.0,0.0,690.8311207255623,823589.196142205,-202.80437212264007,481.8762643147205,-0.0,-3518903.4272425985,true,true,5.588090661,7304.305064935001,0.0,1644.2724500334996,759.0,5.588090661,7304.305064935001,0.0,121.92,0.0 -760,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,532000.0,5833.333333333334,16445570.617003929,5833.333333333334,12423966.700155202,true,760.0,760,0.875,0.0,0.0,0.0,0.0,0.0,760,21750.0,0.0,-10754.605474139486,-10754.605474139486,1845288.5262319236,700.0,532000.0,57.270196899274524,1006356.6811832871,-11154.663001969657,14517.98531118426,0.0,0.0,552.1606402799218,824141.3567824849,-209.3733093490253,272.5029549656952,-0.0,-3518903.4272425985,true,true,4.202244177,7308.507309112,0.0,1644.2724500334996,760.0,4.202244177,7308.507309112,0.0,121.92,0.0 -761,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,532700.0,5833.333333333334,16451403.950337263,5833.333333333334,12429800.033488536,true,761.0,761,0.875,0.0,0.0,0.0,0.0,0.0,761,21750.0,0.0,-7942.036849300388,-7942.036849300388,1837346.4893826232,700.0,532700.0,20.699989578965095,1006377.381172866,-8202.103063119184,6315.882248065076,0.0,0.0,393.3199081515551,824534.6766906364,-153.95368391172414,118.54927105397107,-0.0,-3518903.4272425985,true,true,2.771692968,7311.27900208,0.0,1644.2724500334996,761.0,2.771692968,7311.27900208,0.0,121.92,0.0 -762,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,533400.0,5833.333333333334,16457237.283670597,5833.333333333334,12435633.36682187,true,762.0,762,0.875,0.0,0.0,0.0,0.0,0.0,762,21750.0,0.0,-4691.727205321806,-4691.727205321806,1832654.7621773013,700.0,533400.0,4.245802749406729,1006381.6269756154,-4837.1377044336205,1478.7445436314556,0.0,0.0,231.95789457694724,824766.6345852134,-90.7931982145389,27.756072839432164,-0.0,-3518903.4272425985,true,true,1.341141759,7312.620143839,0.0,1644.2724500334996,762.0,1.341141759,7312.620143839,0.0,121.92,0.0 -763,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,534100.0,5833.333333333334,16463070.61700393,5833.333333333334,12441466.700155204,true,763.0,763,0.875,0.0,0.0,0.0,0.0,0.0,763,21750.0,0.0,-1015.9209372861045,-1015.9209372861045,1831638.8412400153,700.0,534100.0,0.49685981474034724,1006382.1238354301,-1109.0584082749585,369.68613535649706,0.0,0.0,113.45766581403319,824880.0922510275,-20.81705463991947,6.939018199512695,-0.0,-3518903.4272425985,true,true,0.670570879,7313.290714717999,0.0,1644.2724500334996,763.0,0.670570879,7313.290714717999,0.0,121.92,0.0 -764,22450.0,21750.0,0.124,86.61218464124524,4021690.5290333205,700.0,534800.0,6343.646650332623,16469414.263654264,6257.034465691378,12447723.734620895,true,764.0,764,0.875,75.78566156108958,86.61218464124524,10.826523080155653,0.0,0.0,764,21750.0,0.0,75.78566156108958,75.78566156108958,1831714.6269015765,700.0,534800.0,0.14721772266648792,1006382.2710531527,0.0,369.68613535649706,0.0,0.0,75.6384438384231,824955.7306948659,0.0,6.939018199512695,-75.78566156108958,-3518979.2129041594,true,true,0.670570879,7313.961285596999,0.0,1644.2724500334996,764.0,0.670570879,7313.961285596999,0.0,121.92,0.0 -765,22536.612184641246,21836.612184641246,0.12,0.0,4021690.5290333205,700.0,535500.0,5833.333333333334,16475247.596987598,5833.333333333334,12453557.06795423,true,765.0,765,0.875,0.0,0.0,0.0,0.0,0.0,765,21836.612184641246,0.0,-284.3086651241525,-284.3086651241525,1831430.3182364523,700.0,535500.0,0.043620065926468804,1006382.3146732186,-328.6098982172538,41.07623713924329,0.0,0.0,50.42562920681588,825006.1563240727,-6.168016179641098,0.771002019871597,-0.0,-3518979.2129041594,true,true,0.223523626,7314.184809222999,0.0,1644.2724500334996,765.0,0.223523626,7314.184809222999,0.0,121.92,0.0 -766,22450.0,21750.0,0.12,0.0,4021690.5290333205,700.0,536200.0,5833.333333333334,16481080.930320932,5833.333333333334,12459390.401287563,true,766.0,766,0.875,0.0,0.0,0.0,0.0,0.0,766,21750.0,0.0,-29.240150308067577,-29.240150308067577,1831401.0780861443,700.0,536200.0,0.0006815635278141911,1006382.3153547822,-41.07623713933157,-8.827782949083485e-11,0.0,0.0,12.606407287604334,825018.7627313604,-0.7710020198681556,3.4413583094305977e-12,-0.0,-3518979.2129041594,true,true,0.0,7314.184809222999,0.0,1644.2724500334996,766.0,0.0,7314.184809222999,0.0,121.92,0.0 -767,22450.0,21750.0,0.1696,1808.327174958617,4023498.8562082793,700.0,536900.0,14789.664946689958,16495870.595267622,12981.337771731341,12472371.739059294,true,767.0,767,0.875,1582.28627808879,1808.327174958617,226.04089686982707,0.0,0.0,767,21750.0,0.0,1582.28627808879,1582.28627808879,1832983.364364233,700.0,536900.0,0.14721772299579924,1006382.4625725051,1478.7445436315438,1478.7445436314556,0.0,0.0,75.63844389482165,825094.4011752552,27.75607283942872,27.756072839432164,-1582.28627808879,-3520561.499182248,true,true,1.341141759,7315.525950981999,0.0,1644.2724500334996,767.0,1.341141759,7315.525950981999,0.0,121.92,0.0 -768,24258.327174958617,23558.327174958617,0.25,6144.036613858355,4029642.8928221376,700.0,537600.0,27376.14645543342,16523246.741723055,21232.109841575064,12493603.84890087,true,768.0,768,0.875,5376.0320371260605,6144.036613858355,768.0045767322945,0.0,0.0,768,23558.327174958617,0.0,5376.0320371260605,5376.0320371260605,1838359.3964013592,700.0,537600.0,4.385763182919641,1006386.848335688,5042.518889615731,6521.263433247186,0.0,0.0,234.4791760231884,825328.8803512783,94.6482083042216,122.40428114365376,-5376.0320371260605,-3525937.531219374,true,true,2.816397693,7318.342348674999,0.0,1644.2724500334996,768.0,2.816397693,7318.342348674999,0.0,121.92,0.0 -769,28594.036613858356,27894.036613858356,0.30500000000000005,10520.799631997652,4040163.692454135,700.0,538300.0,36789.50699015623,16560036.248713212,26268.70735815858,12519872.556259029,true,769.0,769,0.875,9205.699677997945,10520.799631997652,1315.0999539997065,0.0,0.0,769,27894.036613858356,0.0,9205.699677997945,9205.699677997945,1847565.0960793572,700.0,538300.0,21.917332930719994,1006408.7656686187,8621.080687894411,15142.344121141597,0.0,0.0,400.88375254667716,825729.764103825,161.81790462613696,284.2221857697907,-9205.699677997945,-3535143.2308973717,true,true,4.291653628,7322.634002302999,0.0,1644.2724500334996,769.0,4.291653628,7322.634002302999,0.0,121.92,0.0 -770,32970.79963199765,32270.799631997652,0.335,14923.458149859336,4055087.1506039943,700.0,539000.0,46637.18850704279,16606673.437220255,31713.730357183453,12551586.286616212,true,770.0,770,0.875,13058.02588112692,14923.458149859336,1865.4322687324166,0.0,0.0,770,32270.799631997652,0.0,13058.02588112692,13058.02588112692,1860623.1219604842,700.0,539000.0,62.10747684254341,1006470.8731454613,12199.642474485532,27341.98659562713,0.0,0.0,567.288329070166,826297.0524328952,228.9876007286765,513.2097864984672,-13058.02588112692,-3548201.2567784986,true,true,5.766909562,7328.400911864999,0.0,1644.2724500334996,770.0,5.766909562,7328.400911864999,0.0,121.92,0.0 -771,37373.45814985933,36673.45814985933,0.345,16896.3285360883,4071983.4791400824,700.0,539700.0,51003.85082924145,16657677.288049497,34107.522293153146,12585693.808909364,true,771.0,771,0.875,14784.28746907726,16896.3285360883,2112.0410670110377,0.0,0.0,771,36673.45814985933,0.0,14784.28746907726,14784.28746907726,1875407.4094295613,700.0,539700.0,128.89676625847906,1006599.7699117198,13675.100929466262,41017.08752509339,0.0,0.0,723.6077797522915,827020.6602126475,256.6819936002287,769.8917800986959,-14784.28746907726,-3562985.544247576,true,true,7.063346596,7335.464258460999,0.0,1644.2724500334996,771.0,7.063346596,7335.464258460999,0.0,121.92,0.0 -772,39346.3285360883,38646.3285360883,0.3175,12019.217283633569,4084002.696423716,700.0,540400.0,40060.52687758604,16697737.814927083,28041.309593952472,12613735.118503317,true,772.0,772,0.875,10516.815123179373,12019.217283633569,1502.4021604541958,0.0,0.0,772,38646.3285360883,0.0,10516.815123179373,10516.815123179373,1885924.2245527408,700.0,540400.0,201.33952160080193,1006801.1094333206,9301.303176406584,50318.39070149997,0.0,0.0,839.5867270689644,827860.2469397165,174.58569810302387,944.4774782017198,-10516.815123179373,-3573502.3593707555,true,true,7.823326926,7343.287585386999,0.0,1644.2724500334996,772.0,7.823326926,7343.287585386999,0.0,121.92,0.0 -773,34469.21728363357,33769.21728363357,0.28,7503.720480854858,4091506.416904571,700.0,541100.0,29299.001717338775,16727036.81664442,21795.28123648392,12635530.399739802,true,773.0,773,0.875,6565.755420748001,7503.720480854858,937.965060106857,0.0,0.0,773,33769.21728363357,0.0,6565.755420748001,6565.755420748001,1892489.9799734887,700.0,541100.0,252.27817320752953,1007053.3876065281,5308.692901177233,55627.0836026772,0.0,0.0,905.1400450660244,828765.3869847825,99.64430129721461,1044.1217794989343,-6565.755420748001,-3580068.1147915036,true,true,8.225669453,7351.513254839999,0.0,1644.2724500334996,773.0,8.225669453,7351.513254839999,0.0,121.92,0.0 -774,29953.720480854856,29253.720480854856,0.29250000000000004,9406.680592301276,4100913.0974968723,700.0,541800.0,34552.75416171376,16761589.570806134,25146.073569412485,12660676.473309215,true,774.0,774,0.875,8230.845518263617,9406.680592301276,1175.835074037659,0.0,0.0,774,29253.720480854856,0.0,8230.845518263617,8230.845518263617,1900720.8254917522,700.0,541800.0,296.8342167755756,1007350.2218233037,6849.873329920884,62476.956932598085,0.0,0.0,955.5656742728402,829720.9526590554,128.57229729431728,1172.6940767932515,-8230.845518263617,-3588298.960309767,true,true,8.717421431,7360.230676270999,0.0,1644.2724500334996,774.0,8.717421431,7360.230676270999,0.0,121.92,0.0 -775,31856.680592301276,31156.680592301276,0.30500000000000005,10791.56526636421,4111704.6627632366,700.0,542500.0,37677.26316840724,16799266.83397454,26885.69790204303,12687562.171211258,true,775.0,775,0.875,9442.619608068684,10791.56526636421,1348.9456582955263,0.0,0.0,775,31156.680592301276,0.0,9442.619608068684,9442.619608068684,1910163.4450998208,700.0,542500.0,354.2211518990812,1007704.4429752028,7926.07075774624,70403.02769034433,0.0,0.0,1013.5551479311766,830734.5078069866,148.7725504921874,1321.4666272854388,-9442.619608068684,-3597741.579917836,true,true,9.253878135,7369.484554405999,0.0,1644.2724500334996,775.0,9.253878135,7369.484554405999,0.0,121.92,0.0 -776,33241.56526636421,32541.56526636421,0.3175,12334.686194185027,4124039.3489574217,700.0,543200.0,41054.129745464656,16840320.963720005,28719.443551279626,12716281.614762537,true,776.0,776,0.875,10792.8504199119,12334.686194185027,1541.8357742731278,0.0,0.0,776,32541.56526636421,0.0,10792.8504199119,10792.8504199119,1920956.2955197326,700.0,543200.0,424.50221129221734,1008128.9451864951,9120.567734831191,79523.59542517552,0.0,0.0,1076.587184538394,831811.0949915249,171.19328925009722,1492.659916535536,-10792.8504199119,-3608534.430337748,true,true,9.835039564,7379.319593969999,0.0,1644.2724500334996,776.0,9.835039564,7379.319593969999,0.0,121.92,0.0 -777,34784.68619418503,34084.68619418503,0.3175,12254.069039367985,4136293.41799679,700.0,543900.0,40800.2174468283,16881121.181166835,28546.148407460314,12744827.763169998,true,777.0,777,0.875,10722.310409446987,12254.069039367985,1531.758629920998,0.0,0.0,777,34084.68619418503,0.0,10722.310409446987,10722.310409446987,1931678.6059291796,700.0,543900.0,503.5140996906904,1008632.4592861858,8911.900488783815,88435.49591395933,0.0,0.0,1139.6192212584083,832950.7142127834,167.2765997140738,1659.93651624961,-10722.310409446987,-3619256.740747195,true,true,10.37149627,7389.691090239999,0.0,1644.2724500334996,777.0,10.37149627,7389.691090239999,0.0,121.92,0.0 -778,34704.06903936798,34004.06903936798,0.35,18683.995768790217,4154977.41376558,700.0,544600.0,55382.84505368634,16936504.026220523,36698.84928489612,12781526.612454895,true,778.0,778,0.875,16348.49629769144,18683.995768790217,2335.4994710987776,0.0,0.0,778,34004.06903936798,0.0,16348.49629769144,16348.49629769144,1948027.102226871,700.0,544600.0,610.5727904847815,1009243.0320766706,14255.097301903224,102690.59321586255,0.0,0.0,1215.2576649840344,834165.9718777675,267.56854031939986,1927.5050565690099,-16348.49629769144,-3635605.2370448867,true,true,11.17618132,7400.867271559999,0.0,1644.2724500334996,778.0,11.17618132,7400.867271559999,0.0,121.92,0.0 -779,41133.99576879022,40433.99576879022,0.345,17113.165472541958,4172090.579238122,700.0,545300.0,51632.36368852742,16988136.38990905,34519.19821598546,12816045.81067088,true,779.0,779,0.875,14974.019788474212,17113.165472541958,2139.1456840677456,0.0,0.0,779,40433.99576879022,0.0,14974.019788474212,14974.019788474212,1963001.1220153454,700.0,545300.0,744.7628731337585,1009987.7949498043,12692.557337064038,115383.15055292659,0.0,0.0,1298.4599529919851,835464.4318307595,238.23962528443033,2165.7446818534404,-14974.019788474212,-3650579.256833361,true,true,11.8467522,7412.714023759999,0.0,1644.2724500334996,779.0,11.8467522,7412.714023759999,0.0,121.92,0.0 -780,39563.16547254196,38863.16547254196,0.33,12867.507865526584,4184958.0871036486,700.0,546000.0,41113.660198565405,17029250.050107617,28246.152333038823,12844291.963003919,true,780.0,780,0.875,11259.069382335761,12867.507865526584,1608.4384831908228,0.0,0.0,780,38863.16547254196,0.0,11259.069382335761,11259.069382335761,1974260.1913976811,700.0,546000.0,858.5737592311386,1010846.3687090355,8872.467197838403,124255.61775076498,0.0,0.0,1361.491989430007,836825.9238201895,166.53643583621331,2332.281117689654,-11259.069382335761,-3661838.326215697,true,true,12.29379945,7425.007823209999,0.0,1644.2724500334996,780.0,12.29379945,7425.007823209999,0.0,121.92,0.0 -781,35317.50786552658,34617.50786552658,0.28625,7973.122586863376,4192931.209690512,700.0,546700.0,30299.11820738297,17059549.168315,22325.995620519592,12866617.958624437,true,781.0,781,0.875,6976.482263505453,7973.122586863376,996.6403233579222,0.0,0.0,781,34617.50786552658,0.0,6976.482263505453,6976.482263505453,1981236.6736611866,700.0,546700.0,932.127414067149,1011778.4961231026,4559.462412144059,128815.08016290904,0.0,0.0,1399.311211405617,838225.2350315952,85.58122588862797,2417.862343578282,-6976.482263505453,-3668814.8084792024,true,true,12.51732308,7437.525146289999,0.0,1644.2724500334996,781.0,12.51732308,7437.525146289999,0.0,121.92,0.0 -782,30423.122586863377,29723.122586863377,0.25,5965.37197509375,4198896.581665606,700.0,547400.0,26661.487900375,17086210.656215377,20696.11592528125,12887314.074549718,true,782.0,782,0.875,5219.700478207031,5965.37197509375,745.6714968867191,0.0,0.0,782,29723.122586863377,0.0,5219.700478207031,5219.700478207031,1986456.3741393937,700.0,547400.0,973.0194384315259,1012751.5155615341,2775.1106779563092,131590.19084086534,0.0,0.0,1419.4814635395317,839644.7164951348,52.088898279664605,2469.9512418579466,-5219.700478207031,-3674034.5089574093,true,true,12.65143726,7450.176583549999,0.0,1644.2724500334996,782.0,12.65143726,7450.176583549999,0.0,121.92,0.0 -783,28415.37197509375,27715.37197509375,0.29250000000000004,9379.879766418437,4208276.461432025,700.0,548100.0,34461.12740655876,17120671.783621937,25081.24764014032,12912395.322189858,true,783.0,783,0.875,8207.394795616132,9379.879766418437,1172.4849708023048,0.0,0.0,783,27715.37197509375,0.0,8207.394795616132,8207.394795616132,1994663.7689350098,700.0,548100.0,1020.4328202134943,1013771.9483817476,5638.945821520826,137229.13666238615,0.0,0.0,1442.1729968376947,841086.8894919724,105.84315704411657,2575.794398902063,-8207.394795616132,-3682241.9037530255,true,true,12.91966561,7463.096249159999,0.0,1644.2724500334996,783.0,12.91966561,7463.096249159999,0.0,121.92,0.0 -784,31829.87976641844,31129.87976641844,0.1888,2868.780616819426,4211145.242048845,700.0,548800.0,18902.439707730013,17139574.223329667,16033.659090910587,12928428.981280768,true,784.0,784,0.875,2510.183039716998,2868.780616819426,358.5975771024282,0.0,0.0,784,31129.87976641844,0.0,2510.183039716998,2510.183039716998,1997173.9519747267,700.0,548800.0,1052.8823542018563,1014824.8307359495,0.0,137229.13666238615,0.0,0.0,1457.3006855151418,842544.1901774876,0.0,2575.794398902063,-2510.183039716998,-3684752.0867927424,true,true,12.91966561,7476.01591477,0.0,1644.2724500334996,784.0,12.91966561,7476.01591477,0.0,121.92,0.0 -785,25318.780616819426,24618.780616819426,0.1888,2868.780616819426,4214014.022665665,700.0,549500.0,18902.439707730013,17158476.663037397,16033.659090910587,12944462.640371678,true,785.0,785,0.875,2510.183039716998,2868.780616819426,358.5975771024282,0.0,0.0,785,24618.780616819426,0.0,2510.183039716998,2510.183039716998,1999684.1350144437,700.0,549500.0,1052.8823542018563,1015877.7130901513,0.0,137229.13666238615,0.0,0.0,1457.3006855151418,844001.4908630027,0.0,2575.794398902063,-2510.183039716998,-3687262.2698324593,true,true,12.91966561,7488.93558038,0.0,1644.2724500334996,785.0,12.91966561,7488.93558038,0.0,121.92,0.0 -786,25318.780616819426,24618.780616819426,0.16720000000000002,1755.8537530885512,4215769.8764187535,700.0,550200.0,14688.120532826264,17173164.783570223,12932.266779737713,12957394.907151416,true,786.0,786,0.875,1536.3720339524823,1755.8537530885512,219.48171913606893,0.0,0.0,786,24618.780616819426,0.0,1536.3720339524823,1536.3720339524823,2001220.5070483962,700.0,550200.0,1047.4270155198526,1016925.1401056711,-948.0396567908635,136281.09700559528,0.0,0.0,1454.779403786908,845456.2702667896,-17.794728563414726,2557.9996703386487,-1536.3720339524823,-3688798.6418664115,true,true,12.87496088,7501.81054126,0.0,1644.2724500334996,786.0,12.87496088,7501.81054126,0.0,121.92,0.0 -787,24205.85375308855,23505.85375308855,0.12,0.0,4215769.8764187535,700.0,550900.0,5833.333333333334,17178998.116903555,5833.333333333334,12963228.24048475,true,787.0,787,0.875,0.0,0.0,0.0,0.0,0.0,787,23505.85375308855,0.0,-406.92767017867095,-406.92767017867095,2000813.5793782175,700.0,550900.0,1025.7941019195234,1017950.9342075906,-2824.4019533233245,133456.69505227194,0.0,0.0,1444.6942780019433,846900.9645447915,-53.01409677681319,2504.9855735618353,-0.0,-3688798.6418664115,true,true,12.74084671,7514.55138797,0.0,1644.2724500334996,787.0,12.74084671,7514.55138797,0.0,121.92,0.0 -788,22450.0,21750.0,0.14,605.3986535534868,4216375.275072307,700.0,551600.0,9324.27609681062,17188322.393000364,8718.877443257134,12971947.117928008,true,788.0,788,0.875,529.723821859301,605.3986535534868,75.67483169418585,0.0,0.0,788,21750.0,0.0,529.723821859301,529.723821859301,2001343.3032000768,700.0,551600.0,999.174493917097,1018950.1087015078,-1866.5042114066378,131590.1908408653,0.0,0.0,1432.0878710527304,848333.0524158442,-35.03433170388865,2469.9512418579466,-529.723821859301,-3689328.365688271,true,true,12.65143726,7527.202825230001,0.0,1644.2724500334996,788.0,12.65143726,7527.202825230001,0.0,121.92,0.0 -789,23055.398653553486,22355.398653553486,0.1864,2760.802585916258,4219136.077658224,700.0,552300.0,18566.53747809151,17206888.930478457,15805.734892175253,12987752.852820182,true,789.0,789,0.875,2415.7022626767257,2760.802585916258,345.1003232395324,0.0,0.0,789,22355.398653553486,0.0,2415.7022626767257,2415.7022626767257,2003759.0054627536,700.0,552300.0,988.6569545164776,1019938.7656560242,0.0,131590.1908408653,0.0,0.0,1427.045308160248,849760.0977240044,0.0,2469.9512418579466,-2415.7022626767257,-3691744.0679509477,true,true,12.65143726,7539.854262490001,0.0,1644.2724500334996,789.0,12.65143726,7539.854262490001,0.0,121.92,0.0 -790,25210.80258591626,24510.80258591626,0.1864,2760.802585916258,4221896.8802441405,700.0,553000.0,18566.53747809151,17225455.46795655,15805.734892175253,13003558.587712357,true,790.0,790,0.875,2415.7022626767257,2760.802585916258,345.1003232395324,0.0,0.0,790,24510.80258591626,0.0,2415.7022626767257,2415.7022626767257,2006174.7077254304,700.0,553000.0,988.6569545164776,1020927.4226105406,0.0,131590.1908408653,0.0,0.0,1427.045308160248,851187.1430321647,0.0,2469.9512418579466,-2415.7022626767257,-3694159.7702136245,true,true,12.65143726,7552.505699750001,0.0,1644.2724500334996,790.0,12.65143726,7552.505699750001,0.0,121.92,0.0 -791,25210.80258591626,24510.80258591626,0.16720000000000002,1671.0883355512772,4223567.968579692,700.0,553700.0,14181.150332244479,17239636.618288796,12510.0619966932,13016068.64970905,true,791.0,791,0.875,1462.2022936073674,1671.0883355512772,208.88604194390973,0.0,0.0,791,24510.80258591626,0.0,1462.2022936073674,1462.2022936073674,2007636.9100190378,700.0,553700.0,983.4259756663673,1021910.848586207,-928.3230609352154,130661.8677799301,0.0,0.0,1424.5240264320141,852611.6670585966,-17.424647555798682,2452.5265943021477,-1462.2022936073674,-3695621.972507232,true,true,12.60673253,7565.1124322800015,0.0,1644.2724500334996,791.0,12.60673253,7565.1124322800015,0.0,121.92,0.0 -792,24121.088335551278,23421.088335551278,0.12,0.0,4223567.968579692,700.0,554400.0,5833.333333333334,17245469.95162213,5833.333333333334,13021901.983042384,true,792.0,792,0.875,0.0,0.0,0.0,0.0,0.0,792,23421.088335551278,0.0,-3249.982350692445,-3249.982350692445,2004386.9276683454,700.0,554400.0,947.3248472827854,1022858.1734334899,-5500.929663762416,125160.93811616767,0.0,0.0,1406.8750560263331,854018.542114623,-103.25259023914789,2349.2740040629997,-0.0,-3695621.972507232,true,true,12.33850418,7577.450936460002,0.0,1644.2724500334996,792.0,12.33850418,7577.450936460002,0.0,121.92,0.0 -793,22450.0,21750.0,0.1648,1576.0354830228666,4225144.004062715,700.0,555100.0,13810.894921255258,17259280.846543383,12234.859438232392,13034136.842480617,true,793.0,793,0.875,1379.0310476450084,1576.0354830228666,197.00443537785827,0.0,0.0,793,21750.0,0.0,1379.0310476450084,1379.0310476450084,2005765.9587159904,700.0,555100.0,912.1182138004393,1023770.2916472903,-905.3203654027374,124255.61775076494,0.0,0.0,1389.2260856206524,855407.7682002437,-16.992886373346,2332.2811176896535,-1379.0310476450084,-3697001.003554877,true,true,12.29379945,7589.7447359100015,0.0,1644.2724500334996,793.0,12.29379945,7589.7447359100015,0.0,121.92,0.0 -794,24026.035483022868,23326.035483022868,0.184,2621.5609872463024,4227765.565049961,700.0,555800.0,18051.961887208166,17277332.80843059,15430.400899961864,13049567.243380578,true,794.0,794,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,794,23326.035483022868,0.0,2293.8658638405145,2293.8658638405145,2008059.824579831,700.0,555800.0,907.1610599480958,1024677.4527072385,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,856794.4730041361,0.0,2332.2811176896535,-2293.8658638405145,-3699294.8694187175,true,true,12.29379945,7602.038535360001,0.0,1644.2724500334996,794.0,12.29379945,7602.038535360001,0.0,121.92,0.0 -795,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4230387.126037207,700.0,556500.0,18051.961887208166,17295384.770317797,15430.400899961864,13064997.64428054,true,795.0,795,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,795,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2010353.6904436715,700.0,556500.0,907.1610599480958,1025584.6137671866,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,858181.1778080285,0.0,2332.2811176896535,-2293.8658638405145,-3701588.735282558,true,true,12.29379945,7614.332334810001,0.0,1644.2724500334996,795.0,12.29379945,7614.332334810001,0.0,121.92,0.0 -796,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4233008.687024454,700.0,557200.0,18051.961887208166,17313436.732205003,15430.400899961864,13080428.045180501,true,796.0,796,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,796,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2012647.556307512,700.0,557200.0,907.1610599480958,1026491.7748271348,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,859567.8826119209,0.0,2332.2811176896535,-2293.8658638405145,-3703882.6011463986,true,true,12.29379945,7626.626134260001,0.0,1644.2724500334996,796.0,12.29379945,7626.626134260001,0.0,121.92,0.0 -797,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4235630.2480117,700.0,557900.0,18051.961887208166,17331488.69409221,15430.400899961864,13095858.446080463,true,797.0,797,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,797,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2014941.4221713527,700.0,557900.0,907.1610599480958,1027398.935887083,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,860954.5874158134,0.0,2332.2811176896535,-2293.8658638405145,-3706176.467010239,true,true,12.29379945,7638.919933710001,0.0,1644.2724500334996,797.0,12.29379945,7638.919933710001,0.0,121.92,0.0 -798,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4238251.808998946,700.0,558600.0,18051.961887208166,17349540.655979417,15430.400899961864,13111288.846980425,true,798.0,798,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,798,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2017235.2880351932,700.0,558600.0,907.1610599480958,1028306.0969470311,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,862341.2922197058,0.0,2332.2811176896535,-2293.8658638405145,-3708470.3328740797,true,true,12.29379945,7651.213733160001,0.0,1644.2724500334996,798.0,12.29379945,7651.213733160001,0.0,121.92,0.0 -799,25071.560987246303,24371.560987246303,0.196,3684.1800585110573,4241935.989057457,700.0,559300.0,22368.26560464825,17371908.921584066,18684.085546137194,13129972.932526562,true,799.0,799,0.875,3223.657551197175,3684.1800585110573,460.5225073138822,0.0,0.0,799,24371.560987246303,0.0,3223.657551197175,3223.657551197175,2020458.9455863903,700.0,559300.0,912.1182138004393,1029218.2151608316,905.3203654027374,125160.93811616767,0.0,0.0,1389.2260856206524,863730.5183053265,16.992886373346,2349.2740040629997,-3223.657551197175,-3711693.990425277,true,true,12.33850418,7663.552237340001,0.0,1644.2724500334996,799.0,12.33850418,7663.552237340001,0.0,121.92,0.0 -800,26134.180058511058,25434.180058511058,0.265,6927.7004622089735,4248863.689519666,700.0,560000.0,28783.775329090466,17400692.696913157,21856.074866881492,13151829.007393444,true,800.0,800,0.875,6061.737904432852,6927.7004622089735,865.9625577761217,0.0,0.0,800,25434.180058511058,0.0,6061.737904432852,6061.737904432852,2026520.6834908233,700.0,560000.0,937.1750250423974,1030155.390185874,3654.142046741322,128815.080162909,0.0,0.0,1401.832493133851,865132.3507984603,68.58833951528196,2417.8623435782815,-6061.737904432852,-3717755.7283297097,true,true,12.51732308,7676.069560420001,0.0,1644.2724500334996,800.0,12.51732308,7676.069560420001,0.0,121.92,0.0 -801,29377.700462208973,28677.700462208973,0.28625,8156.214995937008,4257019.904515604,700.0,560700.0,30938.74234388474,17431631.43925704,22782.527347947733,13174611.534741392,true,801.0,801,0.875,7136.688121444882,8156.214995937008,1019.5268744921259,0.0,0.0,801,28677.700462208973,0.0,7136.688121444882,7136.688121444882,2033657.371612268,700.0,560700.0,983.4259756663673,1031138.8161615403,4641.614889362947,133456.69505227194,0.0,0.0,1424.5240264320141,866556.8748248923,87.12322998355324,2504.985573561835,-7136.688121444882,-3724892.4164511547,true,true,12.74084671,7688.810407130001,0.0,1644.2724500334996,801.0,12.74084671,7688.810407130001,0.0,121.92,0.0 -802,30606.214995937007,29906.214995937007,0.3516666666666666,19719.92193247998,4276739.826448084,700.0,561400.0,58066.12871795256,17489697.567974992,38346.206785472576,13212957.741526864,true,802.0,802,0.875,17254.931690919984,19719.92193247998,2464.9902415599972,0.0,0.0,802,29906.214995937007,0.0,17254.931690919984,17254.931690919984,2050912.303303188,700.0,561400.0,1091.6010137358662,1032230.4171752762,14417.759310882255,147874.4543631542,0.0,0.0,1474.9496559208226,868031.8244808131,270.6217103810403,2775.6072839428753,-17254.931690919984,-3742147.348142075,true,true,13.41141759,7702.221824720002,0.0,1644.2724500334996,802.0,13.41141759,7702.221824720002,0.0,121.92,0.0 -803,42169.92193247998,41469.92193247998,0.335,14841.512914275521,4291581.33936236,700.0,562100.0,46392.57586350902,17536090.143838502,31551.062949233496,13244508.804476097,true,803.0,803,0.875,12986.323799991082,14841.512914275521,1855.1891142844397,0.0,0.0,803,41469.92193247998,0.0,12986.323799991082,12986.323799991082,2063898.627103179,700.0,562100.0,1237.6157767511554,1033468.0329520274,10022.601838474762,157897.05620162896,0.0,0.0,1537.9816923588444,869569.806173172,188.12449240631886,2963.731776349194,-12986.323799991082,-3755133.671942066,true,true,13.85846484,7716.080289560002,0.0,1644.2724500334996,803.0,13.85846484,7716.080289560002,0.0,121.92,0.0 -804,37291.51291427552,36591.51291427552,0.33999999999999997,15425.479878628494,4307006.819240988,700.0,562800.0,47427.88199596616,17583518.025834467,32002.402117337668,13276511.206593435,true,804.0,804,0.875,13497.294893799932,15425.479878628494,1928.184984828562,0.0,0.0,804,36591.51291427552,0.0,13497.294893799932,13497.294893799932,2077395.921996979,700.0,562800.0,1363.3833313570601,1034831.4162833844,10351.21173264913,168248.2679342781,0.0,0.0,1588.4073212836674,871158.2134944557,194.2925085100756,3158.0242848592698,-13497.294893799932,-3768630.9668358658,true,true,14.30551209,7730.385801650002,0.0,1644.2724500334996,804.0,14.30551209,7730.385801650002,0.0,121.92,0.0 -805,37875.479878628495,37175.479878628495,0.33999999999999997,16018.869061964053,4323025.688302952,700.0,563500.0,49173.14429989428,17632691.17013436,33154.275237930226,13309665.481831366,true,805.0,805,0.875,14016.510429218546,16018.869061964053,2002.3586327455068,0.0,0.0,805,37175.479878628495,0.0,14016.510429218546,14016.510429218546,2091412.4324261977,700.0,563500.0,1497.3950798833798,1036328.8113632678,10679.821869395772,178928.08980367385,0.0,0.0,1638.8329507724761,872797.0464452282,200.46052916691826,3358.484814026188,-14016.510429218546,-3782647.477265084,true,true,14.75255935,7745.138361000002,0.0,1644.2724500334996,805.0,14.75255935,7745.138361000002,0.0,121.92,0.0 -806,38468.869061964055,37768.869061964055,0.196,3693.280092087905,4326718.968395039,700.0,564200.0,22414.69434738727,17655105.86448175,18721.414255299365,13328386.896086665,true,806.0,806,0.875,3231.6200805769167,3693.280092087905,461.66001151098817,0.0,0.0,806,37768.869061964055,0.0,3231.6200805769167,3231.6200805769167,2094644.0525067747,700.0,564200.0,1567.5743147780436,1037896.3856780459,0.0,178928.08980367385,0.0,0.0,1664.0457657988732,874461.092211027,0.0,3358.484814026188,-3231.6200805769167,-3785879.097345661,true,true,14.75255935,7759.8909203500025,0.0,1644.2724500334996,806.0,14.75255935,7759.8909203500025,0.0,121.92,0.0 -807,26143.280092087905,25443.280092087905,0.3175,11404.28836633784,4338123.256761378,700.0,564900.0,38123.742886103435,17693229.607367855,26719.454519765597,13355106.35060643,true,807.0,807,0.875,9978.75232054561,11404.28836633784,1425.5360457922307,0.0,0.0,807,25443.280092087905,0.0,9978.75232054561,9978.75232054561,2104622.8048273204,700.0,564900.0,1610.7161737802023,1039507.1018518261,6565.625729708203,185493.71553338206,0.0,0.0,1679.17345447632,876140.2656655033,123.23696258088448,3481.7217766070726,-9978.75232054561,-3795857.8496662066,true,true,15.0207877,7774.911708050003,0.0,1644.2724500334996,807.0,15.0207877,7774.911708050003,0.0,121.92,0.0 -808,33854.28836633784,33154.28836633784,0.29250000000000004,9045.656531877703,4347168.9132932555,700.0,565600.0,33318.483869667354,17726548.091237523,24272.82733778965,13379379.17794422,true,808.0,808,0.875,7914.9494653929905,9045.656531877703,1130.7070664847124,0.0,0.0,808,33154.28836633784,0.0,7914.9494653929905,7914.9494653929905,2112537.7542927135,700.0,565600.0,1684.3658195392377,1041191.4676713654,4442.805798640346,189936.5213320224,0.0,0.0,1704.3862689387315,877844.6519344421,83.39157827467528,3565.113354881748,-7914.9494653929905,-3803772.7991315997,true,true,15.1996066,7790.111314650003,0.0,1644.2724500334996,808.0,15.1996066,7790.111314650003,0.0,121.92,0.0 -809,31495.656531877703,30795.656531877703,0.28625,7873.222071420243,4355042.135364676,700.0,566300.0,29950.1207735205,17756498.212011043,22076.898702100254,13401456.07664632,true,809.0,809,0.875,6889.069312492713,7873.222071420243,984.1527589275302,0.0,0.0,809,30795.656531877703,0.0,6889.069312492713,6889.069312492713,2119426.8236052063,700.0,566300.0,1737.2344888771113,1042928.7021602425,3366.6082618045,193303.12959382692,0.0,0.0,1722.0352387804269,879566.6871732225,63.19132303067399,3628.304677912422,-6889.069312492713,-3810661.8684440926,true,true,15.33372077,7805.445035420003,0.0,1644.2724500334996,809.0,15.33372077,7805.445035420003,0.0,121.92,0.0 -810,30323.22207142024,29623.22207142024,0.184,2666.290299206391,4357708.425663882,700.0,567000.0,18295.055973947776,17774793.26798499,15628.765674741386,13417084.842321062,true,810.0,810,0.875,2333.004011805592,2666.290299206391,333.28628740079876,0.0,0.0,810,29623.22207142024,0.0,2333.004011805592,2333.004011805592,2121759.827617012,700.0,567000.0,1752.5404318936303,1044681.2425921361,-1125.4887688338354,192177.64082499308,0.0,0.0,1727.0778016729093,881293.7649748954,-21.12545292711178,3607.17922498531,-2333.004011805592,-3812994.872455898,true,true,15.28901605,7820.734051470003,0.0,1644.2724500334996,810.0,15.28901605,7820.734051470003,0.0,121.92,0.0 -811,25116.29029920639,24416.29029920639,0.16,1332.507023642382,4359040.932687525,700.0,567700.0,12703.168897764886,17787496.436882757,11370.661874122505,13428455.504195185,true,811.0,811,0.875,1165.9436456870842,1332.507023642382,166.5633779552977,0.0,0.0,811,24416.29029920639,0.0,1165.9436456870842,1165.9436456870842,2122925.7712626993,700.0,567700.0,1729.6150511451326,1046410.8576432812,-2241.119492970665,189936.5213320224,0.0,0.0,1719.5139576161787,883013.2789325116,-42.06587010356221,3565.113354881748,-1165.9436456870842,-3814160.8161015855,true,true,15.1996066,7835.933658070003,0.0,1644.2724500334996,811.0,15.1996066,7835.933658070003,0.0,121.92,0.0 -812,23782.50702364238,23082.50702364238,0.20800000000000002,3918.7593953981846,4362959.692082923,700.0,568400.0,22205.574016337425,17809702.010899093,18286.81462093924,13446742.318816125,true,812.0,812,0.875,3428.9144709734114,3918.7593953981846,489.8449244247731,0.0,0.0,812,23082.50702364238,0.0,3428.9144709734114,3428.9144709734114,2126354.6857336727,700.0,568400.0,1714.4430762497152,1048125.3007195309,0.0,189936.5213320224,0.0,0.0,1714.4713947236962,884727.7503272353,0.0,3565.113354881748,-3428.9144709734114,-3817589.730572559,true,true,15.1996066,7851.133264670003,0.0,1644.2724500334996,812.0,15.1996066,7851.133264670003,0.0,121.92,0.0 -813,26368.759395398185,25668.759395398185,0.184,2608.3079392527093,4365568.000022176,700.0,569100.0,17979.934452460377,17827681.945351552,15371.626513207668,13462113.945329333,true,813.0,813,0.875,2282.2694468461204,2608.3079392527093,326.03849240658883,0.0,0.0,813,25668.759395398185,0.0,2282.2694468461204,2282.2694468461204,2128636.955180519,700.0,569100.0,1706.8904736661468,1049832.1911931972,-1115.6307226666315,188820.8906093558,0.0,0.0,1711.9501129954624,886439.7004402308,-20.940417148857104,3544.1729377328907,-2282.2694468461204,-3819872.000019405,true,true,15.15490187,7866.288166540003,0.0,1644.2724500334996,813.0,15.15490187,7866.288166540003,0.0,121.92,0.0 -814,25058.30793925271,24358.30793925271,0.12,0.0,4365568.000022176,700.0,569800.0,5833.333333333334,17833515.278684884,5833.333333333334,13467947.278662667,true,814.0,814,0.875,0.0,0.0,0.0,0.0,0.0,814,24358.30793925271,0.0,-10.859375140363909,-10.859375140363909,2128626.0958053786,700.0,569800.0,1676.9018747486716,1051509.093067946,-3327.175075973715,185493.71553338208,0.0,0.0,1701.8649872104977,888141.5654274413,-62.451161125818174,3481.7217766070726,-0.0,-3819872.000019405,true,true,15.0207877,7881.308954240003,0.0,1644.2724500334996,814.0,15.0207877,7881.308954240003,0.0,121.92,0.0 -815,22450.0,21750.0,0.12,0.0,4365568.000022176,700.0,570500.0,5833.333333333334,17839348.612018216,5833.333333333334,13473780.611996,true,815.0,815,0.875,0.0,0.0,0.0,0.0,0.0,815,21750.0,0.0,-2282.744528886049,-2282.744528886049,2126343.3512764927,700.0,570500.0,1617.982550741672,1053127.0756186876,-5479.57014376485,180014.14538961725,0.0,0.0,1681.6947356405685,889823.2601630818,-102.85167150343926,3378.8701051036333,-0.0,-3819872.000019405,true,true,14.79726407,7896.106218310003,0.0,1644.2724500334996,815.0,14.79726407,7896.106218310003,0.0,121.92,0.0 -816,22450.0,21750.0,0.1816,2439.813283526722,4368007.813305702,700.0,571200.0,17289.720724266088,17856638.332742482,14849.907440739365,13488630.51943674,true,816.0,816,0.875,2134.836623085882,2439.813283526722,304.9766604408401,0.0,0.0,816,21750.0,0.0,2134.836623085882,2134.836623085882,2128478.1878995784,700.0,571200.0,1574.7104531435575,1054701.7860718311,-1086.0555859433525,178928.08980367388,0.0,0.0,1666.5670469631218,891489.827210045,-20.385291077445224,3358.484814026188,-2134.836623085882,-3822006.8366424907,true,true,14.75255935,7910.858777660003,0.0,1644.2724500334996,816.0,14.75255935,7910.858777660003,0.0,121.92,0.0 -817,24889.81328352672,24189.81328352672,0.12,0.0,4368007.813305702,700.0,571900.0,5833.333333333334,17862471.666075815,5833.333333333334,13494463.852770073,true,817.0,817,0.875,0.0,0.0,0.0,0.0,0.0,817,24189.81328352672,0.0,-2298.332238798516,-2298.332238798516,2126179.85566078,700.0,571900.0,1532.216842854109,1056234.0029146853,-5380.987173307377,173547.1026303665,0.0,0.0,1651.4393582856746,893141.2665683306,-101.0012666309227,3257.4835473952653,-0.0,-3822006.8366424907,true,true,14.52903572,7925.3878133800035,0.0,1644.2724500334996,817.0,14.52903572,7925.3878133800035,0.0,121.92,0.0 -818,22450.0,21750.0,0.12,0.0,4368007.813305702,700.0,572600.0,5833.333333333334,17868304.999409147,5833.333333333334,13500297.186103407,true,818.0,818,0.875,0.0,0.0,0.0,0.0,0.0,818,21750.0,0.0,-2308.9624788806427,-2308.9624788806427,2123870.893181899,700.0,572600.0,1463.1049364844707,1057697.1078511698,-5298.8346960883955,168248.26793427812,0.0,0.0,1626.2265432592776,894767.4931115898,-99.45926253599555,3158.0242848592698,-0.0,-3822006.8366424907,true,true,14.30551209,7939.693325470003,0.0,1644.2724500334996,818.0,14.30551209,7939.693325470003,0.0,121.92,0.0 -819,22450.0,21750.0,0.1768,2244.7271876975233,4370252.5404934,700.0,573300.0,16655.69676299504,17884960.69617214,14410.969575297519,13514708.155678704,true,819.0,819,0.875,1964.1362892353327,2244.7271876975233,280.5908984621906,0.0,0.0,819,21750.0,0.0,1964.1362892353327,1964.1362892353327,2125835.0294711343,700.0,573300.0,1422.6527452880216,1059119.7605964579,-1049.908501259502,167198.35943301863,0.0,0.0,1611.098854581831,896378.5919661716,-19.706809375017883,3138.317475484252,-1964.1362892353327,-3823970.972931726,true,true,14.26080737,7953.954132840004,0.0,1644.2724500334996,819.0,14.26080737,7953.954132840004,0.0,121.92,0.0 -820,24694.727187697525,23994.727187697525,0.12,0.0,4370252.5404934,700.0,574000.0,5833.333333333334,17890794.029505473,5833.333333333334,13520541.489012038,true,820.0,820,0.875,0.0,0.0,0.0,0.0,0.0,820,23994.727187697525,0.0,-191.64285391372664,-191.64285391372664,2125643.3866172205,700.0,574000.0,1396.103152351972,1060515.8637488098,-3130.0093791011004,164068.35005391753,0.0,0.0,1601.013728796866,897979.6056949685,-58.75035596146432,3079.567119522788,-0.0,-3823970.972931726,true,true,14.12669319,7968.080826030004,0.0,1644.2724500334996,820.0,14.12669319,7968.080826030004,0.0,121.92,0.0 -821,22450.0,21750.0,0.1768,2176.6746875493723,4372429.215180949,700.0,574700.0,16270.78443184034,17907064.813937314,14094.109744290969,13534635.59875633,true,821.0,821,0.875,1904.5903516057006,2176.6746875493723,272.0843359436717,0.0,0.0,821,21750.0,0.0,1904.5903516057006,1904.5903516057006,2127547.9769688263,700.0,574700.0,1369.8859443148722,1061885.7496931246,-1036.764106962612,163031.5859469549,0.0,0.0,1590.9286030119015,899570.5342979804,-19.460088758460998,3060.1070307643267,-1904.5903516057006,-3825875.5632833317,true,true,14.08198847,7982.162814500004,0.0,1644.2724500334996,821.0,14.08198847,7982.162814500004,0.0,121.92,0.0 -822,24626.674687549374,23926.674687549374,0.12,0.0,4372429.215180949,700.0,575400.0,5833.333333333334,17912898.147270646,5833.333333333334,13540468.932089664,true,822.0,822,0.875,0.0,0.0,0.0,0.0,0.0,822,23926.674687549374,0.0,-6483.869724942868,-6483.869724942868,2121064.1072438834,700.0,575400.0,1305.7833678344905,1063191.533060959,-9183.003668016738,153848.58227893818,0.0,0.0,1565.7157885494898,901136.2500865299,-172.36521331010988,2887.7418174542167,-0.0,-3825875.5632833317,true,true,13.67964594,7995.842460440004,0.0,1644.2724500334996,822.0,13.67964594,7995.842460440004,0.0,121.92,0.0 -823,22450.0,21750.0,0.12,0.0,4372429.215180949,700.0,576100.0,5833.333333333334,17918731.480603978,5833.333333333334,13546302.265422998,true,823.0,823,0.875,0.0,0.0,0.0,0.0,0.0,823,21750.0,0.0,-3344.9373452009113,-3344.9373452009113,2117719.1698986827,700.0,576100.0,1213.4285375204897,1064404.9615984797,-5974.12791578394,147874.45436315425,0.0,0.0,1527.8965665738797,902664.1466531038,-112.13453351134136,2775.6072839428753,-0.0,-3825875.5632833317,true,true,13.41141759,8009.253878030005,0.0,1644.2724500334996,823.0,13.41141759,8009.253878030005,0.0,121.92,0.0 -824,22450.0,21750.0,0.17200000000000001,1919.3720224937144,4374348.587203443,700.0,576800.0,15228.907107521592,17933960.3877115,13309.535085027877,13559611.800508026,true,824.0,824,0.875,1679.450519682,1919.3720224937144,239.9215028117144,0.0,0.0,824,21750.0,0.0,1679.450519682,1679.450519682,2119398.6204183646,700.0,576800.0,1171.8628834918766,1065576.8244819716,-984.1867495604637,146890.26761359378,0.0,0.0,1510.247596168199,904174.394249272,-18.47321041761169,2757.1340735252634,-1679.450519682,-3827555.0138030136,true,true,13.36671286,8022.620590890005,0.0,1644.2724500334996,824.0,13.36671286,8022.620590890005,0.0,121.92,0.0 -825,24369.372022493713,23669.372022493713,0.1912,3055.691307172714,4377404.278510616,700.0,577500.0,19642.736962200386,17953603.124673698,16587.045655027672,13576198.846163053,true,825.0,825,0.875,2673.7298937761248,3055.691307172714,381.96141339658925,0.0,0.0,825,23669.372022493713,0.0,2673.7298937761248,2673.7298937761248,2122072.350312141,700.0,577500.0,1166.0035793361596,1066742.8280613078,0.0,146890.26761359378,0.0,0.0,1507.726314439965,905682.120563712,0.0,2757.1340735252634,-2673.7298937761248,-3830228.7436967897,true,true,13.36671286,8035.987303750005,0.0,1644.2724500334996,825.0,13.36671286,8035.987303750005,0.0,121.92,0.0 -826,25505.691307172714,24805.691307172714,0.1912,3055.691307172714,4380459.969817789,700.0,578200.0,19642.736962200386,17973245.861635897,16587.045655027672,13592785.89181808,true,826.0,826,0.875,2673.7298937761248,3055.691307172714,381.96141339658925,0.0,0.0,826,24805.691307172714,0.0,2673.7298937761248,2673.7298937761248,2124746.080205917,700.0,578200.0,1166.0035793361596,1067908.831640644,0.0,146890.26761359378,0.0,0.0,1507.726314439965,907189.846878152,0.0,2757.1340735252634,-2673.7298937761248,-3832902.473590566,true,true,13.36671286,8049.354016610005,0.0,1644.2724500334996,826.0,13.36671286,8049.354016610005,0.0,121.92,0.0 -827,25505.691307172714,24805.691307172714,0.1912,3055.691307172714,4383515.661124962,700.0,578900.0,19642.736962200386,17992888.598598097,16587.045655027672,13609372.937473107,true,827.0,827,0.875,2673.7298937761248,3055.691307172714,381.96141339658925,0.0,0.0,827,24805.691307172714,0.0,2673.7298937761248,2673.7298937761248,2127419.810099693,700.0,578900.0,1166.0035793361596,1069074.8352199802,0.0,146890.26761359378,0.0,0.0,1507.726314439965,908697.573192592,0.0,2757.1340735252634,-2673.7298937761248,-3835576.203484342,true,true,13.36671286,8062.720729470005,0.0,1644.2724500334996,827.0,13.36671286,8062.720729470005,0.0,121.92,0.0 -828,25505.691307172714,24805.691307172714,0.12,0.0,4383515.661124962,700.0,579600.0,5833.333333333334,17998721.93193143,5833.333333333334,13615206.270806441,true,828.0,828,0.875,0.0,0.0,0.0,0.0,0.0,828,24805.691307172714,0.0,-339.1873668912551,-339.1873668912551,2127080.622732802,700.0,579600.0,1148.5429202219773,1070223.3781402023,-2932.843215460603,143957.42439813318,0.0,0.0,1500.1624703832342,910197.7356629752,-55.04954203586372,2702.0845314893995,-0.0,-3835576.203484342,true,true,13.23259869,8075.953328160004,0.0,1644.2724500334996,828.0,13.23259869,8075.953328160004,0.0,121.92,0.0 -829,22450.0,21750.0,0.1696,1858.6776077127756,4385374.338732675,700.0,580300.0,15086.54249830646,18013808.474429734,13227.864890593684,13628434.135697035,true,829.0,829,0.875,1626.3429067486786,1858.6776077127756,232.334700964097,0.0,0.0,829,21750.0,0.0,1626.3429067486786,1626.3429067486786,2128706.9656395507,700.0,580300.0,1125.534404219617,1071348.9125444219,-971.0423523233416,142986.38204580985,0.0,0.0,1490.0773445982697,911687.8130075735,-18.226489745866665,2683.858041743533,-1626.3429067486786,-3837202.546391091,true,true,13.18789396,8089.141222120004,0.0,1644.2724500334996,829.0,13.18789396,8089.141222120004,0.0,121.92,0.0 -830,24308.677607712776,23608.677607712776,0.1912,2979.8705779713114,4388354.209310646,700.0,581000.0,19246.185031230707,18033054.659460966,16266.314453259396,13644700.450150294,true,830.0,830,0.875,2607.3867557248973,2979.8705779713114,372.4838222464141,0.0,0.0,830,23608.677607712776,0.0,2607.3867557248973,2607.3867557248973,2131314.3523952756,700.0,581000.0,1119.8306928548616,1072468.7432372768,0.0,142986.38204580985,0.0,0.0,1487.5560628700357,913175.3690704436,0.0,2683.858041743533,-2607.3867557248973,-3839809.9331468157,true,true,13.18789396,8102.3291160800045,0.0,1644.2724500334996,830.0,13.18789396,8102.3291160800045,0.0,121.92,0.0 -831,25429.870577971313,24729.870577971313,0.14,711.4291647275921,4389065.638475373,700.0,581700.0,10081.636890911372,18043136.296351876,9370.20772618378,13654070.657876479,true,831.0,831,0.875,622.5005191366431,711.4291647275921,88.92864559094903,0.0,0.0,831,24729.870577971313,0.0,622.5005191366431,622.5005191366431,2131936.852914412,700.0,581700.0,1108.4811443252456,1073577.2243816021,-1932.2261902415157,141054.15585556833,0.0,0.0,1482.5134999775537,914657.8825704211,-36.267934924640436,2647.5901068188923,-622.5005191366431,-3840432.433665952,true,true,13.09848451,8115.427600590005,0.0,1644.2724500334996,831.0,13.09848451,8115.427600590005,0.0,121.92,0.0 -832,23161.429164727593,22461.429164727593,0.12,0.0,4389065.638475373,700.0,582400.0,5833.333333333334,18048969.62968521,5833.333333333334,13659903.991209812,true,832.0,832,0.875,0.0,0.0,0.0,0.0,0.0,832,22461.429164727593,0.0,-1354.5359631710262,-1354.5359631710262,2130582.316951241,700.0,582400.0,1074.8931266278387,1074652.11750823,-3825.019193182142,137229.13666238618,0.0,0.0,1467.3858113001065,916125.2683817212,-71.79570791682987,2575.7943989020623,-0.0,-3840432.433665952,true,true,12.91966561,8128.347266200005,0.0,1644.2724500334996,832.0,12.91966561,8128.347266200005,0.0,121.92,0.0 -833,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,583100.0,5833.333333333334,18054802.96301854,5833.333333333334,13665737.324543146,true,833.0,833,0.875,0.0,0.0,0.0,0.0,0.0,833,21750.0,0.0,-4235.794721628112,-4235.794721628112,2126346.522229613,700.0,583100.0,1015.0902503183833,1075667.2077585484,-6567.268882456041,130661.86777993014,0.0,0.0,1439.6517151094608,917564.9200968307,-123.26780459991525,2452.5265943021473,-0.0,-3840432.433665952,true,true,12.60673253,8140.953998730005,0.0,1644.2724500334996,833.0,12.60673253,8140.953998730005,0.0,121.92,0.0 -834,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,583800.0,5833.333333333334,18060636.296351872,5833.333333333334,13671570.65787648,true,834.0,834,0.875,0.0,0.0,0.0,0.0,0.0,834,21750.0,0.0,-2316.697759506005,-2316.697759506005,2124029.824470107,700.0,583800.0,952.427125113243,1076619.6348836618,-4592.323198682849,126069.54458124729,0.0,0.0,1409.3963377545672,918974.3164345853,-86.19802369096637,2366.328570611181,-0.0,-3840432.433665952,true,true,12.38320891,8153.337207640005,0.0,1644.2724500334996,834.0,12.38320891,8153.337207640005,0.0,121.92,0.0 -835,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,584500.0,5833.333333333334,18066469.629685204,5833.333333333334,13677403.991209814,true,835.0,835,0.875,0.0,0.0,0.0,0.0,0.0,835,21750.0,0.0,-4137.784847028056,-4137.784847028056,2119892.039623079,700.0,584500.0,892.3974305014219,1077512.0323141632,-6291.236566939175,119778.30801430812,0.0,0.0,1379.1409603996733,920353.4573949849,-118.0866709899764,2248.2418996212045,-0.0,-3840432.433665952,true,true,12.07027583,8165.407483470005,0.0,1644.2724500334996,835.0,12.07027583,8165.407483470005,0.0,121.92,0.0 -836,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,585200.0,5833.333333333334,18072302.963018537,5833.333333333334,13683237.324543148,true,836.0,836,0.875,0.0,0.0,0.0,0.0,0.0,836,21750.0,0.0,-11069.212650598878,-11069.212650598878,2108822.82697248,700.0,585200.0,788.9949839284826,1078301.0272980917,-12939.014765045522,106839.2932492626,0.0,0.0,1323.6727680183824,921677.1301630032,-242.86563750022063,2005.376262120984,-0.0,-3840432.433665952,true,true,11.39970495,8176.807188420005,0.0,1644.2724500334996,836.0,11.39970495,8176.807188420005,0.0,121.92,0.0 -837,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,585900.0,5833.333333333334,18078136.29635187,5833.333333333334,13689070.657876482,true,837.0,837,0.875,0.0,0.0,0.0,0.0,0.0,837,21750.0,0.0,-12934.126534978386,-12934.126534978386,2095888.7004375015,700.0,585900.0,649.3691312688386,1078950.3964293606,-14550.84638748677,92288.44686177582,0.0,0.0,1240.470479446446,922917.6006424497,-273.11975820690026,1732.2565039140836,-0.0,-3840432.433665952,true,true,10.59501989,8187.402208310005,0.0,1644.2724500334996,837.0,10.59501989,8187.402208310005,0.0,121.92,0.0 -838,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,586600.0,5833.333333333334,18083969.6296852,5833.333333333334,13694903.991209816,true,838.0,838,0.875,0.0,0.0,0.0,0.0,0.0,838,21750.0,0.0,-11331.8132362759,-11331.8132362759,2084556.8872012256,700.0,586600.0,520.4091594953464,1079470.8055888559,-12764.85143660032,79523.5954251755,0.0,0.0,1152.2256282076216,924069.8262706574,-239.59658737854753,1492.659916535536,-0.0,-3840432.433665952,true,true,9.835039564,8197.237247874005,0.0,1644.2724500334996,838.0,9.835039564,8197.237247874005,0.0,121.92,0.0 -839,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,587300.0,5833.333333333334,18089802.963018533,5833.333333333334,13700737.32454315,true,839.0,839,0.875,0.0,0.0,0.0,0.0,0.0,839,21750.0,0.0,-9180.936213145482,-9180.936213145482,2075375.9509880801,700.0,587300.0,418.56520403034614,1079889.3707928862,-10474.440522719358,69049.15490245614,0.0,0.0,1071.544621589513,925141.3708922468,-196.6055160459838,1296.0544004895523,-0.0,-3840432.433665952,true,true,9.164468684,8206.401716558006,0.0,1644.2724500334996,839.0,9.164468684,8206.401716558006,0.0,121.92,0.0 -840,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,588000.0,5833.333333333334,18095636.296351865,5833.333333333334,13706570.657876484,true,840.0,840,0.875,0.0,0.0,0.0,0.0,0.0,840,21750.0,0.0,-7296.827678331779,-7296.827678331779,2068079.1233097482,700.0,588000.0,341.1676563245566,1080230.5384492108,-8479.778417889507,60569.37648456663,0.0,0.0,1000.9487406435721,926142.3196328904,-159.16565741039994,1136.8887430791524,-0.0,-3840432.433665952,true,true,8.583307256,8214.985023814006,0.0,1644.2724500334996,840.0,8.583307256,8214.985023814006,0.0,121.92,0.0 -841,22450.0,21750.0,0.16240000000000002,1459.3257413904846,4390524.964216764,700.0,588700.0,13296.340772108895,18108932.637123972,11837.01503071841,13718407.672907203,true,841.0,841,0.875,1276.910023716674,1459.3257413904846,182.4157176738106,0.0,0.0,841,21750.0,0.0,1276.910023716674,1276.910023716674,2069356.033333465,700.0,588700.0,308.7379420434323,1080539.2763912543,0.0,60569.37648456663,0.0,0.0,968.1720816732416,927110.4917145637,0.0,1136.8887430791524,-1276.910023716674,-3841709.343689669,true,true,8.583307256,8223.568331070006,0.0,1644.2724500334996,841.0,8.583307256,8223.568331070006,0.0,121.92,0.0 -842,23909.325741390487,23209.325741390487,0.28625,8276.994130063078,4398801.958346827,700.0,589400.0,31360.678183626474,18140293.3153076,23083.684053563396,13741491.356960766,true,842.0,842,0.875,7242.369863805193,8276.994130063078,1034.6242662578852,0.0,0.0,842,23209.325741390487,0.0,7242.369863805193,7242.369863805193,2076598.4031972701,700.0,589400.0,330.95883788694795,1080870.2352291413,5811.466045071076,66380.84252963771,0.0,0.0,990.863614802209,928101.3553293659,109.08136604495968,1245.970109124112,-7242.369863805193,-3848951.7135534743,true,true,8.985649783,8232.553980853007,0.0,1644.2724500334996,842.0,8.985649783,8232.553980853007,0.0,121.92,0.0 -843,30726.994130063078,30026.994130063078,0.28625,7885.572017878172,4406687.530364705,700.0,590100.0,29993.264691277458,18170286.579998877,22107.692673399288,13763599.049634166,true,843.0,843,0.875,6899.875515643401,7885.572017878172,985.6965022347713,0.0,0.0,843,30026.994130063078,0.0,6899.875515643401,6899.875515643401,2083498.2787129136,700.0,590100.0,375.7923214181441,1081246.0275505595,5389.202329292834,71770.04485893055,0.0,0.0,1033.725399613903,929135.0807289798,101.1554653185201,1347.1255744426321,-6899.875515643401,-3855851.589069118,true,true,9.343287585,8241.897268438006,0.0,1644.2724500334996,843.0,9.343287585,8241.897268438006,0.0,121.92,0.0 -844,30335.57201787817,29635.57201787817,0.23500000000000001,5736.528373374279,4412424.05873808,700.0,590800.0,27389.482439890548,18197676.062438767,21652.954066516268,13785252.003700683,true,844.0,844,0.875,5019.4623267024945,5736.528373374279,717.0660466717845,0.0,0.0,844,29635.57201787817,0.0,5019.4623267024945,5019.4623267024945,2088517.741039616,700.0,590800.0,412.6838123532025,1081658.7113629128,3475.0496844069985,75245.09454333755,0.0,0.0,1066.5020586406322,930201.5827876204,65.22677130166099,1412.3523457442932,-5019.4623267024945,-3860871.0513958205,true,true,9.566811212,8251.464079650006,0.0,1644.2724500334996,844.0,9.566811212,8251.464079650006,0.0,121.92,0.0 -845,28186.52837337428,27486.52837337428,0.265,6741.44925180282,4419165.5079898825,700.0,591500.0,28080.940572840827,18225757.003011607,21339.491321038007,13806591.495021721,true,845.0,845,0.875,5898.768095327468,6741.44925180282,842.6811564753525,0.0,0.0,845,27486.52837337428,0.0,5898.768095327468,5898.768095327468,2094416.5091349436,700.0,591500.0,445.7234879233887,1082104.4348508362,4278.5008818379565,79523.5954251755,0.0,0.0,1094.2361547748792,931295.8189423953,80.30757079124295,1492.6599165355362,-5898.768095327468,-3866769.819491148,true,true,9.835039564,8261.299119214007,0.0,1644.2724500334996,845.0,9.835039564,8261.299119214007,0.0,121.92,0.0 -846,29191.44925180282,28491.44925180282,0.265,6957.1974259183335,4426122.705415801,700.0,592200.0,28895.084626106916,18254652.087637715,21937.887200188583,13828529.38222191,true,846.0,846,0.875,6087.547747678542,6957.1974259183335,869.6496782397917,0.0,0.0,846,28491.44925180282,0.0,6087.547747678542,6087.547747678542,2100504.056882622,700.0,592200.0,483.7276452736252,1082588.1624961097,4396.800511954977,83920.39593713048,0.0,0.0,1124.4915325809613,932420.3104749762,82.52805786897848,1575.1879744045148,-6087.547747678542,-3872857.3672388266,true,true,10.10326792,8271.402387134007,0.0,1644.2724500334996,846.0,10.10326792,8271.402387134007,0.0,121.92,0.0 -847,29407.197425918333,28707.197425918333,0.28,7175.346654623566,4433298.052070425,700.0,592900.0,28126.238052227018,18282778.32568994,20950.891397603453,13849480.273619512,true,847.0,847,0.875,6278.42832279562,7175.346654623566,896.9183318279456,0.0,0.0,847,28707.197425918333,0.0,6278.42832279562,6278.42832279562,2106782.485205418,700.0,592900.0,523.8328938474393,1083111.9953899572,4515.099976828838,88435.49591395931,0.0,0.0,1154.7469102742466,933575.0573852505,84.74854184509532,1659.9365162496101,-6278.42832279562,-3879135.7955616224,true,true,10.37149627,8281.773883404006,0.0,1644.2724500334996,847.0,10.37149627,8281.773883404006,0.0,121.92,0.0 -848,29625.346654623565,28925.346654623565,0.29250000000000004,9238.863032659527,4442536.915103084,700.0,593600.0,33979.0189150753,18316757.344605017,24740.155882415773,13874220.429501928,true,848.0,848,0.875,8084.005153577085,9238.863032659527,1154.8578790824413,0.0,0.0,848,28925.346654623565,0.0,8084.005153577085,8084.005153577085,2114866.4903589953,700.0,593600.0,573.3533150677572,1083685.348705025,6204.154843176141,94639.65075713546,0.0,0.0,1190.044850521623,934765.1022357721,116.45214481156428,1776.3886610611744,-8084.005153577085,-3887219.8007151997,true,true,10.72913407,8292.503017474006,0.0,1644.2724500334996,848.0,10.72913407,8292.503017474006,0.0,121.92,0.0 -849,31688.863032659527,30988.863032659527,0.3175,11518.821616399087,4454055.7367194835,700.0,594300.0,38484.477531965626,18355241.822136983,26965.655915566538,13901186.085417494,true,849.0,849,0.875,10078.968914349201,11518.821616399087,1439.852702049886,0.0,0.0,849,30988.863032659527,0.0,10078.968914349201,10078.968914349201,2124945.4592733444,700.0,594300.0,641.4821435603176,1084326.8308485853,8050.942458727084,102690.59321586255,0.0,0.0,1235.4279165539635,936000.530152326,151.1163955078356,1927.5050565690099,-10078.968914349201,-3897298.769629549,true,true,11.17618132,8303.679198794005,0.0,1644.2724500334996,849.0,11.17618132,8303.679198794005,0.0,121.92,0.0 -850,33968.82161639909,33268.82161639909,0.3175,12052.538489204004,4466108.275208687,700.0,595000.0,40165.475556548045,18395407.297693532,28112.937067344043,13929299.022484839,true,850.0,850,0.875,10545.971178053504,12052.538489204004,1506.5673111505002,0.0,0.0,850,33268.82161639909,0.0,10545.971178053504,10545.971178053504,2135491.430451398,700.0,595000.0,723.2806727928487,1085050.1115213782,8379.552544019009,111070.14575988156,0.0,0.0,1285.8535460427722,937286.3836983688,157.28441519887352,2084.7894717678832,-10545.971178053504,-3907844.740807602,true,true,11.62322858,8315.302427374005,0.0,1644.2724500334996,850.0,11.62322858,8315.302427374005,0.0,121.92,0.0 -851,34502.538489204,33802.538489204,0.29250000000000004,8460.001863090596,4474568.277071778,700.0,595700.0,31316.245685779813,18426723.54337931,22856.24382268922,13952155.266307529,true,851.0,851,0.875,7402.501630204271,8460.001863090596,1057.5002328863247,0.0,0.0,851,33802.538489204,0.0,7402.501630204271,7402.501630204271,2142893.932081602,700.0,595700.0,793.5121203230937,1085843.6236417012,5185.46416535502,116255.60992523658,0.0,0.0,1326.1940497466162,938612.5777481154,97.33129477954175,2182.120766547425,-7402.501630204271,-3915247.2424378064,true,true,11.89145693,8327.193884304004,0.0,1644.2724500334996,851.0,11.89145693,8327.193884304004,0.0,121.92,0.0 -852,30910.001863090598,30210.001863090598,0.1816,2471.199073769774,4477039.476145548,700.0,596400.0,17462.549965692586,18444186.093345,14991.350891922812,13967146.617199453,true,852.0,852,0.875,2162.299189548552,2471.199073769774,308.8998842212218,0.0,0.0,852,30210.001863090598,0.0,2162.299189548552,2162.299189548552,2145056.2312711505,700.0,596400.0,820.9774511244888,1086664.6010928256,0.0,116255.60992523658,0.0,0.0,1341.3217384240631,939953.8994865394,0.0,2182.120766547425,-2162.299189548552,-3917409.541627355,true,true,11.89145693,8339.085341234004,0.0,1644.2724500334996,852.0,11.89145693,8339.085341234004,0.0,121.92,0.0 -853,24921.199073769774,24221.199073769774,0.22,4530.685487844309,4481570.161633392,700.0,597100.0,23775.84312656504,18467961.936471567,19245.15763872073,13986391.774838174,true,853.0,853,0.875,3964.34980186377,4530.685487844309,566.335685980539,0.0,0.0,853,24221.199073769774,0.0,3964.34980186377,3964.34980186377,2149020.581073014,700.0,597100.0,830.2714476801368,1087494.8725405058,1754.7768466522741,118010.38677188885,0.0,0.0,1346.3643013165454,941300.263787856,32.93720621481408,2215.057972762239,-3964.34980186377,-3921373.8914292185,true,true,11.98086638,8351.066207614003,0.0,1644.2724500334996,853.0,11.98086638,8351.066207614003,0.0,121.92,0.0 -854,26980.68548784431,26280.68548784431,0.22,4578.998785058628,4486149.160418451,700.0,597800.0,23995.449022993762,18491957.38549456,19416.450237935132,14005808.22507611,true,854.0,854,0.875,4006.6239369262994,4578.998785058628,572.3748481323282,0.0,0.0,854,26280.68548784431,0.0,4006.6239369262994,4006.6239369262994,2153027.2050099405,700.0,597800.0,849.0693405465553,1088343.9418810525,1767.9212424192683,119778.30801430812,0.0,0.0,1356.4494271015103,942656.7132149575,33.183926858965414,2248.2418996212045,-4006.6239369262994,-3925380.515366145,true,true,12.07027583,8363.136483444003,0.0,1644.2724500334996,854.0,12.07027583,8363.136483444003,0.0,121.92,0.0 -855,27028.998785058626,26328.998785058626,0.22,4627.633923578913,4490776.79434203,700.0,598500.0,24216.517834449605,18516173.90332901,19588.883910870692,14025397.10898698,true,855.0,855,0.875,4049.1796831315487,4627.633923578913,578.4542404473641,0.0,0.0,855,26328.998785058626,0.0,4049.1796831315487,4049.1796831315487,2157076.384693072,700.0,598500.0,868.1488445557432,1089212.0907256082,1781.065638186216,121559.37365249434,0.0,0.0,1366.5345528864746,944023.247767844,33.430647503114876,2281.6725471243194,-4049.1796831315487,-3929429.6950492766,true,true,12.15968528,8375.296168724002,0.0,1644.2724500334996,855.0,12.15968528,8375.296168724002,0.0,121.92,0.0 -856,27077.633923578913,26377.633923578913,0.29250000000000004,8934.515909767073,4499711.310251797,700.0,599200.0,32938.5159308276,18549112.41925984,24004.000021060525,14049401.10900804,true,856.0,856,0.875,7817.701421046188,8934.515909767073,1116.8144887208846,0.0,0.0,856,26377.633923578913,0.0,7817.701421046188,7817.701421046188,2164894.0861141183,700.0,599200.0,907.161061054948,1090119.2517866632,5422.06328916059,126981.43694165493,0.0,0.0,1386.704804456404,945409.9525723004,101.77226637424626,2383.4448134985655,-7817.701421046188,-3937247.3964703227,true,true,12.42791363,8387.724082354001,0.0,1644.2724500334996,856.0,12.42791363,8387.724082354001,0.0,121.92,0.0 -857,31384.515909767073,30684.515909767073,0.25,5907.355844272249,4505618.666096069,700.0,599900.0,26429.423377088995,18575541.842636928,20522.067532816745,14069923.176540857,true,857.0,857,0.875,5168.936363738218,5907.355844272249,738.4194805340312,0.0,0.0,857,30684.515909767073,0.0,5168.936363738218,5168.936363738218,2170063.0224778564,700.0,599900.0,952.427125113243,1091071.6789117765,2755.394083570766,129736.83102522569,0.0,0.0,1409.3963377545672,946819.348910055,51.718817299641884,2435.1636307982076,-5168.936363738218,-3942416.332834061,true,true,12.56202781,8400.286110164001,0.0,1644.2724500334996,857.0,12.56202781,8400.286110164001,0.0,121.92,0.0 -858,28357.35584427225,27657.35584427225,0.30500000000000005,10407.054048018803,4516025.720144087,700.0,600600.0,36416.57064924197,18611958.413286168,26009.516601223168,14095932.69314208,true,858.0,858,0.875,9106.172292016452,10407.054048018803,1300.8817560023508,0.0,0.0,858,27657.35584427225,0.0,9106.172292016452,9106.172292016452,2179169.194769873,700.0,600600.0,1004.461119889405,1092076.140031666,6544.265980369629,136281.0970055953,0.0,0.0,1434.6091522169786,948253.9580622719,122.83603954044027,2557.999670338648,-9106.172292016452,-3951522.505126077,true,true,12.87496088,8413.161071044002,0.0,1644.2724500334996,858.0,12.87496088,8413.161071044002,0.0,121.92,0.0 -859,32857.05404801881,32157.054048018806,0.20800000000000002,3963.4752053269017,4519989.195349414,700.0,601300.0,22420.55387176395,18634378.967157934,18457.07866643705,14114389.771808518,true,859.0,859,0.875,3468.040804661039,3963.4752053269017,495.43440066586254,0.0,0.0,859,32157.054048018806,0.0,3468.040804661039,3468.040804661039,2182637.2355745337,700.0,601300.0,1047.4270155198526,1093123.567047186,948.0396567908635,137229.13666238618,0.0,0.0,1454.779403786908,949708.7374660588,17.794728563414726,2575.7943989020623,-3468.040804661039,-3954990.545930738,true,true,12.91966561,8426.080736654001,0.0,1644.2724500334996,859.0,12.91966561,8426.080736654001,0.0,121.92,0.0 -860,26413.475205326904,25713.475205326904,0.20800000000000002,3985.5548750564617,4523974.75022447,700.0,602000.0,22526.70613007914,18656905.673288014,18541.151255022676,14132930.92306354,true,860.0,860,0.875,3487.360515674404,3985.5548750564617,498.1943593820579,0.0,0.0,860,25713.475205326904,0.0,3487.360515674404,3487.360515674404,2186124.5960902083,700.0,602000.0,1058.356600959824,1094181.9236481457,951.3255432981376,138180.4622056843,0.0,0.0,1459.82196667939,951168.5594327382,17.856404737052035,2593.650803639114,-3487.360515674404,-3958477.9064464127,true,true,12.96437033,8439.045106984002,0.0,1644.2724500334996,860.0,12.96437033,8439.045106984002,0.0,121.92,0.0 -861,26435.554875056463,25735.554875056463,0.20800000000000002,4007.7216323819034,4527982.471856852,700.0,602700.0,22633.277078759147,18679538.950366773,18625.555446377242,14151556.478509918,true,861.0,861,0.875,3506.7564283341653,4007.7216323819034,500.9652040477381,0.0,0.0,861,25735.554875056463,0.0,3506.7564283341653,3506.7564283341653,2189631.3525185427,700.0,602700.0,1069.361954453522,1095251.2856025994,954.6118554094829,139135.0740610938,0.0,0.0,1464.8645295718727,952633.4239623101,17.918088899287984,2611.568892538402,-3506.7564283341653,-3961984.662874747,true,true,13.00907506,8452.054182044001,0.0,1644.2724500334996,861.0,13.00907506,8452.054182044001,0.0,121.92,0.0 -862,26457.7216323819,25757.7216323819,0.1696,1784.796045390427,4529767.267902243,700.0,603400.0,14650.92007895299,18694189.870445725,12866.124033562563,14164422.60254348,true,862.0,862,0.875,1561.6965397166236,1784.796045390427,223.09950567380338,0.0,0.0,862,25757.7216323819,0.0,1561.6965397166236,1561.6965397166236,2191193.0490582595,700.0,603400.0,1069.361954453522,1096320.647557053,-954.6118554094829,138180.4622056843,0.0,0.0,1464.8645295718727,954098.2884918819,-17.918088899287984,2593.650803639114,-1561.6965397166236,-3963546.359414464,true,true,12.96437033,8465.018552374002,0.0,1644.2724500334996,862.0,12.96437033,8465.018552374002,0.0,121.92,0.0 -863,24234.796045390427,23534.796045390427,0.12,0.0,4529767.267902243,700.0,604100.0,5833.333333333334,18700023.203779057,5833.333333333334,14170255.935876815,true,863.0,863,0.875,0.0,0.0,0.0,0.0,0.0,863,23534.796045390427,0.0,-6147.376387871692,-6147.376387871692,2185045.6726703877,700.0,604100.0,1015.0902503183833,1097335.7378073714,-8443.63118045863,129736.83102522568,0.0,0.0,1439.6517151094608,955537.9402069914,-158.48717284090702,2435.163630798207,-0.0,-3963546.359414464,true,true,12.56202781,8477.580580184002,0.0,1644.2724500334996,863.0,12.56202781,8477.580580184002,0.0,121.92,0.0 -864,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,604800.0,5833.333333333334,18705856.53711239,5833.333333333334,14176089.269210149,true,864.0,864,0.875,0.0,0.0,0.0,0.0,0.0,864,21750.0,0.0,-3245.088269393007,-3245.088269393007,2181800.5844009947,700.0,604800.0,937.1750250423974,1098272.9128324138,-5481.2132744607015,124255.61775076497,0.0,0.0,1401.832493133851,956939.7727001252,-102.88251310855414,2332.281117689653,-0.0,-3963546.359414464,true,true,12.29379945,8489.874379634002,0.0,1644.2724500334996,864.0,12.29379945,8489.874379634002,0.0,121.92,0.0 -865,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,605500.0,5833.333333333334,18711689.87044572,5833.333333333334,14181922.602543483,true,865.0,865,0.875,0.0,0.0,0.0,0.0,0.0,865,21750.0,0.0,-2304.6060187210624,-2304.6060187210624,2179495.9783822736,700.0,605500.0,882.6445388610508,1099155.5573712748,-4477.30973645687,119778.3080143081,0.0,0.0,1374.0983969432057,958313.8710970684,-84.03921806844889,2248.241899621204,-0.0,-3963546.359414464,true,true,12.07027583,8501.944655464002,0.0,1644.2724500334996,865.0,12.07027583,8501.944655464002,0.0,121.92,0.0 -866,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,606200.0,5833.333333333334,18717523.203779053,5833.333333333334,14187755.935876817,true,866.0,866,0.875,0.0,0.0,0.0,0.0,0.0,866,21750.0,0.0,-8471.929802488148,-8471.929802488148,2171024.0485797855,700.0,606200.0,802.5980481462836,1099958.1554194211,-10410.361707658323,109367.94630664978,0.0,0.0,1331.236612075113,959645.1077091435,-195.40275505122125,2052.8391445699826,-0.0,-3963546.359414464,true,true,11.53381912,8513.478474584002,0.0,1644.2724500334996,866.0,11.53381912,8513.478474584002,0.0,121.92,0.0 -867,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,606900.0,5833.333333333334,18723356.537112385,5833.333333333334,14193589.26921015,true,867.0,867,0.875,0.0,0.0,0.0,0.0,0.0,867,21750.0,0.0,-4807.071382953114,-4807.071382953114,2166216.977196832,700.0,606900.0,714.8048132488018,1100672.96023267,-6677.353090787247,102690.59321586254,0.0,0.0,1280.8109825863046,960925.9186917299,-125.3340880009735,1927.5050565690092,-0.0,-3963546.359414464,true,true,11.17618132,8524.654655904002,0.0,1644.2724500334996,867.0,11.17618132,8524.654655904002,0.0,121.92,0.0 -868,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,607600.0,5833.333333333334,18729189.870445717,5833.333333333334,14199422.602543484,true,868.0,868,0.875,0.0,0.0,0.0,0.0,0.0,868,21750.0,0.0,-2233.5218365004366,-2233.5218365004366,2163983.4553603316,700.0,607600.0,661.3204135987122,1101334.2806462687,-4066.547376089585,98624.04583977295,0.0,0.0,1248.0343240671623,962173.9530157971,-76.32919807672575,1851.1758584922834,-0.0,-3963546.359414464,true,true,10.9526577,8535.607313604001,0.0,1644.2724500334996,868.0,10.9526577,8535.607313604001,0.0,121.92,0.0 -869,22450.0,21750.0,0.22,4996.584096672255,4534763.851998915,700.0,608300.0,25893.56407578298,18755083.4345215,20896.97997911072,14220319.582522595,true,869.0,869,0.875,4372.011084588224,4996.584096672255,624.5730120840317,0.0,0.0,869,21750.0,0.0,4372.011084588224,4372.011084588224,2168355.46644492,700.0,608300.0,653.3367529164735,1101987.6173991852,2430.0700928102124,101054.11593258317,0.0,0.0,1242.9917611746798,963416.9447769717,45.61247768685836,1896.7883361791417,-4372.011084588224,-3967918.370499052,true,true,11.08677187,8546.694085474,0.0,1644.2724500334996,869.0,11.08677187,8546.694085474,0.0,121.92,0.0 -870,27446.584096672254,26746.584096672254,0.22,5075.902333791998,4539839.754332707,700.0,609000.0,26254.101517236355,18781337.536038738,21178.199183444358,14241497.781706039,true,870.0,870,0.875,4441.414542067998,5075.902333791998,634.4877917240001,0.0,0.0,870,26746.584096672254,0.0,4441.414542067998,4441.414542067998,2172796.8809869876,700.0,609000.0,677.4823240752958,1102665.0997232604,2459.6451655826645,103513.76109816584,0.0,0.0,1258.1194498521268,964675.0642268239,46.167602557911074,1942.9559387370527,-4441.414542067998,-3972359.78504112,true,true,11.22088605,8557.914971524,0.0,1644.2724500334996,870.0,11.22088605,8557.914971524,0.0,121.92,0.0 -871,27525.902333791997,26825.902333791997,0.25,6137.275802641789,4545977.030135349,700.0,609700.0,27349.103210567155,18808686.639249306,21211.827407925368,14262709.609113963,true,871.0,871,0.875,5370.116327311565,6137.275802641789,767.1594753302234,0.0,0.0,871,26825.902333791997,0.0,5370.116327311565,5370.116327311565,2178166.997314299,700.0,609700.0,706.3954325730705,1103371.4951558334,3325.532151096757,106839.2932492626,0.0,0.0,1275.7684202578077,965950.8326470817,62.42032338393042,2005.3762621209833,-5370.116327311565,-3977729.9013684313,true,true,11.39970495,8569.314676474,0.0,1644.2724500334996,871.0,11.39970495,8569.314676474,0.0,121.92,0.0 -872,28587.275802641787,27887.275802641787,0.20800000000000002,4270.608332440132,4550247.63846779,700.0,610400.0,23897.155444423708,18832583.79469373,19626.54711198358,14282336.156225948,true,872.0,872,0.875,3736.782290885115,4270.608332440132,533.8260415550167,0.0,0.0,872,27887.275802641787,0.0,3736.782290885115,3736.782290885115,2181903.779605184,700.0,610400.0,731.8232700928227,1104103.3184259261,1682.4826691988467,108521.77591846144,0.0,0.0,1290.8961089352545,967241.7287560169,31.580242658190524,2036.9565047791739,-3736.782290885115,-3981466.6836593165,true,true,11.4891144,8580.803790873999,0.0,1644.2724500334996,872.0,11.4891144,8580.803790873999,0.0,121.92,0.0 -873,26720.608332440133,26020.608332440133,0.28,7330.903198138462,4557578.541665928,700.0,611100.0,28681.797136208792,18861265.59182994,21350.89393807033,14303687.050164018,true,873.0,873,0.875,6414.540298371155,7330.903198138462,916.3628997673077,0.0,0.0,873,26020.608332440133,0.0,6414.540298371155,6414.540298371155,2188318.3199035553,700.0,611100.0,762.2517069876488,1104865.5701329138,4263.713500771498,112785.48941923294,0.0,0.0,1308.5450793409352,968550.2738353579,80.03001127107308,2116.986516050247,-6414.540298371155,-3987881.2239576876,true,true,11.71263803,8592.516428903999,0.0,1644.2724500334996,873.0,11.71263803,8592.516428903999,0.0,121.92,0.0 -874,29780.90319813846,29080.90319813846,0.29250000000000004,9573.719355116233,4567152.261021045,700.0,611800.0,35123.826855098225,18896389.418685038,25550.10749998199,14329237.157664,true,874.0,874,0.875,8377.004435726703,9573.719355116233,1196.7149193895293,0.0,0.0,874,29080.90319813846,0.0,8377.004435726703,8377.004435726703,2196695.3243392822,700.0,611800.0,816.356575297534,1105681.9267082112,6107.214825528112,118892.70424476104,0.0,0.0,1338.8004566958293,969889.0742920537,114.63257820522746,2231.6190942554745,-8377.004435726703,-3996258.2283934145,true,true,12.0255711,8604.542000004,0.0,1644.2724500334996,874.0,12.0255711,8604.542000004,0.0,121.92,0.0 -875,32023.719355116235,31323.719355116235,0.29250000000000004,8814.797141268693,4575967.058162314,700.0,612500.0,32529.220995790398,18928918.63968083,23714.423854521705,14352951.581518522,true,875.0,875,0.875,7712.947498610107,8814.797141268693,1101.8496426585862,0.0,0.0,875,31323.719355116235,0.0,7712.947498610107,7712.947498610107,2204408.2718378925,700.0,612500.0,877.7948539570205,1106559.721562168,5362.913506003936,124255.61775076498,0.0,0.0,1371.5771152149716,971260.6514072687,100.66202343417847,2332.281117689653,-7712.947498610107,-4003971.1758920248,true,true,12.29379945,8616.835799454,0.0,1644.2724500334996,875.0,12.29379945,8616.835799454,0.0,121.92,0.0 -876,31264.797141268693,30564.797141268693,0.23500000000000001,5820.957904344539,4581788.016066658,700.0,613200.0,27748.757039763994,18956667.396720592,21927.799135419453,14374879.38065394,true,876.0,876,0.875,5093.338166301472,5820.957904344539,727.6197380430676,0.0,0.0,876,30564.797141268693,0.0,5093.338166301472,5093.338166301472,2209501.610004194,700.0,613200.0,922.0866310894885,1107481.8081932575,2725.819190889936,126981.43694165492,0.0,0.0,1394.2686485131348,972654.9200557818,51.16369580891225,2383.444813498565,-5093.338166301472,-4009064.5140583264,true,true,12.42791363,8629.263713084,0.0,1644.2724500334996,876.0,12.42791363,8629.263713084,0.0,121.92,0.0 -877,28270.95790434454,27570.95790434454,0.29250000000000004,9176.182398284534,4590964.198464943,700.0,613900.0,33764.72614798131,18990432.12286857,24588.543749696775,14399467.924403638,true,877.0,877,0.875,8029.159598498967,9176.182398284534,1147.0227997855673,0.0,0.0,877,27570.95790434454,0.0,8029.159598498967,8029.159598498967,2217530.769602693,700.0,613900.0,967.8438134527646,1108449.6520067104,5540.362851063305,132521.79979271823,0.0,0.0,1416.9601818112978,974071.8802375931,103.9927521715989,2487.437565670164,-8029.159598498967,-4017093.6736568254,true,true,12.69614198,8641.959855064,0.0,1644.2724500334996,877.0,12.69614198,8641.959855064,0.0,121.92,0.0 -878,31626.182398284534,30926.182398284534,0.29250000000000004,9420.874673652263,4600385.073138596,700.0,614600.0,34601.280935563285,19025033.403804135,25180.406261911023,14424648.33066555,true,878.0,878,0.875,8243.26533944573,9420.874673652263,1177.6093342065324,0.0,0.0,878,30926.182398284534,0.0,8243.26533944573,8243.26533944573,2225774.034942139,700.0,614600.0,1031.174129344498,1109480.826136055,5658.66241296609,138180.4622056843,0.0,0.0,1447.215559166192,975519.0957967592,106.21323796895003,2593.650803639114,-8243.26533944573,-4025336.938996271,true,true,12.96437033,8654.924225394001,0.0,1644.2724500334996,878.0,12.96437033,8654.924225394001,0.0,121.92,0.0 -879,31870.874673652263,31170.874673652263,0.22,5132.213012485917,4605517.286151081,700.0,615300.0,26510.059147663258,19051543.462951798,21377.84613517734,14446026.176800726,true,879.0,879,0.875,4490.686385925177,5132.213012485917,641.5266265607397,0.0,0.0,879,31170.874673652263,0.0,4490.686385925177,4490.686385925177,2230264.7213280643,700.0,615300.0,1074.8931253884425,1110555.7192614435,1912.5095958559955,140092.9718015403,0.0,0.0,1467.3858107361211,976986.4816074953,35.897853944617346,2629.5486575837317,-4490.686385925177,-4029827.6253821966,true,true,13.05377978,8667.978005174002,0.0,1644.2724500334996,879.0,13.05377978,8667.978005174002,0.0,121.92,0.0 -880,27582.213012485918,26882.213012485918,0.1696,1799.3976282215428,4607316.683779303,700.0,616000.0,14737.014317344001,19066280.477269143,12937.616689122458,14458963.79348985,true,880.0,880,0.875,1574.47292469385,1799.3976282215428,224.92470352769283,0.0,0.0,880,26882.213012485918,0.0,1574.47292469385,1574.47292469385,2231839.1942527583,700.0,616000.0,1080.443337721337,1111636.1625991648,-957.8977404465126,139135.07406109376,0.0,0.0,1469.907092464355,978456.3886999597,-17.97976504532936,2611.5688925384025,-1574.47292469385,-4031402.0983068906,true,true,13.00907506,8680.987080234001,0.0,1644.2724500334996,880.0,13.00907506,8680.987080234001,0.0,121.92,0.0 -881,24249.397628221544,23549.397628221544,0.1696,1784.796045390427,4609101.479824694,700.0,616700.0,14650.92007895299,19080931.397348095,12866.124033562563,14471829.917523412,true,881.0,881,0.875,1561.6965397166236,1784.796045390427,223.09950567380338,0.0,0.0,881,23549.397628221544,0.0,1561.6965397166236,1561.6965397166236,2233400.890792475,700.0,616700.0,1069.361954453522,1112705.5245536184,-954.6118554094829,138180.46220568428,0.0,0.0,1464.8645295718727,979921.2532295316,-17.918088899287984,2593.6508036391147,-1561.6965397166236,-4032963.7948466074,true,true,12.96437033,8693.951450564002,0.0,1644.2724500334996,881.0,12.96437033,8693.951450564002,0.0,121.92,0.0 -882,24234.796045390427,23534.796045390427,0.16720000000000002,1770.2818509760275,4610871.76167567,700.0,617400.0,14774.412984306382,19095705.810332403,13004.131133330355,14484834.048656743,true,882.0,882,0.875,1548.996619604024,1770.2818509760275,221.2852313720034,0.0,0.0,882,23534.796045390427,0.0,1548.996619604024,1548.996619604024,2234949.887412079,700.0,617400.0,1058.356600959824,1113763.8811545782,-951.3255432981376,137229.13666238615,0.0,0.0,1459.82196667939,981381.075196211,-17.856404737052035,2575.7943989020628,-1548.996619604024,-4034512.7914662114,true,true,12.91966561,8706.871116174001,0.0,1644.2724500334996,882.0,12.91966561,8706.871116174001,0.0,121.92,0.0 -883,24220.281850976025,23520.281850976025,0.12,0.0,4610871.76167567,700.0,618100.0,5833.333333333334,19101539.143665735,5833.333333333334,14490667.381990077,true,883.0,883,0.875,0.0,0.0,0.0,0.0,0.0,883,23520.281850976025,0.0,-1364.8607451741839,-1364.8607451741839,2233585.026666905,700.0,618100.0,1031.1741305500552,1114795.0552851283,-3772.4416101141883,133456.69505227197,0.0,0.0,1447.2155597301771,982828.2907559412,-70.80882534022791,2504.985573561835,-0.0,-4034512.7914662114,true,true,12.74084671,8719.611962884,0.0,1644.2724500334996,883.0,12.74084671,8719.611962884,0.0,121.92,0.0 -884,22450.0,21750.0,0.12,0.0,4610871.76167567,700.0,618800.0,5833.333333333334,19107372.476999067,5833.333333333334,14496500.71532341,true,884.0,884,0.875,0.0,0.0,0.0,0.0,0.0,884,21750.0,0.0,-1373.9837071332058,-1373.9837071332058,2232211.0429597716,700.0,618800.0,988.6569545164776,1115783.7122396447,-3719.8640270463043,129736.83102522566,0.0,0.0,1427.045308160248,984255.3360641014,-69.82194276362708,2435.1636307982076,-0.0,-4034512.7914662114,true,true,12.56202781,8732.173990694,0.0,1644.2724500334996,884.0,12.56202781,8732.173990694,0.0,121.92,0.0 -885,22450.0,21750.0,0.1648,1643.5123732545853,4612515.274048924,700.0,619500.0,14220.342070719571,19121592.819069788,12576.829697464986,14509077.545020876,true,885.0,885,0.875,1438.0733265977622,1643.5123732545853,205.43904665682317,0.0,0.0,885,21750.0,0.0,1438.0733265977622,1438.0733265977622,2233649.1162863695,700.0,619500.0,962.6865754872817,1116746.398815132,-921.7508623166427,128815.08016290903,0.0,0.0,1414.4389006470494,985669.7749647485,-17.30128721992617,2417.8623435782815,-1438.0733265977622,-4035950.8647928094,true,true,12.51732308,8744.691313774,0.0,1644.2724500334996,885.0,12.51732308,8744.691313774,0.0,121.92,0.0 -886,24093.512373254584,23393.512373254584,0.1864,2707.9603524932495,4615223.234401418,700.0,620200.0,18283.049101358632,19139875.868171148,15575.088748865383,14524652.633769741,true,886.0,886,0.875,2369.4653084315933,2707.9603524932495,338.49504406165624,0.0,0.0,886,23393.512373254584,0.0,2369.4653084315933,2369.4653084315933,2236018.581594801,700.0,620200.0,957.5476895127775,1117703.9465046448,0.0,128815.08016290903,0.0,0.0,1411.9176189188156,987081.6925836673,0.0,2417.8623435782815,-2369.4653084315933,-4038320.330101241,true,true,12.51732308,8757.208636853999,0.0,1644.2724500334996,886.0,12.51732308,8757.208636853999,0.0,121.92,0.0 -887,25157.96035249325,24457.96035249325,0.12,0.0,4615223.234401418,700.0,620900.0,5833.333333333334,19145709.20150448,5833.333333333334,14530485.967103075,true,887.0,887,0.875,0.0,0.0,0.0,0.0,0.0,887,24457.96035249325,0.0,-1383.7228680803555,-1383.7228680803555,2234634.858726721,700.0,620900.0,937.1750250423974,1118641.1215296872,-3654.142046741322,125160.9381161677,0.0,0.0,1401.832493133851,988483.5250768012,-68.58833951528196,2349.2740040629997,-0.0,-4038320.330101241,true,true,12.33850418,8769.547141033998,0.0,1644.2724500334996,887.0,12.33850418,8769.547141033998,0.0,121.92,0.0 -888,22450.0,21750.0,0.12,0.0,4615223.234401418,700.0,621600.0,5833.333333333334,19151542.534837812,5833.333333333334,14536319.30043641,true,888.0,888,0.875,0.0,0.0,0.0,0.0,0.0,888,21750.0,0.0,-1390.2029774790847,-1390.2029774790847,2233244.655749242,700.0,621600.0,897.3007015690653,1119538.4222312563,-3601.5644636733914,121559.37365249431,0.0,0.0,1381.6622415639217,989865.1873183651,-67.60145693868,2281.67254712432,-0.0,-4038320.330101241,true,true,12.15968528,8781.706826313997,0.0,1644.2724500334996,888.0,12.15968528,8781.706826313997,0.0,121.92,0.0 -889,22450.0,21750.0,0.12,0.0,4615223.234401418,700.0,622300.0,5833.333333333334,19157375.868171144,5833.333333333334,14542152.633769743,true,889.0,889,0.875,0.0,0.0,0.0,0.0,0.0,889,21750.0,0.0,-3197.796740186587,-3197.796740186587,2230046.8590090554,700.0,622300.0,849.0693405465553,1120387.4915718029,-5303.763727257759,116255.60992523655,0.0,0.0,1356.4494271015103,991221.6367454666,-99.55178057689437,2182.1207665474253,-0.0,-4038320.330101241,true,true,11.89145693,8793.598283243997,0.0,1644.2724500334996,889.0,11.89145693,8793.598283243997,0.0,121.92,0.0 -890,22450.0,21750.0,0.265,6605.555897068623,4621828.790298486,700.0,623000.0,27568.135460636313,19184944.00363178,20962.57956356769,14563115.21333331,true,890.0,890,0.875,5779.861409935045,6605.555897068623,825.6944871335781,0.0,0.0,890,21750.0,0.0,5779.861409935045,5779.861409935045,2235826.7204189906,700.0,623000.0,839.6353235806953,1121227.1268953835,3522.698089071542,119778.3080143081,0.0,0.0,1351.4068642090278,992573.0436096756,66.1211330737795,2248.241899621205,-5779.861409935045,-4044100.191511176,true,true,12.07027583,8805.668559073996,0.0,1644.2724500334996,890.0,12.07027583,8805.668559073996,0.0,121.92,0.0 -891,29055.555897068625,28355.555897068625,0.28625,7792.105017519515,4629620.895316006,700.0,623700.0,29666.742419282153,19214610.746051066,21874.637401762637,14584989.850735074,true,891.0,891,0.875,6818.091890329576,7792.105017519515,974.013127189939,0.0,0.0,891,28355.555897068625,0.0,6818.091890329576,6818.091890329576,2242644.81230932,700.0,623700.0,882.6445388610508,1122109.7714342445,4477.30973645687,124255.61775076497,0.0,0.0,1374.0983969432057,993947.1420066188,84.03921806844889,2332.281117689654,-6818.091890329576,-4050918.2834015056,true,true,12.29379945,8817.962358523997,0.0,1644.2724500334996,891.0,12.29379945,8817.962358523997,0.0,121.92,0.0 -892,30242.105017519516,29542.105017519516,0.23500000000000001,5820.957904344539,4635441.85322035,700.0,624400.0,27748.757039763994,19242359.50309083,21927.799135419453,14606917.649870493,true,892.0,892,0.875,5093.338166301472,5820.957904344539,727.6197380430676,0.0,0.0,892,29542.105017519516,0.0,5093.338166301472,5093.338166301472,2247738.1504756217,700.0,624400.0,922.0866310894885,1123031.858065334,2725.819190889936,126981.4369416549,0.0,0.0,1394.2686485131348,995341.4106551319,51.16369580891225,2383.444813498566,-5093.338166301472,-4056011.621567807,true,true,12.42791363,8830.390272153996,0.0,1644.2724500334996,892.0,12.42791363,8830.390272153996,0.0,121.92,0.0 -893,28270.95790434454,27570.95790434454,0.22,4825.440748163381,4640267.293968514,700.0,625100.0,25115.639764379004,19267475.14285521,20290.19901621562,14627207.848886708,true,893.0,893,0.875,4222.260654642958,4825.440748163381,603.1800935204228,0.0,0.0,893,27570.95790434454,0.0,4222.260654642958,4222.260654642958,2251960.411130265,700.0,625100.0,947.3248472827859,1123979.1829126168,1833.643221254123,128815.08016290903,0.0,0.0,1406.8750560263334,996748.2857111583,34.41753007971571,2417.8623435782815,-4222.260654642958,-4060233.8822224503,true,true,12.51732308,8842.907595233995,0.0,1644.2724500334996,893.0,12.51732308,8842.907595233995,0.0,121.92,0.0 -894,27275.440748163383,26575.440748163383,0.136,555.5876022574632,4640822.881570771,700.0,625800.0,9232.261781304876,19276707.404636513,8676.674179047413,14635884.523065755,true,894.0,894,0.875,486.13915197528036,555.5876022574632,69.44845028218288,0.0,0.0,894,26575.440748163383,0.0,486.13915197528036,486.13915197528036,2252446.5502822404,700.0,625800.0,947.3248472827859,1124926.5077598996,-1833.643221254123,126981.4369416549,0.0,0.0,1406.8750560263334,998155.1607671847,-34.41753007971571,2383.444813498566,-486.13915197528036,-4060720.021374426,true,true,12.42791363,8855.335508863995,0.0,1644.2724500334996,894.0,12.42791363,8855.335508863995,0.0,121.92,0.0 -895,23005.587602257463,22305.587602257463,0.22,4825.440748163381,4645648.322318935,700.0,626500.0,25115.639764379004,19301823.044400893,20290.19901621562,14656174.72208197,true,895.0,895,0.875,4222.260654642958,4825.440748163381,603.1800935204228,0.0,0.0,895,22305.587602257463,0.0,4222.260654642958,4222.260654642958,2256668.8109368836,700.0,626500.0,947.3248472827859,1125873.8326071824,1833.643221254123,128815.08016290903,0.0,0.0,1406.8750560263334,999562.0358232111,34.41753007971571,2417.8623435782815,-4222.260654642958,-4064942.282029069,true,true,12.51732308,8867.852831943994,0.0,1644.2724500334996,895.0,12.51732308,8867.852831943994,0.0,121.92,0.0 -896,27275.440748163383,26575.440748163383,0.1864,2707.9603524932495,4648356.282671428,700.0,627200.0,18283.049101358632,19320106.093502253,15575.088748865383,14671749.810830835,true,896.0,896,0.875,2369.4653084315933,2707.9603524932495,338.49504406165624,0.0,0.0,896,26575.440748163383,0.0,2369.4653084315933,2369.4653084315933,2259038.276245315,700.0,627200.0,957.5476895127775,1126831.3802966953,0.0,128815.08016290903,0.0,0.0,1411.9176189188156,1000973.9534421299,0.0,2417.8623435782815,-2369.4653084315933,-4067311.7473375006,true,true,12.51732308,8880.370155023993,0.0,1644.2724500334996,896.0,12.51732308,8880.370155023993,0.0,121.92,0.0 -897,25157.96035249325,24457.96035249325,0.1864,2707.9603524932495,4651064.243023922,700.0,627900.0,18283.049101358632,19338389.142603613,15575.088748865383,14687324.8995797,true,897.0,897,0.875,2369.4653084315933,2707.9603524932495,338.49504406165624,0.0,0.0,897,24457.96035249325,0.0,2369.4653084315933,2369.4653084315933,2261407.7415537466,700.0,627900.0,957.5476895127775,1127788.9279862081,0.0,128815.08016290903,0.0,0.0,1411.9176189188156,1002385.8710610487,0.0,2417.8623435782815,-2369.4653084315933,-4069681.212645932,true,true,12.51732308,8892.887478103992,0.0,1644.2724500334996,897.0,12.51732308,8892.887478103992,0.0,121.92,0.0 -898,25157.96035249325,24457.96035249325,0.12,0.0,4651064.243023922,700.0,628600.0,5833.333333333334,19344222.475936946,5833.333333333334,14693158.232913034,true,898.0,898,0.875,0.0,0.0,0.0,0.0,0.0,898,24457.96035249325,0.0,-450.47475417775206,-450.47475417775206,2260957.2667995687,700.0,628600.0,942.2408255890183,1128731.1688117972,-2745.535581661755,126069.54458124728,0.0,0.0,1404.353774862085,1003790.2248359108,-51.53377296710045,2366.328570611181,-0.0,-4069681.212645932,true,true,12.38320891,8905.270687013992,0.0,1644.2724500334996,898.0,12.38320891,8905.270687013992,0.0,121.92,0.0 -899,22450.0,21750.0,0.12,0.0,4651064.243023922,700.0,629300.0,5833.333333333334,19350055.809270278,5833.333333333334,14698991.566246368,true,899.0,899,0.875,0.0,0.0,0.0,0.0,0.0,899,21750.0,0.0,-465.59524904338764,-465.59524904338764,2260491.6715505254,700.0,629300.0,912.1182149113199,1129643.2870267085,-2715.9608947997485,123353.58368644753,0.0,0.0,1389.2260861846378,1005179.4509220954,-50.97865533959681,2315.349915271584,-0.0,-4069681.212645932,true,true,12.24909473,8917.519781743991,0.0,1644.2724500334996,899.0,12.24909473,8917.519781743991,0.0,121.92,0.0 -900,22450.0,21750.0,0.12,0.0,4651064.243023922,700.0,630000.0,5833.333333333334,19355889.14260361,5833.333333333334,14704824.899579702,true,900.0,900,0.875,0.0,0.0,0.0,0.0,0.0,900,21750.0,0.0,-2302.5914615293414,-2302.5914615293414,2258189.080088996,700.0,630000.0,872.9629671225366,1130516.249993831,-4460.879441686492,118892.70424476103,0.0,0.0,1369.0558340507232,1006548.5067561462,-83.73082101610918,2231.619094255475,-0.0,-4069681.212645932,true,true,12.0255711,8929.545352843992,0.0,1644.2724500334996,900.0,12.0255711,8929.545352843992,0.0,121.92,0.0 -901,22450.0,21750.0,0.12,0.0,4651064.243023922,700.0,630700.0,5833.333333333334,19361722.47593694,5833.333333333334,14710658.232913036,true,901.0,901,0.875,0.0,0.0,0.0,0.0,0.0,901,21750.0,0.0,-502.76243092060474,-502.76243092060474,2257686.317658075,700.0,630700.0,834.9446338311274,1131351.194627662,-2637.0943195244763,116255.60992523655,0.0,0.0,1348.885582480794,1007897.392338627,-49.498327708049914,2182.120766547425,-0.0,-4069681.212645932,true,true,11.89145693,8941.436809773992,0.0,1644.2724500334996,901.0,11.89145693,8941.436809773992,0.0,121.92,0.0 -902,22450.0,21750.0,0.16240000000000002,1447.2246571307292,4652511.467681052,700.0,631400.0,13221.826706470005,19374944.30264341,11774.602049339275,14722432.834962375,true,902.0,902,0.875,1266.321574989388,1447.2246571307292,180.9030821413412,0.0,0.0,902,21750.0,0.0,1266.321574989388,1266.321574989388,2258952.6392330644,700.0,631400.0,816.356575297534,1132167.5512029594,-872.4593723099905,115383.15055292656,0.0,0.0,1338.8004566958293,1009236.1927953229,-16.37608469398493,2165.74468185344,-1266.321574989388,-4070947.5342209213,true,true,11.8467522,8953.28356197399,0.0,1644.2724500334996,902.0,11.8467522,8953.28356197399,0.0,121.92,0.0 -903,23897.22465713073,23197.22465713073,0.1816,2454.8939955807286,4654966.361676632,700.0,632100.0,17372.764292845422,19392317.066936255,14917.870297264693,14737350.70525964,true,903.0,903,0.875,2148.0322461331375,2454.8939955807286,306.86174944759114,0.0,0.0,903,23197.22465713073,0.0,2148.0322461331375,2148.0322461331375,2261100.6714791977,700.0,632100.0,811.7530711655421,1132979.304274125,0.0,115383.15055292656,0.0,0.0,1336.2791749675953,1010572.4719702904,0.0,2165.74468185344,-2148.0322461331375,-4073095.5664670547,true,true,11.8467522,8965.13031417399,0.0,1644.2724500334996,903.0,11.8467522,8965.13031417399,0.0,121.92,0.0 -904,24904.89399558073,24204.89399558073,0.1816,2454.8939955807286,4657421.255672213,700.0,632800.0,17372.764292845422,19409689.8312291,14917.870297264693,14752268.575556904,true,904.0,904,0.875,2148.0322461331375,2454.8939955807286,306.86174944759114,0.0,0.0,904,24204.89399558073,0.0,2148.0322461331375,2148.0322461331375,2263248.703725331,700.0,632800.0,811.7530711655421,1133791.0573452907,0.0,115383.15055292656,0.0,0.0,1336.2791749675953,1011908.751145258,0.0,2165.74468185344,-2148.0322461331375,-4075243.598713188,true,true,11.8467522,8976.97706637399,0.0,1644.2724500334996,904.0,11.8467522,8976.97706637399,0.0,121.92,0.0 -905,24904.89399558073,24204.89399558073,0.132,418.5226088226869,4657839.778281036,700.0,633500.0,8473.656127444598,19418163.487356544,8055.13351862191,14760323.709075525,true,905.0,905,0.875,366.20728271985104,418.5226088226869,52.315326102835854,0.0,0.0,905,24204.89399558073,0.0,366.20728271985104,366.20728271985104,2263614.9110080507,700.0,633500.0,802.5980481462832,1134593.655393437,-1735.0602522667537,113648.09030065981,0.0,0.0,1331.2366120751128,1013239.9877573331,-32.56712523479136,2133.1775566186484,-366.20728271985104,-4075609.8059959076,true,true,11.75734275,8988.734409123988,0.0,1644.2724500334996,905.0,11.75734275,8988.734409123988,0.0,121.92,0.0 -906,22868.52260882269,22168.52260882269,0.16240000000000002,1410.1438056589407,4659249.922086695,700.0,634200.0,12993.49634026441,19431156.983696807,11583.352534605468,14771907.06161013,true,906.0,906,0.875,1233.875829951573,1410.1438056589407,176.26797570736767,0.0,0.0,906,22168.52260882269,0.0,1233.875829951573,1233.875829951573,2264848.786838002,700.0,634200.0,788.9949839284826,1135382.6503773655,-862.600881426891,112785.48941923292,0.0,0.0,1323.6727680183824,1014563.6605253514,-16.19104056840125,2116.9865160502472,-1233.875829951573,-4076843.681825859,true,true,11.71263803,9000.447047153988,0.0,1644.2724500334996,906.0,11.71263803,9000.447047153988,0.0,121.92,0.0 -907,23860.14380565894,23160.14380565894,0.1792,2406.4531551969244,4661656.375241892,700.0,634900.0,17335.118053554266,19448492.101750363,14928.664898357341,14786835.726508487,true,907.0,907,0.875,2105.646510797309,2406.4531551969244,300.8066443996154,0.0,0.0,907,23160.14380565894,0.0,2105.646510797309,2105.646510797309,2266954.433348799,700.0,634900.0,784.4950239431748,1136167.1454013088,0.0,112785.48941923292,0.0,0.0,1321.151486854134,1015884.8120122056,0.0,2116.9865160502472,-2105.646510797309,-4078949.328336656,true,true,11.71263803,9012.159685183988,0.0,1644.2724500334996,907.0,11.71263803,9012.159685183988,0.0,121.92,0.0 -908,24856.453155196923,24156.453155196923,0.12,0.0,4661656.375241892,700.0,635600.0,5833.333333333334,19454325.435083695,5833.333333333334,14792669.059841821,true,908.0,908,0.875,0.0,0.0,0.0,0.0,0.0,908,24156.453155196923,0.0,-531.6039743088604,-531.6039743088604,2266422.8293744903,700.0,635600.0,771.09786723211,1136938.2432685408,-2568.086435805657,110217.40298342727,0.0,0.0,1313.5876422334177,1017198.3996544391,-48.20304796873122,2068.783468081516,-0.0,-4078949.328336656,true,true,11.57852385,9023.738209033987,0.0,1644.2724500334996,908.0,11.57852385,9023.738209033987,0.0,121.92,0.0 -909,22450.0,21750.0,0.12,0.0,4661656.375241892,700.0,636300.0,5833.333333333334,19460158.768417027,5833.333333333334,14798502.393175155,true,909.0,909,0.875,0.0,0.0,0.0,0.0,0.0,909,21750.0,0.0,-542.9366434770149,-542.9366434770149,2265879.8927310132,700.0,636300.0,744.7628731337587,1137683.0061416745,-2538.5115431247573,107678.89144030251,0.0,0.0,1298.4599529919853,1018496.8596074311,-47.64792647800159,2021.1355416035142,-0.0,-4078949.328336656,true,true,11.44440967,9035.182618703988,0.0,1644.2724500334996,909.0,11.44440967,9035.182618703988,0.0,121.92,0.0 -910,22450.0,21750.0,0.1792,2311.6792885770324,4663968.05453047,700.0,637000.0,16806.24603000576,19476965.014447033,14494.566741428729,14812996.959916584,true,910.0,910,0.875,2022.7193775049032,2311.6792885770324,288.9599110721292,0.0,0.0,910,21750.0,0.0,2022.7193775049032,2022.7193775049032,2267902.6121085184,700.0,637000.0,731.823269133634,1138414.8294108082,0.0,107678.89144030251,0.0,0.0,1290.896108371269,1019787.7557158024,0.0,2021.1355416035142,-2022.7193775049032,-4080972.047714161,true,true,11.44440967,9046.627028373989,0.0,1644.2724500334996,910.0,11.44440967,9046.627028373989,0.0,121.92,0.0 -911,24761.679288577034,24061.679288577034,0.23500000000000001,5290.722623689718,4669258.77715416,700.0,637700.0,25492.436696551988,19502457.451143585,20201.71407286227,14833198.673989447,true,911.0,911,0.875,4629.382295728503,5290.722623689718,661.3403279612148,0.0,0.0,911,24061.679288577034,0.0,4629.382295728503,4629.382295728503,2272531.994404247,700.0,637700.0,744.7628731337587,1139159.5922839418,2538.5115431247573,110217.40298342727,0.0,0.0,1298.4599529919853,1021086.2156687945,47.64792647800159,2068.783468081516,-4629.382295728503,-4085601.43000989,true,true,11.57852385,9058.205552223988,0.0,1644.2724500334996,911.0,11.57852385,9058.205552223988,0.0,121.92,0.0 -912,27740.72262368972,27040.72262368972,0.16,1361.7999746315206,4670620.577128791,700.0,638400.0,12886.249841447005,19515343.700985033,11524.449866815485,14844723.123856263,true,912.0,912,0.875,1191.5749778025806,1361.7999746315206,170.22499682894,0.0,0.0,912,27040.72262368972,0.0,1191.5749778025806,1191.5749778025806,2273723.5693820496,700.0,638400.0,753.4734622071352,1139913.065746149,-849.4566767774891,109367.94630664977,0.0,0.0,1303.5025158844676,1022389.7181846789,-15.944323511532993,2052.8391445699826,-1191.5749778025806,-4086793.0049876925,true,true,11.53381912,9069.739371343989,0.0,1644.2724500334996,912.0,11.53381912,9069.739371343989,0.0,121.92,0.0 -913,23811.79997463152,23111.79997463152,0.12,0.0,4670620.577128791,700.0,639100.0,5833.333333333334,19521177.034318365,5833.333333333334,14850556.457189597,true,913.0,913,0.875,0.0,0.0,0.0,0.0,0.0,913,23111.79997463152,0.0,-546.5788726751621,-546.5788726751621,2273176.9905093745,700.0,639100.0,736.1196770615325,1140649.1854232105,-2528.6530573871983,106839.29324926257,0.0,0.0,1293.417390099503,1023683.1355747784,-47.46288244899939,2005.3762621209833,-0.0,-4086793.0049876925,true,true,11.39970495,9081.139076293988,0.0,1644.2724500334996,913.0,11.39970495,9081.139076293988,0.0,121.92,0.0 -914,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,639800.0,5833.333333333334,19527010.367651697,5833.333333333334,14856389.790522931,true,914.0,914,0.875,0.0,0.0,0.0,0.0,0.0,914,21750.0,0.0,-5598.745019824338,-5598.745019824338,2267578.2454895503,700.0,639800.0,685.6610973104235,1141334.846520521,-7408.510204191812,99430.78304507076,0.0,0.0,1263.1620127446092,1024946.297587523,-139.05792568755868,1866.3183364334245,-0.0,-4086793.0049876925,true,true,10.99736242,9092.136438713987,0.0,1644.2724500334996,914.0,10.99736242,9092.136438713987,0.0,121.92,0.0 -915,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,640500.0,5833.333333333334,19532843.70098503,5833.333333333334,14862223.123856265,true,915.0,915,0.875,0.0,0.0,0.0,0.0,0.0,915,21750.0,0.0,-7037.032955429962,-7037.032955429962,2260541.2125341203,700.0,640500.0,606.7804233765929,1141941.6269438977,-8693.374893353921,90737.40815171684,0.0,0.0,1212.7363832558005,1026159.0339707788,-163.17486870843518,1703.1434677249893,-0.0,-4086793.0049876925,true,true,10.50561044,9102.642049153987,0.0,1644.2724500334996,915.0,10.50561044,9102.642049153987,0.0,121.92,0.0 -916,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,641200.0,5833.333333333334,19538677.03431836,5833.333333333334,14868056.457189599,true,916.0,916,0.875,0.0,0.0,0.0,0.0,0.0,916,21750.0,0.0,-8271.943117013,-8271.943117013,2252269.269417107,700.0,641200.0,520.4091594953464,1142462.036103393,-9761.35698488172,80976.05116683512,0.0,0.0,1152.2256282076216,1027311.2595989865,-183.22091983424627,1519.9225478907429,-0.0,-4086793.0049876925,true,true,9.924449014,9112.566498167987,0.0,1644.2724500334996,916.0,9.924449014,9112.566498167987,0.0,121.92,0.0 -917,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,641900.0,5833.333333333334,19544510.367651694,5833.333333333334,14873889.790522933,true,917.0,917,0.875,0.0,0.0,0.0,0.0,0.0,917,21750.0,0.0,-2836.498930106017,-2836.498930106017,2249432.770487001,700.0,641900.0,458.16157526439224,1142920.1976786572,-4317.934053555459,76658.11711327966,0.0,0.0,1104.3212806162423,1028415.5808796027,-81.04773243119234,1438.8748154595505,-0.0,-4086793.0049876925,true,true,9.656220663,9122.222718830988,0.0,1644.2724500334996,917.0,9.656220663,9122.222718830988,0.0,121.92,0.0 -918,22450.0,21750.0,0.16720000000000002,1747.1809794496635,4672367.758108241,700.0,642600.0,14636.249877091288,19559146.617528785,12889.068897641624,14886778.859420575,true,918.0,918,0.875,1528.7833570184555,1747.1809794496635,218.397622431208,0.0,0.0,918,21750.0,0.0,1528.7833570184555,1528.7833570184555,2250961.55384402,700.0,642600.0,439.5897651360588,1143359.7874437934,0.0,76658.11711327966,0.0,0.0,1089.1935918823967,1029504.774471485,0.0,1438.8748154595505,-1528.7833570184555,-4088321.788344711,true,true,9.656220663,9131.878939493989,0.0,1644.2724500334996,918.0,9.656220663,9131.878939493989,0.0,121.92,0.0 -919,24197.180979449662,23497.180979449662,0.184,2581.8955400231557,4674949.653648264,700.0,643300.0,17836.388804473674,19576983.006333258,15254.493264450519,14902033.352685025,true,919.0,919,0.875,2259.158597520261,2581.8955400231557,322.73694250289464,0.0,0.0,919,23497.180979449662,0.0,2259.158597520261,2259.158597520261,2253220.71244154,700.0,643300.0,442.64954372159184,1143802.436987515,711.4404255184759,77369.55753879814,0.0,0.0,1091.714873328638,1030596.4893448137,13.353754951555224,1452.2285704111057,-2259.158597520261,-4090580.946942231,true,true,9.700925388,9141.57986488199,0.0,1644.2724500334996,919.0,9.700925388,9141.57986488199,0.0,121.92,0.0 -920,25031.895540023157,24331.895540023157,0.29250000000000004,9445.436945678564,4684395.090593942,700.0,644000.0,34685.25451514039,19611668.2608484,25239.817569461826,14927273.170254488,true,920.0,920,0.875,8264.757327468744,9445.436945678564,1180.6796182098205,0.0,0.0,920,24331.895540023157,0.0,8264.757327468744,8264.757327468744,2261485.4697690085,700.0,644000.0,474.0318369571718,1144276.4688244723,6550.838398332325,83920.39593713047,0.0,0.0,1116.9276881858395,1031713.4170329996,122.95940399340795,1575.1879744045136,-8264.757327468744,-4098845.7042696998,true,true,10.10326792,9151.683132801989,0.0,1644.2724500334996,920.0,10.10326792,9151.683132801989,0.0,121.92,0.0 -921,31895.436945678564,31195.436945678564,0.29250000000000004,8971.918180895844,4693367.008774838,700.0,644700.0,33066.38694323365,19644734.64779163,24094.468762337805,14951367.639016826,true,921.0,921,0.875,7850.428408283863,8971.918180895844,1121.4897726119807,0.0,0.0,921,31195.436945678564,0.0,7850.428408283863,7850.428408283863,2269335.898177292,700.0,644700.0,530.7253440629648,1144807.1941685353,6046.422093972408,89966.81803110287,0.0,0.0,1159.7894731667288,1032873.2065061663,113.49149708176121,1688.679471486275,-7850.428408283863,-4106696.1326779835,true,true,10.46090572,9162.144038521988,0.0,1644.2724500334996,921.0,10.46090572,9162.144038521988,0.0,121.92,0.0 -922,31421.918180895846,30721.918180895846,0.28,7470.059383160823,4700837.068157999,700.0,645400.0,29178.78351128865,19673913.43130292,21708.724128127826,14973076.363144953,true,922.0,922,0.875,6536.3019602657205,7470.059383160823,933.7574228951025,0.0,0.0,922,30721.918180895846,0.0,6536.3019602657205,6536.3019602657205,2275872.200137558,700.0,645400.0,580.6726312441465,1145387.8667997795,4672.832726032571,94639.65075713545,0.0,0.0,1195.0874134141052,1034068.2939195804,87.70918957489839,1776.3886610611733,-6536.3019602657205,-4113232.434638249,true,true,10.72913407,9172.873172591988,0.0,1644.2724500334996,922.0,10.72913407,9172.873172591988,0.0,121.92,0.0 -923,29920.059383160824,29220.059383160824,0.20800000000000002,3930.811421135484,4704767.879579134,700.0,646100.0,22263.51644776675,19696176.947750688,18332.705026631265,14991409.068171585,true,923.0,923,0.875,3439.4599934935486,3930.811421135484,491.3514276419355,0.0,0.0,923,29220.059383160824,0.0,3439.4599934935486,3439.4599934935486,2279311.6601310517,700.0,646100.0,610.5727904847815,1145998.4395902643,1583.8997002114656,96223.55045734691,0.0,0.0,1215.2576649840344,1035283.5515845645,29.72983781326655,1806.1184988744399,-3439.4599934935486,-4116671.894631743,true,true,10.81854352,9183.691716111987,0.0,1644.2724500334996,923.0,10.81854352,9183.691716111987,0.0,121.92,0.0 -924,26380.811421135484,25680.811421135484,0.20800000000000002,3975.1585327045427,4708743.0381118385,700.0,646800.0,22476.723714925687,19718653.671465613,18501.565182221144,15009910.633353807,true,924.0,924,0.875,3478.263716116475,3975.1585327045427,496.8948165880679,0.0,0.0,924,25680.811421135484,0.0,3478.263716116475,3478.263716116475,2282789.923847168,700.0,646800.0,625.9002709116227,1146624.339861176,1597.0440959784364,97820.59455332534,0.0,0.0,1225.342790768999,1036508.8943753334,29.976558457416758,1836.0950573318567,-3478.263716116475,-4120150.1583478595,true,true,10.90795297,9194.599669081987,0.0,1644.2724500334996,924.0,10.90795297,9194.599669081987,0.0,121.92,0.0 -925,26425.158532704543,25725.158532704543,0.265,6882.818717386428,4715625.856829225,700.0,647500.0,28614.410254288407,19747268.0817199,21731.59153690198,15031642.224890709,true,925.0,925,0.875,6022.4663777131245,6882.818717386428,860.3523396733035,0.0,0.0,925,25725.158532704543,0.0,6022.4663777131245,6022.4663777131245,2288812.3902248815,700.0,647500.0,653.3367529164735,1147277.6766140924,4050.1170629425164,101870.71161626786,0.0,0.0,1242.9917611746798,1037751.8861365081,76.02080067945532,1912.115858011312,-6022.4663777131245,-4126172.6247255728,true,true,11.1314766,9205.731145681986,0.0,1644.2724500334996,925.0,11.1314766,9205.731145681986,0.0,121.92,0.0 -926,29332.818717386428,28632.818717386428,0.20800000000000002,4132.678658962306,4719758.535488187,700.0,648200.0,23234.032014241853,19770502.113734145,19101.35335527955,15050743.578245988,true,926.0,926,0.875,3616.0938265920176,4132.678658962306,516.5848323702885,0.0,0.0,926,28632.818717386428,0.0,3616.0938265920176,3616.0938265920176,2292428.4840514734,700.0,648200.0,681.5635323879594,1147959.2401464805,1643.049481897957,103513.76109816582,0.0,0.0,1260.6407315803606,1039012.5268680884,30.840080725740645,1942.9559387370525,-3616.0938265920176,-4129788.7185521647,true,true,11.22088605,9216.952031731986,0.0,1644.2724500334996,926.0,11.22088605,9216.952031731986,0.0,121.92,0.0 -927,26582.678658962308,25882.678658962308,0.1936,3204.658700285793,4722963.194188473,700.0,648900.0,20168.69163370761,19790670.805367853,16964.03293342182,15067707.61117941,true,927.0,927,0.875,2804.076362750069,3204.658700285793,400.58233753572404,0.0,0.0,927,25882.678658962308,0.0,2804.076362750069,2804.076362750069,2295232.5604142235,700.0,648900.0,693.905431503963,1148653.1455779844,826.4537967430404,104340.21489490886,0.0,0.0,1268.2045756370915,1040280.7314437255,15.512558865974277,1958.468497603027,-2804.076362750069,-4132592.7949149148,true,true,11.26559077,9228.217622501985,0.0,1644.2724500334996,927.0,11.26559077,9228.217622501985,0.0,121.92,0.0 -928,25654.658700285792,24954.658700285792,0.196,3223.7452003790268,4726186.939388852,700.0,649600.0,20019.108165199115,19810689.913533054,16795.362964820088,15084502.97414423,true,928.0,928,0.875,2820.7770503316483,3223.7452003790268,402.96815004737846,0.0,0.0,928,24954.658700285792,0.0,2820.7770503316483,2820.7770503316483,2298053.337464555,700.0,649600.0,702.2155883763056,1149355.3611663608,829.7400809218527,105169.95497583071,0.0,0.0,1273.2471385295737,1041553.9785822551,15.574242503915828,1974.0427401069428,-2820.7770503316483,-4135413.5719652465,true,true,11.3102955,9239.527918001984,0.0,1644.2724500334996,928.0,11.3102955,9239.527918001984,0.0,121.92,0.0 -929,25673.745200379028,24973.745200379028,0.20800000000000002,4224.328677473436,4730411.268066325,700.0,650300.0,23674.65710323767,19834364.57063629,19450.328425764234,15103953.302569995,true,929.0,929,0.875,3696.2875927892565,4224.328677473436,528.0410846841796,0.0,0.0,929,24973.745200379028,0.0,3696.2875927892565,3696.2875927892565,2301749.6250573443,700.0,650300.0,714.8048141930619,1150070.165980554,1669.338273431864,106839.29324926257,0.0,0.0,1280.81098315029,1042834.7895654053,31.333522014040316,2005.376262120983,-3696.2875927892565,-4139109.8595580356,true,true,11.39970495,9250.927622951984,0.0,1644.2724500334996,929.0,11.39970495,9250.927622951984,0.0,121.92,0.0 -930,26674.328677473437,25974.328677473437,0.12,0.0,4730411.268066325,700.0,651000.0,5833.333333333334,19840197.903969623,5833.333333333334,15109786.635903329,true,930.0,930,0.875,0.0,0.0,0.0,0.0,0.0,930,25974.328677473437,0.0,-557.1045878017741,-557.1045878017741,2301192.5204695426,700.0,651000.0,710.5918296478429,1150780.7578102017,-2499.078354353717,104340.21489490886,0.0,0.0,1278.289701422056,1044113.0792668274,-46.907764517956146,1958.468497603027,-0.0,-4139109.8595580356,true,true,11.26559077,9262.193213721983,0.0,1644.2724500334996,930.0,11.26559077,9262.193213721983,0.0,121.92,0.0 -931,22450.0,21750.0,0.128,314.1408300540935,4730725.408896379,700.0,651700.0,7922.9752347976055,19848120.879204422,7608.834404743512,15117395.470308073,true,931.0,931,0.875,274.8732262973318,314.1408300540935,39.26760375676167,0.0,0.0,931,21750.0,0.0,274.8732262973318,274.8732262973318,2301467.39369584,700.0,651700.0,689.7750524688241,1151470.5328626705,-1649.621679046332,102690.59321586252,0.0,0.0,1265.6832939088576,1045378.7625607363,-30.96344103401797,1927.505056569009,-274.8732262973318,-4139384.732784333,true,true,11.17618132,9273.369395041982,0.0,1644.2724500334996,931.0,11.17618132,9273.369395041982,0.0,121.92,0.0 -932,22764.140830054093,22064.140830054093,0.1768,2219.6620142738066,4732945.070910653,700.0,652400.0,16513.925420100713,19864634.804624524,14294.263405826907,15131689.7337139,true,932.0,932,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,932,22064.140830054093,0.0,1942.2042624895807,1942.2042624895807,2303409.5979583296,700.0,652400.0,681.5635314732057,1152152.0963941438,0.0,102690.59321586252,0.0,0.0,1260.6407310163752,1046639.4032917527,0.0,1927.505056569009,-1942.2042624895807,-4141326.9370468226,true,true,11.17618132,9284.545576361981,0.0,1644.2724500334996,932.0,11.17618132,9284.545576361981,0.0,121.92,0.0 -933,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,4735164.732924927,700.0,653100.0,16513.925420100713,19881148.730044626,14294.263405826907,15145983.997119728,true,933.0,933,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,933,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,2305351.802220819,700.0,653100.0,681.5635314732057,1152833.659925617,0.0,102690.59321586252,0.0,0.0,1260.6407310163752,1047900.0440227691,0.0,1927.505056569009,-1942.2042624895807,-4143269.141309312,true,true,11.17618132,9295.72175768198,0.0,1644.2724500334996,933.0,11.17618132,9295.72175768198,0.0,121.92,0.0 -934,24669.662014273807,23969.662014273807,0.12,0.0,4735164.732924927,700.0,653800.0,5833.333333333334,19886982.063377958,5833.333333333334,15151817.330453062,true,934.0,934,0.875,0.0,0.0,0.0,0.0,0.0,934,23969.662014273807,0.0,-573.3235073270697,-573.3235073270697,2304778.478713492,700.0,653800.0,669.368850078189,1153503.0287756952,-2449.7866857256167,100240.8065301369,0.0,0.0,1253.0768869596443,1049153.1209097288,-45.98255863928627,1881.5224979297227,-0.0,-4143269.141309312,true,true,11.04206715,9306.76382483198,0.0,1644.2724500334996,934.0,11.04206715,9306.76382483198,0.0,121.92,0.0 -935,22450.0,21750.0,0.128,277.40832270123127,4735442.141247628,700.0,654500.0,7636.00252110337,19894618.065899063,7358.594198402138,15159175.924651464,true,935.0,935,0.875,242.73228236357738,277.40832270123127,34.67604033765389,0.0,0.0,935,21750.0,0.0,242.73228236357738,242.73228236357738,2305021.2109958557,700.0,654500.0,649.3691321545542,1154152.3979078499,-1616.7606903639685,98624.04583977294,0.0,0.0,1240.4704800104312,1050393.5913897392,-30.346639437439478,1851.1758584922832,-242.73228236357738,-4143511.873591676,true,true,10.9526577,9317.71648253198,0.0,1644.2724500334996,935.0,10.9526577,9317.71648253198,0.0,121.92,0.0 -936,22727.40832270123,22027.40832270123,0.128,263.23247891953673,4735705.373726548,700.0,655200.0,7525.253741558881,19902143.31964062,7262.021262639345,15166437.945914105,true,936.0,936,0.875,230.32841905459463,263.23247891953673,32.9040598649421,0.0,0.0,936,22027.40832270123,0.0,230.32841905459463,230.32841905459463,2305251.53941491,700.0,655200.0,633.6592782194152,1154786.0571860692,-1603.6162945969975,97020.42954517594,0.0,0.0,1230.385354225467,1051623.9767439647,-30.099918793290016,1821.0759396989931,-230.32841905459463,-4143742.2020107303,true,true,10.86324825,9328.57973078198,0.0,1644.2724500334996,936.0,10.86324825,9328.57973078198,0.0,121.92,0.0 -937,22713.232478919537,22013.232478919537,0.1744,2115.7063578386874,4737821.080084386,700.0,655900.0,16145.10526283651,19918288.42490346,14029.398904997823,15180467.344819102,true,937.0,937,0.875,1851.2430631088514,2115.7063578386874,264.463294729836,0.0,0.0,937,22013.232478919537,0.0,1851.2430631088514,1851.2430631088514,2307102.782478019,700.0,655900.0,625.9002717758669,1155411.957457845,0.0,97020.42954517594,0.0,0.0,1225.3427913329845,1052849.3195352978,0.0,1821.0759396989931,-1851.2430631088514,-4145593.4450738393,true,true,10.86324825,9339.44297903198,0.0,1644.2724500334996,937.0,10.86324825,9339.44297903198,0.0,121.92,0.0 -938,24565.706357838688,23865.706357838688,0.20800000000000002,3997.440966668765,4741818.521051055,700.0,656600.0,22583.850801292137,19940872.275704753,18586.409834623373,15199053.754653726,true,938.0,938,0.875,3497.7608458351697,3997.440966668765,499.68012083359554,0.0,0.0,938,23865.706357838688,0.0,3497.7608458351697,3497.7608458351697,2310600.5433238545,700.0,656600.0,633.6592782194152,1156045.6167360644,1603.6162945969975,98624.04583977294,0.0,0.0,1230.385354225467,1054079.7048895233,30.099918793290016,1851.1758584922832,-3497.7608458351697,-4149091.2059196746,true,true,10.9526577,9350.395636731979,0.0,1644.2724500334996,938.0,10.9526577,9350.395636731979,0.0,121.92,0.0 -939,26447.440966668764,25747.440966668764,0.265,6916.835784951069,4748735.356836006,700.0,657300.0,28742.776546985166,19969615.052251738,21825.940762034097,15220879.69541576,true,939.0,939,0.875,6052.231311832185,6916.835784951069,864.604473118884,0.0,0.0,939,25747.440966668764,0.0,6052.231311832185,6052.231311832185,2316652.7746356865,700.0,657300.0,661.3204135987122,1156706.9371496632,4066.547376089585,102690.59321586252,0.0,0.0,1248.0343240671623,1055327.7392135905,76.32919807672575,1927.505056569009,-6052.231311832185,-4155143.4372315067,true,true,11.17618132,9361.571818051978,0.0,1644.2724500334996,939.0,11.17618132,9361.571818051978,0.0,121.92,0.0 -940,29366.83578495107,28666.83578495107,0.1768,2219.6620142738066,4750955.01885028,700.0,658000.0,16513.925420100713,19986128.97767184,14294.263405826907,15235173.958821587,true,940.0,940,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,940,28666.83578495107,0.0,1942.2042624895807,1942.2042624895807,2318594.978898176,700.0,658000.0,681.5635314732057,1157388.5006811365,0.0,102690.59321586252,0.0,0.0,1260.6407310163752,1056588.379944607,0.0,1927.505056569009,-1942.2042624895807,-4157085.641493996,true,true,11.17618132,9372.747999371977,0.0,1644.2724500334996,940.0,11.17618132,9372.747999371977,0.0,121.92,0.0 -941,24669.662014273807,23969.662014273807,0.12,0.0,4750955.01885028,700.0,658700.0,5833.333333333334,19991962.31100517,5833.333333333334,15241007.292154921,true,941.0,941,0.875,0.0,0.0,0.0,0.0,0.0,941,23969.662014273807,0.0,-1405.1047676397538,-1405.1047676397538,2317189.8741305363,700.0,658700.0,665.3365180561832,1158053.8371991927,-3259.8101707917626,99430.78304507076,0.0,0.0,1250.5556052314105,1057838.9355498382,-61.18672013558456,1866.3183364334243,-0.0,-4157085.641493996,true,true,10.99736242,9383.745361791976,0.0,1644.2724500334996,941.0,10.99736242,9383.745361791976,0.0,121.92,0.0 -942,22450.0,21750.0,0.1744,2159.816697960325,4753114.835548241,700.0,659400.0,16398.031525001865,20008360.342530172,14238.21482704154,15255245.506981963,true,942.0,942,0.875,1889.8396107152846,2159.816697960325,269.9770872450406,0.0,0.0,942,21750.0,0.0,1889.8396107152846,1889.8396107152846,2319079.7137412517,700.0,659400.0,649.3691312688386,1158703.2063304617,0.0,99430.78304507076,0.0,0.0,1240.470479446446,1059079.4060292847,0.0,1866.3183364334243,-1889.8396107152846,-4158975.4811047115,true,true,10.99736242,9394.742724211976,0.0,1644.2724500334996,942.0,10.99736242,9394.742724211976,0.0,121.92,0.0 -943,24609.816697960327,23909.816697960327,0.12,0.0,4753114.835548241,700.0,660100.0,5833.333333333334,20014193.675863504,5833.333333333334,15261078.840315297,true,943.0,943,0.875,0.0,0.0,0.0,0.0,0.0,943,23909.816697960327,0.0,-2218.2852945700915,-2218.2852945700915,2316861.4284466817,700.0,660100.0,629.7718075814728,1159332.978138043,-4000.8255758761084,95429.95746919465,0.0,0.0,1227.8640719332475,1060307.270101218,-75.0955982087037,1791.2227382247206,-0.0,-4158975.4811047115,true,true,10.77383879,9405.516563001976,0.0,1644.2724500334996,943.0,10.77383879,9405.516563001976,0.0,121.92,0.0 -944,22450.0,21750.0,0.25,5834.610917173108,4758949.446465414,700.0,660800.0,26138.44366869243,20040332.119532198,20303.832751519323,15281382.673066817,true,944.0,944,0.875,5105.284552526469,5834.610917173108,729.3263646466385,0.0,0.0,944,21750.0,0.0,5105.284552526469,5105.284552526469,2321966.7129992084,700.0,660800.0,625.9002709116223,1159958.8784089547,3194.088370578286,98624.04583977294,0.0,0.0,1225.3427907689988,1061532.612891987,59.953120267562525,1851.1758584922832,-5105.284552526469,-4164080.765657238,true,true,10.9526577,9416.469220701976,0.0,1644.2724500334996,944.0,10.9526577,9416.469220701976,0.0,121.92,0.0 -945,28284.610917173108,27584.610917173108,0.28625,7882.728529587887,4766832.174995002,700.0,661500.0,29983.331107730606,20070315.45063993,22100.60257814272,15303483.27564496,true,945.0,945,0.875,6897.387463389401,7882.728529587887,985.3410661984863,0.0,0.0,945,27584.610917173108,0.0,6897.387463389401,6897.387463389401,2328864.100462598,700.0,661500.0,665.3365189563594,1160624.214927911,4889.715258392876,103513.76109816582,0.0,0.0,1250.555605795396,1062783.1684977824,91.78008024476944,1942.9559387370525,-6897.387463389401,-4170978.1531206276,true,true,11.22088605,9427.690106751976,0.0,1644.2724500334996,945.0,11.22088605,9427.690106751976,0.0,121.92,0.0 -946,30332.728529587886,29632.728529587886,0.265,7122.504544083483,4773954.679539085,700.0,662200.0,29518.88507201314,20099834.33571194,22396.380527929658,15325879.65617289,true,946.0,946,0.875,6232.191476073048,7122.504544083483,890.313068010435,0.0,0.0,946,29632.728529587886,0.0,6232.191476073048,6232.191476073048,2335096.291938671,700.0,662200.0,710.5918296478434,1161334.8067575588,4165.130342136687,107678.89144030251,0.0,0.0,1278.2897014220562,1064061.4581992044,78.17960286646121,2021.1355416035137,-6232.191476073048,-4177210.3445967007,true,true,11.44440967,9439.134516421977,0.0,1644.2724500334996,946.0,11.44440967,9439.134516421977,0.0,121.92,0.0 -947,29572.504544083484,28872.504544083484,0.12,0.0,4773954.679539085,700.0,662900.0,5833.333333333334,20105667.669045273,5833.333333333334,15331712.989506224,true,947.0,947,0.875,0.0,0.0,0.0,0.0,0.0,947,28872.504544083484,0.0,-2254.428413933249,-2254.428413933249,2332841.863524738,700.0,662900.0,710.5918296478434,1162045.3985872066,-4165.130342136687,103513.76109816582,0.0,0.0,1278.2897014220562,1065339.7479006264,-78.17960286646121,1942.9559387370525,-0.0,-4177210.3445967007,true,true,11.22088605,9450.355402471976,0.0,1644.2724500334996,947.0,11.22088605,9450.355402471976,0.0,121.92,0.0 -948,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,663600.0,5833.333333333334,20111501.002378605,5833.333333333334,15337546.322839558,true,948.0,948,0.875,0.0,0.0,0.0,0.0,0.0,948,21750.0,0.0,-7157.310814112974,-7157.310814112974,2325684.552710625,700.0,663600.0,645.4176063110826,1162690.8161935178,-8874.110341030375,94639.65075713545,0.0,0.0,1237.9491982821976,1066577.6970989085,-166.56727767587927,1776.3886610611733,-0.0,-4177210.3445967007,true,true,10.72913407,9461.084536541975,0.0,1644.2724500334996,948.0,10.72913407,9461.084536541975,0.0,121.92,0.0 -949,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,664300.0,5833.333333333334,20117334.335711937,5833.333333333334,15343379.656172892,true,949.0,949,0.875,0.0,0.0,0.0,0.0,0.0,949,21750.0,0.0,-13709.26926005884,-13709.26926005884,2311975.283450566,700.0,664300.0,530.7253435984163,1163221.5415371163,-15116.055331959957,79523.59542517549,0.0,0.0,1159.7894728283377,1067737.4865717369,-283.7287445256381,1492.659916535535,-0.0,-4177210.3445967007,true,true,9.835039564,9470.919576105976,0.0,1644.2724500334996,949.0,9.835039564,9470.919576105976,0.0,121.92,0.0 -950,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,665000.0,5833.333333333334,20123167.66904527,5833.333333333334,15349212.989506226,true,950.0,950,0.875,0.0,0.0,0.0,0.0,0.0,950,21750.0,0.0,-11921.125432595825,-11921.125432595825,2300054.1580179706,700.0,665000.0,406.8577746052386,1163628.3993117216,-13142.75289553779,66380.8425296377,0.0,0.0,1061.4594957481497,1068798.946067485,-246.68980741142406,1245.970109124111,-0.0,-4177210.3445967007,true,true,8.985649783,9479.905225888977,0.0,1644.2724500334996,950.0,8.985649783,9479.905225888977,0.0,121.92,0.0 -951,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,665700.0,5833.333333333334,20129001.0023786,5833.333333333334,15355046.32283956,true,951.0,951,0.875,0.0,0.0,0.0,0.0,0.0,951,21750.0,0.0,-18609.792499565556,-18609.792499565556,2281444.365518405,700.0,665700.0,276.1859006480107,1163904.5852123697,-19453.70598335574,46927.13654628195,0.0,0.0,932.8741411438726,1069731.820208629,-365.14655800169936,880.8235511224118,-0.0,-4177210.3445967007,true,true,7.555098574,9487.460324462976,0.0,1644.2724500334996,951.0,7.555098574,9487.460324462976,0.0,121.92,0.0 -952,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,666400.0,5833.333333333334,20134834.335711934,5833.333333333334,15360879.656172894,true,952.0,952,0.875,0.0,0.0,0.0,0.0,0.0,952,21750.0,0.0,-15924.005739591918,-15924.005739591918,2265520.359778813,700.0,666400.0,154.70197202581846,1164059.2871843956,-16537.293143155388,30389.843403126564,0.0,0.0,768.9908460666251,1070500.8110546956,-310.40541452897276,570.418136593439,-0.0,-4177210.3445967007,true,true,6.079842639,9493.540167101975,0.0,1644.2724500334996,952.0,6.079842639,9493.540167101975,0.0,121.92,0.0 -953,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,667100.0,5833.333333333334,20140667.669045266,5833.333333333334,15366712.989506228,true,953.0,953,0.875,0.0,0.0,0.0,0.0,0.0,953,21750.0,0.0,-12524.943587030239,-12524.943587030239,2252995.416191783,700.0,667100.0,74.4372010436826,1164133.7243854392,-12958.73133951072,17431.112063615845,0.0,0.0,602.5862695431363,1071103.3973242387,-243.23571810633786,327.1824184871012,-0.0,-4177210.3445967007,true,true,4.604586705,9498.144753806975,0.0,1644.2724500334996,953.0,4.604586705,9498.144753806975,0.0,121.92,0.0 -954,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,667800.0,5833.333333333334,20146501.002378598,5833.333333333334,15372546.322839562,true,954.0,954,0.875,0.0,0.0,0.0,0.0,0.0,954,21750.0,0.0,-9091.822337742968,-9091.822337742968,2243903.59385404,700.0,667800.0,28.23154468499448,1164161.9559301243,-9380.169553434154,8050.9425101816905,0.0,0.0,436.1816930196476,1071539.5790172582,-176.06602201345643,151.11639647364476,-0.0,-4177210.3445967007,true,true,3.12933077,9501.274084576975,0.0,1644.2724500334996,954.0,3.12933077,9501.274084576975,0.0,121.92,0.0 -955,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,668500.0,5833.333333333334,20152334.33571193,5833.333333333334,15378379.656172896,true,955.0,955,0.875,0.0,0.0,0.0,0.0,0.0,955,21750.0,0.0,-5634.047406756002,-5634.047406756002,2238269.546447284,700.0,668500.0,6.679557070649019,1164168.6354871949,-5801.607754640927,2249.3347555407636,0.0,0.0,269.7771164961588,1071809.3561337544,-108.89632568188298,42.22007079176177,-0.0,-4177210.3445967007,true,true,1.654074836,9502.928159412975,0.0,1644.2724500334996,955.0,1.654074836,9502.928159412975,0.0,121.92,0.0 -956,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,669200.0,5833.333333333334,20158167.669045262,5833.333333333334,15384212.98950623,true,956.0,956,0.875,0.0,0.0,0.0,0.0,0.0,956,21750.0,0.0,-2161.024260916646,-2161.024260916646,2236108.5221863673,700.0,669200.0,0.3757923215411603,1164169.0112795164,-2223.0459637129175,26.288791827846126,0.0,0.0,103.37253997267001,1071912.728673727,-41.72662949793998,0.4934412938217889,-0.0,-4177210.3445967007,true,true,0.178818901,9503.106978313976,0.0,1644.2724500334996,956.0,0.178818901,9503.106978313976,0.0,121.92,0.0 -957,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,669900.0,5833.333333333334,20164001.002378594,5833.333333333334,15390046.322839564,true,957.0,957,0.875,0.0,0.0,0.0,0.0,0.0,957,21750.0,0.0,-16.69675831990641,-16.69675831990641,2236091.825428047,700.0,669900.0,0.0003489605274117505,1164169.011628477,-26.2887918279776,-1.3147527511137014e-10,0.0,0.0,10.085125841363176,1071922.8137995685,-0.49344129381939833,2.3905877277741183e-12,-0.0,-4177210.3445967007,true,true,0.0,9503.106978313976,0.0,1644.2724500334996,957.0,0.0,9503.106978313976,0.0,121.92,0.0 -958,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,670600.0,5833.333333333334,20169834.335711926,5833.333333333334,15395879.656172898,true,958.0,958,0.875,0.0,0.0,0.0,0.0,0.0,958,21750.0,0.0,0.0,0.0,2236091.825428047,700.0,670600.0,0.0,1164169.011628477,0.0,-1.3147527511137014e-10,0.0,0.0,0.0,1071922.8137995685,0.0,2.3905877277741183e-12,-0.0,-4177210.3445967007,true,true,0.0,9503.106978313976,0.0,1644.2724500334996,958.0,0.0,9503.106978313976,0.0,121.92,0.0 -959,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,671300.0,5833.333333333334,20175667.66904526,5833.333333333334,15401712.989506232,true,959.0,959,0.875,0.0,0.0,0.0,0.0,0.0,959,21750.0,0.0,0.0,0.0,2236091.825428047,700.0,671300.0,0.0,1164169.011628477,0.0,-1.3147527511137014e-10,0.0,0.0,0.0,1071922.8137995685,0.0,2.3905877277741183e-12,-0.0,-4177210.3445967007,true,true,0.0,9503.106978313976,0.0,1644.2724500334996,959.0,0.0,9503.106978313976,0.0,121.92,0.0 -960,22450.0,21750.0,0.14400000000000002,822.8858044250761,4774777.56534351,700.0,672000.0,10575.595864063027,20186243.26490932,9752.710059637951,15411465.699565869,true,960.0,960,0.875,720.0250788719416,822.8858044250761,102.86072555313456,0.0,0.0,960,21750.0,0.0,720.0250788719416,720.0250788719416,2236811.850506919,700.0,672000.0,0.043620066072829394,1164169.055248543,657.2197971695749,657.2197971694435,0.0,0.0,50.425629263214425,1071973.2394288317,12.336032373079432,12.336032373081823,-720.0250788719416,-4177930.3696755725,true,true,0.894094506,9504.001072819976,0.0,1644.2724500334996,960.0,0.894094506,9504.001072819976,0.0,121.92,0.0 -961,23272.885804425077,22572.885804425077,0.22,4821.22816572823,4779598.793509238,700.0,672700.0,25096.491662401048,20211339.75657172,20275.26349667282,15431740.963062542,true,961.0,961,0.875,4218.5746450122015,4821.22816572823,602.6535207160287,0.0,0.0,961,22572.885804425077,0.0,4218.5746450122015,4218.5746450122015,2241030.425151931,700.0,672700.0,2.121118403676834,1164171.1763669467,3958.1062249474926,4615.326022116936,0.0,0.0,184.05354675997395,1072157.2929755917,74.29375490105805,86.62978727413987,-4218.5746450122015,-4182148.9443205846,true,true,2.36935044,9506.370423259976,0.0,1644.2724500334996,961.0,2.36935044,9506.370423259976,0.0,121.92,0.0 -962,27271.22816572823,26571.22816572823,0.29250000000000004,9192.266236285755,4788791.059745524,700.0,673400.0,33819.713628327365,20245159.470200047,24627.44739204161,15456368.410454582,true,962.0,962,0.875,8043.232956750036,9192.266236285755,1149.0332795357199,0.0,0.0,962,26571.22816572823,0.0,8043.232956750036,8043.232956750036,2249073.658108681,700.0,673400.0,14.643359766287459,1164185.819726713,7536.66802249111,12151.994044608045,0.0,0.0,350.4581232834627,1072507.7510988752,141.4634512091763,228.09323848331616,-8043.232956750036,-4190192.1772773345,true,true,3.844606375,9510.215029634976,0.0,1644.2724500334996,962.0,3.844606375,9510.215029634976,0.0,121.92,0.0 -963,31642.266236285755,30942.266236285755,0.33,13585.942511002311,4802377.002256527,700.0,674100.0,43290.734881825185,20288450.205081873,29704.792370822874,15486073.202825405,true,963.0,963,0.875,11887.699697127022,13585.942511002311,1698.2428138752894,0.0,0.0,963,30942.266236285755,0.0,11887.699697127022,11887.699697127022,2260961.357805808,700.0,674100.0,46.97404017726804,1164232.7937668902,11115.229809817289,23267.223854425334,0.0,0.0,516.8626998069516,1073024.613798682,208.63314732551282,436.726385808829,-11887.699697127022,-4202079.876974462,true,true,5.319862309,9515.534891943975,0.0,1644.2724500334996,963.0,5.319862309,9515.534891943975,0.0,121.92,0.0 -964,36035.942511002315,35335.942511002315,0.35,18013.006100323655,4820390.008356851,700.0,674800.0,53465.731715210444,20341915.936797082,35452.72561488679,15521525.928440291,true,964.0,964,0.875,15761.3803377832,18013.006100323655,2251.625762540456,0.0,0.0,964,35335.942511002315,0.0,15761.3803377832,15761.3803377832,2276722.738143591,700.0,674800.0,108.51860551572359,1164341.312372406,14693.791612212344,37961.01546663768,0.0,0.0,683.2672763304403,1073707.8810750125,275.80284372469254,712.5292295335215,-15761.3803377832,-4217841.257312245,true,true,6.795118244,9522.330010187974,0.0,1644.2724500334996,964.0,6.795118244,9522.330010187974,0.0,121.92,0.0 -965,40463.006100323655,39763.006100323655,0.33999999999999997,15547.924276893042,4835937.932633744,700.0,675500.0,47788.01257909719,20389703.94937618,32240.088302204145,15553766.016742496,true,965.0,965,0.875,13604.433742281411,15547.924276893042,1943.4905346116302,0.0,0.0,965,39763.006100323655,0.0,13604.433742281411,13604.433742281411,2290327.1718858727,700.0,675500.0,190.65122047223792,1164531.9635928783,12357.375234862255,50318.39070149993,0.0,0.0,824.4590382787204,1074532.3401132913,231.94824866819718,944.4774782017187,-13604.433742281411,-4231445.691054526,true,true,7.823326926,9530.153337113974,0.0,1644.2724500334996,965.0,7.823326926,9530.153337113974,0.0,121.92,0.0 -966,37997.92427689304,37297.92427689304,0.29250000000000004,8929.961319928294,4844867.893953672,700.0,676200.0,32922.94468351553,20422626.894059695,23992.98336358724,15577759.000106083,true,966.0,966,0.875,7813.716154937258,8929.961319928294,1116.2451649910363,0.0,0.0,966,37297.92427689304,0.0,7813.716154937258,7813.716154937258,2298140.88804081,700.0,676200.0,256.5180545519494,1164788.4816474302,6524.549531086411,56842.94023258634,0.0,0.0,910.1826080149052,1075442.5227213062,122.46596128399227,1066.943439485711,-7813.716154937258,-4239259.407209463,true,true,8.315078904,9538.468416017973,0.0,1644.2724500334996,966.0,8.315078904,9538.468416017973,0.0,121.92,0.0 -967,31379.961319928294,30679.961319928294,0.3175,11808.57261478694,4856676.466568459,700.0,676900.0,39397.07910169115,20462023.97316139,27588.50648690421,15605347.506592987,true,967.0,967,0.875,10332.501037938573,11808.57261478694,1476.0715768483678,0.0,0.0,967,30679.961319928294,0.0,10332.501037938573,10332.501037938573,2308473.3890787484,700.0,676900.0,313.58714113416886,1165102.0687885643,8879.039454968335,65721.97968755467,0.0,0.0,973.214644565724,1076415.737365872,166.65979727034525,1233.6032367560563,-10332.501037938573,-4249591.908247402,true,true,8.940945058,9547.409361075974,0.0,1644.2724500334996,967.0,8.940945058,9547.409361075974,0.0,121.92,0.0 -968,34258.57261478694,33558.57261478694,0.30500000000000005,10265.657338911098,4866942.12390737,700.0,677600.0,35952.97488167573,20497976.948043063,25687.317542764627,15631034.824135752,true,968.0,968,0.875,8982.45017154721,10265.657338911098,1283.2071673638875,0.0,0.0,968,33558.57261478694,0.0,8982.45017154721,8982.45017154721,2317455.8392502954,700.0,677600.0,378.5487334126411,1165480.617521977,7428.226751238988,73150.20643879366,0.0,0.0,1036.2466811165427,1077451.9840469884,139.4280057790397,1373.031242535096,-8982.45017154721,-4258574.358418949,true,true,9.432697036,9556.842058111974,0.0,1644.2724500334996,968.0,9.432697036,9556.842058111974,0.0,121.92,0.0 -969,32715.6573389111,32015.6573389111,0.29250000000000004,9161.410388738037,4876103.5342961075,700.0,678300.0,33714.22355124115,20531691.171594303,24552.813162503113,15655587.637298256,true,969.0,969,0.875,8016.234090145782,9161.410388738037,1145.176298592255,0.0,0.0,969,32015.6573389111,0.0,8016.234090145782,8016.234090145782,2325472.073340441,700.0,678300.0,436.54411938377126,1165917.1616413607,6373.388986381814,79523.59542517547,0.0,0.0,1086.6723103797572,1078538.6563573682,119.62867400043929,1492.6599165355353,-8016.234090145782,-4266590.592509095,true,true,9.835039564,9566.677097675974,0.0,1644.2724500334996,969.0,9.835039564,9566.677097675974,0.0,121.92,0.0 -970,31611.410388738037,30911.410388738037,0.30500000000000005,10473.073835350215,4886576.608131458,700.0,679000.0,36633.02896836135,20568324.200562663,26159.955133011135,15681747.592431268,true,970.0,970,0.875,9163.939605931439,10473.073835350215,1309.1342294187762,0.0,0.0,970,30911.410388738037,0.0,9163.939605931439,9163.939605931439,2334636.0129463724,700.0,679000.0,496.85981503672747,1166414.0214563974,7393.722767407227,86917.3181925827,0.0,0.0,1134.5766583659263,1079673.2330157342,138.78036512155848,1631.4402816570937,-9163.939605931439,-4275754.532115026,true,true,10.28208682,9576.959184495974,0.0,1644.2724500334996,970.0,10.28208682,9576.959184495974,0.0,121.92,0.0 -971,32923.07383535022,32223.073835350217,0.33999999999999997,15666.774231948886,4902243.382363407,700.0,679700.0,48137.571270437904,20616461.7718331,32470.797038489018,15714218.389469756,true,971.0,971,0.875,13708.427452955275,15666.774231948886,1958.3467789936112,0.0,0.0,971,32223.073835350217,0.0,13708.427452955275,13708.427452955275,2348344.440399328,700.0,679700.0,584.355533787518,1166998.376990185,11706.727647190228,98624.04583977292,0.0,0.0,1197.608695142339,1080870.8417108767,219.73557683518942,1851.1758584922832,-13708.427452955275,-4289462.959567982,true,true,10.9526577,9587.911842195974,0.0,1644.2724500334996,971.0,10.9526577,9587.911842195974,0.0,121.92,0.0 -972,38116.77423194889,37416.77423194889,0.3516666666666666,19773.327950121813,4922016.710313529,700.0,680400.0,58217.994170962505,20674679.766004063,38444.66622084069,15752663.055690596,true,972.0,972,0.875,17301.661956356587,19773.327950121813,2471.6659937652257,0.0,0.0,972,37416.77423194889,0.0,17301.661956356587,17301.661956356587,2365646.102355684,700.0,680400.0,714.8048141930616,1167713.181804378,15024.04446088687,113648.0903006598,0.0,0.0,1280.8109831502898,1082151.652694027,282.0016981263647,2133.177556618648,-17301.661956356587,-4306764.621524339,true,true,11.75734275,9599.669184945973,0.0,1644.2724500334996,972.0,11.75734275,9599.669184945973,0.0,121.92,0.0 -973,42223.32795012181,41523.32795012181,0.335,14871.028316801328,4936887.73863033,700.0,681100.0,46480.68154269053,20721160.447546754,31609.653225889204,15784272.708916485,true,973.0,973,0.875,13012.149777201163,14871.028316801328,1858.8785396001658,0.0,0.0,973,41523.32795012181,0.0,13012.149777201163,13012.149777201163,2378658.252132885,700.0,681100.0,849.0693394874753,1168562.2511438655,10607.527450105157,124255.61775076496,0.0,0.0,1356.4494265375247,1083508.1021205646,199.10356107100466,2332.2811176896525,-13012.149777201163,-4319776.77130154,true,true,12.29379945,9611.962984395974,0.0,1644.2724500334996,973.0,12.29379945,9611.962984395974,0.0,121.92,0.0 -974,37321.02831680133,36621.02831680133,0.29250000000000004,9054.97520656629,4945942.713836896,700.0,681800.0,33350.342586551415,20754510.790133305,24295.367379985124,15808568.076296471,true,974.0,974,0.875,7923.103305745504,9054.97520656629,1131.8719008207863,0.0,0.0,974,36621.02831680133,0.0,7923.103305745504,7923.103305745504,2386581.3554386306,700.0,681800.0,937.1750250423974,1169499.426168908,5481.2132744607015,129736.83102522566,0.0,0.0,1401.832493133851,1084909.9346136984,102.88251310855414,2435.1636307982067,-7923.103305745504,-4327699.8746072855,true,true,12.56202781,9624.525012205973,0.0,1644.2724500334996,974.0,12.56202781,9624.525012205973,0.0,121.92,0.0 -975,31504.97520656629,30804.97520656629,0.25,5994.505947957574,4951937.219784854,700.0,682500.0,26778.023791830296,20781288.813925136,20783.517843872723,15829351.594140343,true,975.0,975,0.875,5245.192704462877,5994.505947957574,749.3132434946965,0.0,0.0,975,30804.97520656629,0.0,5245.192704462877,5245.192704462877,2391826.5481430935,700.0,682500.0,983.4259756663673,1170482.8521445743,2784.9687674925394,132521.7997927182,0.0,0.0,1424.5240264320141,1086334.4586401305,52.273934871957,2487.4375656701636,-5245.192704462877,-4332945.067311748,true,true,12.69614198,9637.221154185974,0.0,1644.2724500334996,975.0,12.69614198,9637.221154185974,0.0,121.92,0.0 -976,28444.505947957572,27744.505947957572,0.20800000000000002,3876.0154737735065,4955813.235258628,700.0,683200.0,22000.074393141855,20803288.888318278,18124.058919368348,15847475.653059712,true,976.0,976,0.875,3391.513539551818,3876.0154737735065,484.5019342216883,0.0,0.0,976,27744.505947957572,0.0,3391.513539551818,3391.513539551818,2395218.061682645,700.0,683200.0,1004.461119889405,1171487.3132644638,934.8952595537647,133456.69505227197,0.0,0.0,1434.6091522169786,1087769.0677923474,17.548007891670075,2504.985573561834,-3391.513539551818,-4336336.5808513,true,true,12.74084671,9649.962000895974,0.0,1644.2724500334996,976.0,12.74084671,9649.962000895974,0.0,121.92,0.0 -977,26326.015473773507,25626.015473773507,0.1864,2796.4534809765923,4958609.688739604,700.0,683900.0,18757.797644724207,20822046.685963,15961.344163747615,15863436.99722346,true,977.0,977,0.875,2446.896795854518,2796.4534809765923,349.5566851220742,0.0,0.0,977,25626.015473773507,0.0,2446.896795854518,2446.896795854518,2397664.9584784997,700.0,683900.0,1009.7663619093055,1172497.079626373,0.0,133456.69505227197,0.0,0.0,1437.1304339452126,1089206.1982262926,0.0,2504.985573561834,-2446.896795854518,-4338783.477647155,true,true,12.74084671,9662.702847605973,0.0,1644.2724500334996,977.0,12.74084671,9662.702847605973,0.0,121.92,0.0 -978,25246.453480976594,24546.453480976594,0.1864,2796.4534809765923,4961406.142220581,700.0,684600.0,18757.797644724207,20840804.483607724,15961.344163747615,15879398.341387207,true,978.0,978,0.875,2446.896795854518,2796.4534809765923,349.5566851220742,0.0,0.0,978,24546.453480976594,0.0,2446.896795854518,2446.896795854518,2400111.855274354,700.0,684600.0,1009.7663619093055,1173506.8459882822,0.0,133456.69505227197,0.0,0.0,1437.1304339452126,1090643.3286602378,0.0,2504.985573561834,-2446.896795854518,-4341230.3744430095,true,true,12.74084671,9675.443694315973,0.0,1644.2724500334996,978.0,12.74084671,9675.443694315973,0.0,121.92,0.0 -979,25246.453480976594,24546.453480976594,0.12,0.0,4961406.142220581,700.0,685300.0,5833.333333333334,20846637.816941056,5833.333333333334,15885231.67472054,true,979.0,979,0.875,0.0,0.0,0.0,0.0,0.0,979,24546.453480976594,0.0,-5141.003476991629,-5141.003476991629,2394970.8517973623,700.0,685300.0,967.8438146084426,1174474.6898028906,-7387.150471024702,126069.54458124728,0.0,0.0,1416.9601823752832,1092060.288842613,-138.6570029506537,2366.32857061118,-0.0,-4341230.3744430095,true,true,12.38320891,9687.826903225972,0.0,1644.2724500334996,979.0,12.38320891,9687.826903225972,0.0,121.92,0.0 -980,22450.0,21750.0,0.136,526.7045458216281,4961932.846766403,700.0,686000.0,9019.886366335499,20855657.70330739,8493.18182051387,15893724.856541054,true,980.0,980,0.875,460.8664775939246,526.7045458216281,65.8380682277035,0.0,0.0,980,21750.0,0.0,460.8664775939246,460.8664775939246,2395431.718274956,700.0,686000.0,917.0933936488705,1175391.7831965396,-1813.9268304823047,124255.61775076497,0.0,0.0,1391.7473673488864,1093452.036209962,-34.047452921527515,2332.2811176896525,-460.8664775939246,-4341691.240920603,true,true,12.29379945,9700.120702675973,0.0,1644.2724500334996,980.0,12.29379945,9700.120702675973,0.0,121.92,0.0 -981,22976.704545821627,22276.704545821627,0.12,0.0,4961932.846766403,700.0,686700.0,5833.333333333334,20861491.036640722,5833.333333333334,15899558.189874388,true,981.0,981,0.875,0.0,0.0,0.0,0.0,0.0,981,22276.704545821627,0.0,-475.31427959368864,-475.31427959368864,2394956.4039953626,700.0,686700.0,892.3974294066116,1176284.1806259463,-2696.244098270654,121559.37365249431,0.0,0.0,1379.1409598356877,1094831.1771697977,-50.608570565334006,2281.6725471243185,-0.0,-4341691.240920603,true,true,12.15968528,9712.280387955972,0.0,1644.2724500334996,981.0,12.15968528,9712.280387955972,0.0,121.92,0.0 -982,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,687400.0,5833.333333333334,20867324.369974054,5833.333333333334,15905391.523207722,true,982.0,982,0.875,0.0,0.0,0.0,0.0,0.0,982,21750.0,0.0,-1395.5357046754648,-1395.5357046754648,2393560.868290687,700.0,687400.0,858.5737602981075,1177142.7543862443,-3548.986880605484,118010.38677188882,0.0,0.0,1361.4919899939923,1096192.6691597917,-66.61457436208029,2215.057972762238,-0.0,-4341691.240920603,true,true,11.98086638,9724.261254335972,0.0,1644.2724500334996,982.0,11.98086638,9724.261254335972,0.0,121.92,0.0 -983,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,688100.0,5833.333333333334,20873157.703307386,5833.333333333334,15911224.856541056,true,983.0,983,0.875,0.0,0.0,0.0,0.0,0.0,983,21750.0,0.0,-507.0907599607714,-507.0907599607714,2393053.777530726,700.0,688100.0,825.6157303219805,1177968.3701165663,-2627.2362189622645,115383.15055292656,0.0,0.0,1343.8430195883116,1097536.51217938,-49.31329090879901,2165.744681853439,-0.0,-4341691.240920603,true,true,11.8467522,9736.108006535971,0.0,1644.2724500334996,983.0,11.8467522,9736.108006535971,0.0,121.92,0.0 -984,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,688800.0,5833.333333333334,20878991.03664072,5833.333333333334,15917058.18987439,true,984.0,984,0.875,0.0,0.0,0.0,0.0,0.0,984,21750.0,0.0,-2281.292251183721,-2281.292251183721,2390772.4852795424,700.0,688800.0,788.9949839284826,1178757.3651004948,-4313.004793045029,111070.14575988153,0.0,0.0,1323.6727680183824,1098860.1849473985,-80.95521008555681,2084.7894717678823,-0.0,-4341691.240920603,true,true,11.62322858,9747.73123511597,0.0,1644.2724500334996,984.0,11.62322858,9747.73123511597,0.0,121.92,0.0 -985,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,689500.0,5833.333333333334,20884824.36997405,5833.333333333334,15922891.523207724,true,985.0,985,0.875,0.0,0.0,0.0,0.0,0.0,985,21750.0,0.0,-539.2268287752191,-539.2268287752191,2390233.258450767,700.0,689500.0,753.4734631851496,1179510.83856368,-2548.369841420113,108521.77591846143,0.0,0.0,1303.5025164484532,1100163.687463847,-47.832966988708876,2036.9565047791734,-0.0,-4341691.240920603,true,true,11.4891144,9759.22034951597,0.0,1644.2724500334996,985.0,11.4891144,9759.22034951597,0.0,121.92,0.0 -986,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,690200.0,5833.333333333334,20890657.703307383,5833.333333333334,15928724.856541058,true,986.0,986,0.875,0.0,0.0,0.0,0.0,0.0,986,21750.0,0.0,-2257.6823493752063,-2257.6823493752063,2387975.576101392,700.0,690200.0,719.0344170389658,1180229.872980719,-4181.561023552564,104340.21489490886,0.0,0.0,1283.3322643145384,1101447.0197281616,-78.48800717614667,1958.4684976030267,-0.0,-4341691.240920603,true,true,11.26559077,9770.48594028597,0.0,1644.2724500334996,986.0,11.26559077,9770.48594028597,0.0,121.92,0.0 -987,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,690900.0,5833.333333333334,20896491.036640715,5833.333333333334,15934558.189874392,true,987.0,987,0.875,0.0,0.0,0.0,0.0,0.0,987,21750.0,0.0,-7992.804363599984,-7992.804363599984,2379982.771737792,700.0,690900.0,649.3691312688386,1180879.242111988,-9700.564137773415,94639.65075713545,0.0,0.0,1240.470479446446,1102687.490207608,-182.07983654185355,1776.388661061173,-0.0,-4341691.240920603,true,true,10.72913407,9781.215074355969,0.0,1644.2724500334996,987.0,10.72913407,9781.215074355969,0.0,121.92,0.0 -988,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,691600.0,5833.333333333334,20902324.369974047,5833.333333333334,15940391.523207726,true,988.0,988,0.875,0.0,0.0,0.0,0.0,0.0,988,21750.0,0.0,-13709.26926005884,-13709.26926005884,2366273.5024777334,700.0,691600.0,530.7253435984163,1181409.9674555864,-15116.055331959957,79523.59542517549,0.0,0.0,1159.7894728283377,1103847.2796804365,-283.7287445256381,1492.6599165355349,-0.0,-4341691.240920603,true,true,9.835039564,9791.05011391997,0.0,1644.2724500334996,988.0,9.835039564,9791.05011391997,0.0,121.92,0.0 -989,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,692300.0,5833.333333333334,20908157.70330738,5833.333333333334,15946224.85654106,true,989.0,989,0.875,0.0,0.0,0.0,0.0,0.0,989,21750.0,0.0,-2095.140763762001,-2095.140763762001,2364178.3617139715,700.0,692300.0,448.8116304564986,1181858.779086043,-3573.6326542764773,75949.96277089902,0.0,0.0,1096.7574362211203,1104944.0371166577,-67.07717616314252,1425.5827403723924,-0.0,-4341691.240920603,true,true,9.611515937,9800.66162985697,0.0,1644.2724500334996,989.0,9.611515937,9800.66162985697,0.0,121.92,0.0 -990,22450.0,21750.0,0.16720000000000002,1734.47268879474,4963667.319455198,700.0,693000.0,14560.243354035525,20922717.946661413,12825.770665240785,15959050.627206301,true,990.0,990,0.875,1517.6636026953975,1734.47268879474,216.8090860993425,0.0,0.0,990,21750.0,0.0,1517.6636026953975,1517.6636026953975,2365696.025316667,700.0,693000.0,433.51257381828,1182292.291659861,0.0,75949.96277089902,0.0,0.0,1084.1510288771174,1106028.1881455348,0.0,1425.5827403723924,-1517.6636026953975,-4343208.904523299,true,true,9.611515937,9810.27314579397,0.0,1644.2724500334996,990.0,9.611515937,9810.27314579397,0.0,121.92,0.0 -991,24184.47268879474,23484.47268879474,0.20800000000000002,4238.567970783865,4967905.887425981,700.0,693700.0,23743.115244153196,20946461.061905567,19504.54727336933,15978555.17447967,true,991.0,991,0.875,3708.7469744358823,4238.567970783865,529.820996347983,0.0,0.0,991,23484.47268879474,0.0,3708.7469744358823,3708.7469744358823,2369404.772291103,700.0,693700.0,442.64954365298934,1182734.941203514,2134.321292359348,78084.28406325837,0.0,0.0,1091.7148732722394,1107119.903018807,40.06126515130583,1465.6440055236983,-3708.7469744358823,-4346917.651497735,true,true,9.745630113,9820.01877590697,0.0,1644.2724500334996,991.0,9.745630113,9820.01877590697,0.0,121.92,0.0 -992,26688.567970783864,25988.567970783864,0.28,7750.5041029581125,4975656.39152894,700.0,694400.0,30180.371796278967,20976641.433701847,22429.867693320855,16000985.042172993,true,992.0,992,0.875,6781.691090088349,7750.5041029581125,968.813012869764,0.0,0.0,992,25988.567970783864,0.0,6781.691090088349,6781.691090088349,2376186.4633811912,700.0,694400.0,474.0318365981325,1183208.9730401123,5095.096474668295,83179.38053792666,0.0,0.0,1116.9276879038466,1108236.830706711,95.63509091807472,1561.279096441773,-6781.691090088349,-4353699.342587823,true,true,10.05856319,9830.07733909697,0.0,1644.2724500334996,992.0,10.05856319,9830.07733909697,0.0,121.92,0.0 -993,30200.50410295811,29500.50410295811,0.25,6250.15819208733,4981906.549721027,700.0,695100.0,27800.63276834932,21004442.066470195,21550.47457626199,16022535.516749255,true,993.0,993,0.875,5468.8884180764135,6250.15819208733,781.2697740109161,0.0,0.0,993,29500.50410295811,0.0,5468.8884180764135,5468.8884180764135,2381655.351799268,700.0,695100.0,513.6065125515006,1183722.5795526637,3737.9376546560616,86917.31819258272,0.0,0.0,1147.1830656535303,1109384.0137723645,70.16118521532044,1631.4402816570935,-5468.8884180764135,-4359168.2310059,true,true,10.28208682,9840.35942591697,0.0,1644.2724500334996,993.0,10.28208682,9840.35942591697,0.0,121.92,0.0 -994,28700.15819208733,28000.15819208733,0.124,166.0536737871037,4982072.603394814,700.0,695800.0,6984.303820863739,21011426.370291058,6818.250147076636,16029353.766896332,true,994.0,994,0.875,145.29696456371573,166.0536737871037,20.756709223387958,0.0,0.0,994,28000.15819208733,0.0,145.29696456371573,145.29696456371573,2381800.6487638317,700.0,695800.0,523.8328938474393,1184246.4124465112,-1505.0333256096048,85412.28486697312,0.0,0.0,1154.7469102742466,1110538.7606826387,-28.24951394836529,1603.1907677087281,-145.29696456371573,-4359313.527970463,true,true,10.19267737,9850.55210328697,0.0,1644.2724500334996,994.0,10.19267737,9850.55210328697,0.0,121.92,0.0 -995,22616.053673787104,21916.053673787104,0.1696,1904.8053999813317,4983977.408794795,700.0,696500.0,15358.522405550306,21026784.892696608,13453.717005568975,16042807.483901901,true,995.0,995,0.875,1666.7047249836653,1904.8053999813317,238.10067499766637,0.0,0.0,995,21916.053673787104,0.0,1666.7047249836653,1666.7047249836653,2383467.3534888155,700.0,696500.0,517.0003776019009,1184763.4128241132,0.0,85412.28486697312,0.0,0.0,1149.7043473817644,1111688.4650300206,0.0,1603.1907677087281,-1666.7047249836653,-4360980.232695446,true,true,10.19267737,9860.744780656969,0.0,1644.2724500334996,995.0,10.19267737,9860.744780656969,0.0,121.92,0.0 -996,24354.80539998133,23654.80539998133,0.196,3670.7001642053215,4987648.108959001,700.0,697200.0,22299.49063370062,21049084.383330308,18628.7904694953,16061436.274371397,true,996.0,996,0.875,3211.8626436796562,3670.7001642053215,458.83752052566524,0.0,0.0,996,23654.80539998133,0.0,3211.8626436796562,3211.8626436796562,2386679.216132495,700.0,697200.0,523.8328938474393,1185287.2457179606,1505.0333256096048,86917.31819258272,0.0,0.0,1154.7469102742466,1112843.2119402948,28.24951394836529,1631.4402816570935,-3211.8626436796562,-4364192.095339126,true,true,10.28208682,9871.026867476969,0.0,1644.2724500334996,996.0,10.28208682,9871.026867476969,0.0,121.92,0.0 -997,26120.700164205322,25420.700164205322,0.12,0.0,4987648.108959001,700.0,697900.0,5833.333333333334,21054917.71666364,5833.333333333334,16067269.60770473,true,997.0,997,0.875,0.0,0.0,0.0,0.0,0.0,997,25420.700164205322,0.0,-622.2678871790627,-622.2678871790627,2386056.948245316,700.0,697900.0,520.4091599538554,1185807.6548779146,-2252.6209234319535,84664.69726915077,0.0,0.0,1152.2256285460128,1113995.4375688408,-42.28175224697732,1589.1585294101162,-0.0,-4364192.095339126,true,true,10.14797264,9881.174840116968,0.0,1644.2724500334996,997.0,10.14797264,9881.174840116968,0.0,121.92,0.0 -998,22450.0,21750.0,0.1696,1891.3020763166555,4989539.411035317,700.0,698600.0,15278.903751867072,21070196.62041551,13387.601675550417,16080657.20938028,true,998.0,998,0.875,1654.8893167770736,1891.3020763166555,236.41275953958188,0.0,0.0,998,21750.0,0.0,1654.8893167770736,1654.8893167770736,2387711.837562093,700.0,698600.0,510.2275328517772,1186317.8824107663,0.0,84664.69726915077,0.0,0.0,1144.6617839252965,1115140.099352766,0.0,1589.1585294101162,-1654.8893167770736,-4365846.984655903,true,true,10.14797264,9891.322812756967,0.0,1644.2724500334996,998.0,10.14797264,9891.322812756967,0.0,121.92,0.0 -999,24341.302076316657,23641.302076316657,0.1696,1891.3020763166555,4991430.713111633,700.0,699300.0,15278.903751867072,21085475.524167378,13387.601675550417,16094044.81105583,true,999.0,999,0.875,1654.8893167770736,1891.3020763166555,236.41275953958188,0.0,0.0,999,23641.302076316657,0.0,1654.8893167770736,1654.8893167770736,2389366.7268788703,700.0,699300.0,510.2275328517772,1186828.109943618,0.0,84664.69726915077,0.0,0.0,1144.6617839252965,1116284.7611366913,0.0,1589.1585294101162,-1654.8893167770736,-4367501.8739726795,true,true,10.14797264,9901.470785396967,0.0,1644.2724500334996,999.0,10.14797264,9901.470785396967,0.0,121.92,0.0 -1000,24341.302076316657,23641.302076316657,0.29250000000000004,9016.235252073206,5000446.9483637065,700.0,700000.0,33217.898297686166,21118693.422465064,24201.66304561296,16118246.474101443,true,1000.0,1000,0.875,7889.205845564055,9016.235252073206,1127.0294065091502,0.0,0.0,1000,23641.302076316657,0.0,7889.205845564055,7889.205845564055,2397255.9327244344,700.0,700000.0,537.6779891878742,1187365.787932806,6072.710882566083,90737.40815171685,0.0,0.0,1164.8320354952257,1117449.5931721865,113.98493831487275,1703.143467724989,-7889.205845564055,-4375391.079818243,true,true,10.50561044,9911.976395836966,0.0,1644.2724500334996,1000.0,10.50561044,9911.976395836966,0.0,121.92,0.0 -1001,31466.235252073206,30766.235252073206,0.265,6579.945172908674,5007026.893536615,700.0,700700.0,27471.491218523297,21146164.913683586,20891.546045614625,16139138.020147057,true,1001.0,1001,0.875,5757.45202629509,6579.945172908674,822.493146613584,0.0,0.0,1001,30766.235252073206,0.0,5757.45202629509,5757.45202629509,2403013.3847507294,700.0,700700.0,584.3555329619527,1187950.1434657678,3902.2426054185994,94639.65075713545,0.0,0.0,1197.6086945783534,1118647.2018667648,73.24519333618417,1776.3886610611733,-5757.45202629509,-4381148.531844539,true,true,10.72913407,9922.705529906965,0.0,1644.2724500334996,1001.0,10.72913407,9922.705529906965,0.0,121.92,0.0 -1002,29029.945172908672,28329.945172908672,0.28,7694.062885700793,5014720.956422316,700.0,701400.0,29978.796020359976,21176143.709703945,22284.73313465918,16161422.753281716,true,1002.0,1002,0.875,6732.305024988194,7694.062885700793,961.7578607125988,0.0,0.0,1002,28329.945172908672,0.0,6732.305024988194,6732.305024988194,2409745.6897757174,700.0,701400.0,625.9002709116227,1188576.0437366795,4791.132287935321,99430.78304507077,0.0,0.0,1225.342790768999,1119872.5446575338,89.92967537225101,1866.3183364334243,-6732.305024988194,-4387880.836869527,true,true,10.99736242,9933.702892326965,0.0,1644.2724500334996,1002.0,10.99736242,9933.702892326965,0.0,121.92,0.0 -1003,30144.062885700794,29444.062885700794,0.20800000000000002,4064.7273506183224,5018785.683772935,700.0,702100.0,22907.34303181886,21199051.052735765,18842.615681200536,16180265.368962917,true,1003.0,1003,0.875,3556.636431791032,4064.7273506183224,508.09091882729035,0.0,0.0,1003,29444.062885700794,0.0,3556.636431791032,3556.636431791032,2413302.3262075083,700.0,702100.0,657.3205021939968,1189233.3642388736,1623.33288751239,101054.11593258315,0.0,0.0,1245.5130423389282,1121118.0576998726,30.469999745717175,1896.7883361791414,-3556.636431791032,-4391437.473301318,true,true,11.08677187,9944.789664196964,0.0,1644.2724500334996,1003.0,11.08677187,9944.789664196964,0.0,121.92,0.0 -1004,26514.727350618323,25814.727350618323,0.22,5075.902333791998,5023861.586106727,700.0,702800.0,26254.101517236355,21225305.154253002,21178.199183444358,16201443.568146361,true,1004.0,1004,0.875,4441.414542067998,5075.902333791998,634.4877917240001,0.0,0.0,1004,25814.727350618323,0.0,4441.414542067998,4441.414542067998,2417743.740749576,700.0,702800.0,677.4823240752958,1189910.8465629488,2459.6451655826645,103513.76109816582,0.0,0.0,1258.1194498521268,1122376.1771497247,46.167602557911074,1942.9559387370525,-4441.414542067998,-4395878.887843385,true,true,11.22088605,9956.010550246963,0.0,1644.2724500334996,1004.0,11.22088605,9956.010550246963,0.0,121.92,0.0 -1005,27525.902333791997,26825.902333791997,0.25,6137.275802641789,5029998.861909369,700.0,703500.0,27349.103210567155,21252654.25746357,21211.827407925368,16222655.395554285,true,1005.0,1005,0.875,5370.116327311565,6137.275802641789,767.1594753302234,0.0,0.0,1005,26825.902333791997,0.0,5370.116327311565,5370.116327311565,2423113.8570768875,700.0,703500.0,706.3954325730705,1190617.2419955218,3325.532151096757,106839.29324926258,0.0,0.0,1275.7684202578077,1123651.9455699825,62.42032338393042,2005.376262120983,-5370.116327311565,-4401249.004170697,true,true,11.39970495,9967.410255196963,0.0,1644.2724500334996,1005.0,11.39970495,9967.410255196963,0.0,121.92,0.0 -1006,28587.275802641787,27887.275802641787,0.196,3281.4581828566247,5033280.320092225,700.0,704200.0,20313.56215743176,21272967.819621004,17032.103974575133,16239687.49952886,true,1006.0,1006,0.875,2871.2759099995465,3281.4581828566247,410.18227285707826,0.0,0.0,1006,27887.275802641787,0.0,2871.2759099995465,2871.2759099995465,2425985.132986887,700.0,704200.0,727.543612270065,1191344.785607792,839.5981910399303,107678.89144030251,0.0,0.0,1288.3748272070206,1124940.3203971896,15.759279482530792,2021.1355416035137,-2871.2759099995465,-4404120.280080697,true,true,11.44440967,9978.854664866964,0.0,1644.2724500334996,1006.0,11.44440967,9978.854664866964,0.0,121.92,0.0 -1007,25731.458182856626,25031.458182856626,0.16,1326.3553930909995,5034606.675485317,700.0,704900.0,12664.721206818747,21285632.540827822,11338.365813727747,16251025.86534259,true,1007.0,1007,0.875,1160.5609689546245,1326.3553930909995,165.79442413637503,0.0,0.0,1007,25031.458182856626,0.0,1160.5609689546245,1160.5609689546245,2427145.6939558415,700.0,704900.0,727.543612270065,1192072.3292200621,-839.5981910399303,106839.29324926258,0.0,0.0,1288.3748272070206,1126228.6952243967,-15.759279482530792,2005.376262120983,-1160.5609689546245,-4405280.841049652,true,true,11.39970495,9990.254369816963,0.0,1644.2724500334996,1007.0,11.39970495,9990.254369816963,0.0,121.92,0.0 -1008,23776.355393091,23076.355393091,0.12,0.0,5034606.675485317,700.0,705600.0,5833.333333333334,21291465.874161154,5833.333333333334,16256859.198675923,true,1008.0,1008,0.875,0.0,0.0,0.0,0.0,0.0,1008,23076.355393091,0.0,-2251.1085120461435,-2251.1085120461435,2424894.585443795,700.0,705600.0,702.2155883763056,1192774.5448084385,-4148.700033400049,102690.59321586254,0.0,0.0,1273.2471385295737,1127501.9423629262,-77.87120555197411,1927.505056569009,-0.0,-4405280.841049652,true,true,11.17618132,10001.430551136962,0.0,1644.2724500334996,1008.0,11.17618132,10001.430551136962,0.0,121.92,0.0 -1009,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,706300.0,5833.333333333334,21297299.207494486,5833.333333333334,16262692.532009257,true,1009.0,1009,0.875,0.0,0.0,0.0,0.0,0.0,1009,21750.0,0.0,-5513.551261864985,-5513.551261864985,2419381.03418193,700.0,706300.0,645.4176054289632,1193419.9624138675,-7260.635746667871,95429.95746919466,0.0,0.0,1237.949197718212,1128739.8915606444,-136.28231834428826,1791.2227382247206,-0.0,-4405280.841049652,true,true,10.77383879,10012.204389926963,0.0,1644.2724500334996,1009.0,10.77383879,10012.204389926963,0.0,121.92,0.0 -1010,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,707000.0,5833.333333333334,21303132.54082782,5833.333333333334,16268525.865342591,true,1010.0,1010,0.875,0.0,0.0,0.0,0.0,0.0,1010,21750.0,0.0,-1399.8066954137637,-1399.8066954137637,2417981.2274865163,700.0,707000.0,595.4976076806397,1194015.4600215482,-3141.5106074188498,92288.44686177581,0.0,0.0,1205.1725386350843,1129945.0640992795,-58.96623431063786,1732.2565039140827,-0.0,-4405280.841049652,true,true,10.59501989,10022.799409816962,0.0,1644.2724500334996,1010.0,10.59501989,10022.799409816962,0.0,121.92,0.0 -1011,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,707700.0,5833.333333333334,21308965.87416115,5833.333333333334,16274359.198675925,true,1011.0,1011,0.875,0.0,0.0,0.0,0.0,0.0,1011,21750.0,0.0,-2180.299859693081,-2180.299859693081,2415800.927626823,700.0,707700.0,562.4900698869907,1194577.950091435,-3852.9509478165046,88435.49591395931,0.0,0.0,1182.4810059009064,1131127.5451051805,-72.31998766447373,1659.936516249609,-0.0,-4405280.841049652,true,true,10.37149627,10033.170906086962,0.0,1644.2724500334996,1011.0,10.37149627,10033.170906086962,0.0,121.92,0.0 -1012,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,708400.0,5833.333333333334,21314799.207494482,5833.333333333334,16280192.532009259,true,1012.0,1012,0.875,0.0,0.0,0.0,0.0,0.0,1012,21750.0,0.0,-618.4844709052221,-618.4844709052221,2415182.443155918,700.0,708400.0,534.1941258082862,1195112.1442172434,-2272.3375178174856,86163.15839614182,0.0,0.0,1162.3107543309773,1132289.8558595115,-42.65183322700004,1617.284683022609,-0.0,-4405280.841049652,true,true,10.23738209,10043.408288176961,0.0,1644.2724500334996,1012.0,10.23738209,10043.408288176961,0.0,121.92,0.0 -1013,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,709100.0,5833.333333333334,21320632.540827814,5833.333333333334,16286025.865342593,true,1013.0,1013,0.875,0.0,0.0,0.0,0.0,0.0,1013,21750.0,0.0,-1384.8941280189263,-1384.8941280189263,2413797.549027899,700.0,709100.0,510.22753285177686,1195622.3717500952,-2983.7778582151636,83179.38053792666,0.0,0.0,1144.6617839252963,1133434.5176434368,-56.00558658083572,1561.2790964417732,-0.0,-4405280.841049652,true,true,10.05856319,10053.46685136696,0.0,1644.2724500334996,1013.0,10.05856319,10053.46685136696,0.0,121.92,0.0 -1014,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,709800.0,5833.333333333334,21326465.874161147,5833.333333333334,16291859.198675927,true,1014.0,1014,0.875,0.0,0.0,0.0,0.0,0.0,1014,21750.0,0.0,-2121.9528802667282,-2121.9528802667282,2411675.596147632,700.0,709800.0,480.48116153794797,1196102.8529116332,-3655.785112751166,79523.59542517549,0.0,0.0,1121.9702508527275,1134556.4878942894,-68.61917990623803,1492.659916535535,-0.0,-4405280.841049652,true,true,9.835039564,10063.301890930961,0.0,1644.2724500334996,1014.0,9.835039564,10063.301890930961,0.0,121.92,0.0 -1015,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,710500.0,5833.333333333334,21332299.20749448,5833.333333333334,16297692.53200926,true,1015.0,1015,0.875,0.0,0.0,0.0,0.0,0.0,1015,21750.0,0.0,-1368.0706911425218,-1368.0706911425218,2410307.5254564895,700.0,710500.0,451.91400410552706,1196554.7669157388,-2865.478311895824,76658.11711327966,0.0,0.0,1099.2787177237599,1135655.766612013,-53.7851010759847,1438.8748154595505,-0.0,-4405280.841049652,true,true,9.656220663,10072.958111593962,0.0,1644.2724500334996,1015.0,9.656220663,10072.958111593962,0.0,121.92,0.0 -1016,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,711200.0,5833.333333333334,21338132.54082781,5833.333333333334,16303525.865342595,true,1016.0,1016,0.875,0.0,0.0,0.0,0.0,0.0,1016,21750.0,0.0,-6283.465355440145,-6283.465355440145,2404024.0601010495,700.0,711200.0,406.8577746052386,1196961.624690344,-7608.962210823534,69049.15490245612,0.0,0.0,1061.4594957481497,1136717.2261077613,-142.8204149699991,1296.0544004895514,-0.0,-4405280.841049652,true,true,9.164468684,10082.122580277963,0.0,1644.2724500334996,1016.0,9.164468684,10082.122580277963,0.0,121.92,0.0 -1017,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,711900.0,5833.333333333334,21343965.874161143,5833.333333333334,16309359.198675929,true,1017.0,1017,0.875,0.0,0.0,0.0,0.0,0.0,1017,21750.0,0.0,-17825.06413448635,-17825.06413448635,2386198.995966563,700.0,711900.0,299.1900329821921,1197260.8147233264,-18730.76420095619,50318.390701499935,0.0,0.0,958.0869557754799,1137675.3130635368,-351.5769222878327,944.4774782017187,-0.0,-4405280.841049652,true,true,7.823326926,10089.945907203963,0.0,1644.2724500334996,1017.0,7.823326926,10089.945907203963,0.0,121.92,0.0 -1018,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,712600.0,5833.333333333334,21349799.207494475,5833.333333333334,16315192.532009263,true,1018.0,1018,0.875,0.0,0.0,0.0,0.0,0.0,1018,21750.0,0.0,-16537.622884461296,-16537.622884461296,2369661.373082102,700.0,712600.0,173.68972136237082,1197434.5044446888,-17187.940742882525,33130.449958617406,0.0,0.0,799.2462236471132,1138474.559287184,-322.6180865882553,621.8593916134633,-0.0,-4405280.841049652,true,true,6.348070991,10096.293978194963,0.0,1644.2724500334996,1018.0,6.348070991,10096.293978194963,0.0,121.92,0.0 -1019,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,713300.0,5833.333333333334,21355632.540827807,5833.333333333334,16321025.865342597,true,1019.0,1019,0.875,0.0,0.0,0.0,0.0,0.0,1019,21750.0,0.0,-13145.763800202758,-13145.763800202758,2356515.609281899,700.0,713300.0,86.2218816277595,1197520.7263263166,-13609.3789387968,19521.071019820607,0.0,0.0,632.8416471236244,1139107.4009343076,-255.44839015734206,366.4110014561213,-0.0,-4405280.841049652,true,true,4.872815057,10101.166793251963,0.0,1644.2724500334996,1019.0,4.872815057,10101.166793251963,0.0,121.92,0.0 -1020,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,714000.0,5833.333333333334,21361465.87416114,5833.333333333334,16326859.19867593,true,1020.0,1020,0.875,0.0,0.0,0.0,0.0,0.0,1020,21750.0,0.0,-9718.135539046629,-9718.135539046629,2346797.4737428525,700.0,714000.0,34.523237587262855,1197555.2495639038,-10030.817153161288,9490.25386665932,0.0,0.0,466.43707060013566,1139573.8380049078,-188.27869407273917,178.13230738338214,-0.0,-4405280.841049652,true,true,3.397559122,10104.564352373964,0.0,1644.2724500334996,1020.0,3.397559122,10104.564352373964,0.0,121.92,0.0 -1021,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,714700.0,5833.333333333334,21367299.20749447,5833.333333333334,16332692.532009264,true,1021.0,1021,0.875,0.0,0.0,0.0,0.0,0.0,1021,21750.0,0.0,-6264.143517503177,-6264.143517503177,2340533.3302253494,700.0,714700.0,9.18834335659429,1197564.4379072604,-6452.2553570878035,3037.9985095715156,0.0,0.0,300.03249402024835,1139873.870498928,-121.10899779221543,57.02330959116671,-0.0,-4405280.841049652,true,true,1.922303187,10106.486655560964,0.0,1644.2724500334996,1021.0,1.922303187,10106.486655560964,0.0,121.92,0.0 -1022,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,715400.0,5833.333333333334,21373132.540827803,5833.333333333334,16338525.865342598,true,1022.0,1022,0.875,0.0,0.0,0.0,0.0,0.0,1022,21750.0,0.0,-2793.193191209225,-2793.193191209225,2337740.13703414,700.0,715400.0,0.8117530711655422,1197565.2496603315,-2873.6935602792555,164.30494929226006,0.0,0.0,133.62791749675952,1140007.4984164247,-53.93930149789451,3.084008093272196,-0.0,-4405280.841049652,true,true,0.447047253,10106.933702813963,0.0,1644.2724500334996,1022.0,0.447047253,10106.933702813963,0.0,121.92,0.0 -1023,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,716100.0,5833.333333333334,21378965.874161135,5833.333333333334,16344359.198675932,true,1023.0,1023,0.875,0.0,0.0,0.0,0.0,0.0,1023,21750.0,0.0,-142.17069024579726,-142.17069024579726,2337597.966343894,700.0,716100.0,0.005452508259103674,1197565.2551128399,-164.30494929239373,-1.3366729945119005e-10,0.0,0.0,25.212814631607213,1140032.7112310564,-3.084008093269858,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1023.0,0.0,10106.933702813963,0.0,121.92,0.0 -1024,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,716800.0,5833.333333333334,21384799.207494467,5833.333333333334,16350192.532009266,true,1024.0,1024,0.875,0.0,0.0,0.0,0.0,0.0,1024,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,716800.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1024.0,0.0,10106.933702813963,0.0,121.92,0.0 -1025,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,717500.0,5833.333333333334,21390632.5408278,5833.333333333334,16356025.8653426,true,1025.0,1025,0.875,0.0,0.0,0.0,0.0,0.0,1025,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,717500.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1025.0,0.0,10106.933702813963,0.0,121.92,0.0 -1026,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,718200.0,5833.333333333334,21396465.87416113,5833.333333333334,16361859.198675934,true,1026.0,1026,0.875,0.0,0.0,0.0,0.0,0.0,1026,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,718200.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1026.0,0.0,10106.933702813963,0.0,121.92,0.0 -1027,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,718900.0,5833.333333333334,21402299.207494464,5833.333333333334,16367692.532009268,true,1027.0,1027,0.875,0.0,0.0,0.0,0.0,0.0,1027,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,718900.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1027.0,0.0,10106.933702813963,0.0,121.92,0.0 -1028,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,719600.0,5833.333333333334,21408132.540827796,5833.333333333334,16373525.865342602,true,1028.0,1028,0.875,0.0,0.0,0.0,0.0,0.0,1028,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,719600.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1028.0,0.0,10106.933702813963,0.0,121.92,0.0 -1029,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,720300.0,5833.333333333334,21413965.874161128,5833.333333333334,16379359.198675936,true,1029.0,1029,0.875,0.0,0.0,0.0,0.0,0.0,1029,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,720300.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1029.0,0.0,10106.933702813963,0.0,121.92,0.0 -1030,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,721000.0,5833.333333333334,21419799.20749446,5833.333333333334,16385192.53200927,true,1030.0,1030,0.875,0.0,0.0,0.0,0.0,0.0,1030,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,721000.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1030.0,0.0,10106.933702813963,0.0,121.92,0.0 -1031,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,721700.0,5833.333333333334,21425632.540827792,5833.333333333334,16391025.865342604,true,1031.0,1031,0.875,0.0,0.0,0.0,0.0,0.0,1031,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,721700.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1031.0,0.0,10106.933702813963,0.0,121.92,0.0 -1032,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,722400.0,5833.333333333334,21431465.874161124,5833.333333333334,16396859.198675938,true,1032.0,1032,0.875,0.0,0.0,0.0,0.0,0.0,1032,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,722400.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1032.0,0.0,10106.933702813963,0.0,121.92,0.0 -1033,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,723100.0,5833.333333333334,21437299.207494456,5833.333333333334,16402692.532009272,true,1033.0,1033,0.875,0.0,0.0,0.0,0.0,0.0,1033,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,723100.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1033.0,0.0,10106.933702813963,0.0,121.92,0.0 -1034,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,723800.0,5833.333333333334,21443132.54082779,5833.333333333334,16408525.865342606,true,1034.0,1034,0.875,0.0,0.0,0.0,0.0,0.0,1034,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,723800.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1034.0,0.0,10106.933702813963,0.0,121.92,0.0 -1035,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,724500.0,5833.333333333334,21448965.87416112,5833.333333333334,16414359.19867594,true,1035.0,1035,0.875,0.0,0.0,0.0,0.0,0.0,1035,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,724500.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1035.0,0.0,10106.933702813963,0.0,121.92,0.0 -1036,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,725200.0,5833.333333333334,21454799.207494453,5833.333333333334,16420192.532009274,true,1036.0,1036,0.875,0.0,0.0,0.0,0.0,0.0,1036,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,725200.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1036.0,0.0,10106.933702813963,0.0,121.92,0.0 -1037,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,725900.0,5833.333333333334,21460632.540827785,5833.333333333334,16426025.865342608,true,1037.0,1037,0.875,0.0,0.0,0.0,0.0,0.0,1037,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,725900.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1037.0,0.0,10106.933702813963,0.0,121.92,0.0 -1038,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,726600.0,5833.333333333334,21466465.874161117,5833.333333333334,16431859.198675942,true,1038.0,1038,0.875,0.0,0.0,0.0,0.0,0.0,1038,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,726600.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1038.0,0.0,10106.933702813963,0.0,121.92,0.0 -1039,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,727300.0,5833.333333333334,21472299.20749445,5833.333333333334,16437692.532009276,true,1039.0,1039,0.875,0.0,0.0,0.0,0.0,0.0,1039,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,727300.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1039.0,0.0,10106.933702813963,0.0,121.92,0.0 -1040,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,728000.0,5833.333333333334,21478132.54082778,5833.333333333334,16443525.86534261,true,1040.0,1040,0.875,0.0,0.0,0.0,0.0,0.0,1040,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,728000.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1040.0,0.0,10106.933702813963,0.0,121.92,0.0 -1041,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,728700.0,5833.333333333334,21483965.874161113,5833.333333333334,16449359.198675944,true,1041.0,1041,0.875,0.0,0.0,0.0,0.0,0.0,1041,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,728700.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1041.0,0.0,10106.933702813963,0.0,121.92,0.0 -1042,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,729400.0,5833.333333333334,21489799.207494445,5833.333333333334,16455192.532009277,true,1042.0,1042,0.875,0.0,0.0,0.0,0.0,0.0,1042,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,729400.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1042.0,0.0,10106.933702813963,0.0,121.92,0.0 -1043,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,730100.0,5833.333333333334,21495632.540827777,5833.333333333334,16461025.865342611,true,1043.0,1043,0.875,0.0,0.0,0.0,0.0,0.0,1043,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,730100.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1043.0,0.0,10106.933702813963,0.0,121.92,0.0 -1044,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,730800.0,5833.333333333334,21501465.87416111,5833.333333333334,16466859.198675945,true,1044.0,1044,0.875,0.0,0.0,0.0,0.0,0.0,1044,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,730800.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1044.0,0.0,10106.933702813963,0.0,121.92,0.0 -1045,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,731500.0,5833.333333333334,21507299.20749444,5833.333333333334,16472692.53200928,true,1045.0,1045,0.875,0.0,0.0,0.0,0.0,0.0,1045,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,731500.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1045.0,0.0,10106.933702813963,0.0,121.92,0.0 -1046,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,732200.0,5833.333333333334,21513132.540827774,5833.333333333334,16478525.865342613,true,1046.0,1046,0.875,0.0,0.0,0.0,0.0,0.0,1046,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,732200.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1046.0,0.0,10106.933702813963,0.0,121.92,0.0 -1047,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,732900.0,5833.333333333334,21518965.874161106,5833.333333333334,16484359.198675947,true,1047.0,1047,0.875,0.0,0.0,0.0,0.0,0.0,1047,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,732900.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1047.0,0.0,10106.933702813963,0.0,121.92,0.0 -1048,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,733600.0,5833.333333333334,21524799.207494438,5833.333333333334,16490192.532009281,true,1048.0,1048,0.875,0.0,0.0,0.0,0.0,0.0,1048,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,733600.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1048.0,0.0,10106.933702813963,0.0,121.92,0.0 -1049,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,734300.0,5833.333333333334,21530632.54082777,5833.333333333334,16496025.865342615,true,1049.0,1049,0.875,0.0,0.0,0.0,0.0,0.0,1049,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,734300.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1049.0,0.0,10106.933702813963,0.0,121.92,0.0 -1050,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,735000.0,5833.333333333334,21536465.874161102,5833.333333333334,16501859.19867595,true,1050.0,1050,0.875,0.0,0.0,0.0,0.0,0.0,1050,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,735000.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1050.0,0.0,10106.933702813963,0.0,121.92,0.0 -1051,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,735700.0,5833.333333333334,21542299.207494434,5833.333333333334,16507692.532009283,true,1051.0,1051,0.875,0.0,0.0,0.0,0.0,0.0,1051,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,735700.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1051.0,0.0,10106.933702813963,0.0,121.92,0.0 -1052,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,736400.0,5833.333333333334,21548132.540827766,5833.333333333334,16513525.865342617,true,1052.0,1052,0.875,0.0,0.0,0.0,0.0,0.0,1052,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,736400.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,1644.2724500334996,1052.0,0.0,10106.933702813963,0.0,121.92,0.0 -1053,22450.0,21750.0,0.128,310.06274006228875,5034916.738225379,700.0,737100.0,7891.1151567366305,21556023.655984502,7581.052416674342,16521106.917759292,true,1053.0,1053,0.875,271.30489755450265,310.06274006228875,38.75784250778611,0.0,0.0,1053,21750.0,0.0,271.30489755450265,271.30489755450265,2337869.271241449,700.0,737100.0,0.009421934240117264,1197565.264534774,236.59912645179844,236.59912645166477,0.0,0.0,30.255377524089532,1140062.9666085804,4.440971644374586,4.4409716443769245,-271.30489755450265,-4405552.145947206,true,true,0.536456703,10107.470159516963,0.0,1644.2724500334996,1053.0,0.536456703,10107.470159516963,0.0,121.92,0.0 -1054,22760.062740062287,22060.062740062287,0.1888,2936.0645970350456,5037852.802822414,700.0,737800.0,19258.816721583928,21575282.472706087,16322.752124548882,16537429.66988384,true,1054.0,1054,0.875,2569.056522405665,2936.0645970350456,367.00807462938064,0.0,0.0,1054,22060.062740062287,0.0,2569.056522405665,2569.056522405665,2340438.3277638545,700.0,737800.0,0.7666662807024109,1197566.0312010548,2392.2800622265013,2628.879188678166,0.0,0.0,131.10663605051838,1140194.073244631,44.90315784794314,49.344129492320064,-2569.056522405665,-4408121.202469612,true,true,1.788189012,10109.258348528963,0.0,1644.2724500334996,1054.0,1.788189012,10109.258348528963,0.0,121.92,0.0 -1055,25386.064597035045,24686.064597035045,0.28,7468.2359189521,5045321.038741366,700.0,738500.0,29172.27113911464,21604454.743845202,21704.03522016254,16559133.705104003,true,1055.0,1055,0.875,6534.706429083088,7468.2359189521,933.5294898690127,0.0,0.0,1055,24686.064597035045,0.0,6534.706429083088,6534.706429083088,2346973.0341929374,700.0,738500.0,7.86740780533094,1197573.89860886,6126.931554283969,8755.810742962134,0.0,0.0,284.90480528640285,1140478.9780499174,115.00266170738516,164.34679119970522,-6534.706429083088,-4414655.908898694,true,true,3.263444946,10112.521793474963,0.0,1644.2724500334996,1055.0,3.263444946,10112.521793474963,0.0,121.92,0.0 -1056,29918.2359189521,29218.2359189521,0.3175,11851.710944453755,5057172.74968582,700.0,739200.0,39532.94785654726,21643987.691701747,27681.236912093504,16586814.942016097,true,1056.0,1056,0.875,10370.247076397036,11851.710944453755,1481.4638680567186,0.0,0.0,1056,29218.2359189521,0.0,10370.247076397036,10370.247076397036,2357343.2812693343,700.0,739200.0,31.271983246328865,1197605.1705921064,9705.49335329772,18461.304096259853,0.0,0.0,451.3093818098916,1140930.2874317272,182.17235804309774,346.519149242803,-10370.247076397036,-4425026.155975091,true,true,4.738700881,10117.260494355964,0.0,1644.2724500334996,1056.0,4.738700881,10117.260494355964,0.0,121.92,0.0 -1057,34301.71094445376,33601.71094445376,0.33999999999999997,16264.338765241135,5073437.088451061,700.0,739900.0,49895.1140154151,21693882.805717163,33630.77525017397,16620445.71726627,true,1057.0,1057,0.875,14231.296419585993,16264.338765241135,2033.0423456551416,0.0,0.0,1057,33601.71094445376,0.0,14231.296419585993,14231.296419585993,2371574.5776889203,700.0,739900.0,80.18526796700294,1197685.3558600734,13284.05513915377,31745.359235413624,0.0,0.0,617.7139583333803,1141548.0013900606,249.34205413183997,595.861203374643,-14231.296419585993,-4439257.452394677,true,true,6.213956815,10123.474451170963,0.0,1644.2724500334996,1057.0,6.213956815,10123.474451170963,0.0,121.92,0.0 -1058,38714.33876524113,38014.33876524113,0.3516666666666666,19399.00911175056,5092836.097562812,700.0,740600.0,57153.58041256085,21751036.386129722,37754.57130081029,16658200.288567081,true,1058.0,1058,0.875,16974.132972781743,19399.00911175056,2424.876138968819,0.0,0.0,1058,38014.33876524113,0.0,16974.132972781743,16974.132972781743,2388548.710661702,700.0,740600.0,160.8687806667652,1197846.22464074,15738.771085095746,47484.13032050937,0.0,0.0,779.0759719079883,1142327.0773619686,295.4171351112423,891.2783384858853,-16974.132972781743,-4456231.585367459,true,true,7.599803299,10131.074254469962,0.0,1644.2724500334996,1058.0,7.599803299,10131.074254469962,0.0,121.92,0.0 -1059,41849.009111750565,41149.009111750565,0.3175,11488.52113139514,5104324.618694208,700.0,741300.0,38389.042933528,21789425.42906325,26900.52180213286,16685100.810369214,true,1059.0,1059,0.875,10052.455989970747,11488.52113139514,1436.065141424393,0.0,0.0,1059,41149.009111750565,0.0,10052.455989970747,10052.455989970747,2398601.1666516727,700.0,741300.0,243.9390852791123,1198090.1637260192,8749.238554414122,56233.36887492349,0.0,0.0,895.054919224661,1143222.1322811933,164.2234310528525,1055.5017695387378,-10052.455989970747,-4466284.04135743,true,true,8.270374179,10139.344628648962,0.0,1644.2724500334996,1059.0,8.270374179,10139.344628648962,0.0,121.92,0.0 -1060,33938.521131395144,33238.521131395144,0.33,12512.642156468382,5116837.260850676,700.0,742000.0,40038.3095650557,21829463.738628305,27525.667408587316,16712626.477777801,true,1060.0,1060,0.875,10948.561886909834,12512.642156468382,1564.080269558548,0.0,0.0,1060,33238.521131395144,0.0,10948.561886909834,10948.561886909834,2409549.7285385826,700.0,742000.0,311.1562439418471,1198401.319969961,9488.610812631186,65721.97968755467,0.0,0.0,970.6933631194827,1144192.8256443127,178.10146721731846,1233.6032367560563,-10948.561886909834,-4477232.603244339,true,true,8.940945058,10148.285573706962,0.0,1644.2724500334996,1060.0,8.940945058,10148.285573706962,0.0,121.92,0.0 -1061,34962.642156468384,34262.642156468384,0.33999999999999997,16053.100262541306,5132890.361113218,700.0,742700.0,49273.82430159208,21878737.5629299,33220.72403905078,16745847.201816853,true,1061.0,1061,0.875,14046.462729723642,16053.100262541306,2006.6375328176637,0.0,0.0,1061,34262.642156468384,0.0,14046.462729723642,14046.462729723642,2423596.191268306,700.0,742700.0,398.2219338992979,1198799.5419038602,12362.304375703674,78084.28406325835,0.0,0.0,1053.895651353028,1145246.7212956657,232.04076876764228,1465.6440055236985,-14046.462729723642,-4491279.065974062,true,true,9.745630113,10158.031203819963,0.0,1644.2724500334996,1061.0,9.745630113,10158.031203819963,0.0,121.92,0.0 -1062,38503.10026254131,37803.10026254131,0.3175,12135.575906597176,5145025.937019815,700.0,743400.0,40427.01072943993,21919164.573659338,28291.43482284275,16774138.636639696,true,1062.0,1062,0.875,10618.628918272529,12135.575906597176,1516.9469883246475,0.0,0.0,1062,37803.10026254131,0.0,10618.628918272529,10618.628918272529,2434214.8201865787,700.0,743400.0,490.2644173977315,1199289.806321258,8833.034129324356,86917.31819258271,0.0,0.0,1129.5340954170451,1146376.2553910827,165.79627613339517,1631.4402816570937,-10618.628918272529,-4501897.694892335,true,true,10.28208682,10168.313290639962,0.0,1644.2724500334996,1062.0,10.28208682,10168.313290639962,0.0,121.92,0.0 -1063,34585.57590659718,33885.57590659718,0.30500000000000005,10992.433138845763,5156018.37015866,700.0,744100.0,38335.84635687135,21957500.42001621,27343.413218025584,16801482.04985772,true,1063.0,1063,0.875,9618.378996490042,10992.433138845763,1374.0541423557206,0.0,0.0,1063,33885.57590659718,0.0,9618.378996490042,9618.378996490042,2443833.1991830687,700.0,744100.0,566.0957649040934,1199855.902086162,7722.332564552728,94639.65075713543,0.0,0.0,1185.0022876291405,1147561.2576787118,144.9483794040796,1776.3886610611733,-9618.378996490042,-4511516.073888825,true,true,10.72913407,10179.042424709962,0.0,1644.2724500334996,1063.0,10.72913407,10179.042424709962,0.0,121.92,0.0 -1064,33442.433138845765,32742.433138845765,0.29250000000000004,9598.753693228804,5165617.123851889,700.0,744800.0,35209.414335824964,21992709.834352035,25610.660642596158,16827092.71050032,true,1064.0,1064,0.875,8398.909481575203,9598.753693228804,1199.8442116536007,0.0,0.0,1064,32742.433138845765,0.0,8398.909481575203,8398.909481575203,2452232.108664644,700.0,744800.0,633.6592773480427,1200489.56136351,6414.465175447712,101054.11593258314,0.0,0.0,1230.3853536614813,1148791.6430323732,120.39967511796819,1896.7883361791414,-8398.909481575203,-4519914.9833704,true,true,11.08677187,10190.129196579961,0.0,1644.2724500334996,1064.0,11.08677187,10190.129196579961,0.0,121.92,0.0 -1065,32048.753693228806,31348.753693228806,0.30500000000000005,9963.315240260683,5175580.43909215,700.0,745500.0,34961.689312330105,22027671.523664366,24998.374072069422,16852091.08457239,true,1065.0,1065,0.875,8717.900835228098,9963.315240260683,1245.414405032585,0.0,0.0,1065,31348.753693228806,0.0,8717.900835228098,8717.900835228098,2460950.009499872,700.0,745500.0,698.0522652830352,1201187.613628793,6624.7755077193515,107678.8914403025,0.0,0.0,1270.7258568013397,1150062.3688891744,124.34720542437229,2021.1355416035137,-8717.900835228098,-4528632.884205628,true,true,11.44440967,10201.573606249962,0.0,1644.2724500334996,1065.0,11.44440967,10201.573606249962,0.0,121.92,0.0 -1066,32413.315240260683,31713.315240260683,0.3175,11352.63286946551,5186933.071961615,700.0,746200.0,37961.04840776538,22065632.572072133,26608.415538299872,16878699.50011069,true,1066.0,1066,0.875,9933.55376078232,11352.63286946551,1419.0791086831887,0.0,0.0,1066,31713.315240260683,0.0,9933.55376078232,9933.55376078232,2470883.5632606545,700.0,746200.0,771.0978662389034,1201958.7114950318,7704.259112624059,115383.15055292656,0.0,0.0,1313.5876416694323,1151375.9565308439,144.60914024992542,2165.744681853439,-9933.55376078232,-4538566.43796641,true,true,11.8467522,10213.420358449961,0.0,1644.2724500334996,1066.0,11.8467522,10213.420358449961,0.0,121.92,0.0 -1067,33802.63286946551,33102.63286946551,0.23500000000000001,5538.2951540358345,5192471.367115651,700.0,746900.0,26545.9368256844,22092178.50889782,21007.641671648566,16899707.14178234,true,1067.0,1067,0.875,4846.008259781355,5538.2951540358345,692.2868942544792,0.0,0.0,1067,33102.63286946551,0.0,4846.008259781355,4846.008259781355,2475729.5715204356,700.0,746900.0,825.6157303219805,1202784.3272253538,2627.2362189622645,118010.38677188882,0.0,0.0,1343.8430195883116,1152719.7995504322,49.31329090879901,2215.057972762238,-4846.008259781355,-4543412.446226192,true,true,11.98086638,10225.40122482996,0.0,1644.2724500334996,1067.0,11.98086638,10225.40122482996,0.0,121.92,0.0 -1068,27988.295154035834,27288.295154035834,0.29250000000000004,8775.05400515458,5201246.421120806,700.0,747600.0,32393.3470261695,22124571.855923988,23618.29302101492,16923325.434803355,true,1068.0,1068,0.875,7678.1722545102575,8775.05400515458,1096.881750644322,0.0,0.0,1068,27288.295154035834,0.0,7678.1722545102575,7678.1722545102575,2483407.743774946,700.0,747600.0,868.1488445557432,1203652.4760699095,5343.1969145586945,123353.58368644751,0.0,0.0,1366.5345528864746,1154086.3341033186,100.291942509345,2315.349915271583,-7678.1722545102575,-4551090.618480702,true,true,12.24909473,10237.65031955996,0.0,1644.2724500334996,1068.0,12.24909473,10237.65031955996,0.0,121.92,0.0 -1069,31225.05400515458,30525.05400515458,0.28625,7936.754314630945,5209183.175435437,700.0,748300.0,30172.06747469326,22154743.92339868,22235.313160062316,16945560.747963417,true,1069.0,1069,0.875,6944.660025302077,7936.754314630945,992.0942893288684,0.0,0.0,1069,30525.05400515458,0.0,6944.660025302077,6944.660025302077,2490352.4038002477,700.0,748300.0,922.0866322084482,1204574.562702118,4543.0319189054735,127896.61560535298,0.0,0.0,1394.2686490771202,1155480.6027523957,85.27282511103483,2400.622740382618,-6944.660025302077,-4558035.278506004,true,true,12.47261836,10250.12293791996,0.0,1644.2724500334996,1069.0,12.47261836,10250.12293791996,0.0,121.92,0.0 -1070,30386.754314630947,29686.754314630947,0.265,7025.951695967306,5216209.127131404,700.0,749000.0,29154.534701763416,22183898.458100446,22128.58300579611,16967689.330969214,true,1070.0,1070,0.875,6147.707733971392,7025.951695967306,878.2439619959132,0.0,0.0,1070,29686.754314630947,0.0,6147.707733971392,6147.707733971392,2496500.1115342192,700.0,749000.0,967.8438146084426,1205542.4065167264,3693.575235512339,131590.1908408653,0.0,0.0,1416.9601823752832,1156897.562934771,69.32850147532703,2469.9512418579448,-6147.707733971392,-4564182.986239975,true,true,12.65143726,10262.774375179959,0.0,1644.2724500334996,1070.0,12.65143726,10262.774375179959,0.0,121.92,0.0 -1071,29475.951695967306,28775.951695967306,0.12,0.0,5216209.127131404,700.0,749700.0,5833.333333333334,22189731.791433778,5833.333333333334,16973522.664302547,true,1071.0,1071,0.875,0.0,0.0,0.0,0.0,0.0,1071,28775.951695967306,0.0,-434.69867426491624,-434.69867426491624,2496065.4128599544,700.0,749700.0,973.0194384315259,1206515.425955158,-2775.1106779563092,128815.080162909,0.0,0.0,1419.4814635395317,1158317.0443983106,-52.088898279664605,2417.86234357828,-0.0,-4564182.986239975,true,true,12.51732308,10275.291698259958,0.0,1644.2724500334996,1071.0,12.51732308,10275.291698259958,0.0,121.92,0.0 -1072,22450.0,21750.0,0.12,0.0,5216209.127131404,700.0,750400.0,5833.333333333334,22195565.12476711,5833.333333333334,16979355.99763588,true,1072.0,1072,0.875,0.0,0.0,0.0,0.0,0.0,1072,21750.0,0.0,-2313.6050125599213,-2313.6050125599213,2493751.8078473946,700.0,750400.0,932.127414067149,1207447.553369225,-4559.462412144059,124255.61775076494,0.0,0.0,1399.311211405617,1159716.3556097161,-85.58122588862797,2332.281117689652,-0.0,-4564182.986239975,true,true,12.29379945,10287.585497709959,0.0,1644.2724500334996,1072.0,12.29379945,10287.585497709959,0.0,121.92,0.0 -1073,22450.0,21750.0,0.12,0.0,5216209.127131404,700.0,751100.0,5833.333333333334,22201398.45810044,5833.333333333334,16985189.33096921,true,1073.0,1073,0.875,0.0,0.0,0.0,0.0,0.0,1073,21750.0,0.0,-2304.6060187210624,-2304.6060187210624,2491447.2018286735,700.0,751100.0,882.6445388610508,1208330.197908086,-4477.30973645687,119778.30801430807,0.0,0.0,1374.0983969432057,1161090.4540066593,-84.03921806844889,2248.241899621203,-0.0,-4564182.986239975,true,true,12.07027583,10299.655773539958,0.0,1644.2724500334996,1073.0,12.07027583,10299.655773539958,0.0,121.92,0.0 -1074,22450.0,21750.0,0.1816,2537.2180003338285,5218746.345131738,700.0,751800.0,17826.090310208307,22219224.54841065,15288.872309874478,17000478.203279085,true,1074.0,1074,0.875,2220.0657502921,2537.2180003338285,317.1522500417286,0.0,0.0,1074,21750.0,0.0,2220.0657502921,2220.0657502921,2493667.2675789655,700.0,751800.0,858.5737602981075,1209188.771668384,0.0,119778.30801430807,0.0,0.0,1361.4919899939923,1162451.9459966533,0.0,2248.241899621203,-2220.0657502921,-4566403.051990268,true,true,12.07027583,10311.726049369958,0.0,1644.2724500334996,1074.0,12.07027583,10311.726049369958,0.0,121.92,0.0 -1075,24987.21800033383,24287.21800033383,0.12,0.0,5218746.345131738,700.0,752500.0,5833.333333333334,22225057.881743982,5833.333333333334,17006311.536612418,true,1075.0,1075,0.875,0.0,0.0,0.0,0.0,0.0,1075,24287.21800033383,0.0,-4075.823306740551,-4075.823306740551,2489591.444272225,700.0,752500.0,825.6157303219805,1210014.387398706,-6130.217713648287,113648.09030065978,0.0,0.0,1343.8430195883116,1163795.7890162417,-115.06434300255579,2133.1775566186475,-0.0,-4566403.051990268,true,true,11.75734275,10323.483392119957,0.0,1644.2724500334996,1075.0,11.75734275,10323.483392119957,0.0,121.92,0.0 -1076,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,753200.0,5833.333333333334,22230891.215077315,5833.333333333334,17012144.86994575,true,1076.0,1076,0.875,0.0,0.0,0.0,0.0,0.0,1076,21750.0,0.0,-13310.430361669883,-13310.430361669883,2476281.013910555,700.0,753200.0,714.8048141930616,1210729.1922128992,-15024.04446088687,98624.04583977291,0.0,0.0,1280.8109831502898,1165076.599999392,-282.0016981263647,1851.1758584922827,-0.0,-4566403.051990268,true,true,10.9526577,10334.436049819957,0.0,1644.2724500334996,1076.0,10.9526577,10334.436049819957,0.0,121.92,0.0 -1077,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,753900.0,5833.333333333334,22236724.548410647,5833.333333333334,17017978.20327908,true,1077.0,1077,0.875,0.0,0.0,0.0,0.0,0.0,1077,21750.0,0.0,-13983.464011363565,-13983.464011363565,2462297.549899191,700.0,753900.0,566.095764904093,1211295.2879778033,-15444.66530184629,83179.38053792663,0.0,0.0,1185.0022876291403,1166261.602287021,-289.8967620505099,1561.2790964417727,-0.0,-4566403.051990268,true,true,10.05856319,10344.494613009956,0.0,1644.2724500334996,1077.0,10.05856319,10344.494613009956,0.0,121.92,0.0 -1078,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,754600.0,5833.333333333334,22242557.88174398,5833.333333333334,17023811.536612414,true,1078.0,1078,0.875,0.0,0.0,0.0,0.0,0.0,1078,21750.0,0.0,-5791.2838163990045,-5791.2838163990045,2456506.266082792,700.0,754600.0,464.4664631892949,1211759.7544409926,-7229.417767027643,75949.96277089899,0.0,0.0,1109.3638435087248,1167370.9661305298,-135.69635606938056,1425.5827403723922,-0.0,-4566403.051990268,true,true,9.611515937,10354.106128946956,0.0,1644.2724500334996,1078.0,9.611515937,10354.106128946956,0.0,121.92,0.0 -1079,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,755300.0,5833.333333333334,22248391.21507731,5833.333333333334,17029644.869945746,true,1079.0,1079,0.875,0.0,0.0,0.0,0.0,0.0,1079,21750.0,0.0,-4874.050312505836,-4874.050312505836,2451632.215770286,700.0,755300.0,406.8577746052386,1212166.6122155979,-6225.514516435229,69724.44825446376,0.0,0.0,1061.4594957481497,1168432.425626278,-116.85306642399509,1308.729673948397,-0.0,-4566403.051990268,true,true,9.20917341,10363.315302356956,0.0,1644.2724500334996,1079.0,9.20917341,10363.315302356956,0.0,121.92,0.0 -1080,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,756000.0,5833.333333333334,22254224.548410643,5833.333333333334,17035478.203279078,true,1080.0,1080,0.875,0.0,0.0,0.0,0.0,0.0,1080,21750.0,0.0,-15512.353976716528,-15512.353976716528,2436119.8617935693,700.0,756000.0,313.58714113416886,1212480.199356732,-16489.644710190758,53234.803544273,0.0,0.0,973.214644565724,1169405.6402708436,-309.5110522256618,999.2186217227352,-0.0,-4566403.051990268,true,true,8.046850552,10371.362152908956,0.0,1644.2724500334996,1080.0,8.046850552,10371.362152908956,0.0,121.92,0.0 -1081,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,756700.0,5833.333333333334,22260057.881743975,5833.333333333334,17041311.53661241,true,1081.0,1081,0.875,0.0,0.0,0.0,0.0,0.0,1081,21750.0,0.0,-15543.537104922045,-15543.537104922045,2420576.3246886474,700.0,756700.0,195.94678914802216,1212676.14614588,-16266.189975536578,36968.61356873643,0.0,0.0,832.022882617444,1170237.6631534612,-305.31680115093235,693.9018205718028,-0.0,-4566403.051990268,true,true,6.705708793,10378.067861701957,0.0,1644.2724500334996,1081.0,6.705708793,10378.067861701957,0.0,121.92,0.0 -1082,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,757400.0,5833.333333333334,22265891.215077307,5833.333333333334,17047144.869945742,true,1082.0,1082,0.875,0.0,0.0,0.0,0.0,0.0,1082,21750.0,0.0,-11538.991188785352,-11538.991188785352,2409037.333499862,700.0,757400.0,110.93900665658364,1212787.0851525366,-12110.917798427517,24857.695770308914,0.0,0.0,688.3098392793212,1170925.9729927406,-227.32223629373965,466.5795842780631,-0.0,-4566403.051990268,true,true,5.498681211,10383.566542912957,0.0,1644.2724500334996,1082.0,5.498681211,10383.566542912957,0.0,121.92,0.0 -1083,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,758100.0,5833.333333333334,22271724.54841064,5833.333333333334,17052978.203279074,true,1083.0,1083,0.875,0.0,0.0,0.0,0.0,0.0,1083,21750.0,0.0,-4040.439598811062,-4040.439598811062,2404996.893901051,700.0,758100.0,69.86246483902484,1212856.9476173758,-4613.682978600243,20244.012791708672,0.0,0.0,589.979862255532,1171515.952854996,-86.59894730537631,379.9806369726868,-0.0,-4566403.051990268,true,true,4.962224507,10388.528767419957,0.0,1644.2724500334996,1083.0,4.962224507,10388.528767419957,0.0,121.92,0.0 -1084,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,758800.0,5833.333333333334,22277557.88174397,5833.333333333334,17058811.536612406,true,1084.0,1084,0.875,0.0,0.0,0.0,0.0,0.0,1084,21750.0,0.0,-1213.336669800846,-1213.336669800846,2403783.55723125,700.0,758800.0,55.715435990423586,1212912.6630533661,-1782.7086954488248,18461.304096259846,0.0,0.0,547.1180773874396,1172063.0709323834,-33.4614877298845,346.5191492428023,-0.0,-4566403.051990268,true,true,4.738700881,10393.267468300957,0.0,1644.2724500334996,1084.0,4.738700881,10393.267468300957,0.0,121.92,0.0 -1085,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,759500.0,5833.333333333334,22283391.215077303,5833.333333333334,17064644.86994574,true,1085.0,1085,0.875,0.0,0.0,0.0,0.0,0.0,1085,21750.0,0.0,-1501.8787092038656,-1501.8787092038656,2402281.678522046,700.0,759500.0,47.66482391161534,1212960.3278772777,-2030.8091743712848,16430.49492188856,0.0,0.0,519.3839813095913,1172582.454913693,-38.11834005378715,308.40080918901515,-0.0,-4566403.051990268,true,true,4.470472529,10397.737940829957,0.0,1644.2724500334996,1085.0,4.470472529,10397.737940829957,0.0,121.92,0.0 -1086,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,760200.0,5833.333333333334,22289224.548410635,5833.333333333334,17070478.20327907,true,1086.0,1086,0.875,0.0,0.0,0.0,0.0,0.0,1086,21750.0,0.0,-1099.9627853746183,-1099.9627853746183,2401181.7157366714,700.0,760200.0,40.42966714293786,1213000.7575444207,-1601.9732587248811,14828.521663163678,0.0,0.0,491.6498851753443,1173074.1047988683,-30.069078968019408,278.3317302209957,-0.0,-4566403.051990268,true,true,4.246948902,10401.984889731957,0.0,1644.2724500334996,1086.0,4.246948902,10401.984889731957,0.0,121.92,0.0 -1087,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,760900.0,5833.333333333334,22295057.881743968,5833.333333333334,17076311.536612403,true,1087.0,1087,0.875,0.0,0.0,0.0,0.0,0.0,1087,21750.0,0.0,-741.3293836964052,-741.3293836964052,2400440.386352975,700.0,760900.0,35.0861054506984,1213035.8436498714,-1222.4288209565434,13606.092842207134,0.0,0.0,468.9583519899782,1173543.0631508583,-22.945020180538386,255.38671004045733,-0.0,-4566403.051990268,true,true,4.068130001,10406.053019732957,0.0,1644.2724500334996,1087.0,4.068130001,10406.053019732957,0.0,121.92,0.0 -1088,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,761600.0,5833.333333333334,22300891.2150773,5833.333333333334,17082144.869945735,true,1088.0,1088,0.875,0.0,0.0,0.0,0.0,0.0,1088,21750.0,0.0,-712.2704802547668,-712.2704802547668,2399728.1158727203,700.0,761600.0,30.750794331472743,1213066.594444203,-1169.8512373005917,12436.241604906541,0.0,0.0,448.7881003072519,1173991.8512511656,-21.95813759289969,233.42857244755766,-0.0,-4566403.051990268,true,true,3.8893111,10409.942330832957,0.0,1644.2724500334996,1088.0,3.8893111,10409.942330832957,0.0,121.92,0.0 -1089,22450.0,21750.0,0.124,199.80610679073285,5218946.151238529,700.0,762300.0,7256.500861215588,22308147.715938516,7056.694754424855,17089201.56470016,true,1089.0,1089,0.875,174.83034344189124,199.80610679073285,24.97576334884161,0.0,0.0,1089,21750.0,0.0,174.83034344189124,174.83034344189124,2399902.9462161623,700.0,762300.0,28.23154468499448,1213094.825988888,-284.2475602985086,12151.994044608033,0.0,0.0,436.1816930196476,1174428.0329441852,-5.335333964242216,228.09323848331545,-174.83034344189124,-4566577.88233371,true,true,3.844606375,10413.786937207957,0.0,1644.2724500334996,1089.0,3.844606375,10413.786937207957,0.0,121.92,0.0 -1090,22649.806106790733,21949.806106790733,0.15600000000000003,1199.931984501665,5220146.083223031,700.0,763000.0,12179.051182702979,22320326.76712122,10979.119198201313,17100180.683898363,true,1090.0,1090,0.875,1049.940486438957,1199.931984501665,149.99149806270816,0.0,0.0,1090,21949.806106790733,0.0,1049.940486438957,1049.940486438957,2400952.8867026013,700.0,763000.0,28.723944344784705,1213123.5499332328,571.7812195387614,12723.775264146794,0.0,0.0,438.7029744658887,1174866.735918651,10.732348089522032,238.82558657283747,-1049.940486438957,-4567627.822820148,true,true,3.934015825,10417.720953032956,0.0,1644.2724500334996,1090.0,3.934015825,10417.720953032956,0.0,121.92,0.0 -1091,23649.931984501665,22949.931984501665,0.15600000000000003,1229.0783833347662,5221375.161606366,700.0,763700.0,12365.887072658756,22332692.65419388,11136.808689323989,17111317.492587686,true,1091.0,1091,0.875,1075.4435854179203,1229.0783833347662,153.63479791684586,0.0,0.0,1091,22949.931984501665,0.0,1075.4435854179203,1075.4435854179203,2402028.330288019,700.0,763700.0,30.750794331472743,1213154.3007275644,584.9256219213482,13308.700886068142,0.0,0.0,448.7881003072519,1175315.5240189584,10.979068857847556,249.80465543068502,-1075.4435854179203,-4568703.266405567,true,true,4.023425276,10421.744378308957,0.0,1644.2724500334996,1091.0,4.023425276,10421.744378308957,0.0,121.92,0.0 -1092,23679.078383334767,22979.078383334767,0.12,0.0,5221375.161606366,700.0,764400.0,5833.333333333334,22338525.98752721,5833.333333333334,17117150.825921018,true,1092.0,1092,0.875,0.0,0.0,0.0,0.0,0.0,1092,22979.078383334767,0.0,-412.33311657663637,-412.33311657663637,2401615.9971714425,700.0,764400.0,30.23542870708126,1213184.5361562714,-872.459281161601,12436.241604906541,0.0,0.0,446.26681886101073,1175761.7908378195,-16.37608298312737,233.42857244755766,-0.0,-4568703.266405567,true,true,3.8893111,10425.633689408956,0.0,1644.2724500334996,1092.0,3.8893111,10425.633689408956,0.0,121.92,0.0 -1093,22450.0,21750.0,0.124,199.80610679073285,5221574.967713157,700.0,765100.0,7256.500861215588,22345782.488388427,7056.694754424855,17124207.520675443,true,1093.0,1093,0.875,174.83034344189124,199.80610679073285,24.97576334884161,0.0,0.0,1093,21750.0,0.0,174.83034344189124,174.83034344189124,2401790.8275148845,700.0,765100.0,28.23154468499448,1213212.7677009564,-284.2475602985086,12151.994044608033,0.0,0.0,436.1816930196476,1176197.972530839,-5.335333964242216,228.09323848331545,-174.83034344189124,-4568878.096749009,true,true,3.844606375,10429.478295783956,0.0,1644.2724500334996,1093.0,3.844606375,10429.478295783956,0.0,121.92,0.0 -1094,22649.806106790733,21949.806106790733,0.12,0.0,5221574.967713157,700.0,765800.0,5833.333333333334,22351615.82172176,5833.333333333334,17130040.854008775,true,1094.0,1094,0.875,0.0,0.0,0.0,0.0,0.0,1094,21949.806106790733,0.0,-1223.7199069153396,-1223.7199069153396,2400567.107607969,700.0,765800.0,24.941386701435896,1213237.709087658,-1636.4772957755172,10515.516748832515,0.0,0.0,418.53272278316234,1176616.5052536223,-30.716720624420702,197.37651785889474,-0.0,-4568878.096749009,true,true,3.576378023,10433.054673806957,0.0,1644.2724500334996,1094.0,3.576378023,10433.054673806957,0.0,121.92,0.0 -1095,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,766500.0,5833.333333333334,22357449.15505509,5833.333333333334,17135874.187342107,true,1095.0,1095,0.875,0.0,0.0,0.0,0.0,0.0,1095,21750.0,0.0,-2114.2399253167687,-2114.2399253167687,2398452.867682652,700.0,766500.0,18.40221535800934,1213256.111303016,-2464.5742386508387,8050.942510181676,0.0,0.0,378.1922193613111,1176994.6974729835,-46.260121385250685,151.11639647364404,-0.0,-4568878.096749009,true,true,3.12933077,10436.184004576957,0.0,1644.2724500334996,1095.0,3.12933077,10436.184004576957,0.0,121.92,0.0 -1096,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,767200.0,5833.333333333334,22363282.488388423,5833.333333333334,17141707.52067544,true,1096.0,1096,0.875,0.0,0.0,0.0,0.0,0.0,1096,21750.0,0.0,-3705.3592660305153,-3705.3592660305153,2394747.5084166215,700.0,767200.0,9.421934261193188,1213265.5332372773,-3943.3187815473157,4107.62372863436,0.0,0.0,302.55377546648947,1177297.25124845,-74.01619421088212,77.10020226276193,-0.0,-4568878.096749009,true,true,2.235236264,10438.419240840956,0.0,1644.2724500334996,1096.0,2.235236264,10438.419240840956,0.0,121.92,0.0 -1097,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,767900.0,5833.333333333334,22369115.821721755,5833.333333333334,17147540.85400877,true,1097.0,1097,0.875,0.0,0.0,0.0,0.0,0.0,1097,21750.0,0.0,-995.7790272344416,-995.7790272344416,2393751.729389387,700.0,767900.0,4.245802746309739,1213269.7790400237,-1209.284424969051,2898.339303665309,0.0,0.0,231.95789452054868,1177529.2091429706,-22.69829953224901,54.401902730512916,-0.0,-4568878.096749009,true,true,1.877598462,10440.296839302957,0.0,1644.2724500334996,1097.0,1.877598462,10440.296839302957,0.0,121.92,0.0 -1098,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,768600.0,5833.333333333334,22374949.155055087,5833.333333333334,17153374.187342104,true,1098.0,1098,0.875,0.0,0.0,0.0,0.0,0.0,1098,21750.0,0.0,-1648.0302715308517,-1648.0302715308517,2392103.699117856,700.0,768600.0,1.7144430762497151,1213271.4934830999,-1787.6378460666385,1110.7014575986707,0.0,0.0,171.44713947236963,1177700.656282443,-33.554008012832455,20.84789471768046,-0.0,-4568878.096749009,true,true,1.162322858,10441.459162160956,0.0,1644.2724500334996,1098.0,1.162322858,10441.459162160956,0.0,121.92,0.0 -1099,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,769300.0,5833.333333333334,22380782.48838842,5833.333333333334,17159207.520675436,true,1099.0,1099,0.875,0.0,0.0,0.0,0.0,0.0,1099,21750.0,0.0,-873.1398700203347,-873.1398700203347,2391230.5592478355,700.0,769300.0,0.25439222543158274,1213271.7478753254,-946.396508306423,164.30494929224767,0.0,0.0,90.76613268506568,1177791.4224151282,-17.763886624408947,3.084008093271514,-0.0,-4568878.096749009,true,true,0.447047253,10441.906209413955,0.0,1644.2724500334996,1099.0,0.447047253,10441.906209413955,0.0,121.92,0.0 -1100,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,770000.0,5833.333333333334,22386615.82172175,5833.333333333334,17165040.854008768,true,1100.0,1100,0.875,0.0,0.0,0.0,0.0,0.0,1100,21750.0,0.0,-142.17069024579726,-142.17069024579726,2391088.3885575896,700.0,770000.0,0.005452508259103674,1213271.7533278337,-164.30494929239373,-1.460591647628462e-10,0.0,0.0,25.212814631607213,1177816.6352297598,-3.084008093269858,1.6560086635308835e-12,-0.0,-4568878.096749009,true,true,0.0,10441.906209413955,0.0,1644.2724500334996,1100.0,0.0,10441.906209413955,0.0,121.92,0.0 -1101,22450.0,21750.0,0.12,4.7944873715885725,5221579.762200529,700.0,770700.0,5873.287394763239,22392489.109116513,5868.49290739165,17170909.346916158,true,1101.0,1101,0.875,4.195176450140001,4.7944873715885725,0.5993109214485717,0.0,0.0,1101,21750.0,0.0,4.195176450140001,4.195176450140001,2391092.5837340397,700.0,770700.0,5.452508149333234e-6,1213271.7533332861,1.643049470871913,1.6430494707258538,0.0,0.0,2.521281446241158,1177819.1565112062,0.030840080518781524,0.030840080520437532,-4.195176450140001,-4568882.291925459,true,true,0.044704725,10441.950914138955,0.0,1644.2724500334996,1101.0,0.044704725,10441.950914138955,0.0,121.92,0.0 -1102,22454.79448737159,21754.79448737159,0.124,87.127972164718,5221666.890172694,700.0,771400.0,6347.806227134823,22398836.91534365,6260.678254970105,17177170.025171127,true,1102.0,1102,0.875,76.23697564412825,87.127972164718,10.890996520589752,0.0,0.0,1102,21754.79448737159,0.0,76.23697564412825,76.23697564412825,2391168.820709684,700.0,771400.0,0.0018702103310796435,1213271.7552034964,57.50673236259794,59.14978183332379,0.0,0.0,17.648970236485194,1177836.8054814427,1.0794028347140356,1.1102429152344733,-76.23697564412825,-4568958.528901103,true,true,0.268228352,10442.219142490956,0.0,1644.2724500334996,1102.0,0.268228352,10442.219142490956,0.0,121.92,0.0 -1103,22537.12797216472,21837.12797216472,0.136,484.322236478105,5222151.212409172,700.0,772100.0,8708.251738809595,22407545.16708246,8223.92950233149,17185393.954673458,true,1103.0,1103,0.875,423.7819569183419,484.322236478105,60.54027955976312,0.0,0.0,1103,21837.12797216472,0.0,423.7819569183419,423.7819569183419,2391592.6026666025,700.0,772100.0,0.05805830801377445,1213271.8132618044,361.47088859027974,420.62067042360354,0.0,0.0,55.46819221209528,1177892.2736736548,6.784817807953136,7.895060723187609,-423.7819569183419,-4569382.3108580215,true,true,0.715275605,10442.934418095956,0.0,1644.2724500334996,1103.0,0.715275605,10442.934418095956,0.0,121.92,0.0 -1104,22934.322236478103,22234.322236478103,0.1744,2140.2496648522915,5224291.462074025,700.0,772800.0,16285.83523424479,22423831.002316702,14145.585569392499,17199539.54024285,true,1104.0,1104,0.875,1872.718456745755,2140.2496648522915,267.5312081065365,0.0,0.0,1104,22234.322236478103,0.0,1872.718456745755,1872.718456745755,2393465.321123348,700.0,772800.0,0.7666662807024109,1213272.5799280852,1708.771470288679,2129.3921407122825,0.0,0.0,131.10663605051838,1178023.3803097054,32.073684125855365,39.96874484904298,-1872.718456745755,-4571255.029314768,true,true,1.60937011,10444.543788205956,0.0,1644.2724500334996,1104.0,1.60937011,10444.543788205956,0.0,121.92,0.0 -1105,24590.24966485229,23890.24966485229,0.265,6938.370154705862,5231229.83222873,700.0,773500.0,28824.03831964476,22452655.040636346,21885.668164938896,17221425.20840779,true,1105.0,1105,0.875,6071.073885367629,6938.370154705862,867.2962693382324,0.0,0.0,1105,23890.24966485229,0.0,6071.073885367629,6071.073885367629,2399536.395008716,700.0,773500.0,6.311959867393796,1213278.8918879526,5693.1664915480615,7822.558632260344,0.0,0.0,264.7345535472779,1178288.1148632527,106.86088040489594,146.8296252539389,-6071.073885367629,-4577326.103200135,true,true,3.084626045,10447.628414250956,0.0,1644.2724500334996,1105.0,3.084626045,10447.628414250956,0.0,121.92,0.0 -1106,29388.370154705863,28688.370154705863,0.30500000000000005,10539.339721898768,5241769.171950629,700.0,774200.0,36850.29417015989,22489505.334806506,26310.954448261124,17247736.16285605,true,1106.0,1106,0.875,9221.922256661423,10539.339721898768,1317.4174652373458,0.0,0.0,1106,28688.370154705863,0.0,9221.922256661423,9221.922256661423,2408758.3172653774,700.0,774200.0,26.318215919850086,1213305.2101038725,8607.936289628213,16430.494921888556,0.0,0.0,426.09656717828443,1178714.211430431,161.57118393507622,308.40080918901515,-9221.922256661423,-4586548.025456796,true,true,4.470472529,10452.098886779955,0.0,1644.2724500334996,1106.0,4.470472529,10452.098886779955,0.0,121.92,0.0 -1107,32989.33972189877,32289.339721898767,0.33,12943.52943332479,5254712.701383954,700.0,774900.0,41344.02858583269,22530849.36339234,28400.499152507902,17276136.662008557,true,1107.0,1107,0.875,11325.588254159191,12943.52943332479,1617.9411791655984,0.0,0.0,1107,32289.339721898767,0.0,11325.588254159191,11325.588254159191,2420083.9055195367,700.0,774900.0,64.62504712415351,1213369.8351509967,10489.227957004678,26919.722878893233,0.0,0.0,574.8521734652879,1179289.0636038964,196.8830765650735,505.28388575408866,-11325.588254159191,-4597873.613710956,true,true,5.722204837,10457.821091616956,0.0,1644.2724500334996,1107.0,5.722204837,10457.821091616956,0.0,121.92,0.0 -1108,35393.52943332479,34693.52943332479,0.265,7044.4419655374195,5261757.143349491,700.0,775600.0,29224.30930391479,22560073.67269625,22179.86733837737,17298316.529346935,true,1108.0,1108,0.875,6163.886719845242,7044.4419655374195,880.5552456921778,0.0,0.0,1108,34693.52943332479,0.0,6163.886719845242,6163.886719845242,2426247.792239382,700.0,775600.0,104.95441539502589,1213474.7895663916,5284.047172124855,32203.770051018088,0.0,0.0,675.7034319917168,1179964.767035888,99.18170033364402,604.4655860877326,-6163.886719845242,-4604037.500430801,true,true,6.258661541,10464.079753157956,0.0,1644.2724500334996,1108.0,6.258661541,10464.079753157956,0.0,121.92,0.0 -1109,29494.44196553742,28794.44196553742,0.196,3691.518455978318,5265448.66180547,700.0,776300.0,22405.70640805264,22582479.379104305,18714.18795207432,17317030.71729901,true,1109.0,1109,0.875,3230.078648981028,3691.518455978318,461.4398069972899,0.0,0.0,1109,28794.44196553742,0.0,3230.078648981028,3230.078648981028,2429477.870888363,700.0,776300.0,126.22079517922248,1213601.0103615709,2341.3455217198293,34545.115572737915,0.0,0.0,718.5652168598092,1180683.3322527478,43.9471152221668,648.4127013098994,-3230.078648981028,-4607267.579079782,true,true,6.482185167,10470.561938324956,0.0,1644.2724500334996,1109.0,6.482185167,10470.561938324956,0.0,121.92,0.0 -1110,26141.518455978316,25441.518455978316,0.30500000000000005,9807.700126640793,5275256.36193211,700.0,777000.0,34451.47582505178,22616930.854929358,24643.775698410984,17341674.492997423,true,1110.0,1110,0.875,8581.737610810695,9807.700126640793,1225.9625158300987,0.0,0.0,1110,25441.518455978316,0.0,8581.737610810695,8581.737610810695,2438059.608499174,700.0,777000.0,154.7019720258185,1213755.7123335968,7516.951422592578,42062.06699533049,0.0,0.0,768.9908460666252,1181452.3230988146,141.09337012567445,789.5060714355739,-8581.737610810695,-4615849.316690592,true,true,7.152756046,10477.714694370956,0.0,1644.2724500334996,1110.0,7.152756046,10477.714694370956,0.0,121.92,0.0 -1111,32257.700126640793,31557.700126640793,0.335,14928.779532776158,5290185.141464886,700.0,777700.0,46653.07323216763,22663583.928161524,31724.293699391477,17373398.786696814,true,1111.0,1111,0.875,13062.682091179138,14928.779532776158,1866.0974415970195,0.0,0.0,1111,31557.700126640793,0.0,13062.682091179138,13062.682091179138,2451122.2905903533,700.0,777700.0,216.20188130804675,1213971.914214905,11765.877411749612,53827.944407080104,0.0,0.0,859.7569786952922,1182312.0800775099,220.84581942618684,1010.3518908617607,-13062.682091179138,-4628911.998781771,true,true,8.091555277,10485.806249647956,0.0,1644.2724500334996,1111.0,8.091555277,10485.806249647956,0.0,121.92,0.0 -1112,37378.779532776156,36678.779532776156,0.33999999999999997,15290.803593651983,5305475.945058539,700.0,778400.0,47031.77527544701,22710615.70343697,31740.971681795032,17405139.75837861,true,1112.0,1112,0.875,13379.453144445484,15290.803593651983,1911.3504492064985,0.0,0.0,1112,36678.779532776156,0.0,13379.453144445484,13379.453144445484,2464501.743734799,700.0,778400.0,301.55828085491146,1214273.4724957598,11894.035280474556,65721.97968755466,0.0,0.0,960.6082372217212,1183272.6883147317,223.2513458942948,1233.6032367560556,-13379.453144445484,-4642291.4519262165,true,true,8.940945058,10494.747194705957,0.0,1644.2724500334996,1112.0,8.940945058,10494.747194705957,0.0,121.92,0.0 -1113,37740.80359365198,37040.80359365198,0.29250000000000004,9454.245682816474,5314930.190741355,700.0,779100.0,34715.36985578281,22745331.073292755,25261.124172966338,17430400.882551577,true,1113.0,1113,0.875,8272.464972464415,9454.245682816474,1181.780710352059,0.0,0.0,1113,37040.80359365198,0.0,8272.464972464415,8272.464972464415,2472774.208707263,700.0,779100.0,375.79232147965234,1214649.2648172395,6736.502919517991,72458.48260707266,0.0,0.0,1033.7253996703016,1184306.413714402,126.44433179646937,1360.047568552525,-8272.464972464415,-4650563.916898681,true,true,9.387992311,10504.135187016956,0.0,1644.2724500334996,1113.0,9.387992311,10504.135187016956,0.0,121.92,0.0 -1114,31904.245682816472,31204.245682816472,0.196,3298.8656666378765,5318229.056407993,700.0,779800.0,20402.375850193246,22765733.449142948,17103.51018355537,17447504.39273513,true,1114.0,1114,0.875,2886.507458308142,3298.8656666378765,412.3582083297347,0.0,0.0,1114,31204.245682816472,0.0,2886.507458308142,2886.507458308142,2475660.7161655715,700.0,779800.0,409.7638906038589,1215059.0287078433,1386.733762383714,73845.21636945636,0.0,0.0,1063.980777194391,1185370.3944915964,26.029028126177998,1386.076596678703,-2886.507458308142,-4653450.424356989,true,true,9.477401761,10513.612588777956,0.0,1644.2724500334996,1114.0,9.477401761,10513.612588777956,0.0,121.92,0.0 -1115,25748.865666637877,25048.865666637877,0.1816,2516.0147491197868,5320745.071157113,700.0,780500.0,17709.332318941557,22783442.78146189,15193.317569821771,17462697.710304953,true,1115.0,1115,0.875,2201.5129054798135,2516.0147491197868,314.50184363997323,0.0,0.0,1115,25048.865666637877,0.0,2201.5129054798135,2201.5129054798135,2477862.2290710513,700.0,780500.0,418.56520403034614,1215477.5939118736,698.2960452614277,74543.51241471778,0.0,0.0,1071.544621589513,1186441.939113186,13.107034598526546,1399.1836312772296,-2201.5129054798135,-4655651.937262468,true,true,9.522106487,10523.134695264956,0.0,1644.2724500334996,1115.0,9.522106487,10523.134695264956,0.0,121.92,0.0 -1116,24966.014749119786,24266.014749119786,0.1816,2532.388844477013,5323277.46000159,700.0,781200.0,17799.4980422743,22801242.279504165,15267.109197797286,17477964.819502752,true,1116.0,1116,0.875,2215.8402389173866,2532.388844477013,316.5486055596266,0.0,0.0,1116,24266.014749119786,0.0,2215.8402389173866,2215.8402389173866,2480078.069309969,700.0,781200.0,424.50221129221734,1215902.096123166,701.5821286197132,75245.0945433375,0.0,0.0,1076.587184538394,1187518.5262977243,13.168714467062118,1412.3523457442916,-2215.8402389173866,-4657867.777501386,true,true,9.566811212,10532.701506476957,0.0,1644.2724500334996,1116.0,9.566811212,10532.701506476957,0.0,121.92,0.0 -1117,24982.388844477013,24282.388844477013,0.20800000000000002,4214.349314161086,5327491.80931575,700.0,781900.0,23626.67939500522,22824868.95889917,19412.330080844134,17497377.149583597,true,1117.0,1117,0.875,3687.5556498909505,4214.349314161086,526.7936642701357,0.0,0.0,1117,24282.388844477013,0.0,3687.5556498909505,3687.5556498909505,2483765.62495986,700.0,781900.0,436.54411938377126,1216338.6402425496,2124.4629954606085,77369.55753879811,0.0,0.0,1086.6723103797572,1188605.1986081041,39.87622466681347,1452.228570411105,-3687.5556498909505,-4661555.333151276,true,true,9.700925388,10542.402431864957,0.0,1644.2724500334996,1117.0,9.700925388,10542.402431864957,0.0,121.92,0.0 -1118,26664.349314161085,25964.349314161085,0.29250000000000004,8576.124412901596,5336067.933728652,700.0,782600.0,31713.245856073827,22856582.204755243,23137.121443172233,17520514.271026768,true,1118.0,1118,0.875,7504.108861288897,8576.124412901596,1072.0155516126988,0.0,0.0,1118,25964.349314161085,0.0,7504.108861288897,7504.108861288897,2491269.733821149,700.0,782600.0,470.8289296721101,1216809.4691722216,5809.822999128513,83179.38053792663,0.0,0.0,1114.4064064576055,1189719.6050145617,109.0505260306675,1561.2790964417725,-7504.108861288897,-4669059.442012565,true,true,10.05856319,10552.460995054957,0.0,1644.2724500334996,1118.0,10.05856319,10552.460995054957,0.0,121.92,0.0 -1119,31026.124412901598,30326.124412901598,0.25,6250.15819208733,5342318.091920739,700.0,783300.0,27800.63276834932,22884382.83752359,21550.47457626199,17542064.74560303,true,1119.0,1119,0.875,5468.8884180764135,6250.15819208733,781.2697740109161,0.0,0.0,1119,30326.124412901598,0.0,5468.8884180764135,5468.8884180764135,2496738.6222392255,700.0,783300.0,513.6065125515006,1217323.075684773,3737.9376546560616,86917.3181925827,0.0,0.0,1147.1830656535303,1190866.7880802152,70.16118521532044,1631.440281657093,-5468.8884180764135,-4674528.330430642,true,true,10.28208682,10562.743081874956,0.0,1644.2724500334996,1119.0,10.28208682,10562.743081874956,0.0,121.92,0.0 -1120,28700.15819208733,28000.15819208733,0.29250000000000004,9149.602246985864,5351467.694167725,700.0,784000.0,33673.8538358491,22918056.69135944,24524.251588863233,17566588.99719189,true,1120.0,1120,0.875,8005.90196611263,9149.602246985864,1143.7002808732332,0.0,0.0,1120,28000.15819208733,0.0,8005.90196611263,8005.90196611263,2504744.524205338,700.0,784000.0,558.8997190327635,1217881.9754038057,6151.577260108245,93068.89545269094,0.0,0.0,1179.959724736658,1192046.7478049519,115.46526223496363,1746.9055438920566,-8005.90196611263,-4682534.232396754,true,true,10.63972462,10573.382806494956,0.0,1644.2724500334996,1120.0,10.63972462,10573.382806494956,0.0,121.92,0.0 -1121,31599.602246985865,30899.602246985865,0.29250000000000004,8561.80637102245,5360029.500538747,700.0,784700.0,31664.295285546836,22949720.986644987,23102.488914524387,17589691.486106414,true,1121.0,1121,0.875,7491.580574644644,8561.80637102245,1070.2257963778065,0.0,0.0,1121,30899.602246985865,0.0,7491.580574644644,7491.580574644644,2512236.104779983,700.0,784700.0,614.3809262501679,1218496.356330056,5555.1503870819815,98624.04583977292,0.0,0.0,1217.7789467122682,1193264.5267516642,104.2703146002258,1851.1758584922825,-7491.580574644644,-4690025.812971399,true,true,10.9526577,10584.335464194955,0.0,1644.2724500334996,1121.0,10.9526577,10584.335464194955,0.0,121.92,0.0 -1122,31011.806371022452,30311.806371022452,0.265,6916.835784951069,5366946.336323698,700.0,785400.0,28742.776546985166,22978463.763191972,21825.940762034097,17611517.42686845,true,1122.0,1122,0.875,6052.231311832185,6916.835784951069,864.604473118884,0.0,0.0,1122,30311.806371022452,0.0,6052.231311832185,6052.231311832185,2518288.336091815,700.0,785400.0,661.3204135987122,1219157.6767436548,4066.547376089585,102690.59321586251,0.0,0.0,1248.0343240671623,1194512.5610757314,76.32919807672575,1927.5050565690083,-6052.231311832185,-4696078.044283232,true,true,11.17618132,10595.511645514955,0.0,1644.2724500334996,1122.0,11.17618132,10595.511645514955,0.0,121.92,0.0 -1123,29366.83578495107,28666.83578495107,0.16,1257.5211151714964,5368203.85743887,700.0,786100.0,12234.506969821852,22990698.270161793,10976.985854650356,17622494.4127231,true,1123.0,1123,0.875,1100.3309757750594,1257.5211151714964,157.19013939643696,0.0,0.0,1123,28666.83578495107,0.0,1100.3309757750594,1100.3309757750594,2519388.66706759,700.0,786100.0,677.4823240752954,1219835.15906773,-819.8815995946654,101870.71161626784,0.0,0.0,1258.1194498521265,1195770.6805255834,-15.389198557696954,1912.1158580113113,-1100.3309757750594,-4697178.375259006,true,true,11.1314766,10606.643122114954,0.0,1644.2724500334996,1123.0,11.1314766,10606.643122114954,0.0,121.92,0.0 -1124,23707.521115171498,23007.521115171498,0.15600000000000003,1246.3114645953776,5369450.168903465,700.0,786800.0,12476.35554227806,23003174.625704072,11230.044077682682,17633724.456800785,true,1124.0,1124,0.875,1090.5225315209555,1246.3114645953776,155.78893307442218,0.0,0.0,1124,23007.521115171498,0.0,1090.5225315209555,1090.5225315209555,2520479.189599111,700.0,786800.0,669.368850078189,1220504.5279178082,-816.5956836847073,101054.11593258314,0.0,0.0,1253.0768869596443,1197023.757412543,-15.327521832170431,1896.7883361791407,-1090.5225315209555,-4698268.897790527,true,true,11.08677187,10617.729893984953,0.0,1644.2724500334996,1124.0,11.08677187,10617.729893984953,0.0,121.92,0.0 -1125,23696.31146459538,22996.31146459538,0.20800000000000002,4109.953842707339,5373560.122746172,700.0,787500.0,23124.77808993913,23026299.403794013,19014.82424723179,17652739.28104802,true,1125.0,1125,0.875,3596.2096123689216,4109.953842707339,513.7442303384178,0.0,0.0,1125,22996.31146459538,0.0,3596.2096123689216,3596.2096123689216,2524075.3992114803,700.0,787500.0,673.4174405757889,1221177.945358384,1636.4772832793726,102690.59321586251,0.0,0.0,1255.5981681238927,1198279.355580667,30.716720389867387,1927.505056569008,-3596.2096123689216,-4701865.107402896,true,true,11.17618132,10628.906075304953,0.0,1644.2724500334996,1125.0,11.17618132,10628.906075304953,0.0,121.92,0.0 -1126,26559.95384270734,25859.95384270734,0.25,6106.673689892849,5379666.796436065,700.0,788200.0,27226.694759571397,23053526.098553583,21120.021069678547,17673859.302117698,true,1126.0,1126,0.875,5343.339478656243,6106.673689892849,763.3342112366063,0.0,0.0,1126,25859.95384270734,0.0,5343.339478656243,5343.339478656243,2529418.7386901365,700.0,788200.0,698.0522652830352,1221875.997623667,3312.3877538596817,106002.9809697222,0.0,0.0,1270.7258568013397,1199550.0814374683,62.173602712186515,1989.6786592811945,-5343.339478656243,-4707208.446881552,true,true,11.35500022,10640.261075524953,0.0,1644.2724500334996,1126.0,11.35500022,10640.261075524953,0.0,121.92,0.0 -1127,28556.67368989285,27856.67368989285,0.25,6229.5373711100065,5385896.333807175,700.0,788900.0,27718.149484440026,23081244.248038024,21488.61211333002,17695347.91423103,true,1127.0,1127,0.875,5450.845199721256,6229.5373711100065,778.6921713887505,0.0,0.0,1127,27856.67368989285,0.0,5450.845199721256,5450.845199721256,2534869.583889858,700.0,788900.0,731.823269133634,1222607.8208928006,3364.965336927565,109367.94630664976,0.0,0.0,1290.896108371269,1200840.9775458395,63.16048528878698,2052.8391445699817,-5450.845199721256,-4712659.292081273,true,true,11.53381912,10651.794894644954,0.0,1644.2724500334996,1127.0,11.53381912,10651.794894644954,0.0,121.92,0.0 -1128,28679.537371110007,27979.537371110007,0.20800000000000002,4340.603073645875,5390236.936880821,700.0,789600.0,24233.668623297475,23105477.916661322,19893.0655496516,17715240.97978068,true,1128.0,1128,0.875,3798.0276894401404,4340.603073645875,542.5753842057347,0.0,0.0,1128,27979.537371110007,0.0,3798.0276894401404,3798.0276894401404,2538667.611579298,700.0,789600.0,757.8541113977777,1223365.6750041984,1702.1994532317615,111070.14575988152,0.0,0.0,1306.0237976127014,1202147.0013434521,31.950327197900013,2084.789471767882,-3798.0276894401404,-4716457.319770713,true,true,11.62322858,10663.418123224954,0.0,1644.2724500334996,1128.0,11.62322858,10663.418123224954,0.0,121.92,0.0 -1129,26790.603073645874,26090.603073645874,0.25,6416.136039401033,5396653.072920223,700.0,790300.0,28464.54415760413,23133942.460818928,22048.408118203097,17737289.387898885,true,1129.0,1129,0.875,5614.119034475903,6416.136039401033,802.0170049251292,0.0,0.0,1129,26090.603073645874,0.0,5614.119034475903,5614.119034475903,2544281.730613774,700.0,790300.0,784.4950239431748,1224150.1700281417,3443.8317144697166,114513.97747435124,0.0,0.0,1321.151486854134,1203468.1528303062,64.64080920887787,2149.4302809767596,-5614.119034475903,-4722071.438805189,true,true,11.80204748,10675.220170704953,0.0,1644.2724500334996,1129.0,11.80204748,10675.220170704953,0.0,121.92,0.0 -1130,28866.136039401033,28166.136039401033,0.20800000000000002,4482.691639063894,5401135.764559287,700.0,791000.0,24916.78672626872,23158859.247545198,20434.095087204827,17757723.48298609,true,1130.0,1130,0.875,3922.3551841809076,4482.691639063894,560.3364548829868,0.0,0.0,1130,28166.136039401033,0.0,3922.3551841809076,3922.3551841809076,2548204.0857979553,700.0,791000.0,811.7530721933598,1224961.923100335,1741.6324508853031,116255.60992523654,0.0,0.0,1336.279175531581,1204804.4320058378,32.690485570663874,2182.1207665474235,-3922.3551841809076,-4725993.79398937,true,true,11.89145693,10687.111627634953,0.0,1644.2724500334996,1130.0,11.89145693,10687.111627634953,0.0,121.92,0.0 -1131,26932.691639063894,26232.691639063894,0.23500000000000001,5566.197558336512,5406701.962117624,700.0,791700.0,26664.670461006433,23185523.918006204,21098.47290266992,17778821.95588876,true,1131.0,1131,0.875,4870.422863544448,5566.197558336512,695.7746947920641,0.0,0.0,1131,26232.691639063894,0.0,4870.422863544448,4870.422863544448,2553074.5086614997,700.0,791700.0,834.9446338311274,1225796.867734166,2637.0943195244763,118892.70424476101,0.0,0.0,1348.885582480794,1206153.3175883186,49.498327708049914,2231.6190942554736,-4870.422863544448,-4730864.216852915,true,true,12.0255711,10699.137198734954,0.0,1644.2724500334996,1131.0,12.0255711,10699.137198734954,0.0,121.92,0.0 -1132,28016.197558336513,27316.197558336513,0.196,3560.0114472727305,5410261.973564897,700.0,792400.0,21734.75228200373,23207258.67028821,18174.740834731,17796996.69672349,true,1132.0,1132,0.875,3115.0100163636394,3560.0114472727305,445.00143090909114,0.0,0.0,1132,27316.197558336513,0.0,3115.0100163636394,3115.0100163636394,2556189.5186778633,700.0,792400.0,853.812733185085,1226650.680467351,885.6037695470659,119778.30801430807,0.0,0.0,1358.9707082657585,1207512.2882965843,16.62280536572958,2248.241899621203,-3115.0100163636394,-4733979.226869279,true,true,12.07027583,10711.207474564953,0.0,1644.2724500334996,1132.0,12.07027583,10711.207474564953,0.0,121.92,0.0 -1133,26010.01144727273,25310.01144727273,0.1816,2537.2180003338285,5412799.1915652305,700.0,793100.0,17826.090310208307,23225084.760598417,15288.872309874478,17812285.569033366,true,1133.0,1133,0.875,2220.0657502921,2537.2180003338285,317.1522500417286,0.0,0.0,1133,25310.01144727273,0.0,2220.0657502921,2220.0657502921,2558409.5844281553,700.0,793100.0,858.5737602981075,1227509.2542276492,0.0,119778.30801430807,0.0,0.0,1361.4919899939923,1208873.7802865782,0.0,2248.241899621203,-2220.0657502921,-4736199.292619571,true,true,12.07027583,10723.277750394953,0.0,1644.2724500334996,1133.0,12.07027583,10723.277750394953,0.0,121.92,0.0 -1134,24987.21800033383,24287.21800033383,0.1816,2537.2180003338285,5415336.409565564,700.0,793800.0,17826.090310208307,23242910.850908626,15288.872309874478,17827574.44134324,true,1134.0,1134,0.875,2220.0657502921,2537.2180003338285,317.1522500417286,0.0,0.0,1134,24287.21800033383,0.0,2220.0657502921,2220.0657502921,2560629.6501784474,700.0,793800.0,858.5737602981075,1228367.8279879473,0.0,119778.30801430807,0.0,0.0,1361.4919899939923,1210235.2722765722,0.0,2248.241899621203,-2220.0657502921,-4738419.358369864,true,true,12.07027583,10735.348026224952,0.0,1644.2724500334996,1134.0,12.07027583,10735.348026224952,0.0,121.92,0.0 -1135,24987.21800033383,24287.21800033383,0.16240000000000002,1497.7792760434834,5416834.188841607,700.0,794500.0,13533.123620957407,23256443.974529583,12035.344344913923,17839609.785688154,true,1135.0,1135,0.875,1310.5568665380479,1497.7792760434834,187.2224095054355,0.0,0.0,1135,24287.21800033383,0.0,1310.5568665380479,1310.5568665380479,2561940.2070449856,700.0,794500.0,853.812733185085,1229221.6407211323,-885.6037695470659,118892.704244761,0.0,0.0,1358.9707082657585,1211594.2429848379,-16.62280536572958,2231.6190942554736,-1310.5568665380479,-4739729.915236401,true,true,12.0255711,10747.373597324953,0.0,1644.2724500334996,1135.0,12.0255711,10747.373597324953,0.0,121.92,0.0 -1136,23947.779276043482,23247.779276043482,0.16240000000000002,1485.0206840608037,5418319.209525668,700.0,795200.0,13454.56086244337,23269898.535392027,11969.540178382566,17851579.325866535,true,1136.0,1136,0.875,1299.3930985532031,1485.0206840608037,185.62758550760054,0.0,0.0,1136,23247.779276043482,0.0,1299.3930985532031,1299.3930985532031,2563239.600143539,700.0,795200.0,844.343547545365,1230065.9842686777,-882.3174728722024,118010.38677188879,0.0,0.0,1353.9281453732763,1212948.171130211,-16.56112149323583,2215.0579727622376,-1299.3930985532031,-4741029.308334955,true,true,11.98086638,10759.354463704953,0.0,1644.2724500334996,1136.0,11.98086638,10759.354463704953,0.0,121.92,0.0 -1137,23935.020684060804,23235.020684060804,0.1816,2504.0482146168265,5420823.257740285,700.0,795900.0,17643.437305158735,23287541.972697187,15139.389090541908,17866718.714957077,true,1137.0,1137,0.875,2191.0421877897234,2504.0482146168265,313.00602682710314,0.0,0.0,1137,23235.020684060804,0.0,2191.0421877897234,2191.0421877897234,2565430.6423313287,700.0,795900.0,839.6353235806953,1230905.6195922582,0.0,118010.38677188879,0.0,0.0,1351.4068642090278,1214299.5779944202,0.0,2215.0579727622376,-2191.0421877897234,-4743220.3505227445,true,true,11.98086638,10771.335330084952,0.0,1644.2724500334996,1137.0,11.98086638,10771.335330084952,0.0,121.92,0.0 -1138,24954.048214616825,24254.048214616825,0.12,0.0,5420823.257740285,700.0,796600.0,5833.333333333334,23293375.30603052,5833.333333333334,17872552.04829041,true,1138.0,1138,0.875,0.0,0.0,0.0,0.0,0.0,1138,24254.048214616825,0.0,-507.0907599607714,-507.0907599607714,2564923.551571368,700.0,796600.0,825.6157303219805,1231731.2353225802,-2627.2362189622645,115383.15055292653,0.0,0.0,1343.8430195883116,1215643.4210140086,-49.31329090879901,2165.7446818534386,-0.0,-4743220.3505227445,true,true,11.8467522,10783.182082284951,0.0,1644.2724500334996,1138.0,11.8467522,10783.182082284951,0.0,121.92,0.0 -1139,22450.0,21750.0,0.16240000000000002,1434.7855101585733,5422258.043250443,700.0,797300.0,13145.230973882839,23306520.537004404,11710.445463724265,17884262.493754134,true,1139.0,1139,0.875,1255.4373213887516,1434.7855101585733,179.34818876982172,0.0,0.0,1139,21750.0,0.0,1255.4373213887516,1255.4373213887516,2566178.9888927564,700.0,797300.0,807.1669070373962,1232538.4022296176,-869.1730785753125,114513.97747435121,0.0,0.0,1333.7578938033469,1216977.1789078119,-16.314400876678945,2149.4302809767596,-1255.4373213887516,-4744475.787844134,true,true,11.80204748,10794.984129764951,0.0,1644.2724500334996,1139.0,11.80204748,10794.984129764951,0.0,121.92,0.0 -1140,23884.785510158574,23184.785510158574,0.12,0.0,5422258.043250443,700.0,798000.0,5833.333333333334,23312353.870337736,5833.333333333334,17890095.827087466,true,1140.0,1140,0.875,0.0,0.0,0.0,0.0,0.0,1140,23184.785510158574,0.0,-1402.826012881286,-1402.826012881286,2564776.162879875,700.0,798000.0,784.4950239431748,1233322.8972535608,-3443.8317144697166,111070.14575988149,0.0,0.0,1321.151486854134,1218298.330394666,-64.64080920887787,2084.789471767882,-0.0,-4744475.787844134,true,true,11.62322858,10806.60735834495,0.0,1644.2724500334996,1140.0,11.62322858,10806.60735834495,0.0,121.92,0.0 -1141,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,798700.0,5833.333333333334,23318187.203671068,5833.333333333334,17895929.160420798,true,1141.0,1141,0.875,0.0,0.0,0.0,0.0,0.0,1141,21750.0,0.0,-2267.0428926056675,-2267.0428926056675,2562509.1199872694,700.0,798700.0,744.7628741042208,1234067.6601276651,-4230.85251061896,106839.29324926253,0.0,0.0,1298.4599535559707,1219596.790348222,-79.4132096468994,2005.3762621209826,-0.0,-4744475.787844134,true,true,11.39970495,10818.00706329495,0.0,1644.2724500334996,1141.0,11.39970495,10818.00706329495,0.0,121.92,0.0 -1142,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,799400.0,5833.333333333334,23324020.5370044,5833.333333333334,17901762.49375413,true,1142.0,1142,0.875,0.0,0.0,0.0,0.0,0.0,1142,21750.0,0.0,-5598.745019824338,-5598.745019824338,2556910.374967445,700.0,799400.0,685.6610973104235,1234753.3212249756,-7408.510204191812,99430.78304507071,0.0,0.0,1263.1620127446092,1220859.9523609667,-139.05792568755868,1866.3183364334238,-0.0,-4744475.787844134,true,true,10.99736242,10829.00442571495,0.0,1644.2724500334996,1142.0,10.99736242,10829.00442571495,0.0,121.92,0.0 -1143,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,800100.0,5833.333333333334,23329853.870337732,5833.333333333334,17907595.827087462,true,1143.0,1143,0.875,0.0,0.0,0.0,0.0,0.0,1143,21750.0,0.0,-7037.032955429962,-7037.032955429962,2549873.342012015,700.0,800100.0,606.7804233765929,1235360.1016483523,-8693.374893353921,90737.4081517168,0.0,0.0,1212.7363832558005,1222072.6887442225,-163.17486870843518,1703.1434677249886,-0.0,-4744475.787844134,true,true,10.50561044,10839.510036154948,0.0,1644.2724500334996,1143.0,10.50561044,10839.510036154948,0.0,121.92,0.0 -1144,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,800800.0,5833.333333333334,23335687.203671064,5833.333333333334,17913429.160420794,true,1144.0,1144,0.875,0.0,0.0,0.0,0.0,0.0,1144,21750.0,0.0,-13433.569635681231,-13433.569635681231,2536439.772376334,700.0,800800.0,496.85981451806185,1235856.9614628705,-14787.445380817833,75949.96277089896,0.0,0.0,1134.5766579711362,1223207.2654021936,-277.5607273525964,1425.5827403723922,-0.0,-4744475.787844134,true,true,9.611515937,10849.121552091949,0.0,1644.2724500334996,1144.0,9.611515937,10849.121552091949,0.0,121.92,0.0 -1145,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,801500.0,5833.333333333334,23341520.537004396,5833.333333333334,17919262.493754126,true,1145.0,1145,0.875,0.0,0.0,0.0,0.0,0.0,1145,21750.0,0.0,-8983.92161279282,-8983.92161279282,2527455.850763541,700.0,801500.0,389.70916720993597,1236246.6706300804,-10227.983083344325,65721.97968755463,0.0,0.0,1046.3318069579059,1224253.5972091516,-191.97950361633644,1233.6032367560558,-0.0,-4744475.787844134,true,true,8.940945058,10858.06249714995,0.0,1644.2724500334996,1145.0,8.940945058,10858.06249714995,0.0,121.92,0.0 -1146,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,802200.0,5833.333333333334,23347353.87033773,5833.333333333334,17925095.82708746,true,1146.0,1146,0.875,0.0,0.0,0.0,0.0,0.0,1146,21750.0,0.0,-14459.699581075129,-14459.699581075129,2512996.151182466,700.0,802200.0,287.5346150460783,1236534.2052451265,-15403.588986054745,50318.390701499884,0.0,0.0,945.4805484878756,1225199.0777576396,-289.12575855433755,944.4774782017182,-0.0,-4744475.787844134,true,true,7.823326926,10865.88582407595,0.0,1644.2724500334996,1146.0,7.823326926,10865.88582407595,0.0,121.92,0.0 -1147,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,802900.0,5833.333333333334,23353187.20367106,5833.333333333334,17930929.16042079,true,1147.0,1147,0.875,0.0,0.0,0.0,0.0,0.0,1147,21750.0,0.0,-7361.676730426242,-7361.676730426242,2505634.47445204,700.0,802900.0,204.98909254787833,1236739.1943376744,-8256.323706169424,42062.06699533046,0.0,0.0,844.6292899614467,1226043.707047601,-154.9714067661441,789.5060714355741,-0.0,-4744475.787844134,true,true,7.152756046,10873.038580121949,0.0,1644.2724500334996,1147.0,7.152756046,10873.038580121949,0.0,121.92,0.0 -1148,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,803600.0,5833.333333333334,23359020.537004393,5833.333333333334,17936762.493754122,true,1148.0,1148,0.875,0.0,0.0,0.0,0.0,0.0,1148,21750.0,0.0,-9139.73526798422,-9139.73526798422,2496494.739184056,700.0,803600.0,147.21772289700587,1236886.4120605714,-9858.296944312408,32203.77005101805,0.0,0.0,756.3844387790208,1226800.09148638,-185.04048534784127,604.4655860877328,-0.0,-4744475.787844134,true,true,6.258661541,10879.29724166295,0.0,1644.2724500334996,1148.0,6.258661541,10879.29724166295,0.0,121.92,0.0 -1149,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,804300.0,5833.333333333334,23364853.870337725,5833.333333333334,17942595.827087454,true,1149.0,1149,0.875,0.0,0.0,0.0,0.0,0.0,1149,21750.0,0.0,-12938.952330734322,-12938.952330734322,2483555.786853322,700.0,804300.0,82.16506281889619,1236968.5771233903,-13392.496415183821,18811.27363583423,0.0,0.0,622.7565212822612,1227422.8480076622,-251.37749965165852,353.0880864360743,-0.0,-4744475.787844134,true,true,4.783405606,10884.08064726895,0.0,1644.2724500334996,1149.0,4.783405606,10884.08064726895,0.0,121.92,0.0 -1150,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,805000.0,5833.333333333334,23370687.203671057,5833.333333333334,17948429.160420787,true,1150.0,1150,0.875,0.0,0.0,0.0,0.0,0.0,1150,21750.0,0.0,-9509.45851602982,-9509.45851602982,2474046.328337292,700.0,805000.0,32.331961749274896,1237000.9090851396,-9813.934619110332,8997.339016723898,0.0,0.0,456.3519447023739,1227879.1999523647,-184.20780337113453,168.8802830649398,-0.0,-4744475.787844134,true,true,3.308149671,10887.38879693995,0.0,1644.2724500334996,1150.0,3.308149671,10887.38879693995,0.0,121.92,0.0 -1151,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,805700.0,5833.333333333334,23376520.53700439,5833.333333333334,17954262.49375412,true,1151.0,1151,0.875,0.0,0.0,0.0,0.0,0.0,1151,21750.0,0.0,-6054.170975386927,-6054.170975386927,2467992.157361905,700.0,805700.0,8.29258349130573,1237009.201668631,-6235.372820023076,2761.9661967008215,0.0,0.0,289.94736817888514,1228169.1473205436,-117.03810703404224,51.84217603089755,-0.0,-4744475.787844134,true,true,1.832893737,10889.22169067695,0.0,1644.2724500334996,1151.0,1.832893737,10889.22169067695,0.0,121.92,0.0 -1152,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,806400.0,5833.333333333334,23382353.87033772,5833.333333333334,17960095.82708745,true,1152.0,1152,0.875,0.0,0.0,0.0,0.0,0.0,1152,21750.0,0.0,-2582.495166445757,-2582.495166445757,2465409.6621954595,700.0,806400.0,0.6414821435603179,1237009.8431507747,-2656.8110293890954,105.15516731172602,0.0,0.0,123.54279165539637,1228292.690112199,-49.868410855618116,1.973765175279432,-0.0,-4744475.787844134,true,true,0.357637802,10889.57932847895,0.0,1644.2724500334996,1152.0,0.357637802,10889.57932847895,0.0,121.92,0.0 -1153,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,807100.0,5833.333333333334,23388187.203671053,5833.333333333334,17965929.160420783,true,1153.0,1153,0.875,0.0,0.0,0.0,0.0,0.0,1153,21750.0,0.0,-86.95588912024235,-86.95588912024235,2465322.7063063392,700.0,807100.0,0.002791684219294004,1237009.8459424588,-105.1551673119104,-1.84385839929746e-10,0.0,0.0,20.170251682726352,1228312.8603638816,-1.9737651752775933,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1153.0,0.0,10889.57932847895,0.0,121.92,0.0 -1154,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,807800.0,5833.333333333334,23394020.537004385,5833.333333333334,17971762.493754115,true,1154.0,1154,0.875,0.0,0.0,0.0,0.0,0.0,1154,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,807800.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1154.0,0.0,10889.57932847895,0.0,121.92,0.0 -1155,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,808500.0,5833.333333333334,23399853.870337717,5833.333333333334,17977595.827087447,true,1155.0,1155,0.875,0.0,0.0,0.0,0.0,0.0,1155,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,808500.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1155.0,0.0,10889.57932847895,0.0,121.92,0.0 -1156,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,809200.0,5833.333333333334,23405687.20367105,5833.333333333334,17983429.16042078,true,1156.0,1156,0.875,0.0,0.0,0.0,0.0,0.0,1156,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,809200.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1156.0,0.0,10889.57932847895,0.0,121.92,0.0 -1157,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,809900.0,5833.333333333334,23411520.53700438,5833.333333333334,17989262.49375411,true,1157.0,1157,0.875,0.0,0.0,0.0,0.0,0.0,1157,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,809900.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1157.0,0.0,10889.57932847895,0.0,121.92,0.0 -1158,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,810600.0,5833.333333333334,23417353.870337714,5833.333333333334,17995095.827087443,true,1158.0,1158,0.875,0.0,0.0,0.0,0.0,0.0,1158,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,810600.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1158.0,0.0,10889.57932847895,0.0,121.92,0.0 -1159,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,811300.0,5833.333333333334,23423187.203671046,5833.333333333334,18000929.160420775,true,1159.0,1159,0.875,0.0,0.0,0.0,0.0,0.0,1159,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,811300.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1159.0,0.0,10889.57932847895,0.0,121.92,0.0 -1160,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,812000.0,5833.333333333334,23429020.537004378,5833.333333333334,18006762.493754108,true,1160.0,1160,0.875,0.0,0.0,0.0,0.0,0.0,1160,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,812000.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1160.0,0.0,10889.57932847895,0.0,121.92,0.0 -1161,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,812700.0,5833.333333333334,23434853.87033771,5833.333333333334,18012595.82708744,true,1161.0,1161,0.875,0.0,0.0,0.0,0.0,0.0,1161,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,812700.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1161.0,0.0,10889.57932847895,0.0,121.92,0.0 -1162,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,813400.0,5833.333333333334,23440687.203671042,5833.333333333334,18018429.16042077,true,1162.0,1162,0.875,0.0,0.0,0.0,0.0,0.0,1162,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,813400.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1162.0,0.0,10889.57932847895,0.0,121.92,0.0 -1163,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,814100.0,5833.333333333334,23446520.537004374,5833.333333333334,18024262.493754104,true,1163.0,1163,0.875,0.0,0.0,0.0,0.0,0.0,1163,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,814100.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1163.0,0.0,10889.57932847895,0.0,121.92,0.0 -1164,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,814800.0,5833.333333333334,23452353.870337706,5833.333333333334,18030095.827087436,true,1164.0,1164,0.875,0.0,0.0,0.0,0.0,0.0,1164,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,814800.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1164.0,0.0,10889.57932847895,0.0,121.92,0.0 -1165,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,815500.0,5833.333333333334,23458187.20367104,5833.333333333334,18035929.160420768,true,1165.0,1165,0.875,0.0,0.0,0.0,0.0,0.0,1165,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,815500.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1165.0,0.0,10889.57932847895,0.0,121.92,0.0 -1166,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,816200.0,5833.333333333334,23464020.53700437,5833.333333333334,18041762.4937541,true,1166.0,1166,0.875,0.0,0.0,0.0,0.0,0.0,1166,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,816200.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1166.0,0.0,10889.57932847895,0.0,121.92,0.0 -1167,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,816900.0,5833.333333333334,23469853.870337702,5833.333333333334,18047595.827087432,true,1167.0,1167,0.875,0.0,0.0,0.0,0.0,0.0,1167,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,816900.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1167.0,0.0,10889.57932847895,0.0,121.92,0.0 -1168,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,817600.0,5833.333333333334,23475687.203671034,5833.333333333334,18053429.160420764,true,1168.0,1168,0.875,0.0,0.0,0.0,0.0,0.0,1168,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,817600.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,1644.2724500334996,1168.0,0.0,10889.57932847895,0.0,121.92,0.0 -1169,22450.0,21750.0,0.14800000000000002,904.2088091284415,5423162.252059571,700.0,818300.0,10839.248710327307,23486526.45238136,9935.039901198865,18063364.200321965,true,1169.0,1169,0.875,791.1827079873864,904.2088091284415,113.02610114105516,0.0,0.0,1169,21750.0,0.0,791.1827079873864,791.1827079873864,2466113.8890143265,700.0,818300.0,0.05049567893915037,1237009.8964381379,724.5848259163639,724.5848259161795,0.0,0.0,52.94691070945558,1228365.807274591,13.600475682627815,13.600475682629654,-791.1827079873864,-4745266.970552121,true,true,0.938799231,10890.518127709951,0.0,1644.2724500334996,1169.0,0.938799231,10890.518127709951,0.0,121.92,0.0 -1170,23354.208809128442,22654.208809128442,0.22,4953.454950386079,5428115.707009957,700.0,819000.0,25697.522501754906,23512223.974883117,20744.067551368826,18084108.267873332,true,1170.0,1170,0.875,4334.273081587819,4953.454950386079,619.1818687982595,0.0,0.0,1170,22654.208809128442,0.0,4334.273081587819,4334.273081587819,2470448.162095914,700.0,819000.0,2.3002769207802647,1237012.1967150585,4066.547494655964,4791.132320572144,0.0,0.0,189.0961097088548,1228554.9033842997,76.32920030222022,89.92967598484987,-4334.273081587819,-4749601.243633709,true,true,2.414055166,10892.932182875951,0.0,1644.2724500334996,1170.0,2.414055166,10892.932182875951,0.0,121.92,0.0 -1171,27403.45495038608,26703.45495038608,0.29250000000000004,9325.021088770909,5437440.728098728,700.0,819700.0,34273.57637186635,23546497.551254984,24948.55528309544,18109056.823156428,true,1171.0,1171,0.875,8159.393452674545,9325.021088770909,1165.6276360963639,0.0,0.0,1171,26703.45495038608,0.0,8159.393452674545,8159.393452674545,2478607.5555485887,700.0,819700.0,15.284585645136026,1237027.4813007037,7645.109284334358,12436.241604906501,0.0,0.0,355.5006862323436,1228910.404070532,143.49889646270796,233.42857244755783,-8159.393452674545,-4757760.637086383,true,true,3.8893111,10896.821493975951,0.0,1644.2724500334996,1171.0,3.8893111,10896.821493975951,0.0,121.92,0.0 -1172,31775.02108877091,31075.02108877091,0.335,13719.551185007402,5451160.279283735,700.0,820400.0,43043.43637315642,23589540.98762814,29323.88518814902,18138380.708344575,true,1172.0,1172,0.875,12004.607286881477,13719.551185007402,1714.9438981259245,0.0,0.0,1172,31075.02108877091,0.0,12004.607286881477,12004.607286881477,2490612.1628354704,700.0,820400.0,48.362346930702145,1237075.8436476344,11223.671084377205,23659.91268928371,0.0,0.0,521.9052627558324,1229432.3093332879,210.66859281773674,444.09716526529456,-12004.607286881477,-4769765.244373265,true,true,5.364567035,10902.18606101095,0.0,1644.2724500334996,1172.0,5.364567035,10902.18606101095,0.0,121.92,0.0 -1173,36169.5511850074,35469.5511850074,0.35,18147.79429031682,5469308.073574052,700.0,821100.0,53850.84082947663,23643391.828457616,35703.04653915981,18174083.754883736,true,1173.0,1173,0.875,15879.320004027215,18147.79429031682,2268.4742862896037,0.0,0.0,1173,35469.5511850074,0.0,15879.320004027215,15879.320004027215,2506491.4828394977,700.0,821100.0,110.93900665658364,1237186.782654291,14802.232869204148,38462.14555848786,0.0,0.0,688.3098392793212,1230120.6191725673,277.8382888871626,721.9354541524572,-15879.320004027215,-4785644.564377292,true,true,6.839822969,10909.02588397995,0.0,1644.2724500334996,1173.0,6.839822969,10909.02588397995,0.0,121.92,0.0 -1174,40597.794290316815,39897.794290316815,0.355,22620.499526784435,5491928.573100837,700.0,821800.0,65691.54796277305,23709083.37642039,43071.04843598862,18217154.803319726,true,1174.0,1174,0.875,19792.93708593638,22620.499526784435,2827.5624408480544,0.0,0.0,1174,39897.794290316815,0.0,19792.93708593638,19792.93708593638,2526284.419925434,700.0,821800.0,212.4200107018856,1237399.202664993,18380.794674098433,56842.94023258629,0.0,0.0,854.7144158028099,1230975.3335883701,345.00798533325326,1066.9434394857103,-19792.93708593638,-4805437.501463229,true,true,8.315078904,10917.340962883949,0.0,1644.2724500334996,1174.0,8.315078904,10917.340962883949,0.0,121.92,0.0 -1175,45070.499526784435,44370.499526784435,0.35333333333333333,20520.5376071141,5512449.110707951,700.0,822500.0,60058.125303153116,23769141.501723543,39537.587696039016,18256692.391015764,true,1175.0,1175,0.875,17955.47040622484,20520.5376071141,2565.0672008892616,0.0,0.0,1175,44370.499526784435,0.0,17955.47040622484,17955.47040622484,2544239.890331659,700.0,822500.0,341.1676563245569,1237740.3703213176,16307.266206207323,73150.20643879361,0.0,0.0,1000.9487406435724,1231976.2823290138,306.08780304938495,1373.0312425350953,-17955.47040622484,-4823392.971869454,true,true,9.432697036,10926.773659919949,0.0,1644.2724500334996,1175.0,9.432697036,10926.773659919949,0.0,121.92,0.0 -1176,42970.5376071141,42270.5376071141,0.35,17834.33874411757,5530283.449452069,700.0,823200.0,52955.25355462163,23822096.755278163,35120.914810504066,18291813.30582627,true,1176.0,1176,0.875,15605.046401102874,17834.33874411757,2229.292343014695,0.0,0.0,1176,42270.5376071141,0.0,15605.046401102874,15605.046401102874,2559844.936732762,700.0,823200.0,467.64048301127605,1238208.0108043288,13767.111753789042,86917.31819258265,0.0,0.0,1111.88512518056,1233088.1674541943,258.40903912199775,1631.440281657093,-15605.046401102874,-4838998.018270557,true,true,10.28208682,10937.055746739949,0.0,1644.2724500334996,1176.0,10.28208682,10937.055746739949,0.0,121.92,0.0 -1177,40284.33874411757,39584.33874411757,0.25,6414.182197923338,5536697.631649992,700.0,823900.0,28456.728791693353,23850553.484069858,22042.546593770014,18313855.85242004,true,1177.0,1177,0.875,5612.409423182921,6414.182197923338,801.7727747404169,0.0,0.0,1177,39584.33874411757,0.0,5612.409423182921,5612.409423182921,2565457.3461559447,700.0,823900.0,548.2203978649552,1238756.2312021938,3820.0899591341295,90737.40815171678,0.0,0.0,1172.395880115942,1234260.5633343102,71.70318606789543,1703.1434677249883,-5612.409423182921,-4844610.4276937395,true,true,10.50561044,10947.561357179948,0.0,1644.2724500334996,1177.0,10.50561044,10947.561357179948,0.0,121.92,0.0 -1178,28864.18219792334,28164.18219792334,0.12,0.0,5536697.631649992,700.0,824600.0,5833.333333333334,23856386.81740319,5833.333333333334,18319689.18575337,true,1178.0,1178,0.875,0.0,0.0,0.0,0.0,0.0,1178,28164.18219792334,0.0,-2171.1768672211274,-2171.1768672211274,2563286.1692887237,700.0,824600.0,548.2203978649552,1239304.4516000587,-3820.0899591341295,86917.31819258265,0.0,0.0,1172.395880115942,1235432.959214426,-71.70318606789543,1631.440281657093,-0.0,-4844610.4276937395,true,true,10.28208682,10957.843443999947,0.0,1644.2724500334996,1178.0,10.28208682,10957.843443999947,0.0,121.92,0.0 -1179,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,825300.0,5833.333333333334,23862220.150736522,5833.333333333334,18325522.519086704,true,1179.0,1179,0.875,0.0,0.0,0.0,0.0,0.0,1179,21750.0,0.0,-2147.309261666351,-2147.309261666351,2561138.8600270576,700.0,825300.0,513.6065125515006,1239818.0581126101,-3737.9376546560616,83179.38053792658,0.0,0.0,1147.1830656535303,1236580.1422800797,-70.16118521532044,1561.2790964417725,-0.0,-4844610.4276937395,true,true,10.05856319,10967.902007189947,0.0,1644.2724500334996,1179.0,10.05856319,10967.902007189947,0.0,121.92,0.0 -1180,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,826000.0,5833.333333333334,23868053.484069854,5833.333333333334,18331355.852420036,true,1180.0,1180,0.875,0.0,0.0,0.0,0.0,0.0,1180,21750.0,0.0,-16294.966884437825,-16294.966884437825,2544843.8931426196,700.0,826000.0,418.56520403034614,1240236.6233166405,-17457.400850371967,65721.97968755462,0.0,0.0,1071.544621589513,1237651.6869016693,-327.675859685717,1233.6032367560556,-0.0,-4844610.4276937395,true,true,8.940945058,10976.842952247947,0.0,1644.2724500334996,1180.0,8.940945058,10976.842952247947,0.0,121.92,0.0 -1181,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,826700.0,5833.333333333334,23873886.817403186,5833.333333333334,18337189.185753368,true,1181.0,1181,0.875,0.0,0.0,0.0,0.0,0.0,1181,21750.0,0.0,-19077.644139977016,-19077.644139977016,2525766.2490026425,700.0,826700.0,269.52218856006243,1240506.1455052006,-19898.972405177938,45823.00728237668,0.0,0.0,925.3102967487507,1238576.997198418,-373.5042201078922,860.0990166481633,-0.0,-4844610.4276937395,true,true,7.465689123,10984.308641370948,0.0,1644.2724500334996,1181.0,7.465689123,10984.308641370948,0.0,121.92,0.0 -1182,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,827400.0,5833.333333333334,23879720.15073652,5833.333333333334,18343022.5190867,true,1182.0,1182,0.875,0.0,0.0,0.0,0.0,0.0,1182,21750.0,0.0,-15719.14458984546,-15719.14458984546,2510047.104412797,700.0,827400.0,148.69481282630025,1240654.840318027,-16320.410599254537,29502.596683122145,0.0,0.0,758.9057202252619,1239335.9029186433,-306.3345236424856,553.7644930056778,-0.0,-4844610.4276937395,true,true,5.990433189,10990.299074559947,0.0,1644.2724500334996,1182.0,5.990433189,10990.299074559947,0.0,121.92,0.0 -1183,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,828100.0,5833.333333333334,23885553.48406985,5833.333333333334,18348855.852420032,true,1183.0,1183,0.875,0.0,0.0,0.0,0.0,0.0,1183,21750.0,0.0,-12317.750528774688,-12317.750528774688,2497729.353884022,700.0,828100.0,70.76197057259785,1240725.6022885996,-12741.848815456684,16760.74786766546,0.0,0.0,592.5011437017731,1239928.4040623452,-239.1648275923756,314.5996654133022,-0.0,-4844610.4276937395,true,true,4.515177254,10994.814251813947,0.0,1644.2724500334996,1183.0,4.515177254,10994.814251813947,0.0,121.92,0.0 -1184,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,828800.0,5833.333333333334,23891386.817403182,5833.333333333334,18354689.185753364,true,1184.0,1184,0.875,0.0,0.0,0.0,0.0,0.0,1184,21750.0,0.0,-8882.867362504645,-8882.867362504645,2488846.4865215174,700.0,828800.0,26.318215919850086,1240751.9205045195,-9163.287014384749,7597.460853280712,0.0,0.0,426.09656717828443,1240354.5006295235,-171.99513121803076,142.60453419527144,-0.0,-4844610.4276937395,true,true,3.03992132,10997.854173133946,0.0,1644.2724500334996,1184.0,3.03992132,10997.854173133946,0.0,121.92,0.0 -1185,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,829500.0,5833.333333333334,23897220.150736514,5833.333333333334,18360522.519086696,true,1185.0,1185,0.875,0.0,0.0,0.0,0.0,0.0,1185,21750.0,0.0,-5423.900567168558,-5423.900567168558,2483422.585954349,700.0,829500.0,5.958102988951918,1240757.8786075085,-5584.725225735447,2012.7356275452657,0.0,0.0,259.69199065479563,1240614.1926201782,-104.82543507685916,37.779099118412276,-0.0,-4844610.4276937395,true,true,1.564665385,10999.418838518946,0.0,1644.2724500334996,1185.0,1.564665385,10999.418838518946,0.0,121.92,0.0 -1186,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,830200.0,5833.333333333334,23903053.484069847,5833.333333333334,18366355.85242003,true,1186.0,1186,0.875,0.0,0.0,0.0,0.0,0.0,1186,21750.0,0.0,-1950.2555682764255,-1950.2555682764255,2481472.3303860724,700.0,830200.0,0.27618590079828664,1240758.1547934094,-2006.1634295149545,6.572198030311256,0.0,0.0,93.28741413130685,1240707.4800343094,-37.65573879357602,0.12336032483625559,-0.0,-4844610.4276937395,true,true,0.089409451,10999.508247969947,0.0,1644.2724500334996,1186.0,0.089409451,10999.508247969947,0.0,121.92,0.0 -1187,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,830900.0,5833.333333333334,23908886.81740318,5833.333333333334,18372189.18575336,true,1187.0,1187,0.875,0.0,0.0,0.0,0.0,0.0,1187,21750.0,0.0,-1.6529517863882033,-1.6529517863882033,2481470.677434286,700.0,830900.0,0.000043620066658271756,1240758.1548370295,-6.5721980305011485,-1.8989254613188677e-10,0.0,0.0,5.04256294888086,1240712.5225972582,-0.12336032483457314,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1187.0,0.0,10999.508247969947,0.0,121.92,0.0 -1188,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,831600.0,5833.333333333334,23914720.15073651,5833.333333333334,18378022.519086692,true,1188.0,1188,0.875,0.0,0.0,0.0,0.0,0.0,1188,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,831600.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1188.0,0.0,10999.508247969947,0.0,121.92,0.0 -1189,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,832300.0,5833.333333333334,23920553.484069843,5833.333333333334,18383855.852420025,true,1189.0,1189,0.875,0.0,0.0,0.0,0.0,0.0,1189,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,832300.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1189.0,0.0,10999.508247969947,0.0,121.92,0.0 -1190,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,833000.0,5833.333333333334,23926386.817403175,5833.333333333334,18389689.185753357,true,1190.0,1190,0.875,0.0,0.0,0.0,0.0,0.0,1190,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,833000.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1190.0,0.0,10999.508247969947,0.0,121.92,0.0 -1191,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,833700.0,5833.333333333334,23932220.150736507,5833.333333333334,18395522.51908669,true,1191.0,1191,0.875,0.0,0.0,0.0,0.0,0.0,1191,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,833700.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1191.0,0.0,10999.508247969947,0.0,121.92,0.0 -1192,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,834400.0,5833.333333333334,23938053.48406984,5833.333333333334,18401355.85242002,true,1192.0,1192,0.875,0.0,0.0,0.0,0.0,0.0,1192,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,834400.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1192.0,0.0,10999.508247969947,0.0,121.92,0.0 -1193,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,835100.0,5833.333333333334,23943886.81740317,5833.333333333334,18407189.185753353,true,1193.0,1193,0.875,0.0,0.0,0.0,0.0,0.0,1193,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,835100.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1193.0,0.0,10999.508247969947,0.0,121.92,0.0 -1194,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,835800.0,5833.333333333334,23949720.150736503,5833.333333333334,18413022.519086685,true,1194.0,1194,0.875,0.0,0.0,0.0,0.0,0.0,1194,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,835800.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1194.0,0.0,10999.508247969947,0.0,121.92,0.0 -1195,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,836500.0,5833.333333333334,23955553.484069835,5833.333333333334,18418855.852420017,true,1195.0,1195,0.875,0.0,0.0,0.0,0.0,0.0,1195,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,836500.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1195.0,0.0,10999.508247969947,0.0,121.92,0.0 -1196,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,837200.0,5833.333333333334,23961386.817403167,5833.333333333334,18424689.18575335,true,1196.0,1196,0.875,0.0,0.0,0.0,0.0,0.0,1196,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,837200.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,1644.2724500334996,1196.0,0.0,10999.508247969947,0.0,121.92,0.0 -1197,22450.0,21750.0,0.12,13.415045627752276,5536711.04669562,700.0,837900.0,5945.125380231269,23967331.9427834,5931.710334603517,18430620.896087952,true,1197.0,1197,0.875,11.738164924283241,13.415045627752276,1.6768807034690347,0.0,0.0,1197,21750.0,0.0,11.738164924283241,11.738164924283241,2481482.41559921,700.0,837900.0,0.000043620066658271756,1240758.1548806496,6.5721980305011485,6.572198030311256,0.0,0.0,5.04256294888086,1240717.565160207,0.12336032483457314,0.12336032483625559,-11.738164924283241,-4844622.165858664,true,true,0.089409451,10999.597657420947,0.0,1644.2724500334996,1197.0,0.089409451,10999.597657420947,0.0,121.92,0.0 -1198,22463.415045627753,21763.415045627753,0.132,471.7921922764773,5537182.838887896,700.0,838600.0,8877.213577852099,23976209.156361252,8405.42138557562,18439026.317473527,true,1198.0,1198,0.875,412.81816824191765,471.7921922764773,58.97402403455965,0.0,0.0,1198,21763.415045627753,0.0,412.81816824191765,412.81816824191765,2481895.233767452,700.0,838600.0,0.0267881730664018,1240758.1816688227,363.11393732608417,369.6861353563954,0.0,0.0,42.86178486809241,1240760.4269450752,6.81565787467468,6.939018199510936,-412.81816824191765,-4845034.984026905,true,true,0.670570879,11000.268228299947,0.0,1644.2724500334996,1198.0,0.670570879,11000.268228299947,0.0,121.92,0.0 -1199,22921.792192276476,22221.792192276476,0.1744,2057.868811132437,5539240.707699029,700.0,839300.0,15813.467953741037,23992022.624314994,13755.5991426086,18452781.916616134,true,1199.0,1199,0.875,1800.6352097408821,2057.868811132437,257.23360139155466,0.0,0.0,1199,22221.792192276476,0.0,1800.6352097408821,1800.6352097408821,2483695.8689771933,700.0,839300.0,0.6815635314732058,1240758.8632323542,1643.04949218887,2012.7356275452655,0.0,0.0,126.06407310163752,1240886.4910181768,30.840080918901343,37.779099118412276,-1800.6352097408821,-4846835.619236646,true,true,1.564665385,11001.832893684947,0.0,1644.2724500334996,1199.0,1.564665385,11001.832893684947,0.0,121.92,0.0 -1200,24507.868811132437,23807.868811132437,0.25,6033.42785709912,5545274.135556128,700.0,840000.0,26933.71142839648,24018956.33574339,20900.28357129736,18473682.200187434,true,1200.0,1200,0.875,5279.24937496173,6033.42785709912,754.1784821373903,0.0,0.0,1200,23807.868811132437,0.0,5279.24937496173,5279.24937496173,2488975.118352155,700.0,840000.0,5.452508255444662,1240764.3157406095,4929.148477669211,6941.884105214477,0.0,0.0,252.1281462596736,1241138.6191644364,92.52024277739989,130.29934189581218,-5279.24937496173,-4852114.868611608,true,true,2.905807144,11004.738700828946,0.0,1644.2724500334996,1200.0,2.905807144,11004.738700828946,0.0,121.92,0.0 -1201,28483.42785709912,27783.42785709912,0.30500000000000005,10786.782082387877,5556060.917638516,700.0,840700.0,37661.58059799304,24056617.916341383,26874.798515605158,18500556.99870304,true,1201.0,1201,0.875,9438.434322089393,10786.782082387877,1348.347760298484,0.0,0.0,1201,27783.42785709912,0.0,9438.434322089393,9438.434322089393,2498413.5526742446,700.0,840700.0,23.613433767117364,1240787.9291743767,8837.963214741707,15779.847319956185,0.0,0.0,410.9688783880404,1241549.5880428243,165.88879519252868,296.18813708834085,-9438.434322089393,-4861553.302933697,true,true,4.381063078,11009.119763906947,0.0,1644.2724500334996,1201.0,4.381063078,11009.119763906947,0.0,121.92,0.0 -1202,33236.78208238788,32536.78208238788,0.30500000000000005,9867.546293534457,5565928.46393205,700.0,841400.0,34647.69276568674,24091265.60910707,24780.146472152286,18525337.145175193,true,1202.0,1202,0.875,8634.10300684265,9867.546293534457,1233.4432866918069,0.0,0.0,1202,32536.78208238788,0.0,8634.10300684265,8634.10300684265,2507047.655681087,700.0,841400.0,56.489250504496354,1240844.418424881,7880.065369327518,23659.9126892837,0.0,0.0,549.6393588336808,1242099.227401658,147.9090281769536,444.09716526529445,-8634.10300684265,-4870187.405940539,true,true,5.364567035,11014.484330941947,0.0,1644.2724500334996,1202.0,5.364567035,11014.484330941947,0.0,121.92,0.0 -1203,32317.546293534455,31617.546293534455,0.22,5100.757476421243,5571029.221408471,700.0,842100.0,26367.07943827838,24117632.688545346,21266.321961857135,18546603.46713705,true,1203.0,1203,0.875,4463.162791868588,5100.757476421243,637.594684552655,0.0,0.0,1203,31617.546293534455,0.0,4463.162791868588,4463.162791868588,2511510.818472956,700.0,842100.0,84.17718011734617,1240928.5956049985,3682.073906343327,27341.98659562703,0.0,0.0,627.7990841747436,1242727.0264858326,69.11262123317108,513.2097864984655,-4463.162791868588,-4874650.568732408,true,true,5.766909562,11020.251240503947,0.0,1644.2724500334996,1203.0,5.766909562,11020.251240503947,0.0,121.92,0.0 -1204,27550.757476421244,26850.757476421244,0.16,1350.0355074826268,5572379.256915954,700.0,842800.0,12812.721921766415,24130445.410467114,11462.686414283788,18558066.153551333,true,1204.0,1204,0.875,1181.2810690472984,1350.0355074826268,168.75443843532844,0.0,0.0,1204,26850.757476421244,0.0,1181.2810690472984,1181.2810690472984,2512692.099542003,700.0,842800.0,94.73176392472222,1241023.3273689232,425.5498252314475,27767.536420858476,0.0,0.0,653.0118988063507,1243380.038384639,7.987581084778076,521.1973675832436,-1181.2810690472984,-4875831.849801456,true,true,5.811614288,11026.062854791948,0.0,1644.2724500334996,1204.0,5.811614288,11026.062854791948,0.0,121.92,0.0 -1205,23800.035507482626,23100.035507482626,0.12,0.0,5572379.256915954,700.0,843500.0,5833.333333333334,24136278.743800446,5833.333333333334,18563899.486884665,true,1205.0,1205,0.875,0.0,0.0,0.0,0.0,0.0,1205,23100.035507482626,0.0,-977.1369677293557,-977.1369677293557,2511714.962574274,700.0,843500.0,91.4779087376231,1241114.805277661,-1682.482687869567,26085.05373298891,0.0,0.0,645.4480544112287,1244025.4864390502,-31.58024300864061,489.617124574603,-0.0,-4875831.849801456,true,true,5.632795386,11031.695650177948,0.0,1644.2724500334996,1205.0,5.632795386,11031.695650177948,0.0,121.92,0.0 -1206,22450.0,21750.0,0.1696,1805.819428883467,5574185.076344837,700.0,844200.0,14774.87870803931,24151053.622508485,12969.059279155843,18576868.54616382,true,1206.0,1206,0.875,1580.0920002730336,1805.819428883467,225.72742861043344,0.0,0.0,1206,21750.0,0.0,1580.0920002730336,1580.0920002730336,2513295.054574547,700.0,844200.0,89.35060172691969,1241204.1558793879,834.6691459042803,26919.72287889319,0.0,0.0,640.4054914623479,1244665.8919305126,15.666761179485702,505.2838857540887,-1580.0920002730336,-4877411.941801729,true,true,5.722204837,11037.417855014948,0.0,1644.2724500334996,1206.0,5.722204837,11037.417855014948,0.0,121.92,0.0 -1207,24255.819428883467,23555.819428883467,0.1792,2340.9781283247726,5576526.054473163,700.0,844900.0,16969.74401966949,24168023.366528153,14628.76589134472,18591497.312055163,true,1207.0,1207,0.875,2048.355862284176,2340.9781283247726,292.6222660405965,0.0,0.0,1207,23555.819428883467,0.0,2048.355862284176,2048.355862284176,2515343.410436831,700.0,844900.0,94.73176392472222,1241298.8876433126,1276.6494566561166,28196.372335549306,0.0,0.0,653.0118988063507,1245318.903829319,23.962742896986367,529.2466286510751,-2048.355862284176,-4879460.297664013,true,true,5.856319013,11043.274174027949,0.0,1644.2724500334996,1207.0,5.856319013,11043.274174027949,0.0,121.92,0.0 -1208,24790.978128324772,24090.978128324772,0.14800000000000002,867.0144241073166,5577393.06889727,700.0,845600.0,10587.935298022408,24178611.301826175,9720.920873915093,18601218.232929077,true,1208.0,1208,0.875,758.637621093902,867.0144241073166,108.37680301341459,0.0,0.0,1208,24090.978128324772,0.0,758.637621093902,758.637621093902,2516102.048057925,700.0,845600.0,98.0618778924291,1241396.949521205,0.0,28196.372335549306,0.0,0.0,660.5757432014728,1245979.4795725204,0.0,529.2466286510751,-758.637621093902,-4880218.935285106,true,true,5.856319013,11049.13049304095,0.0,1644.2724500334996,1208.0,5.856319013,11049.13049304095,0.0,121.92,0.0 -1209,23317.014424107318,22617.014424107318,0.23500000000000001,5570.745776954092,5582963.814674224,700.0,846300.0,26684.02458278337,24205295.32640896,21113.27880582928,18622331.511734907,true,1209.0,1209,0.875,4874.402554834831,5570.745776954092,696.3432221192616,0.0,0.0,1209,22617.014424107318,0.0,4874.402554834831,4874.402554834831,2520976.4506127597,700.0,846300.0,108.51860554259576,1241505.4681267475,4007.3977154687386,32203.770051018044,0.0,0.0,683.2672763868388,1246662.746848907,75.21895743665766,604.4655860877327,-4874.402554834831,-4885093.3378399415,true,true,6.258661541,11055.38915458195,0.0,1644.2724500334996,1209.0,6.258661541,11055.38915458195,0.0,121.92,0.0 -1210,28020.745776954092,27320.745776954092,0.29250000000000004,9475.106543449974,5592438.921217673,700.0,847000.0,34786.689037435804,24240082.015446395,25311.58249398583,18647643.094228894,true,1210.0,1210,0.875,8290.718225518727,9475.106543449974,1184.388317931247,0.0,0.0,1210,27320.745776954092,0.0,8290.718225518727,8290.718225518727,2529267.1688382784,700.0,847000.0,139.97883663870027,1241645.4469633861,7270.493999389044,39474.26405040709,0.0,0.0,743.7780314914164,1247406.5248803985,136.46735799956664,740.9329440872993,-8290.718225518727,-4893384.056065461,true,true,6.92923242,11062.31838700195,0.0,1644.2724500334996,1210.0,6.92923242,11062.31838700195,0.0,121.92,0.0 -1211,31925.106543449976,31225.106543449976,0.30500000000000005,10476.34574260277,5602915.266960276,700.0,847700.0,36643.75653312383,24276725.77197952,26167.41079052106,18673810.505019415,true,1211.0,1211,0.875,9166.802524777424,10476.34574260277,1309.5432178253468,0.0,0.0,1211,31225.106543449976,0.0,9166.802524777424,9166.802524777424,2538433.971363056,700.0,847700.0,187.17438494677413,1241832.6213483328,8009.866270102224,47484.13032050931,0.0,0.0,819.4164753298395,1248225.9413557283,150.34539439858528,891.2783384858847,-9166.802524777424,-4902550.858590238,true,true,7.599803299,11069.918190300948,0.0,1644.2724500334996,1211.0,7.599803299,11069.918190300948,0.0,121.92,0.0 -1212,32926.345742602774,32226.345742602774,0.3175,12203.494363938122,5615118.761324215,700.0,848400.0,40640.927130513766,24317366.69911003,28437.432766575643,18702247.93778599,true,1212.0,1212,0.875,10678.057568445856,12203.494363938122,1525.4367954922654,0.0,0.0,1212,32226.345742602774,0.0,10678.057568445856,10678.057568445856,2549112.028931502,700.0,848400.0,246.00635469815484,1242078.627703031,9358.809912076973,56842.94023258629,0.0,0.0,897.5762006709024,1249123.517556399,175.6651009998257,1066.9434394857103,-10678.057568445856,-4913228.916158684,true,true,8.315078904,11078.233269204948,0.0,1644.2724500334996,1212.0,8.315078904,11078.233269204948,0.0,121.92,0.0 -1213,34653.49436393812,33953.49436393812,0.29250000000000004,9513.234024674592,5624631.995348889,700.0,849100.0,34917.03940059689,24352283.738510627,25403.8053759223,18727651.743161913,true,1213.0,1213,0.875,8324.079771590268,9513.234024674592,1189.1542530843235,0.0,0.0,1213,33953.49436393812,0.0,8324.079771590268,8324.079771590268,2557436.108703092,700.0,849100.0,306.33220267020187,1242384.9599057012,6922.167507888866,63765.107740475156,0.0,0.0,965.6508001706019,1250089.1683565697,129.92926086059876,1196.872700346309,-8324.079771590268,-4921552.995930274,true,true,8.806830882,11087.040100086948,0.0,1644.2724500334996,1213.0,8.806830882,11087.040100086948,0.0,121.92,0.0 -1214,31963.23402467459,31263.23402467459,0.3175,11714.645398696619,5636346.640747586,700.0,849800.0,39101.245350225574,24391384.983860854,27386.599951528955,18755038.34311344,true,1214.0,1214,0.875,10250.314723859541,11714.645398696619,1464.3306748370778,0.0,0.0,1214,31263.23402467459,0.0,10250.314723859541,10250.314723859541,2567686.4234269517,700.0,849800.0,367.60343378068563,1242752.5633394818,8693.37486659746,72458.48260707261,0.0,0.0,1026.1615552751794,1251115.3299118448,163.17486820621585,1360.047568552525,-10250.314723859541,-4931803.310654134,true,true,9.387992311,11096.428092397948,0.0,1644.2724500334996,1214.0,9.387992311,11096.428092397948,0.0,121.92,0.0 -1215,34164.64539869662,33464.64539869662,0.23500000000000001,5768.143041446927,5642114.783789033,700.0,850500.0,27524.012942327347,24418908.996803183,21755.869900880418,18776794.213014323,true,1215.0,1215,0.875,5047.125161266061,5768.143041446927,721.0178801808661,0.0,0.0,1215,33464.64539869662,0.0,5047.125161266061,5047.125161266061,2572733.5485882177,700.0,850500.0,418.56520403034614,1243171.1285435122,3491.4801638263343,75949.96277089894,0.0,0.0,1071.544621589513,1252186.8745334344,65.53517181986707,1425.5827403723922,-5047.125161266061,-4936850.4358153995,true,true,9.611515937,11106.039608334948,0.0,1644.2724500334996,1215.0,9.611515937,11106.039608334948,0.0,121.92,0.0 -1216,28218.14304144693,27518.14304144693,0.20800000000000002,4238.567970783865,5646353.3517598165,700.0,851200.0,23743.115244153196,24442652.112047337,19504.54727336933,18796298.76028769,true,1216.0,1216,0.875,3708.7469744358823,4238.567970783865,529.820996347983,0.0,0.0,1216,27518.14304144693,0.0,3708.7469744358823,3708.7469744358823,2576442.295562654,700.0,851200.0,442.64954365298934,1243613.7780871652,2134.321292359348,78084.2840632583,0.0,0.0,1091.7148732722394,1253278.5894067066,40.06126515130583,1465.644005523698,-3708.7469744358823,-4940559.182789835,true,true,9.745630113,11115.785238447948,0.0,1644.2724500334996,1216.0,9.745630113,11115.785238447948,0.0,121.92,0.0 -1217,26688.567970783864,25988.567970783864,0.16720000000000002,1772.791681946666,5648126.143441763,700.0,851900.0,14789.423935087714,24457441.535982426,13016.632253141048,18809315.39254083,true,1217.0,1217,0.875,1551.1927217033326,1772.791681946666,221.5989602433333,0.0,0.0,1217,25988.567970783864,0.0,1551.1927217033326,1551.1927217033326,2577993.4882843574,700.0,851900.0,451.91400403597083,1244065.6920912012,0.0,78084.2840632583,0.0,0.0,1099.2787176673617,1254377.868124374,0.0,1465.644005523698,-1551.1927217033326,-4942110.375511538,true,true,9.745630113,11125.530868560949,0.0,1644.2724500334996,1217.0,9.745630113,11125.530868560949,0.0,121.92,0.0 -1218,24222.791681946666,23522.791681946666,0.12,0.0,5648126.143441763,700.0,852600.0,5833.333333333334,24463274.86931576,5833.333333333334,18815148.725874163,true,1218.0,1218,0.875,0.0,0.0,0.0,0.0,0.0,1218,23522.791681946666,0.0,-640.0181405854249,-640.0181405854249,2577353.4701437717,700.0,852600.0,442.64954365298934,1244508.3416348542,-2134.321292359348,75949.96277089894,0.0,0.0,1091.7148732722394,1255469.5829976462,-40.06126515130583,1425.5827403723922,-0.0,-4942110.375511538,true,true,9.611515937,11135.142384497949,0.0,1644.2724500334996,1218.0,9.611515937,11135.142384497949,0.0,121.92,0.0 -1219,22450.0,21750.0,0.12,0.0,5648126.143441763,700.0,853300.0,5833.333333333334,24469108.20264909,5833.333333333334,18820982.059207495,true,1219.0,1219,0.875,0.0,0.0,0.0,0.0,0.0,1219,21750.0,0.0,-643.1631494288114,-643.1631494288114,2576710.3069943427,700.0,853300.0,424.50221122550295,1244932.8438460797,-2104.7464014426205,73845.21636945632,0.0,0.0,1076.5871844819953,1256546.1701821282,-39.50614369368908,1386.076596678703,-0.0,-4942110.375511538,true,true,9.477401761,11144.619786258949,0.0,1644.2724500334996,1219.0,9.477401761,11144.619786258949,0.0,121.92,0.0 -1220,22450.0,21750.0,0.20800000000000002,4166.105075250066,5652292.248517013,700.0,854000.0,23394.735938702237,24492502.938587792,19228.63086345217,18840210.690070946,true,1220.0,1220,0.875,3645.3419408438076,4166.105075250066,520.7631344062584,0.0,0.0,1220,21750.0,0.0,3645.3419408438076,3645.3419408438076,2580355.6489351867,700.0,854000.0,424.50221122550295,1245357.346057305,2104.7464014426205,75949.96277089894,0.0,0.0,1076.5871844819953,1257622.7573666102,39.50614369368908,1425.5827403723922,-3645.3419408438076,-4945755.717452382,true,true,9.611515937,11154.231302195949,0.0,1644.2724500334996,1220.0,9.611515937,11154.231302195949,0.0,121.92,0.0 -1221,26616.105075250067,25916.105075250067,0.20800000000000002,4238.567970783865,5656530.816487797,700.0,854700.0,23743.115244153196,24516246.053831946,19504.54727336933,18859715.237344313,true,1221.0,1221,0.875,3708.7469744358823,4238.567970783865,529.820996347983,0.0,0.0,1221,25916.105075250067,0.0,3708.7469744358823,3708.7469744358823,2584064.395909623,700.0,854700.0,442.64954365298934,1245799.9956009581,2134.321292359348,78084.2840632583,0.0,0.0,1091.7148732722394,1258714.4722398825,40.06126515130583,1465.644005523698,-3708.7469744358823,-4949464.464426817,true,true,9.745630113,11163.97693230895,0.0,1644.2724500334996,1221.0,9.745630113,11163.97693230895,0.0,121.92,0.0 -1222,26688.567970783864,25988.567970783864,0.196,3461.4972900681155,5659992.313777865,700.0,855400.0,21232.129030959768,24537478.182862908,17770.63174089165,18877485.869085204,true,1222.0,1222,0.875,3028.810128809601,3461.4972900681155,432.6871612585146,0.0,0.0,1222,25988.567970783864,0.0,3028.810128809601,3028.810128809601,2587093.206038432,700.0,855400.0,458.1615752643924,1246258.1571762224,1439.3113619171293,79523.59542517543,0.0,0.0,1104.3212806162426,1259818.7935204988,27.0159110118367,1492.6599165355349,-3028.810128809601,-4952493.274555627,true,true,9.835039564,11173.81197187295,0.0,1644.2724500334996,1222.0,9.835039564,11173.81197187295,0.0,121.92,0.0 -1223,25911.497290068117,25211.497290068117,0.14800000000000002,952.3564183801708,5660944.670196245,700.0,856100.0,11164.570394460612,24548642.753257368,10212.213976080442,18887698.083061285,true,1223.0,1223,0.875,833.3118660826494,952.3564183801708,119.04455229752136,0.0,0.0,1223,25211.497290068117,0.0,833.3118660826494,833.3118660826494,2587926.517904515,700.0,856100.0,461.3068382735643,1246719.464014496,-721.2987385151914,78802.29668666024,0.0,0.0,1106.8425620624835,1260925.6360825612,-13.53879573820693,1479.1211207973279,-833.3118660826494,-4953326.5864217095,true,true,9.790334838,11183.60230671095,0.0,1644.2724500334996,1223.0,9.790334838,11183.60230671095,0.0,121.92,0.0 -1224,23402.35641838017,22702.35641838017,0.124,104.64116966280368,5661049.311365908,700.0,856800.0,6489.041690829062,24555131.794948198,6384.400521166258,18894082.483582452,true,1224.0,1224,0.875,91.56102345495322,104.64116966280368,13.080146207850461,0.0,0.0,1224,22702.35641838017,0.0,91.56102345495322,91.56102345495322,2588018.07892797,700.0,856800.0,451.91400403597083,1247171.378018532,-1432.7391478621566,77369.55753879808,0.0,0.0,1099.2787176673617,1262024.9148002286,-26.892550386222545,1452.2285704111052,-91.56102345495322,-4953418.147445165,true,true,9.700925388,11193.303232098951,0.0,1644.2724500334996,1224.0,9.700925388,11193.303232098951,0.0,121.92,0.0 -1225,22554.641169662802,21854.641169662802,0.124,94.33458166391918,5661143.645947572,700.0,857500.0,6405.9240456767675,24561537.718993876,6311.589464012848,18900394.073046464,true,1225.0,1225,0.875,82.54275895592929,94.33458166391918,11.791822707989894,0.0,0.0,1225,21854.641169662802,0.0,82.54275895592929,82.54275895592929,2588100.621686926,700.0,857500.0,439.58976506777304,1247610.9677835996,-1419.5947678991292,75949.96277089894,0.0,0.0,1089.1935918259985,1263114.1083920544,-26.645830038713054,1425.5827403723922,-82.54275895592929,-4953500.69020412,true,true,9.611515937,11202.914748035952,0.0,1644.2724500334996,1225.0,9.611515937,11202.914748035952,0.0,121.92,0.0 -1226,22544.33458166392,21844.33458166392,0.16720000000000002,1734.47268879474,5662878.118636367,700.0,858200.0,14560.243354035525,24576097.96234791,12825.770665240785,18913219.843711704,true,1226.0,1226,0.875,1517.6636026953975,1734.47268879474,216.8090860993425,0.0,0.0,1226,21844.33458166392,0.0,1517.6636026953975,1517.6636026953975,2589618.2852896214,700.0,858200.0,433.51257381828,1248044.4803574178,0.0,75949.96277089894,0.0,0.0,1084.1510288771174,1264198.2594209316,0.0,1425.5827403723922,-1517.6636026953975,-4955018.353806816,true,true,9.611515937,11212.526263972952,0.0,1644.2724500334996,1226.0,9.611515937,11212.526263972952,0.0,121.92,0.0 -1227,24184.47268879474,23484.47268879474,0.14800000000000002,907.4585383236245,5663785.577174691,700.0,858900.0,10861.206340024488,24586959.168687936,9953.747801700863,18923173.591513406,true,1227.0,1227,0.875,794.0262210331714,907.4585383236245,113.43231729045306,0.0,0.0,1227,23484.47268879474,0.0,794.0262210331714,794.0262210331714,2590412.3115106546,700.0,858900.0,430.4950957918748,1248474.9754532096,-704.8682275614793,75245.09454333746,0.0,0.0,1081.6297474308763,1265279.8891683624,-13.230394628100415,1412.3523457442918,-794.0262210331714,-4955812.380027849,true,true,9.566811212,11222.093075184952,0.0,1644.2724500334996,1227.0,9.566811212,11222.093075184952,0.0,121.92,0.0 -1228,23357.458538323626,22657.458538323626,0.12,0.0,5663785.577174691,700.0,859600.0,5833.333333333334,24592792.502021268,5833.333333333334,18929006.92484674,true,1228.0,1228,0.875,0.0,0.0,0.0,0.0,0.0,1228,22657.458538323626,0.0,-7594.593276152172,-7594.593276152172,2582817.7182345022,700.0,859600.0,389.7091672099357,1248864.6846204195,-8864.252013699832,66380.84252963762,0.0,0.0,1046.3318069579057,1266326.2209753203,-166.3822366201811,1245.9701091241106,-0.0,-4955812.380027849,true,true,8.985649783,11231.078724967952,0.0,1644.2724500334996,1228.0,8.985649783,11231.078724967952,0.0,121.92,0.0 -1229,22450.0,21750.0,0.12,0.0,5663785.577174691,700.0,860300.0,5833.333333333334,24598625.8353546,5833.333333333334,18934840.25818007,true,1229.0,1229,0.875,0.0,0.0,0.0,0.0,0.0,1229,21750.0,0.0,-2640.1381185817872,-2640.1381185817872,2580177.5801159204,700.0,860300.0,338.596051647782,1249203.2806720673,-3903.885597039641,62476.95693259798,0.0,0.0,998.4274591409325,1267324.6484344613,-73.27603233086057,1172.6940767932501,-0.0,-4955812.380027849,true,true,8.717421431,11239.796146398952,0.0,1644.2724500334996,1229.0,8.717421431,11239.796146398952,0.0,121.92,0.0 -1230,22450.0,21750.0,0.12,0.0,5663785.577174691,700.0,861000.0,5833.333333333334,24604459.168687932,5833.333333333334,18940673.591513403,true,1230.0,1230,0.875,0.0,0.0,0.0,0.0,0.0,1230,21750.0,0.0,-651.6191893981224,-651.6191893981224,2579525.9609265225,700.0,861000.0,316.03066633544637,1249519.3113384028,-1907.5804480314348,60569.37648456655,0.0,0.0,975.735926011965,1268300.3843604734,-35.805333714099106,1136.888743079151,-0.0,-4955812.380027849,true,true,8.583307256,11248.379453654952,0.0,1644.2724500334996,1230.0,8.583307256,11248.379453654952,0.0,121.92,0.0 -1231,22450.0,21750.0,0.20800000000000002,4450.995057189844,5668236.57223188,700.0,861700.0,24764.399313412712,24629223.568001345,20313.404256222868,18960986.995769627,true,1231.0,1231,0.875,3894.620675041114,4450.995057189844,556.3743821487305,0.0,0.0,1231,21750.0,0.0,3894.620675041114,3894.620675041114,2583420.581601564,700.0,861700.0,318.48685231581305,1249837.7981907185,2550.012809666063,63119.38929423261,0.0,0.0,978.2572075146049,1269278.641567988,47.86380554463323,1184.7525486237842,-3894.620675041114,-4959707.000702891,true,true,8.762126157,11257.141579811952,0.0,1644.2724500334996,1231.0,8.762126157,11257.141579811952,0.0,121.92,0.0 -1232,26900.995057189844,26200.995057189844,0.1912,3023.887481661989,5671260.459713543,700.0,862400.0,19476.398962667306,24648699.966964014,16452.511481005316,18977439.507250633,true,1232.0,1232,0.875,2645.9015464542404,3023.887481661989,377.98593520774875,0.0,0.0,1232,26200.995057189844,0.0,2645.9015464542404,2645.9015464542404,2586066.483148018,700.0,862400.0,333.49167517286133,1250171.2898658914,1294.7229914268405,64414.11228565945,0.0,0.0,993.3848962484503,1270272.0264642364,24.30198360608816,1209.0545322298724,-2645.9015464542404,-4962352.902249345,true,true,8.851535607,11265.993115418953,0.0,1644.2724500334996,1232.0,8.851535607,11265.993115418953,0.0,121.92,0.0 -1233,25473.88748166199,24773.88748166199,0.1912,3062.443859805262,5674322.903573348,700.0,863100.0,19678.05366006936,24668378.020624083,16615.609800264097,18994055.117050897,true,1233.0,1233,0.875,2679.6383773296043,3062.443859805262,382.80548247565775,0.0,0.0,1233,24773.88748166199,0.0,2679.6383773296043,2679.6383773296043,2588746.1215253477,700.0,863100.0,343.75224881844815,1250515.04211471,1307.8674018951594,65721.97968755462,0.0,0.0,1003.4700220898135,1271275.4964863262,24.54870452618335,1233.6032367560558,-2679.6383773296043,-4965032.540626674,true,true,8.940945058,11274.934060476953,0.0,1644.2724500334996,1233.0,8.940945058,11274.934060476953,0.0,121.92,0.0 -1234,25512.443859805262,24812.443859805262,0.12,0.0,5674322.903573348,700.0,863800.0,5833.333333333334,24674211.353957415,5833.333333333334,18999888.45038423,true,1234.0,1234,0.875,0.0,0.0,0.0,0.0,0.0,1234,24812.443859805262,0.0,-1973.9883350366188,-1973.9883350366188,2586772.133190311,700.0,863800.0,336.0374021881232,1250851.0795168981,-3245.022754956628,62476.95693259799,0.0,0.0,995.9061776946916,1272271.402664021,-60.90915996280563,1172.6940767932501,-0.0,-4965032.540626674,true,true,8.717421431,11283.651481907953,0.0,1644.2724500334996,1234.0,8.717421431,11283.651481907953,0.0,121.92,0.0 -1235,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,864500.0,5833.333333333334,24680044.687290747,5833.333333333334,19005721.78371756,true,1235.0,1235,0.875,0.0,0.0,0.0,0.0,0.0,1235,21750.0,0.0,-11177.722787897766,-11177.722787897766,2575594.4104024135,700.0,864500.0,276.1859006480107,1251127.2654175463,-12158.566231098117,50318.39070149987,0.0,0.0,932.8741411438726,1273204.2768051648,-228.2165985915319,944.4774782017182,-0.0,-4965032.540626674,true,true,7.823326926,11291.474808833953,0.0,1644.2724500334996,1235.0,7.823326926,11291.474808833953,0.0,121.92,0.0 -1236,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,865200.0,5833.333333333334,24685878.02062408,5833.333333333334,19011555.117050894,true,1236.0,1236,0.875,0.0,0.0,0.0,0.0,0.0,1236,21750.0,0.0,-10019.701513345493,-10019.701513345493,2565574.708889068,700.0,865200.0,195.94678918786877,1251323.212206734,-10844.126651092785,39474.26405040709,0.0,0.0,832.0228826738424,1274036.2996878386,-203.5445341144187,740.9329440872996,-0.0,-4965032.540626674,true,true,6.92923242,11298.404041253953,0.0,1644.2724500334996,1236.0,6.92923242,11298.404041253953,0.0,121.92,0.0 -1237,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,865900.0,5833.333333333334,24691711.35395741,5833.333333333334,19017388.450384226,true,1237.0,1237,0.875,0.0,0.0,0.0,0.0,0.0,1237,21750.0,0.0,-11081.677194013635,-11081.677194013635,2554493.0316950544,700.0,865900.0,126.22079517922248,1251449.4330019134,-11706.727629548612,27767.536420858476,0.0,0.0,718.5652168598092,1274754.8649046985,-219.73557650405576,521.1973675832438,-0.0,-4965032.540626674,true,true,5.811614288,11304.215655541953,0.0,1644.2724500334996,1237.0,5.811614288,11304.215655541953,0.0,121.92,0.0 -1238,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,866600.0,5833.333333333334,24697544.687290743,5833.333333333334,19023221.783717558,true,1238.0,1238,0.875,0.0,0.0,0.0,0.0,0.0,1238,21750.0,0.0,-10903.602653000222,-10903.602653000222,2543589.4290420543,700.0,866600.0,66.34066794980204,1251515.7736698631,-11337.041498969964,16430.494921888512,0.0,0.0,579.8947364141688,1275334.7596411125,-212.7965583942284,308.4008091890154,-0.0,-4965032.540626674,true,true,4.470472529,11308.686128070953,0.0,1644.2724500334996,1238.0,4.470472529,11308.686128070953,0.0,121.92,0.0 -1239,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,867300.0,5833.333333333334,24703378.020624075,5833.333333333334,19029055.11705089,true,1239.0,1239,0.875,0.0,0.0,0.0,0.0,0.0,1239,21750.0,0.0,-5540.372772986647,-5540.372772986647,2538049.056269068,700.0,867300.0,31.799028143382223,1251547.5726980064,-5914.978173056042,10515.51674883247,0.0,0.0,453.83066325613277,1275788.5903043686,-111.0242913301204,197.37651785889497,-0.0,-4965032.540626674,true,true,3.576378023,11312.262506093954,0.0,1644.2724500334996,1239.0,3.576378023,11312.262506093954,0.0,121.92,0.0 -1240,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,868000.0,5833.333333333334,24709211.353957407,5833.333333333334,19034888.450384222,true,1240.0,1240,0.875,0.0,0.0,0.0,0.0,0.0,1240,21750.0,0.0,-4318.94971792251,-4318.94971792251,2533730.106551145,700.0,868000.0,14.961682648637149,1251562.534380655,-4600.53857871689,5914.97817011558,0.0,0.0,352.9794047297039,1276141.5697090984,-86.35222658396157,111.0242912749334,-0.0,-4965032.540626674,true,true,2.682283517,11314.944789610954,0.0,1644.2724500334996,1240.0,2.682283517,11314.944789610954,0.0,121.92,0.0 -1241,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,868700.0,5833.333333333334,24715044.68729074,5833.333333333334,19040721.783717554,true,1241.0,1241,0.875,0.0,0.0,0.0,0.0,0.0,1241,21750.0,0.0,-3090.198488704966,-3090.198488704966,2530639.9080624403,700.0,868700.0,5.452508255444662,1251567.9868889104,-3286.0989814374707,2628.879188678109,0.0,0.0,252.1281462596736,1276393.697855358,-61.68016178261377,49.34412949231963,-0.0,-4965032.540626674,true,true,1.788189012,11316.732978622955,0.0,1644.2724500334996,1241.0,1.788189012,11316.732978622955,0.0,121.92,0.0 -1242,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,869400.0,5833.333333333334,24720878.02062407,5833.333333333334,19046555.117050886,true,1242.0,1242,0.875,0.0,0.0,0.0,0.0,0.0,1242,21750.0,0.0,-1466.66164528917,-1466.66164528917,2529173.2464171513,700.0,869400.0,1.4973950798833795,1251569.4842839902,-1601.9732565196732,1026.905932158436,0.0,0.0,163.8832950772476,1276557.5811504351,-30.069078926627657,19.275050565691974,-0.0,-4965032.540626674,true,true,1.117618132,11317.850596754955,0.0,1644.2724500334996,1242.0,1.117618132,11317.850596754955,0.0,121.92,0.0 -1243,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,870100.0,5833.333333333334,24726711.353957403,5833.333333333334,19052388.45038422,true,1243.0,1243,0.875,0.0,0.0,0.0,0.0,0.0,1243,21750.0,0.0,-883.3007190800487,-883.3007190800487,2528289.9456980713,700.0,870100.0,0.1786677904094994,1251569.6629517807,-946.3965070568084,80.50942510162747,0.0,0.0,80.68100678730396,1276638.2621572225,-17.763886600953644,1.51116396473833,-0.0,-4965032.540626674,true,true,0.312933077,11318.163529831956,0.0,1644.2724500334996,1243.0,0.312933077,11318.163529831956,0.0,121.92,0.0 -1244,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,870800.0,5833.333333333334,24732544.687290736,5833.333333333334,19058221.78371755,true,1244.0,1244,0.875,0.0,0.0,0.0,0.0,0.0,1244,21750.0,0.0,-64.36974861973837,-64.36974861973837,2528225.5759494514,700.0,870800.0,0.0018702103310796435,1251569.664821991,-80.50942510181822,-1.907523028421565e-10,0.0,0.0,17.648970236485194,1276655.911127459,-1.511163964736424,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1244.0,0.0,11318.163529831956,0.0,121.92,0.0 -1245,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,871500.0,5833.333333333334,24738378.020624068,5833.333333333334,19064055.117050882,true,1245.0,1245,0.875,0.0,0.0,0.0,0.0,0.0,1245,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,871500.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1245.0,0.0,11318.163529831956,0.0,121.92,0.0 -1246,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,872200.0,5833.333333333334,24744211.3539574,5833.333333333334,19069888.450384215,true,1246.0,1246,0.875,0.0,0.0,0.0,0.0,0.0,1246,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,872200.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1246.0,0.0,11318.163529831956,0.0,121.92,0.0 -1247,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,872900.0,5833.333333333334,24750044.68729073,5833.333333333334,19075721.783717547,true,1247.0,1247,0.875,0.0,0.0,0.0,0.0,0.0,1247,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,872900.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1247.0,0.0,11318.163529831956,0.0,121.92,0.0 -1248,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,873600.0,5833.333333333334,24755878.020624064,5833.333333333334,19081555.11705088,true,1248.0,1248,0.875,0.0,0.0,0.0,0.0,0.0,1248,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,873600.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1248.0,0.0,11318.163529831956,0.0,121.92,0.0 -1249,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,874300.0,5833.333333333334,24761711.353957396,5833.333333333334,19087388.45038421,true,1249.0,1249,0.875,0.0,0.0,0.0,0.0,0.0,1249,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,874300.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1249.0,0.0,11318.163529831956,0.0,121.92,0.0 -1250,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,875000.0,5833.333333333334,24767544.687290728,5833.333333333334,19093221.783717543,true,1250.0,1250,0.875,0.0,0.0,0.0,0.0,0.0,1250,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,875000.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1250.0,0.0,11318.163529831956,0.0,121.92,0.0 -1251,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,875700.0,5833.333333333334,24773378.02062406,5833.333333333334,19099055.117050875,true,1251.0,1251,0.875,0.0,0.0,0.0,0.0,0.0,1251,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,875700.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,1644.2724500334996,1251.0,0.0,11318.163529831956,0.0,121.92,0.0 -1252,22450.0,21750.0,0.128,220.12254231489132,5674543.026115663,700.0,876400.0,7188.457361835089,24780566.477985896,6968.334819520197,19106023.451870397,true,1252.0,1252,0.875,192.60722452552992,220.12254231489132,27.515317789361404,0.0,0.0,1252,21750.0,0.0,192.60722452552992,192.60722452552992,2528418.183173977,700.0,876400.0,0.005452508259103674,1251569.6702744993,164.30494929239373,164.304949292203,0.0,0.0,25.212814631607213,1276681.1239420907,3.084008093269858,3.084008093271764,-192.60722452552992,-4965225.1478512,true,true,0.447047253,11318.610577084955,0.0,1644.2724500334996,1252.0,0.447047253,11318.610577084955,0.0,121.92,0.0 -1253,22670.12254231489,21970.12254231489,0.12,57.679142090614,5674600.705257754,700.0,877100.0,6313.992850755118,24786880.47083665,6256.313708664504,19112279.76557906,true,1253.0,1253,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1253,21970.12254231489,0.0,50.46924932928725,50.46924932928725,2528468.652423306,700.0,877100.0,0.043620066072829394,1251569.7138945654,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276731.549571354,0.0,3.084008093271764,-50.46924932928725,-4965275.617100529,true,true,0.447047253,11319.057624337955,0.0,1644.2724500334996,1253.0,0.447047253,11319.057624337955,0.0,121.92,0.0 -1254,22507.679142090616,21807.679142090616,0.12,57.679142090614,5674658.384399844,700.0,877800.0,6313.992850755118,24793194.463687405,6256.313708664504,19118536.079287723,true,1254.0,1254,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1254,21807.679142090616,0.0,50.46924932928725,50.46924932928725,2528519.121672635,700.0,877800.0,0.043620066072829394,1251569.7575146314,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276781.9752006172,0.0,3.084008093271764,-50.46924932928725,-4965326.086349859,true,true,0.447047253,11319.504671590954,0.0,1644.2724500334996,1254.0,0.447047253,11319.504671590954,0.0,121.92,0.0 -1255,22507.679142090616,21807.679142090616,0.12,57.679142090614,5674716.063541935,700.0,878500.0,6313.992850755118,24799508.45653816,6256.313708664504,19124792.392996386,true,1255.0,1255,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1255,21807.679142090616,0.0,50.46924932928725,50.46924932928725,2528569.590921964,700.0,878500.0,0.043620066072829394,1251569.8011346974,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276832.4008298805,0.0,3.084008093271764,-50.46924932928725,-4965376.555599188,true,true,0.447047253,11319.951718843953,0.0,1644.2724500334996,1255.0,0.447047253,11319.951718843953,0.0,121.92,0.0 -1256,22507.679142090616,21807.679142090616,0.12,57.679142090614,5674773.742684025,700.0,879200.0,6313.992850755118,24805822.449388914,6256.313708664504,19131048.70670505,true,1256.0,1256,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1256,21807.679142090616,0.0,50.46924932928725,50.46924932928725,2528620.060171293,700.0,879200.0,0.043620066072829394,1251569.8447547634,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276882.8264591438,0.0,3.084008093271764,-50.46924932928725,-4965427.024848518,true,true,0.447047253,11320.398766096952,0.0,1644.2724500334996,1256.0,0.447047253,11320.398766096952,0.0,121.92,0.0 -1257,22507.679142090616,21807.679142090616,0.132,373.4582001142193,5675147.200884139,700.0,879900.0,8132.259091774389,24813954.70848069,7758.80089166017,19138807.50759671,true,1257.0,1257,0.875,326.7759250999419,373.4582001142193,46.68227501427742,0.0,0.0,1257,21807.679142090616,0.0,326.7759250999419,326.7759250999419,2528946.836096393,700.0,879900.0,0.09583328521147606,1251569.9405880487,256.3157211313559,420.62067042355886,0.0,0.0,65.55331805345847,1276948.3797771973,4.8110526299160945,7.895060723187859,-326.7759250999419,-4965753.800773618,true,true,0.715275605,11321.114041701952,0.0,1644.2724500334996,1257.0,0.715275605,11321.114041701952,0.0,121.92,0.0 -1258,22823.45820011422,22123.45820011422,0.16,1365.1366376968836,5676512.337521836,700.0,880600.0,12907.103985605521,24826861.812466294,11541.967347908638,19150349.474944618,true,1258.0,1258,0.875,1194.494557984773,1365.1366376968836,170.64207971211044,0.0,0.0,1258,22123.45820011422,0.0,1194.494557984773,1194.494557984773,2530141.3306543776,700.0,880600.0,0.5307253440629649,1251570.4713133927,1058.1238732077943,1478.7445436313533,0.0,0.0,115.97894731667289,1277064.358724514,19.861012116242772,27.75607283943063,-1194.494557984773,-4966948.295331603,true,true,1.341141759,11322.455183460952,0.0,1644.2724500334996,1258.0,1.341141759,11322.455183460952,0.0,121.92,0.0 -1259,23815.136637696884,23115.136637696884,0.1648,1542.9515593757349,5678055.289081212,700.0,881300.0,13610.142957377033,24840471.95542367,12067.191398001298,19162416.66634262,true,1259.0,1259,0.875,1350.082614453768,1542.9515593757349,192.8689449219669,0.0,0.0,1259,23115.136637696884,0.0,1350.082614453768,1350.082614453768,2531491.4132688316,700.0,881300.0,1.8702103328725608,1251572.3415237255,1150.1346450467558,2628.879188678109,0.0,0.0,176.4897024212505,1277240.8484269353,21.588056652889,49.34412949231963,-1350.082614453768,-4968298.377946056,true,true,1.788189012,11324.243372472953,0.0,1644.2724500334996,1259.0,1.788189012,11324.243372472953,0.0,121.92,0.0 -1260,23992.951559375735,23292.951559375735,0.17200000000000001,1985.5895118544438,5680040.878593067,700.0,882000.0,15613.89251078165,24856085.847934455,13628.302998927207,19176044.969341546,true,1260.0,1260,0.875,1737.3908228726384,1985.5895118544438,248.1986889818054,0.0,0.0,1260,23292.951559375735,0.0,1737.3908228726384,1737.3908228726384,2533228.804091704,700.0,882000.0,3.974878517922778,1251576.3164022435,1478.7445399562066,4107.623728634316,0.0,0.0,226.91533162806638,1277467.7637585634,27.756072770442543,77.10020226276217,-1737.3908228726384,-4970035.768768929,true,true,2.235236264,11326.478608736952,0.0,1644.2724500334996,1260.0,2.235236264,11326.478608736952,0.0,121.92,0.0 -1261,24435.589511854443,23735.589511854443,0.1936,3144.818281742082,5683185.6968748085,700.0,882700.0,19859.598562717365,24875945.446497172,16714.780280975283,19192759.74962252,true,1261.0,1261,0.875,2751.715996524322,3144.818281742082,393.10228521776025,0.0,0.0,1261,23735.589511854443,0.0,2751.715996524322,2751.715996524322,2535980.5200882284,700.0,882700.0,7.867407800658743,1251584.183810044,2413.6397046127686,6521.263433247084,0.0,0.0,284.9048052300043,1277752.6685637934,45.30407888089005,122.40428114365221,-2751.715996524322,-4972787.484765453,true,true,2.816397693,11329.295006429953,0.0,1644.2724500334996,1261.0,2.816397693,11329.295006429953,0.0,121.92,0.0 -1262,25594.818281742082,24894.818281742082,0.22,5080.814930548649,5688266.511805357,700.0,883400.0,26276.43150249386,24902221.877999667,21195.61657194521,19213955.366194464,true,1262.0,1262,0.875,4445.713064230067,5080.814930548649,635.1018663185814,0.0,0.0,1262,24894.818281742082,0.0,4445.713064230067,4445.713064230067,2540426.2331524584,700.0,883400.0,15.944262804612375,1251600.1280728488,3994.2533155853857,10515.51674883247,0.0,0.0,360.54324912482593,1278113.2118129183,74.97223671524274,197.37651785889494,-4445.713064230067,-4977233.197829683,true,true,3.576378023,11332.871384452954,0.0,1644.2724500334996,1262.0,3.576378023,11332.871384452954,0.0,121.92,0.0 -1263,27530.814930548648,26830.814930548648,0.28,7441.865320897917,5695708.377126255,700.0,884100.0,29078.09043177827,24931299.968431447,21636.225110880354,19235591.591305345,true,1263.0,1263,0.875,6511.632155785677,7441.865320897917,930.2331651122395,0.0,0.0,1263,26830.814930548648,0.0,6511.632155785677,6511.632155785677,2546937.8653082442,700.0,884100.0,31.799028143382223,1251631.927100992,5914.978173056042,16430.494921888512,0.0,0.0,453.83066325613277,1278567.0424761744,111.0242913301204,308.4008091890154,-6511.632155785677,-4983744.829985469,true,true,4.470472529,11337.341856981953,0.0,1644.2724500334996,1263.0,4.470472529,11337.341856981953,0.0,121.92,0.0 -1264,29891.865320897916,29191.865320897916,0.184,2605.2269130071954,5698313.604039262,700.0,884800.0,17963.189744604322,24949263.15817605,15357.962831597128,19250949.554136943,true,1264.0,1264,0.875,2279.573548881296,2605.2269130071954,325.6533641258993,0.0,0.0,1264,29191.865320897916,0.0,2279.573548881296,2279.573548881296,2549217.4388571256,700.0,884800.0,46.974040177268016,1251678.9011411692,1684.1257260203947,18114.62064790891,0.0,0.0,516.8626998069515,1279083.9051759813,31.611082876681838,340.0118920656972,-2279.573548881296,-4986024.40353435,true,true,4.693996155,11342.035853136953,0.0,1644.2724500334996,1264.0,4.693996155,11342.035853136953,0.0,121.92,0.0 -1265,25055.226913007195,24355.226913007195,0.12,0.0,5698313.604039262,700.0,885500.0,5833.333333333334,24955096.49150938,5833.333333333334,19256782.887470275,true,1265.0,1265,0.875,0.0,0.0,0.0,0.0,0.0,1265,24355.226913007195,0.0,-2799.9027880981075,-2799.9027880981075,2546417.5360690276,700.0,885500.0,43.62006602892123,1251722.5212071983,-3286.098984745276,14828.521663163632,0.0,0.0,504.25629246294864,1279588.1614684444,-61.680161844701246,278.33173022099595,-0.0,-4986024.40353435,true,true,4.246948902,11346.282802038953,0.0,1644.2724500334996,1265.0,4.246948902,11346.282802038953,0.0,121.92,0.0 -1266,22450.0,21750.0,0.12,0.0,5698313.604039262,700.0,886200.0,5833.333333333334,24960929.824842714,5833.333333333334,19262616.220803607,true,1266.0,1266,0.875,0.0,0.0,0.0,0.0,0.0,1266,21750.0,0.0,-2527.371534053781,-2527.371534053781,2543890.164534974,700.0,886200.0,31.799028143382202,1251754.3202353416,-2957.489079912411,11871.03258325122,0.0,0.0,453.83066325613265,1280041.9921317005,-55.51214554088505,222.8195846801109,-0.0,-4986024.40353435,true,true,3.79990165,11350.082703688953,0.0,1644.2724500334996,1266.0,3.79990165,11350.082703688953,0.0,121.92,0.0 -1267,22450.0,21750.0,0.12,0.0,5698313.604039262,700.0,886900.0,5833.333333333334,24966763.158176046,5833.333333333334,19268449.55413694,true,1267.0,1267,0.875,0.0,0.0,0.0,0.0,0.0,1267,21750.0,0.0,-1996.7848292853987,-1996.7848292853987,2541893.3797056885,700.0,886900.0,22.75484910773055,1251777.0750844493,-2380.778716591958,9490.253866659263,0.0,0.0,405.926315495558,1280447.918447196,-44.68727729672922,178.13230738338166,-0.0,-4986024.40353435,true,true,3.397559122,11353.480262810954,0.0,1644.2724500334996,1267.0,3.397559122,11353.480262810954,0.0,121.92,0.0 -1268,22450.0,21750.0,0.20800000000000002,4264.863480091449,5702578.467519353,700.0,887600.0,23869.535961978116,24990632.694138024,19604.672481886668,19288054.226618826,true,1268.0,1268,0.875,3731.7555450800173,4264.863480091449,533.1079350114314,0.0,0.0,1268,21750.0,0.0,3731.7555450800173,3731.7555450800173,2545625.1352507686,700.0,887600.0,24.050708568792974,1251801.1257930181,3233.5213974874864,12723.775264146749,0.0,0.0,413.4901598342815,1280861.4086070303,60.69327918945601,238.82558657283766,-3731.7555450800173,-4989756.15907943,true,true,3.934015825,11357.414278635953,0.0,1644.2724500334996,1268.0,3.934015825,11357.414278635953,0.0,121.92,0.0 -1269,26714.863480091448,26014.863480091448,0.29250000000000004,8952.001395125086,5711530.468914478,700.0,888300.0,32998.29536794901,25023630.989505973,24046.29397282392,19312100.52059165,true,1269.0,1269,0.875,7833.001220734451,8952.001395125086,1119.000174390635,0.0,0.0,1269,26014.863480091448,0.0,7833.001220734451,7833.001220734451,2553458.136471503,700.0,888300.0,42.32450645597278,1251843.4502994742,7157.123592146964,19880.898856293712,0.0,0.0,499.21372957046634,1281360.6223366007,134.33939256104742,373.1649791338851,-7833.001220734451,-4997589.1603001645,true,true,4.917519782,11362.331798417954,0.0,1644.2724500334996,1269.0,4.917519782,11362.331798417954,0.0,121.92,0.0 -1270,31402.001395125088,30702.001395125088,0.33999999999999997,15165.357267266652,5726695.826181745,700.0,889000.0,46662.81549196075,25070293.804997932,31497.458224694095,19343597.978816345,true,1270.0,1270,0.875,13269.687608858321,15165.357267266652,1895.669658408331,0.0,0.0,1270,30702.001395125088,0.0,13269.687608858321,13269.687608858321,2566727.824080361,700.0,889000.0,85.19544150275728,1251928.645740977,12322.871194724332,32203.770051018044,0.0,0.0,630.3203656773833,1281990.942702278,231.3006069538478,604.4655860877328,-13269.687608858321,-5010858.847909023,true,true,6.258661541,11368.590459958954,0.0,1644.2724500334996,1270.0,6.258661541,11368.590459958954,0.0,121.92,0.0 -1271,37615.35726726665,36915.35726726665,0.35,18869.94965570459,5745565.775837449,700.0,889700.0,55914.14187344169,25126207.946871374,37044.1922177371,19380642.171034083,true,1271.0,1271,0.875,16511.205948741517,18869.94965570459,2358.7437069630723,0.0,0.0,1271,36915.35726726665,0.0,16511.205948741517,16511.205948741517,2583239.0300291027,700.0,889700.0,162.4356734414682,1252091.0814144185,15280.360269491268,47484.13032050931,0.0,0.0,781.597253410628,1282772.5399556886,286.81275239815193,891.2783384858848,-16511.205948741517,-5027370.053857764,true,true,7.599803299,11376.190263257953,0.0,1644.2724500334996,1271.0,7.599803299,11376.190263257953,0.0,121.92,0.0 -1272,41319.94965570459,40619.94965570459,0.35,18811.028439606307,5764376.804277056,700.0,890400.0,55745.79554173231,25181953.742413107,36934.767102126,19417576.93813621,true,1272.0,1272,0.875,16459.64988465552,18811.028439606307,2351.3785549507884,0.0,0.0,1272,40619.94965570459,0.0,16459.64988465552,16459.64988465552,2599698.6799137583,700.0,890400.0,265.13980045960426,1252356.2212148781,14992.82661208868,62476.956932598,0.0,0.0,920.2677337998698,1283692.8076894884,281.41573830736536,1172.6940767932501,-16459.64988465552,-5043829.703742419,true,true,8.717421431,11384.907684688953,0.0,1644.2724500334996,1272.0,8.717421431,11384.907684688953,0.0,121.92,0.0 -1273,41261.02843960631,40561.02843960631,0.33,13202.524529721035,5777579.328806777,700.0,891100.0,42128.86221127586,25224082.604624383,28926.337681554825,19446503.275817763,true,1273.0,1273,0.875,11552.208963505906,13202.524529721035,1650.3155662151294,0.0,0.0,1273,40561.02843960631,0.0,11552.208963505906,11552.208963505906,2611250.888877264,700.0,891100.0,362.21080494571305,1252718.432019824,9981.525674474618,72458.48260707261,0.0,0.0,1021.1189923262987,1284713.9266818147,187.353491759275,1360.047568552525,-11552.208963505906,-5055381.912705925,true,true,9.387992311,11394.295676999953,0.0,1644.2724500334996,1273.0,9.387992311,11394.295676999953,0.0,121.92,0.0 -1274,35652.524529721035,34952.524529721035,0.28625,8271.99772761489,5785851.326534391,700.0,891800.0,31343.223502584766,25255425.828126967,23071.225774969877,19469574.501592733,true,1274.0,1274,0.875,7237.998011663029,8271.99772761489,1033.9997159518607,0.0,0.0,1274,34952.524529721035,0.0,7237.998011663029,7237.998011663029,2618488.8868889273,700.0,891800.0,427.4916525215372,1253145.9236723455,5625.801456185683,78084.2840632583,0.0,0.0,1079.1084659846351,1285793.0351477994,105.5964369711729,1465.6440055236978,-7237.998011663029,-5062619.910717588,true,true,9.745630113,11404.041307112953,0.0,1644.2724500334996,1274.0,9.745630113,11404.041307112953,0.0,121.92,0.0 -1275,30721.99772761489,30021.99772761489,0.22,5165.572517304946,5791016.899051696,700.0,892500.0,26661.693260477026,25282087.521387443,21496.12074317208,19491070.622335903,true,1275.0,1275,0.875,4519.875952641828,5165.572517304946,645.6965646631179,0.0,0.0,1275,30021.99772761489,0.0,4519.875952641828,4519.875952641828,2623008.7628415693,700.0,892500.0,464.4664631892949,1253610.3901355348,2891.7671035767644,80976.05116683507,0.0,0.0,1109.3638435087248,1286902.3989913082,54.27854236704434,1519.9225478907422,-4519.875952641828,-5067139.786670229,true,true,9.924449014,11413.965756126954,0.0,1644.2724500334996,1275.0,9.924449014,11413.965756126954,0.0,121.92,0.0 -1276,27615.572517304947,26915.572517304947,0.29250000000000004,8795.33494910062,5799812.234000796,700.0,893200.0,32462.68358666878,25314550.20497411,23667.34863756816,19514737.970973473,true,1276.0,1276,0.875,7695.918080463041,8795.33494910062,1099.4168686375779,0.0,0.0,1276,26915.572517304947,0.0,7695.918080463041,7695.918080463041,2630704.6809220323,700.0,893200.0,503.5140996906904,1254113.9042352254,5941.267025747592,86917.31819258266,0.0,0.0,1139.6192212584083,1288042.0182125666,111.51773376635083,1631.440281657093,-7695.918080463041,-5074835.7047506925,true,true,10.28208682,11424.247842946954,0.0,1644.2724500334996,1276.0,10.28208682,11424.247842946954,0.0,121.92,0.0 -1277,31245.33494910062,30545.33494910062,0.28,7322.145479677999,5807134.379480475,700.0,893900.0,28650.519570278564,25343200.72454439,21328.374090600566,19536066.345064074,true,1277.0,1277,0.875,6406.877294718249,7322.145479677999,915.2681849597502,0.0,0.0,1277,30545.33494910062,0.0,6406.877294718249,6406.877294718249,2637111.5582167506,700.0,893900.0,551.7649157333773,1254665.6691509588,4593.9663514306985,91511.28454401337,0.0,0.0,1174.917161844176,1289216.9353744108,86.22886570999675,1717.6691473670899,-6406.877294718249,-5081242.582045411,true,true,10.55031517,11434.798158116953,0.0,1644.2724500334996,1277.0,10.55031517,11434.798158116953,0.0,121.92,0.0 -1278,29772.145479677998,29072.145479677998,0.265,6613.30944273073,5813747.688923205,700.0,894600.0,27597.394123512186,25370798.118667904,20984.084680781456,19557050.429744855,true,1278.0,1278,0.875,5786.645762389388,6613.30944273073,826.6636803413412,0.0,0.0,1278,29072.145479677998,0.0,5786.645762389388,5786.645762389388,2642898.20397914,700.0,894600.0,591.7679888796802,1255257.4371398385,3918.672925181243,95429.9574691946,0.0,0.0,1202.6512574708356,1290419.5866318818,73.55359085763014,1791.22273822472,-5786.645762389388,-5087029.2278078,true,true,10.77383879,11445.571996906954,0.0,1644.2724500334996,1278.0,10.77383879,11445.571996906954,0.0,121.92,0.0 -1279,29063.30944273073,28363.30944273073,0.25,5834.610917173108,5819582.299840379,700.0,895300.0,26138.44366869243,25396936.562336598,20303.832751519323,19577354.262496375,true,1279.0,1279,0.875,5105.284552526469,5834.610917173108,729.3263646466385,0.0,0.0,1279,28363.30944273073,0.0,5105.284552526469,5105.284552526469,2648003.488531667,700.0,895300.0,625.9002709116223,1255883.33741075,3194.088370578286,98624.0458397729,0.0,0.0,1225.3427907689988,1291644.9294226507,59.953120267562525,1851.1758584922825,-5105.284552526469,-5092134.512360327,true,true,10.9526577,11456.524654606954,0.0,1644.2724500334996,1279.0,10.9526577,11456.524654606954,0.0,121.92,0.0 -1280,28284.610917173108,27584.610917173108,0.1744,2145.040070350624,5821727.339910729,700.0,896000.0,16313.303155680183,25413249.865492277,14168.26308532956,19591522.525581703,true,1280.0,1280,0.875,1876.9100615567959,2145.040070350624,268.130008793828,0.0,0.0,1280,27584.610917173108,0.0,1876.9100615567959,1876.9100615567959,2649880.3985932237,700.0,896000.0,641.4821444388471,1256524.819555189,0.0,98624.0458397729,0.0,0.0,1235.427917117949,1292880.3573397687,0.0,1851.1758584922825,-1876.9100615567959,-5094011.422421884,true,true,10.9526577,11467.477312306954,0.0,1644.2724500334996,1280.0,10.9526577,11467.477312306954,0.0,121.92,0.0 -1281,24595.040070350624,23895.040070350624,0.12,0.0,5821727.339910729,700.0,896700.0,5833.333333333334,25419083.19882561,5833.333333333334,19597355.858915035,true,1281.0,1281,0.875,0.0,0.0,0.0,0.0,0.0,1281,23895.040070350624,0.0,-2214.3161367117764,-2214.3161367117764,2647666.082456512,700.0,896700.0,622.0446337520815,1257146.864188941,-3984.395082637499,94639.6507571354,0.0,0.0,1222.8215096047506,1294103.1788493735,-74.78719743110983,1776.3886610611726,-0.0,-5094011.422421884,true,true,10.72913407,11478.206446376953,0.0,1644.2724500334996,1281.0,10.72913407,11478.206446376953,0.0,121.92,0.0 -1282,22450.0,21750.0,0.12,0.0,5821727.339910729,700.0,897400.0,5833.333333333334,25424916.53215894,5833.333333333334,19603189.192248367,true,1282.0,1282,0.875,0.0,0.0,0.0,0.0,0.0,1282,21750.0,0.0,-2193.5235712144777,-2193.5235712144777,2645472.5588852973,700.0,897400.0,584.3555329619527,1257731.2197219029,-3902.2426054185994,90737.40815171681,0.0,0.0,1197.6086945783534,1295300.7875439518,-73.24519333618417,1703.1434677249883,-0.0,-5094011.422421884,true,true,10.50561044,11488.712056816952,0.0,1644.2724500334996,1282.0,10.50561044,11488.712056816952,0.0,121.92,0.0 -1283,22450.0,21750.0,0.17200000000000001,2001.2549156125392,5823728.594826342,700.0,898100.0,15704.970439607785,25440621.50259855,13703.715523995246,19616892.907772362,true,1283.0,1283,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1283,21750.0,0.0,1751.0980511609719,1751.0980511609719,2647223.6569364583,700.0,898100.0,566.0957640958169,1258297.3154859988,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1296485.789831017,0.0,1703.1434677249883,-1751.0980511609719,-5095762.520473044,true,true,10.50561044,11499.217667256951,0.0,1644.2724500334996,1283.0,10.50561044,11499.217667256951,0.0,121.92,0.0 -1284,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5825729.849741954,700.0,898800.0,15704.970439607785,25456326.47303816,13703.715523995246,19630596.623296358,true,1284.0,1284,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1284,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2648974.7549876194,700.0,898800.0,566.0957640958169,1258863.4112500947,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1297670.792118082,0.0,1703.1434677249883,-1751.0980511609719,-5097513.618524205,true,true,10.50561044,11509.72327769695,0.0,1644.2724500334996,1284.0,10.50561044,11509.72327769695,0.0,121.92,0.0 -1285,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5827731.104657567,700.0,899500.0,15704.970439607785,25472031.44347777,13703.715523995246,19644300.338820353,true,1285.0,1285,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1285,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2650725.8530387804,700.0,899500.0,566.0957640958169,1259429.5070141905,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1298855.7944051472,0.0,1703.1434677249883,-1751.0980511609719,-5099264.7165753655,true,true,10.50561044,11520.22888813695,0.0,1644.2724500334996,1285.0,10.50561044,11520.22888813695,0.0,121.92,0.0 -1286,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5829732.35957318,700.0,900200.0,15704.970439607785,25487736.413917378,13703.715523995246,19658004.05434435,true,1286.0,1286,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1286,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2652476.9510899414,700.0,900200.0,566.0957640958169,1259995.6027782864,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1300040.7966922123,0.0,1703.1434677249883,-1751.0980511609719,-5101015.814626526,true,true,10.50561044,11530.734498576949,0.0,1644.2724500334996,1286.0,10.50561044,11530.734498576949,0.0,121.92,0.0 -1287,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5831733.614488793,700.0,900900.0,15704.970439607785,25503441.384356987,13703.715523995246,19671707.769868344,true,1287.0,1287,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1287,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2654228.0491411025,700.0,900900.0,566.0957640958169,1260561.6985423823,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1301225.7989792775,0.0,1703.1434677249883,-1751.0980511609719,-5102766.912677687,true,true,10.50561044,11541.240109016948,0.0,1644.2724500334996,1287.0,10.50561044,11541.240109016948,0.0,121.92,0.0 -1288,24451.25491561254,23751.25491561254,0.265,6579.945172908674,5838313.559661701,700.0,901600.0,27471.491218523297,25530912.87557551,20891.546045614625,19692599.31591396,true,1288.0,1288,0.875,5757.45202629509,6579.945172908674,822.493146613584,0.0,0.0,1288,23751.25491561254,0.0,5757.45202629509,5757.45202629509,2659985.5011673975,700.0,901600.0,584.3555329619527,1261146.0540753442,3902.2426054185994,94639.6507571354,0.0,0.0,1197.6086945783534,1302423.4076738558,73.24519333618417,1776.3886610611726,-5757.45202629509,-5108524.364703982,true,true,10.72913407,11551.969243086947,0.0,1644.2724500334996,1288.0,10.72913407,11551.969243086947,0.0,121.92,0.0 -1289,29029.945172908672,28329.945172908672,0.1912,2999.6086809773187,5841313.168342679,700.0,902300.0,19349.417787538277,25550262.293363046,16349.809106560959,19708949.125020523,true,1289.0,1289,0.875,2624.657595855154,2999.6086809773187,374.95108512216484,0.0,0.0,1289,28329.945172908672,0.0,2624.657595855154,2624.657595855154,2662610.1587632527,700.0,902300.0,606.7804233765929,1261752.834498721,790.306712059213,95429.95746919462,0.0,0.0,1212.7363832558005,1303636.1440571116,14.834077163547308,1791.22273822472,-2624.657595855154,-5111149.022299837,true,true,10.77383879,11562.743081876948,0.0,1644.2724500334996,1289.0,10.77383879,11562.743081876948,0.0,121.92,0.0 -1290,25449.60868097732,24749.60868097732,0.25,5834.610917173108,5847147.779259852,700.0,903000.0,26138.44366869243,25576400.73703174,20303.832751519323,19729252.957772043,true,1290.0,1290,0.875,5105.284552526469,5834.610917173108,729.3263646466385,0.0,0.0,1290,24749.60868097732,0.0,5105.284552526469,5105.284552526469,2667715.4433157793,700.0,903000.0,625.9002709116223,1262378.7347696326,3194.088370578286,98624.04583977291,0.0,0.0,1225.3427907689988,1304861.4868478805,59.953120267562525,1851.1758584922825,-5105.284552526469,-5116254.306852364,true,true,10.9526577,11573.695739576948,0.0,1644.2724500334996,1290.0,10.9526577,11573.695739576948,0.0,121.92,0.0 -1291,28284.610917173108,27584.610917173108,0.20800000000000002,4042.225076533021,5851190.004336385,700.0,903700.0,22799.159021793366,25599199.896053534,18756.933945260345,19748009.891717304,true,1291.0,1291,0.875,3536.9469419663933,4042.225076533021,505.2781345666276,0.0,0.0,1291,27584.610917173108,0.0,3536.9469419663933,3536.9469419663933,2671252.3902577455,700.0,903700.0,649.3691321545542,1263028.1039017872,1616.7606903639685,100240.80653013688,0.0,0.0,1240.4704800104312,1306101.957327891,30.346639437439478,1881.522497929722,-3536.9469419663933,-5119791.25379433,true,true,11.04206715,11584.737806726947,0.0,1644.2724500334996,1291.0,11.04206715,11584.737806726947,0.0,121.92,0.0 -1292,26492.22507653302,25792.22507653302,0.22,5049.388550174555,5856239.3928865595,700.0,904400.0,26133.584318975252,25625333.48037251,21084.195768800695,19769094.087486103,true,1292.0,1292,0.875,4418.214981402736,5049.388550174555,631.1735687718192,0.0,0.0,1292,25792.22507653302,0.0,4418.214981402736,4418.214981402736,2675670.6052391483,700.0,904400.0,669.368850078189,1263697.4727518654,2449.7866857256167,102690.5932158625,0.0,0.0,1253.0768869596443,1307355.0342148505,45.98255863928627,1927.5050565690083,-4418.214981402736,-5124209.468775732,true,true,11.17618132,11595.913988046947,0.0,1644.2724500334996,1292.0,11.17618132,11595.913988046947,0.0,121.92,0.0 -1293,27499.388550174554,26799.388550174554,0.25,6106.673689892849,5862346.066576452,700.0,905100.0,27226.694759571397,25652560.17513208,21120.021069678547,19790214.108555783,true,1293.0,1293,0.875,5343.339478656243,6106.673689892849,763.3342112366063,0.0,0.0,1293,26799.388550174554,0.0,5343.339478656243,5343.339478656243,2681013.9447178044,700.0,905100.0,698.0522652830352,1264395.5250171483,3312.3877538596817,106002.98096972218,0.0,0.0,1270.7258568013397,1308625.7600716518,62.173602712186515,1989.6786592811948,-5343.339478656243,-5129552.808254389,true,true,11.35500022,11607.268988266947,0.0,1644.2724500334996,1293.0,11.35500022,11607.268988266947,0.0,121.92,0.0 -1294,28556.67368989285,27856.67368989285,0.20800000000000002,4247.430365968618,5866593.4969424205,700.0,905800.0,23785.722913310663,25676345.89804539,19538.292547342044,19809752.401103124,true,1294.0,1294,0.875,3716.5015702225414,4247.430365968618,530.928795746077,0.0,0.0,1294,27856.67368989285,0.0,3716.5015702225414,3716.5015702225414,2684730.446288027,700.0,905800.0,723.2806718411389,1265118.8056889896,1675.9104705802972,107678.89144030248,0.0,0.0,1285.8535454787868,1309911.6136171306,31.456882322318386,2021.135541603513,-3716.5015702225414,-5133269.309824612,true,true,11.44440967,11618.713397936948,0.0,1644.2724500334996,1294.0,11.44440967,11618.713397936948,0.0,121.92,0.0 -1295,26697.43036596862,25997.43036596862,0.196,3300.848581137842,5869894.345523559,700.0,906500.0,20412.492760907357,25696758.3908063,17111.644179769515,19826864.045282893,true,1295.0,1295,0.875,2888.2425084956117,3300.848581137842,412.6060726422302,0.0,0.0,1295,25997.43036596862,0.0,2888.2425084956117,2888.2425084956117,2687618.6887965226,700.0,906500.0,736.1196770615325,1265854.925366051,842.8844781589164,108521.7759184614,0.0,0.0,1293.417390099503,1311205.03100723,15.820963175659735,2036.9565047791727,-2888.2425084956117,-5136157.552333107,true,true,11.4891144,11630.202512336948,0.0,1644.2724500334996,1295.0,11.4891144,11630.202512336948,0.0,121.92,0.0 -1296,25750.84858113784,25050.84858113784,0.23500000000000001,5317.918614905628,5875212.264138464,700.0,907200.0,25608.16431874735,25722366.555125047,20290.24570384172,19847154.290986735,true,1296.0,1296,0.875,4653.1787880424245,5317.918614905628,664.7398268632032,0.0,0.0,1296,25050.84858113784,0.0,4653.1787880424245,4653.1787880424245,2692271.867584565,700.0,907200.0,753.4734631851496,1266608.3988292362,2548.369841420113,111070.1457598815,0.0,0.0,1303.5025164484532,1312508.5335236785,47.832966988708876,2084.7894717678814,-4653.1787880424245,-5140810.73112115,true,true,11.62322858,11641.825740916947,0.0,1644.2724500334996,1296.0,11.62322858,11641.825740916947,0.0,121.92,0.0 -1297,27767.918614905626,27067.918614905626,0.20800000000000002,4387.652715316127,5879599.91685378,700.0,907900.0,24459.868823635225,25746826.423948683,20072.2161083191,19867226.507095054,true,1297.0,1297,0.875,3839.1961259016107,4387.652715316127,548.4565894145162,0.0,0.0,1297,27067.918614905626,0.0,3839.1961259016107,3839.1961259016107,2696111.063710467,700.0,907900.0,775.54649830621,1267383.9453275423,1715.3436593513845,112785.4894192329,0.0,0.0,1316.1089239616515,1313824.6424476402,32.1970442823642,2116.9865160502454,-3839.1961259016107,-5144649.927247051,true,true,11.71263803,11653.538378946947,0.0,1644.2724500334996,1297.0,11.71263803,11653.538378946947,0.0,121.92,0.0 -1298,26837.652715316126,26137.652715316126,0.30500000000000005,10612.997906508213,5890212.914760288,700.0,908600.0,37091.79641478102,25783918.220363464,26478.798508272805,19893705.305603325,true,1298.0,1298,0.875,9286.373168194687,10612.997906508213,1326.624738313527,0.0,0.0,1298,26137.652715316126,0.0,9286.373168194687,9286.373168194687,2705397.4368786616,700.0,908600.0,820.9774511244888,1268204.9227786667,6992.818595075178,119778.30801430807,0.0,0.0,1341.3217384240631,1315165.9641860642,131.25538357095704,2248.2418996212023,-9286.373168194687,-5153936.300415246,true,true,12.07027583,11665.608654776946,0.0,1644.2724500334996,1298.0,12.07027583,11665.608654776946,0.0,121.92,0.0 -1299,33062.997906508215,32362.997906508215,0.30500000000000005,10991.19403926532,5901204.1087995535,700.0,909300.0,38331.78373529612,25822250.00409876,27340.589696030802,19921045.895299356,true,1299.0,1299,0.875,9617.294784357155,10991.19403926532,1373.899254908165,0.0,0.0,1299,32362.997906508215,0.0,9617.294784357155,9617.294784357155,2715014.731663019,700.0,909300.0,897.3007015690653,1269102.2234802358,7203.128927346806,126981.43694165489,0.0,0.0,1381.6622415639217,1316547.626427628,135.20291387736114,2383.4448134985632,-9617.294784357155,-5163553.595199603,true,true,12.42791363,11678.036568406946,0.0,1644.2724500334996,1299.0,12.42791363,11678.036568406946,0.0,121.92,0.0 -1300,33441.19403926532,32741.19403926532,0.28625,8082.726632804736,5909286.835432358,700.0,910000.0,30682.014437745805,25852932.018536508,22599.28780494107,19943645.1831043,true,1300.0,1300,0.875,7072.385803704145,8082.726632804736,1010.3408291005917,0.0,0.0,1300,32741.19403926532,0.0,7072.385803704145,7072.385803704145,2722087.117466723,700.0,910000.0,962.6865754872817,1270064.910055723,4608.753899210433,131590.1908408653,0.0,0.0,1414.4389006470494,1317962.065328275,86.50642835938032,2469.9512418579434,-7072.385803704145,-5170625.981003307,true,true,12.65143726,11690.688005666945,0.0,1644.2724500334996,1300.0,12.65143726,11690.688005666945,0.0,121.92,0.0 -1301,30532.726632804737,29832.726632804737,0.30500000000000005,10496.52492173897,5919783.360354097,700.0,910700.0,36709.91777619334,25889641.9363127,26213.392854454367,19969858.575958755,true,1301.0,1301,0.875,9184.4593065216,10496.52492173897,1312.0656152173706,0.0,0.0,1301,29832.726632804737,0.0,9184.4593065216,9184.4593065216,2731271.576773245,700.0,910700.0,1025.7941019195234,1271090.7041576426,6590.271364818964,138180.46220568428,0.0,0.0,1444.6942780019433,1319406.759606277,123.6995617811686,2593.650803639112,-9184.4593065216,-5179810.440309828,true,true,12.96437033,11703.652375996946,0.0,1644.2724500334996,1301.0,12.96437033,11703.652375996946,0.0,121.92,0.0 -1302,32946.52492173897,32246.524921738972,0.20800000000000002,4007.7216323819034,5923791.0819864785,700.0,911400.0,22633.277078759147,25912275.21339146,18625.555446377242,19988484.131405134,true,1302.0,1302,0.875,3506.7564283341653,4007.7216323819034,500.9652040477381,0.0,0.0,1302,32246.524921738972,0.0,3506.7564283341653,3506.7564283341653,2734778.3332015793,700.0,911400.0,1069.361954453522,1272160.0661120962,954.6118554094829,139135.07406109376,0.0,0.0,1464.8645295718727,1320871.624135849,17.918088899287984,2611.5688925383997,-3506.7564283341653,-5183317.196738162,true,true,13.00907506,11716.661451056945,0.0,1644.2724500334996,1302.0,13.00907506,11716.661451056945,0.0,121.92,0.0 -1303,26457.7216323819,25757.7216323819,0.1696,1784.796045390427,5925575.878031869,700.0,912100.0,14650.92007895299,25926926.133470412,12866.124033562563,20001350.255438697,true,1303.0,1303,0.875,1561.6965397166236,1784.796045390427,223.09950567380338,0.0,0.0,1303,25757.7216323819,0.0,1561.6965397166236,1561.6965397166236,2736340.029741296,700.0,912100.0,1069.361954453522,1273229.4280665498,-954.6118554094829,138180.46220568428,0.0,0.0,1464.8645295718727,1322336.488665421,-17.918088899287984,2593.650803639112,-1561.6965397166236,-5184878.893277879,true,true,12.96437033,11729.625821386946,0.0,1644.2724500334996,1303.0,12.96437033,11729.625821386946,0.0,121.92,0.0 -1304,24234.796045390427,23534.796045390427,0.12,0.0,5925575.878031869,700.0,912800.0,5833.333333333334,25932759.466803744,5833.333333333334,20007183.58877203,true,1304.0,1304,0.875,0.0,0.0,0.0,0.0,0.0,1304,23534.796045390427,0.0,-7094.273708734388,-7094.273708734388,2729245.756032562,700.0,912800.0,1009.7663607204914,1274239.1944272702,-9365.382042775273,128815.080162909,0.0,0.0,1437.130433381227,1323773.6190988023,-175.78846006083322,2417.862343578279,-0.0,-5184878.893277879,true,true,12.51732308,11742.143144466945,0.0,1644.2724500334996,1304.0,12.51732308,11742.143144466945,0.0,121.92,0.0 -1305,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,913500.0,5833.333333333334,25938592.800137077,5833.333333333334,20013016.92210536,true,1305.0,1305,0.875,0.0,0.0,0.0,0.0,0.0,1305,21750.0,0.0,-26983.851683688637,-26983.851683688637,2702261.904348873,700.0,913500.0,798.0464638211758,1275037.2408910913,-28574.273632772118,100240.80653013688,0.0,0.0,1328.7153309108646,1325102.3344297132,-536.3398456485579,1881.5224979297209,-0.0,-5184878.893277879,true,true,11.04206715,11753.185211616945,0.0,1644.2724500334996,1305.0,11.04206715,11753.185211616945,0.0,121.92,0.0 -1306,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,914200.0,5833.333333333334,25944426.13347041,5833.333333333334,20018850.255438693,true,1306.0,1306,0.875,0.0,0.0,0.0,0.0,0.0,1306,21750.0,0.0,-23768.377258577224,-23768.377258577224,2678493.5270902957,700.0,914200.0,534.1941259638097,1275571.4350170551,-24995.71198679938,75245.0945433375,0.0,0.0,1162.3107544437744,1326264.645184157,-469.1701521854303,1412.3523457442907,-0.0,-5184878.893277879,true,true,9.566811212,11762.752022828945,0.0,1644.2724500334996,1306.0,9.566811212,11762.752022828945,0.0,121.92,0.0 -1307,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,914900.0,5833.333333333334,25950259.46680374,5833.333333333334,20024683.588772025,true,1307.0,1307,0.875,0.0,0.0,0.0,0.0,0.0,1307,21750.0,0.0,-20487.20701125712,-20487.20701125712,2658006.3200790384,700.0,914900.0,336.03740218812305,1275907.4724192433,-21417.1501362574,53827.9444070801,0.0,0.0,995.9061776946913,1327260.5513618516,-402.0004548825308,1010.3518908617599,-0.0,-5184878.893277879,true,true,8.091555277,11770.843578105945,0.0,1644.2724500334996,1307.0,8.091555277,11770.843578105945,0.0,121.92,0.0 -1308,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,915600.0,5833.333333333334,25956092.800137073,5833.333333333334,20030516.922105357,true,1308.0,1308,0.875,0.0,0.0,0.0,0.0,0.0,1308,21750.0,0.0,-17149.746639288245,-17149.746639288245,2640856.5734397504,700.0,915600.0,194.1708472432873,1276101.6432664867,-17838.588329304926,35989.35607777517,0.0,0.0,829.5016011712027,1328090.0529630228,-334.8307583978083,675.5211324639515,-0.0,-5184878.893277879,true,true,6.616299343,11777.459877448946,0.0,1644.2724500334996,1308.0,6.616299343,11777.459877448946,0.0,121.92,0.0 -1309,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,916300.0,5833.333333333334,25961926.133470405,5833.333333333334,20036350.25543869,true,1309.0,1309,0.875,0.0,0.0,0.0,0.0,0.0,1309,21750.0,0.0,-13765.401569316318,-13765.401569316318,2627091.171870434,700.0,916300.0,99.18901493915054,1276200.8322814258,-14260.026546536168,21729.329531239004,0.0,0.0,663.0970246477139,1328753.1499876706,-267.6610623670144,407.86007009693714,-0.0,-5184878.893277879,true,true,5.141043408,11782.600920856947,0.0,1644.2724500334996,1309.0,5.141043408,11782.600920856947,0.0,121.92,0.0 -1310,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,917000.0,5833.333333333334,25967759.466803737,5833.333333333334,20042183.58877202,true,1310.0,1310,0.875,0.0,0.0,0.0,0.0,0.0,1310,21750.0,0.0,-10343.577202887654,-10343.577202887654,2616747.5946675465,700.0,917000.0,41.68645939660767,1276242.5187408223,-10681.464744435134,11047.86478680387,0.0,0.0,496.69244812422517,1329249.8424357949,-200.4913659733535,207.36870412358363,-0.0,-5184878.893277879,true,true,3.665787474,11786.266708330946,0.0,1644.2724500334996,1310.0,3.665787474,11786.266708330946,0.0,121.92,0.0 -1311,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,917700.0,5833.333333333334,25973592.80013707,5833.333333333334,20048016.922105353,true,1311.0,1311,0.875,0.0,0.0,0.0,0.0,0.0,1311,21750.0,0.0,-6893.6790203291375,-6893.6790203291375,2609853.9156472175,700.0,917700.0,12.257734736553637,1276254.776475559,-7102.90295681493,3944.96182998894,0.0,0.0,330.2878716007364,1329580.1303073957,-133.32166985149806,74.04703427208557,-0.0,-5184878.893277879,true,true,2.190531539,11788.457239869946,0.0,1644.2724500334996,1311.0,2.190531539,11788.457239869946,0.0,121.92,0.0 -1312,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,918400.0,5833.333333333334,25979426.1334704,5833.333333333334,20053850.255438685,true,1312.0,1312,0.875,0.0,0.0,0.0,0.0,0.0,1312,21750.0,0.0,-3425.112442957111,-3425.112442957111,2606428.8032042603,700.0,918400.0,1.4973950798833802,1276256.2738706388,-3524.3411595653433,420.6206704235965,0.0,0.0,163.88329507724762,1329744.0136024728,-66.15197354889884,7.895060723186731,-0.0,-5184878.893277879,true,true,0.715275605,11789.172515474946,0.0,1644.2724500334996,1312.0,0.715275605,11789.172515474946,0.0,121.92,0.0 -1313,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,919100.0,5833.333333333334,25985259.466803733,5833.333333333334,20059683.588772018,true,1313.0,1313,0.875,0.0,0.0,0.0,0.0,0.0,1313,21750.0,0.0,-388.15289425123626,-388.15289425123626,2606040.6503100093,700.0,919100.0,0.022333473848022808,1276256.2962041127,-420.62067042374963,-1.531361704110168e-10,0.0,0.0,40.340503421851245,1329784.3541058947,-7.895060723185952,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1313.0,0.0,11789.172515474946,0.0,121.92,0.0 -1314,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,919800.0,5833.333333333334,25991092.800137065,5833.333333333334,20065516.92210535,true,1314.0,1314,0.875,0.0,0.0,0.0,0.0,0.0,1314,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,919800.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1314.0,0.0,11789.172515474946,0.0,121.92,0.0 -1315,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,920500.0,5833.333333333334,25996926.133470397,5833.333333333334,20071350.25543868,true,1315.0,1315,0.875,0.0,0.0,0.0,0.0,0.0,1315,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,920500.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1315.0,0.0,11789.172515474946,0.0,121.92,0.0 -1316,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,921200.0,5833.333333333334,26002759.46680373,5833.333333333334,20077183.588772014,true,1316.0,1316,0.875,0.0,0.0,0.0,0.0,0.0,1316,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,921200.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1316.0,0.0,11789.172515474946,0.0,121.92,0.0 -1317,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,921900.0,5833.333333333334,26008592.80013706,5833.333333333334,20083016.922105346,true,1317.0,1317,0.875,0.0,0.0,0.0,0.0,0.0,1317,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,921900.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1317.0,0.0,11789.172515474946,0.0,121.92,0.0 -1318,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,922600.0,5833.333333333334,26014426.133470394,5833.333333333334,20088850.255438678,true,1318.0,1318,0.875,0.0,0.0,0.0,0.0,0.0,1318,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,922600.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1318.0,0.0,11789.172515474946,0.0,121.92,0.0 -1319,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,923300.0,5833.333333333334,26020259.466803726,5833.333333333334,20094683.58877201,true,1319.0,1319,0.875,0.0,0.0,0.0,0.0,0.0,1319,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,923300.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1319.0,0.0,11789.172515474946,0.0,121.92,0.0 -1320,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,924000.0,5833.333333333334,26026092.800137058,5833.333333333334,20100516.922105342,true,1320.0,1320,0.875,0.0,0.0,0.0,0.0,0.0,1320,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,924000.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1320.0,0.0,11789.172515474946,0.0,121.92,0.0 -1321,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,924700.0,5833.333333333334,26031926.13347039,5833.333333333334,20106350.255438674,true,1321.0,1321,0.875,0.0,0.0,0.0,0.0,0.0,1321,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,924700.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1321.0,0.0,11789.172515474946,0.0,121.92,0.0 -1322,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,925400.0,5833.333333333334,26037759.466803722,5833.333333333334,20112183.588772006,true,1322.0,1322,0.875,0.0,0.0,0.0,0.0,0.0,1322,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,925400.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1322.0,0.0,11789.172515474946,0.0,121.92,0.0 -1323,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,926100.0,5833.333333333334,26043592.800137054,5833.333333333334,20118016.92210534,true,1323.0,1323,0.875,0.0,0.0,0.0,0.0,0.0,1323,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,926100.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1323.0,0.0,11789.172515474946,0.0,121.92,0.0 -1324,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,926800.0,5833.333333333334,26049426.133470386,5833.333333333334,20123850.25543867,true,1324.0,1324,0.875,0.0,0.0,0.0,0.0,0.0,1324,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,926800.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1324.0,0.0,11789.172515474946,0.0,121.92,0.0 -1325,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,927500.0,5833.333333333334,26055259.46680372,5833.333333333334,20129683.588772003,true,1325.0,1325,0.875,0.0,0.0,0.0,0.0,0.0,1325,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,927500.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1325.0,0.0,11789.172515474946,0.0,121.92,0.0 -1326,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,928200.0,5833.333333333334,26061092.80013705,5833.333333333334,20135516.922105335,true,1326.0,1326,0.875,0.0,0.0,0.0,0.0,0.0,1326,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,928200.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1326.0,0.0,11789.172515474946,0.0,121.92,0.0 -1327,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,928900.0,5833.333333333334,26066926.133470383,5833.333333333334,20141350.255438667,true,1327.0,1327,0.875,0.0,0.0,0.0,0.0,0.0,1327,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,928900.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1327.0,0.0,11789.172515474946,0.0,121.92,0.0 -1328,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,929600.0,5833.333333333334,26072759.466803715,5833.333333333334,20147183.588772,true,1328.0,1328,0.875,0.0,0.0,0.0,0.0,0.0,1328,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,929600.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1328.0,0.0,11789.172515474946,0.0,121.92,0.0 -1329,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,930300.0,5833.333333333334,26078592.800137047,5833.333333333334,20153016.92210533,true,1329.0,1329,0.875,0.0,0.0,0.0,0.0,0.0,1329,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,930300.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1329.0,0.0,11789.172515474946,0.0,121.92,0.0 -1330,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,931000.0,5833.333333333334,26084426.13347038,5833.333333333334,20158850.255438663,true,1330.0,1330,0.875,0.0,0.0,0.0,0.0,0.0,1330,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,931000.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1330.0,0.0,11789.172515474946,0.0,121.92,0.0 -1331,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,931700.0,5833.333333333334,26090259.46680371,5833.333333333334,20164683.588771995,true,1331.0,1331,0.875,0.0,0.0,0.0,0.0,0.0,1331,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,931700.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1331.0,0.0,11789.172515474946,0.0,121.92,0.0 -1332,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,932400.0,5833.333333333334,26096092.800137043,5833.333333333334,20170516.922105327,true,1332.0,1332,0.875,0.0,0.0,0.0,0.0,0.0,1332,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,932400.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1332.0,0.0,11789.172515474946,0.0,121.92,0.0 -1333,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,933100.0,5833.333333333334,26101926.133470375,5833.333333333334,20176350.25543866,true,1333.0,1333,0.875,0.0,0.0,0.0,0.0,0.0,1333,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,933100.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1333.0,0.0,11789.172515474946,0.0,121.92,0.0 -1334,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,933800.0,5833.333333333334,26107759.466803707,5833.333333333334,20182183.58877199,true,1334.0,1334,0.875,0.0,0.0,0.0,0.0,0.0,1334,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,933800.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1334.0,0.0,11789.172515474946,0.0,121.92,0.0 -1335,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,934500.0,5833.333333333334,26113592.80013704,5833.333333333334,20188016.922105324,true,1335.0,1335,0.875,0.0,0.0,0.0,0.0,0.0,1335,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,934500.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1335.0,0.0,11789.172515474946,0.0,121.92,0.0 -1336,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,935200.0,5833.333333333334,26119426.13347037,5833.333333333334,20193850.255438656,true,1336.0,1336,0.875,0.0,0.0,0.0,0.0,0.0,1336,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,935200.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1336.0,0.0,11789.172515474946,0.0,121.92,0.0 -1337,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,935900.0,5833.333333333334,26125259.466803703,5833.333333333334,20199683.588771988,true,1337.0,1337,0.875,0.0,0.0,0.0,0.0,0.0,1337,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,935900.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,1644.2724500334996,1337.0,0.0,11789.172515474946,0.0,121.92,0.0 -1338,22450.0,21750.0,0.132,473.6717459321594,5926049.549777801,700.0,936600.0,8891.452620698177,26134150.919424403,8417.780874766018,20208101.369646754,true,1338.0,1338,0.875,414.4627776906395,473.6717459321594,59.208968241519926,0.0,0.0,1338,21750.0,0.0,414.4627776906395,414.4627776906395,2606455.1130876997,700.0,936600.0,0.01840221533331099,1276256.314606328,369.68613535658534,369.6861353564322,0.0,0.0,37.81922191921155,1329822.1733278139,6.9390181995092535,6.939018199510032,-414.4627776906395,-5185293.35605557,true,true,0.670570879,11789.843086353945,0.0,1644.2724500334996,1338.0,0.670570879,11789.843086353945,0.0,121.92,0.0 -1339,22923.67174593216,22223.67174593216,0.20800000000000002,4160.252044150284,5930209.801821952,700.0,937300.0,23366.596366107133,26157517.51579051,19206.34432195685,20227307.71396871,true,1339.0,1339,0.875,3640.220538631498,4160.252044150284,520.0315055187857,0.0,0.0,1339,22223.67174593216,0.0,3640.220538631498,3640.220538631498,2610095.3336263313,700.0,937300.0,1.3633833313570598,1276257.6779896594,3415.8998949288366,3785.586030285269,0.0,0.0,158.84073212836674,1329981.0140599422,64.11652824293756,71.05554644244759,-3640.220538631498,-5188933.576594201,true,true,2.145826814,11791.988913167945,0.0,1644.2724500334996,1339.0,2.145826814,11791.988913167945,0.0,121.92,0.0 -1340,26610.252044150286,25910.252044150286,0.29250000000000004,8528.797780118522,5938738.599602071,700.0,938000.0,31551.4454021146,26189068.961192627,23022.64762199608,20250330.361590706,true,1340.0,1340,0.875,7462.698057603708,8528.797780118522,1066.0997225148149,0.0,0.0,1340,25910.252044150286,0.0,7462.698057603708,7462.698057603708,2617558.031683935,700.0,938000.0,11.70483949187577,1276269.3828291513,6994.461685048273,10780.047715333541,0.0,0.0,325.24530865185557,1330306.259368594,131.28622441170364,202.34177085415124,-7462.698057603708,-5196396.274651805,true,true,3.621082748,11795.609995915946,0.0,1644.2724500334996,1340.0,3.621082748,11795.609995915946,0.0,121.92,0.0 -1341,30978.797780118522,30278.797780118522,0.33,12918.35309454493,5951656.952696616,700.0,938700.0,41267.73665013615,26230336.697842762,28349.383555591216,20278679.745146297,true,1341.0,1341,0.875,11303.558957726813,12918.35309454493,1614.7941368181164,0.0,0.0,1341,30278.797780118522,0.0,11303.558957726813,11303.558957726813,2628861.5906416615,700.0,938700.0,40.42966714293786,1276309.8124962943,10573.023484650075,21353.071199983617,0.0,0.0,491.6498851753443,1330797.9092537693,198.45592075845403,400.79769161260526,-11303.558957726813,-5207699.833609532,true,true,5.096338683,11800.706334598946,0.0,1644.2724500334996,1341.0,5.096338683,11800.706334598946,0.0,121.92,0.0 -1342,35368.35309454493,34668.35309454493,0.29250000000000004,9272.44503848686,5960929.397735103,700.0,939400.0,34093.82919140806,26264430.52703417,24821.3841529212,20303501.12929922,true,1342.0,1342,0.875,8113.389408676003,9272.44503848686,1159.0556298108568,0.0,0.0,1342,34668.35309454493,0.0,8113.389408676003,8113.389408676003,2636974.9800503375,700.0,939400.0,81.17114143074772,1276390.983637725,7275.4231491982955,28628.494349181914,0.0,0.0,620.2352397796216,1331418.144493549,136.55987826733804,537.3575698799433,-8113.389408676003,-5215813.223018208,true,true,5.901023738,11806.607358336947,0.0,1644.2724500334996,1342.0,5.901023738,11806.607358336947,0.0,121.92,0.0 -1343,31722.44503848686,31022.44503848686,0.3175,11242.981729006304,5972172.379464109,700.0,940100.0,37615.690485059225,26302046.21751923,26372.70875605292,20329873.83805527,true,1343.0,1343,0.875,9837.609012880515,11242.981729006304,1405.3727161257884,0.0,0.0,1343,31022.44503848686,0.0,9837.609012880515,9837.609012880515,2646812.589063218,700.0,940100.0,123.5821192266457,1276514.5657569517,8834.677124547265,37463.17147372918,0.0,0.0,713.5226539109284,1332131.66714746,165.82711519567806,703.1846850756214,-9837.609012880515,-5225650.832031088,true,true,6.750413519,11813.357771855946,0.0,1644.2724500334996,1343.0,6.750413519,11813.357771855946,0.0,121.92,0.0 -1344,33692.98172900631,32992.98172900631,0.3175,11495.759944753645,5983668.139408863,700.0,940800.0,38411.84234568077,26340458.059864912,26916.082400927127,20356789.920456197,true,1344.0,1344,0.875,10058.789951659439,11495.759944753645,1436.969993094206,0.0,0.0,1344,32992.98172900631,0.0,10058.789951659439,10058.789951659439,2656871.379014877,700.0,940800.0,176.9980089519999,1276691.5637659037,8910.257397267093,46373.42887099627,0.0,0.0,804.288786595994,1332935.9559340558,167.24575884435308,870.4304439199744,-10058.789951659439,-5235709.621982748,true,true,7.510393849,11820.868165704946,0.0,1644.2724500334996,1344.0,7.510393849,11820.868165704946,0.0,121.92,0.0 -1345,33945.75994475365,33245.75994475365,0.3175,11352.896240166237,5995021.03564903,700.0,941500.0,37961.87792178342,26378419.937786695,26608.981681617188,20383398.902137816,true,1345.0,1345,0.875,9933.784210145457,11352.896240166237,1419.1120300207804,0.0,0.0,1345,33245.75994475365,0.0,9933.784210145457,9933.784210145457,2666805.1632250226,700.0,941500.0,235.78581883170884,1276927.3495847355,8650.65557197501,55024.08444297128,0.0,0.0,884.9697933832979,1333820.925727439,162.37302595543886,1032.8034698754134,-9933.784210145457,-5245643.406192893,true,true,8.180964728,11829.049130432946,0.0,1644.2724500334996,1345.0,8.180964728,11829.049130432946,0.0,121.92,0.0 -1346,33802.896240166236,33102.896240166236,0.30500000000000005,10103.198044567533,6005124.233693597,700.0,942200.0,35420.32145759846,26413840.259244293,25317.123413030928,20408716.025550846,true,1346.0,1346,0.875,8840.298288996592,10103.198044567533,1262.8997555709411,0.0,0.0,1346,33102.896240166236,0.0,8840.298288996592,8840.298288996592,2675645.4615140194,700.0,942200.0,294.4907996254063,1277221.8403843609,7452.872489626751,62476.956932598034,0.0,0.0,953.0443928265989,1334773.9701202656,139.8906069178357,1172.694076793249,-8840.298288996592,-5254483.7044818895,true,true,8.717421431,11837.766551863946,0.0,1644.2724500334996,1346.0,8.717421431,11837.766551863946,0.0,121.92,0.0 -1347,32553.198044567533,31853.198044567533,0.28,7630.727636218535,6012754.961329815,700.0,942900.0,29752.59870078048,26443592.857945073,22121.871064561943,20430837.89661541,true,1347.0,1347,0.875,6676.886681691218,7630.727636218535,953.8409545273171,0.0,0.0,1347,31853.198044567533,0.0,6676.886681691218,6676.886681691218,2682322.3481957107,700.0,942900.0,343.75224881844815,1277565.5926331794,5231.469592952789,67708.42652555082,0.0,0.0,1003.4700220898135,1335777.4401423554,98.19481783016793,1270.888894623417,-6676.886681691218,-5261160.59116358,true,true,9.075059234,11846.841611097945,0.0,1644.2724500334996,1347.0,9.075059234,11846.841611097945,0.0,121.92,0.0 -1348,30080.727636218537,29380.727636218537,0.29250000000000004,9605.447828644898,6022360.40915846,700.0,943600.0,35232.30026887144,26478825.158213943,25626.852440226543,20456464.749055635,true,1348.0,1348,0.875,8404.766850064285,9605.447828644898,1200.6809785806126,0.0,0.0,1348,29380.727636218537,0.0,8404.766850064285,8404.766850064285,2690727.115045775,700.0,943600.0,392.53313578295587,1277958.1257689623,6835.085889166971,74543.5124147178,0.0,0.0,1048.8530884605457,1336826.293230816,128.2947366538116,1399.1836312772286,-8404.766850064285,-5269565.358013645,true,true,9.522106487,11856.363717584945,0.0,1644.2724500334996,1348.0,9.522106487,11856.363717584945,0.0,121.92,0.0 -1349,32055.447828644898,31355.447828644898,0.265,6705.720135264398,6029066.129293724,700.0,944300.0,27946.11371797886,26506771.271931924,21240.393582714463,20477705.142638348,true,1349.0,1349,0.875,5867.505118356348,6705.720135264398,838.2150169080496,0.0,0.0,1349,31355.447828644898,0.0,5867.505118356348,5867.505118356348,2696594.6201641317,700.0,944300.0,439.58976506777304,1278397.71553403,4258.784271942478,78802.29668666028,0.0,0.0,1089.1935918259985,1337915.486822642,79.93748952009814,1479.1211207973267,-5867.505118356348,-5275432.863132001,true,true,9.790334838,11866.154052422946,0.0,1644.2724500334996,1349.0,9.790334838,11866.154052422946,0.0,121.92,0.0 -1350,29155.720135264397,28455.720135264397,0.196,3482.117871894214,6032548.247165618,700.0,945000.0,21337.336081092926,26528108.608013015,17855.218209198712,20495560.360847548,true,1350.0,1350,0.875,3046.8531379074375,3482.117871894214,435.2647339867767,0.0,0.0,1350,28455.720135264397,0.0,3046.8531379074375,3046.8531379074375,2699641.4733020393,700.0,945000.0,464.4664631892949,1278862.1819972193,1445.883559874126,80248.18024653441,0.0,0.0,1109.3638435087248,1339024.8506661507,27.13927133529188,1506.2603921326186,-3046.8531379074375,-5278479.7162699085,true,true,9.879744289,11876.033796711947,0.0,1644.2724500334996,1350.0,9.879744289,11876.033796711947,0.0,121.92,0.0 -1351,25932.117871894214,25232.117871894214,0.20800000000000002,4385.25018300902,6036933.497348627,700.0,945700.0,24448.318187543362,26552556.926200558,20063.068004534343,20515623.42885208,true,1351.0,1351,0.875,3837.0939101328922,4385.25018300902,548.1562728761273,0.0,0.0,1351,25232.117871894214,0.0,3837.0939101328922,3837.0939101328922,2703478.5672121723,700.0,945700.0,480.48116117565974,1279342.663158395,2193.47099186525,82441.65123839966,0.0,0.0,1121.9702505707348,1340146.8209167214,41.17150652124778,1547.4318986538663,-3837.0939101328922,-5282316.810180041,true,true,10.01385846,11886.047655171948,0.0,1644.2724500334996,1351.0,10.01385846,11886.047655171948,0.0,121.92,0.0 -1352,26835.25018300902,26135.25018300902,0.12,0.0,6036933.497348627,700.0,946400.0,5833.333333333334,26558390.25953389,5833.333333333334,20521456.762185413,true,1352.0,1352,0.875,0.0,0.0,0.0,0.0,0.0,1352,26135.25018300902,0.0,-1376.1295902156437,-1376.1295902156437,2702102.4376219567,700.0,946400.0,477.2492360023803,1279819.9123943974,-2918.055813224185,79523.59542517547,0.0,0.0,1119.4489691244937,1341266.269885846,-54.77198211833273,1492.6599165355335,-0.0,-5282316.810180041,true,true,9.835039564,11895.882694735948,0.0,1644.2724500334996,1352.0,9.835039564,11895.882694735948,0.0,121.92,0.0 -1353,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,947100.0,5833.333333333334,26564223.59286722,5833.333333333334,20527290.095518745,true,1353.0,1353,0.875,0.0,0.0,0.0,0.0,0.0,1353,21750.0,0.0,-1368.0706911425218,-1368.0706911425218,2700734.366930814,700.0,947100.0,451.91400410552706,1280271.826398503,-2865.478311895824,76658.11711327964,0.0,0.0,1099.2787177237599,1342365.5486035696,-53.7851010759847,1438.8748154595487,-0.0,-5282316.810180041,true,true,9.656220663,11905.538915398949,0.0,1644.2724500334996,1353.0,9.656220663,11905.538915398949,0.0,121.92,0.0 -1354,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,947800.0,5833.333333333334,26570056.926200554,5833.333333333334,20533123.428852078,true,1354.0,1354,0.875,0.0,0.0,0.0,0.0,0.0,1354,21750.0,0.0,-2072.664851579834,-2072.664851579834,2698661.702079234,700.0,947800.0,424.50221129221734,1280696.3286097953,-3507.9106744859905,73150.20643879366,0.0,0.0,1076.587184538394,1343442.135788108,-65.84357292445459,1373.0312425350942,-0.0,-5282316.810180041,true,true,9.432697036,11914.971612434949,0.0,1644.2724500334996,1354.0,9.432697036,11914.971612434949,0.0,121.92,0.0 -1355,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,948500.0,5833.333333333334,26575890.259533886,5833.333333333334,20538956.76218541,true,1355.0,1355,0.875,0.0,0.0,0.0,0.0,0.0,1355,21750.0,0.0,-2736.642154259307,-2736.642154259307,2695925.059924975,700.0,948500.0,392.5331357196344,1281088.861745515,-4101.051536337544,69049.15490245611,0.0,0.0,1048.853088404147,1344490.988876512,-76.97684204554449,1296.0544004895496,-0.0,-5282316.810180041,true,true,9.164468684,11924.13608111895,0.0,1644.2724500334996,1355.0,9.164468684,11924.13608111895,0.0,121.92,0.0 -1356,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,949200.0,5833.333333333334,26581723.592867218,5833.333333333334,20544790.09551874,true,1356.0,1356,0.875,0.0,0.0,0.0,0.0,0.0,1356,21750.0,0.0,-2006.2965813629278,-2006.2965813629278,2693918.763343612,700.0,949200.0,362.21080494571305,1281451.0725504607,-3327.175214901444,65721.97968755466,0.0,0.0,1021.1189923262987,1345512.1078688384,-62.4511637334952,1233.6032367560545,-0.0,-5282316.810180041,true,true,8.940945058,11933.07702617695,0.0,1644.2724500334996,1356.0,8.940945058,11933.07702617695,0.0,121.92,0.0 -1357,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,949900.0,5833.333333333334,26587556.92620055,5833.333333333334,20550623.428852074,true,1357.0,1357,0.875,0.0,0.0,0.0,0.0,0.0,1357,21750.0,0.0,-1314.417570551779,-1314.417570551779,2692604.3457730603,700.0,949900.0,338.5960517051614,1281789.6686021658,-2602.590393322,63119.38929423266,0.0,0.0,998.4274591973312,1346510.5353280357,-48.85068813227151,1184.752548623783,-0.0,-5282316.810180041,true,true,8.762126157,11941.83915233395,0.0,1644.2724500334996,1357.0,8.762126157,11941.83915233395,0.0,121.92,0.0 -1358,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,950600.0,5833.333333333334,26593390.259533882,5833.333333333334,20556456.762185406,true,1358.0,1358,0.875,0.0,0.0,0.0,0.0,0.0,1358,21750.0,0.0,-5753.104680208087,-5753.104680208087,2686851.2410928523,700.0,950600.0,301.5582809080259,1282091.2268830738,-6886.020419309186,56233.36887492347,0.0,0.0,960.6082372781195,1347471.143565314,-129.25077908504696,1055.501769538736,-0.0,-5282316.810180041,true,true,8.270374179,11950.10952651295,0.0,1644.2724500334996,1358.0,8.270374179,11950.10952651295,0.0,121.92,0.0 -1359,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,951300.0,5833.333333333334,26599223.592867214,5833.333333333334,20562290.095518738,true,1359.0,1359,0.875,0.0,0.0,0.0,0.0,0.0,1359,21750.0,0.0,-4863.948912997435,-4863.948912997435,2681987.292179855,700.0,951300.0,254.39222519447864,1282345.6191082683,-5914.978173423559,50318.39070149991,0.0,0.0,907.6613265686641,1348378.8048918825,-111.02429133701906,944.4774782017168,-0.0,-5282316.810180041,true,true,7.823326926,11957.93285343895,0.0,1644.2724500334996,1359.0,7.823326926,11957.93285343895,0.0,121.92,0.0 -1360,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,952000.0,5833.333333333334,26605056.926200546,5833.333333333334,20568123.42885207,true,1360.0,1360,0.875,0.0,0.0,0.0,0.0,0.0,1360,21750.0,0.0,-4619.6834681948985,-4619.6834681948985,2677367.6087116604,700.0,952000.0,214.30538448891616,1282559.9244927573,-5586.3682748387855,44732.022426661126,0.0,0.0,857.2356973054495,1349236.040589188,-104.85627515047919,839.6212030512377,-0.0,-5282316.810180041,true,true,7.376279673,11965.30913311195,0.0,1644.2724500334996,1360.0,7.376279673,11965.30913311195,0.0,121.92,0.0 -1361,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,952700.0,5833.333333333334,26610890.25953388,5833.333333333334,20573956.762185402,true,1361.0,1361,0.875,0.0,0.0,0.0,0.0,0.0,1361,21750.0,0.0,-4370.9687766538,-4370.9687766538,2672996.6399350064,700.0,952700.0,178.66779052190432,1282738.5922832792,-5257.758376254,39474.264050407124,0.0,0.0,806.8100680422352,1350042.8506572302,-98.68825896393952,740.9329440872982,-0.0,-5282316.810180041,true,true,6.92923242,11972.23836553195,0.0,1644.2724500334996,1361.0,6.92923242,11972.23836553195,0.0,121.92,0.0 -1362,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,953400.0,5833.333333333334,26616723.59286721,5833.333333333334,20579790.095518734,true,1362.0,1362,0.875,0.0,0.0,0.0,0.0,0.0,1362,21750.0,0.0,-6523.204489258494,-6523.204489258494,2666473.435445748,700.0,953400.0,139.97883663870027,1282878.5711199178,-7270.493999389044,32203.77005101808,0.0,0.0,743.7780314914164,1350786.6286887217,-136.46735799956664,604.4655860877316,-0.0,-5282316.810180041,true,true,6.258661541,11978.49702707295,0.0,1644.2724500334996,1362.0,6.258661541,11978.49702707295,0.0,121.92,0.0 -1363,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,954100.0,5833.333333333334,26622556.926200543,5833.333333333334,20585623.428852066,true,1363.0,1363,0.875,0.0,0.0,0.0,0.0,0.0,1363,21750.0,0.0,-11838.655994498038,-11838.655994498038,2654634.7794512496,700.0,954100.0,85.19544150275728,1282963.7665614206,-12322.871194724332,19880.89885629375,0.0,0.0,630.3203656773833,1351416.949054399,-231.3006069538478,373.1649791338838,-0.0,-5282316.810180041,true,true,4.917519782,11983.41454685495,0.0,1644.2724500334996,1363.0,4.917519782,11983.41454685495,0.0,121.92,0.0 -1364,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,954800.0,5833.333333333334,26628390.259533875,5833.333333333334,20591456.7621854,true,1364.0,1364,0.875,0.0,0.0,0.0,0.0,0.0,1364,21750.0,0.0,-9024.728336725719,-9024.728336725719,2645610.051114524,700.0,954800.0,37.398754122774015,1283001.1653155433,-9365.382107461242,10515.516748832506,0.0,0.0,479.0434778877399,1351895.9925322868,-175.78846127499014,197.37651785889364,-0.0,-5282316.810180041,true,true,3.576378023,11986.990924877951,0.0,1644.2724500334996,1364.0,3.576378023,11986.990924877951,0.0,121.92,0.0 -1365,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,955500.0,5833.333333333334,26634223.592867207,5833.333333333334,20597290.09551873,true,1365.0,1365,0.875,0.0,0.0,0.0,0.0,0.0,1365,21750.0,0.0,-5841.346113767217,-5841.346113767217,2639768.705000757,700.0,955500.0,12.540594505473415,1283013.7059100487,-6072.710922259745,4442.805826572761,0.0,0.0,332.80915304697754,1352228.8016853337,-113.98493905992348,83.39157879897016,-0.0,-5282316.810180041,true,true,2.324645715,11989.315570592951,0.0,1644.2724500334996,1365.0,2.324645715,11989.315570592951,0.0,121.92,0.0 -1366,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,956200.0,5833.333333333334,26640056.92620054,5833.333333333334,20603123.428852063,true,1366.0,1366,0.875,0.0,0.0,0.0,0.0,0.0,1366,21750.0,0.0,-3283.388500095565,-3283.388500095565,2636485.3165006614,700.0,956200.0,2.489249950667005,1283016.1951599994,-3415.8998944142895,1026.9059321584718,0.0,0.0,194.13867260133713,1352422.9403579351,-64.11652823327952,19.275050565690634,-0.0,-5282316.810180041,true,true,1.117618132,11990.433188724952,0.0,1644.2724500334996,1366.0,1.117618132,11990.433188724952,0.0,121.92,0.0 -1367,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,956900.0,5833.333333333334,26645890.25953387,5833.333333333334,20608956.762185395,true,1367.0,1367,0.875,0.0,0.0,0.0,0.0,0.0,1367,21750.0,0.0,-983.0637507320638,-983.0637507320638,2635502.252749929,700.0,956900.0,0.08519544143415073,1283016.280355441,-1026.9059321586267,-1.5484147297684103e-10,0.0,0.0,63.03203655081876,1352485.972394486,-19.275050565690066,5.684341886080801e-13,-0.0,-5282316.810180041,true,true,0.0,11990.433188724952,0.0,1644.2724500334996,1367.0,0.0,11990.433188724952,0.0,121.92,0.0 -1368,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,957600.0,5833.333333333334,26651723.592867203,5833.333333333334,20614790.095518727,true,1368.0,1368,0.875,0.0,0.0,0.0,0.0,0.0,1368,21750.0,0.0,0.0,0.0,2635502.252749929,700.0,957600.0,0.0,1283016.280355441,0.0,-1.5484147297684103e-10,0.0,0.0,0.0,1352485.972394486,0.0,5.684341886080801e-13,-0.0,-5282316.810180041,true,true,0.0,11990.433188724952,0.0,1644.2724500334996,1368.0,0.0,11990.433188724952,0.0,121.92,0.0 -1369,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,958300.0,5833.333333333334,26657556.926200535,5833.333333333334,20620623.42885206,true,1369.0,1369,0.875,0.0,0.0,0.0,0.0,0.0,1369,21750.0,0.0,0.0,0.0,2635502.252749929,700.0,958300.0,0.0,1283016.280355441,0.0,-1.5484147297684103e-10,0.0,0.0,0.0,1352485.972394486,0.0,5.684341886080801e-13,-0.0,-5282316.810180041,true,true,0.0,11990.433188724952,0.0,1644.2724500334996,1369.0,0.0,11990.433188724952,0.0,121.92,0.0 +veh.pt_type.ConventionalVehicle.fc.history.i,veh.pt_type.ConventionalVehicle.fc.history.pwr_out_max_watts,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_max_watts,veh.pt_type.ConventionalVehicle.fc.history.eff,veh.pt_type.ConventionalVehicle.fc.history.pwr_prop_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_prop_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_aux_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_aux_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_fuel_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_fuel_joules,veh.pt_type.ConventionalVehicle.fc.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.fc.history.energy_loss_joules,veh.pt_type.ConventionalVehicle.fc.history.fc_on,veh.pt_type.ConventionalVehicle.fc.history.time_on_seconds,veh.pt_type.ConventionalVehicle.transmission.history.i,veh.pt_type.ConventionalVehicle.transmission.history.eff,veh.pt_type.ConventionalVehicle.transmission.history.pwr_out_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_in_watts,veh.pt_type.ConventionalVehicle.transmission.history.pwr_loss_watts,veh.pt_type.ConventionalVehicle.transmission.history.energy_out_joules,veh.pt_type.ConventionalVehicle.transmission.history.energy_loss_joules,veh.history.i,veh.history.pwr_prop_fwd_max_watts,veh.history.pwr_prop_bwd_max_watts,veh.history.pwr_tractive_watts,veh.history.pwr_tractive_for_cyc_watts,veh.history.energy_tractive_joules,veh.history.pwr_aux_watts,veh.history.energy_aux_joules,veh.history.pwr_drag_watts,veh.history.energy_drag_joules,veh.history.pwr_accel_watts,veh.history.energy_accel_joules,veh.history.pwr_ascent_watts,veh.history.energy_ascent_joules,veh.history.pwr_rr_watts,veh.history.energy_rr_joules,veh.history.pwr_whl_inertia_watts,veh.history.energy_whl_inertia_joules,veh.history.pwr_brake_watts,veh.history.energy_brake_joules,veh.history.cyc_met,veh.history.cyc_met_overall,veh.history.speed_ach_meters_per_second,veh.history.dist_meters,veh.history.grade_curr,veh.history.elev_curr_meters,veh.history.mass_kilograms,cyc.time_seconds,cyc.speed_meters_per_second,cyc.dist_meters,cyc.grade,cyc.elev_meters,cyc.pwr_max_chrg_watts,cyc.temp_amb_air_degrees_Celsius +0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,false,0.0,0,0.0,0.0,0.0,0.0,0.0,0.0,0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,true,true,0.0,0.0,0.0,0.0,1644.2724500334996,0.0,0.0,0.0,0.0,121.92,0.0,295.15 +1,21750.0,21050.0,0.12,0.0,0.0,700.0,700.0,5833.333333333334,5833.333333333334,5833.333333333334,5833.333333333334,true,1.0,1,0.875,0.0,0.0,0.0,0.0,0.0,1,21050.0,0.0,0.0,0.0,0.0,700.0,700.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,1.0,0.0,0.0,0.0,121.92,0.0,295.15 +2,22450.0,21750.0,0.12,0.0,0.0,700.0,1400.0,5833.333333333334,11666.666666666668,5833.333333333334,11666.666666666668,true,2.0,2,0.875,0.0,0.0,0.0,0.0,0.0,2,21750.0,0.0,0.0,0.0,0.0,700.0,1400.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,2.0,0.0,0.0,0.0,121.92,0.0,295.15 +3,22450.0,21750.0,0.12,0.0,0.0,700.0,2100.0,5833.333333333334,17500.0,5833.333333333334,17500.0,true,3.0,3,0.875,0.0,0.0,0.0,0.0,0.0,3,21750.0,0.0,0.0,0.0,0.0,700.0,2100.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,3.0,0.0,0.0,0.0,121.92,0.0,295.15 +4,22450.0,21750.0,0.12,0.0,0.0,700.0,2800.0,5833.333333333334,23333.333333333336,5833.333333333334,23333.333333333336,true,4.0,4,0.875,0.0,0.0,0.0,0.0,0.0,4,21750.0,0.0,0.0,0.0,0.0,700.0,2800.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,4.0,0.0,0.0,0.0,121.92,0.0,295.15 +5,22450.0,21750.0,0.12,0.0,0.0,700.0,3500.0,5833.333333333334,29166.66666666667,5833.333333333334,29166.66666666667,true,5.0,5,0.875,0.0,0.0,0.0,0.0,0.0,5,21750.0,0.0,0.0,0.0,0.0,700.0,3500.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,5.0,0.0,0.0,0.0,121.92,0.0,295.15 +6,22450.0,21750.0,0.12,0.0,0.0,700.0,4200.0,5833.333333333334,35000.00000000001,5833.333333333334,35000.00000000001,true,6.0,6,0.875,0.0,0.0,0.0,0.0,0.0,6,21750.0,0.0,0.0,0.0,0.0,700.0,4200.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,6.0,0.0,0.0,0.0,121.92,0.0,295.15 +7,22450.0,21750.0,0.12,0.0,0.0,700.0,4900.0,5833.333333333334,40833.33333333334,5833.333333333334,40833.33333333334,true,7.0,7,0.875,0.0,0.0,0.0,0.0,0.0,7,21750.0,0.0,0.0,0.0,0.0,700.0,4900.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,7.0,0.0,0.0,0.0,121.92,0.0,295.15 +8,22450.0,21750.0,0.12,0.0,0.0,700.0,5600.0,5833.333333333334,46666.66666666668,5833.333333333334,46666.66666666668,true,8.0,8,0.875,0.0,0.0,0.0,0.0,0.0,8,21750.0,0.0,0.0,0.0,0.0,700.0,5600.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,8.0,0.0,0.0,0.0,121.92,0.0,295.15 +9,22450.0,21750.0,0.12,0.0,0.0,700.0,6300.0,5833.333333333334,52500.000000000015,5833.333333333334,52500.000000000015,true,9.0,9,0.875,0.0,0.0,0.0,0.0,0.0,9,21750.0,0.0,0.0,0.0,0.0,700.0,6300.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,9.0,0.0,0.0,0.0,121.92,0.0,295.15 +10,22450.0,21750.0,0.12,0.0,0.0,700.0,7000.0,5833.333333333334,58333.33333333335,5833.333333333334,58333.33333333335,true,10.0,10,0.875,0.0,0.0,0.0,0.0,0.0,10,21750.0,0.0,0.0,0.0,0.0,700.0,7000.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,10.0,0.0,0.0,0.0,121.92,0.0,295.15 +11,22450.0,21750.0,0.12,0.0,0.0,700.0,7700.0,5833.333333333334,64166.666666666686,5833.333333333334,64166.666666666686,true,11.0,11,0.875,0.0,0.0,0.0,0.0,0.0,11,21750.0,0.0,0.0,0.0,0.0,700.0,7700.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,11.0,0.0,0.0,0.0,121.92,0.0,295.15 +12,22450.0,21750.0,0.12,0.0,0.0,700.0,8400.0,5833.333333333334,70000.00000000001,5833.333333333334,70000.00000000001,true,12.0,12,0.875,0.0,0.0,0.0,0.0,0.0,12,21750.0,0.0,0.0,0.0,0.0,700.0,8400.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,12.0,0.0,0.0,0.0,121.92,0.0,295.15 +13,22450.0,21750.0,0.12,0.0,0.0,700.0,9100.0,5833.333333333334,75833.33333333334,5833.333333333334,75833.33333333334,true,13.0,13,0.875,0.0,0.0,0.0,0.0,0.0,13,21750.0,0.0,0.0,0.0,0.0,700.0,9100.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,13.0,0.0,0.0,0.0,121.92,0.0,295.15 +14,22450.0,21750.0,0.12,0.0,0.0,700.0,9800.0,5833.333333333334,81666.66666666667,5833.333333333334,81666.66666666667,true,14.0,14,0.875,0.0,0.0,0.0,0.0,0.0,14,21750.0,0.0,0.0,0.0,0.0,700.0,9800.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,14.0,0.0,0.0,0.0,121.92,0.0,295.15 +15,22450.0,21750.0,0.12,0.0,0.0,700.0,10500.0,5833.333333333334,87500.0,5833.333333333334,87500.0,true,15.0,15,0.875,0.0,0.0,0.0,0.0,0.0,15,21750.0,0.0,0.0,0.0,0.0,700.0,10500.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,15.0,0.0,0.0,0.0,121.92,0.0,295.15 +16,22450.0,21750.0,0.12,0.0,0.0,700.0,11200.0,5833.333333333334,93333.33333333333,5833.333333333334,93333.33333333333,true,16.0,16,0.875,0.0,0.0,0.0,0.0,0.0,16,21750.0,0.0,0.0,0.0,0.0,700.0,11200.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,16.0,0.0,0.0,0.0,121.92,0.0,295.15 +17,22450.0,21750.0,0.12,0.0,0.0,700.0,11900.0,5833.333333333334,99166.66666666666,5833.333333333334,99166.66666666666,true,17.0,17,0.875,0.0,0.0,0.0,0.0,0.0,17,21750.0,0.0,0.0,0.0,0.0,700.0,11900.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,17.0,0.0,0.0,0.0,121.92,0.0,295.15 +18,22450.0,21750.0,0.12,0.0,0.0,700.0,12600.0,5833.333333333334,104999.99999999999,5833.333333333334,104999.99999999999,true,18.0,18,0.875,0.0,0.0,0.0,0.0,0.0,18,21750.0,0.0,0.0,0.0,0.0,700.0,12600.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,18.0,0.0,0.0,0.0,121.92,0.0,295.15 +19,22450.0,21750.0,0.12,0.0,0.0,700.0,13300.0,5833.333333333334,110833.33333333331,5833.333333333334,110833.33333333331,true,19.0,19,0.875,0.0,0.0,0.0,0.0,0.0,19,21750.0,0.0,0.0,0.0,0.0,700.0,13300.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,19.0,0.0,0.0,0.0,121.92,0.0,295.15 +20,22450.0,21750.0,0.12,0.0,0.0,700.0,14000.0,5833.333333333334,116666.66666666664,5833.333333333334,116666.66666666664,true,20.0,20,0.875,0.0,0.0,0.0,0.0,0.0,20,21750.0,0.0,0.0,0.0,0.0,700.0,14000.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,0.0,-0.0,0.0,true,true,0.0,0.0,0.0,121.92,1644.2724500334996,20.0,0.0,0.0,0.0,121.92,0.0,295.15 +21,22450.0,21750.0,0.1696,1808.327174958617,1808.327174958617,700.0,14700.0,14789.664946689958,131456.3316133566,12981.337771731341,129648.00443839798,true,21.0,21,0.875,1582.28627808879,1808.327174958617,226.04089686982707,0.0,0.0,21,21750.0,0.0,1582.28627808879,1582.28627808879,1582.28627808879,700.0,14700.0,0.14721772299579924,0.14721772299579924,1478.7445436315438,1478.7445436315438,0.0,0.0,75.63844389482165,75.63844389482165,27.75607283942872,27.75607283942872,-1582.28627808879,-1582.28627808879,true,true,1.341141759,1.341141759,0.0,121.92,1644.2724500334996,21.0,1.341141759,1.341141759,0.0,121.92,0.0,295.15 +22,24258.327174958617,23558.327174958617,0.23500000000000001,5198.339298863856,7006.666473822474,700.0,15400.0,25099.31616537811,156555.6477787347,19900.976866514255,149548.98130491225,true,22.0,22,0.875,4548.546886505874,5198.339298863856,649.7924123579824,0.0,0.0,22,23558.327174958617,0.0,4548.546886505874,4548.546886505874,6130.833164594664,700.0,15400.0,3.843849292883245,3.991067015879044,4240.710738200853,5719.455281832396,0.0,0.0,224.3940501818252,300.03249407664686,79.59824883031244,107.35432166974117,-4548.546886505874,-6130.833164594664,true,true,2.637578792,3.978720551,0.0,121.92,1644.2724500334996,22.0,2.637578792,3.978720551,0.0,121.92,0.0,295.15 +23,27648.339298863855,26948.339298863855,0.28625,7926.2698795919205,14932.936353414394,700.0,16100.0,30135.440627395354,186691.08840613006,22209.170747803433,171758.15205271568,true,23.0,23,0.875,6935.48614464293,7926.2698795919205,990.7837349489901,0.0,0.0,23,26948.339298863855,0.0,6935.48614464293,6935.48614464293,13066.319309237595,700.0,16100.0,16.62265297987032,20.613719995749364,6432.538762775781,12151.994044608178,0.0,0.0,365.5858120737068,665.6183061503536,120.7389168135726,228.09323848331377,-6935.48614464293,-13066.319309237595,true,true,3.844606375,7.823326926,0.0,121.92,1644.2724500334996,23.0,3.844606375,7.823326926,0.0,121.92,0.0,295.15 +24,30376.26987959192,29676.26987959192,0.3175,11780.751469940089,26713.687823354485,700.0,16800.0,39309.4534486302,226000.54185476026,27528.70197869011,199286.8540314058,true,24.0,24,0.875,10308.157536197577,11780.751469940089,1472.5939337425116,0.0,0.0,24,29676.26987959192,0.0,10308.157536197577,10308.157536197577,23374.476845435172,700.0,16800.0,44.27764398738515,64.89136398313451,9577.335486630982,21729.32953123916,0.0,0.0,506.7775739655883,1172.395880115942,179.7668316136226,407.8600700969364,-10308.157536197577,-23374.476845435172,true,true,5.141043408,12.964370334,0.0,121.92,1644.2724500334996,24.0,5.141043408,12.964370334,0.0,121.92,0.0,295.15 +25,34230.75146994009,33530.75146994009,0.335,14670.065836971798,41383.753660326285,700.0,17500.0,45880.7935431994,271881.3353979597,31210.727706227597,230497.5817376334,true,25.0,25,0.875,12836.307607350323,14670.065836971798,1833.758229621475,0.0,0.0,25,33530.75146994009,0.0,12836.307607350323,12836.307607350323,36210.7844527855,700.0,17500.0,93.63871593500616,158.53007991814067,11869.389529590659,33598.71906082982,0.0,0.0,650.4906173037111,1822.886497419653,222.788744520946,630.6488146178824,-12836.307607350323,-36210.7844527855,true,true,6.392775716,19.35714605,0.0,121.92,1644.2724500334996,25.0,6.392775716,19.35714605,0.0,121.92,0.0,295.15 +26,37120.0658369718,36420.0658369718,0.345,16606.665091304716,57990.418751631005,700.0,18200.0,50164.24664146295,322045.58203942265,33557.58155015824,264055.16328779166,true,26.0,26,0.875,14530.831954891626,16606.665091304716,2075.83313641309,0.0,0.0,26,36420.0658369718,0.0,14530.831954891626,14530.831954891626,50741.616407677124,700.0,18200.0,165.59991663172076,324.1299965498614,13328.417485452268,46927.13654628208,0.0,0.0,786.6398163031103,2609.5263137227635,250.17473650452703,880.8235511224094,-14530.831954891626,-50741.616407677124,true,true,7.555098574,26.912244624,0.0,121.92,1644.2724500334996,26.0,7.555098574,26.912244624,0.0,121.92,0.0,295.15 +27,39056.66509130472,38356.66509130472,0.196,3851.7356893457522,61842.15444097676,700.0,18900.0,23223.141272172208,345268.72331159486,19371.405582826457,283426.5688706181,true,27.0,27,0.875,3370.2687281775334,3851.7356893457522,481.46696116821886,0.0,0.0,27,38356.66509130472,0.0,3370.2687281775334,3370.2687281775334,54111.88513585466,700.0,18900.0,218.10953404401812,542.2395305938795,2247.691703276772,49174.82824955886,0.0,0.0,862.278260197932,3471.8045739206955,42.1892306588113,923.0127817812207,-3370.2687281775334,-54111.88513585466,true,true,7.733917475,34.646162099,0.0,121.92,1644.2724500334996,27.0,7.733917475,34.646162099,0.0,121.92,0.0,295.15 +28,26301.735689345755,25601.735689345755,0.265,6714.13981026355,68556.29425124031,700.0,19600.0,27977.886076466228,373246.6093880611,21263.746266202677,304690.3151368208,true,28.0,28,0.875,5874.8723339806065,6714.13981026355,839.2674762829438,0.0,0.0,28,25601.735689345755,0.0,5874.8723339806065,5874.8723339806065,59986.75746983527,700.0,19600.0,241.8834296566501,784.1229602505296,4653.116157521396,53827.94440708026,0.0,0.0,892.5336377220215,4364.3382116427165,87.33910908053836,1010.3518908617591,-5874.8723339806065,-59986.75746983527,true,true,8.091555277,42.737717376,0.0,121.92,1644.2724500334996,28.0,8.091555277,42.737717376,0.0,121.92,0.0,295.15 +29,29164.13981026355,28464.13981026355,0.35333333333333333,20780.50523360775,89336.79948484806,700.0,20300.0,60793.88273662571,434040.49212468683,40013.37750301796,344703.69263983873,true,29.0,29,0.875,18182.94207940678,20780.50523360775,2597.5631542009687,0.0,0.0,29,28464.13981026355,0.0,18182.94207940678,18182.94207940678,78169.69954924205,700.0,20300.0,318.4868522607286,1102.609812511258,16575.083283264168,70403.02769034443,0.0,0.0,978.2572074582062,5342.595419100922,311.11473642367656,1321.4666272854356,-18182.94207940678,-78169.69954924205,true,true,9.253878135,51.991595511,0.0,121.92,1644.2724500334996,29.0,9.253878135,51.991595511,0.0,121.92,0.0,295.15 +30,43230.50523360775,42530.50523360775,0.30500000000000005,9807.923090693579,99144.72257554164,700.0,21000.0,34452.20685473304,468492.6989794199,24644.283764039465,369347.9764038782,true,30.0,30,0.875,8581.932704356881,9807.923090693579,1225.990386336698,0.0,0.0,30,42530.50523360775,0.0,8581.932704356881,8581.932704356881,86751.63225359893,700.0,21000.0,415.61757263409874,1518.2273851453567,6966.5298484538425,77369.55753879827,0.0,0.0,1069.023340143272,6411.618759244195,130.76194312566773,1452.2285704111034,-8581.932704356881,-86751.63225359893,true,true,9.700925388,61.692520899,0.0,121.92,1644.2724500334996,30.0,9.700925388,61.692520899,0.0,121.92,0.0,295.15 +31,32257.923090693577,31557.923090693577,0.28,7710.654440017892,106855.37701555954,700.0,21700.0,30038.05157149247,498530.75055091234,22327.39713147458,391675.37353535276,true,31.0,31,0.875,6746.822635015656,7710.654440017892,963.8318050022363,0.0,0.0,31,31557.923090693577,0.0,6746.822635015656,6746.822635015656,93498.4548886146,700.0,21700.0,467.6404824419889,1985.8678675873457,5072.0936996015325,82441.6512383998,0.0,0.0,1111.8851247293717,7523.503883973566,95.2033282427622,1547.4318986538656,-6746.822635015656,-93498.4548886146,true,true,10.01385846,71.706379359,0.0,121.92,1644.2724500334996,31.0,10.01385846,71.706379359,0.0,121.92,0.0,295.15 +32,30160.65444001789,29460.65444001789,0.1864,2716.7847369011556,109572.1617524607,700.0,22400.0,18330.3902194268,516861.1407703392,15613.605482525645,407288.9790178784,true,32.0,32,0.875,2377.1866447885113,2716.7847369011556,339.5980921126443,0.0,0.0,32,29460.65444001789,0.0,2377.1866447885113,2377.1866447885113,95875.6415334031,700.0,22400.0,493.55477106152716,2479.4226386488726,737.729299526981,83179.38053792679,0.0,0.0,1132.055376412098,8655.559260385664,13.847197787905301,1561.279096441771,-2377.1866447885113,-95875.6415334031,true,true,10.05856319,81.764942549,0.0,121.92,1644.2724500334996,32.0,10.05856319,81.764942549,0.0,121.92,0.0,295.15 +33,25166.784736901154,24466.784736901154,0.12,0.0,109572.1617524607,700.0,23100.0,5833.333333333334,522694.4741036725,5833.333333333334,413122.31235121173,true,33.0,33,0.875,0.0,0.0,0.0,0.0,0.0,33,24466.784736901154,0.0,-1377.999818492709,-1377.999818492709,94497.6417149104,700.0,23100.0,483.72764490970684,2963.1502835585793,-2931.2002913922315,80248.18024653455,0.0,0.0,1124.4915322989687,9780.050792684633,-55.01870430915308,1506.2603921326179,-0.0,-95875.6415334031,true,true,9.879744289,91.644686838,0.0,121.92,1644.2724500334996,33.0,9.879744289,91.644686838,0.0,121.92,0.0,295.15 +34,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,23800.0,5833.333333333334,528527.8074370058,5833.333333333334,418955.64568454504,true,34.0,34,0.875,0.0,0.0,0.0,0.0,0.0,34,21750.0,0.0,-2827.7024056923065,-2827.7024056923065,91669.93930921808,700.0,23800.0,451.91400403597083,3415.06428759455,-4298.217475635412,75949.96277089915,0.0,0.0,1099.2787176673617,10879.329510351994,-80.67765176022748,1425.5827403723904,-0.0,-95875.6415334031,true,true,9.611515937,101.25620277499999,0.0,121.92,1644.2724500334996,34.0,9.611515937,101.25620277499999,0.0,121.92,0.0,295.15 +35,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,24500.0,5833.333333333334,534361.1407703392,5833.333333333334,424788.97901787836,true,35.0,35,0.875,0.0,0.0,0.0,0.0,0.0,35,21750.0,0.0,-2773.7341652430473,-2773.7341652430473,88896.20514397504,700.0,24500.0,415.61757256831817,3830.6818601628684,-4179.917911968478,71770.04485893066,0.0,0.0,1069.0233400868733,11948.352850438867,-78.4571659297614,1347.125574442629,-0.0,-95875.6415334031,true,true,9.343287585,110.59949035999999,0.0,121.92,1644.2724500334996,35.0,9.343287585,110.59949035999999,0.0,121.92,0.0,295.15 +36,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,25200.0,5833.333333333334,540194.4741036725,5833.333333333334,430622.3123512117,true,36.0,36,0.875,0.0,0.0,0.0,0.0,0.0,36,21750.0,0.0,-2031.1907897063204,-2031.1907897063204,86865.01435426871,700.0,25200.0,384.10192764921766,4214.783787812086,-3392.8971943978986,68377.14766453276,0.0,0.0,1041.2892440090252,12989.642094447892,-63.6847669666647,1283.4408074759642,-0.0,-95875.6415334031,true,true,9.119763959,119.71925431899999,0.0,121.92,1644.2724500334996,36.0,9.119763959,119.71925431899999,0.0,121.92,0.0,295.15 +37,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,25900.0,5833.333333333334,546027.8074370059,5833.333333333334,436455.645684545,true,37.0,37,0.875,0.0,0.0,0.0,0.0,0.0,37,21750.0,0.0,-2669.645354288944,-2669.645354288944,84195.36899997976,700.0,25900.0,354.2211518990812,4569.004939711167,-3963.035378873108,64414.112285659656,0.0,0.0,1013.5551479311766,14003.197242379068,-74.3862752460937,1209.0545322298706,-0.0,-95875.6415334031,true,true,8.851535607,128.57078992599997,0.0,121.92,1644.2724500334996,37.0,8.851535607,128.57078992599997,0.0,121.92,0.0,295.15 +38,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,26600.0,5833.333333333334,551861.1407703393,5833.333333333334,442288.9790178783,true,38.0,38,0.875,0.0,0.0,0.0,0.0,0.0,38,21750.0,0.0,-16048.195204836218,-16048.195204836218,68147.17379514355,700.0,26600.0,271.731375862927,4840.736315574094,-16929.98196515015,47484.1303205095,0.0,0.0,927.8315781949918,14931.02882057406,-317.7761937439876,891.278338485883,-0.0,-95875.6415334031,true,true,7.599803299,136.17059322499998,0.0,121.92,1644.2724500334996,38.0,7.599803299,136.17059322499998,0.0,121.92,0.0,295.15 +39,22450.0,21750.0,0.12,0.0,109572.1617524607,700.0,27300.0,5833.333333333334,557694.4741036727,5833.333333333334,448122.3123512116,true,39.0,39,0.875,0.0,0.0,0.0,0.0,0.0,39,21750.0,0.0,-10232.0994533186,-10232.0994533186,57915.07434182495,700.0,27300.0,176.99800891476542,5017.73432448886,-11006.788546724434,36477.34177378507,0.0,0.0,804.2887865395954,15735.317607113655,-206.59770204852575,684.6806364373572,-0.0,-95875.6415334031,true,true,6.661004068,142.831597293,0.0,121.92,1644.2724500334996,39.0,6.661004068,142.831597293,0.0,121.92,0.0,295.15 +40,22450.0,21750.0,0.15200000000000002,1023.5826624745278,110595.74441493522,700.0,28000.0,11339.359621542944,569033.8337252156,10315.776959068417,458438.08931028005,true,40.0,40,0.875,895.6348296652118,1023.5826624745278,127.94783280931597,0.0,0.0,40,21750.0,0.0,895.6348296652118,895.6348296652118,58810.70917149016,700.0,28000.0,144.29295383507196,5162.027278323932,0.0,36477.34177378507,0.0,0.0,751.3418758301399,16486.659482943796,0.0,684.6806364373572,-895.6348296652118,-96771.27636306832,true,true,6.661004068,149.492601361,0.0,121.92,1644.2724500334996,40.0,6.661004068,149.492601361,0.0,121.92,0.0,295.15 +41,23473.582662474528,22773.582662474528,0.1864,2764.7117931433886,113360.45620807861,700.0,28700.0,18587.509619867964,587621.3433450836,15822.797826724574,474260.88713700464,true,41.0,41,0.875,2419.122819000465,2764.7117931433886,345.5889741429237,0.0,0.0,41,22773.582662474528,0.0,2419.122819000465,2419.122819000465,61229.831990490624,700.0,28700.0,148.69481282630025,5310.722091150232,1483.673692852741,37961.01546663781,0.0,0.0,758.9057202252619,17245.56520316906,27.848593096162,712.5292295335191,-2419.122819000465,-99190.39918206878,true,true,6.795118244,156.287719605,0.0,121.92,1644.2724500334996,41.0,6.795118244,156.287719605,0.0,121.92,0.0,295.15 +42,25214.71179314339,24514.71179314339,0.1888,2826.801139042185,116187.2573471208,700.0,29400.0,18680.09077882513,606301.4341239088,15853.289639782946,490114.1767767876,true,42.0,42,0.875,2473.4509966619116,2826.801139042185,353.35014238027316,0.0,0.0,42,24514.71179314339,0.0,2473.4509966619116,2473.4509966619116,63703.28298715253,700.0,29400.0,157.76528932315836,5468.48738047339,1513.2485837694687,39474.26405040728,0.0,0.0,774.0334090155059,18019.598612184564,28.40371455377847,740.9329440872976,-2473.4509966619116,-101663.85017873069,true,true,6.92923242,163.216952025,0.0,121.92,1644.2724500334996,42.0,6.92923242,163.216952025,0.0,121.92,0.0,295.15 +43,25276.801139042185,24576.801139042185,0.20800000000000002,4115.431599343782,120302.68894646458,700.0,30100.0,23151.113458383566,629452.5475822923,19035.681859039785,509149.8586358274,true,43.0,43,0.875,3601.002649425809,4115.431599343782,514.4289499179731,0.0,0.0,43,24576.801139042185,0.0,3601.002649425809,3601.002649425809,67304.28563657834,700.0,30100.0,170.4229164559391,5638.910296929329,2587.802944923363,42062.06699533064,0.0,0.0,794.2036606982323,18813.802272882796,48.573127348274625,789.5060714355723,-3601.002649425809,-105264.8528281565,true,true,7.152756046,170.36970807100002,0.0,121.92,1644.2724500334996,43.0,7.152756046,170.36970807100002,0.0,121.92,0.0,295.15 +44,26565.43159934378,25865.43159934378,0.28625,8145.039570291977,128447.72851675656,700.0,30800.0,30899.701555605163,660352.2491378975,22754.661985313185,531904.5206211406,true,44.0,44,0.875,7126.90962400548,8145.039570291977,1018.1299462864972,0.0,0.0,44,25865.43159934378,0.0,7126.90962400548,7126.90962400548,74431.19526058382,700.0,30800.0,197.73352701896206,5836.643823948291,5982.34319834801,48044.410193678654,0.0,0.0,834.544164063685,19648.346436946482,112.28873457482169,901.7948060103939,-7126.90962400548,-112391.76245216197,true,true,7.644508024,178.01421609500002,0.0,121.92,1644.2724500334996,44.0,7.644508024,178.01421609500002,0.0,121.92,0.0,295.15 +45,30595.039570291978,29895.039570291978,0.33999999999999997,15188.937251058542,143636.6657678151,700.0,31500.0,46732.168385466306,707084.4175233638,31543.231134407764,563447.7517555484,true,45.0,45,0.875,13290.320094676224,15188.937251058542,1898.6171563823173,0.0,0.0,45,29895.039570291978,0.0,13290.320094676224,13290.320094676224,87721.51535526004,700.0,31500.0,258.65569399419934,6095.299517942491,11895.678325388006,59940.08851906666,0.0,0.0,912.703889404748,20561.05032635123,223.28218588927055,1125.0769918996646,-13290.320094676224,-125682.0825468382,true,true,8.53860253,186.55281862500001,0.0,121.92,1644.2724500334996,45.0,8.53860253,186.55281862500001,0.0,121.92,0.0,295.15 +46,37638.93725105854,36938.93725105854,0.345,16943.826823077517,160580.49259089262,700.0,32200.0,51141.527023413095,758225.9445467769,34197.700200335574,597645.451955884,true,46.0,46,0.875,14825.848470192828,16943.826823077517,2117.9783528846892,0.0,0.0,46,36938.93725105854,0.0,14825.848470192828,14825.848470192828,102547.36382545286,700.0,32200.0,354.2211518990812,6449.520669841571,13210.117919727141,73150.2064387938,0.0,0.0,1013.5551479311766,21574.605474282405,247.95425063542908,1373.0312425350937,-14825.848470192828,-140507.93101703102,true,true,9.432697036,195.98551566100002,0.0,121.92,1644.2724500334996,46.0,9.432697036,195.98551566100002,0.0,121.92,0.0,295.15 +47,39393.826823077514,38693.826823077514,0.33999999999999997,15192.115397698453,175772.60798859107,700.0,32900.0,46741.51587558369,804967.4604223606,31549.400477885236,629194.8524337693,true,47.0,47,0.875,13293.100972986147,15192.115397698453,1899.0144247123062,0.0,0.0,47,38693.826823077514,0.0,13293.100972986147,13293.100972986147,115840.464798439,700.0,32900.0,458.1615751941962,6907.682245035768,11514.490830357088,84664.69726915089,0.0,0.0,1104.3212805598437,22678.92675484225,216.12728687502045,1589.1585294101142,-13293.100972986147,-153801.03199001716,true,true,10.14797264,206.13348830100003,0.0,121.92,1644.2724500334996,47.0,10.14797264,206.13348830100003,0.0,121.92,0.0,295.15 +48,37642.11539769845,36942.11539769845,0.196,3649.4765762998713,179422.08456489095,700.0,33600.0,22191.207021938117,827158.6674442987,18541.730445638244,647736.5828794076,true,48.0,48,0.875,3193.2920042623873,3649.4765762998713,456.18457203748403,0.0,0.0,48,36942.11539769845,0.0,3193.2920042623873,3193.2920042623873,119033.75680270139,700.0,33600.0,517.0003768410601,7424.682621876827,1498.4611269910556,86163.15839614194,0.0,0.0,1149.704346817779,23828.63110166003,28.126153612492594,1617.2846830226067,-3193.2920042623873,-156994.32399427955,true,true,10.23738209,216.37087039100004,0.0,121.92,1644.2724500334996,48.0,10.23738209,216.37087039100004,0.0,121.92,0.0,295.15 +49,26099.476576299872,25399.476576299872,0.124,160.13422063461817,179582.21878552556,700.0,34300.0,6936.566295440469,834095.2337397392,6776.432074805851,654513.0149542134,true,49.0,49,0.875,140.1174430552909,160.13422063461817,20.016777579327282,0.0,0.0,49,25399.476576299872,0.0,140.1174430552909,140.1174430552909,119173.87424575668,700.0,34300.0,517.0003768410601,7941.682998717887,-1498.4611269910556,84664.69726915089,0.0,0.0,1149.704346817779,24978.33544847781,-28.126153612492594,1589.1585294101142,-140.1174430552909,-157134.44143733484,true,true,10.14797264,226.51884303100005,0.0,121.92,1644.2724500334996,49.0,10.14797264,226.51884303100005,0.0,121.92,0.0,295.15 +50,22610.13422063462,21910.13422063462,0.15200000000000002,1017.9794540270638,180600.1982395526,700.0,35000.0,11302.496408072786,845397.7301478119,10284.516954045723,664797.5319082591,true,50.0,50,0.875,890.7320222736807,1017.9794540270638,127.24743175338301,0.0,0.0,50,21910.13422063462,0.0,890.7320222736807,890.7320222736807,120064.60626803036,700.0,35000.0,506.8634065385323,8448.54640525642,-744.301332020297,83920.39593713058,0.0,0.0,1142.140502761048,26120.47595123886,-13.970555005602682,1575.1879744045116,-890.7320222736807,-158025.17345960852,true,true,10.10326792,236.62211095100005,0.0,121.92,1644.2724500334996,50.0,10.10326792,236.62211095100005,0.0,121.92,0.0,295.15 +51,23467.979454027063,22767.979454027063,0.12,0.0,180600.1982395526,700.0,35700.0,5833.333333333334,851231.0634811453,5833.333333333334,670630.8652415925,true,51.0,51,0.875,0.0,0.0,0.0,0.0,0.0,51,22767.979454027063,0.0,-7984.7384645693055,-7984.7384645693055,112079.86780346105,700.0,35700.0,461.30683862614904,8909.85324388257,-9376.883522412647,74543.51241471793,0.0,0.0,1106.8425623444764,27227.318513583334,-176.00434312728353,1399.183631277228,-0.0,-158025.17345960852,true,true,9.522106487,246.14421743800006,0.0,121.92,1644.2724500334996,51.0,9.522106487,246.14421743800006,0.0,121.92,0.0,295.15 +52,22450.0,21750.0,0.12,0.0,180600.1982395526,700.0,36400.0,5833.333333333334,857064.3968144787,5833.333333333334,676464.1985749259,true,52.0,52,0.875,0.0,0.0,0.0,0.0,0.0,52,21750.0,0.0,-14142.334854242756,-14142.334854242756,97937.5329492183,700.0,36400.0,356.8711745509055,9266.724418433476,-15229.425748096373,59314.08666662156,0.0,0.0,1016.0764294338162,28243.39494301715,-285.8567101311042,1113.3269211461238,-0.0,-158025.17345960852,true,true,8.493897805,254.63811524300004,0.0,121.92,1644.2724500334996,52.0,8.493897805,254.63811524300004,0.0,121.92,0.0,295.15 +53,22450.0,21750.0,0.12,0.0,180600.1982395526,700.0,37100.0,5833.333333333334,862897.730147812,5833.333333333334,682297.5319082593,true,53.0,53,0.875,0.0,0.0,0.0,0.0,0.0,53,21750.0,0.0,-10314.507925615877,-10314.507925615877,87623.02502360241,700.0,37100.0,256.5180545042647,9523.24247293774,-11269.676472942918,48044.41019367864,0.0,0.0,910.1826079585067,29153.577550975657,-211.53211513572967,901.7948060103942,-0.0,-158025.17345960852,true,true,7.644508024,262.282623267,0.0,121.92,1644.2724500334996,53.0,7.644508024,262.282623267,0.0,121.92,0.0,295.15 +54,22450.0,21750.0,0.12,0.0,180600.1982395526,700.0,37800.0,5833.333333333334,868731.0634811454,5833.333333333334,688130.8652415926,true,54.0,54,0.875,0.0,0.0,0.0,0.0,0.0,54,21750.0,0.0,-6135.553246082382,-6135.553246082382,81487.47177752003,700.0,37800.0,194.1708472432873,9717.413320181027,-7027.322668585171,41017.08752509347,0.0,0.0,829.5016011712027,29983.07915214686,-131.90302591170146,769.8917800986927,-0.0,-158025.17345960852,true,true,7.063346596,269.345969863,0.0,121.92,1644.2724500334996,54.0,7.063346596,269.345969863,0.0,121.92,0.0,295.15 +55,22450.0,21750.0,0.15200000000000002,1107.1726767433381,181707.37091629594,700.0,38500.0,11889.293925943011,880620.3574070884,10782.121249199674,698912.9864907924,true,55.0,55,0.875,968.7760921504209,1107.1726767433381,138.39658459291718,0.0,0.0,55,21750.0,0.0,968.7760921504209,968.7760921504209,82456.24786967045,700.0,38500.0,172.051149949549,9889.464470130577,0.0,41017.08752509347,0.0,0.0,796.724942200872,30779.80409434773,0.0,769.8917800986927,-968.7760921504209,-158993.94955175894,true,true,7.063346596,276.40931645899997,0.0,121.92,1644.2724500334996,55.0,7.063346596,276.40931645899997,0.0,121.92,0.0,295.15 +56,23557.17267674334,22857.17267674334,0.33,13375.9148672416,195083.28578353755,700.0,39200.0,42654.28747648969,923274.6448835781,29278.372609248094,728191.3591000405,true,56.0,56,0.875,11703.925508836399,13375.9148672416,1671.9893584052006,0.0,0.0,56,22857.17267674334,0.0,11703.925508836399,11703.925508836399,94160.17337850685,700.0,39200.0,204.98909254787833,10094.453562678455,10458.010011398097,51475.097536491565,0.0,0.0,844.6292899614467,31624.433384309177,196.297114928978,966.1888950276707,-11703.925508836399,-170697.87506059534,true,true,7.912736376,284.32205283499997,0.0,121.92,1644.2724500334996,56.0,7.912736376,284.32205283499997,0.0,121.92,0.0,295.15 +57,35825.9148672416,35125.9148672416,0.345,16474.166342624427,211557.45212616198,700.0,39900.0,49780.19229746211,973054.8371810402,33306.025954837685,761497.3850548782,true,57.0,57,0.875,14414.895549796373,16474.166342624427,2059.2707928280543,0.0,0.0,57,35125.9148672416,0.0,14414.895549796373,14414.895549796373,108575.06892830323,700.0,39900.0,287.5346149946233,10381.988177673078,12939.014749168073,64414.112285659634,0.0,0.0,945.480548431477,32569.913932740656,242.86563720220002,1209.0545322298708,-14414.895549796373,-185112.77061039172,true,true,8.851535607,293.173588442,0.0,121.92,1644.2724500334996,57.0,8.851535607,293.173588442,0.0,121.92,0.0,295.15 +58,38924.16634262443,38224.16634262443,0.33999999999999997,15890.896470636682,227448.34859679866,700.0,40600.0,48796.75432540201,1021851.5915064422,32905.85785476533,794403.2429096436,true,58.0,58,0.875,13904.534411807097,15890.896470636682,1986.3620588295853,0.0,0.0,58,38224.16634262443,0.0,13904.534411807097,13904.534411807097,122479.60334011032,700.0,40600.0,386.89877544561716,10768.886953118696,12244.004827620138,76658.11711327978,0.0,0.0,1043.8105255116648,33613.72445825232,229.82028322967764,1438.8748154595485,-13904.534411807097,-199017.30502219882,true,true,9.656220663,302.829809105,0.0,121.92,1644.2724500334996,58.0,9.656220663,302.829809105,0.0,121.92,0.0,295.15 +59,38340.89647063668,37640.89647063668,0.33999999999999997,15563.701730610828,243012.0503274095,700.0,41300.0,47834.416854737734,1069686.0083611798,32270.715124126906,826673.9580337704,true,59.0,59,0.875,13618.239014284474,15563.701730610828,1945.462716326354,0.0,0.0,59,37640.89647063668,0.0,13618.239014284474,13618.239014284474,136097.8423543948,700.0,41300.0,490.2644173977315,11259.151370516427,11777.378800679639,88435.49591395941,0.0,0.0,1129.5340954170451,34743.258553669366,221.0617007900585,1659.936516249607,-13618.239014284474,-212635.5440364833,true,true,10.37149627,313.201305375,0.0,121.92,1644.2724500334996,59.0,10.37149627,313.201305375,0.0,121.92,0.0,295.15 +60,38013.70173061083,37313.70173061083,0.3175,11097.13893790936,254109.18926531886,700.0,42000.0,37156.343111525544,1106842.3514727054,26059.204173616185,852733.1622073866,true,60.0,60,0.875,9709.99657067069,11097.13893790936,1387.14236723867,0.0,0.0,60,37313.70173061083,0.0,9709.99657067069,9709.99657067069,145807.83892506547,700.0,42000.0,580.6726312441465,11839.824001760573,7788.054543387607,96223.55045734702,0.0,0.0,1195.0874134141052,35938.34596708347,146.18198262483082,1806.1184988744378,-9709.99657067069,-222345.540607154,true,true,10.81854352,324.019848895,0.0,121.92,1644.2724500334996,60.0,10.81854352,324.019848895,0.0,121.92,0.0,295.15 +61,33547.13893790936,32847.13893790936,0.25,5864.545207191273,259973.7344725101,700.0,42700.0,26258.180828765093,1133100.5323014704,20393.63562157382,873126.7978289603,true,61.0,61,0.875,5131.477056292364,5864.545207191273,733.0681508989092,0.0,0.0,61,32847.13893790936,0.0,5131.477056292364,5131.477056292364,150939.31598135782,700.0,42700.0,633.6592773480427,12473.483279108616,3207.232587723856,99430.78304507089,0.0,0.0,1230.3853536614813,37168.731320744955,60.19983755898447,1866.3183364334222,-5131.477056292364,-227477.01766344634,true,true,10.99736242,335.017211315,0.0,121.92,1644.2724500334996,61.0,10.99736242,335.017211315,0.0,121.92,0.0,295.15 +62,28314.545207191273,27614.545207191273,0.22,5022.94952050384,264996.6839930139,700.0,43400.0,26013.40691138109,1159113.9392128515,20990.45739087725,894117.2552198377,true,62.0,62,0.875,4395.08083044086,5022.94952050384,627.86869006298,0.0,0.0,62,27614.545207191273,0.0,4395.08083044086,4395.08083044086,155334.39681179868,700.0,43400.0,661.3204135987122,13134.803692707328,2439.9285711970974,101870.71161626799,0.0,0.0,1248.0343240671623,38416.76564481212,45.79752157788761,1912.11585801131,-4395.08083044086,-231872.0984938872,true,true,11.1314766,346.148687915,0.0,121.92,1644.2724500334996,62.0,11.1314766,346.148687915,0.0,121.92,0.0,295.15 +63,27472.94952050384,26772.94952050384,0.1936,3166.7115109483248,268163.39550396224,700.0,44100.0,19972.68342431986,1179086.6226371713,16805.971913371537,910923.2271332092,true,63.0,63,0.875,2770.8725720797843,3166.7115109483248,395.8389388685405,0.0,0.0,63,26772.94952050384,0.0,2770.8725720797843,2770.8725720797843,158105.26938387848,700.0,44100.0,677.4823240752954,13812.286016782624,819.8815995946654,102690.59321586265,0.0,0.0,1258.1194498521265,39674.88509466425,15.389198557696954,1927.505056569007,-2770.8725720797843,-234642.971065967,true,true,11.17618132,357.324869235,0.0,121.92,1644.2724500334996,63.0,11.17618132,357.324869235,0.0,121.92,0.0,295.15 +64,25616.711510948324,24916.711510948324,0.12,0.0,268163.39550396224,700.0,44800.0,5833.333333333334,1184919.9559705046,5833.333333333334,916756.5604665426,true,64.0,64,0.875,0.0,0.0,0.0,0.0,0.0,64,24916.711510948324,0.0,-1405.1047676397538,-1405.1047676397538,156700.16461623873,700.0,44800.0,665.3365180561832,14477.622534838807,-3259.8101707917626,99430.78304507089,0.0,0.0,1250.5556052314105,40925.44069989566,-61.18672013558456,1866.3183364334222,-0.0,-234642.971065967,true,true,10.99736242,368.322231655,0.0,121.92,1644.2724500334996,64.0,10.99736242,368.322231655,0.0,121.92,0.0,295.15 +65,22450.0,21750.0,0.15600000000000003,1213.128138690647,269376.5236426529,700.0,45500.0,12263.641914683632,1197183.5978851882,11050.513775992986,927807.0742425356,true,65.0,65,0.875,1061.487121354316,1213.128138690647,151.64101733633083,0.0,0.0,65,21750.0,0.0,1061.487121354316,1061.487121354316,157761.65173759306,700.0,45500.0,645.4176063110823,15123.04014114989,-806.7372052978224,98624.04583977307,0.0,0.0,1237.9491982821974,42163.38989817786,-15.142477941141186,1851.1758584922811,-1061.487121354316,-235704.45818732132,true,true,10.9526577,379.27488935499997,0.0,121.92,1644.2724500334996,65.0,10.9526577,379.27488935499997,0.0,121.92,0.0,295.15 +66,23663.12813869065,22963.12813869065,0.20800000000000002,4042.225076533021,273418.74871918594,700.0,46200.0,22799.159021793366,1219982.7569069816,18756.933945260345,946564.008187796,true,66.0,66,0.875,3536.9469419663933,4042.225076533021,505.2781345666276,0.0,0.0,66,22963.12813869065,0.0,3536.9469419663933,3536.9469419663933,161298.59867955945,700.0,46200.0,649.3691321545542,15772.409273304444,1616.7606903639685,100240.80653013704,0.0,0.0,1240.4704800104312,43403.86037818829,30.346639437439478,1881.5224979297207,-3536.9469419663933,-239241.4051292877,true,true,11.04206715,390.31695650499995,0.0,121.92,1644.2724500334996,66.0,11.04206715,390.31695650499995,0.0,121.92,0.0,295.15 +67,26492.22507653302,25792.22507653302,0.1936,3129.062832413186,276547.8115515991,700.0,46900.0,19778.21710957224,1239760.9740165537,16649.154277159054,963213.162464955,true,67.0,67,0.875,2737.9299783615375,3129.062832413186,391.13285405164834,0.0,0.0,67,25792.22507653302,0.0,2737.9299783615375,2737.9299783615375,164036.52865792098,700.0,46900.0,661.3204135987122,16433.729686903156,813.3094024462439,101054.11593258329,0.0,0.0,1248.0343240671623,44651.89470225546,15.265838249418884,1896.7883361791396,-2737.9299783615375,-241979.33510764924,true,true,11.08677187,401.40372837499996,0.0,121.92,1644.2724500334996,67.0,11.08677187,401.40372837499996,0.0,121.92,0.0,295.15 +68,25579.062832413187,24879.062832413187,0.15600000000000003,1235.1765679659563,277782.98811956507,700.0,47600.0,12404.97799978177,1252165.9520163354,11169.801431815813,974382.9638967708,true,68.0,68,0.875,1080.7794969702118,1235.1765679659563,154.39707099574457,0.0,0.0,68,24879.062832413187,0.0,1080.7794969702118,1080.7794969702118,165117.3081548912,700.0,47600.0,661.3204135987122,17095.050100501867,-813.3094024462439,100240.80653013704,0.0,0.0,1248.0343240671623,45899.92902632262,-15.265838249418884,1881.5224979297207,-1080.7794969702118,-243060.11460461945,true,true,11.04206715,412.44579552499994,0.0,121.92,1644.2724500334996,68.0,11.04206715,412.44579552499994,0.0,121.92,0.0,295.15 +69,23685.176567965955,22985.176567965955,0.15600000000000003,1224.1152771756674,279007.10339674074,700.0,48300.0,12334.07228958761,1264500.0243059231,11109.957012411942,985492.9209091828,true,69.0,69,0.875,1071.100867528709,1224.1152771756674,153.01440964695848,0.0,0.0,69,22985.176567965955,0.0,1071.100867528709,1071.100867528709,166188.4090224199,700.0,48300.0,653.3367529164735,17748.386853418342,-810.0234850661462,99430.78304507089,0.0,0.0,1242.9917611746798,47142.9207874973,-15.204161496298292,1866.3183364334225,-1071.100867528709,-244131.21547214815,true,true,10.99736242,423.44315794499994,0.0,121.92,1644.2724500334996,69.0,10.99736242,423.44315794499994,0.0,121.92,0.0,295.15 +70,23674.115277175668,22974.115277175668,0.1744,2159.816697960325,281166.92009470105,700.0,49000.0,16398.031525001865,1280898.055830925,14238.21482704154,999731.1357362242,true,70.0,70,0.875,1889.8396107152846,2159.816697960325,269.9770872450406,0.0,0.0,70,22974.115277175668,0.0,1889.8396107152846,1889.8396107152846,168078.24863313517,700.0,49000.0,649.3691312688386,18397.75598468718,0.0,99430.78304507089,0.0,0.0,1240.470479446446,48383.39126694375,0.0,1866.3183364334225,-1889.8396107152846,-246021.05508286343,true,true,10.99736242,434.44052036499994,0.0,121.92,1644.2724500334996,70.0,10.99736242,434.44052036499994,0.0,121.92,0.0,295.15 +71,24609.816697960327,23909.816697960327,0.265,6950.927305641732,288117.8474003428,700.0,49700.0,28871.42379487446,1309769.4796257995,21920.496489232726,1021651.632225457,true,71.0,71,0.875,6082.061392436516,6950.927305641732,868.8659132052162,0.0,0.0,71,23909.816697960327,0.0,6082.061392436516,6082.061392436516,174160.31002557167,700.0,49700.0,669.368850078189,19067.12483476537,4082.9780530950543,103513.76109816594,0.0,0.0,1253.0768869596443,49636.46815390339,76.63760230362826,1942.9559387370507,-6082.061392436516,-252103.11647529993,true,true,11.22088605,445.66140641499993,0.0,121.92,1644.2724500334996,71.0,11.22088605,445.66140641499993,0.0,121.92,0.0,295.15 +72,29400.927305641733,28700.927305641733,0.265,7122.504544083483,295240.3519444263,700.0,50400.0,29518.88507201314,1339288.3646978126,22396.380527929658,1044048.0127533866,true,72.0,72,0.875,6232.191476073048,7122.504544083483,890.313068010435,0.0,0.0,72,28700.927305641733,0.0,6232.191476073048,6232.191476073048,180392.50150164473,700.0,50400.0,710.5918296478434,19777.716664413216,4165.130342136687,107678.89144030263,0.0,0.0,1278.2897014220562,50914.75785532545,78.17960286646121,2021.135541603512,-6232.191476073048,-258335.307951373,true,true,11.44440967,457.10581608499996,0.0,121.92,1644.2724500334996,72.0,11.44440967,457.10581608499996,0.0,121.92,0.0,295.15 +73,29572.504544083484,28872.504544083484,0.196,3300.848581137842,298541.20052556414,700.0,51100.0,20412.492760907357,1359700.85745872,17111.644179769515,1061159.656933156,true,73.0,73,0.875,2888.2425084956117,3300.848581137842,412.6060726422302,0.0,0.0,73,28872.504544083484,0.0,2888.2425084956117,2888.2425084956117,183280.74401014033,700.0,51100.0,736.1196770615325,20513.836341474747,842.8844781589164,108521.77591846154,0.0,0.0,1293.417390099503,52208.17524542495,15.820963175659735,2036.9565047791716,-2888.2425084956117,-261223.5504598686,true,true,11.4891144,468.59493048499996,0.0,121.92,1644.2724500334996,73.0,11.4891144,468.59493048499996,0.0,121.92,0.0,295.15 +74,25750.84858113784,25050.84858113784,0.12,0.0,298541.20052556414,700.0,51800.0,5833.333333333334,1365534.1907920532,5833.333333333334,1066992.9902664893,true,74.0,74,0.875,0.0,0.0,0.0,0.0,0.0,74,25050.84858113784,0.0,-550.154354760106,-550.154354760106,182730.58965538023,700.0,51800.0,727.543612270065,21241.379953744814,-2518.7949487392134,106002.98096972232,0.0,0.0,1288.3748272070206,53496.55007263197,-47.27784549797812,1989.6786592811934,-0.0,-261223.5504598686,true,true,11.35500022,479.949930705,0.0,121.92,1644.2724500334996,74.0,11.35500022,479.949930705,0.0,121.92,0.0,295.15 +75,22450.0,21750.0,0.12,0.0,298541.20052556414,700.0,52500.0,5833.333333333334,1371367.5241253865,5833.333333333334,1072826.3235998226,true,75.0,75,0.875,0.0,0.0,0.0,0.0,0.0,75,21750.0,0.0,-2247.7221475831757,-2247.7221475831757,180482.86750779705,700.0,52500.0,693.905431503963,21935.285385248775,-4132.269353454347,101870.71161626797,0.0,0.0,1268.2045756370915,54764.75464826907,-77.56280126988347,1912.11585801131,-0.0,-261223.5504598686,true,true,11.1314766,491.08140730499997,0.0,121.92,1644.2724500334996,75.0,11.1314766,491.08140730499997,0.0,121.92,0.0,295.15 +76,22450.0,21750.0,0.1936,3166.7115109483248,301707.91203651245,700.0,53200.0,19972.68342431986,1391340.2075497063,16805.971913371537,1089632.295513194,true,76.0,76,0.875,2770.8725720797843,3166.7115109483248,395.8389388685405,0.0,0.0,76,21750.0,0.0,2770.8725720797843,2770.8725720797843,183253.74007987685,700.0,53200.0,677.4823240752954,22612.76770932407,819.8815995946654,102690.59321586264,0.0,0.0,1258.1194498521265,56022.874098121196,15.389198557696954,1927.505056569007,-2770.8725720797843,-263994.4230319484,true,true,11.17618132,502.257588625,0.0,121.92,1644.2724500334996,76.0,11.17618132,502.257588625,0.0,121.92,0.0,295.15 +77,25616.711510948324,24916.711510948324,0.25,6106.673689892849,307814.5857264053,700.0,53900.0,27226.694759571397,1418566.9023092778,21120.021069678547,1110752.3165828725,true,77.0,77,0.875,5343.339478656243,6106.673689892849,763.3342112366063,0.0,0.0,77,24916.711510948324,0.0,5343.339478656243,5343.339478656243,188597.0795585331,700.0,53900.0,698.0522652830352,23310.819974607108,3312.3877538596817,106002.98096972232,0.0,0.0,1270.7258568013397,57293.59995492254,62.173602712186515,1989.6786592811934,-5343.339478656243,-269337.76251060463,true,true,11.35500022,513.612588845,0.0,121.92,1644.2724500334996,77.0,11.35500022,513.612588845,0.0,121.92,0.0,295.15 +78,28556.67368989285,27856.67368989285,0.28625,8227.025305471001,316041.6110318763,700.0,54600.0,31186.114604265505,1449753.0169135432,22959.089298794504,1133711.405881667,true,78.0,78,0.875,7198.6471422871255,8227.025305471001,1028.3781631838756,0.0,0.0,78,27856.67368989285,0.0,7198.6471422871255,7198.6471422871255,195795.7267008202,700.0,54600.0,740.4328678133747,24051.252842420483,5067.164790159327,111070.14575988165,0.0,0.0,1295.938671827737,58589.538626750276,95.110812486687,2084.7894717678805,-7198.6471422871255,-276536.40965289174,true,true,11.62322858,525.235817425,0.0,121.92,1644.2724500334996,78.0,11.62322858,525.235817425,0.0,121.92,0.0,295.15 +79,30677.025305471,29977.025305471,0.1792,2374.5515917268317,318416.16262360313,700.0,55300.0,17157.095935975623,1466910.112849519,14782.544344248792,1148493.9502259158,true,79.0,79,0.875,2077.732642760978,2374.5515917268317,296.8189489658539,0.0,0.0,79,29977.025305471,0.0,2077.732642760978,2077.732642760978,197873.45934358117,700.0,55300.0,766.6662816918084,24817.91912411229,0.0,111070.14575988165,0.0,0.0,1311.0663610691693,59900.604987819446,0.0,2084.7894717678805,-2077.732642760978,-278614.1422956527,true,true,11.62322858,536.8590460050001,0.0,121.92,1644.2724500334996,79.0,11.62322858,536.8590460050001,0.0,121.92,0.0,295.15 +80,24824.55159172683,24124.55159172683,0.12,0.0,318416.16262360313,700.0,56000.0,5833.333333333334,1472743.4461828521,5833.333333333334,1154327.283559249,true,80.0,80,0.875,0.0,0.0,0.0,0.0,0.0,80,24124.55159172683,0.0,-539.2268287752191,-539.2268287752191,197334.23251480595,700.0,56000.0,753.4734631851496,25571.39258729744,-2548.369841420113,108521.77591846154,0.0,0.0,1303.5025164484532,61204.1075042679,-47.832966988708876,2036.9565047791716,-0.0,-278614.1422956527,true,true,11.4891144,548.348160405,0.0,121.92,1644.2724500334996,80.0,11.4891144,548.348160405,0.0,121.92,0.0,295.15 +81,22450.0,21750.0,0.25,6322.488093666218,324738.65071726934,700.0,56700.0,28089.952374664874,1500833.398557517,21767.464280998654,1176094.7478402476,true,81.0,81,0.875,5532.1770819579415,6322.488093666218,790.311011708277,0.0,0.0,81,21750.0,0.0,5532.1770819579415,5532.1770819579415,202866.4095967639,700.0,56700.0,757.8541113977777,26329.246698695217,3404.3985256986293,111926.17444416018,0.0,0.0,1306.0237976127014,62510.1313018806,63.9006472488328,2100.8571520280043,-5532.1770819579415,-284146.31937761063,true,true,11.6679333,560.016093705,0.0,121.92,1644.2724500334996,81.0,11.6679333,560.016093705,0.0,121.92,0.0,295.15 +82,28772.48809366622,28072.48809366622,0.29250000000000004,8499.104905972637,333237.755623242,700.0,57400.0,31449.93130247055,1532283.3298599876,22950.826396497912,1199045.5742367455,true,82.0,82,0.875,7436.716792726057,8499.104905972637,1062.3881132465804,0.0,0.0,82,28072.48809366622,0.0,7436.716792726057,7436.716792726057,210303.12638948995,700.0,57400.0,802.5980481462836,27131.8447468415,5205.180756800284,117131.35520096046,0.0,0.0,1331.236612075113,63841.36791395571,97.70137570437558,2198.55852773238,-7436.716792726057,-291583.0361703367,true,true,11.93616165,571.952255355,0.0,121.92,1644.2724500334996,82.0,11.93616165,571.952255355,0.0,121.92,0.0,295.15 +83,30949.104905972636,30249.104905972636,0.30500000000000005,10848.764040645998,344086.51966388803,700.0,58100.0,37864.80013326556,1570148.1299932532,27016.036092619564,1226061.6103293651,true,83.0,83,0.875,9492.668535565248,10848.764040645998,1356.0955050807497,0.0,0.0,83,30249.104905972636,0.0,9492.668535565248,9492.668535565248,219795.7949250552,700.0,58100.0,868.1488434808566,27999.993590322356,7124.262549804632,124255.61775076509,0.0,0.0,1366.5345523224894,65207.9024662782,133.72258995727063,2332.2811176896503,-9492.668535565248,-301075.70470590197,true,true,12.29379945,584.2460548050001,0.0,121.92,1644.2724500334996,83.0,12.29379945,584.2460548050001,0.0,121.92,0.0,295.15 +84,33298.764040646,32598.764040645998,0.335,14521.940645622575,358608.4603095106,700.0,58800.0,45438.628792903204,1615586.7587861563,30916.688147280627,1256978.2984766457,true,84.0,84,0.875,12706.698064919754,14521.940645622575,1815.2425807028212,0.0,0.0,84,32598.764040645998,0.0,12706.698064919754,12706.698064919754,232502.49298997497,700.0,58800.0,962.6865743357127,28962.680164658068,10139.258450508301,134394.87620127338,0.0,0.0,1414.438900083064,66622.34136636127,190.31413999267747,2522.595257682328,-12706.698064919754,-313782.4027708217,true,true,12.78555143,597.0316062350001,0.0,121.92,1644.2724500334996,84.0,12.78555143,597.0316062350001,0.0,121.92,0.0,295.15 +85,36971.94064562258,36271.94064562258,0.30500000000000005,10631.374938366644,369239.8352478772,700.0,59500.0,37152.04897825128,1652738.8077644075,26520.674039884638,1283498.9725165304,true,85.0,85,0.875,9302.453071070813,10631.374938366644,1328.9218672958305,0.0,0.0,85,36271.94064562258,0.0,9302.453071070813,9302.453071070813,241804.94606104578,700.0,59500.0,1058.3566009598244,30021.036765617893,6659.2796542950355,141054.15585556842,0.0,0.0,1459.8219666793902,68082.16333304066,124.99484913656153,2647.5901068188896,-9302.453071070813,-323084.85584189254,true,true,13.09848451,610.1300907450002,0.0,121.92,1644.2724500334996,85.0,13.09848451,610.1300907450002,0.0,121.92,0.0,295.15 +86,33081.37493836664,32381.374938366644,0.29250000000000004,8642.234876097113,377882.07012397435,700.0,60200.0,31939.264533665337,1684678.0722980727,23297.029657568222,1306796.0021740987,true,86.0,86,0.875,7561.955516584974,8642.234876097113,1080.2793595121384,0.0,0.0,86,32381.374938366644,0.0,7561.955516584974,7561.955516584974,249366.90157763075,700.0,60200.0,1125.534404219617,31146.57116983751,4855.211327191917,145909.36718276032,0.0,0.0,1490.0773445982697,69572.24067763893,91.13244057516951,2738.722547394059,-7561.955516584974,-330646.8113584775,true,true,13.32200814,623.4520988850002,0.0,121.92,1644.2724500334996,86.0,13.32200814,623.4520988850002,0.0,121.92,0.0,295.15 +87,31092.234876097114,30392.234876097114,0.265,6502.9598983135575,384385.0300222879,700.0,60900.0,27180.980748353046,1711859.0530464258,20678.020850039487,1327474.0230241383,true,87.0,87,0.875,5690.089911024363,6502.9598983135575,812.8699872891948,0.0,0.0,87,30392.234876097114,0.0,5690.089911024363,5690.089911024363,255056.9914886551,700.0,60900.0,1171.8628834918766,32318.434053329387,2952.5598083759955,148861.9269911363,0.0,0.0,1510.247596168199,71082.48827380712,55.419622988292,2794.1421703823507,-5690.089911024363,-336336.9012695019,true,true,13.45612231,636.9082211950001,0.0,121.92,1644.2724500334996,87.0,13.45612231,636.9082211950001,0.0,121.92,0.0,295.15 +88,28952.95989831356,28252.95989831356,0.265,6595.332943626811,390980.3629659147,700.0,61600.0,27529.558277837023,1739388.6113242628,20934.225334210212,1348408.2483583486,true,88.0,88,0.875,5770.91632567346,6595.332943626811,824.4166179533513,0.0,0.0,88,28252.95989831356,0.0,5770.91632567346,5770.91632567346,260827.90781432856,700.0,61600.0,1207.4313721302067,33525.8654254596,2982.134920107009,151844.0619112433,0.0,0.0,1525.3752848456459,72607.86355865277,55.97474859059799,2850.116918972949,-5770.91632567346,-342107.81759517535,true,true,13.59023649,650.4984576850002,0.0,121.92,1644.2724500334996,88.0,13.59023649,650.4984576850002,0.0,121.92,0.0,295.15 +89,29045.33294362681,28345.33294362681,0.265,6688.519795461676,397668.8827613764,700.0,62300.0,27881.20677532708,1767269.8180995898,21192.6869798654,1369600.935338214,true,89.0,89,0.875,5852.454821028967,6688.519795461676,836.0649744327093,0.0,0.0,89,28345.33294362681,0.0,5852.454821028967,5852.454821028967,266680.36263535754,700.0,62300.0,1243.712394538102,34769.5778199977,3011.7095871221964,154855.7714983655,0.0,0.0,1540.5029735230928,74148.36653217586,56.52986584557609,2906.6467848185252,-5852.454821028967,-347960.27241620433,true,true,13.72435066,664.2228083450002,0.0,121.92,1644.2724500334996,89.0,13.72435066,664.2228083450002,0.0,121.92,0.0,295.15 +90,29138.519795461674,28438.519795461674,0.1936,3211.644721213193,400880.5274825896,700.0,63000.0,20204.776452547485,1787474.5945521372,16993.13173133429,1386594.0670695484,true,90.0,90,0.875,2810.189131061544,3211.644721213193,401.4555901516492,0.0,0.0,90,28438.519795461674,0.0,2810.189131061544,2810.189131061544,269490.5517664191,700.0,63000.0,1262.1223134817203,36031.70013347942,0.0,154855.7714983655,0.0,0.0,1548.0668175798237,75696.43334975568,0.0,2906.6467848185252,-2810.189131061544,-350770.4615472659,true,true,13.72435066,677.9471590050002,0.0,121.92,1644.2724500334996,90.0,13.72435066,677.9471590050002,0.0,121.92,0.0,295.15 +91,25661.644721213193,24961.644721213193,0.14400000000000002,850.2999225942492,401730.82740518387,700.0,63700.0,10765.971684682285,1798240.5662368194,9915.671762088035,1396509.7388316365,true,91.0,91,0.875,744.012432269968,850.2999225942492,106.28749032428118,0.0,0.0,91,24961.644721213193,0.0,744.012432269968,744.012432269968,270234.56419868907,700.0,63700.0,1249.8290012155803,37281.529134694996,-2011.0925648434115,152844.67893352208,0.0,0.0,1543.0242546873412,77239.45760444301,-37.748258789542064,2868.8985260289833,-744.012432269968,-351514.47397953586,true,true,13.63494121,691.5821002150002,0.0,121.92,1644.2724500334996,91.0,13.63494121,691.5821002150002,0.0,121.92,0.0,295.15 +92,23300.299922594248,22600.299922594248,0.17200000000000001,1997.2581658039267,403728.0855709878,700.0,64400.0,15681.733522115852,1813922.299758935,13684.475356311925,1410194.2141879485,true,92.0,92,0.875,1747.6008950784358,1997.2581658039267,249.6572707254909,0.0,0.0,92,22600.299922594248,0.0,1747.6008950784358,1747.6008950784358,271982.1650937675,700.0,64400.0,1231.539113782644,38513.06824847764,-1000.6170222787847,151844.0619112433,0.0,0.0,1535.4604106306106,78774.91801507362,-18.781607056034026,2850.1169189729494,-1747.6008950784358,-353262.0748746143,true,true,13.59023649,705.1723367050002,0.0,121.92,1644.2724500334996,92.0,13.59023649,705.1723367050002,0.0,121.92,0.0,295.15 +93,24447.258165803927,23747.258165803927,0.17200000000000001,1981.4997677005383,405709.58533868834,700.0,65100.0,15590.114928491503,1829512.4146874265,13608.615160790965,1423802.8293487395,true,93.0,93,0.875,1733.812296737971,1981.4997677005383,247.6874709625672,0.0,0.0,93,23747.258165803927,0.0,1733.812296737971,1733.812296737971,273715.9773905055,700.0,65100.0,1219.4455268868091,39732.51377536445,-997.3311467976091,150846.7307644457,0.0,0.0,1530.417847738128,80305.33586281174,-18.719931089357086,2831.3969878835924,-1733.812296737971,-354995.8871713523,true,true,13.54553176,718.7178684650003,0.0,121.92,1644.2724500334996,93.0,13.54553176,718.7178684650003,0.0,121.92,0.0,295.15 +94,24431.499767700538,23731.499767700538,0.20800000000000002,4303.902231442175,410013.4875701305,700.0,65800.0,24057.222266548917,1853569.6369539755,19753.320035106743,1443556.1493838462,true,94.0,94,0.875,3765.914452511903,4303.902231442175,537.9877789302723,0.0,0.0,94,23731.499767700538,0.0,3765.914452511903,3765.914452511903,277481.89184301737,700.0,65800.0,1219.4455268868091,40951.95930225126,997.3311467976091,151844.0619112433,0.0,0.0,1530.417847738128,81835.75371054986,18.719931089357086,2850.1169189729494,-3765.914452511903,-358761.80162386416,true,true,13.59023649,732.3081049550003,0.0,121.92,1644.2724500334996,94.0,13.59023649,732.3081049550003,0.0,121.92,0.0,295.15 +95,26753.902231442175,26053.902231442175,0.28625,7874.897036115319,417888.3846062458,700.0,66500.0,29955.972178568798,1883525.6091325444,22081.07514245348,1465637.2245262996,true,95.0,95,0.875,6890.534906600904,7874.897036115319,984.3621295144148,0.0,0.0,95,26053.902231442175,0.0,6890.534906600904,6890.534906600904,284372.42674961826,700.0,66500.0,1249.8290025860426,42201.788304837304,4022.1851311568576,155866.24704240015,0.0,0.0,1543.0242552513266,83378.77796580119,75.49651760667783,2925.6134365796274,-6890.534906600904,-365652.33653046505,true,true,13.76905539,746.0771603450003,0.0,121.92,1644.2724500334996,95.0,13.76905539,746.0771603450003,0.0,121.92,0.0,295.15 +96,30324.89703611532,29624.89703611532,0.12,0.0,417888.3846062458,700.0,67200.0,5833.333333333334,1889358.9424658776,5833.333333333334,1471470.557859633,true,96.0,96,0.875,0.0,0.0,0.0,0.0,0.0,96,29624.89703611532,0.0,-1304.828390926166,-1304.828390926166,283067.5983586921,700.0,67200.0,1249.8290025860426,43451.617307423345,-4022.1851311568576,151844.0619112433,0.0,0.0,1543.0242552513266,84921.80222105251,-75.49651760667783,2850.1169189729494,-0.0,-365652.33653046505,true,true,13.59023649,759.6673968350003,0.0,121.92,1644.2724500334996,96.0,13.59023649,759.6673968350003,0.0,121.92,0.0,295.15 +97,22450.0,21750.0,0.12,0.0,417888.3846062458,700.0,67900.0,5833.333333333334,1895192.2757992109,5833.333333333334,1477303.8911929661,true,97.0,97,0.875,0.0,0.0,0.0,0.0,0.0,97,21750.0,0.0,-2330.948033351541,-2330.948033351541,280736.6503253405,700.0,67900.0,1195.4963877924445,44647.11369521579,-4953.7942976494605,146890.26761359384,0.0,0.0,1520.3327219531636,86442.13494300567,-92.98284544768867,2757.1340735252606,-0.0,-365652.33653046505,true,true,13.36671286,773.0341096950003,0.0,121.92,1644.2724500334996,97.0,13.36671286,773.0341096950003,0.0,121.92,0.0,295.15 +98,22450.0,21750.0,0.12,0.0,417888.3846062458,700.0,68600.0,5833.333333333334,1901025.6091325441,5833.333333333334,1483137.2245262994,true,98.0,98,0.875,0.0,0.0,0.0,0.0,0.0,98,21750.0,0.0,-1336.7587367285128,-1336.7587367285128,279399.891588612,700.0,68600.0,1142.7616741821616,45789.87536939795,-3903.885567783944,142986.3820458099,0.0,0.0,1497.6411886550004,87939.77613166068,-73.27603178173038,2683.85804174353,-0.0,-365652.33653046505,true,true,13.18789396,786.2220036550003,0.0,121.92,1644.2724500334996,98.0,13.18789396,786.2220036550003,0.0,121.92,0.0,295.15 +99,22450.0,21750.0,0.25,6411.393614016264,424299.77822026203,700.0,69300.0,28445.574456065056,1929471.183588609,22034.180842048794,1505171.4053683481,true,99.0,99,0.875,5609.969412264231,6411.393614016264,801.4242017520328,0.0,0.0,99,21750.0,0.0,5609.969412264231,5609.969412264231,285009.86100087623,700.0,69300.0,1136.9998621725501,46926.875231570506,2922.985136950401,145909.3671827603,0.0,0.0,1495.1199074907518,89434.89603915143,54.864505650529075,2738.7225473940593,-5609.969412264231,-371262.3059427293,true,true,13.32200814,799.5440117950003,0.0,121.92,1644.2724500334996,99.0,13.32200814,799.5440117950003,0.0,121.92,0.0,295.15 +100,28861.393614016262,28161.393614016262,0.29250000000000004,8833.106849587131,433132.88506984914,700.0,70000.0,32591.81828918677,1962063.001877796,23758.71143959964,1528930.1168079479,true,100.0,100,0.875,7728.96849338874,8833.106849587131,1104.1383561983912,0.0,0.0,100,28161.393614016262,0.0,7728.96849338874,7728.96849338874,292738.82949426497,700.0,70000.0,1183.640312153131,48110.51554372364,4937.363581685395,150846.7307644457,0.0,0.0,1515.2901590606812,90950.1861982121,92.6744404895329,2831.3969878835924,-7728.96849338874,-378991.274436118,true,true,13.54553176,813.0895435550003,0.0,121.92,1644.2724500334996,100.0,13.54553176,813.0895435550003,0.0,121.92,0.0,295.15 +101,31283.10684958713,30583.10684958713,0.28625,7839.8719977591245,440972.7570676083,700.0,70700.0,29833.61396597074,1991896.6158437666,21993.741968211616,1550923.8587761596,true,101.0,101,0.875,6859.887998039234,7839.8719977591245,979.9839997198906,0.0,0.0,101,30583.10684958713,0.0,6859.887998039234,6859.887998039234,299598.7174923042,700.0,70700.0,1237.6157753896364,49348.13131911327,4009.0407339198055,154855.7714983655,0.0,0.0,1537.981691794859,92488.16789000697,75.24979693493317,2906.6467848185257,-6859.887998039234,-385851.1624341573,true,true,13.72435066,826.8138942150003,0.0,121.92,1644.2724500334996,101.0,13.72435066,826.8138942150003,0.0,121.92,0.0,295.15 +102,30289.871997759124,29589.871997759124,0.23500000000000001,5588.385479342606,446561.1425469509,700.0,71400.0,26759.087146138747,2018655.7029899054,21170.70166679614,1572094.5604429557,true,102.0,102,0.875,4889.83729442478,5588.385479342606,698.5481849178259,0.0,0.0,102,29589.871997759124,0.0,4889.83729442478,4889.83729442478,304488.554786729,700.0,71400.0,1274.495973908446,50622.62729302172,2024.2369606103357,156880.00845897585,0.0,0.0,1553.109380472306,94041.27727047927,37.99497943369265,2944.6417642522183,-4889.83729442478,-390740.99972858204,true,true,13.81376011,840.6276543250003,0.0,121.92,1644.2724500334996,102.0,13.81376011,840.6276543250003,0.0,121.92,0.0,295.15 +103,28038.385479342607,27338.385479342607,0.20800000000000002,4445.73562332253,451006.87817027344,700.0,72100.0,24739.113573666007,2043394.8165635713,20293.377950343478,1592387.9383932992,true,103.0,103,0.875,3890.018670407214,4445.73562332253,555.7169529153161,0.0,0.0,103,27338.385479342607,0.0,3890.018670407214,3890.018670407214,308378.5734571362,700.0,72100.0,1293.207690563985,51915.8349835857,1017.0477426532339,157897.05620162908,0.0,0.0,1560.673225093022,95601.9504955723,19.09001209697313,2963.7317763491915,-3890.018670407214,-394631.0183989893,true,true,13.85846484,854.4861191650003,0.0,121.92,1644.2724500334996,103.0,13.85846484,854.4861191650003,0.0,121.92,0.0,295.15 +104,26895.73562332253,26195.73562332253,0.1744,2077.420755322057,453084.2989255955,700.0,72800.0,15925.577725470512,2059320.3942890419,13848.156970148455,1606236.0953634477,true,104.0,104,0.875,1817.7431609067999,2077.420755322057,259.6775944152573,0.0,0.0,104,26195.73562332253,0.0,1817.7431609067999,1817.7431609067999,310196.316618043,700.0,72800.0,1293.207690563985,53209.042674149685,-1017.0477426532339,156880.00845897585,0.0,0.0,1560.673225093022,97162.62372066532,-19.09001209697313,2944.6417642522183,-1817.7431609067999,-396448.76155989605,true,true,13.81376011,868.2998792750003,0.0,121.92,1644.2724500334996,104.0,13.81376011,868.2998792750003,0.0,121.92,0.0,295.15 +105,24527.42075532206,23827.42075532206,0.12,0.0,453084.2989255955,700.0,73500.0,5833.333333333334,2065153.7276223751,5833.333333333334,1612069.428696781,true,105.0,105,0.875,0.0,0.0,0.0,0.0,0.0,105,23827.42075532206,0.0,-2328.960225722652,-2328.960225722652,307867.35639232036,700.0,73500.0,1255.9656308735734,54465.00830502326,-5035.946547732532,151844.0619112433,0.0,0.0,1545.545536415575,98708.1692570809,-94.52484527926875,2850.1169189729494,-0.0,-396448.76155989605,true,true,13.59023649,881.8901157650004,0.0,121.92,1644.2724500334996,105.0,13.59023649,881.8901157650004,0.0,121.92,0.0,295.15 +106,22450.0,21750.0,0.12,0.0,453084.2989255955,700.0,74200.0,5833.333333333334,2070987.0609557084,5833.333333333334,1617902.7620301142,true,106.0,106,0.875,0.0,0.0,0.0,0.0,0.0,106,21750.0,0.0,-3338.719155866952,-3338.719155866952,304528.6372364534,700.0,74200.0,1189.5585034060268,55654.566808429285,-5934.694728483004,145909.3671827603,0.0,0.0,1517.8114407889152,100225.98069786982,-111.39437157888999,2738.7225473940593,-0.0,-396448.76155989605,true,true,13.32200814,895.2121239050003,0.0,121.92,1644.2724500334996,106.0,13.32200814,895.2121239050003,0.0,121.92,0.0,295.15 +107,22450.0,21750.0,0.20800000000000002,4188.206663232858,457272.50558882835,700.0,74900.0,23500.993573234893,2094488.0545289433,19312.786910002036,1637215.5489401163,true,107.0,107,0.875,3664.6808303287507,4188.206663232858,523.5258329041071,0.0,0.0,107,21750.0,0.0,3664.6808303287507,3664.6808303287507,308193.31806678214,700.0,74900.0,1160.1638400882891,56814.73064851757,980.9004308335434,146890.26761359384,0.0,0.0,1505.2050332757167,101731.18573114554,18.411526131201306,2757.1340735252606,-3664.6808303287507,-400113.4423902248,true,true,13.36671286,908.5788367650003,0.0,121.92,1644.2724500334996,107.0,13.36671286,908.5788367650003,0.0,121.92,0.0,295.15 +108,26638.206663232857,25938.206663232857,0.265,6533.661102338143,463806.1666911665,700.0,75600.0,27296.83434844582,2121784.888877389,20763.173246107675,1657978.722186224,true,108.0,108,0.875,5716.953464545875,6533.661102338143,816.7076377922676,0.0,0.0,108,25938.206663232857,0.0,5716.953464545875,5716.953464545875,313910.27153132804,700.0,75600.0,1183.6403121531314,57998.370960670705,2962.418325721488,149852.68593931533,0.0,0.0,1515.2901590606812,103246.47589020622,55.60466761057527,2812.738741135836,-5716.953464545875,-405830.3958547707,true,true,13.50082704,922.0796638050003,0.0,121.92,1644.2724500334996,108.0,13.50082704,922.0796638050003,0.0,121.92,0.0,295.15 +109,28983.66110233814,28283.66110233814,0.29250000000000004,8987.420716738416,472793.5874079049,700.0,76300.0,33119.38706577236,2154904.2759431615,24131.966349033944,1682110.688535258,true,109.0,109,0.875,7863.993127146114,8987.420716738416,1123.427589592302,0.0,0.0,109,28283.66110233814,0.0,7863.993127146114,7863.993127146114,321774.26465847413,700.0,76300.0,1231.5391137826448,59229.91007445335,5003.085559050169,154855.7714983655,0.0,0.0,1535.4604106306106,104781.93630083682,93.90804368268951,2906.6467848185252,-7863.993127146114,-413694.38898191677,true,true,13.72435066,935.8040144650004,0.0,121.92,1644.2724500334996,109.0,13.72435066,935.8040144650004,0.0,121.92,0.0,295.15 +110,31437.420716738416,30737.420716738416,0.29250000000000004,9182.364829555214,481975.9522374601,700.0,77000.0,33785.86266514603,2188690.1386083076,24603.497835590817,1706714.1863708487,true,110.0,110,0.875,8034.569225860812,9182.364829555214,1147.7956036944015,0.0,0.0,110,30737.420716738416,0.0,8034.569225860812,8034.569225860812,329808.83388433495,700.0,77000.0,1293.207690563985,60523.117765017334,5085.2382582594255,159941.00975662493,0.0,0.0,1560.673225093022,106342.60952592985,95.45005194438004,3002.0968367629052,-8034.569225860812,-421728.9582077776,true,true,13.94787429,949.7518887550003,0.0,121.92,1644.2724500334996,110.0,13.94787429,949.7518887550003,0.0,121.92,0.0,295.15 +111,31632.364829555212,30932.364829555212,0.30500000000000005,10604.677939812895,492580.630177273,700.0,77700.0,37064.517835452105,2225754.65644376,26459.839895639212,1733174.0262664878,true,111.0,111,0.875,9279.093197336282,10604.677939812895,1325.5847424766125,0.0,0.0,111,30932.364829555212,0.0,9279.093197336282,9279.093197336282,339087.92708167125,700.0,77700.0,1363.3833313570601,61886.50109637439,6210.72703958951,166151.73679621445,0.0,0.0,1588.4073212836674,107931.01684721351,116.57550510604513,3118.6723418689503,-9279.093197336282,-431008.0514051139,true,true,14.21610264,963.9679913950004,0.0,121.92,1644.2724500334996,111.0,14.21610264,963.9679913950004,0.0,121.92,0.0,295.15 +112,33054.67793981289,32354.677939812893,0.28625,8374.993985761574,500955.6241630346,700.0,78400.0,31703.035758119033,2257457.692201879,23328.041772357457,1756502.0680388452,true,112.0,112,0.875,7328.119737541377,8374.993985761574,1046.874248220197,0.0,0.0,112,32354.677939812893,0.0,7328.119737541377,7328.119737541377,346416.0468192126,700.0,78400.0,1429.3423232759949,63315.84341965039,4206.206671894521,170357.94346810898,0.0,0.0,1613.620135746079,109544.6369829596,78.95060662478151,3197.6229484937317,-7328.119737541377,-438336.17114265525,true,true,14.39492154,978.3629129350004,0.0,121.92,1644.2724500334996,112.0,14.39492154,978.3629129350004,0.0,121.92,0.0,295.15 +113,30824.993985761575,30124.993985761575,0.25,6012.952879168578,506968.57704220316,700.0,79100.0,26851.811516674312,2284309.503718553,20838.858637505735,1777340.9266763509,true,113.0,113,0.875,5261.333769272505,6012.952879168578,751.6191098960726,0.0,0.0,113,30124.993985761575,0.0,5261.333769272505,5261.333769272505,351677.3805884851,700.0,79100.0,1469.9206309726349,64785.764050623024,2122.8199295977283,172480.7633977067,0.0,0.0,1628.7478244235263,111173.38480738312,39.84538427861551,3237.4683327723474,-5261.333769272505,-443597.50491192774,true,true,14.48433099,992.8472439250004,0.0,121.92,1644.2724500334996,113.0,14.48433099,992.8472439250004,0.0,121.92,0.0,295.15 +114,28462.952879168577,27762.952879168577,0.15200000000000002,1069.7178760226484,508038.2949182258,700.0,79800.0,11642.880763306895,2295952.38448186,10573.162887284247,1787914.0895636352,true,114.0,114,0.875,936.0031415198173,1069.7178760226484,133.7147345028311,0.0,0.0,114,27762.952879168577,0.0,936.0031415198173,936.0031415198173,352613.3837300049,700.0,79800.0,1469.9206309726349,66255.68468159565,-2122.8199295977283,170357.94346810898,0.0,0.0,1628.7478244235263,112802.13263180664,-39.84538427861551,3197.6229484937317,-936.0031415198173,-444533.5080534476,true,true,14.39492154,1007.2421654650004,0.0,121.92,1644.2724500334996,114.0,14.39492154,1007.2421654650004,0.0,121.92,0.0,295.15 +115,23519.71787602265,22819.71787602265,0.12,0.0,508038.2949182258,700.0,80500.0,5833.333333333334,2301785.7178151933,5833.333333333334,1793747.4228969684,true,115.0,115,0.875,0.0,0.0,0.0,0.0,0.0,115,22819.71787602265,0.0,-2314.3254318272693,-2314.3254318272693,350299.0582981776,700.0,80500.0,1422.6527452880216,67678.33742688368,-5249.542976005601,165108.40049210336,0.0,0.0,1611.098854581831,114413.23148638847,-98.53405569152058,3099.088892802211,-0.0,-444533.5080534476,true,true,14.17139792,1021.4135633850004,0.0,121.92,1644.2724500334996,115.0,14.17139792,1021.4135633850004,0.0,121.92,0.0,295.15 +116,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,81200.0,5833.333333333334,2307619.051148527,5833.333333333334,1799580.7562303017,true,116.0,116,0.875,0.0,0.0,0.0,0.0,0.0,116,21750.0,0.0,-28574.188816204285,-28574.188816204285,321724.86948197335,700.0,81200.0,1195.4963877924445,68873.83381467612,-30713.52429083001,134394.87620127335,0.0,0.0,1520.3327219531636,115933.56420834163,-576.4936351198833,2522.5952576823274,-0.0,-444533.5080534476,true,true,12.78555143,1034.1991148150005,0.0,121.92,1644.2724500334996,116.0,12.78555143,1034.1991148150005,0.0,121.92,0.0,295.15 +117,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,81900.0,5833.333333333334,2313452.3844818603,5833.333333333334,1805414.089563635,true,117.0,117,0.875,0.0,0.0,0.0,0.0,0.0,117,21750.0,0.0,-27560.6903015671,-27560.6903015671,294164.17918040627,700.0,81900.0,853.812733185085,69727.64654786121,-29224.92122544256,105169.9549758308,0.0,0.0,1358.9707082657585,117292.53491660739,-548.5525175753874,1974.04274010694,-0.0,-444533.5080534476,true,true,11.3102955,1045.5094103150004,0.0,121.92,1644.2724500334996,117.0,11.3102955,1045.5094103150004,0.0,121.92,0.0,295.15 +118,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,82600.0,5833.333333333334,2319285.717815194,5833.333333333334,1811247.4228969682,true,118.0,118,0.875,0.0,0.0,0.0,0.0,0.0,118,21750.0,0.0,-24358.171006350192,-24358.171006350192,269806.00817405607,700.0,82600.0,577.005235964974,70304.65178382618,-25646.359550655226,79523.59542517558,0.0,0.0,1192.5661319114654,118485.10104851885,-481.38282357140747,1492.6599165355326,-0.0,-444533.5080534476,true,true,9.835039564,1055.3444498790004,0.0,121.92,1644.2724500334996,118.0,9.835039564,1055.3444498790004,0.0,121.92,0.0,295.15 +119,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,83300.0,5833.333333333334,2325119.0511485273,5833.333333333334,1817080.7562303015,true,119.0,119,0.875,0.0,0.0,0.0,0.0,0.0,119,21750.0,0.0,-21088.24587387048,-21088.24587387048,248717.7623001856,700.0,83300.0,367.6034337806858,70672.25521760687,-22067.79773598453,57455.797689191044,0.0,0.0,1026.1615552751796,119511.26260379402,-414.21312694181347,1078.4467895937191,-0.0,-444533.5080534476,true,true,8.359783629,1063.7042335080005,0.0,121.92,1644.2724500334996,119.0,8.359783629,1063.7042335080005,0.0,121.92,0.0,295.15 +120,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,84000.0,5833.333333333334,2330952.384481861,5833.333333333334,1822914.0895636347,true,120.0,120,0.875,0.0,0.0,0.0,0.0,0.0,120,21750.0,0.0,-17760.32049893756,-17760.32049893756,230957.44180124803,700.0,84000.0,216.20188135059425,70888.45709895747,-18489.23592859103,38966.561760600016,0.0,0.0,859.7569787516909,120371.0195825457,-347.0434304488127,731.4033591449064,-0.0,-444533.5080534476,true,true,6.884527695,1070.5887612030006,0.0,121.92,1644.2724500334996,120.0,6.884527695,1070.5887612030006,0.0,121.92,0.0,295.15 +121,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,84700.0,5833.333333333334,2336785.7178151943,5833.333333333334,1828747.422896968,true,121.0,121,0.875,0.0,0.0,0.0,0.0,0.0,121,21750.0,0.0,-14383.800345829519,-14383.800345829519,216573.64145541852,700.0,84700.0,113.3951326318685,71001.85223158934,-14910.674146263293,24055.887614336723,0.0,0.0,693.352402228202,121064.37198477391,-279.87373442629723,451.52962471860917,-0.0,-444533.5080534476,true,true,5.40927176,1075.9980329630005,0.0,121.92,1644.2724500334996,121.0,5.40927176,1075.9980329630005,0.0,121.92,0.0,295.15 +122,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,85400.0,5833.333333333334,2342619.051148528,5833.333333333334,1834580.7562303012,true,122.0,122,0.875,0.0,0.0,0.0,0.0,0.0,122,21750.0,0.0,-10968.09082095786,-10968.09082095786,205605.55063446067,700.0,85400.0,49.777741729420754,71051.62997331876,-11332.11235018982,12723.775264146903,0.0,0.0,526.9478256483147,121591.31981042222,-212.70403814577358,238.8255865728356,-0.0,-444533.5080534476,true,true,3.934015825,1079.9320487880004,0.0,121.92,1644.2724500334996,122.0,3.934015825,1079.9320487880004,0.0,121.92,0.0,295.15 +123,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,86100.0,5833.333333333334,2348452.3844818613,5833.333333333334,1840414.0895636345,true,123.0,123,0.875,0.0,0.0,0.0,0.0,0.0,123,21750.0,0.0,-7522.59737993339,-7522.59737993339,198082.95325452727,700.0,86100.0,15.944262804612375,71067.57423612337,-7753.5505500734635,4970.22471407344,0.0,0.0,360.54324912482593,121951.86305954705,-145.534341789365,93.2912447834706,-0.0,-444533.5080534476,true,true,2.458759891,1082.3908086790004,0.0,121.92,1644.2724500334996,123.0,2.458759891,1082.3908086790004,0.0,121.92,0.0,295.15 +124,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,86800.0,5833.333333333334,2354285.7178151947,5833.333333333334,1846247.4228969677,true,124.0,124,0.875,0.0,0.0,0.0,0.0,0.0,124,21750.0,0.0,-4056.725483546832,-4056.725483546832,194026.22777098045,700.0,86800.0,2.489249950667005,71070.06348607404,-4174.988760468579,795.2359536048607,0.0,0.0,194.13867260133713,122146.00173214839,-78.36464563025704,14.926599153213559,-0.0,-444533.5080534476,true,true,0.983503956,1083.3743126350005,0.0,121.92,1644.2724500334996,124.0,0.983503956,1083.3743126350005,0.0,121.92,0.0,295.15 +125,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,87500.0,5833.333333333334,2360119.0511485282,5833.333333333334,1852080.756230301,true,125.0,125,0.875,0.0,0.0,0.0,0.0,0.0,125,21750.0,0.0,-754.636302294577,-754.636302294577,193271.59146868586,700.0,87500.0,0.05805830783667814,71070.12154438188,-795.2359536048966,-3.5925040720030665e-11,0.0,0.0,55.46819215569674,122201.46992430408,-14.926599153213761,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,125.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +126,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,88200.0,5833.333333333334,2365952.3844818617,5833.333333333334,1857914.0895636342,true,126.0,126,0.875,0.0,0.0,0.0,0.0,0.0,126,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,88200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,126.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +127,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,88900.0,5833.333333333334,2371785.717815195,5833.333333333334,1863747.4228969675,true,127.0,127,0.875,0.0,0.0,0.0,0.0,0.0,127,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,88900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,127.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +128,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,89600.0,5833.333333333334,2377619.0511485287,5833.333333333334,1869580.7562303008,true,128.0,128,0.875,0.0,0.0,0.0,0.0,0.0,128,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,89600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,128.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +129,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,90300.0,5833.333333333334,2383452.384481862,5833.333333333334,1875414.089563634,true,129.0,129,0.875,0.0,0.0,0.0,0.0,0.0,129,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,90300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,129.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +130,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,91000.0,5833.333333333334,2389285.7178151957,5833.333333333334,1881247.4228969673,true,130.0,130,0.875,0.0,0.0,0.0,0.0,0.0,130,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,91000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,130.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +131,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,91700.0,5833.333333333334,2395119.051148529,5833.333333333334,1887080.7562303005,true,131.0,131,0.875,0.0,0.0,0.0,0.0,0.0,131,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,91700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,131.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +132,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,92400.0,5833.333333333334,2400952.3844818627,5833.333333333334,1892914.0895636338,true,132.0,132,0.875,0.0,0.0,0.0,0.0,0.0,132,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,92400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,132.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +133,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,93100.0,5833.333333333334,2406785.717815196,5833.333333333334,1898747.422896967,true,133.0,133,0.875,0.0,0.0,0.0,0.0,0.0,133,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,93100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,133.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +134,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,93800.0,5833.333333333334,2412619.0511485296,5833.333333333334,1904580.7562303003,true,134.0,134,0.875,0.0,0.0,0.0,0.0,0.0,134,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,93800.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,134.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +135,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,94500.0,5833.333333333334,2418452.384481863,5833.333333333334,1910414.0895636335,true,135.0,135,0.875,0.0,0.0,0.0,0.0,0.0,135,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,94500.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,135.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +136,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,95200.0,5833.333333333334,2424285.7178151966,5833.333333333334,1916247.4228969668,true,136.0,136,0.875,0.0,0.0,0.0,0.0,0.0,136,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,95200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,136.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +137,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,95900.0,5833.333333333334,2430119.05114853,5833.333333333334,1922080.7562303,true,137.0,137,0.875,0.0,0.0,0.0,0.0,0.0,137,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,95900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,137.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +138,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,96600.0,5833.333333333334,2435952.3844818636,5833.333333333334,1927914.0895636333,true,138.0,138,0.875,0.0,0.0,0.0,0.0,0.0,138,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,96600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,138.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +139,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,97300.0,5833.333333333334,2441785.717815197,5833.333333333334,1933747.4228969666,true,139.0,139,0.875,0.0,0.0,0.0,0.0,0.0,139,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,97300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,139.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +140,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,98000.0,5833.333333333334,2447619.0511485306,5833.333333333334,1939580.7562302998,true,140.0,140,0.875,0.0,0.0,0.0,0.0,0.0,140,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,98000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,140.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +141,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,98700.0,5833.333333333334,2453452.384481864,5833.333333333334,1945414.089563633,true,141.0,141,0.875,0.0,0.0,0.0,0.0,0.0,141,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,98700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,141.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +142,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,99400.0,5833.333333333334,2459285.7178151975,5833.333333333334,1951247.4228969663,true,142.0,142,0.875,0.0,0.0,0.0,0.0,0.0,142,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,99400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,142.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +143,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,100100.0,5833.333333333334,2465119.051148531,5833.333333333334,1957080.7562302996,true,143.0,143,0.875,0.0,0.0,0.0,0.0,0.0,143,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,100100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,143.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +144,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,100800.0,5833.333333333334,2470952.3844818645,5833.333333333334,1962914.0895636328,true,144.0,144,0.875,0.0,0.0,0.0,0.0,0.0,144,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,100800.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,144.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +145,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,101500.0,5833.333333333334,2476785.717815198,5833.333333333334,1968747.422896966,true,145.0,145,0.875,0.0,0.0,0.0,0.0,0.0,145,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,101500.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,145.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +146,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,102200.0,5833.333333333334,2482619.0511485315,5833.333333333334,1974580.7562302994,true,146.0,146,0.875,0.0,0.0,0.0,0.0,0.0,146,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,102200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,146.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +147,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,102900.0,5833.333333333334,2488452.384481865,5833.333333333334,1980414.0895636326,true,147.0,147,0.875,0.0,0.0,0.0,0.0,0.0,147,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,102900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,147.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +148,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,103600.0,5833.333333333334,2494285.7178151985,5833.333333333334,1986247.4228969659,true,148.0,148,0.875,0.0,0.0,0.0,0.0,0.0,148,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,103600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,148.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +149,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,104300.0,5833.333333333334,2500119.051148532,5833.333333333334,1992080.7562302991,true,149.0,149,0.875,0.0,0.0,0.0,0.0,0.0,149,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,104300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,149.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +150,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,105000.0,5833.333333333334,2505952.3844818654,5833.333333333334,1997914.0895636324,true,150.0,150,0.875,0.0,0.0,0.0,0.0,0.0,150,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,105000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,150.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +151,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,105700.0,5833.333333333334,2511785.717815199,5833.333333333334,2003747.4228969656,true,151.0,151,0.875,0.0,0.0,0.0,0.0,0.0,151,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,105700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,151.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +152,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,106400.0,5833.333333333334,2517619.0511485324,5833.333333333334,2009580.756230299,true,152.0,152,0.875,0.0,0.0,0.0,0.0,0.0,152,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,106400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,152.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +153,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,107100.0,5833.333333333334,2523452.384481866,5833.333333333334,2015414.0895636322,true,153.0,153,0.875,0.0,0.0,0.0,0.0,0.0,153,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,107100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,153.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +154,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,107800.0,5833.333333333334,2529285.7178151994,5833.333333333334,2021247.4228969654,true,154.0,154,0.875,0.0,0.0,0.0,0.0,0.0,154,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,107800.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,154.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +155,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,108500.0,5833.333333333334,2535119.051148533,5833.333333333334,2027080.7562302987,true,155.0,155,0.875,0.0,0.0,0.0,0.0,0.0,155,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,108500.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,155.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +156,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,109200.0,5833.333333333334,2540952.3844818664,5833.333333333334,2032914.089563632,true,156.0,156,0.875,0.0,0.0,0.0,0.0,0.0,156,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,109200.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,156.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +157,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,109900.0,5833.333333333334,2546785.7178152,5833.333333333334,2038747.4228969652,true,157.0,157,0.875,0.0,0.0,0.0,0.0,0.0,157,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,109900.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,157.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +158,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,110600.0,5833.333333333334,2552619.0511485334,5833.333333333334,2044580.7562302984,true,158.0,158,0.875,0.0,0.0,0.0,0.0,0.0,158,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,110600.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,158.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +159,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,111300.0,5833.333333333334,2558452.384481867,5833.333333333334,2050414.0895636317,true,159.0,159,0.875,0.0,0.0,0.0,0.0,0.0,159,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,111300.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,159.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +160,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,112000.0,5833.333333333334,2564285.7178152003,5833.333333333334,2056247.422896965,true,160.0,160,0.875,0.0,0.0,0.0,0.0,0.0,160,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,112000.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,160.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +161,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,112700.0,5833.333333333334,2570119.051148534,5833.333333333334,2062080.7562302982,true,161.0,161,0.875,0.0,0.0,0.0,0.0,0.0,161,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,112700.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,161.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +162,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,113400.0,5833.333333333334,2575952.3844818673,5833.333333333334,2067914.0895636315,true,162.0,162,0.875,0.0,0.0,0.0,0.0,0.0,162,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,113400.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,162.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +163,22450.0,21750.0,0.12,0.0,508038.2949182258,700.0,114100.0,5833.333333333334,2581785.717815201,5833.333333333334,2073747.4228969647,true,163.0,163,0.875,0.0,0.0,0.0,0.0,0.0,163,21750.0,0.0,0.0,0.0,193271.59146868586,700.0,114100.0,0.0,71070.12154438188,0.0,-3.5925040720030665e-11,0.0,0.0,0.0,122201.46992430408,0.0,-2.0250467969162855e-13,-0.0,-444533.5080534476,true,true,0.0,1083.3743126350005,0.0,121.92,1644.2724500334996,163.0,0.0,1083.3743126350005,0.0,121.92,0.0,295.15 +164,22450.0,21750.0,0.1768,2178.5874071500493,510216.88232537586,700.0,114800.0,16281.602981617925,2598067.320796819,14103.015574467876,2087850.4384714325,true,164.0,164,0.875,1906.2639812562932,2178.5874071500493,272.32342589375617,0.0,0.0,164,21750.0,0.0,1906.2639812562932,1906.2639812562932,195177.85544994214,700.0,114800.0,0.19594678934725546,71070.31749117123,1789.2808980367404,1789.2808980367045,0.0,0.0,83.20228828994367,122284.67221259403,33.58484814026184,33.58484814026164,-1906.2639812562932,-446439.77203470387,true,true,1.475255935,1084.8495685700004,0.0,121.92,1644.2724500334996,164.0,1.475255935,1084.8495685700004,0.0,121.92,0.0,295.15 +165,24628.58740715005,23928.58740715005,0.265,6541.136756240824,516758.01908161666,700.0,115500.0,27325.04436317292,2625392.3651599917,20783.907606932098,2108634.3460783646,true,165.0,165,0.875,5723.494661710721,6541.136756240824,817.6420945301033,0.0,0.0,165,23928.58740715005,0.0,5723.494661710721,5723.494661710721,200901.35011165286,700.0,115500.0,5.290563308789698,71075.60805448002,5367.842689258775,7157.123587295479,0.0,0.0,249.60686481343245,122534.27907740747,100.75454432972379,134.33939246998543,-5723.494661710721,-452163.2666964146,true,true,2.950511869,1087.8000804390003,0.0,121.92,1644.2724500334996,165.0,2.950511869,1087.8000804390003,0.0,121.92,0.0,295.15 +166,28991.136756240823,28291.136756240823,0.30500000000000005,10919.809735313333,527677.82881693,700.0,116200.0,38097.73683709289,2663490.1019970844,27177.927101779555,2135812.2731801444,true,166.0,166,0.875,9554.833518399166,10919.809735313333,1364.9762169141668,0.0,0.0,166,28291.136756240823,0.0,9554.833518399166,9554.833518399166,210456.18363005202,700.0,116200.0,24.493348648483604,71100.1014031285,8946.404487757982,16103.528075053462,0.0,0.0,416.0114413369212,122950.29051874438,167.9242406557784,302.2636331257638,-9554.833518399166,-461718.1002148138,true,true,4.425767804,1092.2258482430004,0.0,121.92,1644.2724500334996,166.0,4.425767804,1092.2258482430004,0.0,121.92,0.0,295.15 +167,33369.809735313334,32669.809735313334,0.33999999999999997,15325.35540277793,543003.1842197079,700.0,116900.0,47133.39824346451,2710623.500240549,31808.042840686576,2167620.316020831,true,167.0,167,0.875,13409.685977430689,15325.35540277793,1915.6694253472415,0.0,0.0,167,32669.809735313334,0.0,13409.685977430689,13409.685977430689,223865.86960748272,700.0,116900.0,67.20974868753402,71167.31115181603,12524.966274128567,28628.49434918203,0.0,0.0,582.41601786041,123532.70653660479,235.09393675417851,537.3575698799423,-13409.685977430689,-475127.78619224444,true,true,5.901023738,1098.1268719810005,0.0,121.92,1644.2724500334996,167.0,5.901023738,1098.1268719810005,0.0,121.92,0.0,295.15 +168,37775.35540277793,37075.35540277793,0.3516666666666666,19768.52287353081,562771.7070932387,700.0,117600.0,58204.330446059175,2768827.8306866083,38435.80757252837,2206056.1235933593,true,168.0,168,0.875,17297.457514339458,19768.52287353081,2471.0653591913506,0.0,0.0,168,37075.35540277793,0.0,17297.457514339458,17297.457514339458,241163.32712182216,700.0,117600.0,142.84520930504598,71310.15636112107,16103.528077479215,44732.02242666125,0.0,0.0,748.8205943838988,124281.52713098869,302.2636331712946,839.6212030512369,-17297.457514339458,-492425.2437065839,true,true,7.376279673,1105.5031516540005,0.0,121.92,1644.2724500334996,168.0,7.376279673,1105.5031516540005,0.0,121.92,0.0,295.15 +169,42218.522873530805,41518.522873530805,0.35833333333333334,24260.06118338802,587031.7682766267,700.0,118300.0,69655.98469782704,2838483.8153844355,45395.92351443901,2251452.047107798,true,169.0,169,0.875,21227.553535464518,24260.06118338802,3032.507647923503,0.0,0.0,169,41518.522873530805,0.0,21227.553535464518,21227.553535464518,262390.8806572867,700.0,118300.0,260.8051763801247,71570.96153750119,19682.089858998374,64414.11228565962,0.0,0.0,915.2251709073876,125196.75230189608,369.43332917863336,1209.0545322298703,-21227.553535464518,-513652.79724204843,true,true,8.851535607,1114.3546872610004,0.0,121.92,1644.2724500334996,169.0,8.851535607,1114.3546872610004,0.0,121.92,0.0,295.15 +170,46710.061183388025,46010.061183388025,0.35333333333333333,20955.097763039685,607986.8660396663,700.0,119000.0,61288.01253690477,2899771.8279213402,40332.91477386508,2291784.961881663,true,170.0,170,0.875,18335.710542659723,20955.097763039685,2619.387220379962,0.0,0.0,170,46010.061183388025,0.0,18335.710542659723,18335.710542659723,280726.5911999464,700.0,119000.0,403.96543157774795,71974.92696907894,16561.938881175596,80976.05116683521,0.0,0.0,1058.9382142455102,126255.69051614159,310.86801566086996,1519.9225478907404,-18335.710542659723,-531988.5077847082,true,true,9.924449014,1124.2791362750004,0.0,121.92,1644.2724500334996,170.0,9.924449014,1124.2791362750004,0.0,121.92,0.0,295.15 +171,43405.09776303968,42705.09776303968,0.35333333333333333,20647.026341339464,628633.8923810058,700.0,119700.0,60416.1122868098,2960187.94020815,39769.08594547034,2331554.0478271334,true,171.0,171,0.875,18066.148048672032,20647.026341339464,2580.878292667432,0.0,0.0,171,42705.09776303968,0.0,18066.148048672032,18066.148048672032,298792.7392486184,700.0,119700.0,548.2203981814235,72523.14736726036,16044.378378340822,97020.42954517604,0.0,0.0,1172.3958803415362,127428.08639648312,301.15339180825026,1821.0759396989906,-18066.148048672032,-550054.6558333802,true,true,10.86324825,1135.1423845250004,0.0,121.92,1644.2724500334996,171.0,10.86324825,1135.1423845250004,0.0,121.92,0.0,295.15 +172,43097.026341339464,42397.026341339464,0.345,16603.546373028403,645237.4387540342,700.0,120400.0,50155.2068783432,3010343.147086493,33551.660505314794,2365105.7083324483,true,172.0,172,0.875,14528.103076399851,16603.546373028403,2075.4432966285513,0.0,0.0,172,42397.026341339464,0.0,14528.103076399851,14528.103076399851,313320.84232501825,700.0,120400.0,685.6610973104235,73208.80846457079,12347.51676147383,109367.94630664987,0.0,0.0,1263.1620127446092,128691.24840922773,231.76320487098926,2052.83914456998,-14528.103076399851,-564582.7589097801,true,true,11.53381912,1146.6762036450004,0.0,121.92,1644.2724500334996,172.0,11.53381912,1146.6762036450004,0.0,121.92,0.0,295.15 +173,39053.5463730284,38353.5463730284,0.28625,8382.031685502983,653619.4704395372,700.0,121100.0,31727.621608744044,3042070.768695237,23345.58992324106,2388451.2982556894,true,173.0,173,0.875,7334.27772481511,8382.031685502983,1047.7539606878736,0.0,0.0,173,38353.5463730284,0.0,7334.27772481511,7334.27772481511,320655.1200498334,700.0,121100.0,775.5464973091873,73984.35496187997,5146.031167701478,114513.97747435136,0.0,0.0,1316.1089233976663,130007.3573326254,96.59113640677788,2149.430280976758,-7334.27772481511,-571917.0366345951,true,true,11.80204748,1158.4782511250005,0.0,121.92,1644.2724500334996,173.0,11.80204748,1158.4782511250005,0.0,121.92,0.0,295.15 +174,30832.03168550298,30132.03168550298,0.12,0.0,653619.4704395372,700.0,121800.0,5833.333333333334,3047904.1020285706,5833.333333333334,2394284.631589023,true,174.0,174,0.875,0.0,0.0,0.0,0.0,0.0,174,30132.03168550298,0.0,-4019.9898226218893,-4019.9898226218893,316635.1302272115,700.0,121800.0,771.09786723211,74755.45282911208,-5992.20155588983,108521.77591846153,0.0,0.0,1313.5876422334177,131320.9449748588,-112.47377619758674,2036.9565047791712,-0.0,-571917.0366345951,true,true,11.4891144,1169.9673655250006,0.0,121.92,1644.2724500334996,174.0,11.4891144,1169.9673655250006,0.0,121.92,0.0,295.15 +175,22450.0,21750.0,0.12,0.0,653619.4704395372,700.0,122500.0,5833.333333333334,3053737.435361904,5833.333333333334,2400117.9649223564,true,175.0,175,0.875,0.0,0.0,0.0,0.0,0.0,175,21750.0,0.0,-3106.3995889943726,-3106.3995889943726,313528.7306382171,700.0,122500.0,714.8048141930619,75470.25764330514,-5008.014820295603,103513.76109816592,0.0,0.0,1280.81098315029,132601.7559580091,-94.00056604212095,1942.9559387370502,-0.0,-571917.0366345951,true,true,11.22088605,1181.1882515750005,0.0,121.92,1644.2724500334996,175.0,11.22088605,1181.1882515750005,0.0,121.92,0.0,295.15 +176,22450.0,21750.0,0.12,0.0,653619.4704395372,700.0,123200.0,5833.333333333334,3059570.7686952376,5833.333333333334,2405951.29825569,true,176.0,176,0.875,0.0,0.0,0.0,0.0,0.0,176,21750.0,0.0,-1405.3723986651207,-1405.3723986651207,312123.358239552,700.0,123200.0,673.4174414832393,76143.67508478838,-3272.9545680289084,100240.80653013702,0.0,0.0,1255.5981686878783,133857.35412669697,-61.43344080732996,1881.5224979297202,-0.0,-571917.0366345951,true,true,11.04206715,1192.2303187250006,0.0,121.92,1644.2724500334996,176.0,11.04206715,1192.2303187250006,0.0,121.92,0.0,295.15 +177,22450.0,21750.0,0.22,5049.388550174555,658668.8589897117,700.0,123900.0,26133.584318975252,3085704.353014213,21084.195768800695,2427035.4940244905,true,177.0,177,0.875,4418.214981402736,5049.388550174555,631.1735687718192,0.0,0.0,177,21750.0,0.0,4418.214981402736,4418.214981402736,316541.57322095474,700.0,123900.0,669.368850078189,76813.04393486657,2449.7866857256167,102690.59321586264,0.0,0.0,1253.0768869596443,135110.4310136566,45.98255863928627,1927.5050565690065,-4418.214981402736,-576335.2516159979,true,true,11.17618132,1203.4065000450007,0.0,121.92,1644.2724500334996,177.0,11.17618132,1203.4065000450007,0.0,121.92,0.0,295.15 +178,27499.388550174554,26799.388550174554,0.20800000000000002,4155.478247380607,662824.3372370923,700.0,124600.0,23343.64542009907,3109047.998434312,19188.167172718462,2446223.661197209,true,178.0,178,0.875,3636.0434664580316,4155.478247380607,519.4347809225756,0.0,0.0,178,26799.388550174554,0.0,3636.0434664580316,3636.0434664580316,320177.6166874128,700.0,124600.0,689.7750524688241,77502.8189873354,1649.621679046332,104340.21489490898,0.0,0.0,1265.6832939088576,136376.11430756547,30.96344103401797,1958.4684976030244,-3636.0434664580316,-579971.2950824559,true,true,11.26559077,1214.6720908150007,0.0,121.92,1644.2724500334996,178.0,11.26559077,1214.6720908150007,0.0,121.92,0.0,295.15 +179,26605.478247380608,25905.478247380608,0.20800000000000002,4201.302957510367,667025.6401946027,700.0,125300.0,23563.956526492148,3132611.9549608044,19362.65356898178,2465586.3147661905,true,179.0,179,0.875,3676.1400878215713,4201.302957510367,525.162869688796,0.0,0.0,179,25905.478247380608,0.0,3676.1400878215713,3676.1400878215713,323853.75677523436,700.0,125300.0,706.3954316362309,78209.21441897163,1662.7660748133496,106002.98096972232,0.0,0.0,1275.7684196938221,137651.8827272593,31.21016167816855,1989.678659281193,-3676.1400878215713,-583647.4351702774,true,true,11.35500022,1226.0270910350007,0.0,121.92,1644.2724500334996,179.0,11.35500022,1226.0270910350007,0.0,121.92,0.0,295.15 +180,26651.30295751037,25951.30295751037,0.25,6229.5373711100065,673255.1775657127,700.0,126000.0,27718.149484440026,3160330.1044452447,21488.61211333002,2487074.9268795205,true,180.0,180,0.875,5450.845199721256,6229.5373711100065,778.6921713887505,0.0,0.0,180,25951.30295751037,0.0,5450.845199721256,5450.845199721256,329304.60197495564,700.0,126000.0,731.823269133634,78941.03768810527,3364.965336927565,109367.94630664989,0.0,0.0,1290.896108371269,138942.77883563057,63.16048528878698,2052.83914456998,-5450.845199721256,-589098.2803699987,true,true,11.53381912,1237.5609101550008,0.0,121.92,1644.2724500334996,180.0,11.53381912,1237.5609101550008,0.0,121.92,0.0,295.15 +181,28679.537371110007,27979.537371110007,0.345,16649.477708036586,689904.6552737493,700.0,126700.0,50288.34118271474,3210618.4456279594,33638.86347467816,2520713.790354199,true,181.0,181,0.875,14568.292994532014,16649.477708036586,2081.184713504572,0.0,0.0,181,27979.537371110007,0.0,14568.292994532014,14568.292994532014,343872.8949694877,700.0,126700.0,811.7530711655426,79752.7907592708,12191.42734584454,121559.37365249443,0.0,0.0,1336.2791749675955,140279.05801059815,228.83340255433612,2281.672547124316,-14568.292994532014,-603666.5733645307,true,true,12.15968528,1249.7205954350009,0.0,121.92,1644.2724500334996,181.0,12.15968528,1249.7205954350009,0.0,121.92,0.0,295.15 +182,39099.47770803659,38399.47770803659,0.12,0.0,689904.6552737493,700.0,127400.0,5833.333333333334,3216451.778961293,5833.333333333334,2526547.1236875323,true,182.0,182,0.875,0.0,0.0,0.0,0.0,0.0,182,38399.47770803659,0.0,-4093.879271919988,-4093.879271919988,339779.01569756767,700.0,127400.0,844.3435475453647,80597.13430681617,-6176.223099567749,115383.15055292667,0.0,0.0,1353.9281453732763,141632.98615597142,-115.92786527087931,2165.7446818534368,-0.0,-603666.5733645307,true,true,11.8467522,1261.567347635001,0.0,121.92,1644.2724500334996,182.0,11.8467522,1261.567347635001,0.0,121.92,0.0,295.15 +183,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,128100.0,5833.333333333334,3222285.1122946264,5833.333333333334,2532380.4570208658,true,183.0,183,0.875,0.0,0.0,0.0,0.0,0.0,183,21750.0,0.0,-19157.39308967751,-19157.39308967751,320621.62260789017,700.0,128100.0,702.2155883763056,81299.34989519247,-20743.499795791122,94639.65075713555,0.0,0.0,1273.2471385295737,142906.233294501,-389.3560207922659,1776.3886610611708,-0.0,-603666.5733645307,true,true,10.72913407,1272.296481705001,0.0,121.92,1644.2724500334996,183.0,10.72913407,1272.296481705001,0.0,121.92,0.0,295.15 +184,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,128800.0,5833.333333333334,3228118.44562796,5833.333333333334,2538213.7903541992,true,184.0,184,0.875,0.0,0.0,0.0,0.0,0.0,184,21750.0,0.0,-8429.420498607207,-8429.420498607207,312192.20210928295,700.0,128800.0,555.3246780201065,81854.67457321257,-9974.953487984681,84664.69726915087,0.0,0.0,1177.4384430084242,144083.67173750943,-187.23013165105692,1589.1585294101137,-0.0,-603666.5733645307,true,true,10.14797264,1282.444454345001,0.0,121.92,1644.2724500334996,184.0,10.14797264,1282.444454345001,0.0,121.92,0.0,295.15 +185,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,129500.0,5833.333333333334,3233951.7789612934,5833.333333333334,2544047.1236875327,true,185.0,185,0.875,0.0,0.0,0.0,0.0,0.0,185,21750.0,0.0,-21787.030558622064,-21787.030558622064,290405.17155066086,700.0,129500.0,406.85777454038606,82261.53234775296,-22826.886584838263,61837.81068431261,0.0,0.0,1061.4594956917515,145145.1312332012,-428.46124401593653,1160.6972853941772,-0.0,-603666.5733645307,true,true,8.672716706,1291.1171710510012,0.0,121.92,1644.2724500334996,185.0,8.672716706,1291.1171710510012,0.0,121.92,0.0,295.15 +186,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,130200.0,5833.333333333334,3239785.112294627,5833.333333333334,2549880.457020866,true,186.0,186,0.875,0.0,0.0,0.0,0.0,0.0,186,21750.0,0.0,-9343.394812086932,-9343.394812086932,281061.7767385739,700.0,130200.0,278.4313035105071,82539.96365126346,-10362.713147821047,51475.097536491565,0.0,0.0,935.3954225901139,146080.5266557913,-194.50839036650697,966.1888950276702,-0.0,-603666.5733645307,true,true,7.912736376,1299.0299074270013,0.0,121.92,1644.2724500334996,186.0,7.912736376,1299.0299074270013,0.0,121.92,0.0,295.15 +187,22450.0,21750.0,0.12,0.0,689904.6552737493,700.0,130900.0,5833.333333333334,3245618.4456279604,5833.333333333334,2555713.7903541997,true,187.0,187,0.875,0.0,0.0,0.0,0.0,0.0,187,21750.0,0.0,-1809.2318543787503,-1809.2318543787503,279252.54488419514,700.0,130900.0,231.7782143401148,82771.74186560357,-2867.121358058867,48607.9761784327,0.0,0.0,879.9272304344172,146960.4538862257,-53.81594109441542,912.3729539332548,-0.0,-603666.5733645307,true,true,7.68921275,1306.7191201770013,0.0,121.92,1644.2724500334996,187.0,7.68921275,1306.7191201770013,0.0,121.92,0.0,295.15 +188,22450.0,21750.0,0.28,7368.913002353727,697273.568276103,700.0,131600.0,28817.546436977595,3274435.992064938,21448.633434623865,2577162.4237888237,true,188.0,188,0.875,6447.798877059511,7368.913002353727,921.1141252942161,0.0,0.0,188,21750.0,0.0,6447.798877059511,6447.798877059511,285700.3437612547,700.0,131600.0,239.83935520768443,83011.58122081126,5219.968228647543,53827.94440708024,0.0,0.0,890.0123562757803,147850.46624250148,97.97893692850403,1010.3518908617589,-6447.798877059511,-610114.3722415902,true,true,8.091555277,1314.8106754540013,0.0,121.92,1644.2724500334996,188.0,8.091555277,1314.8106754540013,0.0,121.92,0.0,295.15 +189,29818.91300235373,29118.91300235373,0.22,4875.908410787412,702149.4766868905,700.0,132300.0,25345.038230851875,3299781.0302957897,20469.129820064463,2597631.5536088883,true,189.0,189,0.875,4266.419859438985,4875.908410787412,609.4885513484269,0.0,0.0,189,29118.91300235373,0.0,4266.419859438985,4266.419859438985,289966.76362069364,700.0,132300.0,269.52218856006243,83281.10340937132,3014.9958255062224,56842.940232586465,0.0,0.0,925.3102967487507,148775.77653925025,56.59154862394952,1066.9434394857085,-4266.419859438985,-614380.7921010292,true,true,8.315078904,1323.1257543580014,0.0,121.92,1644.2724500334996,189.0,8.315078904,1323.1257543580014,0.0,121.92,0.0,295.15 +190,27325.90841078741,26625.90841078741,0.3175,11808.57261478694,713958.0493016774,700.0,133000.0,39397.07910169115,3339178.1093974807,27588.50648690421,2625220.0600957926,true,190.0,190,0.875,10332.501037938573,11808.57261478694,1476.0715768483678,0.0,0.0,190,26625.90841078741,0.0,10332.501037938573,10332.501037938573,300299.2646586322,700.0,133000.0,313.58714113416886,83594.69055050549,8879.039454968335,65721.9796875548,0.0,0.0,973.214644565724,149748.99118381596,166.65979727034525,1233.6032367560538,-10332.501037938573,-624713.2931389677,true,true,8.940945058,1332.0666994160013,0.0,121.92,1644.2724500334996,190.0,8.940945058,1332.0666994160013,0.0,121.92,0.0,295.15 +191,34258.57261478694,33558.57261478694,0.3516666666666666,19444.726237958144,733402.7755396356,700.0,133700.0,57283.581719312264,3396461.691116793,37838.85548135412,2663058.9155771467,true,191.0,191,0.875,17014.135458213375,19444.726237958144,2430.590779744769,0.0,0.0,191,33558.57261478694,0.0,17014.135458213375,17014.135458213375,317313.4001168456,700.0,133700.0,409.7638906038589,84004.45444110935,15254.071479280437,80976.05116683524,0.0,0.0,1063.980777194391,150812.97196101036,286.31931113468664,1519.9225478907404,-17014.135458213375,-641727.4285971811,true,true,9.924449014,1341.9911484300012,0.0,121.92,1644.2724500334996,191.0,9.924449014,1341.9911484300012,0.0,121.92,0.0,295.15 +192,41894.726237958144,41194.726237958144,0.355,22528.012691557353,755930.788231193,700.0,134400.0,65431.02166635874,3461892.712783152,42903.008974801385,2705961.924551948,true,192.0,192,0.875,19712.011105112684,22528.012691557353,2816.0015864446686,0.0,0.0,192,41194.726237958144,0.0,19712.011105112684,19712.011105112684,337025.4112219583,700.0,134400.0,555.3246783393029,84559.77911944865,17647.99467293782,98624.04583977305,0.0,0.0,1177.4384432340185,151990.41040424438,331.25331060154025,1851.1758584922807,-19712.011105112684,-661439.4397022938,true,true,10.9526577,1352.9438061300011,0.0,121.92,1644.2724500334996,192.0,10.9526577,1352.9438061300011,0.0,121.92,0.0,295.15 +193,44978.01269155735,44278.01269155735,0.3585,30105.1109938774,786035.8992250704,700.0,135100.0,85927.78519910014,3547820.497982252,55822.674205222735,2761784.5987571706,true,193.0,193,0.875,26341.972119642724,30105.1109938774,3763.1388742346753,0.0,0.0,193,44278.01269155735,0.0,26341.972119642724,26341.972119642724,363367.383341601,700.0,135100.0,757.8541113977777,85317.63323084643,23830.78967989042,122454.83551966347,0.0,0.0,1306.0237976127014,153296.43420185708,447.3045307418266,2298.4803892341074,-26341.972119642724,-687781.4118219366,true,true,12.20439,1365.1481961300012,0.0,121.92,1644.2724500334996,193.0,12.20439,1365.1481961300012,0.0,121.92,0.0,295.15 +194,52555.1109938774,51855.1109938774,0.3555,38251.936672667565,824287.8358977379,700.0,135800.0,109569.44211720835,3657389.94009946,71317.50544454079,2833102.1042017112,true,194.0,194,0.875,33470.44458858412,38251.936672667565,4781.492084083446,0.0,0.0,194,51855.1109938774,0.0,33470.44458858412,33470.44458858412,396837.8279301851,700.0,135800.0,1052.882352979438,86370.51558382587,30389.84341385865,152844.6789335221,0.0,0.0,1457.3006849511562,154753.73488680823,570.4181367948753,2868.898526028983,-33470.44458858412,-721251.8564105207,true,true,13.63494121,1378.7831373400013,0.0,121.92,1644.2724500334996,194.0,13.63494121,1378.7831373400013,0.0,121.92,0.0,295.15 +195,60701.936672667565,60001.936672667565,0.3545,40207.59118577558,864495.4270835135,700.0,136500.0,115395.17964957851,3772785.1197490385,75187.58846380294,2908289.692665514,true,195.0,195,0.875,35181.64228755363,40207.59118577558,5025.948898221948,0.0,0.0,195,60001.936672667565,0.0,35181.64228755363,35181.64228755363,432019.47021773877,700.0,136500.0,1429.3423232759949,87799.85790710186,31546.550274430578,184391.22920795268,0.0,0.0,1613.620135746079,156367.35502255431,592.1295541009748,3461.0280801299577,-35181.64228755363,-756433.4986980744,true,true,14.97608297,1393.7592203100014,0.0,121.92,1644.2724500334996,195.0,14.97608297,1393.7592203100014,0.0,121.92,0.0,295.15 +196,62657.59118577558,61957.59118577558,0.3545,40119.46131246792,904614.8883959814,700.0,137200.0,115146.5763398249,3887931.6960888635,75027.11502735698,2983316.807692871,true,196.0,196,0.875,35104.52864840943,40119.46131246792,5014.932664058491,0.0,0.0,196,61957.59118577558,0.0,35104.52864840943,35104.52864840943,467123.9988661482,700.0,137200.0,1846.2676741318962,89646.12558123376,30920.5483139305,215311.7775218832,0.0,0.0,1757.3331790278032,158124.68820158212,580.3794813192384,4041.4075614491962,-35104.52864840943,-791538.0273464838,true,true,16.18311055,1409.9423308600014,0.0,121.92,1644.2724500334996,196.0,16.18311055,1409.9423308600014,0.0,121.92,0.0,295.15 +197,62569.46131246792,61869.46131246792,0.3516666666666666,20058.904403552944,924673.7927995344,700.0,137900.0,59030.05991531644,3946961.75600418,38971.15551176349,3022287.9632046344,true,197.0,197,0.875,17551.541353108827,20058.904403552944,2507.363050444117,0.0,0.0,197,61869.46131246792,0.0,17551.541353108827,17551.541353108827,484675.540219257,700.0,137900.0,2165.0022335277254,91811.1278147615,13284.055189946921,228595.83271183012,0.0,0.0,1853.1418745489523,159977.83007613107,249.34205508522933,4290.7496165344255,-17551.541353108827,-809089.5686995926,true,true,16.67486253,1426.6171933900014,0.0,121.92,1644.2724500334996,197.0,16.67486253,1426.6171933900014,0.0,121.92,0.0,295.15 +198,42508.904403552944,41808.904403552944,0.357,34315.36868575039,958989.1614852848,700.0,138600.0,98082.26522619158,4045044.021230371,63766.89654044119,3086054.8597450755,true,198.0,198,0.875,30025.94760003159,34315.36868575039,4289.421085718801,0.0,0.0,198,41808.904403552944,0.0,30025.94760003159,30025.94760003159,514701.4878192886,700.0,138600.0,2450.657620932225,94261.78543569372,25171.51833700349,253767.3510488336,0.0,0.0,1931.3016002284066,161909.13167635948,472.4700418674672,4763.219658401893,-30025.94760003159,-839115.5162996242,true,true,17.56895704,1444.1861504300014,0.0,121.92,1644.2724500334996,198.0,17.56895704,1444.1861504300014,0.0,121.92,0.0,295.15 +199,56765.36868575039,56065.36868575039,0.35666666666666663,23785.083371140277,982774.2448564251,700.0,139300.0,68649.76646114097,4113693.787691512,44864.68309000069,3130919.5428350763,true,199.0,199,0.875,20811.947949747744,23785.083371140277,2973.1354213925333,0.0,0.0,199,56065.36868575039,0.0,20811.947949747744,20811.947949747744,535513.4357690364,700.0,139300.0,2770.7988952150754,97032.5843309088,15733.84183450869,269501.1928833423,0.0,0.0,2011.9826070721094,163921.11428343158,295.3246129518697,5058.544271353762,-20811.947949747744,-859927.464249372,true,true,18.10541374,1462.2915641700013,0.0,121.92,1644.2724500334996,199.0,18.10541374,1462.2915641700013,0.0,121.92,0.0,295.15 +200,46235.08337114028,45535.08337114028,0.358,31174.307056075904,1013948.551912501,700.0,140000.0,89034.37725160868,4202728.16494312,57860.07019553277,3188779.613030609,true,200.0,200,0.875,27277.518674066418,31174.307056075904,3896.7883820094867,0.0,0.0,200,45535.08337114028,0.0,27277.518674066418,27277.518674066418,562790.9544431028,700.0,140000.0,3072.8154216930316,100105.39975260182,21714.542251758998,291215.73513510125,0.0,0.0,2082.578488130847,166003.69277156243,407.582512483542,5466.126783837304,-27277.518674066418,-887204.9829234384,true,true,18.82068935,1481.1122535200013,0.0,121.92,1644.2724500334996,200.0,18.82068935,1481.1122535200013,0.0,121.92,0.0,295.15 +201,53624.30705607591,52924.30705607591,0.359,29300.62019166626,1043249.1721041673,700.0,140700.0,83567.18716341577,4286295.352106536,54266.56697174951,3243046.1800023587,true,201.0,201,0.875,25638.042667707978,29300.62019166626,3662.5775239582836,0.0,0.0,201,52924.30705607591,0.0,25638.042667707978,25638.042667707978,588428.9971108108,700.0,140700.0,3419.933220708514,103525.33297331033,19690.304987565803,310906.04012266704,0.0,0.0,2158.216932082067,168161.9097036445,369.58752735159464,5835.714311188899,-25638.042667707978,-912843.0255911464,true,true,19.4465555,1500.5588090200013,0.0,121.92,1644.2724500334996,201.0,19.4465555,1500.5588090200013,0.0,121.92,0.0,295.15 +202,51750.62019166626,51050.62019166626,0.357,34005.907243420355,1077255.0793475877,700.0,141400.0,97215.42645215786,4383510.778558694,63209.5192087375,3306255.6992110964,true,202.0,202,0.875,29755.168837992813,34005.907243420355,4250.738405427543,0.0,0.0,202,51050.62019166626,0.0,29755.168837992813,29755.168837992813,618184.1659488037,700.0,141400.0,3792.254693933985,107317.58766724431,23291.869777609292,334197.90990027634,0.0,0.0,2233.8553760332875,170395.76507967777,437.1889904162494,6272.903301605148,-29755.168837992813,-942598.1944291393,true,true,20.16183111,1520.7206401300014,0.0,121.92,1644.2724500334996,202.0,20.16183111,1520.7206401300014,0.0,121.92,0.0,295.15 +203,56455.907243420355,55755.907243420355,0.35666666666666663,23021.16619307473,1100276.2455406624,700.0,142100.0,66507.94259740578,4450018.7211561,43486.77640433105,3349742.4756154274,true,203.0,203,0.875,20143.52041894039,23021.16619307473,2877.64577413434,0.0,0.0,203,55755.907243420355,0.0,20143.52041894039,20143.52041894039,638327.686367744,700.0,142100.0,4122.412655868708,111440.00032311302,13471.362531923885,347669.2724322002,0.0,0.0,2296.8874124713093,172692.6524921491,252.85781867648708,6525.761120281635,-20143.52041894039,-962741.7148480796,true,true,20.56417363,1541.2848137600013,0.0,121.92,1644.2724500334996,203.0,20.56417363,1541.2848137600013,0.0,121.92,0.0,295.15 +204,45471.16619307473,44771.16619307473,0.355,21856.267883826073,1122132.5134244885,700.0,142800.0,63538.78277134105,4513557.503927441,41682.514887514975,3391424.9905029424,true,204.0,204,0.875,19124.234398347813,21856.267883826073,2732.0334854782595,0.0,0.0,204,44771.16619307473,0.0,19124.234398347813,19124.234398347813,657451.9207660918,700.0,142800.0,4357.528743133255,115797.52906624628,12197.999692211702,359867.2721244119,0.0,0.0,2339.7491973394017,175032.4016894885,228.95676566345475,6754.71788594509,-19124.234398347813,-981865.9492464274,true,true,20.92181144,1562.2066252000013,0.0,121.92,1644.2724500334996,204.0,20.92181144,1562.2066252000013,0.0,121.92,0.0,295.15 +205,44306.267883826076,43606.267883826076,0.35333333333333333,20570.489622222016,1142703.0030467105,700.0,143500.0,60199.498930817026,4573757.002858259,39629.00930859501,3431053.9998115376,true,205.0,205,0.875,17999.178419444263,20570.489622222016,2571.3112027777534,0.0,0.0,205,43606.267883826076,0.0,17999.178419444263,17999.178419444263,675451.099185536,700.0,143500.0,4572.2651758659185,120369.7942421122,10845.769454683572,370713.0415790955,0.0,0.0,2377.5684193150114,177409.9701088035,203.57536957976183,6958.293255524852,-17999.178419444263,-999865.1276658716,true,true,21.23474451,1583.4413697100013,0.0,121.92,1644.2724500334996,205.0,21.23474451,1583.4413697100013,0.0,121.92,0.0,295.15 +206,43020.48962222201,42320.48962222201,0.28625,8080.0704604026605,1150783.0735071131,700.0,144200.0,30672.735232847725,4604429.7380911065,22592.664772445063,3453646.6645839824,true,206.0,206,0.875,7070.061652852328,8080.0704604026605,1010.0088075503327,0.0,0.0,206,42320.48962222201,0.0,7070.061652852328,7070.061652852328,682521.1608383884,700.0,144200.0,4674.8442636956215,125044.63850580782,0.0,370713.0415790955,0.0,0.0,2395.2173891567068,179805.1874979602,0.0,6958.293255524852,-7070.061652852328,-1006935.189318724,true,true,21.23474451,1604.6761142200012,0.0,121.92,1644.2724500334996,206.0,21.23474451,1604.6761142200012,0.0,121.92,0.0,295.15 +207,30530.07046040266,29830.07046040266,0.20800000000000002,4413.55572945483,1155196.629236568,700.0,144900.0,24584.40254545591,4629014.140636562,20170.846816001078,3473817.5113999834,true,207.0,207,0.875,3861.861263272976,4413.55572945483,551.6944661818538,0.0,0.0,207,29830.07046040266,0.0,3861.861263272976,3861.861263272976,686383.0221016613,700.0,144900.0,4645.3810466648,129690.01955247262,-3115.2218166199136,367597.81976247556,0.0,0.0,2390.1748262642245,182195.36232422444,-58.47279303613522,6899.820462488717,-3861.861263272976,-1010797.0505819969,true,true,21.14533506,1625.8214492800012,0.0,121.92,1644.2724500334996,207.0,21.14533506,1625.8214492800012,0.0,121.92,0.0,295.15 +208,26863.55572945483,26163.55572945483,0.25,6173.947734548011,1161370.576971116,700.0,145600.0,27495.790938192044,4656509.931574754,21321.84320364403,3495139.354603627,true,208.0,208,0.875,5402.204267729509,6173.947734548011,771.7434668185015,0.0,0.0,208,26163.55572945483,0.0,5402.204267729509,5402.204267729509,691785.2263693908,700.0,145600.0,4601.418744963874,134291.43829743649,-1552.6815864214939,366045.13817605405,0.0,0.0,2382.610982207494,184577.97330643193,-29.143873020364406,6870.676589468352,-5402.204267729509,-1016199.2548497265,true,true,21.10063034,1646.922079620001,0.0,121.92,1644.2724500334996,208.0,21.10063034,1646.922079620001,0.0,121.92,0.0,295.15 +209,28623.94773454801,27923.94773454801,0.20800000000000002,4319.055870968466,1165689.6328420844,700.0,146300.0,24130.076302733007,4680640.007877488,19811.02043176454,3514950.3750353917,true,209.0,209,0.875,3779.1738870974073,4319.055870968466,539.8819838710583,0.0,0.0,209,27923.94773454801,0.0,3779.1738870974073,3779.1738870974073,695564.4002564882,700.0,146300.0,4557.734684734872,138849.17298217135,-3095.505223704521,362949.63295234955,0.0,0.0,2375.047138150763,186953.02044458268,-58.10271208370657,6812.573877384646,-3779.1738870974073,-1019978.4287368238,true,true,21.01122089,1667.9333005100011,0.0,121.92,1644.2724500334996,209.0,21.01122089,1667.9333005100011,0.0,121.92,0.0,295.15 +210,26769.055870968466,26069.055870968466,0.28625,7884.3093651326035,1173573.942207217,700.0,147000.0,29988.853677319137,4710628.861554807,22104.544312186532,3537054.919347578,true,210.0,210,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,210,26069.055870968466,0.0,6898.770694491028,6898.770694491028,702463.1709509792,700.0,147000.0,4528.766119232747,143377.9391014041,0.0,362949.63295234955,0.0,0.0,2370.004575258281,189323.02501984098,0.0,6812.573877384646,-6898.770694491028,-1026877.1994313148,true,true,21.01122089,1688.9445214000011,0.0,121.92,1644.2724500334996,210.0,21.01122089,1688.9445214000011,0.0,121.92,0.0,295.15 +211,30334.309365132605,29634.309365132605,0.28625,7884.3093651326035,1181458.2515723496,700.0,147700.0,29988.853677319137,4740617.715232126,22104.544312186532,3559159.4636597647,true,211.0,211,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,211,29634.309365132605,0.0,6898.770694491028,6898.770694491028,709361.9416454702,700.0,147700.0,4528.766119232747,147906.70522063685,0.0,362949.63295234955,0.0,0.0,2370.004575258281,191693.02959509927,0.0,6812.573877384646,-6898.770694491028,-1033775.9701258058,true,true,21.01122089,1709.9557422900011,0.0,121.92,1644.2724500334996,211.0,21.01122089,1709.9557422900011,0.0,121.92,0.0,295.15 +212,30334.309365132605,29634.309365132605,0.28625,7884.3093651326035,1189342.5609374822,700.0,148400.0,29988.853677319137,4770606.568909446,22104.544312186532,3581264.0079719513,true,212.0,212,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,212,29634.309365132605,0.0,6898.770694491028,6898.770694491028,716260.7123399612,700.0,148400.0,4528.766119232747,152435.4713398696,0.0,362949.63295234955,0.0,0.0,2370.004575258281,194063.03417035757,0.0,6812.573877384646,-6898.770694491028,-1040674.7408202968,true,true,21.01122089,1730.9669631800011,0.0,121.92,1644.2724500334996,212.0,21.01122089,1730.9669631800011,0.0,121.92,0.0,295.15 +213,30334.309365132605,29634.309365132605,0.28625,7884.3093651326035,1197226.8703026148,700.0,149100.0,29988.853677319137,4800595.422586765,22104.544312186532,3603368.552284138,true,213.0,213,0.875,6898.770694491028,7884.3093651326035,985.5386706415757,0.0,0.0,213,29634.309365132605,0.0,6898.770694491028,6898.770694491028,723159.4830344522,700.0,149100.0,4528.766119232747,156964.23745910235,0.0,362949.63295234955,0.0,0.0,2370.004575258281,196433.03874561586,0.0,6812.573877384646,-6898.770694491028,-1047573.5115147878,true,true,21.01122089,1751.9781840700011,0.0,121.92,1644.2724500334996,213.0,21.01122089,1751.9781840700011,0.0,121.92,0.0,295.15 +214,30334.309365132605,29634.309365132605,0.3175,11527.302581341559,1208754.1728839562,700.0,149800.0,38511.189232571836,4839106.611819337,26983.886651230277,3630352.4389353683,true,214.0,214,0.875,10086.389758673864,11527.302581341559,1440.9128226676949,0.0,0.0,214,29634.309365132605,0.0,10086.389758673864,10086.389758673864,733245.872793126,700.0,149800.0,4557.734684734872,161521.97214383722,3095.505223704521,366045.13817605405,0.0,0.0,2375.047138150763,198808.08588376662,58.10271208370657,6870.676589468352,-10086.389758673864,-1057659.9012734618,true,true,21.10063034,1773.078814410001,0.0,121.92,1644.2724500334996,214.0,21.10063034,1773.078814410001,0.0,121.92,0.0,295.15 +215,33977.30258134156,33277.30258134156,0.3175,11620.769376582699,1220374.942260539,700.0,150500.0,38805.57283963055,4877912.184658968,27184.80346304785,3657537.242398416,true,215.0,215,0.875,10168.173204509862,11620.769376582699,1452.5961720728374,0.0,0.0,215,33277.30258134156,0.0,10168.173204509862,10168.173204509862,743414.0459976359,700.0,150500.0,4616.041888374692,166138.0140322119,3108.649619471585,369153.7877955256,0.0,0.0,2385.1322639357277,201193.21814770234,58.349432727857526,6929.02602219621,-10168.173204509862,-1067828.0744779715,true,true,21.19003979,1794.268854200001,0.0,121.92,1644.2724500334996,215.0,21.19003979,1794.268854200001,0.0,121.92,0.0,295.15 +216,34070.7693765827,33370.7693765827,0.345,17255.013813299836,1237629.9560738388,700.0,151200.0,52043.51829941982,4929955.702958387,34788.504486119986,3692325.746884536,true,216.0,216,0.875,15098.137086637356,17255.013813299836,2156.87672666248,0.0,0.0,216,33370.7693765827,0.0,15098.137086637356,15098.137086637356,758512.1830842732,700.0,151200.0,4719.272267415918,170857.28629962783,7829.130604110655,376982.9183996363,0.0,0.0,2402.781233777423,203595.99938147975,146.95298133336095,7075.979003529571,-15098.137086637356,-1082926.2115646088,true,true,21.41356341,1815.682417610001,0.0,121.92,1644.2724500334996,216.0,21.41356341,1815.682417610001,0.0,121.92,0.0,295.15 +217,39705.01381329984,39005.01381329984,0.3516666666666666,19425.000277654424,1257054.9563514933,700.0,151900.0,57227.48894119742,4987183.191899585,37802.488663543,3730128.235548079,true,217.0,217,0.875,16996.875242947623,19425.000277654424,2428.1250347068017,0.0,0.0,217,39005.01381329984,0.0,16996.875242947623,16996.875242947623,775509.0583272208,700.0,151900.0,4884.582323878252,175741.86862350607,9503.398555571433,386486.31695520773,0.0,0.0,2430.5153299680687,206026.51471144782,178.37903352986842,7254.358037059439,-16996.875242947623,-1099923.0868075565,true,true,21.68179177,1837.364209380001,0.0,121.92,1644.2724500334996,217.0,21.68179177,1837.364209380001,0.0,121.92,0.0,295.15 +218,41875.00027765443,41175.00027765443,0.3516666666666666,19808.391095145107,1276863.3474466384,700.0,152600.0,58317.699796621164,5045500.891696205,38509.30870147605,3768637.544249555,true,218.0,218,0.875,17332.34220825197,19808.391095145107,2476.048886893139,0.0,0.0,218,41175.00027765443,0.0,17332.34220825197,17332.34220825197,792841.4005354728,700.0,152600.0,5069.274222269831,180811.1428457759,9621.69776537684,396108.01472058456,0.0,0.0,2460.770707886948,208487.28541933477,180.599512718346,7434.957549777785,-17332.34220825197,-1117255.4290158085,true,true,21.95002012,1859.3142295000011,0.0,121.92,1644.2724500334996,218.0,21.95002012,1859.3142295000011,0.0,121.92,0.0,295.15 +219,42258.39109514511,41558.39109514511,0.345,16359.42626262878,1293222.7737092671,700.0,153300.0,49447.61235544575,5094948.504051651,33088.18609281697,3801725.730342372,true,219.0,219,0.875,14314.497979800182,16359.42626262878,2044.9282828285977,0.0,0.0,219,41558.39109514511,0.0,14314.497979800182,14314.497979800182,807155.898515273,700.0,153300.0,5226.694023331791,186037.8368691077,6480.187155752717,402588.2018763373,0.0,0.0,2485.98352234936,210973.26894168413,121.6332783663133,7556.590828144098,-14314.497979800182,-1131569.9269956087,true,true,22.12883902,1881.4430685200011,0.0,121.92,1644.2724500334996,219.0,22.12883902,1881.4430685200011,0.0,121.92,0.0,295.15 +220,38809.42626262878,38109.42626262878,0.35,18522.747802527214,1311745.5215117943,700.0,154000.0,54922.13657864919,5149870.6406303,36399.388776121974,3838125.119118494,true,220.0,220,0.875,16207.404327211312,18522.747802527214,2315.3434753159017,0.0,0.0,220,38109.42626262878,0.0,16207.404327211312,16207.404327211312,823363.3028424843,700.0,154000.0,5371.128886882622,191408.96575599033,8174.170987113224,410762.3728634505,0.0,0.0,2508.6750550835372,213481.94399676766,153.42939813192748,7710.020226276026,-16207.404327211312,-1147777.33132282,true,true,22.35236264,1903.795431160001,0.0,121.92,1644.2724500334996,220.0,22.35236264,1903.795431160001,0.0,121.92,0.0,295.15 +221,40972.747802527214,40272.747802527214,0.35333333333333333,20790.000431234697,1332535.521943029,700.0,154700.0,60820.75593745669,5210691.396567757,40030.75550622199,3878155.874624716,true,221.0,221,0.875,18191.25037733036,20790.000431234697,2598.750053904336,0.0,0.0,221,40272.747802527214,0.0,18191.25037733036,18191.25037733036,841554.5532198147,700.0,154700.0,5551.243452031704,196960.20920802205,9917.447039872739,420679.81990332325,0.0,0.0,2536.409151274183,216018.35314804185,186.15073415173518,7896.170960427761,-18191.25037733036,-1165968.5817001504,true,true,22.620591,1926.4160221600011,0.0,121.92,1644.2724500334996,221.0,22.620591,1926.4160221600011,0.0,121.92,0.0,295.15 +222,43240.0004312347,42540.0004312347,0.345,17237.42589900422,1349772.9478420333,700.0,155400.0,51992.5388376934,5262683.935405451,34755.11293868918,3912910.987563405,true,222.0,222,0.875,15082.747661628693,17237.42589900422,2154.6782373755286,0.0,0.0,222,42540.0004312347,0.0,15082.747661628693,15082.747661628693,856637.3008814433,700.0,155400.0,5718.438513544495,202678.64772156655,6677.353093727456,427357.1729970507,0.0,0.0,2561.62196630058,218579.97511434244,125.33408805616126,8021.505048483922,-15082.747661628693,-1181051.3293617791,true,true,22.7994099,1949.2154320600011,0.0,121.92,1644.2724500334996,222.0,22.7994099,1949.2154320600011,0.0,121.92,0.0,295.15 +223,39687.42589900422,38987.42589900422,0.3516666666666666,19468.288383317395,1369241.2362253508,700.0,156100.0,57350.5830805234,5320034.5184859745,37882.294697206,3950793.282260611,true,223.0,223,0.875,17034.75233540272,19468.288383317395,2433.536047914673,0.0,0.0,223,38987.42589900422,0.0,17034.75233540272,17034.75233540272,873672.0532168461,700.0,156100.0,5871.755022158502,208550.40274372505,8420.628404068704,435777.8014011194,0.0,0.0,2584.313499034757,221164.2886133772,158.05541014075965,8179.560458624682,-17034.75233540272,-1198086.0816971818,true,true,23.02293352,1972.238365580001,0.0,121.92,1644.2724500334996,223.0,23.02293352,1972.238365580001,0.0,121.92,0.0,295.15 +224,41918.2883833174,41218.2883833174,0.35666666666666663,23823.70252371239,1393064.938749063,700.0,156800.0,68758.0444590067,5388792.562944981,44934.34193529432,3995727.6241959054,true,224.0,224,0.875,20845.73970824834,23823.70252371239,2977.9628154640486,0.0,0.0,224,41218.2883833174,0.0,20845.73970824834,20845.73970824834,894517.7929250944,700.0,156800.0,6080.4063068501555,214630.8090505752,11926.8963755212,447704.6977766406,0.0,0.0,2614.5688763896515,223778.85748976684,223.86814948733362,8403.428608112015,-20845.73970824834,-1218931.82140543,true,true,23.3358666,1995.574232180001,0.0,121.92,1644.2724500334996,224.0,23.3358666,1995.574232180001,0.0,121.92,0.0,295.15 +225,46273.70252371239,45573.70252371239,0.3585,30496.68383057132,1423561.6225796344,700.0,157500.0,87020.0385789995,5475812.6015239805,56523.35474842819,4052250.9789443337,true,225.0,225,0.875,26684.598351749904,30496.68383057132,3812.0854788214165,0.0,0.0,225,45573.70252371239,0.0,26684.598351749904,26684.598351749904,921202.3912768443,700.0,157500.0,6384.371706504551,221015.18075707974,17317.741533250064,465022.4393098907,0.0,0.0,2657.430661257744,226436.28815102458,325.05445073754447,8728.48305884956,-26684.598351749904,-1245616.41975718,true,true,23.78291385,2019.3571460300009,0.0,121.92,1644.2724500334996,225.0,23.78291385,2019.3571460300009,0.0,121.92,0.0,295.15 +226,52946.68383057132,52246.68383057132,0.359,29263.98244472508,1452825.6050243594,700.0,158200.0,83465.13215800858,5559277.733681989,54201.1497132835,4106452.128657617,true,226.0,226,0.875,25605.984639134444,29263.98244472508,3657.997805590636,0.0,0.0,226,52246.68383057132,0.0,25605.984639134444,25605.984639134444,946808.3759159788,700.0,158200.0,6735.8979286715885,227751.07868575133,15866.92903827989,480889.36834817054,0.0,0.0,2705.3350090183185,229141.6231600429,297.82266316464796,9026.30572201421,-25605.984639134444,-1271222.4043963144,true,true,24.18525638,2043.542402410001,0.0,121.92,1644.2724500334996,226.0,24.18525638,2043.542402410001,0.0,121.92,0.0,295.15 +227,51713.98244472508,51013.98244472508,0.355,21532.841636721954,1474358.4466610814,700.0,158900.0,62627.722920343534,5621905.456602332,41094.88128362158,4147547.009941239,true,227.0,227,0.875,18841.23643213171,21532.841636721954,2691.6052045902434,0.0,0.0,227,51013.98244472508,0.0,18841.23643213171,18841.23643213171,965649.6123481105,700.0,158900.0,7003.0135080163955,234754.09219376772,8929.974131830124,489819.3424800007,0.0,0.0,2740.63294982968,231882.25610987257,167.61584245551103,9193.92156446972,-18841.23643213171,-1290063.640828446,true,true,24.40878001,2067.951182420001,0.0,121.92,1644.2724500334996,227.0,24.40878001,2067.951182420001,0.0,121.92,0.0,295.15 +228,43982.841636721954,43282.841636721954,0.35,17620.919794868005,1491979.3664559494,700.0,159600.0,52345.485128194305,5674250.941730526,34724.5653333263,4182271.5752745653,true,228.0,228,0.875,15418.304820509504,17620.919794868005,2202.614974358501,0.0,0.0,228,43282.841636721954,0.0,15418.304820509504,15418.304820509504,981067.91716862,700.0,159600.0,7158.774612409318,241912.86680617704,5397.417345321454,495216.75982532214,0.0,0.0,2760.80320139961,234643.05931127217,101.30966137912259,9295.231225848842,-15418.304820509504,-1305481.9456489554,true,true,24.54289418,2092.494076600001,0.0,121.92,1644.2724500334996,228.0,24.54289418,2092.494076600001,0.0,121.92,0.0,295.15 +229,40070.91979486801,39370.91979486801,0.33,13540.579463911852,1505519.9459198613,700.0,160300.0,43153.27110276319,5717404.212833289,29612.691638851335,4211884.266913417,true,229.0,229,0.875,11848.00703092287,13540.579463911852,1692.5724329889817,0.0,0.0,229,39370.91979486801,0.0,11848.00703092287,11848.00703092287,992915.924199543,700.0,160300.0,7237.513869214731,249150.3806753918,1805.7115820253287,497022.4714073475,0.0,0.0,2770.8883271845743,237413.94763845674,33.893252498236684,9329.12447834708,-11848.00703092287,-1317329.9526798783,true,true,24.58759891,2117.081675510001,0.0,121.92,1644.2724500334996,229.0,24.58759891,2117.081675510001,0.0,121.92,0.0,295.15 +230,35990.579463911854,35290.579463911854,0.29250000000000004,9335.768413572276,1514855.7143334337,700.0,161000.0,34310.31936264026,5751714.532195929,24974.550949067983,4236858.817862485,true,230.0,230,0.875,8168.7973618757405,9335.768413572276,1166.9710516965351,0.0,0.0,230,35290.579463911854,0.0,8168.7973618757405,8168.7973618757405,1001084.7215614187,700.0,161000.0,7237.513869214731,256387.89454460653,-1805.7115820253287,495216.75982532214,0.0,0.0,2770.8883271845743,240184.8359656413,-33.893252498236684,9295.231225848842,-8168.7973618757405,-1325498.750041754,true,true,24.54289418,2141.624569690001,0.0,121.92,1644.2724500334996,230.0,24.54289418,2141.624569690001,0.0,121.92,0.0,295.15 +231,31785.768413572274,31085.768413572274,0.22,5052.400922409543,1519908.1152558431,700.0,161700.0,26147.27692004338,5777861.809115972,21094.875997633837,4257953.693860118,true,231.0,231,0.875,4420.850807108351,5052.400922409543,631.5501153011928,0.0,0.0,231,31085.768413572274,0.0,4420.850807108351,4420.850807108351,1005505.5723685271,700.0,161700.0,7158.774612409318,263546.66915701586,-5397.417345321454,489819.3424800007,0.0,0.0,2760.80320139961,242945.6391670409,-101.30966137912259,9193.92156446972,-4420.850807108351,-1329919.6008488624,true,true,24.40878001,2166.033349700001,0.0,121.92,1644.2724500334996,231.0,24.40878001,2166.033349700001,0.0,121.92,0.0,295.15 +232,27502.400922409543,26802.400922409543,0.3175,11260.95518298232,1531169.0704388255,700.0,162400.0,37672.29978892069,5815534.1089048935,26411.34460593837,4284365.038466057,true,232.0,232,0.875,9853.33578510953,11260.95518298232,1407.6193978727897,0.0,0.0,232,26802.400922409543,0.0,9853.33578510953,9853.33578510953,1015358.9081536366,700.0,162400.0,7100.096427766651,270646.7655847825,0.0,489819.3424800007,0.0,0.0,2753.239357342879,245698.8785243838,0.0,9193.92156446972,-9853.33578510953,-1339772.936633972,true,true,24.40878001,2190.442129710001,0.0,121.92,1644.2724500334996,232.0,24.40878001,2190.442129710001,0.0,121.92,0.0,295.15 +233,33710.95518298232,33010.95518298232,0.33999999999999997,15497.0648254559,1546666.1352642814,700.0,163100.0,47638.42595722324,5863172.534862117,32141.361131767342,4316506.399597825,true,233.0,233,0.875,13559.931722273912,15497.0648254559,1937.1331031819882,0.0,0.0,233,33010.95518298232,0.0,13559.931722273912,13559.931722273912,1028918.8398759105,700.0,163100.0,7139.179439632134,277785.9450244146,3594.9922657898123,493414.3347457905,0.0,0.0,2758.281920235361,248457.16044461916,67.47809661660416,9261.399661086323,-13559.931722273912,-1353332.8683562458,true,true,24.49818946,2214.940319170001,0.0,121.92,1644.2724500334996,233.0,24.49818946,2214.940319170001,0.0,121.92,0.0,295.15 +234,37947.0648254559,37247.0648254559,0.35,17745.389573677432,1564411.5248379589,700.0,163800.0,52701.11306764981,5915873.647929767,34955.72349397237,4351462.123091797,true,234.0,234,0.875,15527.215876967752,17745.389573677432,2218.1736967096804,0.0,0.0,234,37247.0648254559,0.0,15527.215876967752,15527.215876967752,1044446.0557528783,700.0,163800.0,7237.513869214731,285023.4588936294,5417.133938236893,498831.46868402744,0.0,0.0,2770.8883271845743,251228.04877180373,101.67974233155273,9363.079403417876,-15527.215876967752,-1368860.0842332134,true,true,24.63230363,2239.572622800001,0.0,121.92,1644.2724500334996,234.0,24.63230363,2239.572622800001,0.0,121.92,0.0,295.15 +235,40195.38957367743,39495.38957367743,0.3516666666666666,20080.592215067383,1584492.1170530263,700.0,164500.0,59091.73141725323,5974965.379347021,39011.13920218585,4390473.262293983,true,235.0,235,0.875,17570.51818818396,20080.592215067383,2510.0740268834234,0.0,0.0,235,39495.38957367743,0.0,17570.51818818396,17570.51818818396,1062016.5739410622,700.0,164500.0,7376.693053191742,292400.15194682113,7268.851312673977,506100.31999670144,0.0,0.0,2788.5372975902546,254016.586069394,136.43652472798456,9499.51592814586,-17570.51818818396,-1386430.6024213973,true,true,24.81112254,2264.383745340001,0.0,121.92,1644.2724500334996,235.0,24.81112254,2264.383745340001,0.0,121.92,0.0,295.15 +236,42530.59221506739,41830.59221506739,0.33999999999999997,16027.194947086708,1600519.312000113,700.0,165200.0,49197.63219731385,6024163.011544335,33170.43725022714,4423643.69954421,true,236.0,236,0.875,14023.795578700869,16027.194947086708,2003.399368385839,0.0,0.0,236,41830.59221506739,0.0,14023.795578700869,14023.795578700869,1076040.3695197632,700.0,165200.0,7497.400204863716,299897.5521516848,3654.142047476386,509754.4620441778,0.0,0.0,2803.6649868316877,256820.25105622568,68.58833952907825,9568.104267674938,-14023.795578700869,-1400454.3980000983,true,true,24.90053199,2289.2842773300013,0.0,121.92,1644.2724500334996,236.0,24.90053199,2289.2842773300013,0.0,121.92,0.0,295.15 +237,38477.19494708671,37777.19494708671,0.35333333333333333,20484.392913896423,1621003.7049140094,700.0,165900.0,59955.82900159365,6084118.840545928,39471.43608769723,4463115.135631907,true,237.0,237,0.875,17923.84379965937,20484.392913896423,2560.549114237052,0.0,0.0,237,37777.19494708671,0.0,17923.84379965937,17923.84379965937,1093964.2133194224,700.0,165900.0,7619.417000905944,307516.9691525908,7347.717282253684,517102.1793264315,0.0,0.0,2818.7926755091344,259639.04373173483,137.91684099060788,9706.021108665547,-17923.84379965937,-1418378.2417997576,true,true,25.07935089,2314.3636282200014,0.0,121.92,1644.2724500334996,237.0,25.07935089,2314.3636282200014,0.0,121.92,0.0,295.15 +238,42934.39291389642,42234.39291389642,0.345,16388.085271623022,1637391.7901856324,700.0,166600.0,49530.6819467334,6133649.522492661,33142.59667511038,4496257.732307017,true,238.0,238,0.875,14339.574612670145,16388.085271623022,2048.510658952877,0.0,0.0,238,42234.39291389642,0.0,14339.574612670145,14339.574612670145,1108303.7879320926,700.0,166600.0,7742.75051224483,315259.7196648356,3693.575234777205,520795.75456120865,0.0,0.0,2833.920364186581,262472.96409592143,69.32850146152813,9775.349610127076,-14339.574612670145,-1432717.8164124277,true,true,25.16876034,2339.5323885600014,0.0,121.92,1644.2724500334996,238.0,25.16876034,2339.5323885600014,0.0,121.92,0.0,295.15 +239,38838.08527162302,38138.08527162302,0.35,18700.03413159407,1656091.8243172264,700.0,167300.0,55428.668947411636,6189078.191440073,36728.63481581757,4532986.367122835,true,239.0,239,0.875,16362.529865144814,18700.03413159407,2337.5042664492576,0.0,0.0,239,38138.08527162302,0.0,16362.529865144814,16362.529865144814,1124666.3177972373,700.0,167300.0,7846.539358308673,323106.25902314426,5565.008386204887,526360.7629474135,0.0,0.0,2846.526771135794,265319.49086705723,104.45534949545944,9879.804959622536,-16362.529865144814,-1449080.3462775724,true,true,25.30287451,2364.8352630700015,0.0,121.92,1644.2724500334996,239.0,25.30287451,2364.8352630700015,0.0,121.92,0.0,295.15 +240,41150.034131594075,40450.034131594075,0.335,14495.2732101463,1670587.0975273727,700.0,168000.0,45359.024507899405,6234437.215947973,30863.751297753104,4563850.118420588,true,240.0,240,0.875,12683.364058878013,14495.2732101463,1811.909151268288,0.0,0.0,240,40450.034131594075,0.0,12683.364058878013,12683.364058878013,1137349.6818561153,700.0,168000.0,7930.2350759464825,331036.49409909075,1861.5752706507171,528222.3382180642,0.0,0.0,2856.6118969207587,268176.102763978,34.94181536005417,9914.74677498259,-12683.364058878013,-1461763.7103364505,true,true,25.34757924,2390.1828423100014,0.0,121.92,1644.2724500334996,240.0,25.34757924,2390.1828423100014,0.0,121.92,0.0,295.15 +241,36945.273210146304,36245.273210146304,0.33,12354.725451367505,1682941.82297874,700.0,168700.0,39559.77409505304,6273996.990043025,27205.048643685535,4591055.167064274,true,241.0,241,0.875,10810.384769946568,12354.725451367505,1544.3406814209375,0.0,0.0,241,36245.273210146304,0.0,10810.384769946568,10810.384769946568,1148160.066626062,700.0,168700.0,7951.251591297574,338987.7456903883,0.0,528222.3382180642,0.0,0.0,2859.133178648993,271035.235942627,0.0,9914.74677498259,-10810.384769946568,-1472574.095106397,true,true,25.34757924,2415.5304215500014,0.0,121.92,1644.2724500334996,241.0,25.34757924,2415.5304215500014,0.0,121.92,0.0,295.15 +242,34804.72545136751,34104.72545136751,0.28625,7969.897460729621,1690911.7204394697,700.0,169400.0,30287.851391195185,6304284.841434221,22317.953930465563,4613373.120994739,true,242.0,242,0.875,6973.660278138419,7969.897460729621,996.2371825912023,0.0,0.0,242,34104.72545136751,0.0,6973.660278138419,6973.660278138419,1155133.7269042004,700.0,169400.0,7909.255631443072,346897.00132183137,-3719.864026311334,524502.4741917528,0.0,0.0,2854.0906157565105,273889.32655838353,-69.82194274983004,9844.92483223276,-6973.660278138419,-1479547.7553845355,true,true,25.25816979,2440.7885913400014,0.0,121.92,1644.2724500334996,242.0,25.25816979,2440.7885913400014,0.0,121.92,0.0,295.15 +243,30419.897460729622,29719.897460729622,0.3175,12247.378123651391,1703159.0985631212,700.0,170100.0,40779.14369653982,6345063.985130761,28531.765572888427,4641904.886567628,true,243.0,243,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,243,29719.897460729622,0.0,10716.455858194968,10716.455858194968,1165850.1827623954,700.0,170100.0,7867.407805330939,354764.4091271623,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,276738.37461124756,0.0,9844.92483223276,-10716.455858194968,-1490264.2112427305,true,true,25.25816979,2466.0467611300014,0.0,121.92,1644.2724500334996,243.0,25.25816979,2466.0467611300014,0.0,121.92,0.0,295.15 +244,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1715406.4766867727,700.0,170800.0,40779.14369653982,6385843.128827301,28531.765572888427,4670436.652140517,true,244.0,244,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,244,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1176566.6386205903,700.0,170800.0,7867.407805330939,362631.81693249324,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,279587.4226641116,0.0,9844.92483223276,-10716.455858194968,-1500980.6671009255,true,true,25.25816979,2491.3049309200014,0.0,121.92,1644.2724500334996,244.0,25.25816979,2491.3049309200014,0.0,121.92,0.0,295.15 +245,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1727653.8548104241,700.0,171500.0,40779.14369653982,6426622.272523841,28531.765572888427,4698968.417713406,true,245.0,245,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,245,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1187283.0944787853,700.0,171500.0,7867.407805330939,370499.2247378242,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,282436.47071697563,0.0,9844.92483223276,-10716.455858194968,-1511697.1229591204,true,true,25.25816979,2516.5631007100014,0.0,121.92,1644.2724500334996,245.0,25.25816979,2516.5631007100014,0.0,121.92,0.0,295.15 +246,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1739901.2329340756,700.0,172200.0,40779.14369653982,6467401.416220381,28531.765572888427,4727500.183286294,true,246.0,246,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,246,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1197999.5503369803,700.0,172200.0,7867.407805330939,378366.6325431551,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,285285.51876983966,0.0,9844.92483223276,-10716.455858194968,-1522413.5788173154,true,true,25.25816979,2541.8212705000014,0.0,121.92,1644.2724500334996,246.0,25.25816979,2541.8212705000014,0.0,121.92,0.0,295.15 +247,34697.37812365139,33997.37812365139,0.3175,12247.378123651391,1752148.6110577271,700.0,172900.0,40779.14369653982,6508180.559916921,28531.765572888427,4756031.948859183,true,247.0,247,0.875,10716.455858194968,12247.378123651391,1530.9222654564237,0.0,0.0,247,33997.37812365139,0.0,10716.455858194968,10716.455858194968,1208716.0061951752,700.0,172900.0,7867.407805330939,386234.04034848604,0.0,524502.4741917528,0.0,0.0,2849.0480528640283,288134.5668227037,0.0,9844.92483223276,-10716.455858194968,-1533130.0346755104,true,true,25.25816979,2567.0794402900015,0.0,121.92,1644.2724500334996,247.0,25.25816979,2567.0794402900015,0.0,121.92,0.0,295.15 +248,34697.37812365139,33997.37812365139,0.30500000000000005,10060.85097415801,1762209.462031885,700.0,173600.0,35281.47860379674,6543462.038520718,25220.627629638733,4781252.576488822,true,248.0,248,0.875,8803.244602388258,10060.85097415801,1257.6063717697507,0.0,0.0,248,33997.37812365139,0.0,8803.244602388258,8803.244602388258,1217519.2507975635,700.0,173600.0,7846.539358308673,394080.5797067947,-1855.0030720320276,522647.47111972084,0.0,0.0,2846.526771135794,290981.0935938395,-34.8184550241824,9810.106377208578,-8803.244602388258,-1541933.2792778986,true,true,25.21346506,2592.2929053500015,0.0,121.92,1644.2724500334996,248.0,25.21346506,2592.2929053500015,0.0,121.92,0.0,295.15 +249,32510.85097415801,31810.85097415801,0.23500000000000001,5657.713358670035,1767867.175390555,700.0,174300.0,27054.099398595892,6570516.137919314,21396.386039925856,4802648.9625287475,true,249.0,249,0.875,4950.49918883628,5657.713358670035,707.2141698337546,0.0,0.0,249,31810.85097415801,0.0,4950.49918883628,4950.49918883628,1222469.7499863997,700.0,174300.0,7763.434605317927,401844.01431211265,-5545.291793289447,517102.1793264314,0.0,0.0,2836.4416453508297,293817.5352391903,-104.0852685430293,9706.021108665549,-4950.49918883628,-1546883.7784667348,true,true,25.07935089,2617.3722562400017,0.0,121.92,1644.2724500334996,249.0,25.07935089,2617.3722562400017,0.0,121.92,0.0,295.15 +250,28107.713358670037,27407.713358670037,0.23500000000000001,5533.654218389586,1773400.8296089447,700.0,175000.0,26526.18816335994,6597042.326082674,20992.533944970353,4823641.4964737175,true,250.0,250,0.875,4841.947441090888,5533.654218389586,691.7067772986984,0.0,0.0,250,27407.713358670037,0.0,4841.947441090888,4841.947441090888,1227311.6974274905,700.0,175000.0,7639.8809544382,409483.8952665508,-5515.717315186754,511586.4620112447,0.0,0.0,2821.313956673383,296638.8491958637,-103.5301548339413,9602.490953831608,-4841.947441090888,-1551725.7259078256,true,true,24.94523671,2642.3174929500015,0.0,121.92,1644.2724500334996,250.0,24.94523671,2642.3174929500015,0.0,121.92,0.0,295.15 +251,27983.654218389587,27283.654218389587,0.12,0.0,1773400.8296089447,700.0,175700.0,5833.333333333334,6602875.659416007,5833.333333333334,4829474.8298070505,true,251.0,251,0.875,0.0,0.0,0.0,0.0,0.0,251,27283.654218389587,0.0,-2761.4203759212214,-2761.4203759212214,1224550.2770515692,700.0,175700.0,7436.883360062817,416920.77862661367,-12754.993327217295,498831.4686840274,0.0,0.0,2796.1011416469855,299434.9503375107,-239.4115504137294,9363.079403417878,-0.0,-1551725.7259078256,true,true,24.63230363,2666.9497965800015,0.0,121.92,1644.2724500334996,251.0,24.63230363,2666.9497965800015,0.0,121.92,0.0,295.15 +252,22450.0,21750.0,0.14800000000000002,894.4390689274421,1774295.2686778721,700.0,176400.0,10773.236952212445,6613648.8963682195,9878.797883285002,4839353.627690336,true,252.0,252,0.875,782.6341853115118,894.4390689274421,111.8048836159303,0.0,0.0,252,21750.0,0.0,782.6341853115118,782.6341853115118,1225332.9112368808,700.0,176400.0,7198.072463994284,424118.85109060793,-9012.126204026707,489819.3424800007,0.0,0.0,2765.8457642920916,302200.7961018028,-169.1578389481569,9193.921564469721,-782.6341853115118,-1552508.3600931372,true,true,24.40878001,2691.3585765900016,0.0,121.92,1644.2724500334996,252.0,24.40878001,2691.3585765900016,0.0,121.92,0.0,295.15 +253,23344.43906892744,22644.43906892744,0.1888,2835.137938625249,1777130.4066164973,700.0,177100.0,18724.2475562778,6632373.143924497,15889.109617652553,4855242.737307988,true,253.0,253,0.875,2480.7456962970928,2835.137938625249,354.39224232815604,0.0,0.0,253,22644.43906892744,0.0,2480.7456962970928,2480.7456962970928,1227813.656933178,700.0,177100.0,7022.358840318837,431141.2099309268,-7150.551344278899,482668.7911357218,0.0,0.0,2743.1542315579145,304943.9503333607,-134.21603130075994,9059.70553316896,-2480.7456962970928,-1554989.1057894344,true,true,24.22996111,2715.588537700002,0.0,121.92,1644.2724500334996,253.0,24.22996111,2715.588537700002,0.0,121.92,0.0,295.15 +254,25285.13793862525,24585.13793862525,0.265,6871.484747150224,1784001.8913636475,700.0,177800.0,28571.640555283866,6660944.784479781,21700.15580813364,4876942.893116122,true,254.0,254,0.875,6012.549153756447,6871.484747150224,858.9355933937777,0.0,0.0,254,24585.13793862525,0.0,6012.549153756447,6012.549153756447,1233826.2060869343,700.0,177800.0,6906.819624049127,438048.0295549759,-3555.5590784889932,479113.2320572328,0.0,0.0,2728.0265428804673,307671.97687624115,-66.73793468415427,8992.967598484807,-6012.549153756447,-1561001.6549431907,true,true,24.14055166,2739.7290893600016,0.0,121.92,1644.2724500334996,254.0,24.14055166,2739.7290893600016,0.0,121.92,0.0,295.15 +255,29321.484747150225,28621.484747150225,0.22,4706.963926496867,1788708.8552901444,700.0,178500.0,24577.108756803944,6685521.893236585,19870.144830307076,4896813.037946429,true,255.0,255,0.875,4118.593435684759,4706.963926496867,588.3704908121081,0.0,0.0,255,28621.484747150225,0.0,4118.593435684759,4118.593435684759,1237944.799522619,700.0,178500.0,6811.510677876555,444859.54023285245,-5308.693073036055,473804.5389841968,0.0,0.0,2715.420135367269,310387.3970116084,-99.64430452300941,8893.323293961797,-4118.593435684759,-1565120.2483788754,true,true,24.00643748,2763.7355268400015,0.0,121.92,1644.2724500334996,255.0,24.00643748,2763.7355268400015,0.0,121.92,0.0,295.15 +256,27156.96392649687,26456.96392649687,0.29250000000000004,8737.313877614573,1797446.1691677591,700.0,179200.0,32264.32094910965,6717786.214185694,23527.007071495078,4920340.045017924,true,256.0,256,0.875,7645.149642912752,8737.313877614573,1092.1642347018214,0.0,0.0,256,26456.96392649687,0.0,7645.149642912752,7645.149642912752,1245589.9491655317,700.0,179200.0,6735.897932884319,451595.4381657368,-1762.9918966410187,472041.54708755575,0.0,0.0,2705.335009582304,313092.7320211907,-33.091402912852246,8860.231891048945,-7645.149642912752,-1572765.398021788,true,true,23.96173276,2787.6972596000014,0.0,121.92,1644.2724500334996,256.0,23.96173276,2787.6972596000014,0.0,121.92,0.0,295.15 +257,31187.31387761457,30487.31387761457,0.345,17008.348774698465,1814454.5179424577,700.0,179900.0,51328.547173039035,6769114.761358733,34320.198398340566,4954660.243416265,true,257.0,257,0.875,14882.305177861155,17008.348774698465,2126.0435968373095,0.0,0.0,257,30487.31387761457,0.0,14882.305177861155,14882.305177861155,1260472.2543433928,700.0,179900.0,6773.6339680248475,458369.07213376166,5298.834380744538,477340.3814683003,0.0,0.0,2710.377572474786,315803.10959366546,99.4592566169838,8959.691147665928,-14882.305177861155,-1587647.7031996492,true,true,24.09584693,2811.7931065300013,0.0,121.92,1644.2724500334996,257.0,24.09584693,2811.7931065300013,0.0,121.92,0.0,295.15 +258,39458.34877469846,38758.34877469846,0.33,13001.277785338274,1827455.795727796,700.0,180600.0,41519.023591934165,6810633.784950667,28517.745806595893,4983177.989222861,true,258.0,258,0.875,11376.11806217099,13001.277785338274,1625.159723167284,0.0,0.0,258,38758.34877469846,0.0,11376.11806217099,11376.11806217099,1271848.3724055637,700.0,180600.0,6849.528324159826,465218.6004579215,1772.8505889325352,479113.2320572328,0.0,0.0,2720.462698259751,318523.5722919252,33.276450818877855,8992.967598484805,-11376.11806217099,-1599023.8212618202,true,true,24.14055166,2835.933658190001,0.0,121.92,1644.2724500334996,258.0,24.14055166,2835.933658190001,0.0,121.92,0.0,295.15 +259,35451.27778533827,34751.27778533827,0.33,13054.476393387953,1840510.2721211838,700.0,181300.0,41680.231495115004,6852314.016445782,28625.755101727053,5011803.744324588,true,259.0,259,0.875,11422.666844214458,13054.476393387953,1631.8095491734948,0.0,0.0,259,34751.27778533827,0.0,11422.666844214458,11422.666844214458,1283271.0392497783,700.0,181300.0,6887.687168595054,472106.28762651654,1776.1362909377685,480889.3683481706,0.0,0.0,2725.5052611522333,321249.0775530774,33.33812352940316,9026.30572201421,-11422.666844214458,-1610446.4881060347,true,true,24.18525638,2860.118914570001,0.0,121.92,1644.2724500334996,259.0,24.18525638,2860.118914570001,0.0,121.92,0.0,295.15 +260,35504.47639338795,34804.47639338795,0.30500000000000005,11011.252756665037,1851521.5248778488,700.0,182000.0,38397.55002185257,6890711.566467634,27386.29726518753,5039190.041589776,true,260.0,260,0.875,9634.846162081907,11011.252756665037,1376.4065945831298,0.0,0.0,260,34804.47639338795,0.0,9634.846162081907,9634.846162081907,1292905.8854118602,700.0,182000.0,6906.819619765426,479013.107246282,0.0,480889.3683481706,0.0,0.0,2728.0265423164815,323977.1040953939,0.0,9026.30572201421,-9634.846162081907,-1620081.3342681166,true,true,24.18525638,2884.3041709500008,0.0,121.92,1644.2724500334996,260.0,24.18525638,2884.3041709500008,0.0,121.92,0.0,295.15 +261,33461.25275666504,32761.25275666504,0.22,4744.697955646035,1856266.222833495,700.0,182700.0,24748.62707111834,6915460.193538752,20003.929115472303,5059193.970705248,true,261.0,261,0.875,4151.61071119028,4744.697955646035,593.0872444557544,0.0,0.0,261,32761.25275666504,0.0,4151.61071119028,4151.61071119028,1297057.4961230506,700.0,182700.0,6849.5283241598245,485862.63557044184,-5318.550973659884,475570.8173745107,0.0,0.0,2720.4626982597506,326697.56679365365,-99.82933756941095,8926.476384444799,-4151.61071119028,-1624232.944979307,true,true,24.05114221,2908.3553131600006,0.0,121.92,1644.2724500334996,261.0,24.05114221,2908.3553131600006,0.0,121.92,0.0,295.15 +262,27194.697955646036,26494.697955646036,0.184,2562.5799635549047,1858828.8027970497,700.0,183400.0,17731.412845407092,6933191.606384159,15168.832881852188,5074362.8035871005,true,262.0,262,0.875,2242.2574681105416,2562.5799635549047,320.3224954443631,0.0,0.0,262,26494.697955646036,0.0,2242.2574681105416,2242.2574681105416,1299299.7535911612,700.0,183400.0,6717.082584440681,492579.71815488255,-7045.3965706689305,468525.4208038418,0.0,0.0,2702.8137278540703,329400.3805215077,-132.24227351527915,8794.23411092952,-2242.2574681105416,-1626475.2024474177,true,true,23.8723233,2932.2276364600007,0.0,121.92,1644.2724500334996,262.0,23.8723233,2932.2276364600007,0.0,121.92,0.0,295.15 +263,25012.579963554905,24312.579963554905,0.1792,2430.1589723205657,1861258.9617693704,700.0,184100.0,17467.404979467443,6950659.011363626,15037.246007146878,5089400.049594248,true,263.0,263,0.875,2126.389100780495,2430.1589723205657,303.76987154007065,0.0,0.0,263,24312.579963554905,0.0,2126.389100780495,2126.389100780495,1301426.1426919417,700.0,184100.0,6567.8196007111965,499147.5377555937,-6992.818592135086,461532.6022117067,0.0,0.0,2682.6434757201555,332083.02399722784,-131.25538351577077,8662.978727413749,-2126.389100780495,-1628601.5915481981,true,true,23.6935044,2955.921140860001,0.0,121.92,1644.2724500334996,263.0,23.6935044,2955.921140860001,0.0,121.92,0.0,295.15 +264,24880.158972320565,24180.158972320565,0.1768,2300.283542073498,1863559.245311444,700.0,184800.0,16969.929536614807,6967628.940900241,14669.645994541308,5104069.695588789,true,264.0,264,0.875,2012.7480993143108,2300.283542073498,287.5354427591874,0.0,0.0,264,24180.158972320565,0.0,2012.7480993143108,2012.7480993143108,1303438.890791256,700.0,184800.0,6420.7843851702655,505568.322140764,-6940.241009067015,454592.3612026397,0.0,0.0,2662.4732241502256,334745.4972213781,-130.26850093916545,8532.710226474583,-2012.7480993143108,-1630614.3396475124,true,true,23.5146855,2979.4358263600006,0.0,121.92,1644.2724500334996,264.0,23.5146855,2979.4358263600006,0.0,121.92,0.0,295.15 +265,24750.2835420735,24050.2835420735,0.124,154.26493346921157,1863713.5102449132,700.0,185500.0,6889.2333344291255,6974518.174234671,6734.968400959914,5110804.663989749,true,265.0,265,0.875,134.9818167855601,154.26493346921157,19.283116683651457,0.0,0.0,265,24050.2835420735,0.0,134.9818167855601,134.9818167855601,1303573.8726080416,700.0,185500.0,6258.011787985309,511826.3339287493,-8601.363843659363,445990.99735898036,0.0,0.0,2639.7816914160485,337385.27891279414,-161.44781895643413,8371.262407518148,-134.9818167855601,-1630749.321464298,true,true,23.29116188,3002.7269882400005,0.0,121.92,1644.2724500334996,265.0,23.29116188,3002.7269882400005,0.0,121.92,0.0,295.15 +266,22604.26493346921,21904.26493346921,0.33999999999999997,16119.54334734692,1879833.05359226,700.0,186200.0,49469.245139255654,7023987.419373926,33349.70179190874,5144154.365781657,true,266.0,266,0.875,14104.600428928556,16119.54334734692,2014.9429184183646,0.0,0.0,266,21904.26493346921,0.0,14104.600428928556,14104.600428928556,1317678.4730369702,700.0,186200.0,6222.217718175461,518048.55164692475,5150.959932776452,451141.9572917568,0.0,0.0,2634.739128523566,340020.0180413177,96.68364945307559,8467.946056971225,-14104.600428928556,-1644853.9218932267,true,true,23.42527605,3026.1522642900004,0.0,121.92,1644.2724500334996,266.0,23.42527605,3026.1522642900004,0.0,121.92,0.0,295.15 +267,38569.54334734692,37869.54334734692,0.1744,2110.2023014050033,1881943.255893665,700.0,186900.0,16113.54530622135,7040100.964680147,14003.343004816346,5158157.708786474,true,267.0,267,0.875,1846.427013729378,2110.2023014050033,263.77528767562535,0.0,0.0,267,37869.54334734692,0.0,1846.427013729378,1846.427013729378,1319524.9000506997,700.0,186900.0,6204.3719784734985,524252.92362539825,-6861.374634465189,444280.5826572916,0.0,0.0,2632.2178467953327,342652.23588811303,-128.78817707426418,8339.15787989696,-1846.427013729378,-1646700.3489069561,true,true,23.24645715,3049.3987214400004,0.0,121.92,1644.2724500334996,267.0,23.24645715,3049.3987214400004,0.0,121.92,0.0,295.15 +268,24560.202301405003,23860.202301405003,0.28625,7995.537524965263,1889938.7934186303,700.0,187600.0,30377.423668000923,7070478.388348148,22381.88614303566,5180539.594929509,true,268.0,268,0.875,6996.095334344605,7995.537524965263,999.442190620658,0.0,0.0,268,23860.202301405003,0.0,6996.095334344605,6996.095334344605,1326520.9953850443,700.0,187600.0,6115.654955296027,530368.5785806943,-1707.12822051195,442573.45443677966,0.0,0.0,2619.611439846119,345271.84732795914,-32.042840285590316,8307.11503961137,-6996.095334344605,-1653696.4442413007,true,true,23.20175243,3072.6004738700003,0.0,121.92,1644.2724500334996,268.0,23.20175243,3072.6004738700003,0.0,121.92,0.0,295.15 +269,30445.537524965264,29745.537524965264,0.25,5950.378200626575,1895889.1716192567,700.0,188300.0,26601.5128025063,7097079.901150654,20651.134601879723,5201190.729531389,true,269.0,269,0.875,5206.580925548253,5950.378200626575,743.797275078322,0.0,0.0,269,29745.537524965264,0.0,5206.580925548253,5206.580925548253,1331727.5763105925,700.0,188300.0,6062.832891182222,536431.4114718765,-3404.39890646357,439169.0555303161,0.0,0.0,2612.047595225403,347883.89492318453,-63.90065439580226,8243.214385215568,-5206.580925548253,-1658903.025166849,true,true,23.11234297,3095.7128168400004,0.0,121.92,1644.2724500334996,269.0,23.11234297,3095.7128168400004,0.0,121.92,0.0,295.15 +270,28400.378200626576,27700.378200626576,0.25,5874.208263532774,1901763.3798827894,700.0,189000.0,26296.833054131097,7123376.734204785,20422.624790598322,5221613.354321987,true,270.0,270,0.875,5139.932230591177,5874.208263532774,734.2760329415969,0.0,0.0,270,27700.378200626576,0.0,5139.932230591177,5139.932230591177,1336867.5085411835,700.0,189000.0,5992.877817502228,542424.2892893788,-3391.254129196618,435777.80140111945,0.0,0.0,2601.9624688764525,350485.857392061,-63.65392659088444,8179.560458624684,-5139.932230591177,-1664042.95739744,true,true,23.02293352,3118.7357503600006,0.0,121.92,1644.2724500334996,270.0,23.02293352,3118.7357503600006,0.0,121.92,0.0,295.15 +271,28324.208263532775,27624.208263532775,0.3175,11772.222923296884,1913535.6028060864,700.0,189700.0,39282.59188439963,7162659.326089185,27510.36896110275,5249123.72328309,true,271.0,271,0.875,10300.695057884774,11772.222923296884,1471.5278654121103,0.0,0.0,271,27624.208263532775,0.0,10300.695057884774,10300.695057884774,1347168.2035990683,700.0,189700.0,5975.473538623031,548399.7628280019,1693.9842047749257,437471.78560589434,0.0,0.0,2599.4411877122043,353085.29857977317,31.796126774612166,8211.356585399295,-10300.695057884774,-1674343.6524553248,true,true,23.06763825,3141.8033886100006,0.0,121.92,1644.2724500334996,271.0,23.06763825,3141.8033886100006,0.0,121.92,0.0,295.15 +272,34222.22292329688,33522.22292329688,0.335,13824.452969878786,1927360.055775965,700.0,190400.0,43356.57602948891,7206015.902118674,29532.123059610123,5278655.8463427,true,272.0,272,0.875,12096.396348643939,13824.452969878786,1728.0566212348476,0.0,0.0,272,33522.22292329688,0.0,12096.396348643939,12096.396348643939,1359264.5999477124,700.0,190400.0,6027.78770156914,554427.550529571,3397.8263278151207,440869.6119337095,0.0,0.0,2607.0050323329206,355692.3036121061,63.7772869267577,8275.133872326052,-12096.396348643939,-1686440.0488039688,true,true,23.1570477,3164.9604363100007,0.0,121.92,1644.2724500334996,272.0,23.1570477,3164.9604363100007,0.0,121.92,0.0,295.15 +273,36274.45296987879,35574.45296987879,0.33999999999999997,15946.034692120082,1943306.0904680851,700.0,191100.0,48958.92556505907,7254974.827683733,33012.89087293899,5311668.737215638,true,273.0,273,0.875,13952.780355605071,15946.034692120082,1993.2543365150104,0.0,0.0,273,35574.45296987879,0.0,13952.780355605071,13952.780355605071,1373217.3803033174,700.0,191100.0,6115.654955296027,560543.2054848671,5121.385425270829,445990.9973589803,0.0,0.0,2619.611439846119,358311.9150519522,96.12853519209577,8371.262407518148,-13952.780355605071,-1700392.829159574,true,true,23.29116188,3188.2515981900005,0.0,121.92,1644.2724500334996,273.0,23.29116188,3188.2515981900005,0.0,121.92,0.0,295.15 +274,38396.03469212008,37696.03469212008,0.35,18149.61369692742,1961455.7041650126,700.0,191800.0,53856.039134078346,7308830.8668178115,35706.42543715093,5347375.162652789,true,274.0,274,0.875,15880.911984811493,18149.61369692742,2268.701712115926,0.0,0.0,274,37696.03469212008,0.0,15880.911984811493,15880.911984811493,1389098.292288129,700.0,191800.0,6240.097645111396,566783.3031299785,6874.519031702288,452865.5163906826,0.0,0.0,2637.2604102518003,360949.175462204,129.03489774600922,8500.297305264157,-15880.911984811493,-1716273.7411443854,true,true,23.46998078,3211.7215789700003,0.0,121.92,1644.2724500334996,274.0,23.46998078,3211.7215789700003,0.0,121.92,0.0,295.15 +275,40599.61369692742,39899.61369692742,0.35333333333333333,20448.319973537084,1981904.0241385496,700.0,192500.0,59853.735774161556,7368684.602591973,39405.41580062447,5386780.578453413,true,275.0,275,0.875,17892.279976844948,20448.319973537084,2556.039996692136,0.0,0.0,275,39899.61369692742,0.0,17892.279976844948,17892.279976844948,1406990.572264974,700.0,192500.0,6402.560790685292,573185.8639206637,8667.08582102409,461532.6022117067,0.0,0.0,2659.9519429859774,363609.12740518997,162.68142214959036,8662.978727413747,-17892.279976844948,-1734166.0211212304,true,true,23.6935044,3235.4150833700005,0.0,121.92,1644.2724500334996,275.0,23.6935044,3235.4150833700005,0.0,121.92,0.0,295.15 +276,42898.31997353709,42198.31997353709,0.35333333333333333,20782.836772532737,2002686.8609110822,700.0,193200.0,60800.481431696426,7429485.084023669,40017.64465916369,5426798.223112577,true,276.0,276,0.875,18184.982175966146,20782.836772532737,2597.8545965665908,0.0,0.0,276,42198.31997353709,0.0,18184.982175966146,18184.982175966146,1425175.5544409403,700.0,193200.0,6586.355300875975,579772.2192215397,8749.238684153715,470281.8408958604,0.0,0.0,2685.164757448389,366294.29216263833,164.2234334880662,8827.202160901814,-18184.982175966146,-1752351.0032971967,true,true,23.91702803,3259.3321114000005,0.0,121.92,1644.2724500334996,276.0,23.91702803,3259.3321114000005,0.0,121.92,0.0,295.15 +277,43232.83677253274,42532.83677253274,0.35333333333333333,21121.335016520046,2023808.1959276022,700.0,193900.0,61758.495329773716,7491243.579353443,40637.16031325367,5467435.38342583,true,277.0,277,0.875,18481.16813945504,21121.335016520046,2640.1668770650067,0.0,0.0,277,42532.83677253274,0.0,18481.16813945504,18481.16813945504,1443656.7225803954,700.0,193900.0,6773.6339680248475,586545.8531895645,8831.391161372416,479113.2320572328,0.0,0.0,2710.377572474786,369004.6697351131,165.7654375829915,8992.967598484805,-18481.16813945504,-1770832.1714366518,true,true,24.14055166,3283.4726630600003,0.0,121.92,1644.2724500334996,277.0,24.14055166,3283.4726630600003,0.0,121.92,0.0,295.15 +278,43571.335016520046,42871.335016520046,0.3585,29935.093337644474,2053743.2892652466,700.0,194600.0,85453.53790137928,7576697.1172548225,55518.44456373481,5522953.827989565,true,278.0,278,0.875,26193.206670438914,29935.093337644474,3741.886667205559,0.0,0.0,278,42871.335016520046,0.0,26193.206670438914,26193.206670438914,1469849.9292508343,700.0,194600.0,7041.739762263368,593587.5929518279,16103.527768089347,495216.75982532214,0.0,0.0,2745.6755127221627,371750.34524783527,302.2636273640368,9295.231225848842,-26193.206670438914,-1797025.3781070907,true,true,24.54289418,3308.0155572400004,0.0,121.92,1644.2724500334996,278.0,24.54289418,3308.0155572400004,0.0,121.92,0.0,295.15 +279,52385.093337644474,51685.093337644474,0.355,22090.63197920612,2075833.9212444527,700.0,195300.0,64198.96332170738,7640896.08057653,42108.33134250126,5565062.159332067,true,279.0,279,0.875,19329.302981805355,22090.63197920612,2761.328997400764,0.0,0.0,279,51685.093337644474,0.0,19329.302981805355,19329.302981805355,1489179.2322326396,700.0,195300.0,7316.82838744362,600904.4213392716,9061.418092439995,504278.17791776214,0.0,0.0,2780.973452969539,374531.3187008048,170.08304895220277,9465.314274801045,-19329.302981805355,-1816354.681088896,true,true,24.76641781,3332.7819750500003,0.0,121.92,1644.2724500334996,279.0,24.76641781,3332.7819750500003,0.0,121.92,0.0,295.15 +280,44540.63197920612,43840.63197920612,0.33999999999999997,15967.630363967744,2091801.5516084204,700.0,196000.0,49022.442246963954,7689918.522823494,33054.81188299621,5598116.971215063,true,280.0,280,0.875,13971.676568471776,15967.630363967744,1995.9537954959687,0.0,0.0,280,43840.63197920612,0.0,13971.676568471776,13971.676568471776,1503150.9088011114,700.0,196000.0,7457.019317045467,608361.440656317,3647.5698488578832,507925.74776662,0.0,0.0,2798.62242337522,377329.94112418,68.464979193205,9533.77925399425,-13971.676568471776,-1830326.3576573678,true,true,24.85582726,3357.63780231,0.0,121.92,1644.2724500334996,280.0,24.85582726,3357.63780231,0.0,121.92,0.0,295.15 +281,38417.63036396774,37717.63036396774,0.35333333333333333,20416.67645217178,2112218.2280605924,700.0,196700.0,59764.17863822202,7749682.701461716,39347.502186050246,5637464.473401113,true,281.0,281,0.875,17864.59189565031,20416.67645217178,2552.084556521473,0.0,0.0,281,37717.63036396774,0.0,17864.59189565031,17864.59189565031,1521015.5006967618,700.0,196700.0,7578.598778262287,615940.0394345793,7334.572885016492,515260.3206516365,0.0,0.0,2813.7501120526667,380143.69123623264,137.67012031886284,9671.449374313112,-17864.59189565031,-1848190.9495530182,true,true,25.03464616,3382.6724484700003,0.0,121.92,1644.2724500334996,281.0,25.03464616,3382.6724484700003,0.0,121.92,0.0,295.15 +282,42866.676452171785,42166.676452171785,0.3175,11981.962004502686,2124200.190065095,700.0,197400.0,39943.18741575649,7789625.888877472,27961.225411253803,5665425.698812367,true,282.0,282,0.875,10484.21675393985,11981.962004502686,1497.7452505628353,0.0,0.0,282,42166.676452171785,0.0,10484.21675393985,10484.21675393985,1531499.7174507016,700.0,197400.0,7660.38151610222,623600.4209506816,0.0,515260.3206516365,0.0,0.0,2823.835237837631,382967.52647407027,0.0,9671.449374313112,-10484.21675393985,-1858675.166306958,true,true,25.03464616,3407.7070946300005,0.0,121.92,1644.2724500334996,282.0,25.03464616,3407.7070946300005,0.0,121.92,0.0,295.15 +283,34431.96200450268,33731.96200450268,0.28,7651.877269033446,2131852.0673341285,700.0,198100.0,29828.133103690878,7819454.021981163,22176.25583465743,5687601.954647025,true,283.0,283,0.875,6695.392610404266,7651.877269033446,956.4846586291806,0.0,0.0,283,33731.96200450268,0.0,6695.392610404266,6695.392610404266,1538195.1100611058,700.0,198100.0,7619.416996332449,631219.837947014,-3673.8586403918252,511586.4620112447,0.0,0.0,2818.7926749451485,385786.3191490154,-68.9584204815069,9602.490953831604,-6695.392610404266,-1865370.5589173622,true,true,24.94523671,3432.6523313400003,0.0,121.92,1644.2724500334996,283.0,24.94523671,3432.6523313400003,0.0,121.92,0.0,295.15 +284,30101.877269033444,29401.877269033444,0.12,0.0,2131852.0673341285,700.0,198800.0,5833.333333333334,7825287.355314496,5833.333333333334,5693435.287980358,true,284.0,284,0.875,0.0,0.0,0.0,0.0,0.0,284,29401.877269033444,0.0,-892.4627437324007,-892.4627437324007,1537302.6473173734,700.0,198800.0,7457.019317045463,638676.8572640595,-10942.709546573462,500643.7524646712,0.0,0.0,2798.6224233752196,388584.9415723906,-205.39493757962094,9397.096016251984,-0.0,-1865370.5589173622,true,true,24.67700836,3457.3293397,0.0,121.92,1644.2724500334996,284.0,24.67700836,3457.3293397,0.0,121.92,0.0,295.15 +285,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,199500.0,5833.333333333334,7831120.688647829,5833.333333333334,5699268.621313691,true,285.0,285,0.875,0.0,0.0,0.0,0.0,0.0,285,21750.0,0.0,-2889.8799247811494,-2889.8799247811494,1534412.7673925923,700.0,199500.0,7198.072463994284,645874.9297280537,-12616.977169458767,488026.77529521246,0.0,0.0,2765.8457642920916,391350.7873366827,-236.8209836087585,9160.275032643225,-0.0,-1865370.5589173622,true,true,24.36407528,3481.6934149800004,0.0,121.92,1644.2724500334996,285.0,24.36407528,3481.6934149800004,0.0,121.92,0.0,295.15 +286,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,200200.0,5833.333333333334,7836954.021981162,5833.333333333334,5705101.954647024,true,286.0,286,0.875,0.0,0.0,0.0,0.0,0.0,286,21750.0,0.0,-6672.0789195037305,-6672.0789195037305,1527740.6884730884,700.0,200200.0,6887.687168595054,652762.6168966488,-15985.228207656735,472041.54708755575,0.0,0.0,2725.5052611522333,394076.29259783495,-300.0431415942827,8860.231891048943,-0.0,-1865370.5589173622,true,true,23.96173276,3505.6551477400003,0.0,121.92,1644.2724500334996,286.0,23.96173276,3505.6551477400003,0.0,121.92,0.0,295.15 +287,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,200900.0,5833.333333333334,7842787.355314495,5833.333333333334,5710935.287980357,true,287.0,287,0.875,0.0,0.0,0.0,0.0,0.0,287,21750.0,0.0,-10348.464415796621,-10348.464415796621,1517392.2240572919,700.0,200900.0,6512.421234633904,659275.0381312827,-19176.03069687315,452865.5163906826,0.0,0.0,2675.0796322274105,396751.3722300624,-359.9345857847864,8500.297305264157,-0.0,-1865370.5589173622,true,true,23.46998078,3529.12512852,0.0,121.92,1644.2724500334996,287.0,23.46998078,3529.12512852,0.0,121.92,0.0,295.15 +288,22450.0,21750.0,0.12,0.0,2131852.0673341285,700.0,201600.0,5833.333333333334,7848620.688647828,5833.333333333334,5716768.62131369,true,288.0,288,0.875,0.0,0.0,0.0,0.0,0.0,288,21750.0,0.0,-8652.988869572982,-8652.988869572982,1508739.2351877189,700.0,201600.0,6133.330245619286,665408.368376902,-17087.714989563163,435777.80140111945,0.0,0.0,2622.1327210103673,399373.50495107274,-320.73684663947483,8179.560458624683,-0.0,-1865370.5589173622,true,true,23.02293352,3552.1480620400002,0.0,121.92,1644.2724500334996,288.0,23.02293352,3552.1480620400002,0.0,121.92,0.0,295.15 +289,22450.0,21750.0,0.30500000000000005,9777.169018347473,2141629.236352476,700.0,202300.0,34351.37383064745,7882972.062478475,24574.204812299977,5741342.826125991,true,289.0,289,0.875,8555.022891054039,9777.169018347473,1222.146127293434,0.0,0.0,289,21750.0,0.0,8555.022891054039,8555.022891054039,1517294.2580787728,700.0,202300.0,5958.102985070068,671366.471361972,0.0,435777.80140111945,0.0,0.0,2596.9199059839702,401970.4248570567,0.0,8179.560458624683,-8555.022891054039,-1873925.5818084162,true,true,23.02293352,3575.1709955600004,0.0,121.92,1644.2724500334996,289.0,23.02293352,3575.1709955600004,0.0,121.92,0.0,295.15 +290,32227.16901834747,31527.16901834747,0.30500000000000005,9777.169018347473,2151406.405370823,700.0,203000.0,34351.37383064745,7917323.4363091225,24574.204812299977,5765917.030938291,true,290.0,290,0.875,8555.022891054039,9777.169018347473,1222.146127293434,0.0,0.0,290,31527.16901834747,0.0,8555.022891054039,8555.022891054039,1525849.2809698267,700.0,203000.0,5958.102985070068,677324.5743470421,0.0,435777.80140111945,0.0,0.0,2596.9199059839702,404567.34476304066,0.0,8179.560458624683,-8555.022891054039,-1882480.60469947,true,true,23.02293352,3598.1939290800005,0.0,121.92,1644.2724500334996,290.0,23.02293352,3598.1939290800005,0.0,121.92,0.0,295.15 +291,32227.16901834747,31527.16901834747,0.1696,1835.5993535425316,2153242.0047243657,700.0,203700.0,14950.467886453605,7932273.904195576,13114.868532911074,5779031.899471202,true,291.0,291,0.875,1606.1494343497152,1835.5993535425316,229.44991919281642,0.0,0.0,291,31527.16901834747,0.0,1606.1494343497152,1606.1494343497152,1527455.4304041765,700.0,203700.0,5888.957416492257,683213.5317635344,-6743.075071092229,429034.7263300272,0.0,0.0,2586.8347801990058,407154.17954323965,-126.56769124931749,8052.9927673753655,-1606.1494343497152,-1884086.7541338198,true,true,22.84411462,3621.0380437000003,0.0,121.92,1644.2724500334996,291.0,22.84411462,3621.0380437000003,0.0,121.92,0.0,295.15 +292,24285.59935354253,23585.59935354253,0.12,0.0,2153242.0047243657,700.0,204400.0,5833.333333333334,7938107.237528909,5833.333333333334,5784865.232804535,true,292.0,292,0.875,0.0,0.0,0.0,0.0,0.0,292,23585.59935354253,0.0,-8737.062071870416,-8737.062071870416,1518718.3683323062,700.0,204400.0,5651.163456837206,688864.6952203716,-16627.660751808584,412407.0655782186,0.0,0.0,2551.5368399516296,409705.7163831913,-312.1016168506692,7740.891150524696,-0.0,-1884086.7541338198,true,true,22.39706737,3643.4351110700004,0.0,121.92,1644.2724500334996,292.0,22.39706737,3643.4351110700004,0.0,121.92,0.0,295.15 +293,22450.0,21750.0,0.28,7219.567138277719,2160461.5718626436,700.0,205100.0,28284.16835099185,7966391.405879901,21064.601212714133,5805929.834017249,true,293.0,293,0.875,6317.121245993004,7219.567138277719,902.4458922847152,0.0,0.0,293,21750.0,0.0,6317.121245993004,6317.121245993004,1525035.4895782992,700.0,205100.0,5468.882141248776,694333.5773616204,-1644.6927147680865,410762.3728634505,0.0,0.0,2523.802743760984,412229.5191269523,-30.870924248669432,7710.020226276027,-6317.121245993004,-1890403.875379813,true,true,22.35236264,3665.7874737100005,0.0,121.92,1644.2724500334996,293.0,22.35236264,3665.7874737100005,0.0,121.92,0.0,295.15 +294,29669.56713827772,28969.56713827772,0.3175,11049.426884601733,2171510.9987472454,700.0,205800.0,37006.068927879474,8003397.47480778,25956.64204327774,5831886.476060526,true,294.0,294,0.875,9668.248524026516,11049.426884601733,1381.178360575217,0.0,0.0,294,28969.56713827772,0.0,9668.248524026516,9668.248524026516,1534703.7381023257,700.0,205800.0,5468.882141248776,699802.4595028692,1644.6927147680865,412407.0655782186,0.0,0.0,2523.802743760984,414753.32187071326,30.870924248669432,7740.891150524696,-9668.248524026516,-1900072.1239038394,true,true,22.39706737,3688.1845410800006,0.0,121.92,1644.2724500334996,294.0,22.39706737,3688.1845410800006,0.0,121.92,0.0,295.15 +295,33499.42688460174,32799.42688460174,0.28,7219.567138277719,2178730.5658855233,700.0,206500.0,28284.16835099185,8031681.643158772,21064.601212714133,5852951.07727324,true,295.0,295,0.875,6317.121245993004,7219.567138277719,902.4458922847152,0.0,0.0,295,32799.42688460174,0.0,6317.121245993004,6317.121245993004,1541020.8593483188,700.0,206500.0,5468.882141248776,705271.341644118,-1644.6927147680865,410762.3728634505,0.0,0.0,2523.802743760984,417277.12461447425,-30.870924248669432,7710.020226276027,-6317.121245993004,-1906389.2451498325,true,true,22.35236264,3710.5369037200007,0.0,121.92,1644.2724500334996,295.0,22.35236264,3710.5369037200007,0.0,121.92,0.0,295.15 +296,29669.56713827772,28969.56713827772,0.16240000000000002,1405.439824202442,2180136.005709726,700.0,207200.0,12964.530937207152,8044646.174095979,11559.09111300471,5864510.168386245,true,296.0,296,0.875,1229.7598461771368,1405.439824202442,175.67997802530522,0.0,0.0,296,28969.56713827772,0.0,1229.7598461771368,1229.7598461771368,1542250.619194496,700.0,207200.0,5387.339524606311,710658.6811687243,-6545.9091331174905,404216.463730333,0.0,0.0,2511.1963362477854,419788.32095072203,-122.86688155946955,7587.1533447165575,-1229.7598461771368,-1907619.0049960096,true,true,22.17354374,3732.7104474600005,0.0,121.92,1644.2724500334996,296.0,22.17354374,3732.7104474600005,0.0,121.92,0.0,295.15 +297,23855.43982420244,23155.43982420244,0.265,7024.430942910579,2187160.4366526366,700.0,207900.0,29148.796010983315,8073794.970106962,22124.365068072737,5886634.533454318,true,297.0,297,0.875,6146.3770750467565,7024.430942910579,878.0538678638222,0.0,0.0,297,23155.43982420244,0.0,6146.3770750467565,6146.3770750467565,1548396.9962695427,700.0,207900.0,5306.611516316375,715965.2926850407,-1628.2618539957336,402588.2018763373,0.0,0.0,2498.5899292985728,422286.9108800206,-30.562516572457934,7556.5908281441,-6146.3770750467565,-1913765.3820710564,true,true,22.12883902,3754.8392864800007,0.0,121.92,1644.2724500334996,297.0,22.12883902,3754.8392864800007,0.0,121.92,0.0,295.15 +298,29474.430942910578,28774.430942910578,0.29250000000000004,8899.00795077031,2196059.444603407,700.0,208600.0,32817.12119921473,8106612.091306177,23918.113248444417,5910552.646702762,true,298.0,298,0.875,7786.631956924022,8899.00795077031,1112.375993846288,0.0,0.0,298,28774.430942910578,0.0,7786.631956924022,7786.631956924022,1556183.6282264667,700.0,208600.0,5290.563308789698,721255.8559938305,0.0,402588.2018763373,0.0,0.0,2496.0686481343246,424782.9795281549,0.0,7556.5908281441,-7786.631956924022,-1921552.0140279804,true,true,22.12883902,3776.968125500001,0.0,121.92,1644.2724500334996,298.0,22.12883902,3776.968125500001,0.0,121.92,0.0,295.15 +299,31349.007950770312,30649.007950770312,0.29250000000000004,8899.00795077031,2204958.452554177,700.0,209300.0,32817.12119921473,8139429.212505392,23918.113248444417,5934470.759951206,true,299.0,299,0.875,7786.631956924022,8899.00795077031,1112.375993846288,0.0,0.0,299,30649.007950770312,0.0,7786.631956924022,7786.631956924022,1563970.2601833907,700.0,209300.0,5290.563308789698,726546.4193026202,0.0,402588.2018763373,0.0,0.0,2496.0686481343246,427279.0481762892,0.0,7556.5908281441,-7786.631956924022,-1929338.6459849044,true,true,22.12883902,3799.096964520001,0.0,121.92,1644.2724500334996,299.0,22.12883902,3799.096964520001,0.0,121.92,0.0,295.15 +300,31349.007950770312,30649.007950770312,0.16,1269.5509846424227,2206228.0035388195,700.0,210000.0,12309.693654015142,8151738.9061594065,11040.142669372719,5945510.902620578,true,300.0,300,0.875,1110.8571115621198,1269.5509846424227,158.69387308030286,0.0,0.0,300,30649.007950770312,0.0,1110.8571115621198,1110.8571115621198,1565081.1172949527,700.0,210000.0,5226.694023331791,731773.113325952,-6480.187155752717,396108.01472058456,0.0,0.0,2485.98352234936,429765.0316986386,-121.6332783663133,7434.957549777787,-1110.8571115621198,-1930449.5030964664,true,true,21.95002012,3821.046984640001,0.0,121.92,1644.2724500334996,300.0,21.95002012,3821.046984640001,0.0,121.92,0.0,295.15 +301,23719.55098464242,23019.55098464242,0.12,0.0,2206228.0035388195,700.0,210700.0,5833.333333333334,8157572.23949274,5833.333333333334,5951344.235953911,true,301.0,301,0.875,0.0,0.0,0.0,0.0,0.0,301,23019.55098464242,0.0,-628.7867294235994,-628.7867294235994,1564452.3305655292,700.0,210700.0,5084.871976335696,736857.9853022876,-8026.296897123215,388081.71782346134,0.0,0.0,2463.2919890511967,432228.3236876898,-150.65379768727655,7284.30375209051,-0.0,-1930449.5030964664,true,true,21.72649649,3842.773481130001,0.0,121.92,1644.2724500334996,301.0,21.72649649,3842.773481130001,0.0,121.92,0.0,295.15 +302,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,211400.0,5833.333333333334,8163405.572826073,5833.333333333334,5957177.569287244,true,302.0,302,0.875,0.0,0.0,0.0,0.0,0.0,302,21750.0,0.0,-724.8497054925183,-724.8497054925183,1563727.4808600366,700.0,211400.0,4930.327333979124,741788.3126362667,-7944.144419904093,380137.57340355724,0.0,0.0,2438.0791740247996,434666.4028617146,-149.11179359234828,7135.1919584981615,-0.0,-1930449.5030964664,true,true,21.50297286,3864.276453990001,0.0,121.92,1644.2724500334996,302.0,21.50297286,3864.276453990001,0.0,121.92,0.0,295.15 +303,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,212100.0,5833.333333333334,8169238.906159406,5833.333333333334,5963010.902620577,true,303.0,303,0.875,0.0,0.0,0.0,0.0,0.0,303,21750.0,0.0,-7234.897095339675,-7234.897095339675,1556492.583764697,700.0,212100.0,4719.272267415918,746507.5849036826,-14092.435227503207,366045.13817605405,0.0,0.0,2402.781233777423,437069.184095492,-264.515369029808,6870.676589468353,-0.0,-1930449.5030964664,true,true,21.10063034,3885.377084330001,0.0,121.92,1644.2724500334996,303.0,21.10063034,3885.377084330001,0.0,121.92,0.0,295.15 +304,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,212800.0,5833.333333333334,8175072.239492739,5833.333333333334,5968844.23595391,true,304.0,304,0.875,0.0,0.0,0.0,0.0,0.0,304,21750.0,0.0,-10398.430035561676,-10398.430035561676,1546094.1537291352,700.0,212800.0,4428.343113446938,750935.9280171295,-16862.617002191924,349182.52117386216,0.0,0.0,2352.3556048526,439421.5397003446,-316.5117516692918,6554.164837799061,-0.0,-1930449.5030964664,true,true,20.60887836,3905.9859626900006,0.0,121.92,1644.2724500334996,304.0,20.60887836,3905.9859626900006,0.0,121.92,0.0,295.15 +305,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,213500.0,5833.333333333334,8180905.572826072,5833.333333333334,5974677.569287243,true,305.0,305,0.875,0.0,0.0,0.0,0.0,0.0,305,21750.0,0.0,-10354.74740584708,-10354.74740584708,1535739.406323288,700.0,213500.0,4122.412655868705,755058.3406729982,-16464.999022155116,332717.52215170703,0.0,0.0,2296.887412471309,441718.4271128159,-309.04845203197704,6245.1163857670845,-0.0,-1930449.5030964664,true,true,20.11712638,3926.103089070001,0.0,121.92,1644.2724500334996,305.0,20.11712638,3926.103089070001,0.0,121.92,0.0,295.15 +306,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,214200.0,5833.333333333334,8186738.906159405,5833.333333333334,5980510.902620576,true,306.0,306,0.875,0.0,0.0,0.0,0.0,0.0,306,21750.0,0.0,-11780.075346034955,-11780.075346034955,1523959.3309772532,700.0,214200.0,3817.993891481396,758876.3345644796,-17508.335276281618,315209.1868754254,0.0,0.0,2238.8979389257697,443957.3250517417,-328.63190016050356,5916.484485606581,-0.0,-1930449.5030964664,true,true,19.58066968,3945.683758750001,0.0,121.92,1644.2724500334996,306.0,19.58066968,3945.683758750001,0.0,121.92,0.0,295.15 +307,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,214900.0,5833.333333333334,8192572.239492738,5833.333333333334,5986344.235953909,true,307.0,307,0.875,0.0,0.0,0.0,0.0,0.0,307,21750.0,0.0,-11659.782000463774,-11659.782000463774,1512299.5489767895,700.0,214900.0,3516.7181205421844,762393.0526850219,-17035.137341809237,298174.04953361617,0.0,0.0,2178.387183651997,446135.71223539364,-319.74996284871855,5596.734522757863,-0.0,-1930449.5030964664,true,true,19.04421297,3964.727971720001,0.0,121.92,1644.2724500334996,307.0,19.04421297,3964.727971720001,0.0,121.92,0.0,295.15 +308,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,215600.0,5833.333333333334,8198405.572826071,5833.333333333334,5992177.569287242,true,308.0,308,0.875,0.0,0.0,0.0,0.0,0.0,308,21750.0,0.0,-10121.475404698795,-10121.475404698795,1502178.0735720906,700.0,215600.0,3243.2790685707714,765636.3317535927,-15199.850599538468,282974.1989340777,0.0,0.0,2120.397710106457,448256.1099455001,-285.3015838375548,5311.432938920308,-0.0,-1930449.5030964664,true,true,18.552461,3983.280432720001,0.0,121.92,1644.2724500334996,308.0,18.552461,3983.280432720001,0.0,121.92,0.0,295.15 +309,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,216300.0,5833.333333333334,8204238.906159404,5833.333333333334,5998010.902620575,true,309.0,309,0.875,0.0,0.0,0.0,0.0,0.0,309,21750.0,0.0,-11384.09743178823,-11384.09743178823,1490793.9761403024,700.0,216300.0,2984.3945822240516,768620.7263358168,-16128.174012570968,266846.0249215067,0.0,0.0,2062.4082365609183,450318.51818206103,-302.7262380022311,5008.706700918076,-0.0,-1930449.5030964664,true,true,18.01600429,4001.2964370100012,0.0,121.92,1644.2724500334996,309.0,18.01600429,4001.2964370100012,0.0,121.92,0.0,295.15 +310,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,217000.0,5833.333333333334,8210072.239492737,5833.333333333334,6003844.235953908,true,310.0,310,0.875,0.0,0.0,0.0,0.0,0.0,310,21750.0,0.0,-19087.746357493637,-19087.746357493637,1471706.2297828088,700.0,217000.0,2667.933401837301,771288.659737654,-23305.013847006212,243541.01107450048,0.0,0.0,1986.769792609698,452305.2879746707,-437.4357049344245,4571.270995983652,-0.0,-1930449.5030964664,true,true,17.21131924,4018.5077562500014,0.0,121.92,1644.2724500334996,310.0,17.21131924,4018.5077562500014,0.0,121.92,0.0,295.15 +311,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,217700.0,5833.333333333334,8215905.57282607,5833.333333333334,6009677.569287241,true,311.0,311,0.875,0.0,0.0,0.0,0.0,0.0,311,21750.0,0.0,-14706.642087531278,-14706.642087531278,1456999.5876952775,700.0,217700.0,2346.5898450857985,773635.2495827398,-18607.535520411107,224933.47555408938,0.0,0.0,1903.567504601747,454208.85547927243,-349.26391680771457,4222.007079175937,-0.0,-1930449.5030964664,true,true,16.54074836,4035.0485046100016,0.0,121.92,1644.2724500334996,311.0,16.54074836,4035.0485046100016,0.0,121.92,0.0,295.15 +312,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,218400.0,5833.333333333334,8221738.906159403,5833.333333333334,6015510.902620574,true,312.0,312,0.875,0.0,0.0,0.0,0.0,0.0,312,21750.0,0.0,-17881.35936930364,-17881.35936930364,1439118.228325974,700.0,218400.0,2052.144436415595,775687.3940191554,-21353.07132773848,203580.4042263509,0.0,0.0,1820.3652160298104,456029.22069530224,-400.7976940105636,3821.2093851653735,-0.0,-1930449.5030964664,true,true,15.7360633,4050.7845679100014,0.0,121.92,1644.2724500334996,312.0,15.7360633,4050.7845679100014,0.0,121.92,0.0,295.15 +313,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,219100.0,5833.333333333334,8227572.239492736,5833.333333333334,6021344.2359539075,true,313.0,313,0.875,0.0,0.0,0.0,0.0,0.0,313,21750.0,0.0,-12638.890927618613,-12638.890927618613,1426479.3373983554,700.0,219100.0,1791.198034470449,777478.5920536258,-15871.85799153213,187708.54623481876,0.0,0.0,1739.6842091861079,457768.90490448836,-297.91517974304213,3523.2942054223313,-0.0,-1930449.5030964664,true,true,15.11019715,4065.8947650600016,0.0,121.92,1644.2724500334996,313.0,15.11019715,4065.8947650600016,0.0,121.92,0.0,295.15 +314,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,219800.0,5833.333333333334,8233405.572826069,5833.333333333334,6027177.5692872405,true,314.0,314,0.875,0.0,0.0,0.0,0.0,0.0,314,21750.0,0.0,-11166.597014497831,-11166.597014497831,1415312.7403838576,700.0,219800.0,1589.0476381258886,779067.6396917517,-14161.443604452255,173547.1026303665,0.0,0.0,1671.609609855604,459440.514514344,-265.810658027069,3257.483547395262,-0.0,-1930449.5030964664,true,true,14.52903572,4080.423800780002,0.0,121.92,1644.2724500334996,314.0,14.52903572,4080.423800780002,0.0,121.92,0.0,295.15 +315,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,220500.0,5833.333333333334,8239238.906159402,5833.333333333334,6033010.9026205735,true,315.0,315,0.875,0.0,0.0,0.0,0.0,0.0,315,21750.0,0.0,-7669.930738957756,-7669.930738957756,1407642.8096448998,700.0,220500.0,1429.3423247747276,780496.9820165264,-10515.51668341161,163031.5859469549,0.0,0.0,1613.6201363100647,461054.13465065404,-197.37651663093877,3060.1070307643236,-0.0,-1930449.5030964664,true,true,14.08198847,4094.5057892500017,0.0,121.92,1644.2724500334996,315.0,14.08198847,4094.5057892500017,0.0,121.92,0.0,295.15 +316,22450.0,21750.0,0.12,0.0,2206228.0035388195,700.0,221200.0,5833.333333333334,8245072.239492735,5833.333333333334,6038844.235953907,true,316.0,316,0.875,0.0,0.0,0.0,0.0,0.0,316,21750.0,0.0,-6483.869724942868,-6483.869724942868,1401158.939919957,700.0,221200.0,1305.7833678344905,781802.7653843609,-9183.003668016738,153848.58227893818,0.0,0.0,1565.7157885494898,462619.85043920355,-172.36521331010988,2887.7418174542136,-0.0,-1930449.5030964664,true,true,13.67964594,4108.185435190002,0.0,121.92,1644.2724500334996,316.0,13.67964594,4108.185435190002,0.0,121.92,0.0,295.15 +317,22450.0,21750.0,0.17200000000000001,2013.1071213940643,2208241.1106602135,700.0,221900.0,15773.878612756185,8260846.118105491,13760.77149136212,6052605.007445268,true,317.0,317,0.875,1761.4687312198062,2013.1071213940643,251.63839017425812,0.0,0.0,317,21750.0,0.0,1761.4687312198062,1761.4687312198062,1402920.4086511768,700.0,221900.0,1243.712394538102,783046.477778899,-1003.9033454161585,152844.67893352202,0.0,0.0,1540.5029735230928,464160.35341272666,-18.843291425230344,2868.8985260289833,-1761.4687312198062,-1932210.9718276863,true,true,13.63494121,4121.820376400002,0.0,121.92,1644.2724500334996,317.0,13.63494121,4121.820376400002,0.0,121.92,0.0,295.15 +318,24463.107121394063,23763.107121394063,0.12,0.0,2208241.1106602135,700.0,222600.0,5833.333333333334,8266679.451438824,5833.333333333334,6058438.340778601,true,318.0,318,0.875,0.0,0.0,0.0,0.0,0.0,318,23763.107121394063,0.0,-2330.70915547804,-2330.70915547804,1400589.6994956988,700.0,222600.0,1207.4313721302067,784253.9091510292,-4970.224570367782,147874.45436315425,0.0,0.0,1525.3752848456459,465685.7286975723,-93.29124208611101,2775.607283942872,-0.0,-1932210.9718276863,true,true,13.41141759,4135.231793990002,0.0,121.92,1644.2724500334996,318.0,13.41141759,4135.231793990002,0.0,121.92,0.0,295.15 +319,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,223300.0,5833.333333333334,8272512.784772157,5833.333333333334,6064271.674111934,true,319.0,319,0.875,0.0,0.0,0.0,0.0,0.0,319,21750.0,0.0,-7268.56188204879,-7268.56188204879,1393321.13761365,700.0,223300.0,1119.8306928548616,785373.739843884,-9693.992157469927,138180.4622056843,0.0,0.0,1487.5560628700357,467173.28476044233,-181.95648030376034,2593.650803639112,-0.0,-1932210.9718276863,true,true,12.96437033,4148.196164320002,0.0,121.92,1644.2724500334996,319.0,12.96437033,4148.196164320002,0.0,121.92,0.0,295.15 +320,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,224000.0,5833.333333333334,8278346.11810549,5833.333333333334,6070105.007445267,true,320.0,320,0.875,0.0,0.0,0.0,0.0,0.0,320,21750.0,0.0,-11778.264140502446,-11778.264140502446,1381542.8734731474,700.0,224000.0,983.4259744983184,786357.1658183823,-13924.844454919332,124255.61775076497,0.0,0.0,1424.5240258680285,468597.8087863104,-261.36968594946114,2332.2811176896507,-0.0,-1932210.9718276863,true,true,12.29379945,4160.489963770002,0.0,121.92,1644.2724500334996,320.0,12.29379945,4160.489963770002,0.0,121.92,0.0,295.15 +321,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,224700.0,5833.333333333334,8284179.451438823,5833.333333333334,6075938.3407786,true,321.0,321,0.875,0.0,0.0,0.0,0.0,0.0,321,21750.0,0.0,-21538.35219049233,-21538.35219049233,1360004.521282655,700.0,224700.0,780.0122046380777,787137.1780230204,-23201.501818181812,101054.11593258315,0.0,0.0,1318.6302045619145,469916.4389908723,-435.492781510511,1896.7883361791396,-0.0,-1932210.9718276863,true,true,11.08677187,4171.576735640002,0.0,121.92,1644.2724500334996,321.0,11.08677187,4171.576735640002,0.0,121.92,0.0,295.15 +322,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,225400.0,5833.333333333334,8290012.784772156,5833.333333333334,6081771.674111933,true,322.0,322,0.875,0.0,0.0,0.0,0.0,0.0,322,21750.0,0.0,-23866.8284729708,-23866.8284729708,1336137.6928096842,700.0,225400.0,541.1769674658317,787678.3549904862,-25104.153161684146,75949.962770899,0.0,0.0,1167.353317054264,471083.7923079266,-471.2055958067488,1425.5827403723908,-0.0,-1932210.9718276863,true,true,9.611515937,4181.188251577002,0.0,121.92,1644.2724500334996,322.0,9.611515937,4181.188251577002,0.0,121.92,0.0,295.15 +323,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,226100.0,5833.333333333334,8295846.118105489,5833.333333333334,6087605.0074452665,true,323.0,323,0.875,0.0,0.0,0.0,0.0,0.0,323,21750.0,0.0,-8307.346648385812,-8307.346648385812,1327830.3461612985,700.0,226100.0,392.5331357196344,788070.8881262058,-9569.120241261311,66380.8425296377,0.0,0.0,1048.853088404147,472132.64539633074,-179.6126312482815,1245.9701091241093,-0.0,-1932210.9718276863,true,true,8.985649783,4190.173901360002,0.0,121.92,1644.2724500334996,323.0,8.985649783,4190.173901360002,0.0,121.92,0.0,295.15 +324,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,226800.0,5833.333333333334,8301679.451438822,5833.333333333334,6093438.3407785995,true,324.0,324,0.875,0.0,0.0,0.0,0.0,0.0,324,21750.0,0.0,-5244.8659369369325,-5244.8659369369325,1322585.4802243614,700.0,226800.0,328.4388575591084,788399.3269837649,-6440.754010571166,59940.08851906653,0.0,0.0,988.3423332995693,473120.9877296303,-120.89311722444432,1125.076991899665,-0.0,-1932210.9718276863,true,true,8.53860253,4198.712503890002,0.0,121.92,1644.2724500334996,324.0,8.53860253,4198.712503890002,0.0,121.92,0.0,295.15 +325,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,227500.0,5833.333333333334,8307512.784772155,5833.333333333334,6099271.6741119325,true,325.0,325,0.875,0.0,0.0,0.0,0.0,0.0,325,21750.0,0.0,-2538.452005094139,-2538.452005094139,1320047.0282192673,700.0,227500.0,289.8410314757067,788689.1680152406,-3706.7196441430333,56233.36887492349,0.0,0.0,948.0018299341167,474068.98955956445,-69.57522236092908,1055.501769538736,-0.0,-1932210.9718276863,true,true,8.270374179,4206.982878069002,0.0,121.92,1644.2724500334996,325.0,8.270374179,4206.982878069002,0.0,121.92,0.0,295.15 +326,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,228200.0,5833.333333333334,8313346.118105488,5833.333333333334,6105105.007445266,true,326.0,326,0.875,0.0,0.0,0.0,0.0,0.0,326,21750.0,0.0,-7774.467980963201,-7774.467980963201,1312272.560238304,700.0,228200.0,243.9390852791123,788933.1071005197,-8749.238554414122,47484.13032050937,0.0,0.0,895.054919224661,474964.0444787891,-164.2234310528525,891.2783384858835,-0.0,-1932210.9718276863,true,true,7.599803299,4214.582681368002,0.0,121.92,1644.2724500334996,326.0,7.599803299,4214.582681368002,0.0,121.92,0.0,295.15 +327,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,228900.0,5833.333333333334,8319179.451438821,5833.333333333334,6110938.340778599,true,327.0,327,0.875,0.0,0.0,0.0,0.0,0.0,327,21750.0,0.0,-7153.620804224196,-7153.620804224196,1305118.93943408,700.0,228900.0,187.17438494677413,789120.2814854665,-8009.866270102224,39474.264050407146,0.0,0.0,819.4164753298395,475783.4609541189,-150.34539439858528,740.9329440872982,-0.0,-1932210.9718276863,true,true,6.92923242,4221.511913788002,0.0,121.92,1644.2724500334996,327.0,6.92923242,4221.511913788002,0.0,121.92,0.0,295.15 +328,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,229600.0,5833.333333333334,8325012.784772154,5833.333333333334,6116771.674111932,true,328.0,328,0.875,0.0,0.0,0.0,0.0,0.0,328,21750.0,0.0,-13235.020146292263,-13235.020146292263,1291883.9192877878,700.0,229600.0,119.69346121778386,789239.9749466843,-13801.615737253274,25672.64831315387,0.0,0.0,705.9588095158064,476489.41976363474,-259.05667977258054,481.8762643147177,-0.0,-1932210.9718276863,true,true,5.588090661,4227.100004449002,0.0,121.92,1644.2724500334996,328.0,5.588090661,4227.100004449002,0.0,121.92,0.0,295.15 +329,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,230300.0,5833.333333333334,8330846.118105487,5833.333333333334,6122605.007445265,true,329.0,329,0.875,0.0,0.0,0.0,0.0,0.0,329,21750.0,0.0,-5973.84740416778,-5973.84740416778,1285910.07188362,700.0,230300.0,68.97061440707887,789308.9455610914,-6508.1190388034165,19164.529274350454,0.0,0.0,587.4585807528923,477076.87834438763,-122.157560524335,359.7187037903827,-0.0,-1932210.9718276863,true,true,4.828110331,4231.928114780002,0.0,121.92,1644.2724500334996,329.0,4.828110331,4231.928114780002,0.0,121.92,0.0,295.15 +330,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,231000.0,5833.333333333334,8336679.45143882,5833.333333333334,6128438.340778598,true,330.0,330,0.875,0.0,0.0,0.0,0.0,0.0,330,21750.0,0.0,-8301.123667582562,-8301.123667582562,1277608.9482160374,700.0,231000.0,36.23012892799714,789345.1756900194,-8649.012525517928,10515.516748832526,0.0,0.0,474.0009149388592,477550.8792593265,-162.342185931489,197.37651785889366,-0.0,-1932210.9718276863,true,true,3.576378023,4235.504492803002,0.0,121.92,1644.2724500334996,330.0,3.576378023,4235.504492803002,0.0,121.92,0.0,295.15 +331,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,231700.0,5833.333333333334,8342512.784772153,5833.333333333334,6134271.674111931,true,331.0,331,0.875,0.0,0.0,0.0,0.0,0.0,331,21750.0,0.0,-6683.899627416022,-6683.899627416022,1270925.0485886214,700.0,231700.0,11.16882521881578,789356.3445152382,-6886.020419309164,3629.496329523362,0.0,0.0,320.2027457593732,477871.0820050859,-129.2507790850466,68.12573877384708,-0.0,-1932210.9718276863,true,true,2.101122089,4237.6056148920015,0.0,121.92,1644.2724500334996,331.0,2.101122089,4237.6056148920015,0.0,121.92,0.0,295.15 +332,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,232400.0,5833.333333333334,8348346.118105486,5833.333333333334,6140105.007445264,true,332.0,332,0.875,0.0,0.0,0.0,0.0,0.0,332,21750.0,0.0,-3214.5039270184884,-3214.5039270184884,1267710.544661603,700.0,232400.0,1.2376157767511555,789357.5821310149,-3307.458629116223,322.0377004071388,0.0,0.0,153.79816923588444,478024.88017432176,-62.081082914900776,6.0446558589462995,-0.0,-1932210.9718276863,true,true,0.625866154,4238.231481046001,0.0,121.92,1644.2724500334996,332.0,0.625866154,4238.231481046001,0.0,121.92,0.0,295.15 +333,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,233100.0,5833.333333333334,8354179.451438819,5833.333333333334,6145938.340778597,true,333.0,333,0.875,0.0,0.0,0.0,0.0,0.0,333,21750.0,0.0,-292.76945411059955,-292.76945411059955,1267417.7752074923,700.0,233100.0,0.014961682648637148,789357.5970926975,-322.0377004072729,-1.340936250926461e-10,0.0,0.0,35.29794047297039,478060.1781147947,-6.044655858945696,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,333.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +334,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,233800.0,5833.333333333334,8360012.784772152,5833.333333333334,6151771.67411193,true,334.0,334,0.875,0.0,0.0,0.0,0.0,0.0,334,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,233800.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,334.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +335,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,234500.0,5833.333333333334,8365846.118105485,5833.333333333334,6157605.007445263,true,335.0,335,0.875,0.0,0.0,0.0,0.0,0.0,335,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,234500.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,335.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +336,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,235200.0,5833.333333333334,8371679.451438818,5833.333333333334,6163438.340778596,true,336.0,336,0.875,0.0,0.0,0.0,0.0,0.0,336,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,235200.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,336.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +337,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,235900.0,5833.333333333334,8377512.784772151,5833.333333333334,6169271.674111929,true,337.0,337,0.875,0.0,0.0,0.0,0.0,0.0,337,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,235900.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,337.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +338,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,236600.0,5833.333333333334,8383346.118105484,5833.333333333334,6175105.007445262,true,338.0,338,0.875,0.0,0.0,0.0,0.0,0.0,338,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,236600.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,338.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +339,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,237300.0,5833.333333333334,8389179.451438818,5833.333333333334,6180938.340778595,true,339.0,339,0.875,0.0,0.0,0.0,0.0,0.0,339,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,237300.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,339.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +340,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,238000.0,5833.333333333334,8395012.784772152,5833.333333333334,6186771.674111928,true,340.0,340,0.875,0.0,0.0,0.0,0.0,0.0,340,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,238000.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,340.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +341,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,238700.0,5833.333333333334,8400846.118105486,5833.333333333334,6192605.007445261,true,341.0,341,0.875,0.0,0.0,0.0,0.0,0.0,341,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,238700.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,341.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +342,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,239400.0,5833.333333333334,8406679.45143882,5833.333333333334,6198438.340778594,true,342.0,342,0.875,0.0,0.0,0.0,0.0,0.0,342,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,239400.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,342.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +343,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,240100.0,5833.333333333334,8412512.784772154,5833.333333333334,6204271.674111927,true,343.0,343,0.875,0.0,0.0,0.0,0.0,0.0,343,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,240100.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,343.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +344,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,240800.0,5833.333333333334,8418346.118105488,5833.333333333334,6210105.00744526,true,344.0,344,0.875,0.0,0.0,0.0,0.0,0.0,344,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,240800.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,344.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +345,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,241500.0,5833.333333333334,8424179.451438822,5833.333333333334,6215938.340778593,true,345.0,345,0.875,0.0,0.0,0.0,0.0,0.0,345,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,241500.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,345.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +346,22450.0,21750.0,0.12,0.0,2208241.1106602135,700.0,242200.0,5833.333333333334,8430012.784772156,5833.333333333334,6221771.674111926,true,346.0,346,0.875,0.0,0.0,0.0,0.0,0.0,346,21750.0,0.0,0.0,0.0,1267417.7752074923,700.0,242200.0,0.0,789357.5970926975,0.0,-1.340936250926461e-10,0.0,0.0,0.0,478060.1781147947,0.0,6.039613253960852e-13,-0.0,-1932210.9718276863,true,true,0.0,4238.231481046001,0.0,121.92,1644.2724500334996,346.0,0.0,4238.231481046001,0.0,121.92,0.0,295.15 +347,22450.0,21750.0,0.128,220.12254231489132,2208461.233202528,700.0,242900.0,7188.457361835089,8437201.242133992,6968.334819520197,6228740.008931446,true,347.0,347,0.875,192.60722452552992,220.12254231489132,27.515317789361404,0.0,0.0,347,21750.0,0.0,192.60722452552992,192.60722452552992,1267610.3824320177,700.0,242900.0,0.005452508259103674,789357.6025452057,164.30494929239373,164.30494929225964,0.0,0.0,25.212814631607213,478085.3909294263,3.084008093269858,3.084008093270462,-192.60722452552992,-1932403.5790522117,true,true,0.447047253,4238.678528299001,0.0,121.92,1644.2724500334996,347.0,0.447047253,4238.678528299001,0.0,121.92,0.0,295.15 +348,22670.12254231489,21970.12254231489,0.196,3499.5114655372286,2211960.7446680656,700.0,243600.0,21426.078905802187,8458627.321039794,17926.56744026496,6246666.576371711,true,348.0,348,0.875,3062.072532345075,3499.5114655372286,437.4389331921534,0.0,0.0,348,21970.12254231489,0.0,3062.072532345075,3062.072532345075,1270672.4549643628,700.0,243600.0,0.8117530711655422,789358.4142982769,2873.6935602792555,3037.998509571515,0.0,0.0,133.62791749675952,478219.0188469231,53.93930149789451,57.023309591164974,-3062.072532345075,-1935465.6515845568,true,true,1.922303187,4240.600831486001,0.0,121.92,1644.2724500334996,348.0,1.922303187,4240.600831486001,0.0,121.92,0.0,295.15 +349,25949.51146553723,25249.51146553723,0.28625,7865.811648293557,2219826.556316359,700.0,244300.0,29924.232832466572,8488551.553872261,22058.421184173014,6268724.997555884,true,349.0,349,0.875,6882.585192256862,7865.811648293557,983.2264560366948,0.0,0.0,349,25249.51146553723,0.0,6882.585192256862,6882.585192256862,1277555.0401566196,700.0,244300.0,9.18834335659429,789367.6026416335,6452.2553570878035,9490.25386665932,0.0,0.0,300.03249402024835,478519.0513409433,121.10899779221543,178.1323073833804,-6882.585192256862,-1942348.2367768136,true,true,3.397559122,4243.998390608001,0.0,121.92,1644.2724500334996,349.0,3.397559122,4243.998390608001,0.0,121.92,0.0,295.15 +350,30315.81164829356,29615.81164829356,0.3175,12251.492749053057,2232078.049065412,700.0,245000.0,40792.1031466238,8529343.657018885,28540.61039757074,6297265.607953454,true,350.0,350,0.875,10720.056155421426,12251.492749053057,1531.4365936316317,0.0,0.0,350,29615.81164829356,0.0,10720.056155421426,10720.056155421426,1288275.0963120412,700.0,245000.0,34.523237587262855,789402.1258792208,10030.817153161288,19521.071019820607,0.0,0.0,466.43707060013566,478985.4884115435,188.27869407273917,366.4110014561196,-10720.056155421426,-1953068.2929322352,true,true,4.872815057,4248.871205665,0.0,121.92,1644.2724500334996,350.0,4.872815057,4248.871205665,0.0,121.92,0.0,295.15 +351,34701.49274905305,34001.49274905305,0.345,16667.303837377745,2248745.3529027896,700.0,245700.0,50340.01112283405,8579683.668141719,33672.7072854563,6330938.315238911,true,351.0,351,0.875,14583.890857705528,16667.303837377745,2083.4129796722173,0.0,0.0,351,34001.49274905305,0.0,14583.890857705528,14583.890857705528,1302858.9871697468,700.0,245700.0,86.2218816277595,789488.3477608486,13609.3789387968,33130.449958617406,0.0,0.0,632.8416471236244,479618.3300586671,255.44839015734206,621.8593916134616,-14583.890857705528,-1967652.1837899408,true,true,6.348070991,4255.219276656,0.0,121.92,1644.2724500334996,351.0,6.348070991,4255.219276656,0.0,121.92,0.0,295.15 +352,39117.303837377745,38417.303837377745,0.3516666666666666,19783.03800944371,2268528.3909122334,700.0,246400.0,58245.60571405795,8637929.273855777,38462.56770461424,6369400.882943525,true,352.0,352,0.875,17310.158258263247,19783.03800944371,2472.8797511804623,0.0,0.0,352,38417.303837377745,0.0,17310.158258263247,17310.158258263247,1320169.14542801,700.0,246400.0,170.4229164559391,789658.7706773045,16044.378290941317,49174.82824955872,0.0,0.0,794.2036606982323,480412.53371936537,301.1533901677597,923.0127817812213,-17310.158258263247,-1984962.342048204,true,true,7.733917475,4262.953194131001,0.0,121.92,1644.2724500334996,352.0,7.733917475,4262.953194131001,0.0,121.92,0.0,295.15 +353,42233.03800944371,41533.03800944371,0.35333333333333333,20664.158208412446,2289192.549120646,700.0,247100.0,60464.59870305409,8698393.872558832,39800.44049464165,6409201.323438167,true,353.0,353,0.875,18081.13843236089,20664.158208412446,2583.019776051555,0.0,0.0,353,41533.03800944371,0.0,18081.13843236089,18081.13843236089,1338250.283860371,700.0,247100.0,282.9585538511124,789941.7292311556,16547.15143799595,65721.97968755467,0.0,0.0,940.4379855389949,481352.97170490434,310.59045497483316,1233.6032367560545,-18081.13843236089,-2003043.480480565,true,true,8.940945058,4271.894139189,0.0,121.92,1644.2724500334996,353.0,8.940945058,4271.894139189,0.0,121.92,0.0,295.15 +354,43114.158208412446,42414.158208412446,0.355,22028.784612202908,2311221.333732849,700.0,247800.0,64024.74538648707,8762418.617945319,41995.96077428416,6451197.2842124505,true,354.0,354,0.875,19275.186535677545,22028.784612202908,2753.5980765253626,0.0,0.0,354,42414.158208412446,0.0,19275.186535677545,19275.186535677545,1357525.4703960486,700.0,247800.0,418.56520403034614,790360.294435186,17457.400850371967,83179.38053792664,0.0,0.0,1071.544621589513,482424.5163264939,327.675859685717,1561.2790964417713,-19275.186535677545,-2022318.6670162426,true,true,10.05856319,4281.952702379001,0.0,121.92,1644.2724500334996,354.0,10.05856319,4281.952702379001,0.0,121.92,0.0,295.15 +355,44478.78461220291,43778.78461220291,0.33,12551.490006862356,2323772.823739711,700.0,248500.0,40156.03032382532,8802574.648269145,27604.540316962964,6478801.824529413,true,355.0,355,0.875,10982.553756004561,12551.490006862356,1568.9362508577942,0.0,0.0,355,43778.78461220291,0.0,10982.553756004561,10982.553756004561,1368508.0241520533,700.0,248500.0,537.677989187874,790897.9724243738,9109.066323849152,92288.4468617758,0.0,0.0,1164.8320354952257,483589.3483619891,170.9774074723095,1732.256503914081,-10982.553756004561,-2033301.2207722473,true,true,10.59501989,4292.547722269001,0.0,121.92,1644.2724500334996,355.0,10.59501989,4292.547722269001,0.0,121.92,0.0,295.15 +356,35001.490006862354,34301.490006862354,0.33999999999999997,16169.656426097059,2339942.4801658085,700.0,249200.0,49616.63654734429,8852191.284816489,33446.98012124724,6512248.804650661,true,356.0,356,0.875,14148.449372834926,16169.656426097059,2021.2070532621328,0.0,0.0,356,34301.490006862354,0.0,14148.449372834926,14148.449372834926,1382656.4735248883,700.0,249200.0,637.5627111872001,791535.535135561,12051.768033133052,104340.21489490884,0.0,0.0,1232.9066348257297,484822.2549968148,226.2119936889441,1958.468497603025,-14148.449372834926,-2047449.6701450823,true,true,11.26559077,4303.813313039001,0.0,121.92,1644.2724500334996,356.0,11.26559077,4303.813313039001,0.0,121.92,0.0,295.15 +357,38619.65642609706,37919.65642609706,0.33999999999999997,16231.91452375151,2356174.39468956,700.0,249900.0,49799.74859926916,8901991.033415757,33567.83407551765,6545816.638726179,true,357.0,357,0.875,14202.925208282571,16231.91452375151,2028.989315468938,0.0,0.0,357,37919.65642609706,0.0,14202.925208282571,14202.925208282571,1396859.398733171,700.0,249900.0,757.8541113977777,792293.3892469588,11915.395030327696,116255.60992523654,0.0,0.0,1306.0237976127014,486128.2787944275,223.6522689443973,2182.120766547422,-14202.925208282571,-2061652.595353365,true,true,11.89145693,4315.704769969,0.0,121.92,1644.2724500334996,357.0,11.89145693,4315.704769969,0.0,121.92,0.0,295.15 +358,38681.91452375151,37981.91452375151,0.35,18292.345548732563,2374466.7402382926,700.0,250600.0,54263.844424950184,8956254.877840707,35971.49887621762,6581788.137602396,true,358.0,358,0.875,16005.802355140991,18292.345548732563,2286.5431935915713,0.0,0.0,358,37981.91452375151,0.0,16005.802355140991,16005.802355140991,1412865.2010883118,700.0,250600.0,892.3974305014219,793185.7866774602,13481.221099989114,129736.83102522565,0.0,0.0,1379.1409603996733,487507.4197548272,253.04286425078251,2435.163630798205,-16005.802355140991,-2077658.3977085059,true,true,12.56202781,4328.266797779,0.0,121.92,1644.2724500334996,358.0,12.56202781,4328.266797779,0.0,121.92,0.0,295.15 +359,40742.34554873256,40042.34554873256,0.35666666666666663,24014.04968788314,2398480.789926176,700.0,251300.0,69291.72809686862,9025546.605937576,45277.678408985485,6627065.816011381,true,359.0,359,0.875,21012.293476897747,24014.04968788314,3001.7562109853934,0.0,0.0,359,40042.34554873256,0.0,21012.293476897747,21012.293476897747,1433877.4945652096,700.0,251300.0,1069.3619556886626,794255.1486331489,18137.62333792856,147874.45436315422,0.0,0.0,1464.864530135858,488972.2842849631,340.4436531446674,2775.607283942872,-21012.293476897747,-2098670.6911854036,true,true,13.41141759,4341.678215369,0.0,121.92,1644.2724500334996,359.0,13.41141759,4341.678215369,0.0,121.92,0.0,295.15 +360,46464.04968788314,45764.04968788314,0.33,12457.394670840085,2410938.184597016,700.0,252000.0,39870.89294193965,9065417.498879516,27413.49827109957,6654479.314282481,true,360.0,360,0.875,10900.220336985074,12457.394670840085,1557.1743338550114,0.0,0.0,360,45764.04968788314,0.0,10900.220336985074,10900.220336985074,1444777.7149021947,700.0,252000.0,1225.4823756361013,795480.631008785,7991.792679245855,155866.24704240006,0.0,0.0,1532.939129466362,490505.22341442946,150.00615263675482,2925.613436579627,-10900.220336985074,-2109570.9115223885,true,true,13.76905539,4355.447270759,0.0,121.92,1644.2724500334996,360.0,13.76905539,4355.447270759,0.0,121.92,0.0,295.15 +361,34907.39467084008,34207.39467084008,0.33,12861.869325852093,2423800.053922868,700.0,252700.0,41096.57371470331,9106514.07259422,28234.704388851213,6682714.018671332,true,361.0,361,0.875,11254.13566012058,12861.869325852093,1607.7336657315118,0.0,0.0,361,34207.39467084008,0.0,11254.13566012058,11254.13566012058,1456031.8505623152,700.0,252700.0,1324.799333053766,796805.4303418387,8202.103011517436,164068.3500539175,0.0,0.0,1573.2796326062205,492078.50304703566,153.95368294315742,3079.567119522784,-11254.13566012058,-2120825.047182509,true,true,14.12669319,4369.573963949,0.0,121.92,1644.2724500334996,361.0,14.12669319,4369.573963949,0.0,121.92,0.0,295.15 +362,35311.869325852094,34611.869325852094,0.29250000000000004,9539.121070408992,2433339.174993277,700.0,253400.0,35005.54212105638,9141519.614715276,25466.42105064739,6708180.439721979,true,362.0,362,0.875,8346.730936607868,9539.121070408992,1192.3901338011237,0.0,0.0,362,34611.869325852094,0.0,8346.730936607868,8346.730936607868,1464378.581498923,700.0,253400.0,1409.336269847432,798214.7666116862,5233.112715783436,169301.46276970094,0.0,0.0,1606.0562916893482,493684.559338725,98.22565928765192,3177.792778810436,-8346.730936607868,-2129171.778119117,true,true,14.35021682,4383.9241807690005,0.0,121.92,1644.2724500334996,362.0,14.35021682,4383.9241807690005,0.0,121.92,0.0,295.15 +363,31989.12107040899,31289.12107040899,0.3175,12264.327405576478,2445603.5023988537,700.0,254100.0,40832.5272616582,9182352.141976934,28568.199856081723,6736748.639578061,true,363.0,363,0.875,10731.286479879418,12264.327405576478,1533.0409256970597,0.0,0.0,363,31289.12107040899,0.0,10731.286479879418,10731.286479879418,1475109.8679788024,700.0,254100.0,1490.4946518815846,799705.2612635678,7464.373674501998,176765.83644420293,0.0,0.0,1636.3116690442423,495320.87100776925,140.10648445159347,3317.8992632620298,-10731.286479879418,-2139903.0645989967,true,true,14.66314989,4398.587330659,0.0,121.92,1644.2724500334996,363.0,14.66314989,4398.587330659,0.0,121.92,0.0,295.15 +364,34714.32740557648,34014.32740557648,0.335,13899.52141955804,2459503.023818412,700.0,254800.0,43580.66095390459,9225932.80293084,29681.13953434655,6766429.779112408,true,364.0,364,0.875,12162.081242113285,13899.52141955804,1737.4401774447542,0.0,0.0,364,34014.32740557648,0.0,12162.081242113285,12162.081242113285,1487271.9492209158,700.0,254800.0,1596.2487485692484,801301.5100121371,8727.879089179143,185493.71553338208,0.0,0.0,1674.1308910198522,496995.0018987891,163.82251334503954,3481.7217766070694,-12162.081242113285,-2152065.14584111,true,true,15.0207877,4413.608118359,0.0,121.92,1644.2724500334996,364.0,15.0207877,4413.608118359,0.0,121.92,0.0,295.15 +365,36349.52141955804,35649.52141955804,0.33999999999999997,15655.176683377042,2475158.200501789,700.0,255500.0,48103.46083346189,9274036.263764301,32448.284150084848,6798878.063262492,true,365.0,365,0.875,13698.279597954912,15655.176683377042,1956.8970854221297,0.0,0.0,365,35649.52141955804,0.0,13698.279597954912,13698.279597954912,1500970.2288188706,700.0,255500.0,1722.017923374747,803023.5279355119,10070.25014633088,195563.96567971297,0.0,0.0,1716.9926758879446,498711.994574677,189.01885236134012,3670.7406289684095,-13698.279597954912,-2165763.425439065,true,true,15.42313022,4429.031248579,0.0,121.92,1644.2724500334996,365.0,15.42313022,4429.031248579,0.0,121.92,0.0,295.15 +366,38105.17668337704,37405.17668337704,0.23500000000000001,5368.983371727066,2480527.183873516,700.0,256200.0,25825.461156285386,9299861.724920588,20456.47778455832,6819334.541047051,true,366.0,366,0.875,4697.860450261182,5368.983371727066,671.1229214658833,0.0,0.0,366,37405.17668337704,0.0,4697.860450261182,4697.860450261182,1505668.089269132,700.0,256200.0,1798.9971432320265,804822.5250787439,1135.3473185223263,196699.31299823528,0.0,0.0,1742.2054903503563,500454.2000650274,21.310498156473894,3692.0511271248834,-4697.860450261182,-2170461.285889326,true,true,15.46783495,4444.499083529,0.0,121.92,1644.2724500334996,366.0,15.46783495,4444.499083529,0.0,121.92,0.0,295.15 +367,27818.983371727067,27118.983371727067,0.28625,8083.166235612963,2488610.350109129,700.0,256900.0,30683.550168080223,9330545.275088668,22600.38393246726,6841934.924979518,true,367.0,367,0.875,7072.770456161343,8083.166235612963,1010.39577945162,0.0,0.0,367,27118.983371727067,0.0,7072.770456161343,7072.770456161343,1512740.8597252932,700.0,256900.0,1830.4199716696303,806652.9450504136,3425.758297089213,200125.0712953245,0.0,0.0,1752.2906166993064,502206.4906817267,64.3015707031929,3756.352697828076,-7072.770456161343,-2177534.0563454875,true,true,15.60194913,4460.101032659,0.0,121.92,1644.2724500334996,367.0,15.60194913,4460.101032659,0.0,121.92,0.0,295.15 +368,30533.166235612964,29833.166235612964,0.1864,2785.0282285902035,2491395.3783377195,700.0,257600.0,18696.50337226504,9349241.778460933,15911.475143674837,6857846.400123193,true,368.0,368,0.875,2436.899700016428,2785.0282285902035,348.1285285737754,0.0,0.0,368,29833.166235612964,0.0,2436.899700016428,2436.899700016428,1515177.7594253097,700.0,257600.0,1846.2676759094786,808499.212726323,-1145.2056168176591,198979.86567850685,0.0,0.0,1757.3331795917886,503963.8238613185,-21.49553866718006,3734.857159160896,-2436.899700016428,-2179970.9560455037,true,true,15.5572444,4475.658277059,0.0,121.92,1644.2724500334996,368.0,15.5572444,4475.658277059,0.0,121.92,0.0,295.15 +369,25235.028228590203,24535.028228590203,0.124,93.59398601776749,2491488.972323737,700.0,258300.0,6399.9515001432865,9355641.729961077,6306.357514125519,6864152.757637318,true,369.0,369,0.875,81.89473776554655,93.59398601776749,11.69924825222094,0.0,0.0,369,24535.028228590203,0.0,81.89473776554655,81.89473776554655,1515259.6541630754,700.0,258300.0,1814.6632135090754,810313.8759398321,-3415.8999987938805,195563.96567971297,0.0,0.0,1747.2480532428385,505711.0719145614,-64.11653019248674,3670.7406289684095,-81.89473776554655,-2180052.8507832694,true,true,15.42313022,4491.081407279,0.0,121.92,1644.2724500334996,369.0,15.42313022,4491.081407279,0.0,121.92,0.0,295.15 +370,22543.593986017768,21843.593986017768,0.265,6706.524623002805,2498195.49694674,700.0,259000.0,27949.149520765302,9383590.879481843,21242.624897762496,6885395.38253508,true,370.0,370,0.875,5868.209045127454,6706.524623002805,838.3155778753508,0.0,0.0,370,21843.593986017768,0.0,5868.209045127454,5868.209045127454,1521127.8632082029,700.0,259000.0,1806.8188598396466,812120.6947996718,2273.980736721436,197837.9464164344,0.0,0.0,1744.7267720785903,507455.79868664,42.68267648778144,3713.423305456191,-5868.209045127454,-2185921.059828397,true,true,15.51253968,4506.593946959,0.0,121.92,1644.2724500334996,370.0,15.51253968,4506.593946959,0.0,121.92,0.0,295.15 +371,29156.524623002806,28456.524623002806,0.335,14922.04562554899,2513117.542572289,700.0,259700.0,46632.97201656415,9430223.851498406,31710.926391015157,6917106.308926095,true,371.0,371,0.875,13056.789922355367,14922.04562554899,1865.255703193623,0.0,0.0,371,28456.524623002806,0.0,13056.789922355367,13056.789922355367,1534184.6531305583,700.0,259700.0,1886.2865517355772,814006.9813514074,9227.365890162357,207065.31230659675,0.0,0.0,1769.9395871049871,509225.738273745,173.19789335244565,3886.6211988086366,-13056.789922355367,-2198977.849750752,true,true,15.87017748,4522.464124439,0.0,121.92,1644.2724500334996,371.0,15.87017748,4522.464124439,0.0,121.92,0.0,295.15 +372,37372.04562554899,36672.04562554899,0.3175,11177.033310791041,2524294.57588308,700.0,260400.0,37407.97893162532,9467631.83043003,26230.94562083428,6943337.254546929,true,372.0,372,0.875,9779.90414694216,11177.033310791041,1397.1291638488801,0.0,0.0,372,36672.04562554899,0.0,9779.90414694216,9779.90414694216,1543964.5572775004,700.0,260400.0,1993.0328505765465,816000.0142019839,5873.90176464599,212939.21407124275,0.0,0.0,1802.7162456241294,511028.4545193691,110.25328609549629,3996.8744849041327,-9779.90414694216,-2208757.7538976944,true,true,16.0937011,4538.557825539,0.0,121.92,1644.2724500334996,372.0,16.0937011,4538.557825539,0.0,121.92,0.0,295.15 +373,33627.03331079104,32927.03331079104,0.20800000000000002,4400.526231122673,2528695.1021142025,700.0,261100.0,24521.76072655131,9492153.591156581,20121.23449542864,6963458.489042358,true,373.0,373,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,373,32927.03331079104,0.0,3850.460452232339,3850.460452232339,1547815.0177297327,700.0,261100.0,2035.1377996589958,818035.152001643,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,512843.77717194246,0.0,3996.8744849041327,-3850.460452232339,-2212608.214349927,true,true,16.0937011,4554.651526639,0.0,121.92,1644.2724500334996,373.0,16.0937011,4554.651526639,0.0,121.92,0.0,295.15 +374,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2533095.628345325,700.0,261800.0,24521.76072655131,9516675.351883132,20121.23449542864,6983579.723537786,true,374.0,374,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,374,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1551665.478181965,700.0,261800.0,2035.1377996589958,820070.289801302,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,514659.0998245158,0.0,3996.8744849041327,-3850.460452232339,-2216458.6748021594,true,true,16.0937011,4570.745227738999,0.0,121.92,1644.2724500334996,374.0,16.0937011,4570.745227738999,0.0,121.92,0.0,295.15 +375,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2537496.154576448,700.0,262500.0,24521.76072655131,9541197.112609683,20121.23449542864,7003700.958033214,true,375.0,375,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,375,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1555515.9386341972,700.0,262500.0,2035.1377996589958,822105.4276009611,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,516474.42247708916,0.0,3996.8744849041327,-3850.460452232339,-2220309.135254392,true,true,16.0937011,4586.838928838999,0.0,121.92,1644.2724500334996,375.0,16.0937011,4586.838928838999,0.0,121.92,0.0,295.15 +376,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2541896.6808075705,700.0,263200.0,24521.76072655131,9565718.873336233,20121.23449542864,7023822.192528643,true,376.0,376,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,376,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1559366.3990864295,700.0,263200.0,2035.1377996589958,824140.5654006201,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,518289.7451296625,0.0,3996.8744849041327,-3850.460452232339,-2224159.5957066244,true,true,16.0937011,4602.932629938999,0.0,121.92,1644.2724500334996,376.0,16.0937011,4602.932629938999,0.0,121.92,0.0,295.15 +377,26850.526231122672,26150.526231122672,0.20800000000000002,4400.526231122673,2546297.207038693,700.0,263900.0,24521.76072655131,9590240.634062784,20121.23449542864,7043943.427024071,true,377.0,377,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,377,26150.526231122672,0.0,3850.460452232339,3850.460452232339,1563216.8595386618,700.0,263900.0,2035.1377996589958,826175.7032002792,0.0,212939.21407124275,0.0,0.0,1815.3226525733428,520105.06778223586,0.0,3996.8744849041327,-3850.460452232339,-2228010.056158857,true,true,16.0937011,4619.026331038998,0.0,121.92,1644.2724500334996,377.0,16.0937011,4619.026331038998,0.0,121.92,0.0,295.15 +378,26850.526231122672,26150.526231122672,0.23500000000000001,5792.397448882797,2552089.604487576,700.0,264600.0,27627.223186735304,9617867.857249519,21834.82573785251,7065778.252761924,true,378.0,378,0.875,5068.347767772448,5792.397448882797,724.0496811103494,0.0,0.0,378,26150.526231122672,0.0,5068.347767772448,5068.347767772448,1568285.2073064342,700.0,264600.0,2043.6293242594552,828219.3325245386,1184.6388085290018,214123.85287977176,0.0,0.0,1817.8439343015766,521922.91171653743,22.23570068241439,4019.1101855865472,-5068.347767772448,-2233078.4039266296,true,true,16.13840583,4635.164736868998,0.0,121.92,1644.2724500334996,378.0,16.13840583,4635.164736868998,0.0,121.92,0.0,295.15 +379,28242.397448882795,27542.397448882795,0.29250000000000004,8624.53784943239,2560714.1423370084,700.0,265300.0,31878.761878401332,9649746.61912792,23254.224028968943,7089032.476790893,true,379.0,379,0.875,7546.470618253341,8624.53784943239,1078.0672311790495,0.0,0.0,379,27542.397448882795,0.0,7546.470618253341,7546.470618253341,1575831.6779246875,700.0,265300.0,2077.8316234454264,830297.164147984,3573.6327560833283,217697.4856358551,0.0,0.0,1827.929060650527,523750.84077718796,67.0771780740596,4086.187363660607,-7546.470618253341,-2240624.874544883,true,true,16.27252001,4651.437256878999,0.0,121.92,1644.2724500334996,379.0,16.27252001,4651.437256878999,0.0,121.92,0.0,295.15 +380,31074.53784943239,30374.53784943239,0.25,5909.363378591942,2566623.5057156,700.0,266000.0,26437.453514367768,9676184.072642287,20528.090135775827,7109560.566926668,true,380.0,380,0.875,5170.692956267949,5909.363378591942,738.6704223239931,0.0,0.0,380,30374.53784943239,0.0,5170.692956267949,5170.692956267949,1581002.3708809554,700.0,266000.0,2112.413415299001,832409.577563283,1197.78293820149,218895.2685740566,0.0,0.0,1838.0141864354912,525588.8549636235,22.48241633196647,4108.669779992573,-5170.692956267949,-2245795.567501151,true,true,16.31722473,4667.7544816089985,0.0,121.92,1644.2724500334996,380.0,16.31722473,4667.7544816089985,0.0,121.92,0.0,295.15 +381,28359.36337859194,27659.36337859194,0.1936,3120.1854253726124,2569743.691140973,700.0,266700.0,19732.36273436267,9695916.43537665,16612.177308990056,7126172.744235658,true,381.0,381,0.875,2730.162247201036,3120.1854253726124,390.02317817157655,0.0,0.0,381,27659.36337859194,0.0,2730.162247201036,2730.162247201036,1583732.5331281563,700.0,266700.0,2112.413415299001,834521.9909785821,-1197.78293820149,217697.4856358551,0.0,0.0,1838.0141864354912,527426.869150059,-22.48241633196647,4086.187363660607,-2730.162247201036,-2248525.729748352,true,true,16.27252001,4684.027001618999,0.0,121.92,1644.2724500334996,381.0,16.27252001,4684.027001618999,0.0,121.92,0.0,295.15 +382,25570.185425372612,24870.185425372612,0.12,0.0,2569743.691140973,700.0,267400.0,5833.333333333334,9701749.768709984,5833.333333333334,7132006.077568991,true,382.0,382,0.875,0.0,0.0,0.0,0.0,0.0,382,24870.185425372612,0.0,-952.9311121093242,-952.9311121093242,1582779.602016047,700.0,267400.0,2069.245552337187,836591.2365309192,-4758.27156461233,212939.21407124275,0.0,0.0,1825.4077789222927,529252.2769289812,-89.31287875647399,3996.874484904133,-0.0,-2248525.729748352,true,true,16.0937011,4700.1207027189985,0.0,121.92,1644.2724500334996,382.0,16.0937011,4700.1207027189985,0.0,121.92,0.0,295.15 +383,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,268100.0,5833.333333333334,9707583.102043318,5833.333333333334,7137839.410902324,true,383.0,383,0.875,0.0,0.0,0.0,0.0,0.0,383,21750.0,0.0,-6958.81792595786,-6958.81792595786,1575820.7840900891,700.0,268100.0,1959.7701295241397,838551.0066604434,-10513.873501261145,202425.3405699816,0.0,0.0,1792.631119839165,531044.9080488203,-197.34567406001952,3799.5288108441137,-0.0,-2248525.729748352,true,true,15.69135858,4715.812061298999,0.0,121.92,1644.2724500334996,383.0,15.69135858,4715.812061298999,0.0,121.92,0.0,295.15 +384,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,268800.0,5833.333333333334,9713416.435376652,5833.333333333334,7143672.744235657,true,384.0,384,0.875,0.0,0.0,0.0,0.0,0.0,384,21750.0,0.0,-8031.770397699034,-8031.770397699034,1567789.0136923902,700.0,268800.0,1806.8188598396466,840357.8255202831,-11369.902666273734,191055.43790370788,0.0,0.0,1744.7267720785903,532789.6348208989,-213.4133633435361,3586.1154475005774,-0.0,-2248525.729748352,true,true,15.24431132,4731.0563726189985,0.0,121.92,1644.2724500334996,384.0,15.24431132,4731.0563726189985,0.0,121.92,0.0,295.15 +385,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,269500.0,5833.333333333334,9719249.768709986,5833.333333333334,7149506.07756899,true,385.0,385,0.875,0.0,0.0,0.0,0.0,0.0,385,21750.0,0.0,-3400.543976884009,-3400.543976884009,1564388.469715506,700.0,269500.0,1684.3658178671562,842042.1913381502,-6664.208695755293,184391.2292079526,0.0,0.0,1704.3862683747464,534494.0210892736,-125.0873673706192,3461.028080129958,-0.0,-2248525.729748352,true,true,14.97608297,4746.032455588998,0.0,121.92,1644.2724500334996,385.0,14.97608297,4746.032455588998,0.0,121.92,0.0,295.15 +386,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,270200.0,5833.333333333334,9725083.10204332,5833.333333333334,7155339.410902323,true,386.0,386,0.875,0.0,0.0,0.0,0.0,0.0,386,21750.0,0.0,-19686.63464194825,-19686.63464194825,1544701.835073558,700.0,270200.0,1490.4946518815846,843532.6859900318,-22393.12150056489,161998.1077073877,0.0,0.0,1636.3116690442423,536130.3327583178,-420.3194623091883,3040.70861782077,-0.0,-2248525.729748352,true,true,14.03728374,4760.069739328998,0.0,121.92,1644.2724500334996,386.0,14.03728374,4760.069739328998,0.0,121.92,0.0,295.15 +387,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,270900.0,5833.333333333334,9730916.435376653,5833.333333333334,7161172.744235656,true,387.0,387,0.875,0.0,0.0,0.0,0.0,0.0,387,21750.0,0.0,-21540.395313418583,-21540.395313418583,1523161.4397601394,700.0,270900.0,1201.4539993490614,844734.1399893808,-23817.6455017034,138180.4622056843,0.0,0.0,1522.854003117412,537653.1867614352,-447.05781418165793,2593.6508036391124,-0.0,-2248525.729748352,true,true,12.96437033,4773.034109658998,0.0,121.92,1644.2724500334996,387.0,12.96437033,4773.034109658998,0.0,121.92,0.0,295.15 +388,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,271600.0,5833.333333333334,9736749.768709987,5833.333333333334,7167006.077568989,true,388.0,388,0.875,0.0,0.0,0.0,0.0,0.0,388,21750.0,0.0,-27943.84219684052,-27943.84219684052,1495217.597563299,700.0,271600.0,892.3974294066116,845626.5374187875,-29658.686287222878,108521.77591846143,0.0,0.0,1379.1409598356877,539032.327721271,-556.6942988599402,2036.956504779172,-0.0,-2248525.729748352,true,true,11.4891144,4784.5232240589985,0.0,121.92,1644.2724500334996,388.0,11.4891144,4784.5232240589985,0.0,121.92,0.0,295.15 +389,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,272300.0,5833.333333333334,9742583.102043321,5833.333333333334,7172839.410902322,true,389.0,389,0.875,0.0,0.0,0.0,0.0,0.0,389,21750.0,0.0,-20152.338068054276,-20152.338068054276,1475065.2594952446,700.0,272300.0,629.7718084492777,846256.3092272368,-21604.457725878707,86917.31819258272,0.0,0.0,1227.8640724972329,540260.1917937682,-405.5162231220798,1631.4402816570923,-0.0,-2248525.729748352,true,true,10.28208682,4794.805310878998,0.0,121.92,1644.2724500334996,389.0,10.28208682,4794.805310878998,0.0,121.92,0.0,295.15 +390,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,273000.0,5833.333333333334,9748416.435376655,5833.333333333334,7178672.744235655,true,390.0,390,0.875,0.0,0.0,0.0,0.0,0.0,390,21750.0,0.0,-18035.07863664031,-18035.07863664031,1457030.1808586044,700.0,273000.0,442.6495439273991,846698.9587711642,-19208.89166703187,67708.42652555085,0.0,0.0,1091.7148734978334,541351.906667266,-360.55138703367516,1270.8888946234172,-0.0,-2248525.729748352,true,true,9.075059234,4803.880370112998,0.0,121.92,1644.2724500334996,390.0,9.075059234,4803.880370112998,0.0,121.92,0.0,295.15 +391,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,273700.0,5833.333333333334,9754249.76870999,5833.333333333334,7184506.077568988,true,391.0,391,0.875,0.0,0.0,0.0,0.0,0.0,391,21750.0,0.0,-16468.91204791192,-16468.91204791192,1440561.2688106925,700.0,273700.0,294.49079967768796,846993.4495708419,-17390.035824050905,50318.39070149994,0.0,0.0,953.0443928829976,542304.951060149,-326.4114164216998,944.4774782017173,-0.0,-2248525.729748352,true,true,7.823326926,4811.703697038998,0.0,121.92,1644.2724500334996,391.0,7.823326926,4811.703697038998,0.0,121.92,0.0,295.15 +392,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,274400.0,5833.333333333334,9760083.102043323,5833.333333333334,7190339.410902321,true,392.0,392,0.875,0.0,0.0,0.0,0.0,0.0,392,21750.0,0.0,-15083.86204708968,-15083.86204708968,1425477.4067636027,700.0,274400.0,178.66779052190432,847172.1173613637,-15773.275128762001,34545.11557273794,0.0,0.0,806.8100680422352,543111.7611281913,-296.06477689181855,648.4127013098987,-0.0,-2248525.729748352,true,true,6.482185167,4818.1858822059985,0.0,121.92,1644.2724500334996,392.0,6.482185167,4818.1858822059985,0.0,121.92,0.0,295.15 +393,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,275100.0,5833.333333333334,9765916.435376657,5833.333333333334,7196172.744235654,true,393.0,393,0.875,0.0,0.0,0.0,0.0,0.0,393,21750.0,0.0,-10319.9096979551,-10319.9096979551,1415157.4970656477,700.0,275100.0,101.46913394708368,847273.5864953108,-10885.202883454172,23659.912689283767,0.0,0.0,668.1395875965949,543779.9007157879,-204.31553604460507,444.0971652652936,-0.0,-2248525.729748352,true,true,5.364567035,4823.550449240998,0.0,121.92,1644.2724500334996,393.0,5.364567035,4823.550449240998,0.0,121.92,0.0,295.15 +394,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,275800.0,5833.333333333334,9771749.768709991,5833.333333333334,7202006.077568987,true,394.0,394,0.875,0.0,0.0,0.0,0.0,0.0,394,21750.0,0.0,-10864.072067508407,-10864.072067508407,1404293.4249981393,700.0,275800.0,48.362346930702145,847321.9488422414,-11223.671084377205,12436.241604906561,0.0,0.0,521.9052627558324,544301.8059785437,-210.66859281773674,233.42857244755686,-0.0,-2248525.729748352,true,true,3.8893111,4827.439760340998,0.0,121.92,1644.2724500334996,394.0,3.8893111,4827.439760340998,0.0,121.92,0.0,295.15 +395,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,276500.0,5833.333333333334,9777583.102043325,5833.333333333334,7207839.41090232,true,395.0,395,0.875,0.0,0.0,0.0,0.0,0.0,395,21750.0,0.0,-7417.822908919587,-7417.822908919587,1396875.6020892197,700.0,276500.0,15.284585645136026,847337.2334278866,-7645.109284334358,4791.132320572204,0.0,0.0,355.5006862323436,544657.306664776,-143.49889646270796,89.9296759848489,-0.0,-2248525.729748352,true,true,2.414055166,4829.853815506998,0.0,121.92,1644.2724500334996,395.0,2.414055166,4829.853815506998,0.0,121.92,0.0,295.15 +396,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,277200.0,5833.333333333334,9783416.435376659,5833.333333333334,7213672.744235653,true,396.0,396,0.875,0.0,0.0,0.0,0.0,0.0,396,21750.0,0.0,-3951.480308328549,-3951.480308328549,1392924.1217808912,700.0,277200.0,2.3002769207802647,847339.5337048074,-4066.547494655964,724.5848259162399,0.0,0.0,189.0961097088548,544846.402774485,-76.32920030222022,13.600475682628684,-0.0,-2248525.729748352,true,true,0.938799231,4830.7926147379985,0.0,121.92,1644.2724500334996,396.0,0.938799231,4830.7926147379985,0.0,121.92,0.0,295.15 +397,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,277900.0,5833.333333333334,9789249.768709993,5833.333333333334,7219506.077568986,true,397.0,397,0.875,0.0,0.0,0.0,0.0,0.0,397,21750.0,0.0,-685.187895210597,-685.187895210597,1392238.9338856805,700.0,277900.0,0.05049567893915037,847339.5842004863,-724.5848259163639,-1.240323399542831e-10,0.0,0.0,52.94691070945558,544899.3496851944,-13.600475682627815,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,121.92,1644.2724500334996,397.0,0.0,4830.7926147379985,0.0,121.92,0.0,295.15 +398,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,278600.0,5833.333333333334,9795083.102043327,5833.333333333334,7225339.4109023195,true,398.0,398,0.875,0.0,0.0,0.0,0.0,0.0,398,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,278600.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,121.92,1644.2724500334996,398.0,0.0,4830.7926147379985,0.0,121.92,0.0,295.15 +399,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,279300.0,5833.333333333334,9800916.43537666,5833.333333333334,7231172.7442356525,true,399.0,399,0.875,0.0,0.0,0.0,0.0,0.0,399,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,279300.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,121.92,1644.2724500334996,399.0,0.0,4830.7926147379985,0.0,121.92,0.0,295.15 +400,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,280000.0,5833.333333333334,9806749.768709995,5833.333333333334,7237006.0775689855,true,400.0,400,0.875,0.0,0.0,0.0,0.0,0.0,400,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,280000.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,121.92,1644.2724500334996,400.0,0.0,4830.7926147379985,0.0,121.92,0.0,295.15 +401,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,280700.0,5833.333333333334,9812583.102043329,5833.333333333334,7242839.410902319,true,401.0,401,0.875,0.0,0.0,0.0,0.0,0.0,401,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,280700.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,121.92,1644.2724500334996,401.0,0.0,4830.7926147379985,0.0,121.92,0.0,295.15 +402,22450.0,21750.0,0.12,0.0,2569743.691140973,700.0,281400.0,5833.333333333334,9818416.435376663,5833.333333333334,7248672.744235652,true,402.0,402,0.875,0.0,0.0,0.0,0.0,0.0,402,21750.0,0.0,0.0,0.0,1392238.9338856805,700.0,281400.0,0.0,847339.5842004863,0.0,-1.240323399542831e-10,0.0,0.0,0.0,544899.3496851944,0.0,8.686384944667225e-13,-0.0,-2248525.729748352,true,true,0.0,4830.7926147379985,0.0,121.92,1644.2724500334996,402.0,0.0,4830.7926147379985,0.0,121.92,0.0,295.15 +403,22450.0,21750.0,0.16,1368.2268613201893,2571111.918002293,700.0,282100.0,12926.417883251184,9831342.853259914,11558.191021930996,7260230.935257583,true,403.0,403,0.875,1197.1985036551657,1368.2268613201893,171.02835766502358,0.0,0.0,403,21750.0,0.0,1197.1985036551657,1197.1985036551657,1393436.1323893357,700.0,282100.0,0.09583328521147606,847339.6800337716,1110.701457598817,1110.7014575986927,0.0,0.0,65.55331805345847,544964.9030032479,20.847894717678805,20.847894717679672,-1197.1985036551657,-2249722.9282520073,true,true,1.162322858,4831.954937595999,0.0,121.92,1644.2724500334996,403.0,1.162322858,4831.954937595999,0.0,121.92,0.0,295.15 +404,23818.22686132019,23118.22686132019,0.23500000000000001,5614.763082467892,2576726.681084761,700.0,282800.0,26871.332265820813,9858214.185525734,21256.56918335292,7281487.504440936,true,404.0,404,0.875,4912.917697159405,5614.763082467892,701.8453853084866,0.0,0.0,404,23118.22686132019,0.0,4912.917697159405,4912.917697159405,1398349.050086495,700.0,282800.0,3.348521633300225,847343.0285554049,4608.75382423358,5719.455281832274,0.0,0.0,214.30892434046203,545179.2119275883,86.50642695206237,107.35432166974203,-4912.917697159405,-2254635.845949167,true,true,2.637578792,4834.592516387998,0.0,121.92,1644.2724500334996,404.0,2.637578792,4834.592516387998,0.0,121.92,0.0,295.15 +405,28064.763082467893,27364.763082467893,0.30500000000000005,9989.117674403418,2586715.7987591643,700.0,283500.0,35046.28745706038,9893260.472982794,25057.169782656965,7306544.674223593,true,405.0,405,0.875,8740.477965102991,9989.117674403418,1248.639709300427,0.0,0.0,405,27364.763082467893,0.0,8740.477965102991,8740.477965102991,1407089.528051598,700.0,283500.0,18.772718752343465,847361.8012741572,8187.315622218238,13906.77090405051,0.0,0.0,380.7135008639508,545559.9254284523,153.6761232684589,261.03044493820096,-8740.477965102991,-2263376.32391427,true,true,4.112834727,4838.705351114998,0.0,121.92,1644.2724500334996,405.0,4.112834727,4838.705351114998,0.0,121.92,0.0,295.15 +406,32439.117674403416,31739.117674403416,0.335,14388.06484783743,2601103.8636070015,700.0,284200.0,45038.99954578337,9938299.472528577,30650.934697945944,7337195.608921539,true,406.0,406,0.875,12589.55674185775,14388.06484783743,1798.5081059796794,0.0,0.0,406,31739.117674403416,0.0,12589.55674185775,12589.55674185775,1419679.0847934557,700.0,284200.0,55.715435990423586,847417.5167101477,11765.87740910337,25672.64831315388,0.0,0.0,547.1180773874396,546107.0435058398,220.845819376517,481.87626431471796,-12589.55674185775,-2275965.880656128,true,true,5.588090661,4844.293441775998,0.0,121.92,1644.2724500334996,406.0,5.588090661,4844.293441775998,0.0,121.92,0.0,295.15 +407,36838.06484783743,36138.06484783743,0.35,18822.353715269743,2619926.2173222713,700.0,284900.0,55778.153472199265,9994077.626000777,36955.799756929526,7374151.408678468,true,407.0,407,0.875,16469.559500861025,18822.353715269743,2352.7942144087174,0.0,0.0,407,36138.06484783743,0.0,16469.559500861025,16469.559500861025,1436148.6442943166,700.0,284900.0,123.58211922664566,847541.0988293744,15344.439211939476,41017.08752509336,0.0,0.0,713.5226539109283,546820.5661597507,288.0155157839754,769.8917800986933,-16469.559500861025,-2292435.440156989,true,true,7.063346596,4851.356788371998,0.0,121.92,1644.2724500334996,407.0,7.063346596,4851.356788371998,0.0,121.92,0.0,295.15 +408,41272.35371526974,40572.35371526974,0.35666666666666663,23302.733314912777,2643228.950637184,700.0,285600.0,67297.38312592368,10061375.0091267,43994.649811010895,7418146.058489479,true,408.0,408,0.875,20389.89165054868,23302.733314912777,2912.841664364096,0.0,0.0,408,40572.35371526974,0.0,20389.89165054868,20389.89165054868,1456538.5359448653,700.0,285600.0,231.7782143401148,847772.8770437145,18923.000993973175,59940.088519066536,0.0,0.0,879.9272304344172,547700.4933901851,355.185211800972,1125.0769918996652,-20389.89165054868,-2312825.3318075375,true,true,8.53860253,4859.895390901998,0.0,121.92,1644.2724500334996,408.0,8.53860253,4859.895390901998,0.0,121.92,0.0,295.15 +409,45752.73331491278,45052.73331491278,0.3595,27839.952685323547,2671068.9033225076,700.0,286300.0,79387.90733052447,10140762.916457225,51547.95464520092,7469694.01313468,true,409.0,409,0.875,24359.958599658105,27839.952685323547,3479.994085665443,0.0,0.0,409,45052.73331491278,0.0,24359.958599658105,24359.958599658105,1480898.4945445235,700.0,286300.0,389.70916689484903,848162.5862106094,22501.562719333142,82441.65123839967,0.0,0.0,1046.3318066759132,548746.8251968609,422.35490675420107,1547.4318986538663,-24359.958599658105,-2337185.2904071957,true,true,10.01385846,4869.909249361998,0.0,121.92,1644.2724500334996,409.0,10.01385846,4869.909249361998,0.0,121.92,0.0,295.15 +410,50289.952685323544,49589.952685323544,0.36,25605.457347028765,2696674.3606695365,700.0,287000.0,73070.71485285768,10213833.631310083,47465.257505828915,7517159.270640508,true,410.0,410,0.875,22404.77517865017,25605.457347028765,3200.6821683785965,0.0,0.0,410,49589.952685323544,0.0,22404.77517865017,22404.77517865017,1503303.2697231737,700.0,287000.0,580.6726304220535,848743.2588410315,20248.941977462855,102690.59321586252,0.0,0.0,1195.0874128501196,549941.912609711,380.07315791514094,1927.5050565690071,-22404.77517865017,-2359590.065585846,true,true,11.17618132,4881.085430681998,0.0,121.92,1644.2724500334996,410.0,11.17618132,4881.085430681998,0.0,121.92,0.0,295.15 +411,48055.457347028765,47355.457347028765,0.28625,8073.24864091947,2704747.609310456,700.0,287700.0,30648.90354906365,10244482.534859147,22575.654908144177,7539734.925548652,true,411.0,411,0.875,7064.092560804536,8073.24864091947,1009.1560801149335,0.0,0.0,411,47355.457347028765,0.0,7064.092560804536,7064.092560804536,1510367.3622839781,700.0,287700.0,706.3954316362309,849449.6542726677,4988.298224439979,107678.8914403025,0.0,0.0,1275.7684196938221,551217.6810294049,93.6304850345049,2021.1355416035121,-7064.092560804536,-2366654.1581466505,true,true,11.44440967,4892.529840351998,0.0,121.92,1644.2724500334996,411.0,11.44440967,4892.529840351998,0.0,121.92,0.0,295.15 +412,30523.248640919468,29823.248640919468,0.355,21763.46161936718,2726511.0709298234,700.0,288400.0,63277.356674273746,10307759.891533421,41513.89505490656,7581248.820603559,true,412.0,412,0.875,19043.02891694628,21763.46161936718,2720.432702420898,0.0,0.0,412,29823.248640919468,0.0,19043.02891694628,19043.02891694628,1529410.3912009245,700.0,288400.0,816.3565742658346,850266.0108469336,16576.72631046246,124255.61775076496,0.0,0.0,1338.800456131844,552556.4814855367,311.14557608613876,2332.2811176896507,-19043.02891694628,-2385697.1870635967,true,true,12.29379945,4904.823639801998,0.0,121.92,1644.2724500334996,412.0,12.29379945,4904.823639801998,0.0,121.92,0.0,295.15 +413,44213.46161936718,43513.46161936718,0.3516666666666666,18964.759018554443,2745475.829948378,700.0,289100.0,55918.74602432544,10363678.637557747,36953.98700577099,7618202.80760933,true,413.0,413,0.875,16594.16414123514,18964.759018554443,2370.594877319305,0.0,0.0,413,43513.46161936718,0.0,16594.16414123514,16594.16414123514,1546004.5553421597,700.0,289100.0,983.4259744983184,851249.4368214319,13924.844454919332,138180.46220568428,0.0,0.0,1424.5240258680285,553981.0055114047,261.36968594946114,2593.650803639112,-16594.16414123514,-2402291.3512048316,true,true,12.96437033,4917.788010131998,0.0,121.92,1644.2724500334996,413.0,12.96437033,4917.788010131998,0.0,121.92,0.0,295.15 +414,41414.75901855444,40714.75901855444,0.335,14266.669021141239,2759742.498969519,700.0,289800.0,44676.623943705185,10408355.261501452,30409.954922563946,7648612.762531894,true,414.0,414,0.875,12483.335393498584,14266.669021141239,1783.3336276426544,0.0,0.0,414,40714.75901855444,0.0,12483.335393498584,12483.335393498584,1558487.8907356584,700.0,289800.0,1119.8306928548616,852369.2675142867,9693.992157469927,147874.45436315422,0.0,0.0,1487.5560628700357,555468.5615742748,181.95648030376034,2775.607283942872,-12483.335393498584,-2414774.6865983303,true,true,13.41141759,4931.199427721998,0.0,121.92,1644.2724500334996,414.0,13.41141759,4931.199427721998,0.0,121.92,0.0,295.15 +415,36716.669021141235,36016.669021141235,0.20800000000000002,4234.214840726034,2763976.713810245,700.0,290500.0,23722.186734259776,10432077.448235711,19487.971893533744,7668100.734425428,true,415.0,415,0.875,3704.93798563528,4234.214840726034,529.276855090754,0.0,0.0,415,36016.669021141235,0.0,3704.93798563528,3704.93798563528,1562192.8287212937,700.0,290500.0,1183.640312153131,853552.9078264398,987.4726279819884,148861.92699113622,0.0,0.0,1515.2901590606812,556983.8517333355,18.534886439479003,2794.142170382351,-3704.93798563528,-2418479.6245839656,true,true,13.45612231,4944.655550031998,0.0,121.92,1644.2724500334996,415.0,13.45612231,4944.655550031998,0.0,121.92,0.0,295.15 +416,26684.214840726032,25984.214840726032,0.17200000000000001,1934.7690934769655,2765911.482903722,700.0,291200.0,15318.424962075378,10447395.873197787,13383.655868598413,7681484.390294027,true,416.0,416,0.875,1692.9229567923448,1934.7690934769655,241.84613668462066,0.0,0.0,416,25984.214840726032,0.0,1692.9229567923448,1692.9229567923448,1563885.7516780861,700.0,291200.0,1183.640312153131,854736.548138593,-987.4726279819884,147874.45436315422,0.0,0.0,1515.2901590606812,558499.1418923963,-18.534886439479003,2775.607283942872,-1692.9229567923448,-2420172.547540758,true,true,13.41141759,4958.066967621999,0.0,121.92,1644.2724500334996,416.0,13.41141759,4958.066967621999,0.0,121.92,0.0,295.15 +417,24384.769093476963,23684.769093476963,0.12,0.0,2765911.482903722,700.0,291900.0,5833.333333333334,10453229.20653112,5833.333333333334,7687317.72362736,true,417.0,417,0.875,0.0,0.0,0.0,0.0,0.0,417,23684.769093476963,0.0,-332.5674446024675,-332.5674446024675,1563553.1842334836,700.0,291900.0,1160.1638400882891,855896.7119786813,-2942.7017313359215,144931.7526318183,0.0,0.0,1505.2050332757167,560004.346925672,-55.2345866305518,2720.3726973123203,-0.0,-2420172.547540758,true,true,13.27730341,4971.344271031999,0.0,121.92,1644.2724500334996,417.0,13.27730341,4971.344271031999,0.0,121.92,0.0,295.15 +418,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,292600.0,5833.333333333334,10459062.539864454,5833.333333333334,7693151.056960693,true,418.0,418,0.875,0.0,0.0,0.0,0.0,0.0,418,21750.0,0.0,-1342.9926110185363,-1342.9926110185363,1562210.1916224652,700.0,292600.0,1119.8306928548616,857016.5426715361,-3877.5967762500027,141054.1558555683,0.0,0.0,1487.5560628700357,561491.9029885421,-72.78259049343072,2647.5901068188896,-0.0,-2420172.547540758,true,true,13.09848451,4984.442755541999,0.0,121.92,1644.2724500334996,418.0,13.09848451,4984.442755541999,0.0,121.92,0.0,295.15 +419,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,293300.0,5833.333333333334,10464895.873197788,5833.333333333334,7698984.390294026,true,419.0,419,0.875,0.0,0.0,0.0,0.0,0.0,419,21750.0,0.0,-2328.4228024278555,-2328.4228024278555,1559881.7688200374,700.0,293300.0,1069.361954453522,858085.9046259896,-4773.058849973006,136281.0970055953,0.0,0.0,1464.8645295718727,562956.767518114,-89.5904364802446,2557.999670338645,-0.0,-2420172.547540758,true,true,12.87496088,4997.317716421999,0.0,121.92,1644.2724500334996,419.0,12.87496088,4997.317716421999,0.0,121.92,0.0,295.15 +420,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,294000.0,5833.333333333334,10470729.206531122,5833.333333333334,7704817.723627359,true,420.0,420,0.875,0.0,0.0,0.0,0.0,0.0,420,21750.0,0.0,-5174.891806221283,-5174.891806221283,1554706.877013816,700.0,294000.0,999.174492736611,859085.0791187262,-7466.016842686272,128815.08016290904,0.0,0.0,1432.0878704887448,564388.8553886027,-140.13732676036645,2417.862343578279,-0.0,-2420172.547540758,true,true,12.51732308,5009.835039501999,0.0,121.92,1644.2724500334996,420.0,12.51732308,5009.835039501999,0.0,121.92,0.0,295.15 +421,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,294700.0,5833.333333333334,10476562.539864456,5833.333333333334,7710651.056960692,true,421.0,421,0.875,0.0,0.0,0.0,0.0,0.0,421,21750.0,0.0,-24466.811987922632,-24466.811987922632,1530240.0650258935,700.0,294700.0,811.7530711655426,859896.8321898917,-26124.4869470465,102690.59321586255,0.0,0.0,1336.2791749675955,565725.1345635703,-490.3572870092716,1927.5050565690071,-0.0,-2420172.547540758,true,true,11.17618132,5021.011220821999,0.0,121.92,1644.2724500334996,421.0,11.17618132,5021.011220821999,0.0,121.92,0.0,295.15 +422,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,295400.0,5833.333333333334,10482395.87319779,5833.333333333334,7716484.390294025,true,422.0,422,0.875,0.0,0.0,0.0,0.0,0.0,422,21750.0,0.0,-24063.549042466155,-24063.549042466155,1506176.5159834274,700.0,295400.0,555.3246778605084,860452.1568677522,-25321.03567706439,77369.55753879817,0.0,0.0,1177.438442895627,566902.5730064659,-475.27648615790315,1452.228570411104,-0.0,-2420172.547540758,true,true,9.700925388,5030.7121462099985,0.0,121.92,1644.2724500334996,422.0,9.700925388,5030.7121462099985,0.0,121.92,0.0,295.15 +423,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,296100.0,5833.333333333334,10488229.206531124,5833.333333333334,7722317.723627358,true,423.0,423,0.875,0.0,0.0,0.0,0.0,0.0,423,21750.0,0.0,-20787.962579791783,-20787.962579791783,1485388.5534036355,700.0,296100.0,351.58428075642365,860803.7411485086,-21742.47393612097,55627.0836026772,0.0,0.0,1011.0338664849355,567913.6068729508,-408.1067909121724,1044.1217794989316,-0.0,-2420172.547540758,true,true,8.225669453,5038.937815662998,0.0,121.92,1644.2724500334996,423.0,8.225669453,5038.937815662998,0.0,121.92,0.0,295.15 +424,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,296800.0,5833.333333333334,10494062.539864458,5833.333333333334,7728151.056960691,true,424.0,424,0.875,0.0,0.0,0.0,0.0,0.0,424,21750.0,0.0,-17455.230840861954,-17455.230840861954,1467933.3225627735,700.0,296800.0,204.98909254787833,861008.7302410565,-18163.91212894797,37463.171473729235,0.0,0.0,844.6292899614467,568758.2361629122,-340.9370944233103,703.1846850756212,-0.0,-2420172.547540758,true,true,6.750413519,5045.688229181998,0.0,121.92,1644.2724500334996,424.0,6.750413519,5045.688229181998,0.0,121.92,0.0,295.15 +425,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,297500.0,5833.333333333334,10499895.873197792,5833.333333333334,7733984.390294024,true,425.0,425,0.875,0.0,0.0,0.0,0.0,0.0,425,21750.0,0.0,-14074.759363843074,-14074.759363843074,1453858.5631989304,700.0,297500.0,106.1336675153654,861114.8639085719,-14585.35034639974,22877.821127329495,0.0,0.0,678.224713437958,569436.4608763502,-273.76739839665595,429.4172866789653,-0.0,-2420172.547540758,true,true,5.275157584,5050.963386765999,0.0,121.92,1644.2724500334996,425.0,5.275157584,5050.963386765999,0.0,121.92,0.0,295.15 +426,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,298200.0,5833.333333333334,10505729.206531126,5833.333333333334,7739817.723627357,true,426.0,426,0.875,0.0,0.0,0.0,0.0,0.0,426,21750.0,0.0,-10655.953549382784,-10655.953549382784,1443202.6096495476,700.0,298200.0,45.61255977977984,861160.4764683517,-11006.788544078177,11871.032583251317,0.0,0.0,511.8201369144692,569948.2810132647,-206.59770199885568,222.8195846801096,-0.0,-2420172.547540758,true,true,3.79990165,5054.763288415998,0.0,121.92,1644.2724500334996,426.0,3.79990165,5054.763288415998,0.0,121.92,0.0,295.15 +427,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,298900.0,5833.333333333334,10511562.53986446,5833.333333333334,7745651.05696069,true,427.0,427,0.875,0.0,0.0,0.0,0.0,0.0,427,21750.0,0.0,-7208.218878706637,-7208.218878706637,1435994.390770841,700.0,298900.0,14.020323462016645,861174.4967918136,-7428.226756678495,4442.805826572822,0.0,0.0,345.41556039098043,570293.6965736557,-139.42800588113943,83.39157879897019,-0.0,-2420172.547540758,true,true,2.324645715,5057.087934130998,0.0,121.92,1644.2724500334996,427.0,2.324645715,5057.087934130998,0.0,121.92,0.0,295.15 +428,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,299600.0,5833.333333333334,10517395.873197794,5833.333333333334,7751484.390294023,true,428.0,428,0.875,0.0,0.0,0.0,0.0,0.0,428,21750.0,0.0,-3740.960773713411,-3740.960773713411,1432253.4299971275,700.0,299600.0,1.9515126811261934,861176.4483044947,-3849.6649606050146,593.1408659678077,0.0,0.0,179.0109838110931,570472.7075574668,-72.25830960061573,11.133269198354455,-0.0,-2420172.547540758,true,true,0.84938978,5057.937323910998,0.0,121.92,1644.2724500334996,428.0,0.84938978,5057.937323910998,0.0,121.92,0.0,295.15 +429,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,300300.0,5833.333333333334,10523229.206531128,5833.333333333334,7757317.723627356,true,429.0,429,0.875,0.0,0.0,0.0,0.0,0.0,429,21750.0,0.0,-556.3323886516241,-556.3323886516241,1431697.097608476,700.0,300300.0,0.03739875405672881,861176.4857032488,-593.1408659679017,-9.401901479577646e-11,0.0,0.0,47.90434776057472,570520.6119052274,-11.133269198353863,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,429.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +430,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,301000.0,5833.333333333334,10529062.539864462,5833.333333333334,7763151.056960689,true,430.0,430,0.875,0.0,0.0,0.0,0.0,0.0,430,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,301000.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,430.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +431,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,301700.0,5833.333333333334,10534895.873197796,5833.333333333334,7768984.390294022,true,431.0,431,0.875,0.0,0.0,0.0,0.0,0.0,431,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,301700.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,431.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +432,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,302400.0,5833.333333333334,10540729.20653113,5833.333333333334,7774817.723627355,true,432.0,432,0.875,0.0,0.0,0.0,0.0,0.0,432,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,302400.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,432.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +433,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,303100.0,5833.333333333334,10546562.539864464,5833.333333333334,7780651.056960688,true,433.0,433,0.875,0.0,0.0,0.0,0.0,0.0,433,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,303100.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,433.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +434,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,303800.0,5833.333333333334,10552395.873197798,5833.333333333334,7786484.390294021,true,434.0,434,0.875,0.0,0.0,0.0,0.0,0.0,434,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,303800.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,434.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +435,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,304500.0,5833.333333333334,10558229.206531132,5833.333333333334,7792317.723627354,true,435.0,435,0.875,0.0,0.0,0.0,0.0,0.0,435,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,304500.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,435.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +436,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,305200.0,5833.333333333334,10564062.539864466,5833.333333333334,7798151.056960687,true,436.0,436,0.875,0.0,0.0,0.0,0.0,0.0,436,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,305200.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,436.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +437,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,305900.0,5833.333333333334,10569895.8731978,5833.333333333334,7803984.39029402,true,437.0,437,0.875,0.0,0.0,0.0,0.0,0.0,437,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,305900.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,437.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +438,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,306600.0,5833.333333333334,10575729.206531134,5833.333333333334,7809817.723627353,true,438.0,438,0.875,0.0,0.0,0.0,0.0,0.0,438,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,306600.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,438.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +439,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,307300.0,5833.333333333334,10581562.539864467,5833.333333333334,7815651.056960686,true,439.0,439,0.875,0.0,0.0,0.0,0.0,0.0,439,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,307300.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,439.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +440,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,308000.0,5833.333333333334,10587395.873197801,5833.333333333334,7821484.390294019,true,440.0,440,0.875,0.0,0.0,0.0,0.0,0.0,440,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,308000.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,440.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +441,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,308700.0,5833.333333333334,10593229.206531135,5833.333333333334,7827317.723627352,true,441.0,441,0.875,0.0,0.0,0.0,0.0,0.0,441,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,308700.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,441.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +442,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,309400.0,5833.333333333334,10599062.53986447,5833.333333333334,7833151.056960685,true,442.0,442,0.875,0.0,0.0,0.0,0.0,0.0,442,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,309400.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,442.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +443,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,310100.0,5833.333333333334,10604895.873197803,5833.333333333334,7838984.390294018,true,443.0,443,0.875,0.0,0.0,0.0,0.0,0.0,443,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,310100.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,443.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +444,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,310800.0,5833.333333333334,10610729.206531137,5833.333333333334,7844817.723627351,true,444.0,444,0.875,0.0,0.0,0.0,0.0,0.0,444,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,310800.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,444.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +445,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,311500.0,5833.333333333334,10616562.539864471,5833.333333333334,7850651.056960684,true,445.0,445,0.875,0.0,0.0,0.0,0.0,0.0,445,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,311500.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,445.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +446,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,312200.0,5833.333333333334,10622395.873197805,5833.333333333334,7856484.390294017,true,446.0,446,0.875,0.0,0.0,0.0,0.0,0.0,446,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,312200.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,446.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +447,22450.0,21750.0,0.12,0.0,2765911.482903722,700.0,312900.0,5833.333333333334,10628229.20653114,5833.333333333334,7862317.72362735,true,447.0,447,0.875,0.0,0.0,0.0,0.0,0.0,447,21750.0,0.0,0.0,0.0,1431697.097608476,700.0,312900.0,0.0,861176.4857032488,0.0,-9.401901479577646e-11,0.0,0.0,0.0,570520.6119052274,0.0,5.915268275202834e-13,-0.0,-2420172.547540758,true,true,0.0,5057.937323910998,0.0,121.92,1644.2724500334996,447.0,0.0,5057.937323910998,0.0,121.92,0.0,295.15 +448,22450.0,21750.0,0.1768,2178.5874071500493,2768090.070310872,700.0,313600.0,16281.602981617925,10644510.809512757,14103.015574467876,7876420.739201819,true,448.0,448,0.875,1906.2639812562932,2178.5874071500493,272.32342589375617,0.0,0.0,448,21750.0,0.0,1906.2639812562932,1906.2639812562932,1433603.3615897323,700.0,313600.0,0.19594678934725546,861176.6816500381,1789.2808980367404,1789.2808980366462,0.0,0.0,83.20228828994367,570603.8141935173,33.58484814026184,33.58484814026243,-1906.2639812562932,-2422078.811522014,true,true,1.475255935,5059.412579845998,0.0,121.92,1644.2724500334996,448.0,1.475255935,5059.412579845998,0.0,121.92,0.0,295.15 +449,24628.58740715005,23928.58740715005,0.265,6541.136756240824,2774631.207067113,700.0,314300.0,27325.04436317292,10671835.85387593,20783.907606932098,7897204.646808751,true,449.0,449,0.875,5723.494661710721,6541.136756240824,817.6420945301033,0.0,0.0,449,23928.58740715005,0.0,5723.494661710721,5723.494661710721,1439326.856251443,700.0,314300.0,5.290563308789698,861181.9722133469,5367.842689258775,7157.123587295421,0.0,0.0,249.60686481343245,570853.4210583308,100.75454432972379,134.33939246998622,-5723.494661710721,-2427802.3061837247,true,true,2.950511869,5062.3630917149985,0.0,121.92,1644.2724500334996,449.0,2.950511869,5062.3630917149985,0.0,121.92,0.0,295.15 +450,28991.136756240823,28291.136756240823,0.30500000000000005,10919.809735313333,2785551.0168024264,700.0,315000.0,38097.73683709289,10709933.590713022,27177.927101779555,7924382.573910531,true,450.0,450,0.875,9554.833518399166,10919.809735313333,1364.9762169141668,0.0,0.0,450,28291.136756240823,0.0,9554.833518399166,9554.833518399166,1448881.6897698422,700.0,315000.0,24.493348648483604,861206.4655619954,8946.404487757982,16103.528075053404,0.0,0.0,416.0114413369212,571269.4324996677,167.9242406557784,302.2636331257646,-9554.833518399166,-2437357.139702124,true,true,4.425767804,5066.788859518999,0.0,121.92,1644.2724500334996,450.0,4.425767804,5066.788859518999,0.0,121.92,0.0,295.15 +451,33369.809735313334,32669.809735313334,0.33999999999999997,15325.35540277793,2800876.3722052043,700.0,315700.0,47133.39824346451,10757066.988956487,31808.042840686576,7956190.616751217,true,451.0,451,0.875,13409.685977430689,15325.35540277793,1915.6694253472415,0.0,0.0,451,32669.809735313334,0.0,13409.685977430689,13409.685977430689,1462291.375747273,700.0,315700.0,67.20974868753402,861273.675310683,12524.966274128567,28628.494349181972,0.0,0.0,582.41601786041,571851.8485175282,235.09393675417851,537.3575698799432,-13409.685977430689,-2450766.8256795546,true,true,5.901023738,5072.689883256999,0.0,121.92,1644.2724500334996,451.0,5.901023738,5072.689883256999,0.0,121.92,0.0,295.15 +452,37775.35540277793,37075.35540277793,0.3516666666666666,19768.52287353081,2820644.895078735,700.0,316400.0,58204.330446059175,10815271.319402546,38435.80757252837,7994626.424323746,true,452.0,452,0.875,17297.457514339458,19768.52287353081,2471.0653591913506,0.0,0.0,452,37075.35540277793,0.0,17297.457514339458,17297.457514339458,1479588.8332616123,700.0,316400.0,142.84520930504598,861416.520519988,16103.528077479215,44732.02242666119,0.0,0.0,748.8205943838988,572600.669111912,302.2636331712946,839.6212030512378,-17297.457514339458,-2468064.283193894,true,true,7.376279673,5080.066162929998,0.0,121.92,1644.2724500334996,452.0,7.376279673,5080.066162929998,0.0,121.92,0.0,295.15 +453,42218.522873530805,41518.522873530805,0.35833333333333334,24260.06118338802,2844904.956262123,700.0,317100.0,69655.98469782704,10884927.304100372,45395.92351443901,8040022.347838185,true,453.0,453,0.875,21227.553535464518,24260.06118338802,3032.507647923503,0.0,0.0,453,41518.522873530805,0.0,21227.553535464518,21227.553535464518,1500816.3867970768,700.0,317100.0,260.8051763801247,861677.3256963681,19682.089858998374,64414.11228565956,0.0,0.0,915.2251709073876,573515.8942828194,369.43332917863336,1209.0545322298713,-21227.553535464518,-2489291.836729359,true,true,8.851535607,5088.917698536999,0.0,121.92,1644.2724500334996,453.0,8.851535607,5088.917698536999,0.0,121.92,0.0,295.15 +454,46710.061183388025,46010.061183388025,0.359,28810.719430017118,2873715.67569214,700.0,317800.0,82202.56108639867,10967129.865186771,53391.84165638155,8093414.189494566,true,454.0,454,0.875,25209.37950126498,28810.719430017118,3601.339928752139,0.0,0.0,454,46010.061183388025,0.0,25209.37950126498,25209.37950126498,1526025.7662983418,700.0,317800.0,430.49509565719336,862107.8207920253,23260.65163324033,87674.76391889989,0.0,0.0,1081.6297473180794,574597.5240301375,436.60302504937886,1645.65755727925,-25209.37950126498,-2514501.216230624,true,true,10.32679154,5099.244490076999,0.0,121.92,1644.2724500334996,454.0,10.32679154,5099.244490076999,0.0,121.92,0.0,295.15 +455,51260.71943001712,50560.71943001712,0.357,33431.24687635975,2907146.9225685,700.0,318500.0,95605.73354722619,11062735.598733997,62174.48667086644,8155588.676165433,true,455.0,455,0.875,29252.341016814782,33431.24687635975,4178.905859544968,0.0,0.0,455,50560.71943001712,0.0,29252.341016814782,29252.341016814782,1555278.1073151566,700.0,318500.0,661.3204135987122,862769.141205624,26839.2135554514,114513.97747435128,0.0,0.0,1248.0343240671623,575845.5583542046,503.77272369750847,2149.4302809767587,-29252.341016814782,-2543753.5572474385,true,true,11.80204748,5111.046537556998,0.0,121.92,1644.2724500334996,455.0,11.80204748,5111.046537556998,0.0,121.92,0.0,295.15 +456,55881.24687635975,55181.24687635975,0.345,17069.894168305917,2924216.816736806,700.0,319200.0,51506.939618278026,11114242.538352275,34437.04544997211,8190025.721615405,true,456.0,456,0.875,14936.157397267676,17069.894168305917,2133.7367710382405,0.0,0.0,456,55181.24687635975,0.0,14936.157397267676,14936.157397267676,1570214.2647124243,700.0,319200.0,868.1488445557435,863637.2900501797,12467.459467303652,126981.43694165493,0.0,0.0,1366.5345528864748,577212.0929070911,234.0145325218045,2383.4448134985632,-14936.157397267676,-2558689.7146447063,true,true,12.42791363,5123.4744511869985,0.0,121.92,1644.2724500334996,456.0,12.42791363,5123.4744511869985,0.0,121.92,0.0,295.15 +457,39519.89416830592,38819.89416830592,0.345,16938.093109240115,2941154.9098460465,700.0,319900.0,51124.90756301483,11165367.44591529,34186.814453774714,8224212.53606918,true,457.0,457,0.875,14820.8314705851,16938.093109240115,2117.2616386550144,0.0,0.0,457,38819.89416830592,0.0,14820.8314705851,14820.8314705851,1585035.0961830094,700.0,319900.0,1004.461119889405,864641.7511700691,12153.63711943888,139135.07406109382,0.0,0.0,1434.6091522169786,578646.7020593081,228.12407903983691,2611.5688925384,-14820.8314705851,-2573510.5461152913,true,true,13.00907506,5136.483526246999,0.0,121.92,1644.2724500334996,457.0,13.00907506,5136.483526246999,0.0,121.92,0.0,295.15 +458,39388.093109240115,38688.093109240115,0.358,30955.857289350188,2972110.7671353966,700.0,320600.0,88424.18237248657,11253791.628287775,57468.325083136384,8281680.861152316,true,458.0,458,0.875,27086.375128181415,30955.857289350188,3869.482161168773,0.0,0.0,458,38688.093109240115,0.0,27086.375128181415,27086.375128181415,1612121.4713111909,700.0,320600.0,1213.4285375204897,865855.1797075896,23896.511885861124,163031.58594695496,0.0,0.0,1527.8965665738797,580174.598625882,448.5381382259236,3060.107030764324,-27086.375128181415,-2600596.9212434725,true,true,14.08198847,5150.565514716999,0.0,121.92,1644.2724500334996,458.0,14.08198847,5150.565514716999,0.0,121.92,0.0,295.15 +459,53405.857289350184,52705.857289350184,0.355,22039.10071064094,2994149.8678460377,700.0,321300.0,64053.80481870688,11317845.433106482,42014.70410806594,8323695.565260382,true,459.0,459,0.875,19284.213121810822,22039.10071064094,2754.887588830119,0.0,0.0,459,52705.857289350184,0.0,19284.213121810822,19284.213121810822,1631405.6844330018,700.0,321300.0,1463.1049380067125,867318.2846455963,15896.503856718986,178928.08980367394,0.0,0.0,1626.2265438232632,581800.8251697052,298.37778326186145,3358.4848140261856,-19284.213121810822,-2619881.1343652834,true,true,14.75255935,5165.3180740669995,0.0,121.92,1644.2724500334996,459.0,14.75255935,5165.3180740669995,0.0,121.92,0.0,295.15 +460,44489.10071064094,43789.10071064094,0.3175,11404.28836633784,3005554.1562123755,700.0,322000.0,38123.742886103435,11355969.175992586,26719.454519765597,8350415.019780148,true,460.0,460,0.875,9978.75232054561,11404.28836633784,1425.5360457922307,0.0,0.0,460,43789.10071064094,0.0,9978.75232054561,9978.75232054561,1641384.4367535473,700.0,322000.0,1610.7161737802023,868929.0008193764,6565.625729708203,185493.71553338214,0.0,0.0,1679.17345447632,583479.9986241815,123.23696258088448,3481.7217766070703,-9978.75232054561,-2629859.886685829,true,true,15.0207877,5180.338861767,0.0,121.92,1644.2724500334996,460.0,15.0207877,5180.338861767,0.0,121.92,0.0,295.15 +461,33854.28836633784,33154.28836633784,0.3516666666666666,19667.106652436312,3025221.262864812,700.0,322700.0,57915.94308749663,11413885.119080082,38248.836435060315,8388663.856215209,true,461.0,461,0.875,17208.718320881773,19667.106652436312,2458.388331554539,0.0,0.0,461,33154.28836633784,0.0,17208.718320881773,17208.718320881773,1658593.155074429,700.0,322700.0,1744.8762726945233,870673.877092071,13486.150145124762,198979.8656785069,0.0,0.0,1724.556520508661,585204.5551446902,253.13538255382687,3734.857159160897,-17208.718320881773,-2647068.605006711,true,true,15.5572444,5195.896106167,0.0,121.92,1644.2724500334996,461.0,15.5572444,5195.896106167,0.0,121.92,0.0,295.15 +462,42117.10665243631,41417.10665243631,0.28625,8153.975857541137,3033375.238722353,700.0,323400.0,30930.92002634458,11444816.039106427,22776.944168803442,8411440.800384013,true,462.0,462,0.875,7134.7288753484945,8153.975857541137,1019.2469821926425,0.0,0.0,462,41417.10665243631,0.0,7134.7288753484945,7134.7288753484945,1665727.8839497776,700.0,323400.0,1862.2065897062491,872536.0836817772,3445.474891474757,202425.34056998166,0.0,0.0,1762.375742484271,586966.9308871744,64.6716516832171,3799.528810844114,-7134.7288753484945,-2654203.3338820594,true,true,15.69135858,5211.587464747,0.0,121.92,1644.2724500334996,462.0,15.69135858,5211.587464747,0.0,121.92,0.0,295.15 +463,30603.975857541136,29903.975857541136,0.30500000000000005,11001.857187552174,3044377.095909905,700.0,324100.0,38366.74487722023,11483182.783983648,27364.88768966806,8438805.688073682,true,463.0,463,0.875,9626.625039108152,11001.857187552174,1375.2321484440217,0.0,0.0,463,29903.975857541136,0.0,9626.625039108152,9626.625039108152,1675354.5089888857,700.0,324100.0,1926.8795748703742,874462.9632566476,5808.179787281239,208233.5203572629,0.0,0.0,1782.5459940542003,588749.4768812286,109.01968290233931,3908.5484937464535,-9626.625039108152,-2663829.9589211675,true,true,15.9148822,5227.502346947,0.0,121.92,1644.2724500334996,463.0,15.9148822,5227.502346947,0.0,121.92,0.0,295.15 +464,33451.857187552174,32751.857187552174,0.3175,11221.094229335808,3055598.190139241,700.0,324800.0,37546.753478223014,11520729.537461871,26325.659248887205,8465131.347322568,true,464.0,464,0.875,9818.457450668831,11221.094229335808,1402.6367786669762,0.0,0.0,464,32751.857187552174,0.0,9818.457450668831,9818.457450668831,1685172.9664395545,700.0,324800.0,2009.8044278032182,876472.7676844508,5890.3325225089075,214123.85287977182,0.0,0.0,1807.7588085166117,590557.2356897453,110.5616918400946,4019.110185586548,-9818.457450668831,-2673648.4163718363,true,true,16.13840583,5243.640752777,0.0,121.92,1644.2724500334996,464.0,16.13840583,5243.640752777,0.0,121.92,0.0,295.15 +465,33671.09422933581,32971.09422933581,0.1912,3033.8271421138465,3058632.017281355,700.0,325500.0,19528.384634486643,11540257.922096359,16494.557492372798,8481625.904814942,true,465.0,465,0.875,2654.598749349616,3033.8271421138465,379.22839276423065,0.0,0.0,465,32971.09422933581,0.0,2654.598749349616,2654.598749349616,1687827.565188904,700.0,325500.0,2043.6293242594552,878516.3970087103,-1184.6388085290018,212939.2140712428,0.0,0.0,1817.8439343015766,592375.0796240468,-22.23570068241439,3996.8744849041336,-2654.598749349616,-2676303.015121186,true,true,16.0937011,5259.734453876999,0.0,121.92,1644.2724500334996,465.0,16.0937011,5259.734453876999,0.0,121.92,0.0,295.15 +466,25483.827142113845,24783.827142113845,0.23500000000000001,5792.397448882797,3064424.414730238,700.0,326200.0,27627.223186735304,11567885.145283094,21834.82573785251,8503460.730552794,true,466.0,466,0.875,5068.347767772448,5792.397448882797,724.0496811103494,0.0,0.0,466,24783.827142113845,0.0,5068.347767772448,5068.347767772448,1692895.9129566764,700.0,326200.0,2043.6293242594552,880560.0263329698,1184.6388085290018,214123.85287977182,0.0,0.0,1817.8439343015766,594192.9235583483,22.23570068241439,4019.110185586548,-5068.347767772448,-2681371.362888959,true,true,16.13840583,5275.872859706999,0.0,121.92,1644.2724500334996,466.0,16.13840583,5275.872859706999,0.0,121.92,0.0,295.15 +467,28242.397448882795,27542.397448882795,0.23500000000000001,5821.4762081118115,3070245.8909383495,700.0,326900.0,27750.962587709833,11595636.107870804,21929.48637959802,8525390.216932392,true,467.0,467,0.875,5093.791682097835,5821.4762081118115,727.6845260139762,0.0,0.0,467,27542.397448882795,0.0,5093.791682097835,5093.791682097835,1697989.7046387743,700.0,326900.0,2060.6831669298017,882620.7094998995,1187.9246421113255,215311.77752188314,0.0,0.0,1822.8864971940588,596015.8100555424,22.29737586264917,4041.407561449197,-5093.791682097835,-2686465.154571057,true,true,16.18311055,5292.055970256999,0.0,121.92,1644.2724500334996,467.0,16.18311055,5292.055970256999,0.0,121.92,0.0,295.15 +468,28271.47620811181,27571.47620811181,0.16720000000000002,1663.3292831870199,3071909.2202215367,700.0,327600.0,14134.744516668778,11609770.852387473,12471.415233481757,8537861.632165873,true,468.0,468,0.875,1455.4131227886423,1663.3292831870199,207.91616039837754,0.0,0.0,468,27571.47620811181,0.0,1455.4131227886423,1455.4131227886423,1699445.1177615628,700.0,327600.0,2052.1444345082086,884672.8539344077,-2372.5634506403276,212939.2140712428,0.0,0.0,1820.3652154658248,597836.1752710082,-44.53307654506356,3996.8744849041336,-1455.4131227886423,-2687920.5676938454,true,true,16.0937011,5308.149671356999,0.0,121.92,1644.2724500334996,468.0,16.0937011,5308.149671356999,0.0,121.92,0.0,295.15 +469,24113.32928318702,23413.32928318702,0.128,248.0307685541063,3072157.250990091,700.0,328300.0,7406.490379328956,11617177.342766803,7158.459610774849,8545020.091776649,true,469.0,469,0.875,217.026922484843,248.0307685541063,31.00384606926329,0.0,0.0,469,23413.32928318702,0.0,217.026922484843,217.026922484843,1699662.1446840477,700.0,328300.0,2009.8044278032194,886682.658362211,-3534.199302687979,209405.01476855483,0.0,0.0,1807.7588085166121,599643.9340795248,-66.33701114700936,3930.537473757124,-217.026922484843,-2688137.59461633,true,true,15.95958693,5324.109258286999,0.0,121.92,1644.2724500334996,469.0,15.95958693,5324.109258286999,0.0,121.92,0.0,295.15 +470,22698.030768554105,21998.030768554105,0.29250000000000004,8477.828057319795,3080635.0790474107,700.0,329000.0,31377.189939554853,11648554.532706358,22899.361882235058,8567919.453658884,true,470.0,470,0.875,7418.0995501548205,8477.828057319795,1059.7285071649749,0.0,0.0,470,21998.030768554105,0.0,7418.0995501548205,7418.0995501548205,1707080.2442342024,700.0,329000.0,2009.8044278032194,888692.4627900142,3534.199302687979,212939.2140712428,0.0,0.0,1807.7588085166121,601451.6928880415,66.33701114700936,3996.8744849041336,-7418.0995501548205,-2695555.694166485,true,true,16.0937011,5340.202959386998,0.0,121.92,1644.2724500334996,470.0,16.0937011,5340.202959386998,0.0,121.92,0.0,295.15 +471,30927.828057319795,30227.828057319795,0.20800000000000002,4400.526231122673,3085035.6052785334,700.0,329700.0,24521.76072655131,11673076.293432908,20121.23449542864,8588040.688154314,true,471.0,471,0.875,3850.460452232339,4400.526231122673,550.0657788903345,0.0,0.0,471,30227.828057319795,0.0,3850.460452232339,3850.460452232339,1710930.7046864347,700.0,329700.0,2035.1377996589958,890727.6005896733,0.0,212939.2140712428,0.0,0.0,1815.3226525733428,603267.0155406148,0.0,3996.8744849041336,-3850.460452232339,-2699406.1546187177,true,true,16.0937011,5356.296660486998,0.0,121.92,1644.2724500334996,471.0,16.0937011,5356.296660486998,0.0,121.92,0.0,295.15 +472,26850.526231122672,26150.526231122672,0.12,0.0,3085035.6052785334,700.0,330400.0,5833.333333333334,11678909.626766242,5833.333333333334,8593874.021487648,true,472.0,472,0.875,0.0,0.0,0.0,0.0,0.0,472,26150.526231122672,0.0,-987.3752520848134,-987.3752520848134,1709943.32943435,700.0,330400.0,2001.4069262643948,892729.0075159377,-4705.693713979906,208233.5203572629,0.0,0.0,1805.2375267883779,605072.2530674032,-88.3259911576802,3908.5484937464535,-0.0,-2699406.1546187177,true,true,15.9148822,5372.211542686998,0.0,121.92,1644.2724500334996,472.0,15.9148822,5372.211542686998,0.0,121.92,0.0,295.15 +473,22450.0,21750.0,0.1888,2928.303890010748,3087963.909168544,700.0,331100.0,19217.71128183659,11698127.338048078,16289.407391825842,8610163.428879473,true,473.0,473,0.875,2562.2659037594044,2928.303890010748,366.0379862513437,0.0,0.0,473,21750.0,0.0,2562.2659037594044,2562.2659037594044,1712505.5953381094,700.0,331100.0,1959.7701295241397,894688.7776454618,-1168.2080506660843,207065.3123065968,0.0,0.0,1792.631119839165,606864.8841872424,-21.927294937816075,3886.6211988086375,-2562.2659037594044,-2701968.420522477,true,true,15.87017748,5388.081720166998,0.0,121.92,1644.2724500334996,473.0,15.87017748,5388.081720166998,0.0,121.92,0.0,295.15 +474,25378.30389001075,24678.30389001075,0.1888,2907.519070692719,3090871.428239237,700.0,331800.0,19107.622196465672,11717234.960244544,16200.103125772954,8626363.532005247,true,474.0,474,0.875,2544.079186856129,2907.519070692719,363.43988383659007,0.0,0.0,474,24678.30389001075,0.0,2544.079186856129,2544.079186856129,1715049.6745249655,700.0,331800.0,1943.278462257622,896632.0561077194,-1164.922212673377,205900.39009392343,0.0,0.0,1787.5885569466825,608652.4727441891,-21.865619674798342,3864.755579133839,-2544.079186856129,-2704512.4997093333,true,true,15.82547275,5403.907192916998,0.0,121.92,1644.2724500334996,474.0,15.82547275,5403.907192916998,0.0,121.92,0.0,295.15 +475,25357.51907069272,24657.51907069272,0.1648,1525.9514191051114,3092397.3796583423,700.0,332500.0,13506.98676641451,11730741.947010959,11981.035347309398,8638344.567352556,true,475.0,475,0.875,1335.2074917169725,1525.9514191051114,190.7439273881389,0.0,0.0,475,24657.51907069272,0.0,1335.2074917169725,1335.2074917169725,1716384.8820166825,700.0,332500.0,1918.7148409319614,898550.7709486514,-2319.9858675724904,203580.40422635095,0.0,0.0,1780.0247123259664,610432.4974565151,-43.546193968464955,3821.209385165374,-1335.2074917169725,-2705847.70720105,true,true,15.7360633,5419.6432562169975,0.0,121.92,1644.2724500334996,475.0,15.7360633,5419.6432562169975,0.0,121.92,0.0,295.15 +476,23975.951419105113,23275.951419105113,0.20800000000000002,4202.784893801744,3096600.1645521442,700.0,333200.0,23571.081220200693,11754313.028231159,19368.296326398948,8657712.863678955,true,476.0,476,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,476,23275.951419105113,0.0,3677.4367820765265,3677.4367820765265,1720062.318798759,700.0,333200.0,1902.4546326430423,900453.2255812944,0.0,203580.40422635095,0.0,0.0,1774.982149433484,612207.4796059486,0.0,3821.209385165374,-3677.4367820765265,-2709525.1439831266,true,true,15.7360633,5435.379319516997,0.0,121.92,1644.2724500334996,476.0,15.7360633,5435.379319516997,0.0,121.92,0.0,295.15 +477,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3100802.949445946,700.0,333900.0,23571.081220200693,11777884.10945136,19368.296326398948,8677081.160005353,true,477.0,477,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,477,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1723739.7555808355,700.0,333900.0,1902.4546326430423,902355.6802139374,0.0,203580.40422635095,0.0,0.0,1774.982149433484,613982.461755382,0.0,3821.209385165374,-3677.4367820765265,-2713202.580765203,true,true,15.7360633,5451.115382816997,0.0,121.92,1644.2724500334996,477.0,15.7360633,5451.115382816997,0.0,121.92,0.0,295.15 +478,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3105005.734339748,700.0,334600.0,23571.081220200693,11801455.19067156,19368.296326398948,8696449.456331752,true,478.0,478,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,478,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1727417.192362912,700.0,334600.0,1902.4546326430423,904258.1348465804,0.0,203580.40422635095,0.0,0.0,1774.982149433484,615757.4439048155,0.0,3821.209385165374,-3677.4367820765265,-2716880.0175472796,true,true,15.7360633,5466.851446116997,0.0,121.92,1644.2724500334996,478.0,15.7360633,5466.851446116997,0.0,121.92,0.0,295.15 +479,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3109208.51923355,700.0,335300.0,23571.081220200693,11825026.27189176,19368.296326398948,8715817.752658151,true,479.0,479,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,479,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1731094.6291449885,700.0,335300.0,1902.4546326430423,906160.5894792235,0.0,203580.40422635095,0.0,0.0,1774.982149433484,617532.4260542489,0.0,3821.209385165374,-3677.4367820765265,-2720557.454329356,true,true,15.7360633,5482.587509416997,0.0,121.92,1644.2724500334996,479.0,15.7360633,5482.587509416997,0.0,121.92,0.0,295.15 +480,26652.784893801745,25952.784893801745,0.20800000000000002,4202.784893801744,3113411.304127352,700.0,336000.0,23571.081220200693,11848597.35311196,19368.296326398948,8735186.04898455,true,480.0,480,0.875,3677.4367820765265,4202.784893801744,525.3481117252177,0.0,0.0,480,25952.784893801745,0.0,3677.4367820765265,3677.4367820765265,1734772.065927065,700.0,336000.0,1902.4546326430423,908063.0441118665,0.0,203580.40422635095,0.0,0.0,1774.982149433484,619307.4082036824,0.0,3821.209385165374,-3677.4367820765265,-2724234.8911114326,true,true,15.7360633,5498.323572716997,0.0,121.92,1644.2724500334996,480.0,15.7360633,5498.323572716997,0.0,121.92,0.0,295.15 +481,26652.784893801745,25952.784893801745,0.16240000000000002,1492.6687901069624,3114903.972917459,700.0,336700.0,13501.655111496075,11862099.008223455,12008.986321389113,8747195.03530594,true,481.0,481,0.875,1306.0851913435922,1492.6687901069624,186.58359876337022,0.0,0.0,481,25952.784893801745,0.0,1306.0851913435922,1306.0851913435922,1736078.1511184087,700.0,336700.0,1886.2865499323998,909949.330661799,-2306.841471805496,201273.56275454545,0.0,0.0,1769.9395865410017,621077.3477902234,-43.299473324313254,3777.909911841061,-1306.0851913435922,-2725540.976302776,true,true,15.64665385,5513.970226566997,0.0,121.92,1644.2724500334996,481.0,15.64665385,5513.970226566997,0.0,121.92,0.0,295.15 +482,23942.668790106964,23242.668790106964,0.23500000000000001,5507.487993824397,3120411.4609112833,700.0,337400.0,26414.842526912325,11888513.850750368,20907.354533087928,8768102.389839027,true,482.0,482,0.875,4819.051994596347,5507.487993824397,688.4359992280497,0.0,0.0,482,23242.668790106964,0.0,4819.051994596347,4819.051994596347,1740897.203113005,700.0,337400.0,1878.2369747803323,911827.5676365793,1151.7778154362084,202425.34056998166,0.0,0.0,1767.4183053767533,622844.7660956002,21.61889900305332,3799.528810844114,-4819.051994596347,-2730360.028297372,true,true,15.69135858,5529.661585146997,0.0,121.92,1644.2724500334996,482.0,15.69135858,5529.661585146997,0.0,121.92,0.0,295.15 +483,27957.487993824398,27257.487993824398,0.23500000000000001,5535.501933499318,3125946.9628447825,700.0,338100.0,26534.05078084816,11915047.901531216,20998.548847348844,8789100.938686376,true,483.0,483,0.875,4843.564191811903,5535.501933499318,691.9377416874149,0.0,0.0,483,27257.487993824398,0.0,4843.564191811903,4843.564191811903,1745740.767304817,700.0,338100.0,1894.3590928521196,913721.9267294314,1155.0636563692879,203580.40422635095,0.0,0.0,1772.4608682692356,624617.2269638694,21.680574321259936,3821.209385165374,-4843.564191811903,-2735203.592489184,true,true,15.7360633,5545.397648446997,0.0,121.92,1644.2724500334996,483.0,15.7360633,5545.397648446997,0.0,121.92,0.0,295.15 +484,27985.50193349932,27285.50193349932,0.28625,8296.851957501378,3134243.814802284,700.0,338800.0,31430.05050655503,11946477.95203777,23133.198549053654,8812234.137235431,true,484.0,484,0.875,7259.745462813706,8296.851957501378,1037.1064946876722,0.0,0.0,484,27285.50193349932,0.0,7259.745462813706,7259.745462813706,1753000.5127676306,700.0,338800.0,1926.8795748703742,915648.8063043017,3484.9080802458675,207065.3123065968,0.0,0.0,1782.5459940542003,626399.7729579236,65.4118136432633,3886.6211988086375,-7259.745462813706,-2742463.3379519978,true,true,15.87017748,5561.267825926997,0.0,121.92,1644.2724500334996,484.0,15.87017748,5561.267825926997,0.0,121.92,0.0,295.15 +485,30746.851957501378,30046.851957501378,0.124,181.83505718336423,3134425.649859467,700.0,339500.0,7111.5730418013245,11953589.52507957,6929.73798461796,8819163.87522005,true,485.0,485,0.875,159.1056750354437,181.83505718336423,22.729382147920518,0.0,0.0,485,30046.851957501378,0.0,159.1056750354437,159.1056750354437,1753159.618442666,700.0,339500.0,1926.8795748703742,917575.6858791721,-3484.9080802458675,203580.40422635095,0.0,0.0,1782.5459940542003,628182.3189519778,-65.4118136432633,3821.209385165374,-159.1056750354437,-2742622.4436270334,true,true,15.7360633,5577.003889226997,0.0,121.92,1644.2724500334996,485.0,15.7360633,5577.003889226997,0.0,121.92,0.0,295.15 +486,22631.835057183365,21931.835057183365,0.16240000000000002,1492.6687901069624,3135918.318649574,700.0,340200.0,13501.655111496075,11967091.180191066,12008.986321389113,8831172.861541439,true,486.0,486,0.875,1306.0851913435922,1492.6687901069624,186.58359876337022,0.0,0.0,486,21931.835057183365,0.0,1306.0851913435922,1306.0851913435922,1754465.7036340097,700.0,340200.0,1886.2865499323998,919461.9724291045,-2306.841471805496,201273.56275454545,0.0,0.0,1769.9395865410017,629952.2585385188,-43.299473324313254,3777.909911841061,-1306.0851913435922,-2743928.528818377,true,true,15.64665385,5592.650543076997,0.0,121.92,1644.2724500334996,486.0,15.64665385,5592.650543076997,0.0,121.92,0.0,295.15 +487,23942.668790106964,23242.668790106964,0.20800000000000002,4154.408405403615,3140072.727054978,700.0,340900.0,23338.501949055837,11990429.682140121,19184.093543652223,8850356.955085091,true,487.0,487,0.875,3635.107354728163,4154.408405403615,519.3010506754517,0.0,0.0,487,23242.668790106964,0.0,3635.107354728163,3635.107354728163,1758100.810988738,700.0,340900.0,1870.2103310796433,921332.1827601842,0.0,201273.56275454545,0.0,0.0,1764.8970236485195,631717.1555621673,0.0,3777.909911841061,-3635.107354728163,-2747563.636173105,true,true,15.64665385,5608.297196926997,0.0,121.92,1644.2724500334996,487.0,15.64665385,5608.297196926997,0.0,121.92,0.0,295.15 +488,26604.408405403614,25904.408405403614,0.20800000000000002,4154.408405403615,3144227.1354603814,700.0,341600.0,23338.501949055837,12013768.184089176,19184.093543652223,8869541.048628744,true,488.0,488,0.875,3635.107354728163,4154.408405403615,519.3010506754517,0.0,0.0,488,25904.408405403614,0.0,3635.107354728163,3635.107354728163,1761735.9183434662,700.0,341600.0,1870.2103310796433,923202.3930912638,0.0,201273.56275454545,0.0,0.0,1764.8970236485195,633482.0525858158,0.0,3777.909911841061,-3635.107354728163,-2751198.743527833,true,true,15.64665385,5623.943850776996,0.0,121.92,1644.2724500334996,488.0,15.64665385,5623.943850776996,0.0,121.92,0.0,295.15 +489,26604.408405403614,25904.408405403614,0.16240000000000002,1459.8061101733783,3145686.941570555,700.0,342300.0,13299.298707964152,12027067.48279714,11839.492597790773,8881380.541226534,true,489.0,489,0.875,1277.330346401706,1459.8061101733783,182.4757637716723,0.0,0.0,489,25904.408405403614,0.0,1277.330346401706,1277.330346401706,1763013.248689868,700.0,342300.0,1854.225714364381,925056.6188056283,-2293.6970760385484,198979.8656785069,0.0,0.0,1759.8544607560373,635241.9070465718,-43.05275268016379,3734.857159160897,-1277.330346401706,-2752476.0738742347,true,true,15.5572444,5639.501095176996,0.0,121.92,1644.2724500334996,489.0,15.5572444,5639.501095176996,0.0,121.92,0.0,295.15 +490,23909.806110173377,23209.806110173377,0.16240000000000002,1427.3609864323184,3147114.3025569874,700.0,343000.0,13099.513463253192,12040166.996260393,11672.152476820873,8893052.693703355,true,490.0,490,0.875,1248.9408631282786,1427.3609864323184,178.42012330403986,0.0,0.0,490,23209.806110173377,0.0,1248.9408631282786,1248.9408631282786,1764262.1895529963,700.0,343000.0,1822.5302404647734,926879.149046093,-2280.5526802715544,196699.31299823534,0.0,0.0,1749.7693349710723,636991.6763815429,-42.80603203601284,3692.0511271248843,-1248.9408631282786,-2753725.014737363,true,true,15.46783495,5654.968930126996,0.0,121.92,1644.2724500334996,490.0,15.46783495,5654.968930126996,0.0,121.92,0.0,295.15 +491,23877.36098643232,23177.36098643232,0.1864,2725.1940764612373,3149839.4966334486,700.0,343700.0,18375.504702045262,12058542.500962438,15650.310625584025,8908703.00432894,true,491.0,491,0.875,2384.5448169035826,2725.1940764612373,340.64925955765466,0.0,0.0,491,23177.36098643232,0.0,2384.5448169035826,2384.5448169035826,1766646.7343698998,700.0,343700.0,1798.9971432320265,928678.146189325,-1135.3473185223263,195563.96567971303,0.0,0.0,1742.2054903503563,638733.8818718933,-21.310498156473894,3670.7406289684104,-2384.5448169035826,-2756109.5595542667,true,true,15.42313022,5670.392060346996,0.0,121.92,1644.2724500334996,491.0,15.42313022,5670.392060346996,0.0,121.92,0.0,295.15 +492,25175.194076461237,24475.194076461237,0.12,0.0,3149839.4966334486,700.0,344400.0,5833.333333333334,12064375.834295772,5833.333333333334,8914536.337662274,true,492.0,492,0.875,0.0,0.0,0.0,0.0,0.0,492,24475.194076461237,0.0,-7953.534551881345,-7953.534551881345,1758693.1998180186,700.0,344400.0,1714.4430745577865,930392.5892638828,-11172.73647176039,184391.22920795265,0.0,0.0,1714.4713941597108,640448.353266053,-209.71254883845145,3461.028080129959,-0.0,-2756109.5595542667,true,true,14.97608297,5685.368143316996,0.0,121.92,1644.2724500334996,492.0,14.97608297,5685.368143316996,0.0,121.92,0.0,295.15 +493,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,345100.0,5833.333333333334,12070209.167629106,5833.333333333334,8920369.670995608,true,493.0,493,0.875,0.0,0.0,0.0,0.0,0.0,493,21750.0,0.0,-13262.308869939168,-13262.308869939168,1745430.8909480795,700.0,345100.0,1532.2168412843002,931924.8061051671,-16142.961273674466,168248.26793427818,0.0,0.0,1651.4393577216892,642099.7926237747,-303.0037952706914,3158.024284859268,-0.0,-2756109.5595542667,true,true,14.30551209,5699.673655406996,0.0,121.92,1644.2724500334996,493.0,14.30551209,5699.673655406996,0.0,121.92,0.0,295.15 +494,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,345800.0,5833.333333333334,12076042.50096244,5833.333333333334,8926203.004328942,true,494.0,494,0.875,0.0,0.0,0.0,0.0,0.0,494,21750.0,0.0,-16878.72390320989,-16878.72390320989,1728552.1670448696,700.0,345800.0,1305.7833664234245,933230.5894715906,-19386.340943141906,148861.92699113628,0.0,0.0,1565.7157879855042,643665.5084117602,-363.88211447691543,2794.1421703823526,-0.0,-2756109.5595542667,true,true,13.45612231,5713.129777716996,0.0,121.92,1644.2724500334996,494.0,13.45612231,5713.129777716996,0.0,121.92,0.0,295.15 +495,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,346500.0,5833.333333333334,12081875.834295774,5833.333333333334,8932036.337662276,true,495.0,495,0.875,0.0,0.0,0.0,0.0,0.0,495,21750.0,0.0,-17888.90017100587,-17888.90017100587,1710663.2668738638,700.0,346500.0,1069.361954453522,934299.9514260441,-20046.84682822719,128815.08016290909,0.0,0.0,1464.8645295718727,645130.372941332,-376.27982680407257,2417.86234357828,-0.0,-2756109.5595542667,true,true,12.51732308,5725.647100796996,0.0,121.92,1644.2724500334996,495.0,12.51732308,5725.647100796996,0.0,121.92,0.0,295.15 +496,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,347200.0,5833.333333333334,12087709.167629108,5833.333333333334,8937869.67099561,true,496.0,496,0.875,0.0,0.0,0.0,0.0,0.0,496,21750.0,0.0,-20204.442778791825,-20204.442778791825,1690458.824095072,700.0,347200.0,834.9446338311274,935134.8960598753,-21975.78691364645,106839.29324926264,0.0,0.0,1348.885582480794,646479.2585238129,-412.4860814572975,2005.3762621209826,-0.0,-2756109.5595542667,true,true,11.39970495,5737.046805746996,0.0,121.92,1644.2724500334996,496.0,11.39970495,5737.046805746996,0.0,121.92,0.0,295.15 +497,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,347900.0,5833.333333333334,12093542.500962442,5833.333333333334,8943703.004328944,true,497.0,497,0.875,0.0,0.0,0.0,0.0,0.0,497,21750.0,0.0,-22290.790981870003,-22290.790981870003,1668168.033113202,700.0,347900.0,603.0037930535789,935737.8998529288,-23659.912711335925,83179.38053792671,0.0,0.0,1210.2151020915521,647689.4736259044,-444.09716567920975,1561.2790964417727,-0.0,-2756109.5595542667,true,true,10.05856319,5747.1053689369965,0.0,121.92,1644.2724500334996,497.0,10.05856319,5747.1053689369965,0.0,121.92,0.0,295.15 +498,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,348600.0,5833.333333333334,12099375.834295776,5833.333333333334,8949536.337662278,true,498.0,498,0.875,0.0,0.0,0.0,0.0,0.0,498,21750.0,0.0,-17638.306945485194,-17638.306945485194,1650529.7261677168,700.0,348600.0,412.6838123532025,936150.583665282,-18765.268252267128,64414.11228565959,0.0,0.0,1066.5020586406322,648755.975684545,-352.2245642119004,1209.0545322298724,-0.0,-2756109.5595542667,true,true,8.851535607,5755.956904543997,0.0,121.92,1644.2724500334996,498.0,8.851535607,5755.956904543997,0.0,121.92,0.0,295.15 +499,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,349300.0,5833.333333333334,12105209.16762911,5833.333333333334,8955369.670995612,true,499.0,499,0.875,0.0,0.0,0.0,0.0,0.0,499,21750.0,0.0,-18875.492840889496,-18875.492840889496,1631654.2333268272,700.0,349300.0,260.8051763801247,936411.3888416621,-19682.089858998374,44732.02242666122,0.0,0.0,915.2251709073876,649671.2008554523,-369.43332917863336,839.621203051239,-0.0,-2756109.5595542667,true,true,7.376279673,5763.333184216996,0.0,121.92,1644.2724500334996,499.0,7.376279673,5763.333184216996,0.0,121.92,0.0,295.15 +500,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,350000.0,5833.333333333334,12111042.500962444,5833.333333333334,8961203.004328946,true,500.0,500,0.875,0.0,0.0,0.0,0.0,0.0,500,21750.0,0.0,-15514.125906961566,-15514.125906961566,1616140.1074198657,700.0,350000.0,142.84520930504598,936554.2340509671,-16103.528077479215,28628.494349182005,0.0,0.0,748.8205943838988,650420.0214498362,-302.2636331712946,537.3575698799444,-0.0,-2756109.5595542667,true,true,5.901023738,5769.234207954996,0.0,121.92,1644.2724500334996,500.0,5.901023738,5769.234207954996,0.0,121.92,0.0,295.15 +501,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,350700.0,5833.333333333334,12116875.834295778,5833.333333333334,8967036.33766228,true,501.0,501,0.875,0.0,0.0,0.0,0.0,0.0,501,21750.0,0.0,-10744.29432268456,-10744.29432268456,1605395.813097181,700.0,350700.0,70.76197057259785,936624.9960215398,-11197.382285566087,17431.112063615918,0.0,0.0,592.5011437017731,651012.5225935379,-210.17515139284373,327.1824184871007,-0.0,-2756109.5595542667,true,true,4.604586705,5773.838794659996,0.0,121.92,1644.2724500334996,501.0,4.604586705,5773.838794659996,0.0,121.92,0.0,295.15 +502,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,351400.0,5833.333333333334,12122709.167629112,5833.333333333334,8972869.670995614,true,502.0,502,0.875,0.0,0.0,0.0,0.0,0.0,502,21750.0,0.0,-8610.404642062516,-8610.404642062516,1596785.4084551185,700.0,351400.0,29.22203643432516,936654.2180579741,-8913.543495473776,8517.568568142142,0.0,0.0,441.22425596852844,651453.7468495065,-167.30743899159344,159.87497949550723,-0.0,-2756109.5595542667,true,true,3.218740221,5777.057534880996,0.0,121.92,1644.2724500334996,502.0,3.218740221,5777.057534880996,0.0,121.92,0.0,295.15 +503,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,352100.0,5833.333333333334,12128542.500962446,5833.333333333334,8978703.004328948,true,503.0,503,0.875,0.0,0.0,0.0,0.0,0.0,503,21750.0,0.0,-5709.176324106236,-5709.176324106236,1591076.2321310122,700.0,352100.0,7.660381520692089,936661.8784394949,-5888.689379463902,2628.87918867824,0.0,0.0,282.3835238401617,651736.1303733466,-110.53085000318764,49.344129492319595,-0.0,-2756109.5595542667,true,true,1.788189012,5778.845723892996,0.0,121.92,1644.2724500334996,503.0,1.788189012,5778.845723892996,0.0,121.92,0.0,295.15 +504,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,352800.0,5833.333333333334,12134375.83429578,5833.333333333334,8984536.337662281,true,504.0,504,0.875,0.0,0.0,0.0,0.0,0.0,504,21750.0,0.0,-2384.08872409453,-2384.08872409453,1588692.1434069178,700.0,352800.0,0.6815635323879592,936662.5600030273,-2464.574239385906,164.3049492923342,0.0,0.0,126.06407315803605,651862.1944465047,-46.26012139904787,3.084008093271727,-0.0,-2756109.5595542667,true,true,0.447047253,5779.292771145996,0.0,121.92,1644.2724500334996,504.0,0.447047253,5779.292771145996,0.0,121.92,0.0,295.15 +505,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,353500.0,5833.333333333334,12140209.167629113,5833.333333333334,8990369.670995615,true,505.0,505,0.875,0.0,0.0,0.0,0.0,0.0,505,21750.0,0.0,-142.17069024579726,-142.17069024579726,1588549.972716672,700.0,353500.0,0.005452508259103674,936662.5654555355,-164.30494929239373,-5.95434812566964e-11,0.0,0.0,25.212814631607213,651887.4072611363,-3.084008093269858,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,121.92,1644.2724500334996,505.0,0.0,5779.292771145996,0.0,121.92,0.0,295.15 +506,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,354200.0,5833.333333333334,12146042.500962447,5833.333333333334,8996203.00432895,true,506.0,506,0.875,0.0,0.0,0.0,0.0,0.0,506,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,354200.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,121.92,1644.2724500334996,506.0,0.0,5779.292771145996,0.0,121.92,0.0,295.15 +507,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,354900.0,5833.333333333334,12151875.834295781,5833.333333333334,9002036.337662283,true,507.0,507,0.875,0.0,0.0,0.0,0.0,0.0,507,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,354900.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,121.92,1644.2724500334996,507.0,0.0,5779.292771145996,0.0,121.92,0.0,295.15 +508,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,355600.0,5833.333333333334,12157709.167629115,5833.333333333334,9007869.670995617,true,508.0,508,0.875,0.0,0.0,0.0,0.0,0.0,508,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,355600.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,121.92,1644.2724500334996,508.0,0.0,5779.292771145996,0.0,121.92,0.0,295.15 +509,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,356300.0,5833.333333333334,12163542.50096245,5833.333333333334,9013703.004328951,true,509.0,509,0.875,0.0,0.0,0.0,0.0,0.0,509,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,356300.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,121.92,1644.2724500334996,509.0,0.0,5779.292771145996,0.0,121.92,0.0,295.15 +510,22450.0,21750.0,0.12,0.0,3149839.4966334486,700.0,357000.0,5833.333333333334,12169375.834295783,5833.333333333334,9019536.337662285,true,510.0,510,0.875,0.0,0.0,0.0,0.0,0.0,510,21750.0,0.0,0.0,0.0,1588549.972716672,700.0,357000.0,0.0,936662.5654555355,0.0,-5.95434812566964e-11,0.0,0.0,0.0,651887.4072611363,0.0,1.8691714842589136e-12,-0.0,-2756109.5595542667,true,true,0.0,5779.292771145996,0.0,121.92,1644.2724500334996,510.0,0.0,5779.292771145996,0.0,121.92,0.0,295.15 +511,22450.0,21750.0,0.128,310.06274006228875,3150149.559373511,700.0,357700.0,7891.1151567366305,12177266.94945252,7581.052416674342,9027117.39007896,true,511.0,511,0.875,271.30489755450265,310.06274006228875,38.75784250778611,0.0,0.0,511,21750.0,0.0,271.30489755450265,271.30489755450265,1588821.2776142266,700.0,357700.0,0.009421934240117264,936662.5748774698,236.59912645179844,236.5991264517389,0.0,0.0,30.255377524089532,651917.6626386604,4.440971644374586,4.4409716443764555,-271.30489755450265,-2756380.8644518214,true,true,0.536456703,5779.829227848996,0.0,121.92,1644.2724500334996,511.0,0.536456703,5779.829227848996,0.0,121.92,0.0,295.15 +512,22760.062740062287,22060.062740062287,0.1768,2204.0468034723476,3152353.6061769836,700.0,358400.0,16425.604092038164,12193692.553544557,14221.557288565817,9041338.947367527,true,512.0,512,0.875,1928.5409530383042,2204.0468034723476,275.5058504340434,0.0,0.0,512,22060.062740062287,0.0,1928.5409530383042,1928.5409530383042,1590749.8185672648,700.0,358400.0,0.5660957640958172,936663.1409732339,1776.136501093657,2012.7356275453958,0.0,0.0,118.50022870651551,652036.1628673669,33.33812747403601,37.77909911841246,-1928.5409530383042,-2758309.4054048597,true,true,1.564665385,5781.393893233996,0.0,121.92,1644.2724500334996,512.0,1.564665385,5781.393893233996,0.0,121.92,0.0,295.15 +513,24654.04680347235,23954.04680347235,0.196,3707.3045055303655,3156060.910682514,700.0,359100.0,22486.247477195742,12216178.801021753,18778.942971665376,9060117.890339192,true,513.0,513,0.875,3243.8914423390697,3707.3045055303655,463.4130631912958,0.0,0.0,513,23954.04680347235,0.0,3243.8914423390697,3243.8914423390697,1593993.710009604,700.0,359100.0,3.974878517922778,936667.1158517518,2957.4890865280204,4970.224714073416,0.0,0.0,226.91533162806638,652263.078198995,55.5121456650602,93.29124478347266,-3243.8914423390697,-2761553.2968471986,true,true,2.458759891,5783.852653124996,0.0,121.92,1644.2724500334996,513.0,2.458759891,5783.852653124996,0.0,121.92,0.0,295.15 +514,26157.304505530366,25457.304505530366,0.184,2652.16365490615,3158713.07433742,700.0,359800.0,18218.2807331856,12234397.081754938,15566.117078279449,9075684.007417472,true,514.0,514,0.875,2320.643198042881,2652.16365490615,331.5204568632689,0.0,0.0,514,25457.304505530366,0.0,2320.643198042881,2320.643198042881,1596314.3532076469,700.0,359800.0,9.42193426646217,936676.5377860182,1971.6593911411908,6941.884105214607,0.0,0.0,302.55377552288803,652565.6319745178,37.00809711233967,130.29934189581235,-2320.643198042881,-2763873.9400452417,true,true,2.905807144,5786.758460268997,0.0,121.92,1644.2724500334996,514.0,2.905807144,5786.758460268997,0.0,121.92,0.0,295.15 +515,25102.16365490615,24402.16365490615,0.25,6192.30074926285,3164905.375086683,700.0,360500.0,27569.2029970514,12261966.284751989,21376.902247788552,9097060.90966526,true,515.0,515,0.875,5418.263155604994,6192.30074926285,774.0375936578566,0.0,0.0,515,24402.16365490615,0.0,5418.263155604994,5418.263155604994,1601732.6163632518,700.0,360500.0,18.402215366242118,936694.9400013845,4929.148478036744,11871.032583251352,0.0,0.0,378.1922194177096,652943.8241939355,92.52024278429853,222.8195846801109,-5418.263155604994,-2769292.203200847,true,true,3.79990165,5790.5583619189965,0.0,121.92,1644.2724500334996,515.0,3.79990165,5790.5583619189965,0.0,121.92,0.0,295.15 +516,28642.30074926285,27942.30074926285,0.20800000000000002,4367.312051999988,3169272.6871386827,700.0,361200.0,24362.077173076865,12286328.361925066,19994.765121076874,9117055.674786337,true,516.0,516,0.875,3821.3980454999896,4367.312051999988,545.9140064999988,0.0,0.0,516,27942.30074926285,0.0,3821.3980454999896,3821.3980454999896,1605554.0144087519,700.0,361200.0,32.33196176126219,936727.2719631457,3271.3115378902767,15142.344121141628,0.0,0.0,456.35194475877245,653400.1761386943,61.40260108967827,284.2221857697892,-3821.3980454999896,-2773113.6012463467,true,true,4.291653628,5794.8500155469965,0.0,121.92,1644.2724500334996,516.0,4.291653628,5794.8500155469965,0.0,121.92,0.0,295.15 +517,26817.312051999987,26117.312051999987,0.20800000000000002,4090.4245154471905,3173363.11165413,700.0,361900.0,23030.887093496105,12309359.249018561,18940.462578048915,9135996.137364386,true,517.0,517,0.875,3579.1214510162918,4090.4245154471905,511.30306443089876,0.0,0.0,517,26117.312051999987,0.0,3579.1214510162918,3579.1214510162918,1609133.1358597681,700.0,361900.0,44.27764398738515,936771.5496071331,2972.2765267674104,18114.62064790904,0.0,0.0,506.7775739655883,653906.9537126599,55.789706295908026,340.0118920656972,-3579.1214510162918,-2776692.7226973632,true,true,4.693996155,5799.544011701996,0.0,121.92,1644.2724500334996,517.0,4.693996155,5799.544011701996,0.0,121.92,0.0,295.15 +518,26540.42451544719,25840.42451544719,0.265,6714.706057092393,3180077.817711222,700.0,362600.0,27980.022856952426,12337339.271875514,21265.316799860033,9157261.454164246,true,518.0,518,0.875,5875.367799955844,6714.706057092393,839.3382571365491,0.0,0.0,518,25840.42451544719,0.0,5875.367799955844,5875.367799955844,1615008.503659724,700.0,362600.0,61.28305212881776,936832.832659262,5152.603206516369,23267.223854425407,0.0,0.0,564.7670475675262,654471.7207602274,96.7144937431313,436.7263858088285,-5875.367799955844,-2782568.090497319,true,true,5.319862309,5804.863874010996,0.0,121.92,1644.2724500334996,518.0,5.319862309,5804.863874010996,0.0,121.92,0.0,295.15 +519,29164.706057092393,28464.706057092393,0.3175,11259.461782403141,3191337.2794936253,700.0,363300.0,37667.59616504926,12375006.868040564,26408.13438264612,9183669.588546893,true,519.0,519,0.875,9852.029059602748,11259.461782403141,1407.432722800393,0.0,0.0,519,28464.706057092393,0.0,9852.029059602748,9852.029059602748,1624860.5327193267,700.0,363300.0,94.73176392472222,936927.5644231867,8936.54619659277,32203.770051018175,0.0,0.0,653.0118988063507,655124.7326590337,167.73920027890438,604.4655860877328,-9852.029059602748,-2792420.119556922,true,true,6.258661541,5811.122535551996,0.0,121.92,1644.2724500334996,519.0,6.258661541,5811.122535551996,0.0,121.92,0.0,295.15 +520,33709.461782403145,33009.461782403145,0.33,12510.788104384317,3203848.0675980095,700.0,364000.0,40032.69122540702,12415039.559265971,27521.903121022704,9211191.491667915,true,520.0,520,0.875,10946.939591336277,12510.788104384317,1563.8485130480403,0.0,0.0,520,33009.461782403145,0.0,10946.939591336277,10946.939591336277,1635807.472310663,700.0,364000.0,147.21772289700587,937074.7821460837,9858.296944312408,42062.066995330584,0.0,0.0,756.3844387790208,655881.1170978127,185.04048534784127,789.5060714355741,-10946.939591336277,-2803367.059148258,true,true,7.152756046,5818.275291597996,0.0,121.92,1644.2724500334996,520.0,7.152756046,5818.275291597996,0.0,121.92,0.0,295.15 +521,34960.788104384315,34260.788104384315,0.3175,12169.220250591683,3216017.287848601,700.0,364700.0,40532.9771672179,12455572.536433188,28363.756916626215,9239555.24858454,true,521.0,521,0.875,10648.067719267723,12169.220250591683,1521.15253132396,0.0,0.0,521,34260.788104384315,0.0,10648.067719267723,10648.067719267723,1646455.5400299306,700.0,364700.0,208.6825016607592,937283.4646477444,9413.030541160935,51475.09753649152,0.0,0.0,849.6718528539291,656730.7889506667,176.68282359209823,966.1888950276723,-10648.067719267723,-2814015.1268675257,true,true,7.912736376,5826.188027973996,0.0,121.92,1644.2724500334996,521.0,7.912736376,5826.188027973996,0.0,121.92,0.0,295.15 +522,34619.22025059168,33919.22025059168,0.30500000000000005,10492.525304636865,3226509.813153238,700.0,365400.0,36696.80427749791,12492269.340710687,26204.278972861044,9265759.527557401,true,522.0,522,0.875,9180.959641557258,10492.525304636865,1311.5656630796075,0.0,0.0,522,33919.22025059168,0.0,9180.959641557258,9180.959641557258,1655636.4996714878,700.0,365400.0,269.52218856006243,937552.9868363045,7838.989130129992,59314.086666621515,0.0,0.0,925.3102967487507,657656.0992474154,147.13802611845313,1113.3269211461254,-9180.959641557258,-2823196.086509083,true,true,8.493897805,5834.681925778997,0.0,121.92,1644.2724500334996,522.0,8.493897805,5834.681925778997,0.0,121.92,0.0,295.15 +523,32942.52530463687,32242.525304636867,0.29250000000000004,9727.030633639542,3236236.8437868776,700.0,366100.0,35647.96797825484,12527917.30868894,25920.937344615297,9291680.464902015,true,523.0,523,0.875,8511.1518044346,9727.030633639542,1215.878829204943,0.0,0.0,523,32242.525304636867,0.0,8511.1518044346,8511.1518044346,1664147.6514759224,700.0,366100.0,325.9317015870319,937878.9185378916,7066.755863016254,66380.84252963777,0.0,0.0,985.8210518533282,658641.9202992688,132.64318797798518,1245.9701091241106,-8511.1518044346,-2831707.2383135175,true,true,8.985649783,5843.667575561996,0.0,121.92,1644.2724500334996,523.0,8.985649783,5843.667575561996,0.0,121.92,0.0,295.15 +524,32177.030633639544,31477.030633639544,0.29250000000000004,8693.157658734372,3244930.001445612,700.0,366800.0,32113.359517040582,12560030.66820598,23420.20185830621,9315100.666760322,true,524.0,524,0.875,7606.512951392576,8693.157658734372,1086.6447073417958,0.0,0.0,524,31477.030633639544,0.0,7606.512951392576,7606.512951392576,1671754.1644273151,700.0,366800.0,378.54873341264084,938257.4672713042,6077.640077434978,72458.48260707274,0.0,0.0,1036.2466811165425,659678.1669803853,114.07745942841443,1360.047568552525,-7606.512951392576,-2839313.75126491,true,true,9.387992311,5853.055567872996,0.0,121.92,1644.2724500334996,524.0,9.387992311,5853.055567872996,0.0,121.92,0.0,295.15 +525,31143.157658734373,30443.157658734373,0.30500000000000005,9960.444307320311,3254890.445752932,700.0,367500.0,34952.27641744364,12594982.944623424,24991.832110123327,9340092.498870445,true,525.0,525,0.875,8715.388768905272,9960.444307320311,1245.0555384150393,0.0,0.0,525,30443.157658734373,0.0,8715.388768905272,8715.388768905272,1680469.5531962204,700.0,367500.0,433.5125738859352,938690.9798451902,7065.112818102812,79523.59542517556,0.0,0.0,1084.151028933516,660762.3180093188,132.6123479830096,1492.6599165355346,-8715.388768905272,-2848029.1400338155,true,true,9.835039564,5862.890607436996,0.0,121.92,1644.2724500334996,525.0,9.835039564,5862.890607436996,0.0,121.92,0.0,295.15 +526,32410.44430732031,31710.44430732031,0.30500000000000005,10473.073835350215,3265363.5195882823,700.0,368200.0,36633.02896836135,12631615.973591786,26159.955133011135,9366252.454003457,true,526.0,526,0.875,9163.939605931439,10473.073835350215,1309.1342294187762,0.0,0.0,526,31710.44430732031,0.0,9163.939605931439,9163.939605931439,1689633.492802152,700.0,368200.0,496.85981503672747,939187.839660227,7393.722767407227,86917.31819258278,0.0,0.0,1134.5766583659263,661896.8946676847,138.78036512155848,1631.4402816570932,-9163.939605931439,-2857193.079639747,true,true,10.28208682,5873.172694256996,0.0,121.92,1644.2724500334996,526.0,10.28208682,5873.172694256996,0.0,121.92,0.0,295.15 +527,32923.07383535022,32223.073835350217,0.29250000000000004,9149.602246985864,3274513.121835268,700.0,368900.0,33673.8538358491,12665289.827427635,24524.251588863233,9390776.70559232,true,527.0,527,0.875,8005.90196611263,9149.602246985864,1143.7002808732332,0.0,0.0,527,32223.073835350217,0.0,8005.90196611263,8005.90196611263,1697639.3947682646,700.0,368900.0,558.8997190327635,939746.7393792598,6151.577260108245,93068.89545269102,0.0,0.0,1179.959724736658,663076.8543924213,115.46526223496363,1746.9055438920568,-8005.90196611263,-2865198.9816058595,true,true,10.63972462,5883.812418876996,0.0,121.92,1644.2724500334996,527.0,10.63972462,5883.812418876996,0.0,121.92,0.0,295.15 +528,31599.602246985865,30899.602246985865,0.29250000000000004,8561.80637102245,3283074.9282062906,700.0,369600.0,31664.295285546836,12696954.122713182,23102.488914524387,9413879.194506845,true,528.0,528,0.875,7491.580574644644,8561.80637102245,1070.2257963778065,0.0,0.0,528,30899.602246985865,0.0,7491.580574644644,7491.580574644644,1705130.9753429093,700.0,369600.0,614.3809262501679,940361.1203055099,5555.1503870819815,98624.04583977301,0.0,0.0,1217.7789467122682,664294.6333391336,104.2703146002258,1851.1758584922827,-7491.580574644644,-2872690.562180504,true,true,10.9526577,5894.765076576996,0.0,121.92,1644.2724500334996,528.0,10.9526577,5894.765076576996,0.0,121.92,0.0,295.15 +529,31011.806371022452,30311.806371022452,0.25,5954.787796575761,3289029.716002866,700.0,370300.0,26619.151186303043,12723573.273899484,20664.36338972728,9434543.557896571,true,529.0,529,0.875,5210.439322003791,5954.787796575761,744.3484745719697,0.0,0.0,529,30311.806371022452,0.0,5210.439322003791,5210.439322003791,1710341.4146649132,700.0,370300.0,657.320503086928,941018.4408085968,3246.6657764949196,101870.71161626793,0.0,0.0,1245.5130429029136,665540.1463820365,60.939999519028795,1912.1158580113115,-5210.439322003791,-2877901.001502508,true,true,11.1314766,5905.896553176995,0.0,121.92,1644.2724500334996,529.0,11.1314766,5905.896553176995,0.0,121.92,0.0,295.15 +530,28404.78779657576,27704.78779657576,0.1936,3166.7115109483248,3292196.4275138145,700.0,371000.0,19972.68342431986,12743545.957323804,16805.971913371537,9451349.529809942,true,530.0,530,0.875,2770.8725720797843,3166.7115109483248,395.8389388685405,0.0,0.0,530,27704.78779657576,0.0,2770.8725720797843,2770.8725720797843,1713112.287236993,700.0,371000.0,677.4823240752954,941695.9231326721,819.8815995946654,102690.5932158626,0.0,0.0,1258.1194498521265,666798.2658318887,15.389198557696954,1927.5050565690085,-2770.8725720797843,-2880671.8740745876,true,true,11.17618132,5917.0727344969955,0.0,121.92,1644.2724500334996,530.0,11.17618132,5917.0727344969955,0.0,121.92,0.0,295.15 +531,25616.711510948324,24916.711510948324,0.1768,2219.6620142738066,3294416.0895280885,700.0,371700.0,16513.925420100713,12760059.882743904,14294.263405826907,9465643.79321577,true,531.0,531,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,531,24916.711510948324,0.0,1942.2042624895807,1942.2042624895807,1715054.4914994827,700.0,371700.0,681.5635314732057,942377.4866641453,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,668058.9065629051,0.0,1927.5050565690085,-1942.2042624895807,-2882614.078337077,true,true,11.17618132,5928.248915816996,0.0,121.92,1644.2724500334996,531.0,11.17618132,5928.248915816996,0.0,121.92,0.0,295.15 +532,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3296635.7515423624,700.0,372400.0,16513.925420100713,12776573.808164004,14294.263405826907,9479938.056621598,true,532.0,532,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,532,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1716996.6957619723,700.0,372400.0,681.5635314732057,943059.0501956184,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,669319.5472939215,0.0,1927.5050565690085,-1942.2042624895807,-2884556.2825995665,true,true,11.17618132,5939.425097136996,0.0,121.92,1644.2724500334996,532.0,11.17618132,5939.425097136996,0.0,121.92,0.0,295.15 +533,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3298855.4135566363,700.0,373100.0,16513.925420100713,12793087.733584104,14294.263405826907,9494232.320027426,true,533.0,533,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,533,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1718938.900024462,700.0,373100.0,681.5635314732057,943740.6137270916,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,670580.1880249379,0.0,1927.5050565690085,-1942.2042624895807,-2886498.486862056,true,true,11.17618132,5950.601278456996,0.0,121.92,1644.2724500334996,533.0,11.17618132,5950.601278456996,0.0,121.92,0.0,295.15 +534,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3301075.0755709102,700.0,373800.0,16513.925420100713,12809601.659004204,14294.263405826907,9508526.583433254,true,534.0,534,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,534,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1720881.1042869517,700.0,373800.0,681.5635314732057,944422.1772585647,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,671840.8287559543,0.0,1927.5050565690085,-1942.2042624895807,-2888440.6911245454,true,true,11.17618132,5961.777459776996,0.0,121.92,1644.2724500334996,534.0,11.17618132,5961.777459776996,0.0,121.92,0.0,295.15 +535,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3303294.737585184,700.0,374500.0,16513.925420100713,12826115.584424304,14294.263405826907,9522820.846839081,true,535.0,535,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,535,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1722823.3085494414,700.0,374500.0,681.5635314732057,945103.7407900379,0.0,102690.5932158626,0.0,0.0,1260.6407310163752,673101.4694869707,0.0,1927.5050565690085,-1942.2042624895807,-2890382.895387035,true,true,11.17618132,5972.953641096996,0.0,121.92,1644.2724500334996,535.0,11.17618132,5972.953641096996,0.0,121.92,0.0,295.15 +536,24669.662014273807,23969.662014273807,0.28625,8073.24864091947,3311367.9862261037,700.0,375200.0,30648.90354906365,12856764.487973368,22575.654908144177,9545396.501747226,true,536.0,536,0.875,7064.092560804536,8073.24864091947,1009.1560801149335,0.0,0.0,536,23969.662014273807,0.0,7064.092560804536,7064.092560804536,1729887.4011102458,700.0,375200.0,706.3954316362309,945810.1362216742,4988.298224439979,107678.89144030257,0.0,0.0,1275.7684196938221,674377.2379066645,93.6304850345049,2021.1355416035135,-7064.092560804536,-2897446.9879478393,true,true,11.44440967,5984.398050766996,0.0,121.92,1644.2724500334996,536.0,11.44440967,5984.398050766996,0.0,121.92,0.0,295.15 +537,30523.248640919468,29823.248640919468,0.20800000000000002,4293.862865627619,3315661.8490917315,700.0,375900.0,24008.956084748166,12880773.444058117,19715.093219120547,9565111.594966346,true,537.0,537,0.875,3757.1300074241663,4293.862865627619,536.7328582034525,0.0,0.0,537,29823.248640919468,0.0,3757.1300074241663,3757.1300074241663,1733644.53111767,700.0,375900.0,740.4328668466779,946550.5690885208,1689.0548663472682,109367.94630664984,0.0,0.0,1295.9386712637515,675673.1765779282,31.703602966468594,2052.839144569982,-3757.1300074241663,-2901204.1179552637,true,true,11.53381912,5995.931869886996,0.0,121.92,1644.2724500334996,537.0,11.53381912,5995.931869886996,0.0,121.92,0.0,295.15 +538,26743.86286562762,26043.86286562762,0.20800000000000002,4340.603073645875,3320002.4521653773,700.0,376600.0,24233.668623297475,12905007.112681415,19893.0655496516,9585004.660515998,true,538.0,538,0.875,3798.0276894401404,4340.603073645875,542.5753842057347,0.0,0.0,538,26043.86286562762,0.0,3798.0276894401404,3798.0276894401404,1737442.5588071102,700.0,376600.0,757.8541113977777,947308.4231999186,1702.1994532317615,111070.1457598816,0.0,0.0,1306.0237976127014,676979.200375541,31.950327197900013,2084.7894717678823,-3798.0276894401404,-2905002.145644704,true,true,11.62322858,6007.555098466995,0.0,121.92,1644.2724500334996,538.0,11.62322858,6007.555098466995,0.0,121.92,0.0,295.15 +539,26790.603073645874,26090.603073645874,0.12,0.0,3320002.4521653773,700.0,377300.0,5833.333333333334,12910840.446014749,5833.333333333334,9590837.993849332,true,539.0,539,0.875,0.0,0.0,0.0,0.0,0.0,539,26090.603073645874,0.0,-1404.8172873482827,-1404.8172873482827,1736037.741519762,700.0,377300.0,749.1097276748961,948057.5329275934,-3391.2543195790295,107678.89144030257,0.0,0.0,1300.9812347202192,678280.1816102612,-63.65393016436861,2021.1355416035137,-0.0,-2905002.145644704,true,true,11.44440967,6018.999508136995,0.0,121.92,1644.2724500334996,539.0,11.44440967,6018.999508136995,0.0,121.92,0.0,295.15 +540,22450.0,21750.0,0.12,0.0,3320002.4521653773,700.0,378000.0,5833.333333333334,12916673.779348083,5833.333333333334,9596671.327182665,true,540.0,540,0.875,0.0,0.0,0.0,0.0,0.0,540,21750.0,0.0,-1405.7277935590275,-1405.7277935590275,1734632.013726203,700.0,378000.0,714.8048132488018,948772.3377408423,-3338.676545393647,104340.21489490892,0.0,0.0,1280.8109825863046,679560.9925928476,-62.66704400048694,1958.468497603027,-0.0,-2905002.145644704,true,true,11.26559077,6030.265098906995,0.0,121.92,1644.2724500334996,540.0,11.26559077,6030.265098906995,0.0,121.92,0.0,295.15 +541,22450.0,21750.0,0.128,314.1408300540935,3320316.5929954313,700.0,378700.0,7922.9752347976055,12924596.75458288,7608.834404743512,9604280.16158741,true,541.0,541,0.875,274.8732262973318,314.1408300540935,39.26760375676167,0.0,0.0,541,21750.0,0.0,274.8732262973318,274.8732262973318,1734906.8869525003,700.0,378700.0,689.7750524688241,949462.1127933111,-1649.621679046332,102690.59321586258,0.0,0.0,1265.6832939088576,680826.6758867564,-30.96344103401797,1927.505056569009,-274.8732262973318,-2905277.0188710014,true,true,11.17618132,6041.441280226995,0.0,121.92,1644.2724500334996,541.0,11.17618132,6041.441280226995,0.0,121.92,0.0,295.15 +542,22764.140830054093,22064.140830054093,0.1768,2219.6620142738066,3322536.255009705,700.0,379400.0,16513.925420100713,12941110.68000298,14294.263405826907,9618574.424993237,true,542.0,542,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,542,22064.140830054093,0.0,1942.2042624895807,1942.2042624895807,1736849.09121499,700.0,379400.0,681.5635314732057,950143.6763247843,0.0,102690.59321586258,0.0,0.0,1260.6407310163752,682087.3166177728,0.0,1927.505056569009,-1942.2042624895807,-2907219.223133491,true,true,11.17618132,6052.617461546995,0.0,121.92,1644.2724500334996,542.0,11.17618132,6052.617461546995,0.0,121.92,0.0,295.15 +543,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,3324755.917023979,700.0,380100.0,16513.925420100713,12957624.60542308,14294.263405826907,9632868.688399065,true,543.0,543,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,543,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,1738791.2954774797,700.0,380100.0,681.5635314732057,950825.2398562575,0.0,102690.59321586258,0.0,0.0,1260.6407310163752,683347.9573487892,0.0,1927.505056569009,-1942.2042624895807,-2909161.4273959803,true,true,11.17618132,6063.7936428669955,0.0,121.92,1644.2724500334996,543.0,11.17618132,6063.7936428669955,0.0,121.92,0.0,295.15 +544,24669.662014273807,23969.662014273807,0.12,0.0,3324755.917023979,700.0,380800.0,5833.333333333334,12963457.938756414,5833.333333333334,9638702.0217324,true,544.0,544,0.875,0.0,0.0,0.0,0.0,0.0,544,23969.662014273807,0.0,-3058.5751172414093,-3058.5751172414093,1735732.7203602383,700.0,380800.0,657.3205021939968,951482.5603584514,-4869.998662537182,97820.5945533254,0.0,0.0,1245.5130423389282,684593.4703911281,-91.40999923715228,1836.0950573318567,-0.0,-2909161.4273959803,true,true,10.90795297,6074.701595836996,0.0,121.92,1644.2724500334996,544.0,10.90795297,6074.701595836996,0.0,121.92,0.0,295.15 +545,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,381500.0,5833.333333333334,12969291.272089748,5833.333333333334,9644535.355065733,true,545.0,545,0.875,0.0,0.0,0.0,0.0,0.0,545,21750.0,0.0,-8554.30390693779,-8554.30390693779,1727178.4164533005,700.0,381500.0,584.3555329619527,952066.9158914133,-10145.83063442549,87674.7639188999,0.0,0.0,1197.6086945783534,685791.0790857065,-190.43750005260483,1645.6575572792517,-0.0,-2909161.4273959803,true,true,10.32679154,6085.028387376996,0.0,121.92,1644.2724500334996,545.0,10.32679154,6085.028387376996,0.0,121.92,0.0,295.15 +546,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,382200.0,5833.333333333334,12975124.605423082,5833.333333333334,9650368.688399067,true,546.0,546,0.875,0.0,0.0,0.0,0.0,0.0,546,21750.0,0.0,-22185.129815314438,-22185.129815314438,1704993.286637986,700.0,382200.0,430.49509565719336,952497.4109870705,-23260.65163324033,64414.112285659576,0.0,0.0,1081.6297473180794,686872.7088330246,-436.60302504937886,1209.0545322298728,-0.0,-2909161.4273959803,true,true,8.851535607,6093.879922983996,0.0,121.92,1644.2724500334996,546.0,8.851535607,6093.879922983996,0.0,121.92,0.0,295.15 +547,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,382900.0,5833.333333333334,12980957.938756416,5833.333333333334,9656202.021732401,true,547.0,547,0.875,0.0,0.0,0.0,0.0,0.0,547,21750.0,0.0,-18875.492840889496,-18875.492840889496,1686117.7937970965,700.0,382900.0,260.8051763801247,952758.2161634506,-19682.089858998374,44732.022426661206,0.0,0.0,915.2251709073876,687787.9340039319,-369.43332917863336,839.6212030512395,-0.0,-2909161.4273959803,true,true,7.376279673,6101.256202656996,0.0,121.92,1644.2724500334996,547.0,7.376279673,6101.256202656996,0.0,121.92,0.0,295.15 +548,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,383600.0,5833.333333333334,12986791.27208975,5833.333333333334,9662035.355065735,true,548.0,548,0.875,0.0,0.0,0.0,0.0,0.0,548,21750.0,0.0,-15514.125906961566,-15514.125906961566,1670603.667890135,700.0,383600.0,142.84520930504598,952901.0613727557,-16103.528077479215,28628.49434918199,0.0,0.0,748.8205943838988,688536.7545983158,-302.2636331712946,537.3575698799449,-0.0,-2909161.4273959803,true,true,5.901023738,6107.157226394996,0.0,121.92,1644.2724500334996,548.0,5.901023738,6107.157226394996,0.0,121.92,0.0,295.15 +549,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,384300.0,5833.333333333334,12992624.605423084,5833.333333333334,9667868.688399069,true,549.0,549,0.875,0.0,0.0,0.0,0.0,0.0,549,21750.0,0.0,-12110.434444334802,-12110.434444334802,1658493.2334458001,700.0,384300.0,67.20974868753402,952968.2711214432,-12524.966274128567,16103.528075053424,0.0,0.0,582.41601786041,689119.1706161762,-235.09393675417851,302.2636331257664,-0.0,-2909161.4273959803,true,true,4.425767804,6111.582994198996,0.0,121.92,1644.2724500334996,549.0,4.425767804,6111.582994198996,0.0,121.92,0.0,295.15 +550,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,385000.0,5833.333333333334,12998457.938756417,5833.333333333334,9673702.021732403,true,550.0,550,0.875,0.0,0.0,0.0,0.0,0.0,550,21750.0,0.0,-8673.823938428355,-8673.823938428355,1649819.4095073717,700.0,385000.0,24.493348648483604,952992.7644700918,-8946.404487757982,7157.123587295442,0.0,0.0,416.0114413369212,689535.1820575132,-167.9242406557784,134.33939246998798,-0.0,-2909161.4273959803,true,true,2.950511869,6114.533506067996,0.0,121.92,1644.2724500334996,550.0,2.950511869,6114.533506067996,0.0,121.92,0.0,295.15 +551,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,385700.0,5833.333333333334,13004291.272089751,5833.333333333334,9679535.355065737,true,551.0,551,0.875,0.0,0.0,0.0,0.0,0.0,551,21750.0,0.0,-5213.699805466277,-5213.699805466277,1644605.7097019055,700.0,385700.0,5.290563308789698,952998.0550334005,-5367.842689258775,1789.2808980366672,0.0,0.0,249.60686481343245,689784.7889223266,-100.75454432972379,33.5848481402642,-0.0,-2909161.4273959803,true,true,1.475255935,6116.008762002996,0.0,121.92,1644.2724500334996,551.0,1.475255935,6116.008762002996,0.0,121.92,0.0,295.15 +552,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,386400.0,5833.333333333334,13010124.605423085,5833.333333333334,9685368.68839907,true,552.0,552,0.875,0.0,0.0,0.0,0.0,0.0,552,21750.0,0.0,-1739.4675110977112,-1739.4675110977112,1642866.2421908078,700.0,386400.0,0.19594678934725546,952998.2509801899,-1789.2808980367404,-7.321432349272072e-11,0.0,0.0,83.20228828994367,689867.9912106165,-33.58484814026184,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,552.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +553,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,387100.0,5833.333333333334,13015957.93875642,5833.333333333334,9691202.021732405,true,553.0,553,0.875,0.0,0.0,0.0,0.0,0.0,553,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,387100.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,553.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +554,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,387800.0,5833.333333333334,13021791.272089753,5833.333333333334,9697035.355065739,true,554.0,554,0.875,0.0,0.0,0.0,0.0,0.0,554,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,387800.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,554.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +555,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,388500.0,5833.333333333334,13027624.605423087,5833.333333333334,9702868.688399073,true,555.0,555,0.875,0.0,0.0,0.0,0.0,0.0,555,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,388500.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,555.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +556,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,389200.0,5833.333333333334,13033457.938756421,5833.333333333334,9708702.021732407,true,556.0,556,0.875,0.0,0.0,0.0,0.0,0.0,556,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,389200.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,556.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +557,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,389900.0,5833.333333333334,13039291.272089755,5833.333333333334,9714535.35506574,true,557.0,557,0.875,0.0,0.0,0.0,0.0,0.0,557,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,389900.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,557.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +558,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,390600.0,5833.333333333334,13045124.60542309,5833.333333333334,9720368.688399075,true,558.0,558,0.875,0.0,0.0,0.0,0.0,0.0,558,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,390600.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,558.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +559,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,391300.0,5833.333333333334,13050957.938756423,5833.333333333334,9726202.021732409,true,559.0,559,0.875,0.0,0.0,0.0,0.0,0.0,559,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,391300.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,559.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +560,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,392000.0,5833.333333333334,13056791.272089757,5833.333333333334,9732035.355065743,true,560.0,560,0.875,0.0,0.0,0.0,0.0,0.0,560,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,392000.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,560.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +561,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,392700.0,5833.333333333334,13062624.605423091,5833.333333333334,9737868.688399076,true,561.0,561,0.875,0.0,0.0,0.0,0.0,0.0,561,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,392700.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,561.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +562,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,393400.0,5833.333333333334,13068457.938756425,5833.333333333334,9743702.02173241,true,562.0,562,0.875,0.0,0.0,0.0,0.0,0.0,562,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,393400.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,562.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +563,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,394100.0,5833.333333333334,13074291.272089759,5833.333333333334,9749535.355065744,true,563.0,563,0.875,0.0,0.0,0.0,0.0,0.0,563,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,394100.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,563.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +564,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,394800.0,5833.333333333334,13080124.605423093,5833.333333333334,9755368.688399078,true,564.0,564,0.875,0.0,0.0,0.0,0.0,0.0,564,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,394800.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,564.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +565,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,395500.0,5833.333333333334,13085957.938756427,5833.333333333334,9761202.021732412,true,565.0,565,0.875,0.0,0.0,0.0,0.0,0.0,565,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,395500.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,565.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +566,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,396200.0,5833.333333333334,13091791.27208976,5833.333333333334,9767035.355065746,true,566.0,566,0.875,0.0,0.0,0.0,0.0,0.0,566,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,396200.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,566.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +567,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,396900.0,5833.333333333334,13097624.605423095,5833.333333333334,9772868.68839908,true,567.0,567,0.875,0.0,0.0,0.0,0.0,0.0,567,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,396900.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,567.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +568,22450.0,21750.0,0.12,0.0,3324755.917023979,700.0,397600.0,5833.333333333334,13103457.938756429,5833.333333333334,9778702.021732414,true,568.0,568,0.875,0.0,0.0,0.0,0.0,0.0,568,21750.0,0.0,0.0,0.0,1642866.2421908078,700.0,397600.0,0.0,952998.2509801899,0.0,-7.321432349272072e-11,0.0,0.0,0.0,689867.9912106165,0.0,2.3590018827235326e-12,-0.0,-2909161.4273959803,true,true,0.0,6116.008762002996,0.0,121.92,1644.2724500334996,568.0,0.0,6116.008762002996,0.0,121.92,0.0,295.15 +569,22450.0,21750.0,0.1768,2178.5874071500493,3326934.504431129,700.0,398300.0,16281.602981617925,13119739.541738046,14103.015574467876,9792805.037306882,true,569.0,569,0.875,1906.2639812562932,2178.5874071500493,272.32342589375617,0.0,0.0,569,21750.0,0.0,1906.2639812562932,1906.2639812562932,1644772.5061720642,700.0,398300.0,0.19594678934725546,952998.4469269792,1789.2808980367404,1789.2808980366672,0.0,0.0,83.20228828994367,689951.1934989064,33.58484814026184,33.5848481402642,-1906.2639812562932,-2911067.6913772365,true,true,1.475255935,6117.484017937996,0.0,121.92,1644.2724500334996,569.0,1.475255935,6117.484017937996,0.0,121.92,0.0,295.15 +570,24628.58740715005,23928.58740715005,0.265,6541.136756240824,3333475.64118737,700.0,399000.0,27325.04436317292,13147064.586101219,20783.907606932098,9813588.944913814,true,570.0,570,0.875,5723.494661710721,6541.136756240824,817.6420945301033,0.0,0.0,570,23928.58740715005,0.0,5723.494661710721,5723.494661710721,1650496.000833775,700.0,399000.0,5.290563308789698,953003.737490288,5367.842689258775,7157.123587295442,0.0,0.0,249.60686481343245,690200.8003637199,100.75454432972379,134.33939246998798,-5723.494661710721,-2916791.186038947,true,true,2.950511869,6120.434529806997,0.0,121.92,1644.2724500334996,570.0,2.950511869,6120.434529806997,0.0,121.92,0.0,295.15 +571,28991.136756240823,28291.136756240823,0.30500000000000005,10919.809735313333,3344395.4509226833,700.0,399700.0,38097.73683709289,13185162.322938312,27177.927101779555,9840766.872015594,true,571.0,571,0.875,9554.833518399166,10919.809735313333,1364.9762169141668,0.0,0.0,571,28291.136756240823,0.0,9554.833518399166,9554.833518399166,1660050.834352174,700.0,399700.0,24.493348648483604,953028.2308389365,8946.404487757982,16103.528075053424,0.0,0.0,416.0114413369212,690616.8118050569,167.9242406557784,302.2636331257664,-9554.833518399166,-2926346.0195573466,true,true,4.425767804,6124.860297610997,0.0,121.92,1644.2724500334996,571.0,4.425767804,6124.860297610997,0.0,121.92,0.0,295.15 +572,33369.809735313334,32669.809735313334,0.335,14315.193882175934,3358710.644804859,700.0,400400.0,44821.47427515204,13229983.797213463,30506.280392976107,9871273.15240857,true,572.0,572,0.875,12525.794646903942,14315.193882175934,1789.3992352719924,0.0,0.0,572,32669.809735313334,0.0,12525.794646903942,12525.794646903942,1672576.628999078,700.0,400400.0,65.47911167336518,953093.7099506098,11664.00834580517,27767.536420858596,0.0,0.0,577.3734549679277,691194.1852600249,218.93373445747787,521.1973675832443,-12525.794646903942,-2938871.8142042505,true,true,5.811614288,6130.671911898997,0.0,121.92,1644.2724500334996,572.0,5.811614288,6130.671911898997,0.0,121.92,0.0,295.15 +573,36765.19388217593,36065.19388217593,0.29250000000000004,9374.17909267032,3368084.8238975294,700.0,401100.0,34441.63792365921,13264425.435137123,25067.458830988893,9896340.611239558,true,573.0,573,0.875,8202.406706086529,9374.17909267032,1171.7723865837906,0.0,0.0,573,36065.19388217593,0.0,8202.406706086529,8202.406706086529,1680779.0357051645,700.0,401100.0,114.63667420610881,953208.346624816,7255.706550990407,35023.242971849,0.0,0.0,695.8736836744432,691890.0589436993,136.18979721556966,657.387164798814,-8202.406706086529,-2947074.220910337,true,true,6.526889892,6137.198801790997,0.0,121.92,1644.2724500334996,573.0,6.526889892,6137.198801790997,0.0,121.92,0.0,295.15 +574,31824.179092670318,31124.179092670318,0.29250000000000004,9255.638494726774,3377340.462392256,700.0,401800.0,34036.370922142814,13298461.806059266,24780.732427416042,9921121.343666974,true,574.0,574,0.875,8098.683682885928,9255.638494726774,1156.9548118408466,0.0,0.0,574,31124.179092670318,0.0,8098.683682885928,8098.683682885928,1688877.7193880505,700.0,401800.0,156.22862525473224,953364.5752500707,7038.8240234815685,42062.06699533057,0.0,0.0,771.5121275128663,692661.5710712122,132.11890663676073,789.5060714355747,-8098.683682885928,-2955172.904593223,true,true,7.152756046,6144.351557836997,0.0,121.92,1644.2724500334996,574.0,7.152756046,6144.351557836997,0.0,121.92,0.0,295.15 +575,31705.638494726772,31005.638494726772,0.28,7487.7774445653,3384828.2398368213,700.0,402500.0,29242.062302018927,13327703.868361285,21754.284857453626,9942875.628524428,true,575.0,575,0.875,6551.805263994638,7487.7774445653,935.9721805706622,0.0,0.0,575,31005.638494726772,0.0,6551.805263994638,6551.805263994638,1695429.5246520452,700.0,402500.0,195.94678914802216,953560.5220392187,5422.063325178861,47484.13032050943,0.0,0.0,832.022882617444,693493.5939538296,101.77226705031065,891.2783384858853,-6551.805263994638,-2961724.7098572175,true,true,7.599803299,6151.951361135997,0.0,121.92,1644.2724500334996,575.0,7.599803299,6151.951361135997,0.0,121.92,0.0,295.15 +576,29937.7774445653,29237.7774445653,0.15600000000000003,1224.6183790807647,3386052.858215902,700.0,403200.0,12337.297301799772,13340041.165663084,11112.678922719007,9953988.307447147,true,576.0,576,0.875,1071.5410816956692,1224.6183790807647,153.07729738509556,0.0,0.0,576,29237.7774445653,0.0,1071.5410816956692,1071.5410816956692,1696501.0657337408,700.0,403200.0,214.30538444661804,953774.8274236653,0.0,47484.13032050943,0.0,0.0,857.2356972490511,694350.8296510787,0.0,891.2783384858853,-1071.5410816956692,-2962796.2509389133,true,true,7.599803299,6159.551164434997,0.0,121.92,1644.2724500334996,576.0,7.599803299,6159.551164434997,0.0,121.92,0.0,295.15 +577,23674.618379080766,22974.618379080766,0.15600000000000003,1224.6183790807647,3387277.4765949827,700.0,403900.0,12337.297301799772,13352378.462964883,11112.678922719007,9965100.986369865,true,577.0,577,0.875,1071.5410816956692,1224.6183790807647,153.07729738509556,0.0,0.0,577,22974.618379080766,0.0,1071.5410816956692,1071.5410816956692,1697572.6068154364,700.0,403900.0,214.30538444661804,953989.132808112,0.0,47484.13032050943,0.0,0.0,857.2356972490511,695208.0653483277,0.0,891.2783384858853,-1071.5410816956692,-2963867.792020609,true,true,7.599803299,6167.150967733997,0.0,121.92,1644.2724500334996,577.0,7.599803299,6167.150967733997,0.0,121.92,0.0,295.15 +578,23674.618379080766,22974.618379080766,0.22,4549.944433838006,3391827.421028821,700.0,404600.0,23863.383790172757,13376241.846755056,19313.43935633475,9984414.4257262,true,578.0,578,0.875,3981.2013796082556,4549.944433838006,568.7430542297507,0.0,0.0,578,22974.618379080766,0.0,3981.2013796082556,3981.2013796082556,1701553.8081950448,700.0,404600.0,223.89975430880622,954213.0325624208,2834.2603809905618,50318.39070149999,0.0,0.0,869.842104593054,696077.9074529208,53.19913971583344,944.4774782017188,-3981.2013796082556,-2967848.9934002175,true,true,7.823326926,6174.974294659997,0.0,121.92,1644.2724500334996,578.0,7.823326926,6174.974294659997,0.0,121.92,0.0,295.15 +579,26999.944433838005,26299.944433838005,0.184,2632.8184637920685,3394460.239492613,700.0,405300.0,18113.143824956893,13394354.990580013,15480.325361164825,9999894.751087364,true,579.0,579,0.875,2303.71615581806,2632.8184637920685,329.10230797400845,0.0,0.0,579,26299.944433838005,0.0,2303.71615581806,2303.71615581806,1703857.5243508627,700.0,405300.0,237.80682917105364,954450.8393915918,1156.706834991513,51475.09753649151,0.0,0.0,887.4910748295391,696965.3985277504,21.711416825954146,966.188895027673,-2303.71615581806,-2970152.7095560357,true,true,7.912736376,6182.887031035997,0.0,121.92,1644.2724500334996,579.0,7.912736376,6182.887031035997,0.0,121.92,0.0,295.15 +580,25082.818463792068,24382.818463792068,0.16,1296.4766484327677,3395756.7161410456,700.0,406000.0,12477.979052704797,13406832.969632719,11181.502404272029,10011076.253491636,true,580.0,580,0.875,1134.4170673786716,1296.4766484327677,162.05958105409604,0.0,0.0,580,24382.818463792068,0.0,1134.4170673786716,1134.4170673786716,1704991.9414182415,700.0,406000.0,241.8834296566501,954692.7228212485,0.0,51475.09753649151,0.0,0.0,892.5336377220215,697857.9321654724,0.0,966.188895027673,-1134.4170673786716,-2971287.1266234145,true,true,7.912736376,6190.799767411997,0.0,121.92,1644.2724500334996,580.0,7.912736376,6190.799767411997,0.0,121.92,0.0,295.15 +581,23746.476648432767,23046.476648432767,0.12,0.0,3395756.7161410456,700.0,406700.0,5833.333333333334,13412666.302966053,5833.333333333334,10016909.58682497,true,581.0,581,0.875,0.0,0.0,0.0,0.0,0.0,581,23046.476648432767,0.0,-53.12034781687444,-53.12034781687444,1704938.8210704245,700.0,406700.0,237.80682917105364,954930.5296504195,-1156.706834991513,50318.39070149999,0.0,0.0,887.4910748295391,698745.423240302,-21.711416825954146,944.4774782017188,-0.0,-2971287.1266234145,true,true,7.823326926,6198.623094337997,0.0,121.92,1644.2724500334996,581.0,7.823326926,6198.623094337997,0.0,121.92,0.0,295.15 +582,22450.0,21750.0,0.12,0.0,3395756.7161410456,700.0,407400.0,5833.333333333334,13418499.636299387,5833.333333333334,10022742.920158304,true,582.0,582,0.875,0.0,0.0,0.0,0.0,0.0,582,21750.0,0.0,-1793.717661804535,-1793.717661804535,1703145.10340862,700.0,407400.0,223.89975430880622,955154.4294047283,-2834.2603809905618,47484.13032050943,0.0,0.0,869.842104593054,699615.2653448951,-53.19913971583344,891.2783384858853,-0.0,-2971287.1266234145,true,true,7.599803299,6206.222897636997,0.0,121.92,1644.2724500334996,582.0,7.599803299,6206.222897636997,0.0,121.92,0.0,295.15 +583,22450.0,21750.0,0.136,571.06955990149,3396327.785700947,700.0,408100.0,9346.099705158014,13427845.736004544,8775.030145256524,10031517.95030356,true,583.0,583,0.875,499.68586491380375,571.06955990149,71.38369498768628,0.0,0.0,583,21750.0,0.0,499.68586491380375,499.68586491380375,1703644.7892735337,700.0,408100.0,212.4200107018856,955366.8494154302,-556.9937742274183,46927.13654628201,0.0,0.0,854.7144158028099,700469.9797606979,-10.454787363473482,880.8235511224119,-499.68586491380375,-2971786.812488328,true,true,7.555098574,6213.777996210997,0.0,121.92,1644.2724500334996,583.0,7.555098574,6213.777996210997,0.0,121.92,0.0,295.15 +584,23021.06955990149,22321.06955990149,0.12,0.0,3396327.785700947,700.0,408800.0,5833.333333333334,13433679.069337878,5833.333333333334,10037351.283636894,true,584.0,584,0.875,0.0,0.0,0.0,0.0,0.0,584,22321.06955990149,0.0,-632.6406400777848,-632.6406400777848,1703012.1486334559,700.0,408800.0,204.98909254787833,955571.8385079781,-1651.264741233881,45275.871805048126,0.0,0.0,844.6292899614467,701314.6090506593,-30.994281353228892,849.829269769183,-0.0,-2971786.812488328,true,true,7.420984398,6221.198980608997,0.0,121.92,1644.2724500334996,584.0,7.420984398,6221.198980608997,0.0,121.92,0.0,295.15 +585,22450.0,21750.0,0.196,3775.643950356295,3400103.429651303,700.0,409500.0,22834.91811406273,13456513.98745194,19059.274163706436,10056410.5578006,true,585.0,585,0.875,3303.6884565617584,3775.643950356295,471.9554937945368,0.0,0.0,585,21750.0,0.0,3303.6884565617584,3303.6884565617584,1706315.8370900175,700.0,409500.0,206.8303009760687,955778.6688089542,2208.2585154612993,47484.13032050942,0.0,0.0,847.1505714076878,702161.759622067,41.44906871670238,891.2783384858855,-3303.6884565617584,-2975090.50094489,true,true,7.599803299,6228.798783907997,0.0,121.92,1644.2724500334996,585.0,7.599803299,6228.798783907997,0.0,121.92,0.0,295.15 +586,26225.643950356294,25525.643950356294,0.1696,1882.0059436537138,3401985.435594957,700.0,410200.0,15224.091648901616,13471738.079100842,13342.085705247902,10069752.643505849,true,586.0,586,0.875,1646.7552006969995,1882.0059436537138,235.25074295671425,0.0,0.0,586,25525.643950356294,0.0,1646.7552006969995,1646.7552006969995,1707962.5922907146,700.0,410200.0,216.20188130804684,955994.8706902622,560.2798731691493,48044.410193678574,0.0,0.0,859.7569786952923,703021.5166007623,10.516467524511034,901.7948060103965,-1646.7552006969995,-2976737.256145587,true,true,7.644508024,6236.443291931997,0.0,121.92,1644.2724500334996,586.0,7.644508024,6236.443291931997,0.0,121.92,0.0,295.15 +587,24332.005943653712,23632.005943653712,0.136,577.3285934967759,3402562.7641884536,700.0,410900.0,9392.122011005704,13481130.201111848,8814.793417508929,10078567.436923359,true,587.0,587,0.875,505.1625193096788,577.3285934967759,72.16607418709702,0.0,0.0,587,23632.005943653712,0.0,505.1625193096788,505.1625193096788,1708467.7548100243,700.0,410900.0,216.20188130804684,956211.0725715702,-560.2798731691493,47484.13032050942,0.0,0.0,859.7569786952923,703881.2735794575,-10.516467524511034,891.2783384858855,-505.1625193096788,-2977242.418664897,true,true,7.599803299,6244.043095230997,0.0,121.92,1644.2724500334996,587.0,7.599803299,6244.043095230997,0.0,121.92,0.0,295.15 +588,23027.328593496775,22327.328593496775,0.12,0.0,3402562.7641884536,700.0,411600.0,5833.333333333334,13486963.534445181,5833.333333333334,10084400.770256693,true,588.0,588,0.875,0.0,0.0,0.0,0.0,0.0,588,22327.328593496775,0.0,-1195.7267117942454,-1195.7267117942454,1707272.02809823,700.0,411600.0,206.8303009760687,956417.9028725462,-2208.2585154612993,45275.871805048126,0.0,0.0,847.1505714076878,704728.4241508652,-41.44906871670238,849.829269769183,-0.0,-2977242.418664897,true,true,7.420984398,6251.464079628997,0.0,121.92,1644.2724500334996,588.0,7.420984398,6251.464079628997,0.0,121.92,0.0,295.15 +589,22450.0,21750.0,0.136,546.5374240848756,3403109.3016125383,700.0,412300.0,9165.71635356526,13496129.250798747,8619.178929480384,10093019.949186172,true,589.0,589,0.875,478.2202460742662,546.5374240848756,68.31717801060944,0.0,0.0,589,21750.0,0.0,478.2202460742662,478.2202460742662,1707750.2483443043,700.0,412300.0,197.73352705905057,956615.6363996053,-543.8493783869245,44732.0224266612,0.0,0.0,834.5441641200836,705562.9683149853,-10.208066717943383,839.6212030512396,-478.2202460742662,-2977720.638910971,true,true,7.376279673,6258.840359301997,0.0,121.92,1644.2724500334996,589.0,7.376279673,6258.840359301997,0.0,121.92,0.0,295.15 +590,22996.537424084876,22296.537424084876,0.15600000000000003,1174.8224821276701,3404284.124094666,700.0,413000.0,12018.09283415173,13508147.3436329,10843.27035202406,10103863.219538197,true,590.0,590,0.875,1027.9696718617113,1174.8224821276701,146.85281026595885,0.0,0.0,590,22296.537424084876,0.0,1027.9696718617113,1027.9696718617113,1708778.218016166,700.0,413000.0,195.94678918786877,956811.5831887932,0.0,44732.0224266612,0.0,0.0,832.0228826738424,706394.9911976592,0.0,839.6212030512396,-1027.9696718617113,-2978748.608582833,true,true,7.376279673,6266.216638974996,0.0,121.92,1644.2724500334996,590.0,7.376279673,6266.216638974996,0.0,121.92,0.0,295.15 +591,23624.82248212767,22924.82248212767,0.1696,1812.954441467431,3406097.0785361333,700.0,413700.0,14816.948357708909,13522964.291990608,13003.993916241478,10116867.213454438,true,591.0,591,0.875,1586.3351362840021,1812.954441467431,226.61930518342888,0.0,0.0,591,22924.82248212767,0.0,1586.3351362840021,1586.3351362840021,1710364.55315245,700.0,413700.0,197.73352705905057,957009.3167158522,543.8493783869245,45275.871805048126,0.0,0.0,834.5441641200836,707229.5353617793,10.208066717943383,849.829269769183,-1586.3351362840021,-2980334.943719117,true,true,7.420984398,6273.637623372996,0.0,121.92,1644.2724500334996,591.0,7.420984398,6273.637623372996,0.0,121.92,0.0,295.15 +592,24262.95444146743,23562.95444146743,0.196,3775.643950356295,3409872.7224864895,700.0,414400.0,22834.91811406273,13545799.21010467,19059.274163706436,10135926.487618145,true,592.0,592,0.875,3303.6884565617584,3775.643950356295,471.9554937945368,0.0,0.0,592,23562.95444146743,0.0,3303.6884565617584,3303.6884565617584,1713668.2416090115,700.0,414400.0,206.8303009760687,957216.1470168283,2208.2585154612993,47484.13032050942,0.0,0.0,847.1505714076878,708076.6859331869,41.44906871670238,891.2783384858855,-3303.6884565617584,-2983638.632175679,true,true,7.599803299,6281.237426671996,0.0,121.92,1644.2724500334996,592.0,7.599803299,6281.237426671996,0.0,121.92,0.0,295.15 +593,26225.643950356294,25525.643950356294,0.23500000000000001,5226.52628638056,3415099.24877287,700.0,415100.0,25219.260793108766,13571018.470897779,19992.734506728208,10155919.222124873,true,593.0,593,0.875,4573.21050058299,5226.52628638056,653.3157857975702,0.0,0.0,593,25525.643950356294,0.0,4573.21050058299,4573.21050058299,1718241.4521095946,700.0,415100.0,225.85235747995583,957441.9993743083,3410.970749015447,50895.10106952487,0.0,0.0,872.3633860392952,708949.0493192262,64.02400804829202,955.3023465341774,-4573.21050058299,-2988211.842676262,true,true,7.868031651,6289.105458322996,0.0,121.92,1644.2724500334996,593.0,7.868031651,6289.105458322996,0.0,121.92,0.0,295.15 +594,27676.526286380562,26976.526286380562,0.28,7548.763303965818,3422648.0120768356,700.0,415800.0,29459.868942735062,13600478.339840515,21911.105638769244,10177830.327763641,true,594.0,594,0.875,6605.16789097009,7548.763303965818,943.5954129957272,0.0,0.0,594,26976.526286380562,0.0,6605.16789097009,6605.16789097009,1724846.6200005647,700.0,415800.0,256.5180545519494,957698.5174288602,5338.267805398675,56233.368874923544,0.0,0.0,910.1826080149052,709859.2319272411,100.19942300456049,1055.501769538738,-6605.16789097009,-2994817.010567232,true,true,8.270374179,6297.375832501996,0.0,121.92,1644.2724500334996,594.0,8.270374179,6297.375832501996,0.0,121.92,0.0,295.15 +595,29998.763303965818,29298.763303965818,0.25,6468.659935355541,3429116.6720121913,700.0,416500.0,28674.639741422165,13629152.979581937,22205.97980606662,10200036.307569709,true,595.0,595,0.875,5660.077443436098,6468.659935355541,808.5824919194429,0.0,0.0,595,29298.763303965818,0.0,5660.077443436098,5660.077443436098,1730506.6974440007,700.0,416500.0,292.1597488158049,957990.677177676,4336.007609643123,60569.37648456667,0.0,0.0,950.5231114367564,710809.7550386778,81.38697354041373,1136.8887430791517,-5660.077443436098,-3000477.0880106683,true,true,8.583307256,6305.959139757996,0.0,121.92,1644.2724500334996,595.0,8.583307256,6305.959139757996,0.0,121.92,0.0,295.15 +596,28918.659935355543,28218.659935355543,0.29250000000000004,9053.71597267568,3438170.3879848667,700.0,417200.0,33346.03751342112,13662499.017095359,24292.32154074544,10224328.629110454,true,596.0,596,0.875,7922.00147609122,9053.71597267568,1131.71449658446,0.0,0.0,596,28218.659935355543,0.0,7922.00147609122,7922.00147609122,1738428.698920092,700.0,417200.0,333.49167517286133,958324.1688528488,6473.614986095856,67042.99147066253,0.0,0.0,993.3848962484503,711803.1399349263,121.5099185740529,1258.3986616532047,-7922.00147609122,-3008399.0894867596,true,true,9.030354508,6314.989494265996,0.0,121.92,1644.2724500334996,596.0,9.030354508,6314.989494265996,0.0,121.92,0.0,295.15 +597,31503.71597267568,30803.71597267568,0.28625,7928.258968117846,3446098.6469529844,700.0,417900.0,30142.389408271953,13692641.40650363,22214.130440154106,10246542.759550607,true,597.0,597,0.875,6937.226597103116,7928.258968117846,991.0323710147304,0.0,0.0,597,30803.71597267568,0.0,6937.226597103116,6937.226597103116,1745365.9255171951,700.0,417900.0,381.3185912308131,958705.4874440796,5415.491136410198,72458.48260707273,0.0,0.0,1038.7679625627839,712841.907897489,101.6489068993212,1360.047568552526,-6937.226597103116,-3015336.316083863,true,true,9.387992311,6324.377486576996,0.0,121.92,1644.2724500334996,597.0,9.387992311,6324.377486576996,0.0,121.92,0.0,295.15 +598,30378.258968117847,29678.258968117847,0.1816,2483.4568869222353,3448582.1038399064,700.0,418600.0,17530.048936796447,13710171.455440428,15046.592049874213,10261589.351600481,true,598.0,598,0.875,2173.024776056956,2483.4568869222353,310.43211086527936,0.0,0.0,598,29678.258968117847,0.0,2173.024776056956,2173.024776056956,1747538.950293252,700.0,418600.0,406.8577746052386,959112.3452186849,691.7238317209973,73150.20643879373,0.0,0.0,1061.4594957481497,713903.3673932372,12.983673982570316,1373.0312425350962,-2173.024776056956,-3017509.34085992,true,true,9.432697036,6333.810183612995,0.0,121.92,1644.2724500334996,598.0,9.432697036,6333.810183612995,0.0,121.92,0.0,295.15 +599,24933.456886922235,24233.456886922235,0.1816,2499.7041780573245,3451081.8080179635,700.0,419300.0,17619.516398994077,13727790.971839422,15119.812220936754,10276709.163821418,true,599.0,599,0.875,2187.241155800159,2499.7041780573245,312.46302225716545,0.0,0.0,599,24233.456886922235,0.0,2187.241155800159,2187.241155800159,1749726.1914490522,700.0,419300.0,412.6838123532025,959525.029031038,695.0099306627167,73845.21636945645,0.0,0.0,1066.5020586406322,714969.8694518778,13.045354143607682,1386.076596678704,-2187.241155800159,-3019696.5820157197,true,true,9.477401761,6343.287585373995,0.0,121.92,1644.2724500334996,599.0,9.477401761,6343.287585373995,0.0,121.92,0.0,295.15 +600,24949.704178057324,24249.704178057324,0.22,4996.91323555462,3456078.721253518,700.0,420000.0,25895.06016161191,13753686.032001033,20898.14692605729,10297607.310747474,true,600.0,600,0.875,4372.299081110293,4996.91323555462,624.6141544443271,0.0,0.0,600,24249.704178057324,0.0,4372.299081110293,4372.299081110293,1754098.4905301626,700.0,420000.0,427.491652521537,959952.5206835596,2812.900743823274,76658.11711327973,0.0,0.0,1079.1084659846351,716048.9779178624,52.79821878084691,1438.8748154595507,-4372.299081110293,-3024068.88109683,true,true,9.656220663,6352.943806036995,0.0,121.92,1644.2724500334996,600.0,9.656220663,6352.943806036995,0.0,121.92,0.0,295.15 +601,27446.91323555462,26746.91323555462,0.22,5109.092725486967,3461187.813979005,700.0,420700.0,26404.966934031665,13780090.998935064,21295.874208544697,10318903.18495602,true,601.0,601,0.875,4470.456134801096,5109.092725486967,638.6365906858709,0.0,0.0,601,26746.91323555462,0.0,4470.456134801096,4470.456134801096,1758568.9466649636,700.0,420700.0,451.91400410552706,960404.4346876651,2865.478311895824,79523.59542517556,0.0,0.0,1099.2787177237599,717148.2566355861,53.7851010759847,1492.6599165355356,-4470.456134801096,-3028539.3372316314,true,true,9.835039564,6362.778845600995,0.0,121.92,1644.2724500334996,601.0,9.835039564,6362.778845600995,0.0,121.92,0.0,295.15 +602,27559.092725486968,26859.092725486968,0.23500000000000001,5222.315429107876,3466410.1294081127,700.0,421400.0,25201.342251522878,13805292.341186587,19979.026822415002,10338882.211778434,true,602.0,602,0.875,4569.526000469392,5222.315429107876,652.7894286384844,0.0,0.0,602,26859.092725486968,0.0,4569.526000469392,4569.526000469392,1763138.472665433,700.0,421400.0,477.2492360023803,960881.6839236674,2918.055813224185,82441.65123839975,0.0,0.0,1119.4489691244937,718267.7056047106,54.77198211833273,1547.4318986538683,-4569.526000469392,-3033108.863232101,true,true,10.01385846,6372.792704060995,0.0,121.92,1644.2724500334996,602.0,10.01385846,6372.792704060995,0.0,121.92,0.0,295.15 +603,27672.315429107875,26972.315429107875,0.1864,2716.7847369011556,3469126.914145014,700.0,422100.0,18330.3902194268,13823622.731406014,15613.605482525645,10354495.81726096,true,603.0,603,0.875,2377.1866447885113,2716.7847369011556,339.5980921126443,0.0,0.0,603,26972.315429107875,0.0,2377.1866447885113,2377.1866447885113,1765515.6593102217,700.0,422100.0,493.55477106152716,961375.2386947289,737.729299526981,83179.38053792673,0.0,0.0,1132.055376412098,719399.7609811227,13.847197787905301,1561.2790964417736,-2377.1866447885113,-3035486.049876889,true,true,10.05856319,6382.851267250995,0.0,121.92,1644.2724500334996,603.0,10.05856319,6382.851267250995,0.0,121.92,0.0,295.15 +604,25166.784736901154,24466.784736901154,0.1696,1864.4988261493472,3470991.412971163,700.0,422800.0,15120.865720220208,13838743.597126234,13256.366894070861,10367752.18415503,true,604.0,604,0.875,1631.4364728806788,1864.4988261493472,233.0623532686684,0.0,0.0,604,24466.784736901154,0.0,1631.4364728806788,1631.4364728806788,1767147.0957831023,700.0,422800.0,496.8598147403471,961872.0985094693,0.0,83179.38053792673,0.0,0.0,1134.5766581403318,720534.337639263,0.0,1561.2790964417736,-1631.4364728806788,-3037117.48634977,true,true,10.05856319,6392.909830440995,0.0,121.92,1644.2724500334996,604.0,10.05856319,6392.909830440995,0.0,121.92,0.0,295.15 +605,24314.49882614935,23614.49882614935,0.1696,1864.4988261493472,3472855.9117973126,700.0,423500.0,15120.865720220208,13853864.462846454,13256.366894070861,10381008.5510491,true,605.0,605,0.875,1631.4364728806788,1864.4988261493472,233.0623532686684,0.0,0.0,605,23614.49882614935,0.0,1631.4364728806788,1631.4364728806788,1768778.532255983,700.0,423500.0,496.8598147403471,962368.9583242097,0.0,83179.38053792673,0.0,0.0,1134.5766581403318,721668.9142974033,0.0,1561.2790964417736,-1631.4364728806788,-3038748.9228226505,true,true,10.05856319,6402.968393630996,0.0,121.92,1644.2724500334996,605.0,10.05856319,6402.968393630996,0.0,121.92,0.0,295.15 +606,24314.49882614935,23614.49882614935,0.196,3607.2336967050687,3476463.1454940178,700.0,424200.0,21975.682126046268,13875840.144972501,18368.4484293412,10399376.99947844,true,606.0,606,0.875,3156.329484616935,3607.2336967050687,450.9042120881336,0.0,0.0,606,23614.49882614935,0.0,3156.329484616935,3156.329484616935,1771934.8617405999,700.0,424200.0,503.5140993916699,962872.4724236013,1485.316731224108,84664.69726915084,0.0,0.0,1139.6192210328143,722808.5335184361,27.879432968343128,1589.1585294101167,-3156.329484616935,-3041905.2523072674,true,true,10.14797264,6413.116366270996,0.0,121.92,1644.2724500334996,606.0,10.14797264,6413.116366270996,0.0,121.92,0.0,295.15 +607,26057.23369670507,25357.23369670507,0.30500000000000005,10835.900866302274,3487299.04636032,700.0,424900.0,37822.62579115499,13913662.770763656,26986.724924852715,10426363.724403294,true,607.0,607,0.875,9481.41325801449,10835.900866302274,1354.4876082877836,0.0,0.0,607,25357.23369670507,0.0,9481.41325801449,9481.41325801449,1781416.2749986143,700.0,424900.0,544.6910924977716,963417.1635160991,7623.749592625046,92288.44686177588,0.0,0.0,1169.8745983877081,723978.4081168239,143.09797450396636,1732.256503914083,-9481.41325801449,-3051386.665565282,true,true,10.59501989,6423.711386160996,0.0,121.92,1644.2724500334996,607.0,10.59501989,6423.711386160996,0.0,121.92,0.0,295.15 +608,33285.900866302276,32585.900866302276,0.33999999999999997,15200.066631111436,3502499.1129914313,700.0,425600.0,46764.90185621011,13960427.672619866,31564.835225098675,10457928.559628392,true,608.0,608,0.875,13300.058302222507,15200.066631111436,1900.008328888929,0.0,0.0,608,32585.900866302276,0.0,13300.058302222507,13300.058302222507,1794716.3333008368,700.0,425600.0,633.6592773480427,964050.8227934472,11225.314236390013,103513.7610981659,0.0,0.0,1230.3853536614813,725208.7934704854,210.69943482296983,1942.9559387370527,-13300.058302222507,-3064686.7238675044,true,true,11.22088605,6434.932272210996,0.0,121.92,1644.2724500334996,608.0,11.22088605,6434.932272210996,0.0,121.92,0.0,295.15 +609,37650.06663111143,36950.06663111143,0.3175,11101.870440849216,3513600.9834322804,700.0,426300.0,37171.24548298965,13997598.918102857,26069.375042140437,10483997.934670532,true,609.0,609,0.875,9714.136635743063,11101.870440849216,1387.7338051061524,0.0,0.0,609,36950.06663111143,0.0,9714.136635743063,9714.136635743063,1804430.46993658,700.0,426300.0,727.5436132255105,964778.3664066726,7556.384661715717,111070.1457598816,0.0,0.0,1288.374827771006,726497.1682982564,141.8335330308298,2084.789471767883,-9714.136635743063,-3074400.8605032475,true,true,11.62322858,6446.555500790996,0.0,121.92,1644.2724500334996,609.0,11.62322858,6446.555500790996,0.0,121.92,0.0,295.15 +610,33551.87044084922,32851.87044084922,0.28,7436.1460058028015,3521037.129438083,700.0,427000.0,29057.664306438575,14026656.582409296,21621.518300635773,10505619.452971168,true,610.0,610,0.875,6506.627755077451,7436.1460058028015,929.5182507253503,0.0,0.0,610,32851.87044084922,0.0,6506.627755077451,6506.627755077451,1810937.0976916575,700.0,427000.0,788.9949839284826,965567.3613906011,4313.004793045029,115383.15055292663,0.0,0.0,1323.6727680183824,727820.8410662747,80.95521008555681,2165.7446818534395,-6506.627755077451,-3080907.488258325,true,true,11.8467522,6458.402252990996,0.0,121.92,1644.2724500334996,610.0,11.8467522,6458.402252990996,0.0,121.92,0.0,295.15 +611,29886.146005802802,29186.146005802802,0.28,7613.125594812821,3528650.255032896,700.0,427700.0,29689.73426718864,14056346.316676484,22076.60867237582,10527696.061643545,true,611.0,611,0.875,6661.484895461218,7613.125594812821,951.640699351603,0.0,0.0,611,29186.146005802802,0.0,6661.484895461218,6661.484895461218,1817598.5825871187,700.0,427700.0,834.9446338311269,966402.3060244323,4395.157461381533,119778.30801430816,0.0,0.0,1348.8855824807938,729169.7266487555,82.49721776776443,2248.241899621204,-6661.484895461218,-3087568.9731537863,true,true,12.07027583,6470.472528820997,0.0,121.92,1644.2724500334996,611.0,12.07027583,6470.472528820997,0.0,121.92,0.0,295.15 +612,30063.12559481282,29363.12559481282,0.12,0.0,3528650.255032896,700.0,428400.0,5833.333333333334,14062179.650009818,5833.333333333334,10533529.394976879,true,612.0,612,0.875,0.0,0.0,0.0,0.0,0.0,612,29363.12559481282,0.0,-5844.36128574788,-5844.36128574788,1811754.2213013708,700.0,428400.0,816.356575297534,967218.6625997298,-7852.133570148046,111926.17444416012,0.0,0.0,1338.8004566958293,730508.5271054513,-147.38474759319732,2100.8571520280066,-0.0,-3087568.9731537863,true,true,11.6679333,6482.140462120997,0.0,121.92,1644.2724500334996,612.0,11.6679333,6482.140462120997,0.0,121.92,0.0,295.15 +613,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,429100.0,5833.333333333334,14068012.983343152,5833.333333333334,10539362.728310212,true,613.0,613,0.875,0.0,0.0,0.0,0.0,0.0,613,21750.0,0.0,-25141.08661405436,-25141.08661405436,1786613.1346873164,700.0,429100.0,637.5627120621475,967856.225311792,-26513.889577186943,85412.28486697318,0.0,0.0,1232.9066353897151,731741.433740841,-497.6663843192779,1603.1907677087288,-0.0,-3087568.9731537863,true,true,10.19267737,6492.3331394909965,0.0,121.92,1644.2724500334996,613.0,10.19267737,6492.3331394909965,0.0,121.92,0.0,295.15 +614,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,429800.0,5833.333333333334,14073846.316676486,5833.333333333334,10545196.061643546,true,614.0,614,0.875,0.0,0.0,0.0,0.0,0.0,614,21750.0,0.0,-21886.638753809224,-21886.638753809224,1764726.495933507,700.0,429800.0,412.683812615084,968268.9091244071,-22935.327934375055,62476.95693259812,0.0,0.0,1066.5020588662264,732807.9357997072,-430.4966909154778,1172.694076793251,-0.0,-3087568.9731537863,true,true,8.717421431,6501.050560921996,0.0,121.92,1644.2724500334996,614.0,8.717421431,6501.050560921996,0.0,121.92,0.0,295.15 +615,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,430500.0,5833.333333333334,14079679.65000982,5833.333333333334,10551029.39497688,true,615.0,615,0.875,0.0,0.0,0.0,0.0,0.0,615,21750.0,0.0,-18571.91029971662,-18571.91029971662,1746154.5856337906,700.0,430500.0,248.08527067467958,968516.9943950818,-19356.766059355312,43120.19087324281,0.0,0.0,900.0974821171435,733708.0332818243,-363.3269931531311,809.36708364012,-0.0,-3087568.9731537863,true,true,7.242165497,6508.292726418997,0.0,121.92,1644.2724500334996,615.0,7.242165497,6508.292726418997,0.0,121.92,0.0,295.15 +616,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,431200.0,5833.333333333334,14085512.983343154,5833.333333333334,10556862.728310214,true,616.0,616,0.875,0.0,0.0,0.0,0.0,0.0,616,21750.0,0.0,-15206.307028366156,-15206.307028366156,1730948.2786054243,700.0,431200.0,134.36164079749489,968651.3560358792,-15778.204277615652,27341.98659562716,0.0,0.0,733.6929055936547,734441.726187418,-296.15729714165326,513.2097864984667,-0.0,-3087568.9731537863,true,true,5.766909562,6514.059635980997,0.0,121.92,1644.2724500334996,616.0,5.766909562,6514.059635980997,0.0,121.92,0.0,295.15 +617,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,431900.0,5833.333333333334,14091346.316676488,5833.333333333334,10562696.061643548,true,617.0,617,0.875,0.0,0.0,0.0,0.0,0.0,617,21750.0,0.0,-11799.234269301498,-11799.234269301498,1719149.044336123,700.0,431900.0,62.10747684254341,968713.4635127218,-12199.642474485532,15142.344121141628,0.0,0.0,567.288329070166,735009.0145164882,-228.9876007286765,284.22218576979014,-0.0,-3087568.9731537863,true,true,4.291653628,6518.351289608997,0.0,121.92,1644.2724500334996,617.0,4.291653628,6518.351289608997,0.0,121.92,0.0,295.15 +618,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,432600.0,5833.333333333334,14097179.650009822,5833.333333333334,10568529.394976882,true,618.0,618,0.875,0.0,0.0,0.0,0.0,0.0,618,21750.0,0.0,-8360.097507043152,-8360.097507043152,1710788.9468290799,700.0,432600.0,21.917332930719994,968735.3808456525,-8621.080687894411,6521.263433247217,0.0,0.0,400.88375254667716,735409.8982690348,-161.81790462613696,122.40428114365318,-0.0,-3087568.9731537863,true,true,2.816397693,6521.167687301997,0.0,121.92,1644.2724500334996,618.0,2.816397693,6521.167687301997,0.0,121.92,0.0,295.15 +619,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,433300.0,5833.333333333334,14103012.983343156,5833.333333333334,10574362.728310216,true,619.0,619,0.875,0.0,0.0,0.0,0.0,0.0,619,21750.0,0.0,-4898.302158713845,-4898.302158713845,1705890.644670366,700.0,433300.0,4.385763182919641,968739.7666088354,-5042.518889615731,1478.7445436314865,0.0,0.0,234.4791760231884,735644.377445058,-94.6482083042216,27.75607283943158,-0.0,-3087568.9731537863,true,true,1.341141759,6522.5088290609965,0.0,121.92,1644.2724500334996,619.0,1.341141759,6522.5088290609965,0.0,121.92,0.0,295.15 +620,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,434000.0,5833.333333333334,14108846.31667649,5833.333333333334,10580196.06164355,true,620.0,620,0.875,0.0,0.0,0.0,0.0,0.0,620,21750.0,0.0,-1430.7149548531552,-1430.7149548531552,1704459.929715513,700.0,434000.0,0.14721772299579924,968739.9138265584,-1478.7445436315438,-5.729816621169448e-11,0.0,0.0,75.63844389482165,735720.0158889528,-27.75607283942872,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,620.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +621,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,434700.0,5833.333333333334,14114679.650009824,5833.333333333334,10586029.394976884,true,621.0,621,0.875,0.0,0.0,0.0,0.0,0.0,621,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,434700.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,621.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +622,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,435400.0,5833.333333333334,14120512.983343158,5833.333333333334,10591862.728310218,true,622.0,622,0.875,0.0,0.0,0.0,0.0,0.0,622,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,435400.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,622.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +623,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,436100.0,5833.333333333334,14126346.316676492,5833.333333333334,10597696.061643552,true,623.0,623,0.875,0.0,0.0,0.0,0.0,0.0,623,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,436100.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,623.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +624,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,436800.0,5833.333333333334,14132179.650009826,5833.333333333334,10603529.394976886,true,624.0,624,0.875,0.0,0.0,0.0,0.0,0.0,624,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,436800.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,624.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +625,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,437500.0,5833.333333333334,14138012.98334316,5833.333333333334,10609362.72831022,true,625.0,625,0.875,0.0,0.0,0.0,0.0,0.0,625,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,437500.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,625.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +626,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,438200.0,5833.333333333334,14143846.316676494,5833.333333333334,10615196.061643554,true,626.0,626,0.875,0.0,0.0,0.0,0.0,0.0,626,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,438200.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,626.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +627,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,438900.0,5833.333333333334,14149679.650009828,5833.333333333334,10621029.394976888,true,627.0,627,0.875,0.0,0.0,0.0,0.0,0.0,627,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,438900.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,627.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +628,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,439600.0,5833.333333333334,14155512.983343162,5833.333333333334,10626862.728310222,true,628.0,628,0.875,0.0,0.0,0.0,0.0,0.0,628,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,439600.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,628.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +629,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,440300.0,5833.333333333334,14161346.316676496,5833.333333333334,10632696.061643556,true,629.0,629,0.875,0.0,0.0,0.0,0.0,0.0,629,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,440300.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,629.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +630,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,441000.0,5833.333333333334,14167179.65000983,5833.333333333334,10638529.39497689,true,630.0,630,0.875,0.0,0.0,0.0,0.0,0.0,630,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,441000.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,630.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +631,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,441700.0,5833.333333333334,14173012.983343164,5833.333333333334,10644362.728310224,true,631.0,631,0.875,0.0,0.0,0.0,0.0,0.0,631,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,441700.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,631.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +632,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,442400.0,5833.333333333334,14178846.316676497,5833.333333333334,10650196.061643558,true,632.0,632,0.875,0.0,0.0,0.0,0.0,0.0,632,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,442400.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,632.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +633,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,443100.0,5833.333333333334,14184679.650009831,5833.333333333334,10656029.394976892,true,633.0,633,0.875,0.0,0.0,0.0,0.0,0.0,633,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,443100.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,633.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +634,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,443800.0,5833.333333333334,14190512.983343165,5833.333333333334,10661862.728310226,true,634.0,634,0.875,0.0,0.0,0.0,0.0,0.0,634,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,443800.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,634.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +635,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,444500.0,5833.333333333334,14196346.3166765,5833.333333333334,10667696.06164356,true,635.0,635,0.875,0.0,0.0,0.0,0.0,0.0,635,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,444500.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,635.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +636,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,445200.0,5833.333333333334,14202179.650009833,5833.333333333334,10673529.394976893,true,636.0,636,0.875,0.0,0.0,0.0,0.0,0.0,636,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,445200.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,636.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +637,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,445900.0,5833.333333333334,14208012.983343167,5833.333333333334,10679362.728310227,true,637.0,637,0.875,0.0,0.0,0.0,0.0,0.0,637,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,445900.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,637.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +638,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,446600.0,5833.333333333334,14213846.316676501,5833.333333333334,10685196.061643561,true,638.0,638,0.875,0.0,0.0,0.0,0.0,0.0,638,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,446600.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,638.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +639,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,447300.0,5833.333333333334,14219679.650009835,5833.333333333334,10691029.394976895,true,639.0,639,0.875,0.0,0.0,0.0,0.0,0.0,639,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,447300.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,639.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +640,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,448000.0,5833.333333333334,14225512.98334317,5833.333333333334,10696862.72831023,true,640.0,640,0.875,0.0,0.0,0.0,0.0,0.0,640,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,448000.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,640.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +641,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,448700.0,5833.333333333334,14231346.316676503,5833.333333333334,10702696.061643563,true,641.0,641,0.875,0.0,0.0,0.0,0.0,0.0,641,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,448700.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,641.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +642,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,449400.0,5833.333333333334,14237179.650009837,5833.333333333334,10708529.394976897,true,642.0,642,0.875,0.0,0.0,0.0,0.0,0.0,642,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,449400.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,642.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +643,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,450100.0,5833.333333333334,14243012.983343171,5833.333333333334,10714362.728310231,true,643.0,643,0.875,0.0,0.0,0.0,0.0,0.0,643,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,450100.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,643.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +644,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,450800.0,5833.333333333334,14248846.316676505,5833.333333333334,10720196.061643565,true,644.0,644,0.875,0.0,0.0,0.0,0.0,0.0,644,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,450800.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,644.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +645,22450.0,21750.0,0.12,0.0,3528650.255032896,700.0,451500.0,5833.333333333334,14254679.650009839,5833.333333333334,10726029.394976899,true,645.0,645,0.875,0.0,0.0,0.0,0.0,0.0,645,21750.0,0.0,0.0,0.0,1704459.929715513,700.0,451500.0,0.0,968739.9138265584,0.0,-5.729816621169448e-11,0.0,0.0,0.0,735720.0158889528,0.0,2.8599345114344032e-12,-0.0,-3087568.9731537863,true,true,0.0,6522.5088290609965,0.0,121.92,1644.2724500334996,645.0,0.0,6522.5088290609965,0.0,121.92,0.0,295.15 +646,22450.0,21750.0,0.14400000000000002,822.8858044250761,3529473.140837321,700.0,452200.0,10575.595864063027,14265255.245873902,9752.710059637951,10735782.105036536,true,646.0,646,0.875,720.0250788719416,822.8858044250761,102.86072555313456,0.0,0.0,646,21750.0,0.0,720.0250788719416,720.0250788719416,1705179.954794385,700.0,452200.0,0.043620066072829394,968739.9574466244,657.2197971695749,657.2197971695176,0.0,0.0,50.425629263214425,735770.4415182159,12.336032373079432,12.336032373082292,-720.0250788719416,-3088288.998232658,true,true,0.894094506,6523.402923566997,0.0,121.92,1644.2724500334996,646.0,0.894094506,6523.402923566997,0.0,121.92,0.0,295.15 +647,23272.885804425077,22572.885804425077,0.196,3297.658566844822,3532770.7994041657,700.0,452900.0,20396.217177779705,14285651.463051682,17098.558610934884,10752880.663647471,true,647.0,647,0.875,2885.4512459892194,3297.658566844822,412.2073208556026,0.0,0.0,647,22572.885804425077,0.0,2885.4512459892194,2885.4512459892194,1708065.4060403742,700.0,452900.0,1.4973950798833802,968741.4548417043,2669.955424347497,3327.1752215170145,0.0,0.0,163.88329507724762,735934.3248132932,50.11513148459141,62.4511638576737,-2885.4512459892194,-3091174.449478647,true,true,2.011712638,6525.414636204997,0.0,121.92,1644.2724500334996,647.0,2.011712638,6525.414636204997,0.0,121.92,0.0,295.15 +648,25747.65856684482,25047.65856684482,0.28625,8130.950619693936,3540901.7500238596,700.0,453600.0,30850.482514214626,14316501.945565896,22719.53189452069,10775600.19554199,true,648.0,648,0.875,7114.581792232194,8130.950619693936,1016.3688274617416,0.0,0.0,648,25047.65856684482,0.0,7114.581792232194,7114.581792232194,1715179.9878326063,700.0,453600.0,10.146392681611328,968751.601234386,6669.137891138753,9996.313112655767,0.0,0.0,310.11761991801,736244.4424332111,125.17988849381992,187.63105235149362,-7114.581792232194,-3098289.0312708793,true,true,3.486968573,6528.901604777997,0.0,121.92,1644.2724500334996,648.0,3.486968573,6528.901604777997,0.0,121.92,0.0,295.15 +649,30580.950619693936,29880.950619693936,0.29250000000000004,8819.237312322106,3549720.9873361816,700.0,454300.0,32544.401067767878,14349046.346633663,23725.16375544577,10799325.359297438,true,649.0,649,0.875,7716.832648281843,8819.237312322106,1102.404664040263,0.0,0.0,649,29880.950619693936,0.0,7716.832648281843,7716.832648281843,1722896.8204808882,700.0,454300.0,31.799028155237433,968783.4002625413,7097.973807226208,17094.286919881975,0.0,0.0,453.8306633125313,736698.2730965237,133.2291495878662,320.86020193935985,-7716.832648281843,-3106005.8639191613,true,true,4.55988198,6533.461486757997,0.0,121.92,1644.2724500334996,649.0,4.55988198,6533.461486757997,0.0,121.92,0.0,295.15 +650,31269.237312322104,30569.237312322104,0.30500000000000005,10714.84204490481,3560435.8293810864,700.0,455000.0,37425.711622638715,14386472.058256302,26710.869577733905,10826036.228875171,true,650.0,650,0.875,9375.486789291708,10714.84204490481,1339.3552556131017,0.0,0.0,650,30569.237312322104,0.0,9375.486789291708,9375.486789291708,1732272.30727018,700.0,455000.0,63.77844162532666,968847.1787041666,8578.361393271975,25672.64831315395,0.0,0.0,572.3308920190467,737270.6039885428,161.01606237536012,481.87626431471995,-9375.486789291708,-3115381.350708453,true,true,5.588090661,6539.049577418997,0.0,121.92,1644.2724500334996,650.0,5.588090661,6539.049577418997,0.0,121.92,0.0,295.15 +651,33164.84204490481,32464.842044904814,0.29250000000000004,8483.79403563534,3568919.623416722,700.0,455700.0,31397.58644661654,14417869.644702919,22913.7924109812,10848950.021286152,true,651.0,651,0.875,7423.319781180922,8483.79403563534,1060.474254454417,0.0,0.0,651,32464.842044904814,0.0,7423.319781180922,7423.319781180922,1739695.627051361,700.0,455700.0,101.46913394708368,968948.6478381136,6531.1217378642295,32203.77005101818,0.0,0.0,668.1395875965949,737938.7435761394,122.58932177301392,604.4655860877339,-7423.319781180922,-3122804.670489634,true,true,6.258661541,6545.308238959997,0.0,121.92,1644.2724500334996,651.0,6.258661541,6545.308238959997,0.0,121.92,0.0,295.15 +652,30933.79403563534,30233.79403563534,0.28625,8287.693613458236,3577207.3170301802,700.0,456400.0,31398.056291557154,14449267.700994477,23110.362678098918,10872060.383964252,true,652.0,652,0.875,7251.731911775956,8287.693613458236,1035.9617016822795,0.0,0.0,652,30233.79403563534,0.0,7251.731911775956,7251.731911775956,1746947.3589631368,700.0,456400.0,137.1510676988913,969085.7989058124,6258.375507469806,38462.14555848799,0.0,0.0,738.7354685425356,738677.479044682,117.46986806472437,721.9354541524582,-7251.731911775956,-3130056.40240141,true,true,6.839822969,6552.148061928997,0.0,121.92,1644.2724500334996,652.0,6.839822969,6552.148061928997,0.0,121.92,0.0,295.15 +653,30737.693613458236,30037.693613458236,0.33999999999999997,14969.34074900109,3592176.6577791814,700.0,457100.0,46086.29632059145,14495353.997315068,31116.95557159036,10903177.339535842,true,653.0,653,0.875,13098.173155375955,14969.34074900109,1871.1675936251359,0.0,0.0,653,30037.693613458236,0.0,13098.173155375955,13098.173155375955,1760045.5321185128,700.0,457100.0,192.4056685897089,969278.2045744022,11856.245143012024,50318.390701500015,0.0,0.0,826.9803197249615,739504.459364407,222.542024049261,944.4774782017191,-13098.173155375955,-3143154.575556786,true,true,7.823326926,6559.971388854997,0.0,121.92,1644.2724500334996,653.0,7.823326926,6559.971388854997,0.0,121.92,0.0,295.15 +654,37419.34074900109,36719.34074900109,0.345,16291.543302128222,3608468.2010813095,700.0,457800.0,49250.8501510963,14544604.847466163,32959.30684896808,10936136.64638481,true,654.0,654,0.875,14255.100389362195,16291.543302128222,2036.4429127660278,0.0,0.0,654,36719.34074900109,0.0,14255.100389362195,14255.100389362195,1774300.6325078749,700.0,457800.0,278.4313035608702,969556.635877963,12800.998592732745,63119.38929423276,0.0,0.0,935.3954226465124,740439.8547870535,240.27507042206602,1184.752548623785,-14255.100389362195,-3157409.675946148,true,true,8.762126157,6568.733515011997,0.0,121.92,1644.2724500334996,654.0,8.762126157,6568.733515011997,0.0,121.92,0.0,295.15 +655,38741.54330212822,38041.54330212822,0.33,12460.49038266961,3620928.691463979,700.0,458500.0,39880.27388687761,14584485.121353041,27419.783504207997,10963556.429889018,true,655.0,655,0.875,10902.929084835909,12460.49038266961,1557.5612978337012,0.0,0.0,655,38041.54330212822,0.0,10902.929084835909,10902.929084835909,1785203.5615927107,700.0,458500.0,364.90047823823903,969921.5363562013,9339.09331283999,72458.48260707274,0.0,0.0,1023.6402738289385,741463.4950608825,175.29501992874089,1360.047568552526,-10902.929084835909,-3168312.605030984,true,true,9.387992311,6578.121507322997,0.0,121.92,1644.2724500334996,655.0,9.387992311,6578.121507322997,0.0,121.92,0.0,295.15 +656,34910.49038266961,34210.49038266961,0.3175,11664.259309707926,3632592.950773687,700.0,459200.0,38942.5490069541,14623427.670359995,27278.28969724617,10990834.719586264,true,656.0,656,0.875,10206.226895994436,11664.259309707926,1458.0324137134903,0.0,0.0,656,34210.49038266961,0.0,10206.226895994436,10206.226895994436,1795409.7884887052,700.0,459200.0,439.58976506777304,970361.1261212691,8517.568559762447,80976.05116683518,0.0,0.0,1089.1935918259985,742552.6886527085,159.87497933821726,1519.9225478907433,-10206.226895994436,-3178518.8319269787,true,true,9.924449014,6588.045956336997,0.0,121.92,1644.2724500334996,656.0,9.924449014,6588.045956336997,0.0,121.92,0.0,295.15 +657,34114.25930970792,33414.25930970792,0.3175,11472.693545475633,3644065.6443191627,700.0,459900.0,38339.19226921459,14661766.86262921,26866.498723738958,11017701.218310004,true,657.0,657,0.875,10038.60685229118,11472.693545475633,1434.086693184454,0.0,0.0,657,33414.25930970792,0.0,10038.60685229118,10038.60685229118,1805448.3953409963,700.0,459900.0,513.6065120969963,970874.732633366,8223.46267058974,89199.51383742492,0.0,0.0,1147.1830653151392,743699.8717180237,154.35460428930247,1674.2771521800457,-10038.60685229118,-3188557.43877927,true,true,10.41620099,6598.462157326997,0.0,121.92,1644.2724500334996,657.0,10.41620099,6598.462157326997,0.0,121.92,0.0,295.15 +658,33922.69354547563,33222.69354547563,0.33,13030.972407286916,3657096.6167264497,700.0,460600.0,41609.007294808835,14703375.86992402,28578.03488752192,11046279.253197527,true,658.0,658,0.875,11402.100856376052,13030.972407286916,1628.8715509108642,0.0,0.0,658,33222.69354547563,0.0,11402.100856376052,11402.100856376052,1816850.4961973724,700.0,460600.0,595.497608516666,971470.2302418827,9424.532002348078,98624.045839773,0.0,0.0,1205.1725391990697,744905.0442572228,176.89870631223778,1851.1758584922836,-11402.100856376052,-3199959.5396356457,true,true,10.9526577,6609.414815026997,0.0,121.92,1644.2724500334996,658.0,10.9526577,6609.414815026997,0.0,121.92,0.0,295.15 +659,35480.972407286914,34780.972407286914,0.30500000000000005,9826.047574678338,3666922.664301128,700.0,461300.0,34511.631392387986,14737887.501316408,24685.58381770965,11070964.837015236,true,659.0,659,0.875,8597.791627843546,9826.047574678338,1228.2559468347918,0.0,0.0,659,34780.972407286914,0.0,8597.791627843546,8597.791627843546,1825448.287825216,700.0,461300.0,673.4174414832393,972143.647683366,6545.9091360577695,105169.95497583077,0.0,0.0,1255.5981686878783,746160.6424259107,122.86688161465955,1974.0427401069433,-8597.791627843546,-3208557.331263489,true,true,11.3102955,6620.725110526997,0.0,121.92,1644.2724500334996,659.0,11.3102955,6620.725110526997,0.0,121.92,0.0,295.15 +660,32276.047574678338,31576.047574678338,0.23500000000000001,5209.595368367851,3672132.2596694957,700.0,462000.0,25147.214333480213,14763034.715649888,19937.618965112364,11090902.455980347,true,660.0,660,0.875,4558.395947321869,5209.595368367851,651.1994210459816,0.0,0.0,660,31576.047574678338,0.0,4558.395947321869,4558.395947321869,1830006.6837725379,700.0,462000.0,719.0344170389658,972862.682100405,2508.9364644717944,107678.89144030257,0.0,0.0,1283.3322643145384,747443.9746902252,47.092801496571106,2021.1355416035144,-4558.395947321869,-3213115.727210811,true,true,11.44440967,6632.169520196997,0.0,121.92,1644.2724500334996,660.0,11.44440967,6632.169520196997,0.0,121.92,0.0,295.15 +661,27659.595368367853,26959.595368367853,0.25,6291.427671015444,3678423.687340511,700.0,462700.0,27965.710684061774,14791000.426333949,21674.28301304633,11112576.738993393,true,661.0,661,0.875,5504.999212138513,6291.427671015444,786.4284588769306,0.0,0.0,661,26959.595368367853,0.0,5504.999212138513,5504.999212138513,1835511.6829846764,700.0,462700.0,749.1097276748961,973611.7918280798,3391.2543195790295,111070.1457598816,0.0,0.0,1300.9812347202192,748744.9559249454,63.65393016436861,2084.7894717678832,-5504.999212138513,-3218620.726422949,true,true,11.62322858,6643.792748776997,0.0,121.92,1644.2724500334996,661.0,11.62322858,6643.792748776997,0.0,121.92,0.0,295.15 +662,28741.427671015445,28041.427671015445,0.196,3379.1792845761915,3681802.8666250873,700.0,463400.0,20812.139207021384,14811812.565540971,17432.959922445192,11130009.69891584,true,662.0,662,0.875,2956.7818740041675,3379.1792845761915,422.397410572024,0.0,0.0,662,28041.427671015445,0.0,2956.7818740041675,2956.7818740041675,1838468.4648586805,700.0,463400.0,771.0978672321098,974382.889695312,856.0286842785162,111926.17444416012,0.0,0.0,1313.5876422334175,750058.5435671789,16.067680260123925,2100.857152028007,-2956.7818740041675,-3221577.5082969535,true,true,11.6679333,6655.460682076997,0.0,121.92,1644.2724500334996,662.0,11.6679333,6655.460682076997,0.0,121.92,0.0,295.15 +663,25829.179284576192,25129.179284576192,0.196,3398.95628555421,3685201.8229106413,700.0,464100.0,20913.042273235766,14832725.607814208,17514.085987681556,11147523.78490352,true,663.0,663,0.875,2974.0867498599337,3398.95628555421,424.86953569427624,0.0,0.0,663,25129.179284576192,0.0,2974.0867498599337,2974.0867498599337,1841442.5516085404,700.0,464100.0,780.0122056389245,975162.9019009509,859.3149750728685,112785.48941923298,0.0,0.0,1318.6302051259001,751377.1737723048,16.129364022240278,2116.9865160502472,-2974.0867498599337,-3224551.5950468136,true,true,11.71263803,6667.1733201069965,0.0,121.92,1644.2724500334996,663.0,11.71263803,6667.1733201069965,0.0,121.92,0.0,295.15 +664,25848.95628555421,25148.95628555421,0.1792,2406.4531551969244,3687608.276065838,700.0,464800.0,17335.118053554266,14850060.725867761,14928.664898357341,11162452.449801877,true,664.0,664,0.875,2105.646510797309,2406.4531551969244,300.8066443996154,0.0,0.0,664,25148.95628555421,0.0,2105.646510797309,2105.646510797309,1843548.1981193377,700.0,464800.0,784.4950239431748,975947.3969248941,0.0,112785.48941923298,0.0,0.0,1321.151486854134,752698.325259159,0.0,2116.9865160502472,-2105.646510797309,-3226657.2415576107,true,true,11.71263803,6678.885958136996,0.0,121.92,1644.2724500334996,664.0,11.71263803,6678.885958136996,0.0,121.92,0.0,295.15 +665,24856.453155196923,24156.453155196923,0.20800000000000002,4435.014845845207,3692043.2909116833,700.0,465500.0,24687.5713742558,14874748.297242017,20252.556528410594,11182705.006330287,true,665.0,665,0.875,3880.6379901145556,4435.014845845207,554.3768557306512,0.0,0.0,665,24156.453155196923,0.0,3880.6379901145556,3880.6379901145556,1847428.8361094522,700.0,465500.0,793.5121203230937,976740.9090452172,1728.488055118332,114513.97747435131,0.0,0.0,1326.1940497466162,754024.5193089056,32.443764926513666,2149.430280976761,-3880.6379901145556,-3230537.8795477254,true,true,11.80204748,6690.688005616996,0.0,121.92,1644.2724500334996,665.0,11.80204748,6690.688005616996,0.0,121.92,0.0,295.15 +666,26885.014845845206,26185.014845845206,0.196,3458.7568917631256,3695502.0478034467,700.0,466200.0,21218.14740695472,14895966.444648972,17759.390515191593,11200464.396845479,true,666.0,666,0.875,3026.412280292735,3458.7568917631256,432.34461147039065,0.0,0.0,666,26185.014845845206,0.0,3026.412280292735,3026.412280292735,1850455.248389745,700.0,466200.0,807.1669070373962,977548.0759522546,869.1730785753125,115383.15055292663,0.0,0.0,1333.7578938033469,755358.2772027089,16.314400876678945,2165.74468185344,-3026.412280292735,-3233564.291828018,true,true,11.8467522,6702.534757816996,0.0,121.92,1644.2724500334996,666.0,11.8467522,6702.534757816996,0.0,121.92,0.0,295.15 +667,25908.756891763125,25208.756891763125,0.1816,2454.8939955807286,3697956.9417990274,700.0,466900.0,17372.764292845422,14913339.208941817,14917.870297264693,11215382.267142743,true,667.0,667,0.875,2148.0322461331375,2454.8939955807286,306.86174944759114,0.0,0.0,667,25208.756891763125,0.0,2148.0322461331375,2148.0322461331375,1852603.280635878,700.0,466900.0,811.7530711655421,978359.8290234201,0.0,115383.15055292663,0.0,0.0,1336.2791749675953,756694.5563776764,0.0,2165.74468185344,-2148.0322461331375,-3235712.3240741515,true,true,11.8467522,6714.381510016996,0.0,121.92,1644.2724500334996,667.0,11.8467522,6714.381510016996,0.0,121.92,0.0,295.15 +668,24904.89399558073,24204.89399558073,0.12,0.0,3697956.9417990274,700.0,467600.0,5833.333333333334,14919172.542275151,5833.333333333334,11221215.600476077,true,668.0,668,0.875,0.0,0.0,0.0,0.0,0.0,668,24204.89399558073,0.0,-2281.292251183721,-2281.292251183721,1850321.9883846943,700.0,467600.0,788.9949839284826,979148.8240073486,-4313.004793045029,111070.1457598816,0.0,0.0,1323.6727680183824,758018.2291456948,-80.95521008555681,2084.7894717678832,-0.0,-3235712.3240741515,true,true,11.62322858,6726.004738596996,0.0,121.92,1644.2724500334996,668.0,11.62322858,6726.004738596996,0.0,121.92,0.0,295.15 +669,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,468300.0,5833.333333333334,14925005.875608485,5833.333333333334,11227048.93380941,true,669.0,669,0.875,0.0,0.0,0.0,0.0,0.0,669,21750.0,0.0,-2267.0428926056675,-2267.0428926056675,1848054.9454920886,700.0,468300.0,744.7628741042208,979893.5868814528,-4230.85251061896,106839.29324926264,0.0,0.0,1298.4599535559707,759316.6890992507,-79.4132096468994,2005.376262120984,-0.0,-3235712.3240741515,true,true,11.39970495,6737.404443546996,0.0,121.92,1644.2724500334996,669.0,11.39970495,6737.404443546996,0.0,121.92,0.0,295.15 +670,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,469000.0,5833.333333333334,14930839.20894182,5833.333333333334,11232882.267142745,true,670.0,670,0.875,0.0,0.0,0.0,0.0,0.0,670,21750.0,0.0,-13732.349015409776,-13732.349015409776,1834322.5964766787,700.0,469000.0,645.4176063110823,980539.0044877639,-15328.008705249164,91511.28454401348,0.0,0.0,1237.9491982821974,760554.6382975329,-287.70711475389254,1717.6691473670915,-0.0,-3235712.3240741515,true,true,10.55031517,6747.954758716996,0.0,121.92,1644.2724500334996,670.0,10.55031517,6747.954758716996,0.0,121.92,0.0,295.15 +671,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,469700.0,5833.333333333334,14936672.542275153,5833.333333333334,11238715.600476079,true,671.0,671,0.875,0.0,0.0,0.0,0.0,0.0,671,21750.0,0.0,-14940.070329157013,-14940.070329157013,1819382.5261475218,700.0,469700.0,496.8598148885372,981035.8643026524,-16266.190000675882,75245.0945433376,0.0,0.0,1134.576658253129,761689.214955786,-305.31680162279815,1412.3523457442934,-0.0,-3235712.3240741515,true,true,9.566811212,6757.5215699289965,0.0,121.92,1644.2724500334996,671.0,9.566811212,6757.5215699289965,0.0,121.92,0.0,295.15 +672,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,470400.0,5833.333333333334,14942505.875608487,5833.333333333334,11244548.933809413,true,672.0,672,0.875,0.0,0.0,0.0,0.0,0.0,672,21750.0,0.0,-18016.235079067,-18016.235079067,1801366.2910684547,700.0,470400.0,346.3498619601361,981382.2141646126,-19011.725668414034,56233.36887492357,0.0,0.0,1005.991303592453,762695.2062593785,-356.8505762055545,1055.501769538739,-0.0,-3235712.3240741515,true,true,8.270374179,6765.791944107997,0.0,121.92,1644.2724500334996,672.0,8.270374179,6765.791944107997,0.0,121.92,0.0,295.15 +673,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,471100.0,5833.333333333334,14948339.208941821,5833.333333333334,11250382.267142747,true,673.0,673,0.875,0.0,0.0,0.0,0.0,0.0,673,21750.0,0.0,-11156.23124825878,-11156.23124825878,1790210.059820196,700.0,471100.0,231.77821434011472,981613.9923789527,-12041.909739762634,44191.45913516094,0.0,0.0,879.9272304344171,763575.1334898128,-226.02695327067863,829.4748162680603,-0.0,-3235712.3240741515,true,true,7.331574947,6773.123519054997,0.0,121.92,1644.2724500334996,673.0,7.331574947,6773.123519054997,0.0,121.92,0.0,295.15 +674,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,471800.0,5833.333333333334,14954172.542275155,5833.333333333334,11256215.60047608,true,674.0,674,0.875,0.0,0.0,0.0,0.0,0.0,674,21750.0,0.0,-8887.460924806332,-8887.460924806332,1781322.5988953896,700.0,471800.0,160.8687806667652,981774.8611596194,-9646.343562422926,34545.11557273802,0.0,0.0,779.0759719079883,764354.2094617208,-181.062114958159,648.4127013099013,-0.0,-3235712.3240741515,true,true,6.482185167,6779.605704221997,0.0,121.92,1644.2724500334996,674.0,6.482185167,6779.605704221997,0.0,121.92,0.0,295.15 +675,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,472500.0,5833.333333333334,14960005.875608489,5833.333333333334,11262048.933809415,true,675.0,675,0.875,0.0,0.0,0.0,0.0,0.0,675,21750.0,0.0,-11914.67240123873,-11914.67240123873,1769407.926494151,700.0,472500.0,96.94331218857396,981871.804471808,-12436.241602774991,22108.873969963024,0.0,0.0,658.0544617552316,765012.263923476,-233.42857240754407,414.98412890235727,-0.0,-3235712.3240741515,true,true,5.185748134,6784.7914523559975,0.0,121.92,1644.2724500334996,675.0,5.185748134,6784.7914523559975,0.0,121.92,0.0,295.15 +676,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,473200.0,5833.333333333334,14965839.208941823,5833.333333333334,11267882.267142748,true,676.0,676,0.875,0.0,0.0,0.0,0.0,0.0,676,21750.0,0.0,-9296.755224816934,-9296.755224816934,1760111.171269334,700.0,473200.0,45.61255977977984,981917.4170315878,-9672.632365056386,12436.241604906638,0.0,0.0,511.8201369144692,765524.0840603905,-181.55555645479774,233.42857244755953,-0.0,-3235712.3240741515,true,true,3.8893111,6788.680763455997,0.0,121.92,1644.2724500334996,676.0,3.8893111,6788.680763455997,0.0,121.92,0.0,295.15 +677,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,473900.0,5833.333333333334,14971672.542275157,5833.333333333334,11273715.600476082,true,677.0,677,0.875,0.0,0.0,0.0,0.0,0.0,677,21750.0,0.0,-6656.497187584309,-6656.497187584309,1753454.6740817495,700.0,473900.0,16.62265297987032,981934.0396845677,-6909.023112415919,5527.218492490719,0.0,0.0,365.5858120737068,765889.6698724641,-129.68254022196757,103.74603222559196,-0.0,-3235712.3240741515,true,true,2.592874067,6791.273637522997,0.0,121.92,1644.2724500334996,677.0,2.592874067,6791.273637522997,0.0,121.92,0.0,295.15 +678,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,474600.0,5833.333333333334,14977505.87560849,5833.333333333334,11279548.933809416,true,678.0,678,0.875,0.0,0.0,0.0,0.0,0.0,678,21750.0,0.0,-3341.5848588463828,-3341.5848588463828,1750113.0892229031,700.0,474600.0,4.385763182919641,981938.4254477506,-3514.482864945313,2012.7356275454058,0.0,0.0,234.4791760231884,766124.1490484873,-65.96693310717784,37.77909911841412,-0.0,-3235712.3240741515,true,true,1.564665385,6792.838302907997,0.0,121.92,1644.2724500334996,678.0,1.564665385,6792.838302907997,0.0,121.92,0.0,295.15 +679,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,475300.0,5833.333333333334,14983339.208941825,5833.333333333334,11285382.26714275,true,679.0,679,0.875,0.0,0.0,0.0,0.0,0.0,679,21750.0,0.0,-1241.3812556145165,-1241.3812556145165,1748871.7079672886,700.0,475300.0,0.9071610610549482,981939.3326088117,-1355.5158303758806,657.2197971695252,0.0,0.0,138.6704804456404,766262.8195289329,-25.443066745331166,12.336032373082958,-0.0,-3235712.3240741515,true,true,0.894094506,6793.732397413997,0.0,121.92,1644.2724500334996,679.0,0.894094506,6793.732397413997,0.0,121.92,0.0,295.15 +680,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,476000.0,5833.333333333334,14989172.542275159,5833.333333333334,11291215.600476084,true,680.0,680,0.875,0.0,0.0,0.0,0.0,0.0,680,21750.0,0.0,-619.0865802133671,-619.0865802133671,1748252.6213870752,700.0,476000.0,0.043620066072829394,981939.3762288777,-657.2197971695749,-4.9681148084346205e-11,0.0,0.0,50.425629263214425,766313.2451581961,-12.336032373079432,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,680.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +681,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,476700.0,5833.333333333334,14995005.875608493,5833.333333333334,11297048.933809418,true,681.0,681,0.875,0.0,0.0,0.0,0.0,0.0,681,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,476700.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,681.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +682,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,477400.0,5833.333333333334,15000839.208941827,5833.333333333334,11302882.267142752,true,682.0,682,0.875,0.0,0.0,0.0,0.0,0.0,682,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,477400.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,682.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +683,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,478100.0,5833.333333333334,15006672.54227516,5833.333333333334,11308715.600476086,true,683.0,683,0.875,0.0,0.0,0.0,0.0,0.0,683,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,478100.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,683.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +684,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,478800.0,5833.333333333334,15012505.875608495,5833.333333333334,11314548.93380942,true,684.0,684,0.875,0.0,0.0,0.0,0.0,0.0,684,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,478800.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,684.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +685,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,479500.0,5833.333333333334,15018339.208941828,5833.333333333334,11320382.267142754,true,685.0,685,0.875,0.0,0.0,0.0,0.0,0.0,685,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,479500.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,685.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +686,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,480200.0,5833.333333333334,15024172.542275162,5833.333333333334,11326215.600476088,true,686.0,686,0.875,0.0,0.0,0.0,0.0,0.0,686,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,480200.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,686.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +687,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,480900.0,5833.333333333334,15030005.875608496,5833.333333333334,11332048.933809422,true,687.0,687,0.875,0.0,0.0,0.0,0.0,0.0,687,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,480900.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,687.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +688,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,481600.0,5833.333333333334,15035839.20894183,5833.333333333334,11337882.267142756,true,688.0,688,0.875,0.0,0.0,0.0,0.0,0.0,688,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,481600.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,688.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +689,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,482300.0,5833.333333333334,15041672.542275164,5833.333333333334,11343715.60047609,true,689.0,689,0.875,0.0,0.0,0.0,0.0,0.0,689,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,482300.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,689.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +690,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,483000.0,5833.333333333334,15047505.875608498,5833.333333333334,11349548.933809424,true,690.0,690,0.875,0.0,0.0,0.0,0.0,0.0,690,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,483000.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,690.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +691,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,483700.0,5833.333333333334,15053339.208941832,5833.333333333334,11355382.267142758,true,691.0,691,0.875,0.0,0.0,0.0,0.0,0.0,691,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,483700.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,691.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +692,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,484400.0,5833.333333333334,15059172.542275166,5833.333333333334,11361215.600476092,true,692.0,692,0.875,0.0,0.0,0.0,0.0,0.0,692,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,484400.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,692.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +693,22450.0,21750.0,0.12,0.0,3697956.9417990274,700.0,485100.0,5833.333333333334,15065005.8756085,5833.333333333334,11367048.933809426,true,693.0,693,0.875,0.0,0.0,0.0,0.0,0.0,693,21750.0,0.0,0.0,0.0,1748252.6213870752,700.0,485100.0,0.0,981939.3762288777,0.0,-4.9681148084346205e-11,0.0,0.0,0.0,766313.2451581961,0.0,3.526068326209497e-12,-0.0,-3235712.3240741515,true,true,0.0,6793.732397413997,0.0,121.92,1644.2724500334996,693.0,0.0,6793.732397413997,0.0,121.92,0.0,295.15 +694,22450.0,21750.0,0.132,415.3088667678144,3698372.250665795,700.0,485800.0,8449.309596725867,15073455.185205227,8034.000729958052,11375082.934539383,true,694.0,694,0.875,363.3952584218376,415.3088667678144,51.9136083459768,0.0,0.0,694,21750.0,0.0,363.3952584218376,363.3952584218376,1748616.016645497,700.0,485800.0,0.014961682648637148,981939.3911905603,322.0377004072729,322.0377004072232,0.0,0.0,35.29794047297039,766348.543098669,6.044655858945696,6.044655858949222,-363.3952584218376,-3236075.7193325735,true,true,0.625866154,6794.358263567997,0.0,121.92,1644.2724500334996,694.0,0.625866154,6794.358263567997,0.0,121.92,0.0,295.15 +695,22865.308866767813,22165.308866767813,0.1696,1844.3996736441163,3700216.650339439,700.0,486500.0,15002.356566297856,15088457.541771526,13157.95689265374,11388240.891432038,true,695.0,695,0.875,1613.8497144386017,1844.3996736441163,230.5499592055146,0.0,0.0,695,22165.308866767813,0.0,1613.8497144386017,1613.8497144386017,1750229.8663599356,700.0,486500.0,0.5660957649040933,981939.9572863252,1467.2431976294674,1789.2808980366906,0.0,0.0,118.50022876291405,766467.0433274319,27.540192281316145,33.584848140265365,-1613.8497144386017,-3237689.569047012,true,true,1.475255935,6795.833519502997,0.0,121.92,1644.2724500334996,695.0,1.475255935,6795.833519502997,0.0,121.92,0.0,295.15 +696,24294.399673644115,23594.399673644115,0.1696,1845.0427322983046,3702061.6930717374,700.0,487200.0,15006.148185721135,15103463.689957246,13161.10545342283,11401401.99688546,true,696.0,696,0.875,1614.4123907610165,1845.0427322983046,230.63034153728813,0.0,0.0,696,23594.399673644115,0.0,1614.4123907610165,1614.4123907610165,1751844.2787506967,700.0,487200.0,2.489249952836435,981942.446536278,1391.6629196171434,3180.9438176538342,0.0,0.0,194.1386726577357,766661.1820000897,26.121548533301038,59.7063966735664,-1614.4123907610165,-3239303.981437773,true,true,1.967007913,6797.800527415997,0.0,121.92,1644.2724500334996,696.0,1.967007913,6797.800527415997,0.0,121.92,0.0,295.15 +697,24295.042732298305,23595.042732298305,0.22,4701.0446497637795,3706762.7377215014,700.0,487900.0,24550.202953471726,15128013.892910717,19849.158303707947,11421251.155189168,true,697.0,697,0.875,4113.414068543307,4701.0446497637795,587.6305812204728,0.0,0.0,697,23595.042732298305,0.0,4113.414068543307,4113.414068543307,1755957.69281924,700.0,487900.0,7.061156315235682,981949.5076925933,3760.940287560783,6941.884105214617,0.0,0.0,274.81967944503964,766936.0016795347,70.5929452222476,130.299341895814,-4113.414068543307,-3243417.3955063163,true,true,2.905807144,6800.706334559997,0.0,121.92,1644.2724500334996,697.0,2.905807144,6800.706334559997,0.0,121.92,0.0,295.15 +698,27151.04464976378,26451.04464976378,0.29250000000000004,8585.78253150512,3715348.5202530064,700.0,488600.0,31746.265064974763,15159760.157975692,23160.482533469643,11444411.637722638,true,698.0,698,0.875,7512.559715066979,8585.78253150512,1073.2228164381404,0.0,0.0,698,26451.04464976378,0.0,7512.559715066979,7512.559715066979,1763470.252534307,700.0,488600.0,21.10062353442648,981970.6083161277,6964.886798835968,13906.770904050585,0.0,0.0,395.84118965419486,767331.8428691889,130.7311030423896,261.0304449382036,-7512.559715066979,-3250929.9552213834,true,true,4.112834727,6804.819169286997,0.0,121.92,1644.2724500334996,698.0,4.112834727,6804.819169286997,0.0,121.92,0.0,295.15 +699,31035.78253150512,30335.78253150512,0.29250000000000004,8879.921545173249,3724228.4417981794,700.0,489300.0,32751.86853050683,15192512.026506199,23871.94698533358,11468283.584707972,true,699.0,699,0.875,7769.931352026593,8879.921545173249,1109.9901931466557,0.0,0.0,699,30335.78253150512,0.0,7769.931352026593,7769.931352026593,1771240.1838863336,700.0,489300.0,46.97404019264503,982017.5823563203,7073.328063619489,20980.098967670074,0.0,0.0,516.86269986335,767848.7055690523,132.7665483511102,393.7969932893138,-7769.931352026593,-3258699.88657341,true,true,5.051633958,6809.870803244997,0.0,121.92,1644.2724500334996,699.0,5.051633958,6809.870803244997,0.0,121.92,0.0,295.15 +700,31329.92154517325,30629.92154517325,0.3175,11247.07014279289,3735475.5119409724,700.0,490000.0,37628.56737887525,15230140.593885073,26381.497236082356,11494665.081944054,true,700.0,700,0.875,9841.18637494378,11247.07014279289,1405.8837678491109,0.0,0.0,700,30629.92154517325,0.0,9841.18637494378,9841.18637494378,1781081.3702612773,700.0,490000.0,83.1670648020317,982100.7494211224,8964.478025983519,29944.576993653594,0.0,0.0,625.2778027285024,768473.9833717807,168.26348142972716,562.0604747190409,-9841.18637494378,-3268541.072948354,true,true,6.035137914,6815.905941158997,0.0,121.92,1644.2724500334996,700.0,6.035137914,6815.905941158997,0.0,121.92,0.0,295.15 +701,33697.07014279289,32997.07014279289,0.265,6861.089412511706,3742336.601353484,700.0,490700.0,28532.41287740266,15258673.006762477,21671.323464890957,11516336.405408945,true,701.0,701,0.875,6003.4532359477425,6861.089412511706,857.6361765639631,0.0,0.0,701,32997.07014279289,0.0,6003.4532359477425,6003.4532359477425,1787084.823497225,700.0,490700.0,120.98047671048755,982221.7298978328,5078.665978195433,35023.24297184903,0.0,0.0,708.4800909620475,769182.4634627427,95.32669007977408,657.387164798815,-6003.4532359477425,-3274544.5261843014,true,true,6.526889892,6822.432831050997,0.0,121.92,1644.2724500334996,701.0,6.526889892,6822.432831050997,0.0,121.92,0.0,295.15 +702,29311.089412511705,28611.089412511705,0.3175,11753.52770461908,3754090.129058103,700.0,491400.0,39223.70930588687,15297896.716068363,27470.18160126779,11543806.587010212,true,702.0,702,0.875,10284.336741541696,11753.52770461908,1469.1909630773844,0.0,0.0,702,28611.089412511705,0.0,10284.336741541696,10284.336741541696,1797369.1602387668,700.0,491400.0,162.43567340630506,982384.1655712392,9168.216163311916,44191.45913516095,0.0,0.0,781.5972533542295,769964.060716097,172.08765146924523,829.4748162680602,-10284.336741541696,-3284828.862925843,true,true,7.331574947,6829.7644059979975,0.0,121.92,1644.2724500334996,702.0,7.331574947,6829.7644059979975,0.0,121.92,0.0,295.15 +703,34203.52770461908,33503.52770461908,0.1912,3079.37147277558,3757169.5005308785,700.0,492100.0,19766.5872007091,15317663.303269072,16687.21572793352,11560493.802738145,true,703.0,703,0.875,2694.4500386786326,3079.37147277558,384.92143409694745,0.0,0.0,703,33503.52770461908,0.0,2694.4500386786326,2694.4500386786326,1800063.6102774455,700.0,492100.0,197.73352701896206,982581.8990982581,1631.548147215881,45823.00728237683,0.0,0.0,834.544164063685,770798.6048801607,30.624200380104874,860.099016648165,-2694.4500386786326,-3287523.3129645213,true,true,7.465689123,6837.230095120997,0.0,121.92,1644.2724500334996,703.0,7.465689123,6837.230095120997,0.0,121.92,0.0,295.15 +704,25529.37147277558,24829.37147277558,0.12,0.0,3757169.5005308785,700.0,492800.0,5833.333333333334,15323496.636602405,5833.333333333334,11566327.136071479,true,704.0,704,0.875,0.0,0.0,0.0,0.0,0.0,704,24829.37147277558,0.0,-74.86613013470463,-74.86613013470463,1799988.7441473107,700.0,492800.0,199.53109361148717,982781.4301918696,-1090.984855715592,44732.022426661235,0.0,0.0,837.0654455663247,771635.670325727,-20.477813596924506,839.6212030512405,-0.0,-3287523.3129645213,true,true,7.376279673,6844.606374793997,0.0,121.92,1644.2724500334996,704.0,7.376279673,6844.606374793997,0.0,121.92,0.0,295.15 +705,22450.0,21750.0,0.15600000000000003,1174.8224821276701,3758344.3230130062,700.0,493500.0,12018.09283415173,15335514.729436558,10843.27035202406,11577170.406423504,true,705.0,705,0.875,1027.9696718617113,1174.8224821276701,146.85281026595885,0.0,0.0,705,21750.0,0.0,1027.9696718617113,1027.9696718617113,1801016.7138191725,700.0,493500.0,195.94678918786877,982977.3769810575,0.0,44732.022426661235,0.0,0.0,832.0228826738424,772467.6932084009,0.0,839.6212030512405,-1027.9696718617113,-3288551.282636383,true,true,7.376279673,6851.982654466997,0.0,121.92,1644.2724500334996,705.0,7.376279673,6851.982654466997,0.0,121.92,0.0,295.15 +706,23624.82248212767,22924.82248212767,0.33,12545.114903487829,3770889.437916494,700.0,494200.0,40136.711828750995,15375651.44126531,27591.596925263166,11604762.003348766,true,706.0,706,0.875,10976.97554055185,12545.114903487829,1568.139362935979,0.0,0.0,706,22924.82248212767,0.0,10976.97554055185,10976.97554055185,1811993.6893597243,700.0,494200.0,227.8162801021545,983205.1932611596,9692.348955546064,54424.3713822073,0.0,0.0,874.8846675419347,773342.5778759428,181.92563736169512,1021.5468404129356,-10976.97554055185,-3299528.258176935,true,true,8.136260003,6860.1189144699965,0.0,121.92,1644.2724500334996,706.0,8.136260003,6860.1189144699965,0.0,121.92,0.0,295.15 +707,34995.11490348783,34295.11490348783,0.29250000000000004,8558.33913008814,3779447.777046582,700.0,494900.0,31652.4414703868,15407303.882735696,23094.10234029866,11627856.105689064,true,707.0,707,0.875,7488.546738827123,8558.33913008814,1069.7923912610167,0.0,0.0,707,34295.11490348783,0.0,7488.546738827123,7488.546738827123,1819482.2360985514,700.0,494900.0,285.2404667598656,983490.4337279195,6145.005102359405,60569.3764845667,0.0,0.0,942.9592670416345,774285.5371429845,115.34190266621687,1136.8887430791524,-7488.546738827123,-3307016.804915762,true,true,8.583307256,6868.702221725996,0.0,121.92,1644.2724500334996,707.0,8.583307256,6868.702221725996,0.0,121.92,0.0,295.15 +708,31008.33913008814,30308.33913008814,0.28625,8276.994130063078,3787724.771176645,700.0,495600.0,31360.678183626474,15438664.560919322,23083.684053563396,11650939.789742626,true,708.0,708,0.875,7242.369863805193,8276.994130063078,1034.6242662578852,0.0,0.0,708,30308.33913008814,0.0,7242.369863805193,7242.369863805193,1826724.6059623566,700.0,495600.0,330.95883788694795,983821.3925658064,5811.466045071076,66380.84252963778,0.0,0.0,990.863614802209,775276.4007577867,109.08136604495968,1245.970109124112,-7242.369863805193,-3314259.1747795674,true,true,8.985649783,6877.687871508996,0.0,121.92,1644.2724500334996,708.0,8.985649783,6877.687871508996,0.0,121.92,0.0,295.15 +709,30726.994130063078,30026.994130063078,0.33,12788.70753900957,3800513.4787156545,700.0,496300.0,40874.87133033203,15479539.432249654,28086.163791322462,11679025.95353395,true,709.0,709,0.875,11190.119096633374,12788.70753900957,1598.5884423761963,0.0,0.0,709,30026.994130063078,0.0,11190.119096633374,11190.119096633374,1837914.7250589898,700.0,496300.0,392.5331357196344,984213.925701526,9569.120241261311,75949.96277089909,0.0,0.0,1048.853088404147,776325.2538461909,179.6126312482815,1425.5827403723936,-11190.119096633374,-3325449.293876201,true,true,9.611515937,6887.299387445996,0.0,121.92,1644.2724500334996,709.0,9.611515937,6887.299387445996,0.0,121.92,0.0,295.15 +710,35238.70753900957,34538.70753900957,0.30500000000000005,10215.936491194336,3810729.4152068486,700.0,497000.0,35789.955708833884,15515329.387958487,25574.01921763955,11704599.97275159,true,710.0,710,0.875,8938.944429795043,10215.936491194336,1276.9920613992927,0.0,0.0,710,34538.70753900957,0.0,8938.944429795043,8938.944429795043,1846853.6694887849,700.0,497000.0,464.4664631892949,984678.3921647153,7229.417767027643,83179.38053792673,0.0,0.0,1109.3638435087248,777434.6176896996,135.69635606938056,1561.279096441774,-8938.944429795043,-3334388.238305996,true,true,10.05856319,6897.3579506359965,0.0,121.92,1644.2724500334996,710.0,10.05856319,6897.3579506359965,0.0,121.92,0.0,295.15 +711,32665.936491194334,31965.936491194334,0.1696,1864.4988261493472,3812593.914032998,700.0,497700.0,15120.865720220208,15530450.253678707,13256.366894070861,11717856.33964566,true,711.0,711,0.875,1631.4364728806788,1864.4988261493472,233.0623532686684,0.0,0.0,711,31965.936491194334,0.0,1631.4364728806788,1631.4364728806788,1848485.1059616655,700.0,497700.0,496.8598147403471,985175.2519794557,0.0,83179.38053792673,0.0,0.0,1134.5766581403318,778569.1943478399,0.0,1561.279096441774,-1631.4364728806788,-3336019.674778877,true,true,10.05856319,6907.416513825997,0.0,121.92,1644.2724500334996,711.0,10.05856319,6907.416513825997,0.0,121.92,0.0,295.15 +712,24314.49882614935,23614.49882614935,0.12,0.0,3812593.914032998,700.0,498400.0,5833.333333333334,15536283.587012041,5833.333333333334,11723689.672978994,true,712.0,712,0.875,0.0,0.0,0.0,0.0,0.0,712,23614.49882614935,0.0,-1377.999818492709,-1377.999818492709,1847107.1061431728,700.0,498400.0,483.72764490970684,985658.9796243655,-2931.2002913922315,80248.1802465345,0.0,0.0,1124.4915322989687,779693.6858801389,-55.01870430915308,1506.260392132621,-0.0,-3336019.674778877,true,true,9.879744289,6917.296258114997,0.0,121.92,1644.2724500334996,712.0,9.879744289,6917.296258114997,0.0,121.92,0.0,295.15 +713,22450.0,21750.0,0.265,6993.387053930591,3819587.3010869287,700.0,499100.0,29031.649260115435,15565315.236272156,22038.262206184845,11745727.93518518,true,713.0,713,0.875,6119.213672189267,6993.387053930591,874.1733817413242,0.0,0.0,713,21750.0,0.0,6119.213672189267,6119.213672189267,1853226.319815362,700.0,499100.0,490.2644171039799,986149.2440414694,4416.517022616339,84664.69726915084,0.0,0.0,1129.5340951914511,780823.2199753303,82.8981372774962,1589.1585294101174,-6119.213672189267,-3342138.888451066,true,true,10.14797264,6927.444230754997,0.0,121.92,1644.2724500334996,713.0,10.14797264,6927.444230754997,0.0,121.92,0.0,295.15 +714,29443.38705393059,28743.38705393059,0.28,7211.942865069134,3826799.2439519977,700.0,499800.0,28256.938803818335,15593572.175075974,21044.9959387492,11766772.93112393,true,714.0,714,0.875,6310.450006935493,7211.942865069134,901.4928581336417,0.0,0.0,714,28743.38705393059,0.0,6310.450006935493,6310.450006935493,1859536.7698222976,700.0,499800.0,530.7253432887172,986679.9693847582,4534.816568274103,89199.51383742495,0.0,0.0,1159.7894726027434,781983.0094479331,85.11862276992896,1674.2771521800464,-6310.450006935493,-3348449.338458001,true,true,10.41620099,6937.860431744997,0.0,121.92,1644.2724500334996,714.0,10.41620099,6937.860431744997,0.0,121.92,0.0,295.15 +715,29661.942865069133,28961.942865069133,0.196,3777.8515111325114,3830577.09546313,700.0,500500.0,22846.181179247505,15616418.356255222,19068.329668114995,11785841.260792045,true,715.0,715,0.875,3305.6200722409476,3777.8515111325114,472.2314388915638,0.0,0.0,715,28961.942865069133,0.0,3305.6200722409476,3305.6200722409476,1862842.3898945386,700.0,500500.0,558.8997182313515,987238.8691029896,1537.89431429198,90737.40815171693,0.0,0.0,1179.9597241726726,783162.9691721058,28.86631554494378,1703.1434677249902,-3305.6200722409476,-3351754.958530242,true,true,10.50561044,6948.366042184997,0.0,121.92,1644.2724500334996,715.0,10.50561044,6948.366042184997,0.0,121.92,0.0,295.15 +716,26227.85151113251,25527.85151113251,0.12,0.0,3830577.09546313,700.0,501200.0,5833.333333333334,15622251.689588556,5833.333333333334,11791674.594125379,true,716.0,716,0.875,0.0,0.0,0.0,0.0,0.0,716,25527.85151113251,0.0,-6009.377169181946,-6009.377169181946,1856833.0127253565,700.0,501200.0,530.7253432887172,987769.5944462783,-7558.027613790191,83179.38053792673,0.0,0.0,1159.7894726027434,784322.7586447085,-141.8643712832159,1561.2790964417743,-0.0,-3351754.958530242,true,true,10.05856319,6958.424605374998,0.0,121.92,1644.2724500334996,716.0,10.05856319,6958.424605374998,0.0,121.92,0.0,295.15 +717,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,501900.0,5833.333333333334,15628085.02292189,5833.333333333334,11797507.927458713,true,717.0,717,0.875,0.0,0.0,0.0,0.0,0.0,717,21750.0,0.0,-5064.142097820055,-5064.142097820055,1851768.8706275364,700.0,501900.0,467.6404827977933,988237.234929076,-6521.26342464699,76658.11711327973,0.0,0.0,1111.8851250113644,785434.6437697199,-122.40428098222273,1438.8748154595517,-0.0,-3351754.958530242,true,true,9.656220663,6968.080826037997,0.0,121.92,1644.2724500334996,717.0,9.656220663,6968.080826037997,0.0,121.92,0.0,295.15 +718,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,502600.0,5833.333333333334,15633918.356255224,5833.333333333334,11803341.260792047,true,718.0,718,0.875,0.0,0.0,0.0,0.0,0.0,718,21750.0,0.0,-6283.465355440145,-6283.465355440145,1845485.4052720964,700.0,502600.0,406.8577746052386,988644.0927036813,-7608.962210823534,69049.1549024562,0.0,0.0,1061.4594957481497,786496.103265468,-142.8204149699991,1296.0544004895526,-0.0,-3351754.958530242,true,true,9.164468684,6977.245294721997,0.0,121.92,1644.2724500334996,718.0,9.164468684,6977.245294721997,0.0,121.92,0.0,295.15 +719,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,503300.0,5833.333333333334,15639751.689588558,5833.333333333334,11809174.59412538,true,719.0,719,0.875,0.0,0.0,0.0,0.0,0.0,719,21750.0,0.0,-14829.337529999224,-14829.337529999224,1830656.0677420972,700.0,503300.0,311.1562438876115,988955.2489475689,-15814.351358183105,53234.80354427309,0.0,0.0,970.6933630630843,787466.7966285311,-296.8357787668156,999.218621722737,-0.0,-3351754.958530242,true,true,8.046850552,6985.292145273997,0.0,121.92,1644.2724500334996,719.0,8.046850552,6985.292145273997,0.0,121.92,0.0,295.15 +720,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,504000.0,5833.333333333334,15645585.022921892,5833.333333333334,11815007.927458715,true,720.0,720,0.875,0.0,0.0,0.0,0.0,0.0,720,21750.0,0.0,-15543.537104922045,-15543.537104922045,1815112.530637175,700.0,504000.0,195.94678914802216,989151.195736717,-16266.189975536578,36968.61356873652,0.0,0.0,832.022882617444,788298.8195111485,-305.31680115093235,693.9018205718046,-0.0,-3351754.958530242,true,true,6.705708793,6991.997854066997,0.0,121.92,1644.2724500334996,720.0,6.705708793,6991.997854066997,0.0,121.92,0.0,295.15 +721,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,504700.0,5833.333333333334,15651418.356255226,5833.333333333334,11820841.260792049,true,721.0,721,0.875,0.0,0.0,0.0,0.0,0.0,721,21750.0,0.0,-12770.437819891076,-12770.437819891076,1802342.092817284,700.0,504700.0,107.32171998391497,989258.5174567009,-13308.700879452681,23659.912689283836,0.0,0.0,680.7459948841991,788979.5655060327,-249.80465530650835,444.0971652652962,-0.0,-3351754.958530242,true,true,5.364567035,6997.362421101997,0.0,121.92,1644.2724500334996,721.0,5.364567035,6997.362421101997,0.0,121.92,0.0,295.15 +722,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,505400.0,5833.333333333334,15657251.68958856,5833.333333333334,11826674.594125383,true,722.0,722,0.875,0.0,0.0,0.0,0.0,0.0,722,21750.0,0.0,-9965.539526943972,-9965.539526943972,1792376.55329034,700.0,505400.0,50.49567895528665,989309.0131356562,-10351.211803215605,13308.70088606823,0.0,0.0,529.4691071509544,789509.0346131836,-194.29250983460938,249.80465543068684,-0.0,-3351754.958530242,true,true,4.023425276,7001.385846377997,0.0,121.92,1644.2724500334996,722.0,4.023425276,7001.385846377997,0.0,121.92,0.0,295.15 +723,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,506100.0,5833.333333333334,15663085.022921894,5833.333333333334,11832507.927458717,true,723.0,723,0.875,0.0,0.0,0.0,0.0,0.0,723,21750.0,0.0,-6721.691077958786,-6721.691077958786,1785654.862212381,700.0,506100.0,19.1481621108603,989328.1612977671,-6992.818638003123,6315.882248065108,0.0,0.0,383.234782310192,789892.2693954938,-131.2553843767157,118.54927105397113,-0.0,-3351754.958530242,true,true,2.771692968,7004.157539345997,0.0,121.92,1644.2724500334996,723.0,2.771692968,7004.157539345997,0.0,121.92,0.0,295.15 +724,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,506800.0,5833.333333333334,15668918.356255228,5833.333333333334,11838341.26079205,true,724.0,724,0.875,0.0,0.0,0.0,0.0,0.0,724,21750.0,0.0,-2768.3484601775813,-2768.3484601775813,1782886.5137522034,700.0,506800.0,6.679557070649019,989334.8408548377,-2988.7070265480925,3327.1752215170154,0.0,0.0,269.7771164961588,790162.0465119899,-56.098107196296795,62.45116385767433,-0.0,-3351754.958530242,true,true,2.011712638,7006.169251983997,0.0,121.92,1644.2724500334996,724.0,2.011712638,7006.169251983997,0.0,121.92,0.0,295.15 +725,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,507500.0,5833.333333333334,15674751.689588562,5833.333333333334,11844174.594125384,true,725.0,725,0.875,0.0,0.0,0.0,0.0,0.0,725,21750.0,0.0,-1691.7293822741349,-1691.7293822741349,1781194.7843699292,700.0,507500.0,2.300276920780265,989337.1411317585,-1848.430677885528,1478.7445436314874,0.0,0.0,189.09610970885484,790351.1426216988,-34.69509101824212,27.756072839432214,-0.0,-3351754.958530242,true,true,1.341141759,7007.510393742997,0.0,121.92,1644.2724500334996,725.0,1.341141759,7007.510393742997,0.0,121.92,0.0,295.15 +726,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,508200.0,5833.333333333334,15680585.022921896,5833.333333333334,11850007.927458718,true,726.0,726,0.875,0.0,0.0,0.0,0.0,0.0,726,21750.0,0.0,-639.0066795949109,-639.0066795949109,1780555.7776903342,700.0,508200.0,0.7232806727928487,989337.8644124313,-754.15971771518,724.5848259163074,0.0,0.0,128.58535460427723,790479.7279763031,-14.155597156800908,13.600475682631306,-0.0,-3351754.958530242,true,true,0.938799231,7008.449192973997,0.0,121.92,1644.2724500334996,726.0,0.938799231,7008.449192973997,0.0,121.92,0.0,295.15 +727,22450.0,21750.0,0.12,0.0,3830577.09546313,700.0,508900.0,5833.333333333334,15686418.35625523,5833.333333333334,11855841.260792052,true,727.0,727,0.875,0.0,0.0,0.0,0.0,0.0,727,21750.0,0.0,-630.688911157768,-630.688911157768,1779925.0887791766,700.0,508900.0,0.09583328496412666,989337.9602457163,-683.5085887770323,41.07623713927512,0.0,0.0,65.55331799705992,790545.2812943001,-12.829473662759659,0.7710020198716467,-0.0,-3351754.958530242,true,true,0.223523626,7008.672716599997,0.0,121.92,1644.2724500334996,727.0,0.223523626,7008.672716599997,0.0,121.92,0.0,295.15 +728,22450.0,21750.0,0.12,28.820876666778496,3830605.916339797,700.0,509600.0,6073.507305556488,15692491.863560786,6044.6864288897095,11861885.947220942,true,728.0,728,0.875,25.218267083431183,28.820876666778496,3.602609583347313,0.0,0.0,728,21750.0,0.0,25.218267083431183,25.218267083431183,1779950.30704626,700.0,509600.0,0.0054525082225135284,989337.9656982245,0.0,41.07623713927512,0.0,0.0,25.212814575208668,790570.4941088753,0.0,0.7710020198716467,-25.218267083431183,-3351780.1767973257,true,true,0.223523626,7008.896240225998,0.0,121.92,1644.2724500334996,728.0,0.223523626,7008.896240225998,0.0,121.92,0.0,295.15 +729,22478.820876666778,21778.820876666778,0.17200000000000001,2018.0334662941502,3832623.949806091,700.0,510300.0,15802.520152872967,15708294.383713659,13784.486686578817,11875670.43390752,true,729.0,729,0.875,1765.7792830073815,2018.0334662941502,252.2541832867687,0.0,0.0,729,21778.820876666778,0.0,1765.7792830073815,1765.7792830073815,1781716.0863292674,700.0,510300.0,0.2761859002973675,989338.2418841248,1641.4064422034514,1682.4826793427264,0.0,0.0,93.2874140749083,790663.7815229502,30.809240828724494,31.580242848596143,-1765.7792830073815,-3353545.9560803333,true,true,1.430551209,7010.326791434998,0.0,121.92,1644.2724500334996,729.0,1.430551209,7010.326791434998,0.0,121.92,0.0,295.15 +730,24468.03346629415,23768.03346629415,0.25,6408.755638685973,3839032.705444777,700.0,511000.0,28435.022554743893,15736729.406268403,22026.26691605792,11897696.700823577,true,730.0,730,0.875,5607.661183850227,6408.755638685973,801.0944548357465,0.0,0.0,730,23768.03346629415,0.0,5607.661183850227,5607.661183850227,1787323.7475131175,700.0,511000.0,4.976357066573887,989343.2182411914,5259.4014258718835,6941.88410521461,0.0,0.0,244.5643018645516,790908.3458248148,98.71909904721781,130.29934189581394,-5607.661183850227,-3359153.6172641837,true,true,2.905807144,7013.2325985789985,0.0,121.92,1644.2724500334996,730.0,2.905807144,7013.2325985789985,0.0,121.92,0.0,295.15 +731,28858.755638685972,28158.755638685972,0.30500000000000005,10037.78745646204,3849070.492901239,700.0,511700.0,35205.860512990286,15771935.266781393,25168.073056528247,11922864.773880105,true,731.0,731,0.875,8783.064024404284,10037.78745646204,1254.7234320577554,0.0,0.0,731,28158.755638685972,0.0,8783.064024404284,8783.064024404284,1796106.811537522,700.0,511700.0,22.75484910773055,989365.973090299,8200.46001592702,15142.344121141628,0.0,0.0,405.926315495558,791314.2721403103,153.9228438739768,284.2221857697907,-8783.064024404284,-3367936.681288588,true,true,4.291653628,7017.524252206998,0.0,121.92,1644.2724500334996,731.0,4.291653628,7017.524252206998,0.0,121.92,0.0,295.15 +732,32487.78745646204,31787.78745646204,0.33,12964.588674280076,3862035.081575519,700.0,512400.0,41407.84446751538,15813343.111248909,28443.255793235305,11951308.029673342,true,732.0,732,0.875,11344.015089995066,12964.588674280076,1620.57358428501,0.0,0.0,732,31787.78745646204,0.0,11344.015089995066,11344.015089995066,1807450.826627517,700.0,512400.0,58.853616209013765,989424.826706508,10530.30419201232,25672.64831315395,0.0,0.0,557.2032032288027,791871.475343539,197.6540785449298,481.8762643147205,-11344.015089995066,-3379280.696378583,true,true,5.588090661,7023.112342867998,0.0,121.92,1644.2724500334996,732.0,5.588090661,7023.112342867998,0.0,121.92,0.0,295.15 +733,35414.58867428008,34714.58867428008,0.29250000000000004,8483.79403563534,3870518.8756111544,700.0,513100.0,31397.58644661654,15844740.697695525,22913.7924109812,11974221.822084323,true,733.0,733,0.875,7423.319781180922,8483.79403563534,1060.474254454417,0.0,0.0,733,34714.58867428008,0.0,7423.319781180922,7423.319781180922,1814874.1464086978,700.0,513100.0,101.46913394708368,989526.2958404551,6531.1217378642295,32203.77005101818,0.0,0.0,668.1395875965949,792539.6149311357,122.58932177301392,604.4655860877344,-7423.319781180922,-3386704.016159764,true,true,6.258661541,7029.3710044089985,0.0,121.92,1644.2724500334996,733.0,6.258661541,7029.3710044089985,0.0,121.92,0.0,295.15 +734,30933.79403563534,30233.79403563534,0.33,12510.788104384317,3883029.6637155386,700.0,513800.0,40032.69122540702,15884773.388920933,27521.903121022704,12001743.725205345,true,734.0,734,0.875,10946.939591336277,12510.788104384317,1563.8485130480403,0.0,0.0,734,30233.79403563534,0.0,10946.939591336277,10946.939591336277,1825821.0860000341,700.0,513800.0,147.21772289700587,989673.513563352,9858.296944312408,42062.066995330584,0.0,0.0,756.3844387790208,793295.9993699146,185.04048534784127,789.5060714355757,-10946.939591336277,-3397650.9557511,true,true,7.152756046,7036.523760454998,0.0,121.92,1644.2724500334996,734.0,7.152756046,7036.523760454998,0.0,121.92,0.0,295.15 +735,34960.788104384315,34260.788104384315,0.335,14233.131635343245,3897262.7953508818,700.0,514500.0,44576.51234430819,15929349.901265241,30343.380708964945,12032087.10591431,true,735.0,735,0.875,12453.990180925339,14233.131635343245,1779.141454417906,0.0,0.0,735,34260.788104384315,0.0,12453.990180925339,12453.990180925339,1838275.0761809594,700.0,514500.0,214.30538444661804,989887.8189477987,11172.736548942508,53234.80354427309,0.0,0.0,857.2356972490511,794153.2350671637,209.71255028716118,999.2186217227369,-12453.990180925339,-3410104.9459320256,true,true,8.046850552,7044.570611006999,0.0,121.92,1644.2724500334996,735.0,8.046850552,7044.570611006999,0.0,121.92,0.0,295.15 +736,36683.13163534325,35983.13163534325,0.33,12923.385758023465,3910186.181108905,700.0,515200.0,41282.98714552565,15970632.888410768,28359.601387502185,12060446.707301812,true,736.0,736,0.875,11307.962538270533,12923.385758023465,1615.4232197529327,0.0,0.0,736,35983.13163534325,0.0,11307.962538270533,11307.962538270533,1849583.0387192299,700.0,515200.0,289.8410314757067,990177.6599792744,9884.58574995966,63119.38929423275,0.0,0.0,948.0018299341167,795101.2368970978,185.53392690104894,1184.7525486237857,-11307.962538270533,-3421412.9084702963,true,true,8.762126157,7053.332737163999,0.0,121.92,1644.2724500334996,736.0,8.762126157,7053.332737163999,0.0,121.92,0.0,295.15 +737,35373.38575802346,34673.38575802346,0.345,16555.656094793278,3926741.837203698,700.0,515900.0,50016.39447766168,16020649.28288843,33460.738382868396,12093907.44568468,true,737.0,737,0.875,14486.199082944117,16555.656094793278,2069.457011849161,0.0,0.0,737,34673.38575802346,0.0,14486.199082944117,14486.199082944117,1864069.237802174,700.0,515900.0,378.5487334126411,990556.208712687,12830.573476666324,75949.96277089907,0.0,0.0,1036.2466811165427,796137.4835782143,240.83019174860794,1425.5827403723938,-14486.199082944117,-3435899.1075532404,true,true,9.611515937,7062.944253100999,0.0,121.92,1644.2724500334996,737.0,9.611515937,7062.944253100999,0.0,121.92,0.0,295.15 +738,39005.656094793274,38305.656094793274,0.33999999999999997,15489.251590694874,3942231.088794393,700.0,516600.0,47615.44585498493,16068264.728743413,32126.194264290054,12126033.639948972,true,738.0,738,0.875,13553.095141858015,15489.251590694874,1936.1564488368585,0.0,0.0,738,38305.656094793274,0.0,13553.095141858015,13553.095141858015,1877622.332944032,700.0,516600.0,483.7276447641398,991039.9363574511,11724.801148000844,87674.76391889992,0.0,0.0,1124.4915321861718,797261.9751104005,220.07481690685907,1645.6575572792528,-13553.095141858015,-3449452.2026950982,true,true,10.32679154,7073.271044640999,0.0,121.92,1644.2724500334996,738.0,10.32679154,7073.271044640999,0.0,121.92,0.0,295.15 +739,37939.251590694876,37239.251590694876,0.335,14791.98191262441,3957023.0707070176,700.0,517300.0,46244.72212723704,16114509.45087065,31452.740214612626,12157486.380163584,true,739.0,739,0.875,12942.984173546358,14791.98191262441,1848.9977390780514,0.0,0.0,739,37239.251590694876,0.0,12942.984173546358,12942.984173546358,1890565.3171175784,700.0,517300.0,588.0539751536522,991627.9903326047,10949.281920873087,98624.045839773,0.0,0.0,1200.1299763065874,798462.105086707,205.51830121303135,1851.175858492284,-12942.984173546358,-3462395.186868645,true,true,10.9526577,7084.223702340999,0.0,121.92,1644.2724500334996,739.0,10.9526577,7084.223702340999,0.0,121.92,0.0,295.15 +740,37241.98191262441,36541.98191262441,0.3175,11784.745230956176,3968807.8159379736,700.0,518000.0,39322.03222348402,16153831.483094133,27537.286992527843,12185023.667156111,true,740.0,740,0.875,10311.652077086654,11784.745230956176,1473.0931538695222,0.0,0.0,740,36541.98191262441,0.0,10311.652077086654,10311.652077086654,1900876.969194665,700.0,518000.0,681.5635323879594,992309.5538649927,8215.247409489633,106839.29324926263,0.0,0.0,1260.6407315803606,799722.7458182874,154.20040362869986,2005.376262120984,-10311.652077086654,-3472706.8389457315,true,true,11.39970495,7095.623407290999,0.0,121.92,1644.2724500334996,740.0,11.39970495,7095.623407290999,0.0,121.92,0.0,295.15 +741,34234.74523095618,33534.74523095618,0.3175,12322.238130976048,3981130.0540689495,700.0,518700.0,41014.923247168656,16194846.406341301,28692.68511619261,12213716.352272304,true,741.0,741,0.875,10781.958364604041,12322.238130976048,1540.2797663720066,0.0,0.0,741,33534.74523095618,0.0,10781.958364604041,10781.958364604041,1911658.9275592691,700.0,518700.0,766.6662807024107,993076.2201456951,8543.85730366399,115383.15055292661,0.0,0.0,1311.0663605051836,801033.8121787925,160.3684197324562,2165.74468185344,-10781.958364604041,-3483488.7973103356,true,true,11.8467522,7107.470159490999,0.0,121.92,1644.2724500334996,741.0,11.8467522,7107.470159490999,0.0,121.92,0.0,295.15 +742,34772.238130976046,34072.238130976046,0.29250000000000004,8656.30973388106,3989786.3638028307,700.0,519400.0,31987.38370557627,16226833.790046878,23331.07397169521,12237047.426243998,true,742.0,742,0.875,7574.2710171459275,8656.30973388106,1082.0387167351328,0.0,0.0,742,34072.238130976046,0.0,7574.2710171459275,7574.2710171459275,1919233.198576415,700.0,519400.0,839.6353225294749,993915.8554682246,5284.047131402133,120667.19768432874,0.0,0.0,1351.4068636450422,802385.2190424376,99.18169956927721,2264.926381422717,-7574.2710171459275,-3491063.0683274814,true,true,12.11498055,7119.585140040999,0.0,121.92,1644.2724500334996,742.0,12.11498055,7119.585140040999,0.0,121.92,0.0,295.15 +743,31106.309733881062,30406.309733881062,0.28625,7828.144507110386,3997614.5083099413,700.0,520100.0,29792.644566324492,16256626.434613202,21964.500059214108,12259011.926303212,true,743.0,743,0.875,6849.626443721588,7828.144507110386,978.5180633887985,0.0,0.0,743,30406.309733881062,0.0,6849.626443721588,6849.626443721588,1926082.8250201365,700.0,520100.0,892.3974294066116,994808.2528976313,4493.740431839006,125160.93811616774,0.0,0.0,1379.1409598356877,803764.3600022733,84.3476226402821,2349.274004062999,-6849.626443721588,-3497912.694771203,true,true,12.33850418,7131.923644220999,0.0,121.92,1644.2724500334996,743.0,12.33850418,7131.923644220999,0.0,121.92,0.0,295.15 +744,30278.144507110388,29578.144507110388,0.25,5849.674117335693,4003464.182427277,700.0,520800.0,26198.696469342773,16282825.131082544,20349.02235200708,12279360.948655218,true,744.0,744,0.875,5118.4648526687315,5849.674117335693,731.2092646669616,0.0,0.0,744,29578.144507110388,0.0,5118.4648526687315,5118.4648526687315,1931201.2898728054,700.0,520800.0,932.1274151942171,995740.3803128254,2735.677489185292,127896.61560535304,0.0,0.0,1399.3112119696025,805163.6712142429,51.34873631961953,2400.6227403826188,-5118.4648526687315,-3503031.159623872,true,true,12.47261836,7144.396262580999,0.0,121.92,1644.2724500334996,744.0,12.47261836,7144.396262580999,0.0,121.92,0.0,295.15 +745,28299.674117335693,27599.674117335693,0.265,7025.951695967306,4010490.1341232443,700.0,521500.0,29154.534701763416,16311979.665784307,22128.58300579611,12301489.531661013,true,745.0,745,0.875,6147.707733971392,7025.951695967306,878.2439619959132,0.0,0.0,745,27599.674117335693,0.0,6147.707733971392,6147.707733971392,1937348.9976067767,700.0,521500.0,967.8438146084426,996708.2241274338,3693.575235512339,131590.19084086537,0.0,0.0,1416.9601823752832,806580.6313966182,69.32850147532703,2469.9512418579457,-6147.707733971392,-3509178.8673578436,true,true,12.65143726,7157.0476998409995,0.0,121.92,1644.2724500334996,745.0,12.65143726,7157.0476998409995,0.0,121.92,0.0,295.15 +746,29475.951695967306,28775.951695967306,0.25,6053.028169529944,4016543.1622927743,700.0,522200.0,27012.112678119775,16338991.778462427,20959.084508589833,12322448.616169604,true,746.0,746,0.875,5296.399648338701,6053.028169529944,756.6285211912427,0.0,0.0,746,28775.951695967306,0.0,5296.399648338701,5296.399648338701,1942645.3972551154,700.0,522200.0,1004.461119889405,997712.6852473232,2804.685360407932,134394.8762012733,0.0,0.0,1434.6091522169786,808015.2405488351,52.64401582438491,2522.5952576823306,-5296.399648338701,-3514475.267006182,true,true,12.78555143,7169.833251270999,0.0,121.92,1644.2724500334996,746.0,12.78555143,7169.833251270999,0.0,121.92,0.0,295.15 +747,28503.02816952994,27803.02816952994,0.1864,2814.4066460457516,4019357.56893882,700.0,522900.0,18854.112907970768,16357845.891370397,16039.706261925017,12338488.322431529,true,747.0,747,0.875,2462.6058152900328,2814.4066460457516,351.80083075571883,0.0,0.0,747,27803.02816952994,0.0,2462.6058152900328,2462.6058152900328,1945108.0030704055,700.0,522900.0,1020.4328190163234,998733.1180663395,0.0,134394.8762012733,0.0,0.0,1442.1729962737095,809457.4135451089,0.0,2522.5952576823306,-2462.6058152900328,-3516937.872821472,true,true,12.78555143,7182.618802700999,0.0,121.92,1644.2724500334996,747.0,12.78555143,7182.618802700999,0.0,121.92,0.0,295.15 +748,25264.40664604575,24564.40664604575,0.12,0.0,4019357.56893882,700.0,523600.0,5833.333333333334,16363679.224703731,5833.333333333334,12344321.655764863,true,748.0,748,0.875,0.0,0.0,0.0,0.0,0.0,748,24564.40664604575,0.0,-418.2591041259333,-418.2591041259333,1944689.7439662796,700.0,523600.0,1004.461119889405,999737.5791862289,-2804.685360407932,131590.19084086537,0.0,0.0,1434.6091522169786,810892.0226973258,-52.64401582438491,2469.9512418579457,-0.0,-3516937.872821472,true,true,12.65143726,7195.270239961,0.0,121.92,1644.2724500334996,748.0,12.65143726,7195.270239961,0.0,121.92,0.0,295.15 +749,22450.0,21750.0,0.16720000000000002,1671.0883355512772,4021028.6572743715,700.0,524300.0,14181.150332244479,16377860.375035975,12510.0619966932,12356831.717761556,true,749.0,749,0.875,1462.2022936073674,1671.0883355512772,208.88604194390973,0.0,0.0,749,21750.0,0.0,1462.2022936073674,1462.2022936073674,1946151.946259887,700.0,524300.0,983.4259756663673,1000721.0051618953,-928.3230609352154,130661.86777993015,0.0,0.0,1424.5240264320141,812316.5467237578,-17.424647555798682,2452.526594302147,-1462.2022936073674,-3518400.0751150795,true,true,12.60673253,7207.876972491,0.0,121.92,1644.2724500334996,749.0,12.60673253,7207.876972491,0.0,121.92,0.0,295.15 +750,24121.088335551278,23421.088335551278,0.136,575.2595743075456,4021603.916848679,700.0,525000.0,9376.908634614305,16387237.28367059,8801.64906030676,12365633.366821863,true,750.0,750,0.875,503.3521275191024,575.2595743075456,71.90744678844317,0.0,0.0,750,23421.088335551278,0.0,503.3521275191024,503.3521275191024,1946655.2983874062,700.0,525000.0,967.8438134527646,1001688.848975348,-1846.787617021094,128815.08016290906,0.0,0.0,1416.9601818112978,813733.506905569,-34.664250723865926,2417.862343578281,-503.3521275191024,-3518903.4272425985,true,true,12.51732308,7220.394295571,0.0,121.92,1644.2724500334996,750.0,12.51732308,7220.394295571,0.0,121.92,0.0,295.15 +751,23025.259574307547,22325.259574307547,0.12,0.0,4021603.916848679,700.0,525700.0,5833.333333333334,16393070.617003923,5833.333333333334,12371466.700155197,true,751.0,751,0.875,0.0,0.0,0.0,0.0,0.0,751,22325.259574307547,0.0,-2313.6050125599213,-2313.6050125599213,1944341.6933748461,700.0,525700.0,932.127414067149,1002620.9763894152,-4559.462412144059,124255.617750765,0.0,0.0,1399.311211405617,815132.8181169747,-85.58122588862797,2332.281117689653,-0.0,-3518903.4272425985,true,true,12.29379945,7232.688095021,0.0,121.92,1644.2724500334996,751.0,12.29379945,7232.688095021,0.0,121.92,0.0,295.15 +752,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,526400.0,5833.333333333334,16398903.950337257,5833.333333333334,12377300.03348853,true,752.0,752,0.875,0.0,0.0,0.0,0.0,0.0,752,21750.0,0.0,-4120.435322630293,-4120.435322630293,1940221.258052216,700.0,526400.0,872.9629671225366,1003493.9393565378,-6245.230978876139,118010.38677188887,0.0,0.0,1369.0558340507232,816501.8739510254,-117.2231449274143,2215.057972762239,-0.0,-3518903.4272425985,true,true,11.98086638,7244.668961401,0.0,121.92,1644.2724500334996,752.0,11.98086638,7244.668961401,0.0,121.92,0.0,295.15 +753,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,527100.0,5833.333333333334,16404737.283670591,5833.333333333334,12383133.366821865,true,753.0,753,0.875,0.0,0.0,0.0,0.0,0.0,753,21750.0,0.0,-9282.132822502685,-9282.132822502685,1930939.1252297133,700.0,527100.0,780.0122056389245,1004273.9515621767,-11171.093522626254,106839.29324926261,0.0,0.0,1318.6302051259001,817820.5041561513,-209.68171064125522,2005.3762621209837,-0.0,-3518903.4272425985,true,true,11.39970495,7256.0686663510005,0.0,121.92,1644.2724500334996,753.0,11.39970495,7256.0686663510005,0.0,121.92,0.0,295.15 +754,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,527800.0,5833.333333333334,16410570.617003925,5833.333333333334,12388966.700155199,true,754.0,754,0.875,0.0,0.0,0.0,0.0,0.0,754,21750.0,0.0,-14527.207831827445,-14527.207831827445,1916411.9173978858,700.0,527800.0,641.4821435603176,1004915.433705737,-16101.885097545732,90737.40815171688,0.0,0.0,1235.4279165539635,819055.9320727052,-302.23279439599384,1703.14346772499,-0.0,-3518903.4272425985,true,true,10.50561044,7266.574276791001,0.0,121.92,1644.2724500334996,754.0,10.50561044,7266.574276791001,0.0,121.92,0.0,295.15 +755,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,528500.0,5833.333333333334,16416403.95033726,5833.333333333334,12394800.033488533,true,755.0,755,0.875,0.0,0.0,0.0,0.0,0.0,755,21750.0,0.0,-13433.569635681231,-13433.569635681231,1902978.3477622045,700.0,528500.0,496.85981451806185,1005412.293520255,-14787.445380817833,75949.96277089904,0.0,0.0,1134.5766579711362,820190.5087306764,-277.5607273525964,1425.5827403723936,-0.0,-3518903.4272425985,true,true,9.611515937,7276.185792728001,0.0,121.92,1644.2724500334996,755.0,9.611515937,7276.185792728001,0.0,121.92,0.0,295.15 +756,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,529200.0,5833.333333333334,16422237.283670593,5833.333333333334,12400633.366821866,true,756.0,756,0.875,0.0,0.0,0.0,0.0,0.0,756,21750.0,0.0,-15564.802126231822,-15564.802126231822,1887413.5456359726,700.0,529200.0,362.21080494571305,1005774.5043252007,-16635.876104277566,59314.08666662148,0.0,0.0,1021.1189923262987,821211.6277230027,-312.2558192262667,1113.326921146127,-0.0,-3518903.4272425985,true,true,8.493897805,7284.679690533001,0.0,121.92,1644.2724500334996,756.0,8.493897805,7284.679690533001,0.0,121.92,0.0,295.15 +757,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,529900.0,5833.333333333334,16428070.617003927,5833.333333333334,12406466.7001552,true,757.0,757,0.875,0.0,0.0,0.0,0.0,0.0,757,21750.0,0.0,-13716.775953551403,-13716.775953551403,1873696.7696824213,700.0,529900.0,243.9390852791123,1006018.4434104798,-14582.064239960291,44732.02242666119,0.0,0.0,895.054919224661,822106.6826422274,-273.7057180948865,839.6212030512405,-0.0,-3518903.4272425985,true,true,7.376279673,7292.055970206001,0.0,121.92,1644.2724500334996,757.0,7.376279673,7292.055970206001,0.0,121.92,0.0,295.15 +758,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,530600.0,5833.333333333334,16433903.950337261,5833.333333333334,12412300.033488534,true,758.0,758,0.875,0.0,0.0,0.0,0.0,0.0,758,21750.0,0.0,-7449.133851998764,-7449.133851998764,1866247.6358304226,700.0,530600.0,168.80498823933542,1006187.2483987191,-8254.68065287621,36477.34177378498,0.0,0.0,791.6823792519912,822898.3650214794,-154.94056661387998,684.6806364373606,-0.0,-3518903.4272425985,true,true,6.661004068,7298.716974274001,0.0,121.92,1644.2724500334996,758.0,6.661004068,7298.716974274001,0.0,121.92,0.0,295.15 +759,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,531300.0,5833.333333333334,16439737.283670595,5833.333333333334,12418133.366821868,true,759.0,759,0.875,0.0,0.0,0.0,0.0,0.0,759,21750.0,0.0,-10204.504124359479,-10204.504124359479,1856043.1317060632,700.0,531300.0,112.16258766866275,1006299.4109863878,-10804.693460631064,25672.648313153917,0.0,0.0,690.8311207255623,823589.196142205,-202.80437212264007,481.8762643147205,-0.0,-3518903.4272425985,true,true,5.588090661,7304.305064935001,0.0,121.92,1644.2724500334996,759.0,5.588090661,7304.305064935001,0.0,121.92,0.0,295.15 +760,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,532000.0,5833.333333333334,16445570.617003929,5833.333333333334,12423966.700155202,true,760.0,760,0.875,0.0,0.0,0.0,0.0,0.0,760,21750.0,0.0,-10754.605474139486,-10754.605474139486,1845288.5262319236,700.0,532000.0,57.270196899274524,1006356.6811832871,-11154.663001969657,14517.98531118426,0.0,0.0,552.1606402799218,824141.3567824849,-209.3733093490253,272.5029549656952,-0.0,-3518903.4272425985,true,true,4.202244177,7308.507309112,0.0,121.92,1644.2724500334996,760.0,4.202244177,7308.507309112,0.0,121.92,0.0,295.15 +761,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,532700.0,5833.333333333334,16451403.950337263,5833.333333333334,12429800.033488536,true,761.0,761,0.875,0.0,0.0,0.0,0.0,0.0,761,21750.0,0.0,-7942.036849300388,-7942.036849300388,1837346.4893826232,700.0,532700.0,20.699989578965095,1006377.381172866,-8202.103063119184,6315.882248065076,0.0,0.0,393.3199081515551,824534.6766906364,-153.95368391172414,118.54927105397107,-0.0,-3518903.4272425985,true,true,2.771692968,7311.27900208,0.0,121.92,1644.2724500334996,761.0,2.771692968,7311.27900208,0.0,121.92,0.0,295.15 +762,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,533400.0,5833.333333333334,16457237.283670597,5833.333333333334,12435633.36682187,true,762.0,762,0.875,0.0,0.0,0.0,0.0,0.0,762,21750.0,0.0,-4691.727205321806,-4691.727205321806,1832654.7621773013,700.0,533400.0,4.245802749406729,1006381.6269756154,-4837.1377044336205,1478.7445436314556,0.0,0.0,231.95789457694724,824766.6345852134,-90.7931982145389,27.756072839432164,-0.0,-3518903.4272425985,true,true,1.341141759,7312.620143839,0.0,121.92,1644.2724500334996,762.0,1.341141759,7312.620143839,0.0,121.92,0.0,295.15 +763,22450.0,21750.0,0.12,0.0,4021603.916848679,700.0,534100.0,5833.333333333334,16463070.61700393,5833.333333333334,12441466.700155204,true,763.0,763,0.875,0.0,0.0,0.0,0.0,0.0,763,21750.0,0.0,-1015.9209372861045,-1015.9209372861045,1831638.8412400153,700.0,534100.0,0.49685981474034724,1006382.1238354301,-1109.0584082749585,369.68613535649706,0.0,0.0,113.45766581403319,824880.0922510275,-20.81705463991947,6.939018199512695,-0.0,-3518903.4272425985,true,true,0.670570879,7313.290714717999,0.0,121.92,1644.2724500334996,763.0,0.670570879,7313.290714717999,0.0,121.92,0.0,295.15 +764,22450.0,21750.0,0.124,86.61218464124524,4021690.5290333205,700.0,534800.0,6343.646650332623,16469414.263654264,6257.034465691378,12447723.734620895,true,764.0,764,0.875,75.78566156108958,86.61218464124524,10.826523080155653,0.0,0.0,764,21750.0,0.0,75.78566156108958,75.78566156108958,1831714.6269015765,700.0,534800.0,0.14721772266648792,1006382.2710531527,0.0,369.68613535649706,0.0,0.0,75.6384438384231,824955.7306948659,0.0,6.939018199512695,-75.78566156108958,-3518979.2129041594,true,true,0.670570879,7313.961285596999,0.0,121.92,1644.2724500334996,764.0,0.670570879,7313.961285596999,0.0,121.92,0.0,295.15 +765,22536.612184641246,21836.612184641246,0.12,0.0,4021690.5290333205,700.0,535500.0,5833.333333333334,16475247.596987598,5833.333333333334,12453557.06795423,true,765.0,765,0.875,0.0,0.0,0.0,0.0,0.0,765,21836.612184641246,0.0,-284.3086651241525,-284.3086651241525,1831430.3182364523,700.0,535500.0,0.043620065926468804,1006382.3146732186,-328.6098982172538,41.07623713924329,0.0,0.0,50.42562920681588,825006.1563240727,-6.168016179641098,0.771002019871597,-0.0,-3518979.2129041594,true,true,0.223523626,7314.184809222999,0.0,121.92,1644.2724500334996,765.0,0.223523626,7314.184809222999,0.0,121.92,0.0,295.15 +766,22450.0,21750.0,0.12,0.0,4021690.5290333205,700.0,536200.0,5833.333333333334,16481080.930320932,5833.333333333334,12459390.401287563,true,766.0,766,0.875,0.0,0.0,0.0,0.0,0.0,766,21750.0,0.0,-29.240150308067577,-29.240150308067577,1831401.0780861443,700.0,536200.0,0.0006815635278141911,1006382.3153547822,-41.07623713933157,-8.827782949083485e-11,0.0,0.0,12.606407287604334,825018.7627313604,-0.7710020198681556,3.4413583094305977e-12,-0.0,-3518979.2129041594,true,true,0.0,7314.184809222999,0.0,121.92,1644.2724500334996,766.0,0.0,7314.184809222999,0.0,121.92,0.0,295.15 +767,22450.0,21750.0,0.1696,1808.327174958617,4023498.8562082793,700.0,536900.0,14789.664946689958,16495870.595267622,12981.337771731341,12472371.739059294,true,767.0,767,0.875,1582.28627808879,1808.327174958617,226.04089686982707,0.0,0.0,767,21750.0,0.0,1582.28627808879,1582.28627808879,1832983.364364233,700.0,536900.0,0.14721772299579924,1006382.4625725051,1478.7445436315438,1478.7445436314556,0.0,0.0,75.63844389482165,825094.4011752552,27.75607283942872,27.756072839432164,-1582.28627808879,-3520561.499182248,true,true,1.341141759,7315.525950981999,0.0,121.92,1644.2724500334996,767.0,1.341141759,7315.525950981999,0.0,121.92,0.0,295.15 +768,24258.327174958617,23558.327174958617,0.25,6144.036613858355,4029642.8928221376,700.0,537600.0,27376.14645543342,16523246.741723055,21232.109841575064,12493603.84890087,true,768.0,768,0.875,5376.0320371260605,6144.036613858355,768.0045767322945,0.0,0.0,768,23558.327174958617,0.0,5376.0320371260605,5376.0320371260605,1838359.3964013592,700.0,537600.0,4.385763182919641,1006386.848335688,5042.518889615731,6521.263433247186,0.0,0.0,234.4791760231884,825328.8803512783,94.6482083042216,122.40428114365376,-5376.0320371260605,-3525937.531219374,true,true,2.816397693,7318.342348674999,0.0,121.92,1644.2724500334996,768.0,2.816397693,7318.342348674999,0.0,121.92,0.0,295.15 +769,28594.036613858356,27894.036613858356,0.30500000000000005,10520.799631997652,4040163.692454135,700.0,538300.0,36789.50699015623,16560036.248713212,26268.70735815858,12519872.556259029,true,769.0,769,0.875,9205.699677997945,10520.799631997652,1315.0999539997065,0.0,0.0,769,27894.036613858356,0.0,9205.699677997945,9205.699677997945,1847565.0960793572,700.0,538300.0,21.917332930719994,1006408.7656686187,8621.080687894411,15142.344121141597,0.0,0.0,400.88375254667716,825729.764103825,161.81790462613696,284.2221857697907,-9205.699677997945,-3535143.2308973717,true,true,4.291653628,7322.634002302999,0.0,121.92,1644.2724500334996,769.0,4.291653628,7322.634002302999,0.0,121.92,0.0,295.15 +770,32970.79963199765,32270.799631997652,0.335,14923.458149859336,4055087.1506039943,700.0,539000.0,46637.18850704279,16606673.437220255,31713.730357183453,12551586.286616212,true,770.0,770,0.875,13058.02588112692,14923.458149859336,1865.4322687324166,0.0,0.0,770,32270.799631997652,0.0,13058.02588112692,13058.02588112692,1860623.1219604842,700.0,539000.0,62.10747684254341,1006470.8731454613,12199.642474485532,27341.98659562713,0.0,0.0,567.288329070166,826297.0524328952,228.9876007286765,513.2097864984672,-13058.02588112692,-3548201.2567784986,true,true,5.766909562,7328.400911864999,0.0,121.92,1644.2724500334996,770.0,5.766909562,7328.400911864999,0.0,121.92,0.0,295.15 +771,37373.45814985933,36673.45814985933,0.345,16896.3285360883,4071983.4791400824,700.0,539700.0,51003.85082924145,16657677.288049497,34107.522293153146,12585693.808909364,true,771.0,771,0.875,14784.28746907726,16896.3285360883,2112.0410670110377,0.0,0.0,771,36673.45814985933,0.0,14784.28746907726,14784.28746907726,1875407.4094295613,700.0,539700.0,128.89676625847906,1006599.7699117198,13675.100929466262,41017.08752509339,0.0,0.0,723.6077797522915,827020.6602126475,256.6819936002287,769.8917800986959,-14784.28746907726,-3562985.544247576,true,true,7.063346596,7335.464258460999,0.0,121.92,1644.2724500334996,771.0,7.063346596,7335.464258460999,0.0,121.92,0.0,295.15 +772,39346.3285360883,38646.3285360883,0.3175,12019.217283633569,4084002.696423716,700.0,540400.0,40060.52687758604,16697737.814927083,28041.309593952472,12613735.118503317,true,772.0,772,0.875,10516.815123179373,12019.217283633569,1502.4021604541958,0.0,0.0,772,38646.3285360883,0.0,10516.815123179373,10516.815123179373,1885924.2245527408,700.0,540400.0,201.33952160080193,1006801.1094333206,9301.303176406584,50318.39070149997,0.0,0.0,839.5867270689644,827860.2469397165,174.58569810302387,944.4774782017198,-10516.815123179373,-3573502.3593707555,true,true,7.823326926,7343.287585386999,0.0,121.92,1644.2724500334996,772.0,7.823326926,7343.287585386999,0.0,121.92,0.0,295.15 +773,34469.21728363357,33769.21728363357,0.28,7503.720480854858,4091506.416904571,700.0,541100.0,29299.001717338775,16727036.81664442,21795.28123648392,12635530.399739802,true,773.0,773,0.875,6565.755420748001,7503.720480854858,937.965060106857,0.0,0.0,773,33769.21728363357,0.0,6565.755420748001,6565.755420748001,1892489.9799734887,700.0,541100.0,252.27817320752953,1007053.3876065281,5308.692901177233,55627.0836026772,0.0,0.0,905.1400450660244,828765.3869847825,99.64430129721461,1044.1217794989343,-6565.755420748001,-3580068.1147915036,true,true,8.225669453,7351.513254839999,0.0,121.92,1644.2724500334996,773.0,8.225669453,7351.513254839999,0.0,121.92,0.0,295.15 +774,29953.720480854856,29253.720480854856,0.29250000000000004,9406.680592301276,4100913.0974968723,700.0,541800.0,34552.75416171376,16761589.570806134,25146.073569412485,12660676.473309215,true,774.0,774,0.875,8230.845518263617,9406.680592301276,1175.835074037659,0.0,0.0,774,29253.720480854856,0.0,8230.845518263617,8230.845518263617,1900720.8254917522,700.0,541800.0,296.8342167755756,1007350.2218233037,6849.873329920884,62476.956932598085,0.0,0.0,955.5656742728402,829720.9526590554,128.57229729431728,1172.6940767932515,-8230.845518263617,-3588298.960309767,true,true,8.717421431,7360.230676270999,0.0,121.92,1644.2724500334996,774.0,8.717421431,7360.230676270999,0.0,121.92,0.0,295.15 +775,31856.680592301276,31156.680592301276,0.30500000000000005,10791.56526636421,4111704.6627632366,700.0,542500.0,37677.26316840724,16799266.83397454,26885.69790204303,12687562.171211258,true,775.0,775,0.875,9442.619608068684,10791.56526636421,1348.9456582955263,0.0,0.0,775,31156.680592301276,0.0,9442.619608068684,9442.619608068684,1910163.4450998208,700.0,542500.0,354.2211518990812,1007704.4429752028,7926.07075774624,70403.02769034433,0.0,0.0,1013.5551479311766,830734.5078069866,148.7725504921874,1321.4666272854388,-9442.619608068684,-3597741.579917836,true,true,9.253878135,7369.484554405999,0.0,121.92,1644.2724500334996,775.0,9.253878135,7369.484554405999,0.0,121.92,0.0,295.15 +776,33241.56526636421,32541.56526636421,0.3175,12334.686194185027,4124039.3489574217,700.0,543200.0,41054.129745464656,16840320.963720005,28719.443551279626,12716281.614762537,true,776.0,776,0.875,10792.8504199119,12334.686194185027,1541.8357742731278,0.0,0.0,776,32541.56526636421,0.0,10792.8504199119,10792.8504199119,1920956.2955197326,700.0,543200.0,424.50221129221734,1008128.9451864951,9120.567734831191,79523.59542517552,0.0,0.0,1076.587184538394,831811.0949915249,171.19328925009722,1492.659916535536,-10792.8504199119,-3608534.430337748,true,true,9.835039564,7379.319593969999,0.0,121.92,1644.2724500334996,776.0,9.835039564,7379.319593969999,0.0,121.92,0.0,295.15 +777,34784.68619418503,34084.68619418503,0.3175,12254.069039367985,4136293.41799679,700.0,543900.0,40800.2174468283,16881121.181166835,28546.148407460314,12744827.763169998,true,777.0,777,0.875,10722.310409446987,12254.069039367985,1531.758629920998,0.0,0.0,777,34084.68619418503,0.0,10722.310409446987,10722.310409446987,1931678.6059291796,700.0,543900.0,503.5140996906904,1008632.4592861858,8911.900488783815,88435.49591395933,0.0,0.0,1139.6192212584083,832950.7142127834,167.2765997140738,1659.93651624961,-10722.310409446987,-3619256.740747195,true,true,10.37149627,7389.691090239999,0.0,121.92,1644.2724500334996,777.0,10.37149627,7389.691090239999,0.0,121.92,0.0,295.15 +778,34704.06903936798,34004.06903936798,0.35,18683.995768790217,4154977.41376558,700.0,544600.0,55382.84505368634,16936504.026220523,36698.84928489612,12781526.612454895,true,778.0,778,0.875,16348.49629769144,18683.995768790217,2335.4994710987776,0.0,0.0,778,34004.06903936798,0.0,16348.49629769144,16348.49629769144,1948027.102226871,700.0,544600.0,610.5727904847815,1009243.0320766706,14255.097301903224,102690.59321586255,0.0,0.0,1215.2576649840344,834165.9718777675,267.56854031939986,1927.5050565690099,-16348.49629769144,-3635605.2370448867,true,true,11.17618132,7400.867271559999,0.0,121.92,1644.2724500334996,778.0,11.17618132,7400.867271559999,0.0,121.92,0.0,295.15 +779,41133.99576879022,40433.99576879022,0.345,17113.165472541958,4172090.579238122,700.0,545300.0,51632.36368852742,16988136.38990905,34519.19821598546,12816045.81067088,true,779.0,779,0.875,14974.019788474212,17113.165472541958,2139.1456840677456,0.0,0.0,779,40433.99576879022,0.0,14974.019788474212,14974.019788474212,1963001.1220153454,700.0,545300.0,744.7628731337585,1009987.7949498043,12692.557337064038,115383.15055292659,0.0,0.0,1298.4599529919851,835464.4318307595,238.23962528443033,2165.7446818534404,-14974.019788474212,-3650579.256833361,true,true,11.8467522,7412.714023759999,0.0,121.92,1644.2724500334996,779.0,11.8467522,7412.714023759999,0.0,121.92,0.0,295.15 +780,39563.16547254196,38863.16547254196,0.33,12867.507865526584,4184958.0871036486,700.0,546000.0,41113.660198565405,17029250.050107617,28246.152333038823,12844291.963003919,true,780.0,780,0.875,11259.069382335761,12867.507865526584,1608.4384831908228,0.0,0.0,780,38863.16547254196,0.0,11259.069382335761,11259.069382335761,1974260.1913976811,700.0,546000.0,858.5737592311386,1010846.3687090355,8872.467197838403,124255.61775076498,0.0,0.0,1361.491989430007,836825.9238201895,166.53643583621331,2332.281117689654,-11259.069382335761,-3661838.326215697,true,true,12.29379945,7425.007823209999,0.0,121.92,1644.2724500334996,780.0,12.29379945,7425.007823209999,0.0,121.92,0.0,295.15 +781,35317.50786552658,34617.50786552658,0.28625,7973.122586863376,4192931.209690512,700.0,546700.0,30299.11820738297,17059549.168315,22325.995620519592,12866617.958624437,true,781.0,781,0.875,6976.482263505453,7973.122586863376,996.6403233579222,0.0,0.0,781,34617.50786552658,0.0,6976.482263505453,6976.482263505453,1981236.6736611866,700.0,546700.0,932.127414067149,1011778.4961231026,4559.462412144059,128815.08016290904,0.0,0.0,1399.311211405617,838225.2350315952,85.58122588862797,2417.862343578282,-6976.482263505453,-3668814.8084792024,true,true,12.51732308,7437.525146289999,0.0,121.92,1644.2724500334996,781.0,12.51732308,7437.525146289999,0.0,121.92,0.0,295.15 +782,30423.122586863377,29723.122586863377,0.25,5965.37197509375,4198896.581665606,700.0,547400.0,26661.487900375,17086210.656215377,20696.11592528125,12887314.074549718,true,782.0,782,0.875,5219.700478207031,5965.37197509375,745.6714968867191,0.0,0.0,782,29723.122586863377,0.0,5219.700478207031,5219.700478207031,1986456.3741393937,700.0,547400.0,973.0194384315259,1012751.5155615341,2775.1106779563092,131590.19084086534,0.0,0.0,1419.4814635395317,839644.7164951348,52.088898279664605,2469.9512418579466,-5219.700478207031,-3674034.5089574093,true,true,12.65143726,7450.176583549999,0.0,121.92,1644.2724500334996,782.0,12.65143726,7450.176583549999,0.0,121.92,0.0,295.15 +783,28415.37197509375,27715.37197509375,0.29250000000000004,9379.879766418437,4208276.461432025,700.0,548100.0,34461.12740655876,17120671.783621937,25081.24764014032,12912395.322189858,true,783.0,783,0.875,8207.394795616132,9379.879766418437,1172.4849708023048,0.0,0.0,783,27715.37197509375,0.0,8207.394795616132,8207.394795616132,1994663.7689350098,700.0,548100.0,1020.4328202134943,1013771.9483817476,5638.945821520826,137229.13666238615,0.0,0.0,1442.1729968376947,841086.8894919724,105.84315704411657,2575.794398902063,-8207.394795616132,-3682241.9037530255,true,true,12.91966561,7463.096249159999,0.0,121.92,1644.2724500334996,783.0,12.91966561,7463.096249159999,0.0,121.92,0.0,295.15 +784,31829.87976641844,31129.87976641844,0.1888,2868.780616819426,4211145.242048845,700.0,548800.0,18902.439707730013,17139574.223329667,16033.659090910587,12928428.981280768,true,784.0,784,0.875,2510.183039716998,2868.780616819426,358.5975771024282,0.0,0.0,784,31129.87976641844,0.0,2510.183039716998,2510.183039716998,1997173.9519747267,700.0,548800.0,1052.8823542018563,1014824.8307359495,0.0,137229.13666238615,0.0,0.0,1457.3006855151418,842544.1901774876,0.0,2575.794398902063,-2510.183039716998,-3684752.0867927424,true,true,12.91966561,7476.01591477,0.0,121.92,1644.2724500334996,784.0,12.91966561,7476.01591477,0.0,121.92,0.0,295.15 +785,25318.780616819426,24618.780616819426,0.1888,2868.780616819426,4214014.022665665,700.0,549500.0,18902.439707730013,17158476.663037397,16033.659090910587,12944462.640371678,true,785.0,785,0.875,2510.183039716998,2868.780616819426,358.5975771024282,0.0,0.0,785,24618.780616819426,0.0,2510.183039716998,2510.183039716998,1999684.1350144437,700.0,549500.0,1052.8823542018563,1015877.7130901513,0.0,137229.13666238615,0.0,0.0,1457.3006855151418,844001.4908630027,0.0,2575.794398902063,-2510.183039716998,-3687262.2698324593,true,true,12.91966561,7488.93558038,0.0,121.92,1644.2724500334996,785.0,12.91966561,7488.93558038,0.0,121.92,0.0,295.15 +786,25318.780616819426,24618.780616819426,0.16720000000000002,1755.8537530885512,4215769.8764187535,700.0,550200.0,14688.120532826264,17173164.783570223,12932.266779737713,12957394.907151416,true,786.0,786,0.875,1536.3720339524823,1755.8537530885512,219.48171913606893,0.0,0.0,786,24618.780616819426,0.0,1536.3720339524823,1536.3720339524823,2001220.5070483962,700.0,550200.0,1047.4270155198526,1016925.1401056711,-948.0396567908635,136281.09700559528,0.0,0.0,1454.779403786908,845456.2702667896,-17.794728563414726,2557.9996703386487,-1536.3720339524823,-3688798.6418664115,true,true,12.87496088,7501.81054126,0.0,121.92,1644.2724500334996,786.0,12.87496088,7501.81054126,0.0,121.92,0.0,295.15 +787,24205.85375308855,23505.85375308855,0.12,0.0,4215769.8764187535,700.0,550900.0,5833.333333333334,17178998.116903555,5833.333333333334,12963228.24048475,true,787.0,787,0.875,0.0,0.0,0.0,0.0,0.0,787,23505.85375308855,0.0,-406.92767017867095,-406.92767017867095,2000813.5793782175,700.0,550900.0,1025.7941019195234,1017950.9342075906,-2824.4019533233245,133456.69505227194,0.0,0.0,1444.6942780019433,846900.9645447915,-53.01409677681319,2504.9855735618353,-0.0,-3688798.6418664115,true,true,12.74084671,7514.55138797,0.0,121.92,1644.2724500334996,787.0,12.74084671,7514.55138797,0.0,121.92,0.0,295.15 +788,22450.0,21750.0,0.14,605.3986535534868,4216375.275072307,700.0,551600.0,9324.27609681062,17188322.393000364,8718.877443257134,12971947.117928008,true,788.0,788,0.875,529.723821859301,605.3986535534868,75.67483169418585,0.0,0.0,788,21750.0,0.0,529.723821859301,529.723821859301,2001343.3032000768,700.0,551600.0,999.174493917097,1018950.1087015078,-1866.5042114066378,131590.1908408653,0.0,0.0,1432.0878710527304,848333.0524158442,-35.03433170388865,2469.9512418579466,-529.723821859301,-3689328.365688271,true,true,12.65143726,7527.202825230001,0.0,121.92,1644.2724500334996,788.0,12.65143726,7527.202825230001,0.0,121.92,0.0,295.15 +789,23055.398653553486,22355.398653553486,0.1864,2760.802585916258,4219136.077658224,700.0,552300.0,18566.53747809151,17206888.930478457,15805.734892175253,12987752.852820182,true,789.0,789,0.875,2415.7022626767257,2760.802585916258,345.1003232395324,0.0,0.0,789,22355.398653553486,0.0,2415.7022626767257,2415.7022626767257,2003759.0054627536,700.0,552300.0,988.6569545164776,1019938.7656560242,0.0,131590.1908408653,0.0,0.0,1427.045308160248,849760.0977240044,0.0,2469.9512418579466,-2415.7022626767257,-3691744.0679509477,true,true,12.65143726,7539.854262490001,0.0,121.92,1644.2724500334996,789.0,12.65143726,7539.854262490001,0.0,121.92,0.0,295.15 +790,25210.80258591626,24510.80258591626,0.1864,2760.802585916258,4221896.8802441405,700.0,553000.0,18566.53747809151,17225455.46795655,15805.734892175253,13003558.587712357,true,790.0,790,0.875,2415.7022626767257,2760.802585916258,345.1003232395324,0.0,0.0,790,24510.80258591626,0.0,2415.7022626767257,2415.7022626767257,2006174.7077254304,700.0,553000.0,988.6569545164776,1020927.4226105406,0.0,131590.1908408653,0.0,0.0,1427.045308160248,851187.1430321647,0.0,2469.9512418579466,-2415.7022626767257,-3694159.7702136245,true,true,12.65143726,7552.505699750001,0.0,121.92,1644.2724500334996,790.0,12.65143726,7552.505699750001,0.0,121.92,0.0,295.15 +791,25210.80258591626,24510.80258591626,0.16720000000000002,1671.0883355512772,4223567.968579692,700.0,553700.0,14181.150332244479,17239636.618288796,12510.0619966932,13016068.64970905,true,791.0,791,0.875,1462.2022936073674,1671.0883355512772,208.88604194390973,0.0,0.0,791,24510.80258591626,0.0,1462.2022936073674,1462.2022936073674,2007636.9100190378,700.0,553700.0,983.4259756663673,1021910.848586207,-928.3230609352154,130661.8677799301,0.0,0.0,1424.5240264320141,852611.6670585966,-17.424647555798682,2452.5265943021477,-1462.2022936073674,-3695621.972507232,true,true,12.60673253,7565.1124322800015,0.0,121.92,1644.2724500334996,791.0,12.60673253,7565.1124322800015,0.0,121.92,0.0,295.15 +792,24121.088335551278,23421.088335551278,0.12,0.0,4223567.968579692,700.0,554400.0,5833.333333333334,17245469.95162213,5833.333333333334,13021901.983042384,true,792.0,792,0.875,0.0,0.0,0.0,0.0,0.0,792,23421.088335551278,0.0,-3249.982350692445,-3249.982350692445,2004386.9276683454,700.0,554400.0,947.3248472827854,1022858.1734334899,-5500.929663762416,125160.93811616767,0.0,0.0,1406.8750560263331,854018.542114623,-103.25259023914789,2349.2740040629997,-0.0,-3695621.972507232,true,true,12.33850418,7577.450936460002,0.0,121.92,1644.2724500334996,792.0,12.33850418,7577.450936460002,0.0,121.92,0.0,295.15 +793,22450.0,21750.0,0.1648,1576.0354830228666,4225144.004062715,700.0,555100.0,13810.894921255258,17259280.846543383,12234.859438232392,13034136.842480617,true,793.0,793,0.875,1379.0310476450084,1576.0354830228666,197.00443537785827,0.0,0.0,793,21750.0,0.0,1379.0310476450084,1379.0310476450084,2005765.9587159904,700.0,555100.0,912.1182138004393,1023770.2916472903,-905.3203654027374,124255.61775076494,0.0,0.0,1389.2260856206524,855407.7682002437,-16.992886373346,2332.2811176896535,-1379.0310476450084,-3697001.003554877,true,true,12.29379945,7589.7447359100015,0.0,121.92,1644.2724500334996,793.0,12.29379945,7589.7447359100015,0.0,121.92,0.0,295.15 +794,24026.035483022868,23326.035483022868,0.184,2621.5609872463024,4227765.565049961,700.0,555800.0,18051.961887208166,17277332.80843059,15430.400899961864,13049567.243380578,true,794.0,794,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,794,23326.035483022868,0.0,2293.8658638405145,2293.8658638405145,2008059.824579831,700.0,555800.0,907.1610599480958,1024677.4527072385,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,856794.4730041361,0.0,2332.2811176896535,-2293.8658638405145,-3699294.8694187175,true,true,12.29379945,7602.038535360001,0.0,121.92,1644.2724500334996,794.0,12.29379945,7602.038535360001,0.0,121.92,0.0,295.15 +795,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4230387.126037207,700.0,556500.0,18051.961887208166,17295384.770317797,15430.400899961864,13064997.64428054,true,795.0,795,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,795,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2010353.6904436715,700.0,556500.0,907.1610599480958,1025584.6137671866,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,858181.1778080285,0.0,2332.2811176896535,-2293.8658638405145,-3701588.735282558,true,true,12.29379945,7614.332334810001,0.0,121.92,1644.2724500334996,795.0,12.29379945,7614.332334810001,0.0,121.92,0.0,295.15 +796,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4233008.687024454,700.0,557200.0,18051.961887208166,17313436.732205003,15430.400899961864,13080428.045180501,true,796.0,796,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,796,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2012647.556307512,700.0,557200.0,907.1610599480958,1026491.7748271348,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,859567.8826119209,0.0,2332.2811176896535,-2293.8658638405145,-3703882.6011463986,true,true,12.29379945,7626.626134260001,0.0,121.92,1644.2724500334996,796.0,12.29379945,7626.626134260001,0.0,121.92,0.0,295.15 +797,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4235630.2480117,700.0,557900.0,18051.961887208166,17331488.69409221,15430.400899961864,13095858.446080463,true,797.0,797,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,797,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2014941.4221713527,700.0,557900.0,907.1610599480958,1027398.935887083,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,860954.5874158134,0.0,2332.2811176896535,-2293.8658638405145,-3706176.467010239,true,true,12.29379945,7638.919933710001,0.0,121.92,1644.2724500334996,797.0,12.29379945,7638.919933710001,0.0,121.92,0.0,295.15 +798,25071.560987246303,24371.560987246303,0.184,2621.5609872463024,4238251.808998946,700.0,558600.0,18051.961887208166,17349540.655979417,15430.400899961864,13111288.846980425,true,798.0,798,0.875,2293.8658638405145,2621.5609872463024,327.69512340578785,0.0,0.0,798,24371.560987246303,0.0,2293.8658638405145,2293.8658638405145,2017235.2880351932,700.0,558600.0,907.1610599480958,1028306.0969470311,0.0,124255.61775076494,0.0,0.0,1386.7048038924186,862341.2922197058,0.0,2332.2811176896535,-2293.8658638405145,-3708470.3328740797,true,true,12.29379945,7651.213733160001,0.0,121.92,1644.2724500334996,798.0,12.29379945,7651.213733160001,0.0,121.92,0.0,295.15 +799,25071.560987246303,24371.560987246303,0.196,3684.1800585110573,4241935.989057457,700.0,559300.0,22368.26560464825,17371908.921584066,18684.085546137194,13129972.932526562,true,799.0,799,0.875,3223.657551197175,3684.1800585110573,460.5225073138822,0.0,0.0,799,24371.560987246303,0.0,3223.657551197175,3223.657551197175,2020458.9455863903,700.0,559300.0,912.1182138004393,1029218.2151608316,905.3203654027374,125160.93811616767,0.0,0.0,1389.2260856206524,863730.5183053265,16.992886373346,2349.2740040629997,-3223.657551197175,-3711693.990425277,true,true,12.33850418,7663.552237340001,0.0,121.92,1644.2724500334996,799.0,12.33850418,7663.552237340001,0.0,121.92,0.0,295.15 +800,26134.180058511058,25434.180058511058,0.265,6927.7004622089735,4248863.689519666,700.0,560000.0,28783.775329090466,17400692.696913157,21856.074866881492,13151829.007393444,true,800.0,800,0.875,6061.737904432852,6927.7004622089735,865.9625577761217,0.0,0.0,800,25434.180058511058,0.0,6061.737904432852,6061.737904432852,2026520.6834908233,700.0,560000.0,937.1750250423974,1030155.390185874,3654.142046741322,128815.080162909,0.0,0.0,1401.832493133851,865132.3507984603,68.58833951528196,2417.8623435782815,-6061.737904432852,-3717755.7283297097,true,true,12.51732308,7676.069560420001,0.0,121.92,1644.2724500334996,800.0,12.51732308,7676.069560420001,0.0,121.92,0.0,295.15 +801,29377.700462208973,28677.700462208973,0.28625,8156.214995937008,4257019.904515604,700.0,560700.0,30938.74234388474,17431631.43925704,22782.527347947733,13174611.534741392,true,801.0,801,0.875,7136.688121444882,8156.214995937008,1019.5268744921259,0.0,0.0,801,28677.700462208973,0.0,7136.688121444882,7136.688121444882,2033657.371612268,700.0,560700.0,983.4259756663673,1031138.8161615403,4641.614889362947,133456.69505227194,0.0,0.0,1424.5240264320141,866556.8748248923,87.12322998355324,2504.985573561835,-7136.688121444882,-3724892.4164511547,true,true,12.74084671,7688.810407130001,0.0,121.92,1644.2724500334996,801.0,12.74084671,7688.810407130001,0.0,121.92,0.0,295.15 +802,30606.214995937007,29906.214995937007,0.3516666666666666,19719.92193247998,4276739.826448084,700.0,561400.0,58066.12871795256,17489697.567974992,38346.206785472576,13212957.741526864,true,802.0,802,0.875,17254.931690919984,19719.92193247998,2464.9902415599972,0.0,0.0,802,29906.214995937007,0.0,17254.931690919984,17254.931690919984,2050912.303303188,700.0,561400.0,1091.6010137358662,1032230.4171752762,14417.759310882255,147874.4543631542,0.0,0.0,1474.9496559208226,868031.8244808131,270.6217103810403,2775.6072839428753,-17254.931690919984,-3742147.348142075,true,true,13.41141759,7702.221824720002,0.0,121.92,1644.2724500334996,802.0,13.41141759,7702.221824720002,0.0,121.92,0.0,295.15 +803,42169.92193247998,41469.92193247998,0.335,14841.512914275521,4291581.33936236,700.0,562100.0,46392.57586350902,17536090.143838502,31551.062949233496,13244508.804476097,true,803.0,803,0.875,12986.323799991082,14841.512914275521,1855.1891142844397,0.0,0.0,803,41469.92193247998,0.0,12986.323799991082,12986.323799991082,2063898.627103179,700.0,562100.0,1237.6157767511554,1033468.0329520274,10022.601838474762,157897.05620162896,0.0,0.0,1537.9816923588444,869569.806173172,188.12449240631886,2963.731776349194,-12986.323799991082,-3755133.671942066,true,true,13.85846484,7716.080289560002,0.0,121.92,1644.2724500334996,803.0,13.85846484,7716.080289560002,0.0,121.92,0.0,295.15 +804,37291.51291427552,36591.51291427552,0.33999999999999997,15425.479878628494,4307006.819240988,700.0,562800.0,47427.88199596616,17583518.025834467,32002.402117337668,13276511.206593435,true,804.0,804,0.875,13497.294893799932,15425.479878628494,1928.184984828562,0.0,0.0,804,36591.51291427552,0.0,13497.294893799932,13497.294893799932,2077395.921996979,700.0,562800.0,1363.3833313570601,1034831.4162833844,10351.21173264913,168248.2679342781,0.0,0.0,1588.4073212836674,871158.2134944557,194.2925085100756,3158.0242848592698,-13497.294893799932,-3768630.9668358658,true,true,14.30551209,7730.385801650002,0.0,121.92,1644.2724500334996,804.0,14.30551209,7730.385801650002,0.0,121.92,0.0,295.15 +805,37875.479878628495,37175.479878628495,0.33999999999999997,16018.869061964053,4323025.688302952,700.0,563500.0,49173.14429989428,17632691.17013436,33154.275237930226,13309665.481831366,true,805.0,805,0.875,14016.510429218546,16018.869061964053,2002.3586327455068,0.0,0.0,805,37175.479878628495,0.0,14016.510429218546,14016.510429218546,2091412.4324261977,700.0,563500.0,1497.3950798833798,1036328.8113632678,10679.821869395772,178928.08980367385,0.0,0.0,1638.8329507724761,872797.0464452282,200.46052916691826,3358.484814026188,-14016.510429218546,-3782647.477265084,true,true,14.75255935,7745.138361000002,0.0,121.92,1644.2724500334996,805.0,14.75255935,7745.138361000002,0.0,121.92,0.0,295.15 +806,38468.869061964055,37768.869061964055,0.196,3693.280092087905,4326718.968395039,700.0,564200.0,22414.69434738727,17655105.86448175,18721.414255299365,13328386.896086665,true,806.0,806,0.875,3231.6200805769167,3693.280092087905,461.66001151098817,0.0,0.0,806,37768.869061964055,0.0,3231.6200805769167,3231.6200805769167,2094644.0525067747,700.0,564200.0,1567.5743147780436,1037896.3856780459,0.0,178928.08980367385,0.0,0.0,1664.0457657988732,874461.092211027,0.0,3358.484814026188,-3231.6200805769167,-3785879.097345661,true,true,14.75255935,7759.8909203500025,0.0,121.92,1644.2724500334996,806.0,14.75255935,7759.8909203500025,0.0,121.92,0.0,295.15 +807,26143.280092087905,25443.280092087905,0.3175,11404.28836633784,4338123.256761378,700.0,564900.0,38123.742886103435,17693229.607367855,26719.454519765597,13355106.35060643,true,807.0,807,0.875,9978.75232054561,11404.28836633784,1425.5360457922307,0.0,0.0,807,25443.280092087905,0.0,9978.75232054561,9978.75232054561,2104622.8048273204,700.0,564900.0,1610.7161737802023,1039507.1018518261,6565.625729708203,185493.71553338206,0.0,0.0,1679.17345447632,876140.2656655033,123.23696258088448,3481.7217766070726,-9978.75232054561,-3795857.8496662066,true,true,15.0207877,7774.911708050003,0.0,121.92,1644.2724500334996,807.0,15.0207877,7774.911708050003,0.0,121.92,0.0,295.15 +808,33854.28836633784,33154.28836633784,0.29250000000000004,9045.656531877703,4347168.9132932555,700.0,565600.0,33318.483869667354,17726548.091237523,24272.82733778965,13379379.17794422,true,808.0,808,0.875,7914.9494653929905,9045.656531877703,1130.7070664847124,0.0,0.0,808,33154.28836633784,0.0,7914.9494653929905,7914.9494653929905,2112537.7542927135,700.0,565600.0,1684.3658195392377,1041191.4676713654,4442.805798640346,189936.5213320224,0.0,0.0,1704.3862689387315,877844.6519344421,83.39157827467528,3565.113354881748,-7914.9494653929905,-3803772.7991315997,true,true,15.1996066,7790.111314650003,0.0,121.92,1644.2724500334996,808.0,15.1996066,7790.111314650003,0.0,121.92,0.0,295.15 +809,31495.656531877703,30795.656531877703,0.28625,7873.222071420243,4355042.135364676,700.0,566300.0,29950.1207735205,17756498.212011043,22076.898702100254,13401456.07664632,true,809.0,809,0.875,6889.069312492713,7873.222071420243,984.1527589275302,0.0,0.0,809,30795.656531877703,0.0,6889.069312492713,6889.069312492713,2119426.8236052063,700.0,566300.0,1737.2344888771113,1042928.7021602425,3366.6082618045,193303.12959382692,0.0,0.0,1722.0352387804269,879566.6871732225,63.19132303067399,3628.304677912422,-6889.069312492713,-3810661.8684440926,true,true,15.33372077,7805.445035420003,0.0,121.92,1644.2724500334996,809.0,15.33372077,7805.445035420003,0.0,121.92,0.0,295.15 +810,30323.22207142024,29623.22207142024,0.184,2666.290299206391,4357708.425663882,700.0,567000.0,18295.055973947776,17774793.26798499,15628.765674741386,13417084.842321062,true,810.0,810,0.875,2333.004011805592,2666.290299206391,333.28628740079876,0.0,0.0,810,29623.22207142024,0.0,2333.004011805592,2333.004011805592,2121759.827617012,700.0,567000.0,1752.5404318936303,1044681.2425921361,-1125.4887688338354,192177.64082499308,0.0,0.0,1727.0778016729093,881293.7649748954,-21.12545292711178,3607.17922498531,-2333.004011805592,-3812994.872455898,true,true,15.28901605,7820.734051470003,0.0,121.92,1644.2724500334996,810.0,15.28901605,7820.734051470003,0.0,121.92,0.0,295.15 +811,25116.29029920639,24416.29029920639,0.16,1332.507023642382,4359040.932687525,700.0,567700.0,12703.168897764886,17787496.436882757,11370.661874122505,13428455.504195185,true,811.0,811,0.875,1165.9436456870842,1332.507023642382,166.5633779552977,0.0,0.0,811,24416.29029920639,0.0,1165.9436456870842,1165.9436456870842,2122925.7712626993,700.0,567700.0,1729.6150511451326,1046410.8576432812,-2241.119492970665,189936.5213320224,0.0,0.0,1719.5139576161787,883013.2789325116,-42.06587010356221,3565.113354881748,-1165.9436456870842,-3814160.8161015855,true,true,15.1996066,7835.933658070003,0.0,121.92,1644.2724500334996,811.0,15.1996066,7835.933658070003,0.0,121.92,0.0,295.15 +812,23782.50702364238,23082.50702364238,0.20800000000000002,3918.7593953981846,4362959.692082923,700.0,568400.0,22205.574016337425,17809702.010899093,18286.81462093924,13446742.318816125,true,812.0,812,0.875,3428.9144709734114,3918.7593953981846,489.8449244247731,0.0,0.0,812,23082.50702364238,0.0,3428.9144709734114,3428.9144709734114,2126354.6857336727,700.0,568400.0,1714.4430762497152,1048125.3007195309,0.0,189936.5213320224,0.0,0.0,1714.4713947236962,884727.7503272353,0.0,3565.113354881748,-3428.9144709734114,-3817589.730572559,true,true,15.1996066,7851.133264670003,0.0,121.92,1644.2724500334996,812.0,15.1996066,7851.133264670003,0.0,121.92,0.0,295.15 +813,26368.759395398185,25668.759395398185,0.184,2608.3079392527093,4365568.000022176,700.0,569100.0,17979.934452460377,17827681.945351552,15371.626513207668,13462113.945329333,true,813.0,813,0.875,2282.2694468461204,2608.3079392527093,326.03849240658883,0.0,0.0,813,25668.759395398185,0.0,2282.2694468461204,2282.2694468461204,2128636.955180519,700.0,569100.0,1706.8904736661468,1049832.1911931972,-1115.6307226666315,188820.8906093558,0.0,0.0,1711.9501129954624,886439.7004402308,-20.940417148857104,3544.1729377328907,-2282.2694468461204,-3819872.000019405,true,true,15.15490187,7866.288166540003,0.0,121.92,1644.2724500334996,813.0,15.15490187,7866.288166540003,0.0,121.92,0.0,295.15 +814,25058.30793925271,24358.30793925271,0.12,0.0,4365568.000022176,700.0,569800.0,5833.333333333334,17833515.278684884,5833.333333333334,13467947.278662667,true,814.0,814,0.875,0.0,0.0,0.0,0.0,0.0,814,24358.30793925271,0.0,-10.859375140363909,-10.859375140363909,2128626.0958053786,700.0,569800.0,1676.9018747486716,1051509.093067946,-3327.175075973715,185493.71553338208,0.0,0.0,1701.8649872104977,888141.5654274413,-62.451161125818174,3481.7217766070726,-0.0,-3819872.000019405,true,true,15.0207877,7881.308954240003,0.0,121.92,1644.2724500334996,814.0,15.0207877,7881.308954240003,0.0,121.92,0.0,295.15 +815,22450.0,21750.0,0.12,0.0,4365568.000022176,700.0,570500.0,5833.333333333334,17839348.612018216,5833.333333333334,13473780.611996,true,815.0,815,0.875,0.0,0.0,0.0,0.0,0.0,815,21750.0,0.0,-2282.744528886049,-2282.744528886049,2126343.3512764927,700.0,570500.0,1617.982550741672,1053127.0756186876,-5479.57014376485,180014.14538961725,0.0,0.0,1681.6947356405685,889823.2601630818,-102.85167150343926,3378.8701051036333,-0.0,-3819872.000019405,true,true,14.79726407,7896.106218310003,0.0,121.92,1644.2724500334996,815.0,14.79726407,7896.106218310003,0.0,121.92,0.0,295.15 +816,22450.0,21750.0,0.1816,2439.813283526722,4368007.813305702,700.0,571200.0,17289.720724266088,17856638.332742482,14849.907440739365,13488630.51943674,true,816.0,816,0.875,2134.836623085882,2439.813283526722,304.9766604408401,0.0,0.0,816,21750.0,0.0,2134.836623085882,2134.836623085882,2128478.1878995784,700.0,571200.0,1574.7104531435575,1054701.7860718311,-1086.0555859433525,178928.08980367388,0.0,0.0,1666.5670469631218,891489.827210045,-20.385291077445224,3358.484814026188,-2134.836623085882,-3822006.8366424907,true,true,14.75255935,7910.858777660003,0.0,121.92,1644.2724500334996,816.0,14.75255935,7910.858777660003,0.0,121.92,0.0,295.15 +817,24889.81328352672,24189.81328352672,0.12,0.0,4368007.813305702,700.0,571900.0,5833.333333333334,17862471.666075815,5833.333333333334,13494463.852770073,true,817.0,817,0.875,0.0,0.0,0.0,0.0,0.0,817,24189.81328352672,0.0,-2298.332238798516,-2298.332238798516,2126179.85566078,700.0,571900.0,1532.216842854109,1056234.0029146853,-5380.987173307377,173547.1026303665,0.0,0.0,1651.4393582856746,893141.2665683306,-101.0012666309227,3257.4835473952653,-0.0,-3822006.8366424907,true,true,14.52903572,7925.3878133800035,0.0,121.92,1644.2724500334996,817.0,14.52903572,7925.3878133800035,0.0,121.92,0.0,295.15 +818,22450.0,21750.0,0.12,0.0,4368007.813305702,700.0,572600.0,5833.333333333334,17868304.999409147,5833.333333333334,13500297.186103407,true,818.0,818,0.875,0.0,0.0,0.0,0.0,0.0,818,21750.0,0.0,-2308.9624788806427,-2308.9624788806427,2123870.893181899,700.0,572600.0,1463.1049364844707,1057697.1078511698,-5298.8346960883955,168248.26793427812,0.0,0.0,1626.2265432592776,894767.4931115898,-99.45926253599555,3158.0242848592698,-0.0,-3822006.8366424907,true,true,14.30551209,7939.693325470003,0.0,121.92,1644.2724500334996,818.0,14.30551209,7939.693325470003,0.0,121.92,0.0,295.15 +819,22450.0,21750.0,0.1768,2244.7271876975233,4370252.5404934,700.0,573300.0,16655.69676299504,17884960.69617214,14410.969575297519,13514708.155678704,true,819.0,819,0.875,1964.1362892353327,2244.7271876975233,280.5908984621906,0.0,0.0,819,21750.0,0.0,1964.1362892353327,1964.1362892353327,2125835.0294711343,700.0,573300.0,1422.6527452880216,1059119.7605964579,-1049.908501259502,167198.35943301863,0.0,0.0,1611.098854581831,896378.5919661716,-19.706809375017883,3138.317475484252,-1964.1362892353327,-3823970.972931726,true,true,14.26080737,7953.954132840004,0.0,121.92,1644.2724500334996,819.0,14.26080737,7953.954132840004,0.0,121.92,0.0,295.15 +820,24694.727187697525,23994.727187697525,0.12,0.0,4370252.5404934,700.0,574000.0,5833.333333333334,17890794.029505473,5833.333333333334,13520541.489012038,true,820.0,820,0.875,0.0,0.0,0.0,0.0,0.0,820,23994.727187697525,0.0,-191.64285391372664,-191.64285391372664,2125643.3866172205,700.0,574000.0,1396.103152351972,1060515.8637488098,-3130.0093791011004,164068.35005391753,0.0,0.0,1601.013728796866,897979.6056949685,-58.75035596146432,3079.567119522788,-0.0,-3823970.972931726,true,true,14.12669319,7968.080826030004,0.0,121.92,1644.2724500334996,820.0,14.12669319,7968.080826030004,0.0,121.92,0.0,295.15 +821,22450.0,21750.0,0.1768,2176.6746875493723,4372429.215180949,700.0,574700.0,16270.78443184034,17907064.813937314,14094.109744290969,13534635.59875633,true,821.0,821,0.875,1904.5903516057006,2176.6746875493723,272.0843359436717,0.0,0.0,821,21750.0,0.0,1904.5903516057006,1904.5903516057006,2127547.9769688263,700.0,574700.0,1369.8859443148722,1061885.7496931246,-1036.764106962612,163031.5859469549,0.0,0.0,1590.9286030119015,899570.5342979804,-19.460088758460998,3060.1070307643267,-1904.5903516057006,-3825875.5632833317,true,true,14.08198847,7982.162814500004,0.0,121.92,1644.2724500334996,821.0,14.08198847,7982.162814500004,0.0,121.92,0.0,295.15 +822,24626.674687549374,23926.674687549374,0.12,0.0,4372429.215180949,700.0,575400.0,5833.333333333334,17912898.147270646,5833.333333333334,13540468.932089664,true,822.0,822,0.875,0.0,0.0,0.0,0.0,0.0,822,23926.674687549374,0.0,-6483.869724942868,-6483.869724942868,2121064.1072438834,700.0,575400.0,1305.7833678344905,1063191.533060959,-9183.003668016738,153848.58227893818,0.0,0.0,1565.7157885494898,901136.2500865299,-172.36521331010988,2887.7418174542167,-0.0,-3825875.5632833317,true,true,13.67964594,7995.842460440004,0.0,121.92,1644.2724500334996,822.0,13.67964594,7995.842460440004,0.0,121.92,0.0,295.15 +823,22450.0,21750.0,0.12,0.0,4372429.215180949,700.0,576100.0,5833.333333333334,17918731.480603978,5833.333333333334,13546302.265422998,true,823.0,823,0.875,0.0,0.0,0.0,0.0,0.0,823,21750.0,0.0,-3344.9373452009113,-3344.9373452009113,2117719.1698986827,700.0,576100.0,1213.4285375204897,1064404.9615984797,-5974.12791578394,147874.45436315425,0.0,0.0,1527.8965665738797,902664.1466531038,-112.13453351134136,2775.6072839428753,-0.0,-3825875.5632833317,true,true,13.41141759,8009.253878030005,0.0,121.92,1644.2724500334996,823.0,13.41141759,8009.253878030005,0.0,121.92,0.0,295.15 +824,22450.0,21750.0,0.17200000000000001,1919.3720224937144,4374348.587203443,700.0,576800.0,15228.907107521592,17933960.3877115,13309.535085027877,13559611.800508026,true,824.0,824,0.875,1679.450519682,1919.3720224937144,239.9215028117144,0.0,0.0,824,21750.0,0.0,1679.450519682,1679.450519682,2119398.6204183646,700.0,576800.0,1171.8628834918766,1065576.8244819716,-984.1867495604637,146890.26761359378,0.0,0.0,1510.247596168199,904174.394249272,-18.47321041761169,2757.1340735252634,-1679.450519682,-3827555.0138030136,true,true,13.36671286,8022.620590890005,0.0,121.92,1644.2724500334996,824.0,13.36671286,8022.620590890005,0.0,121.92,0.0,295.15 +825,24369.372022493713,23669.372022493713,0.1912,3055.691307172714,4377404.278510616,700.0,577500.0,19642.736962200386,17953603.124673698,16587.045655027672,13576198.846163053,true,825.0,825,0.875,2673.7298937761248,3055.691307172714,381.96141339658925,0.0,0.0,825,23669.372022493713,0.0,2673.7298937761248,2673.7298937761248,2122072.350312141,700.0,577500.0,1166.0035793361596,1066742.8280613078,0.0,146890.26761359378,0.0,0.0,1507.726314439965,905682.120563712,0.0,2757.1340735252634,-2673.7298937761248,-3830228.7436967897,true,true,13.36671286,8035.987303750005,0.0,121.92,1644.2724500334996,825.0,13.36671286,8035.987303750005,0.0,121.92,0.0,295.15 +826,25505.691307172714,24805.691307172714,0.1912,3055.691307172714,4380459.969817789,700.0,578200.0,19642.736962200386,17973245.861635897,16587.045655027672,13592785.89181808,true,826.0,826,0.875,2673.7298937761248,3055.691307172714,381.96141339658925,0.0,0.0,826,24805.691307172714,0.0,2673.7298937761248,2673.7298937761248,2124746.080205917,700.0,578200.0,1166.0035793361596,1067908.831640644,0.0,146890.26761359378,0.0,0.0,1507.726314439965,907189.846878152,0.0,2757.1340735252634,-2673.7298937761248,-3832902.473590566,true,true,13.36671286,8049.354016610005,0.0,121.92,1644.2724500334996,826.0,13.36671286,8049.354016610005,0.0,121.92,0.0,295.15 +827,25505.691307172714,24805.691307172714,0.1912,3055.691307172714,4383515.661124962,700.0,578900.0,19642.736962200386,17992888.598598097,16587.045655027672,13609372.937473107,true,827.0,827,0.875,2673.7298937761248,3055.691307172714,381.96141339658925,0.0,0.0,827,24805.691307172714,0.0,2673.7298937761248,2673.7298937761248,2127419.810099693,700.0,578900.0,1166.0035793361596,1069074.8352199802,0.0,146890.26761359378,0.0,0.0,1507.726314439965,908697.573192592,0.0,2757.1340735252634,-2673.7298937761248,-3835576.203484342,true,true,13.36671286,8062.720729470005,0.0,121.92,1644.2724500334996,827.0,13.36671286,8062.720729470005,0.0,121.92,0.0,295.15 +828,25505.691307172714,24805.691307172714,0.12,0.0,4383515.661124962,700.0,579600.0,5833.333333333334,17998721.93193143,5833.333333333334,13615206.270806441,true,828.0,828,0.875,0.0,0.0,0.0,0.0,0.0,828,24805.691307172714,0.0,-339.1873668912551,-339.1873668912551,2127080.622732802,700.0,579600.0,1148.5429202219773,1070223.3781402023,-2932.843215460603,143957.42439813318,0.0,0.0,1500.1624703832342,910197.7356629752,-55.04954203586372,2702.0845314893995,-0.0,-3835576.203484342,true,true,13.23259869,8075.953328160004,0.0,121.92,1644.2724500334996,828.0,13.23259869,8075.953328160004,0.0,121.92,0.0,295.15 +829,22450.0,21750.0,0.1696,1858.6776077127756,4385374.338732675,700.0,580300.0,15086.54249830646,18013808.474429734,13227.864890593684,13628434.135697035,true,829.0,829,0.875,1626.3429067486786,1858.6776077127756,232.334700964097,0.0,0.0,829,21750.0,0.0,1626.3429067486786,1626.3429067486786,2128706.9656395507,700.0,580300.0,1125.534404219617,1071348.9125444219,-971.0423523233416,142986.38204580985,0.0,0.0,1490.0773445982697,911687.8130075735,-18.226489745866665,2683.858041743533,-1626.3429067486786,-3837202.546391091,true,true,13.18789396,8089.141222120004,0.0,121.92,1644.2724500334996,829.0,13.18789396,8089.141222120004,0.0,121.92,0.0,295.15 +830,24308.677607712776,23608.677607712776,0.1912,2979.8705779713114,4388354.209310646,700.0,581000.0,19246.185031230707,18033054.659460966,16266.314453259396,13644700.450150294,true,830.0,830,0.875,2607.3867557248973,2979.8705779713114,372.4838222464141,0.0,0.0,830,23608.677607712776,0.0,2607.3867557248973,2607.3867557248973,2131314.3523952756,700.0,581000.0,1119.8306928548616,1072468.7432372768,0.0,142986.38204580985,0.0,0.0,1487.5560628700357,913175.3690704436,0.0,2683.858041743533,-2607.3867557248973,-3839809.9331468157,true,true,13.18789396,8102.3291160800045,0.0,121.92,1644.2724500334996,830.0,13.18789396,8102.3291160800045,0.0,121.92,0.0,295.15 +831,25429.870577971313,24729.870577971313,0.14,711.4291647275921,4389065.638475373,700.0,581700.0,10081.636890911372,18043136.296351876,9370.20772618378,13654070.657876479,true,831.0,831,0.875,622.5005191366431,711.4291647275921,88.92864559094903,0.0,0.0,831,24729.870577971313,0.0,622.5005191366431,622.5005191366431,2131936.852914412,700.0,581700.0,1108.4811443252456,1073577.2243816021,-1932.2261902415157,141054.15585556833,0.0,0.0,1482.5134999775537,914657.8825704211,-36.267934924640436,2647.5901068188923,-622.5005191366431,-3840432.433665952,true,true,13.09848451,8115.427600590005,0.0,121.92,1644.2724500334996,831.0,13.09848451,8115.427600590005,0.0,121.92,0.0,295.15 +832,23161.429164727593,22461.429164727593,0.12,0.0,4389065.638475373,700.0,582400.0,5833.333333333334,18048969.62968521,5833.333333333334,13659903.991209812,true,832.0,832,0.875,0.0,0.0,0.0,0.0,0.0,832,22461.429164727593,0.0,-1354.5359631710262,-1354.5359631710262,2130582.316951241,700.0,582400.0,1074.8931266278387,1074652.11750823,-3825.019193182142,137229.13666238618,0.0,0.0,1467.3858113001065,916125.2683817212,-71.79570791682987,2575.7943989020623,-0.0,-3840432.433665952,true,true,12.91966561,8128.347266200005,0.0,121.92,1644.2724500334996,832.0,12.91966561,8128.347266200005,0.0,121.92,0.0,295.15 +833,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,583100.0,5833.333333333334,18054802.96301854,5833.333333333334,13665737.324543146,true,833.0,833,0.875,0.0,0.0,0.0,0.0,0.0,833,21750.0,0.0,-4235.794721628112,-4235.794721628112,2126346.522229613,700.0,583100.0,1015.0902503183833,1075667.2077585484,-6567.268882456041,130661.86777993014,0.0,0.0,1439.6517151094608,917564.9200968307,-123.26780459991525,2452.5265943021473,-0.0,-3840432.433665952,true,true,12.60673253,8140.953998730005,0.0,121.92,1644.2724500334996,833.0,12.60673253,8140.953998730005,0.0,121.92,0.0,295.15 +834,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,583800.0,5833.333333333334,18060636.296351872,5833.333333333334,13671570.65787648,true,834.0,834,0.875,0.0,0.0,0.0,0.0,0.0,834,21750.0,0.0,-2316.697759506005,-2316.697759506005,2124029.824470107,700.0,583800.0,952.427125113243,1076619.6348836618,-4592.323198682849,126069.54458124729,0.0,0.0,1409.3963377545672,918974.3164345853,-86.19802369096637,2366.328570611181,-0.0,-3840432.433665952,true,true,12.38320891,8153.337207640005,0.0,121.92,1644.2724500334996,834.0,12.38320891,8153.337207640005,0.0,121.92,0.0,295.15 +835,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,584500.0,5833.333333333334,18066469.629685204,5833.333333333334,13677403.991209814,true,835.0,835,0.875,0.0,0.0,0.0,0.0,0.0,835,21750.0,0.0,-4137.784847028056,-4137.784847028056,2119892.039623079,700.0,584500.0,892.3974305014219,1077512.0323141632,-6291.236566939175,119778.30801430812,0.0,0.0,1379.1409603996733,920353.4573949849,-118.0866709899764,2248.2418996212045,-0.0,-3840432.433665952,true,true,12.07027583,8165.407483470005,0.0,121.92,1644.2724500334996,835.0,12.07027583,8165.407483470005,0.0,121.92,0.0,295.15 +836,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,585200.0,5833.333333333334,18072302.963018537,5833.333333333334,13683237.324543148,true,836.0,836,0.875,0.0,0.0,0.0,0.0,0.0,836,21750.0,0.0,-11069.212650598878,-11069.212650598878,2108822.82697248,700.0,585200.0,788.9949839284826,1078301.0272980917,-12939.014765045522,106839.2932492626,0.0,0.0,1323.6727680183824,921677.1301630032,-242.86563750022063,2005.376262120984,-0.0,-3840432.433665952,true,true,11.39970495,8176.807188420005,0.0,121.92,1644.2724500334996,836.0,11.39970495,8176.807188420005,0.0,121.92,0.0,295.15 +837,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,585900.0,5833.333333333334,18078136.29635187,5833.333333333334,13689070.657876482,true,837.0,837,0.875,0.0,0.0,0.0,0.0,0.0,837,21750.0,0.0,-12934.126534978386,-12934.126534978386,2095888.7004375015,700.0,585900.0,649.3691312688386,1078950.3964293606,-14550.84638748677,92288.44686177582,0.0,0.0,1240.470479446446,922917.6006424497,-273.11975820690026,1732.2565039140836,-0.0,-3840432.433665952,true,true,10.59501989,8187.402208310005,0.0,121.92,1644.2724500334996,837.0,10.59501989,8187.402208310005,0.0,121.92,0.0,295.15 +838,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,586600.0,5833.333333333334,18083969.6296852,5833.333333333334,13694903.991209816,true,838.0,838,0.875,0.0,0.0,0.0,0.0,0.0,838,21750.0,0.0,-11331.8132362759,-11331.8132362759,2084556.8872012256,700.0,586600.0,520.4091594953464,1079470.8055888559,-12764.85143660032,79523.5954251755,0.0,0.0,1152.2256282076216,924069.8262706574,-239.59658737854753,1492.659916535536,-0.0,-3840432.433665952,true,true,9.835039564,8197.237247874005,0.0,121.92,1644.2724500334996,838.0,9.835039564,8197.237247874005,0.0,121.92,0.0,295.15 +839,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,587300.0,5833.333333333334,18089802.963018533,5833.333333333334,13700737.32454315,true,839.0,839,0.875,0.0,0.0,0.0,0.0,0.0,839,21750.0,0.0,-9180.936213145482,-9180.936213145482,2075375.9509880801,700.0,587300.0,418.56520403034614,1079889.3707928862,-10474.440522719358,69049.15490245614,0.0,0.0,1071.544621589513,925141.3708922468,-196.6055160459838,1296.0544004895523,-0.0,-3840432.433665952,true,true,9.164468684,8206.401716558006,0.0,121.92,1644.2724500334996,839.0,9.164468684,8206.401716558006,0.0,121.92,0.0,295.15 +840,22450.0,21750.0,0.12,0.0,4389065.638475373,700.0,588000.0,5833.333333333334,18095636.296351865,5833.333333333334,13706570.657876484,true,840.0,840,0.875,0.0,0.0,0.0,0.0,0.0,840,21750.0,0.0,-7296.827678331779,-7296.827678331779,2068079.1233097482,700.0,588000.0,341.1676563245566,1080230.5384492108,-8479.778417889507,60569.37648456663,0.0,0.0,1000.9487406435721,926142.3196328904,-159.16565741039994,1136.8887430791524,-0.0,-3840432.433665952,true,true,8.583307256,8214.985023814006,0.0,121.92,1644.2724500334996,840.0,8.583307256,8214.985023814006,0.0,121.92,0.0,295.15 +841,22450.0,21750.0,0.16240000000000002,1459.3257413904846,4390524.964216764,700.0,588700.0,13296.340772108895,18108932.637123972,11837.01503071841,13718407.672907203,true,841.0,841,0.875,1276.910023716674,1459.3257413904846,182.4157176738106,0.0,0.0,841,21750.0,0.0,1276.910023716674,1276.910023716674,2069356.033333465,700.0,588700.0,308.7379420434323,1080539.2763912543,0.0,60569.37648456663,0.0,0.0,968.1720816732416,927110.4917145637,0.0,1136.8887430791524,-1276.910023716674,-3841709.343689669,true,true,8.583307256,8223.568331070006,0.0,121.92,1644.2724500334996,841.0,8.583307256,8223.568331070006,0.0,121.92,0.0,295.15 +842,23909.325741390487,23209.325741390487,0.28625,8276.994130063078,4398801.958346827,700.0,589400.0,31360.678183626474,18140293.3153076,23083.684053563396,13741491.356960766,true,842.0,842,0.875,7242.369863805193,8276.994130063078,1034.6242662578852,0.0,0.0,842,23209.325741390487,0.0,7242.369863805193,7242.369863805193,2076598.4031972701,700.0,589400.0,330.95883788694795,1080870.2352291413,5811.466045071076,66380.84252963771,0.0,0.0,990.863614802209,928101.3553293659,109.08136604495968,1245.970109124112,-7242.369863805193,-3848951.7135534743,true,true,8.985649783,8232.553980853007,0.0,121.92,1644.2724500334996,842.0,8.985649783,8232.553980853007,0.0,121.92,0.0,295.15 +843,30726.994130063078,30026.994130063078,0.28625,7885.572017878172,4406687.530364705,700.0,590100.0,29993.264691277458,18170286.579998877,22107.692673399288,13763599.049634166,true,843.0,843,0.875,6899.875515643401,7885.572017878172,985.6965022347713,0.0,0.0,843,30026.994130063078,0.0,6899.875515643401,6899.875515643401,2083498.2787129136,700.0,590100.0,375.7923214181441,1081246.0275505595,5389.202329292834,71770.04485893055,0.0,0.0,1033.725399613903,929135.0807289798,101.1554653185201,1347.1255744426321,-6899.875515643401,-3855851.589069118,true,true,9.343287585,8241.897268438006,0.0,121.92,1644.2724500334996,843.0,9.343287585,8241.897268438006,0.0,121.92,0.0,295.15 +844,30335.57201787817,29635.57201787817,0.23500000000000001,5736.528373374279,4412424.05873808,700.0,590800.0,27389.482439890548,18197676.062438767,21652.954066516268,13785252.003700683,true,844.0,844,0.875,5019.4623267024945,5736.528373374279,717.0660466717845,0.0,0.0,844,29635.57201787817,0.0,5019.4623267024945,5019.4623267024945,2088517.741039616,700.0,590800.0,412.6838123532025,1081658.7113629128,3475.0496844069985,75245.09454333755,0.0,0.0,1066.5020586406322,930201.5827876204,65.22677130166099,1412.3523457442932,-5019.4623267024945,-3860871.0513958205,true,true,9.566811212,8251.464079650006,0.0,121.92,1644.2724500334996,844.0,9.566811212,8251.464079650006,0.0,121.92,0.0,295.15 +845,28186.52837337428,27486.52837337428,0.265,6741.44925180282,4419165.5079898825,700.0,591500.0,28080.940572840827,18225757.003011607,21339.491321038007,13806591.495021721,true,845.0,845,0.875,5898.768095327468,6741.44925180282,842.6811564753525,0.0,0.0,845,27486.52837337428,0.0,5898.768095327468,5898.768095327468,2094416.5091349436,700.0,591500.0,445.7234879233887,1082104.4348508362,4278.5008818379565,79523.5954251755,0.0,0.0,1094.2361547748792,931295.8189423953,80.30757079124295,1492.6599165355362,-5898.768095327468,-3866769.819491148,true,true,9.835039564,8261.299119214007,0.0,121.92,1644.2724500334996,845.0,9.835039564,8261.299119214007,0.0,121.92,0.0,295.15 +846,29191.44925180282,28491.44925180282,0.265,6957.1974259183335,4426122.705415801,700.0,592200.0,28895.084626106916,18254652.087637715,21937.887200188583,13828529.38222191,true,846.0,846,0.875,6087.547747678542,6957.1974259183335,869.6496782397917,0.0,0.0,846,28491.44925180282,0.0,6087.547747678542,6087.547747678542,2100504.056882622,700.0,592200.0,483.7276452736252,1082588.1624961097,4396.800511954977,83920.39593713048,0.0,0.0,1124.4915325809613,932420.3104749762,82.52805786897848,1575.1879744045148,-6087.547747678542,-3872857.3672388266,true,true,10.10326792,8271.402387134007,0.0,121.92,1644.2724500334996,846.0,10.10326792,8271.402387134007,0.0,121.92,0.0,295.15 +847,29407.197425918333,28707.197425918333,0.28,7175.346654623566,4433298.052070425,700.0,592900.0,28126.238052227018,18282778.32568994,20950.891397603453,13849480.273619512,true,847.0,847,0.875,6278.42832279562,7175.346654623566,896.9183318279456,0.0,0.0,847,28707.197425918333,0.0,6278.42832279562,6278.42832279562,2106782.485205418,700.0,592900.0,523.8328938474393,1083111.9953899572,4515.099976828838,88435.49591395931,0.0,0.0,1154.7469102742466,933575.0573852505,84.74854184509532,1659.9365162496101,-6278.42832279562,-3879135.7955616224,true,true,10.37149627,8281.773883404006,0.0,121.92,1644.2724500334996,847.0,10.37149627,8281.773883404006,0.0,121.92,0.0,295.15 +848,29625.346654623565,28925.346654623565,0.29250000000000004,9238.863032659527,4442536.915103084,700.0,593600.0,33979.0189150753,18316757.344605017,24740.155882415773,13874220.429501928,true,848.0,848,0.875,8084.005153577085,9238.863032659527,1154.8578790824413,0.0,0.0,848,28925.346654623565,0.0,8084.005153577085,8084.005153577085,2114866.4903589953,700.0,593600.0,573.3533150677572,1083685.348705025,6204.154843176141,94639.65075713546,0.0,0.0,1190.044850521623,934765.1022357721,116.45214481156428,1776.3886610611744,-8084.005153577085,-3887219.8007151997,true,true,10.72913407,8292.503017474006,0.0,121.92,1644.2724500334996,848.0,10.72913407,8292.503017474006,0.0,121.92,0.0,295.15 +849,31688.863032659527,30988.863032659527,0.3175,11518.821616399087,4454055.7367194835,700.0,594300.0,38484.477531965626,18355241.822136983,26965.655915566538,13901186.085417494,true,849.0,849,0.875,10078.968914349201,11518.821616399087,1439.852702049886,0.0,0.0,849,30988.863032659527,0.0,10078.968914349201,10078.968914349201,2124945.4592733444,700.0,594300.0,641.4821435603176,1084326.8308485853,8050.942458727084,102690.59321586255,0.0,0.0,1235.4279165539635,936000.530152326,151.1163955078356,1927.5050565690099,-10078.968914349201,-3897298.769629549,true,true,11.17618132,8303.679198794005,0.0,121.92,1644.2724500334996,849.0,11.17618132,8303.679198794005,0.0,121.92,0.0,295.15 +850,33968.82161639909,33268.82161639909,0.3175,12052.538489204004,4466108.275208687,700.0,595000.0,40165.475556548045,18395407.297693532,28112.937067344043,13929299.022484839,true,850.0,850,0.875,10545.971178053504,12052.538489204004,1506.5673111505002,0.0,0.0,850,33268.82161639909,0.0,10545.971178053504,10545.971178053504,2135491.430451398,700.0,595000.0,723.2806727928487,1085050.1115213782,8379.552544019009,111070.14575988156,0.0,0.0,1285.8535460427722,937286.3836983688,157.28441519887352,2084.7894717678832,-10545.971178053504,-3907844.740807602,true,true,11.62322858,8315.302427374005,0.0,121.92,1644.2724500334996,850.0,11.62322858,8315.302427374005,0.0,121.92,0.0,295.15 +851,34502.538489204,33802.538489204,0.29250000000000004,8460.001863090596,4474568.277071778,700.0,595700.0,31316.245685779813,18426723.54337931,22856.24382268922,13952155.266307529,true,851.0,851,0.875,7402.501630204271,8460.001863090596,1057.5002328863247,0.0,0.0,851,33802.538489204,0.0,7402.501630204271,7402.501630204271,2142893.932081602,700.0,595700.0,793.5121203230937,1085843.6236417012,5185.46416535502,116255.60992523658,0.0,0.0,1326.1940497466162,938612.5777481154,97.33129477954175,2182.120766547425,-7402.501630204271,-3915247.2424378064,true,true,11.89145693,8327.193884304004,0.0,121.92,1644.2724500334996,851.0,11.89145693,8327.193884304004,0.0,121.92,0.0,295.15 +852,30910.001863090598,30210.001863090598,0.1816,2471.199073769774,4477039.476145548,700.0,596400.0,17462.549965692586,18444186.093345,14991.350891922812,13967146.617199453,true,852.0,852,0.875,2162.299189548552,2471.199073769774,308.8998842212218,0.0,0.0,852,30210.001863090598,0.0,2162.299189548552,2162.299189548552,2145056.2312711505,700.0,596400.0,820.9774511244888,1086664.6010928256,0.0,116255.60992523658,0.0,0.0,1341.3217384240631,939953.8994865394,0.0,2182.120766547425,-2162.299189548552,-3917409.541627355,true,true,11.89145693,8339.085341234004,0.0,121.92,1644.2724500334996,852.0,11.89145693,8339.085341234004,0.0,121.92,0.0,295.15 +853,24921.199073769774,24221.199073769774,0.22,4530.685487844309,4481570.161633392,700.0,597100.0,23775.84312656504,18467961.936471567,19245.15763872073,13986391.774838174,true,853.0,853,0.875,3964.34980186377,4530.685487844309,566.335685980539,0.0,0.0,853,24221.199073769774,0.0,3964.34980186377,3964.34980186377,2149020.581073014,700.0,597100.0,830.2714476801368,1087494.8725405058,1754.7768466522741,118010.38677188885,0.0,0.0,1346.3643013165454,941300.263787856,32.93720621481408,2215.057972762239,-3964.34980186377,-3921373.8914292185,true,true,11.98086638,8351.066207614003,0.0,121.92,1644.2724500334996,853.0,11.98086638,8351.066207614003,0.0,121.92,0.0,295.15 +854,26980.68548784431,26280.68548784431,0.22,4578.998785058628,4486149.160418451,700.0,597800.0,23995.449022993762,18491957.38549456,19416.450237935132,14005808.22507611,true,854.0,854,0.875,4006.6239369262994,4578.998785058628,572.3748481323282,0.0,0.0,854,26280.68548784431,0.0,4006.6239369262994,4006.6239369262994,2153027.2050099405,700.0,597800.0,849.0693405465553,1088343.9418810525,1767.9212424192683,119778.30801430812,0.0,0.0,1356.4494271015103,942656.7132149575,33.183926858965414,2248.2418996212045,-4006.6239369262994,-3925380.515366145,true,true,12.07027583,8363.136483444003,0.0,121.92,1644.2724500334996,854.0,12.07027583,8363.136483444003,0.0,121.92,0.0,295.15 +855,27028.998785058626,26328.998785058626,0.22,4627.633923578913,4490776.79434203,700.0,598500.0,24216.517834449605,18516173.90332901,19588.883910870692,14025397.10898698,true,855.0,855,0.875,4049.1796831315487,4627.633923578913,578.4542404473641,0.0,0.0,855,26328.998785058626,0.0,4049.1796831315487,4049.1796831315487,2157076.384693072,700.0,598500.0,868.1488445557432,1089212.0907256082,1781.065638186216,121559.37365249434,0.0,0.0,1366.5345528864746,944023.247767844,33.430647503114876,2281.6725471243194,-4049.1796831315487,-3929429.6950492766,true,true,12.15968528,8375.296168724002,0.0,121.92,1644.2724500334996,855.0,12.15968528,8375.296168724002,0.0,121.92,0.0,295.15 +856,27077.633923578913,26377.633923578913,0.29250000000000004,8934.515909767073,4499711.310251797,700.0,599200.0,32938.5159308276,18549112.41925984,24004.000021060525,14049401.10900804,true,856.0,856,0.875,7817.701421046188,8934.515909767073,1116.8144887208846,0.0,0.0,856,26377.633923578913,0.0,7817.701421046188,7817.701421046188,2164894.0861141183,700.0,599200.0,907.161061054948,1090119.2517866632,5422.06328916059,126981.43694165493,0.0,0.0,1386.704804456404,945409.9525723004,101.77226637424626,2383.4448134985655,-7817.701421046188,-3937247.3964703227,true,true,12.42791363,8387.724082354001,0.0,121.92,1644.2724500334996,856.0,12.42791363,8387.724082354001,0.0,121.92,0.0,295.15 +857,31384.515909767073,30684.515909767073,0.25,5907.355844272249,4505618.666096069,700.0,599900.0,26429.423377088995,18575541.842636928,20522.067532816745,14069923.176540857,true,857.0,857,0.875,5168.936363738218,5907.355844272249,738.4194805340312,0.0,0.0,857,30684.515909767073,0.0,5168.936363738218,5168.936363738218,2170063.0224778564,700.0,599900.0,952.427125113243,1091071.6789117765,2755.394083570766,129736.83102522569,0.0,0.0,1409.3963377545672,946819.348910055,51.718817299641884,2435.1636307982076,-5168.936363738218,-3942416.332834061,true,true,12.56202781,8400.286110164001,0.0,121.92,1644.2724500334996,857.0,12.56202781,8400.286110164001,0.0,121.92,0.0,295.15 +858,28357.35584427225,27657.35584427225,0.30500000000000005,10407.054048018803,4516025.720144087,700.0,600600.0,36416.57064924197,18611958.413286168,26009.516601223168,14095932.69314208,true,858.0,858,0.875,9106.172292016452,10407.054048018803,1300.8817560023508,0.0,0.0,858,27657.35584427225,0.0,9106.172292016452,9106.172292016452,2179169.194769873,700.0,600600.0,1004.461119889405,1092076.140031666,6544.265980369629,136281.0970055953,0.0,0.0,1434.6091522169786,948253.9580622719,122.83603954044027,2557.999670338648,-9106.172292016452,-3951522.505126077,true,true,12.87496088,8413.161071044002,0.0,121.92,1644.2724500334996,858.0,12.87496088,8413.161071044002,0.0,121.92,0.0,295.15 +859,32857.05404801881,32157.054048018806,0.20800000000000002,3963.4752053269017,4519989.195349414,700.0,601300.0,22420.55387176395,18634378.967157934,18457.07866643705,14114389.771808518,true,859.0,859,0.875,3468.040804661039,3963.4752053269017,495.43440066586254,0.0,0.0,859,32157.054048018806,0.0,3468.040804661039,3468.040804661039,2182637.2355745337,700.0,601300.0,1047.4270155198526,1093123.567047186,948.0396567908635,137229.13666238618,0.0,0.0,1454.779403786908,949708.7374660588,17.794728563414726,2575.7943989020623,-3468.040804661039,-3954990.545930738,true,true,12.91966561,8426.080736654001,0.0,121.92,1644.2724500334996,859.0,12.91966561,8426.080736654001,0.0,121.92,0.0,295.15 +860,26413.475205326904,25713.475205326904,0.20800000000000002,3985.5548750564617,4523974.75022447,700.0,602000.0,22526.70613007914,18656905.673288014,18541.151255022676,14132930.92306354,true,860.0,860,0.875,3487.360515674404,3985.5548750564617,498.1943593820579,0.0,0.0,860,25713.475205326904,0.0,3487.360515674404,3487.360515674404,2186124.5960902083,700.0,602000.0,1058.356600959824,1094181.9236481457,951.3255432981376,138180.4622056843,0.0,0.0,1459.82196667939,951168.5594327382,17.856404737052035,2593.650803639114,-3487.360515674404,-3958477.9064464127,true,true,12.96437033,8439.045106984002,0.0,121.92,1644.2724500334996,860.0,12.96437033,8439.045106984002,0.0,121.92,0.0,295.15 +861,26435.554875056463,25735.554875056463,0.20800000000000002,4007.7216323819034,4527982.471856852,700.0,602700.0,22633.277078759147,18679538.950366773,18625.555446377242,14151556.478509918,true,861.0,861,0.875,3506.7564283341653,4007.7216323819034,500.9652040477381,0.0,0.0,861,25735.554875056463,0.0,3506.7564283341653,3506.7564283341653,2189631.3525185427,700.0,602700.0,1069.361954453522,1095251.2856025994,954.6118554094829,139135.0740610938,0.0,0.0,1464.8645295718727,952633.4239623101,17.918088899287984,2611.568892538402,-3506.7564283341653,-3961984.662874747,true,true,13.00907506,8452.054182044001,0.0,121.92,1644.2724500334996,861.0,13.00907506,8452.054182044001,0.0,121.92,0.0,295.15 +862,26457.7216323819,25757.7216323819,0.1696,1784.796045390427,4529767.267902243,700.0,603400.0,14650.92007895299,18694189.870445725,12866.124033562563,14164422.60254348,true,862.0,862,0.875,1561.6965397166236,1784.796045390427,223.09950567380338,0.0,0.0,862,25757.7216323819,0.0,1561.6965397166236,1561.6965397166236,2191193.0490582595,700.0,603400.0,1069.361954453522,1096320.647557053,-954.6118554094829,138180.4622056843,0.0,0.0,1464.8645295718727,954098.2884918819,-17.918088899287984,2593.650803639114,-1561.6965397166236,-3963546.359414464,true,true,12.96437033,8465.018552374002,0.0,121.92,1644.2724500334996,862.0,12.96437033,8465.018552374002,0.0,121.92,0.0,295.15 +863,24234.796045390427,23534.796045390427,0.12,0.0,4529767.267902243,700.0,604100.0,5833.333333333334,18700023.203779057,5833.333333333334,14170255.935876815,true,863.0,863,0.875,0.0,0.0,0.0,0.0,0.0,863,23534.796045390427,0.0,-6147.376387871692,-6147.376387871692,2185045.6726703877,700.0,604100.0,1015.0902503183833,1097335.7378073714,-8443.63118045863,129736.83102522568,0.0,0.0,1439.6517151094608,955537.9402069914,-158.48717284090702,2435.163630798207,-0.0,-3963546.359414464,true,true,12.56202781,8477.580580184002,0.0,121.92,1644.2724500334996,863.0,12.56202781,8477.580580184002,0.0,121.92,0.0,295.15 +864,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,604800.0,5833.333333333334,18705856.53711239,5833.333333333334,14176089.269210149,true,864.0,864,0.875,0.0,0.0,0.0,0.0,0.0,864,21750.0,0.0,-3245.088269393007,-3245.088269393007,2181800.5844009947,700.0,604800.0,937.1750250423974,1098272.9128324138,-5481.2132744607015,124255.61775076497,0.0,0.0,1401.832493133851,956939.7727001252,-102.88251310855414,2332.281117689653,-0.0,-3963546.359414464,true,true,12.29379945,8489.874379634002,0.0,121.92,1644.2724500334996,864.0,12.29379945,8489.874379634002,0.0,121.92,0.0,295.15 +865,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,605500.0,5833.333333333334,18711689.87044572,5833.333333333334,14181922.602543483,true,865.0,865,0.875,0.0,0.0,0.0,0.0,0.0,865,21750.0,0.0,-2304.6060187210624,-2304.6060187210624,2179495.9783822736,700.0,605500.0,882.6445388610508,1099155.5573712748,-4477.30973645687,119778.3080143081,0.0,0.0,1374.0983969432057,958313.8710970684,-84.03921806844889,2248.241899621204,-0.0,-3963546.359414464,true,true,12.07027583,8501.944655464002,0.0,121.92,1644.2724500334996,865.0,12.07027583,8501.944655464002,0.0,121.92,0.0,295.15 +866,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,606200.0,5833.333333333334,18717523.203779053,5833.333333333334,14187755.935876817,true,866.0,866,0.875,0.0,0.0,0.0,0.0,0.0,866,21750.0,0.0,-8471.929802488148,-8471.929802488148,2171024.0485797855,700.0,606200.0,802.5980481462836,1099958.1554194211,-10410.361707658323,109367.94630664978,0.0,0.0,1331.236612075113,959645.1077091435,-195.40275505122125,2052.8391445699826,-0.0,-3963546.359414464,true,true,11.53381912,8513.478474584002,0.0,121.92,1644.2724500334996,866.0,11.53381912,8513.478474584002,0.0,121.92,0.0,295.15 +867,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,606900.0,5833.333333333334,18723356.537112385,5833.333333333334,14193589.26921015,true,867.0,867,0.875,0.0,0.0,0.0,0.0,0.0,867,21750.0,0.0,-4807.071382953114,-4807.071382953114,2166216.977196832,700.0,606900.0,714.8048132488018,1100672.96023267,-6677.353090787247,102690.59321586254,0.0,0.0,1280.8109825863046,960925.9186917299,-125.3340880009735,1927.5050565690092,-0.0,-3963546.359414464,true,true,11.17618132,8524.654655904002,0.0,121.92,1644.2724500334996,867.0,11.17618132,8524.654655904002,0.0,121.92,0.0,295.15 +868,22450.0,21750.0,0.12,0.0,4529767.267902243,700.0,607600.0,5833.333333333334,18729189.870445717,5833.333333333334,14199422.602543484,true,868.0,868,0.875,0.0,0.0,0.0,0.0,0.0,868,21750.0,0.0,-2233.5218365004366,-2233.5218365004366,2163983.4553603316,700.0,607600.0,661.3204135987122,1101334.2806462687,-4066.547376089585,98624.04583977295,0.0,0.0,1248.0343240671623,962173.9530157971,-76.32919807672575,1851.1758584922834,-0.0,-3963546.359414464,true,true,10.9526577,8535.607313604001,0.0,121.92,1644.2724500334996,868.0,10.9526577,8535.607313604001,0.0,121.92,0.0,295.15 +869,22450.0,21750.0,0.22,4996.584096672255,4534763.851998915,700.0,608300.0,25893.56407578298,18755083.4345215,20896.97997911072,14220319.582522595,true,869.0,869,0.875,4372.011084588224,4996.584096672255,624.5730120840317,0.0,0.0,869,21750.0,0.0,4372.011084588224,4372.011084588224,2168355.46644492,700.0,608300.0,653.3367529164735,1101987.6173991852,2430.0700928102124,101054.11593258317,0.0,0.0,1242.9917611746798,963416.9447769717,45.61247768685836,1896.7883361791417,-4372.011084588224,-3967918.370499052,true,true,11.08677187,8546.694085474,0.0,121.92,1644.2724500334996,869.0,11.08677187,8546.694085474,0.0,121.92,0.0,295.15 +870,27446.584096672254,26746.584096672254,0.22,5075.902333791998,4539839.754332707,700.0,609000.0,26254.101517236355,18781337.536038738,21178.199183444358,14241497.781706039,true,870.0,870,0.875,4441.414542067998,5075.902333791998,634.4877917240001,0.0,0.0,870,26746.584096672254,0.0,4441.414542067998,4441.414542067998,2172796.8809869876,700.0,609000.0,677.4823240752958,1102665.0997232604,2459.6451655826645,103513.76109816584,0.0,0.0,1258.1194498521268,964675.0642268239,46.167602557911074,1942.9559387370527,-4441.414542067998,-3972359.78504112,true,true,11.22088605,8557.914971524,0.0,121.92,1644.2724500334996,870.0,11.22088605,8557.914971524,0.0,121.92,0.0,295.15 +871,27525.902333791997,26825.902333791997,0.25,6137.275802641789,4545977.030135349,700.0,609700.0,27349.103210567155,18808686.639249306,21211.827407925368,14262709.609113963,true,871.0,871,0.875,5370.116327311565,6137.275802641789,767.1594753302234,0.0,0.0,871,26825.902333791997,0.0,5370.116327311565,5370.116327311565,2178166.997314299,700.0,609700.0,706.3954325730705,1103371.4951558334,3325.532151096757,106839.2932492626,0.0,0.0,1275.7684202578077,965950.8326470817,62.42032338393042,2005.3762621209833,-5370.116327311565,-3977729.9013684313,true,true,11.39970495,8569.314676474,0.0,121.92,1644.2724500334996,871.0,11.39970495,8569.314676474,0.0,121.92,0.0,295.15 +872,28587.275802641787,27887.275802641787,0.20800000000000002,4270.608332440132,4550247.63846779,700.0,610400.0,23897.155444423708,18832583.79469373,19626.54711198358,14282336.156225948,true,872.0,872,0.875,3736.782290885115,4270.608332440132,533.8260415550167,0.0,0.0,872,27887.275802641787,0.0,3736.782290885115,3736.782290885115,2181903.779605184,700.0,610400.0,731.8232700928227,1104103.3184259261,1682.4826691988467,108521.77591846144,0.0,0.0,1290.8961089352545,967241.7287560169,31.580242658190524,2036.9565047791739,-3736.782290885115,-3981466.6836593165,true,true,11.4891144,8580.803790873999,0.0,121.92,1644.2724500334996,872.0,11.4891144,8580.803790873999,0.0,121.92,0.0,295.15 +873,26720.608332440133,26020.608332440133,0.28,7330.903198138462,4557578.541665928,700.0,611100.0,28681.797136208792,18861265.59182994,21350.89393807033,14303687.050164018,true,873.0,873,0.875,6414.540298371155,7330.903198138462,916.3628997673077,0.0,0.0,873,26020.608332440133,0.0,6414.540298371155,6414.540298371155,2188318.3199035553,700.0,611100.0,762.2517069876488,1104865.5701329138,4263.713500771498,112785.48941923294,0.0,0.0,1308.5450793409352,968550.2738353579,80.03001127107308,2116.986516050247,-6414.540298371155,-3987881.2239576876,true,true,11.71263803,8592.516428903999,0.0,121.92,1644.2724500334996,873.0,11.71263803,8592.516428903999,0.0,121.92,0.0,295.15 +874,29780.90319813846,29080.90319813846,0.29250000000000004,9573.719355116233,4567152.261021045,700.0,611800.0,35123.826855098225,18896389.418685038,25550.10749998199,14329237.157664,true,874.0,874,0.875,8377.004435726703,9573.719355116233,1196.7149193895293,0.0,0.0,874,29080.90319813846,0.0,8377.004435726703,8377.004435726703,2196695.3243392822,700.0,611800.0,816.356575297534,1105681.9267082112,6107.214825528112,118892.70424476104,0.0,0.0,1338.8004566958293,969889.0742920537,114.63257820522746,2231.6190942554745,-8377.004435726703,-3996258.2283934145,true,true,12.0255711,8604.542000004,0.0,121.92,1644.2724500334996,874.0,12.0255711,8604.542000004,0.0,121.92,0.0,295.15 +875,32023.719355116235,31323.719355116235,0.29250000000000004,8814.797141268693,4575967.058162314,700.0,612500.0,32529.220995790398,18928918.63968083,23714.423854521705,14352951.581518522,true,875.0,875,0.875,7712.947498610107,8814.797141268693,1101.8496426585862,0.0,0.0,875,31323.719355116235,0.0,7712.947498610107,7712.947498610107,2204408.2718378925,700.0,612500.0,877.7948539570205,1106559.721562168,5362.913506003936,124255.61775076498,0.0,0.0,1371.5771152149716,971260.6514072687,100.66202343417847,2332.281117689653,-7712.947498610107,-4003971.1758920248,true,true,12.29379945,8616.835799454,0.0,121.92,1644.2724500334996,875.0,12.29379945,8616.835799454,0.0,121.92,0.0,295.15 +876,31264.797141268693,30564.797141268693,0.23500000000000001,5820.957904344539,4581788.016066658,700.0,613200.0,27748.757039763994,18956667.396720592,21927.799135419453,14374879.38065394,true,876.0,876,0.875,5093.338166301472,5820.957904344539,727.6197380430676,0.0,0.0,876,30564.797141268693,0.0,5093.338166301472,5093.338166301472,2209501.610004194,700.0,613200.0,922.0866310894885,1107481.8081932575,2725.819190889936,126981.43694165492,0.0,0.0,1394.2686485131348,972654.9200557818,51.16369580891225,2383.444813498565,-5093.338166301472,-4009064.5140583264,true,true,12.42791363,8629.263713084,0.0,121.92,1644.2724500334996,876.0,12.42791363,8629.263713084,0.0,121.92,0.0,295.15 +877,28270.95790434454,27570.95790434454,0.29250000000000004,9176.182398284534,4590964.198464943,700.0,613900.0,33764.72614798131,18990432.12286857,24588.543749696775,14399467.924403638,true,877.0,877,0.875,8029.159598498967,9176.182398284534,1147.0227997855673,0.0,0.0,877,27570.95790434454,0.0,8029.159598498967,8029.159598498967,2217530.769602693,700.0,613900.0,967.8438134527646,1108449.6520067104,5540.362851063305,132521.79979271823,0.0,0.0,1416.9601818112978,974071.8802375931,103.9927521715989,2487.437565670164,-8029.159598498967,-4017093.6736568254,true,true,12.69614198,8641.959855064,0.0,121.92,1644.2724500334996,877.0,12.69614198,8641.959855064,0.0,121.92,0.0,295.15 +878,31626.182398284534,30926.182398284534,0.29250000000000004,9420.874673652263,4600385.073138596,700.0,614600.0,34601.280935563285,19025033.403804135,25180.406261911023,14424648.33066555,true,878.0,878,0.875,8243.26533944573,9420.874673652263,1177.6093342065324,0.0,0.0,878,30926.182398284534,0.0,8243.26533944573,8243.26533944573,2225774.034942139,700.0,614600.0,1031.174129344498,1109480.826136055,5658.66241296609,138180.4622056843,0.0,0.0,1447.215559166192,975519.0957967592,106.21323796895003,2593.650803639114,-8243.26533944573,-4025336.938996271,true,true,12.96437033,8654.924225394001,0.0,121.92,1644.2724500334996,878.0,12.96437033,8654.924225394001,0.0,121.92,0.0,295.15 +879,31870.874673652263,31170.874673652263,0.22,5132.213012485917,4605517.286151081,700.0,615300.0,26510.059147663258,19051543.462951798,21377.84613517734,14446026.176800726,true,879.0,879,0.875,4490.686385925177,5132.213012485917,641.5266265607397,0.0,0.0,879,31170.874673652263,0.0,4490.686385925177,4490.686385925177,2230264.7213280643,700.0,615300.0,1074.8931253884425,1110555.7192614435,1912.5095958559955,140092.9718015403,0.0,0.0,1467.3858107361211,976986.4816074953,35.897853944617346,2629.5486575837317,-4490.686385925177,-4029827.6253821966,true,true,13.05377978,8667.978005174002,0.0,121.92,1644.2724500334996,879.0,13.05377978,8667.978005174002,0.0,121.92,0.0,295.15 +880,27582.213012485918,26882.213012485918,0.1696,1799.3976282215428,4607316.683779303,700.0,616000.0,14737.014317344001,19066280.477269143,12937.616689122458,14458963.79348985,true,880.0,880,0.875,1574.47292469385,1799.3976282215428,224.92470352769283,0.0,0.0,880,26882.213012485918,0.0,1574.47292469385,1574.47292469385,2231839.1942527583,700.0,616000.0,1080.443337721337,1111636.1625991648,-957.8977404465126,139135.07406109376,0.0,0.0,1469.907092464355,978456.3886999597,-17.97976504532936,2611.5688925384025,-1574.47292469385,-4031402.0983068906,true,true,13.00907506,8680.987080234001,0.0,121.92,1644.2724500334996,880.0,13.00907506,8680.987080234001,0.0,121.92,0.0,295.15 +881,24249.397628221544,23549.397628221544,0.1696,1784.796045390427,4609101.479824694,700.0,616700.0,14650.92007895299,19080931.397348095,12866.124033562563,14471829.917523412,true,881.0,881,0.875,1561.6965397166236,1784.796045390427,223.09950567380338,0.0,0.0,881,23549.397628221544,0.0,1561.6965397166236,1561.6965397166236,2233400.890792475,700.0,616700.0,1069.361954453522,1112705.5245536184,-954.6118554094829,138180.46220568428,0.0,0.0,1464.8645295718727,979921.2532295316,-17.918088899287984,2593.6508036391147,-1561.6965397166236,-4032963.7948466074,true,true,12.96437033,8693.951450564002,0.0,121.92,1644.2724500334996,881.0,12.96437033,8693.951450564002,0.0,121.92,0.0,295.15 +882,24234.796045390427,23534.796045390427,0.16720000000000002,1770.2818509760275,4610871.76167567,700.0,617400.0,14774.412984306382,19095705.810332403,13004.131133330355,14484834.048656743,true,882.0,882,0.875,1548.996619604024,1770.2818509760275,221.2852313720034,0.0,0.0,882,23534.796045390427,0.0,1548.996619604024,1548.996619604024,2234949.887412079,700.0,617400.0,1058.356600959824,1113763.8811545782,-951.3255432981376,137229.13666238615,0.0,0.0,1459.82196667939,981381.075196211,-17.856404737052035,2575.7943989020628,-1548.996619604024,-4034512.7914662114,true,true,12.91966561,8706.871116174001,0.0,121.92,1644.2724500334996,882.0,12.91966561,8706.871116174001,0.0,121.92,0.0,295.15 +883,24220.281850976025,23520.281850976025,0.12,0.0,4610871.76167567,700.0,618100.0,5833.333333333334,19101539.143665735,5833.333333333334,14490667.381990077,true,883.0,883,0.875,0.0,0.0,0.0,0.0,0.0,883,23520.281850976025,0.0,-1364.8607451741839,-1364.8607451741839,2233585.026666905,700.0,618100.0,1031.1741305500552,1114795.0552851283,-3772.4416101141883,133456.69505227197,0.0,0.0,1447.2155597301771,982828.2907559412,-70.80882534022791,2504.985573561835,-0.0,-4034512.7914662114,true,true,12.74084671,8719.611962884,0.0,121.92,1644.2724500334996,883.0,12.74084671,8719.611962884,0.0,121.92,0.0,295.15 +884,22450.0,21750.0,0.12,0.0,4610871.76167567,700.0,618800.0,5833.333333333334,19107372.476999067,5833.333333333334,14496500.71532341,true,884.0,884,0.875,0.0,0.0,0.0,0.0,0.0,884,21750.0,0.0,-1373.9837071332058,-1373.9837071332058,2232211.0429597716,700.0,618800.0,988.6569545164776,1115783.7122396447,-3719.8640270463043,129736.83102522566,0.0,0.0,1427.045308160248,984255.3360641014,-69.82194276362708,2435.1636307982076,-0.0,-4034512.7914662114,true,true,12.56202781,8732.173990694,0.0,121.92,1644.2724500334996,884.0,12.56202781,8732.173990694,0.0,121.92,0.0,295.15 +885,22450.0,21750.0,0.1648,1643.5123732545853,4612515.274048924,700.0,619500.0,14220.342070719571,19121592.819069788,12576.829697464986,14509077.545020876,true,885.0,885,0.875,1438.0733265977622,1643.5123732545853,205.43904665682317,0.0,0.0,885,21750.0,0.0,1438.0733265977622,1438.0733265977622,2233649.1162863695,700.0,619500.0,962.6865754872817,1116746.398815132,-921.7508623166427,128815.08016290903,0.0,0.0,1414.4389006470494,985669.7749647485,-17.30128721992617,2417.8623435782815,-1438.0733265977622,-4035950.8647928094,true,true,12.51732308,8744.691313774,0.0,121.92,1644.2724500334996,885.0,12.51732308,8744.691313774,0.0,121.92,0.0,295.15 +886,24093.512373254584,23393.512373254584,0.1864,2707.9603524932495,4615223.234401418,700.0,620200.0,18283.049101358632,19139875.868171148,15575.088748865383,14524652.633769741,true,886.0,886,0.875,2369.4653084315933,2707.9603524932495,338.49504406165624,0.0,0.0,886,23393.512373254584,0.0,2369.4653084315933,2369.4653084315933,2236018.581594801,700.0,620200.0,957.5476895127775,1117703.9465046448,0.0,128815.08016290903,0.0,0.0,1411.9176189188156,987081.6925836673,0.0,2417.8623435782815,-2369.4653084315933,-4038320.330101241,true,true,12.51732308,8757.208636853999,0.0,121.92,1644.2724500334996,886.0,12.51732308,8757.208636853999,0.0,121.92,0.0,295.15 +887,25157.96035249325,24457.96035249325,0.12,0.0,4615223.234401418,700.0,620900.0,5833.333333333334,19145709.20150448,5833.333333333334,14530485.967103075,true,887.0,887,0.875,0.0,0.0,0.0,0.0,0.0,887,24457.96035249325,0.0,-1383.7228680803555,-1383.7228680803555,2234634.858726721,700.0,620900.0,937.1750250423974,1118641.1215296872,-3654.142046741322,125160.9381161677,0.0,0.0,1401.832493133851,988483.5250768012,-68.58833951528196,2349.2740040629997,-0.0,-4038320.330101241,true,true,12.33850418,8769.547141033998,0.0,121.92,1644.2724500334996,887.0,12.33850418,8769.547141033998,0.0,121.92,0.0,295.15 +888,22450.0,21750.0,0.12,0.0,4615223.234401418,700.0,621600.0,5833.333333333334,19151542.534837812,5833.333333333334,14536319.30043641,true,888.0,888,0.875,0.0,0.0,0.0,0.0,0.0,888,21750.0,0.0,-1390.2029774790847,-1390.2029774790847,2233244.655749242,700.0,621600.0,897.3007015690653,1119538.4222312563,-3601.5644636733914,121559.37365249431,0.0,0.0,1381.6622415639217,989865.1873183651,-67.60145693868,2281.67254712432,-0.0,-4038320.330101241,true,true,12.15968528,8781.706826313997,0.0,121.92,1644.2724500334996,888.0,12.15968528,8781.706826313997,0.0,121.92,0.0,295.15 +889,22450.0,21750.0,0.12,0.0,4615223.234401418,700.0,622300.0,5833.333333333334,19157375.868171144,5833.333333333334,14542152.633769743,true,889.0,889,0.875,0.0,0.0,0.0,0.0,0.0,889,21750.0,0.0,-3197.796740186587,-3197.796740186587,2230046.8590090554,700.0,622300.0,849.0693405465553,1120387.4915718029,-5303.763727257759,116255.60992523655,0.0,0.0,1356.4494271015103,991221.6367454666,-99.55178057689437,2182.1207665474253,-0.0,-4038320.330101241,true,true,11.89145693,8793.598283243997,0.0,121.92,1644.2724500334996,889.0,11.89145693,8793.598283243997,0.0,121.92,0.0,295.15 +890,22450.0,21750.0,0.265,6605.555897068623,4621828.790298486,700.0,623000.0,27568.135460636313,19184944.00363178,20962.57956356769,14563115.21333331,true,890.0,890,0.875,5779.861409935045,6605.555897068623,825.6944871335781,0.0,0.0,890,21750.0,0.0,5779.861409935045,5779.861409935045,2235826.7204189906,700.0,623000.0,839.6353235806953,1121227.1268953835,3522.698089071542,119778.3080143081,0.0,0.0,1351.4068642090278,992573.0436096756,66.1211330737795,2248.241899621205,-5779.861409935045,-4044100.191511176,true,true,12.07027583,8805.668559073996,0.0,121.92,1644.2724500334996,890.0,12.07027583,8805.668559073996,0.0,121.92,0.0,295.15 +891,29055.555897068625,28355.555897068625,0.28625,7792.105017519515,4629620.895316006,700.0,623700.0,29666.742419282153,19214610.746051066,21874.637401762637,14584989.850735074,true,891.0,891,0.875,6818.091890329576,7792.105017519515,974.013127189939,0.0,0.0,891,28355.555897068625,0.0,6818.091890329576,6818.091890329576,2242644.81230932,700.0,623700.0,882.6445388610508,1122109.7714342445,4477.30973645687,124255.61775076497,0.0,0.0,1374.0983969432057,993947.1420066188,84.03921806844889,2332.281117689654,-6818.091890329576,-4050918.2834015056,true,true,12.29379945,8817.962358523997,0.0,121.92,1644.2724500334996,891.0,12.29379945,8817.962358523997,0.0,121.92,0.0,295.15 +892,30242.105017519516,29542.105017519516,0.23500000000000001,5820.957904344539,4635441.85322035,700.0,624400.0,27748.757039763994,19242359.50309083,21927.799135419453,14606917.649870493,true,892.0,892,0.875,5093.338166301472,5820.957904344539,727.6197380430676,0.0,0.0,892,29542.105017519516,0.0,5093.338166301472,5093.338166301472,2247738.1504756217,700.0,624400.0,922.0866310894885,1123031.858065334,2725.819190889936,126981.4369416549,0.0,0.0,1394.2686485131348,995341.4106551319,51.16369580891225,2383.444813498566,-5093.338166301472,-4056011.621567807,true,true,12.42791363,8830.390272153996,0.0,121.92,1644.2724500334996,892.0,12.42791363,8830.390272153996,0.0,121.92,0.0,295.15 +893,28270.95790434454,27570.95790434454,0.22,4825.440748163381,4640267.293968514,700.0,625100.0,25115.639764379004,19267475.14285521,20290.19901621562,14627207.848886708,true,893.0,893,0.875,4222.260654642958,4825.440748163381,603.1800935204228,0.0,0.0,893,27570.95790434454,0.0,4222.260654642958,4222.260654642958,2251960.411130265,700.0,625100.0,947.3248472827859,1123979.1829126168,1833.643221254123,128815.08016290903,0.0,0.0,1406.8750560263334,996748.2857111583,34.41753007971571,2417.8623435782815,-4222.260654642958,-4060233.8822224503,true,true,12.51732308,8842.907595233995,0.0,121.92,1644.2724500334996,893.0,12.51732308,8842.907595233995,0.0,121.92,0.0,295.15 +894,27275.440748163383,26575.440748163383,0.136,555.5876022574632,4640822.881570771,700.0,625800.0,9232.261781304876,19276707.404636513,8676.674179047413,14635884.523065755,true,894.0,894,0.875,486.13915197528036,555.5876022574632,69.44845028218288,0.0,0.0,894,26575.440748163383,0.0,486.13915197528036,486.13915197528036,2252446.5502822404,700.0,625800.0,947.3248472827859,1124926.5077598996,-1833.643221254123,126981.4369416549,0.0,0.0,1406.8750560263334,998155.1607671847,-34.41753007971571,2383.444813498566,-486.13915197528036,-4060720.021374426,true,true,12.42791363,8855.335508863995,0.0,121.92,1644.2724500334996,894.0,12.42791363,8855.335508863995,0.0,121.92,0.0,295.15 +895,23005.587602257463,22305.587602257463,0.22,4825.440748163381,4645648.322318935,700.0,626500.0,25115.639764379004,19301823.044400893,20290.19901621562,14656174.72208197,true,895.0,895,0.875,4222.260654642958,4825.440748163381,603.1800935204228,0.0,0.0,895,22305.587602257463,0.0,4222.260654642958,4222.260654642958,2256668.8109368836,700.0,626500.0,947.3248472827859,1125873.8326071824,1833.643221254123,128815.08016290903,0.0,0.0,1406.8750560263334,999562.0358232111,34.41753007971571,2417.8623435782815,-4222.260654642958,-4064942.282029069,true,true,12.51732308,8867.852831943994,0.0,121.92,1644.2724500334996,895.0,12.51732308,8867.852831943994,0.0,121.92,0.0,295.15 +896,27275.440748163383,26575.440748163383,0.1864,2707.9603524932495,4648356.282671428,700.0,627200.0,18283.049101358632,19320106.093502253,15575.088748865383,14671749.810830835,true,896.0,896,0.875,2369.4653084315933,2707.9603524932495,338.49504406165624,0.0,0.0,896,26575.440748163383,0.0,2369.4653084315933,2369.4653084315933,2259038.276245315,700.0,627200.0,957.5476895127775,1126831.3802966953,0.0,128815.08016290903,0.0,0.0,1411.9176189188156,1000973.9534421299,0.0,2417.8623435782815,-2369.4653084315933,-4067311.7473375006,true,true,12.51732308,8880.370155023993,0.0,121.92,1644.2724500334996,896.0,12.51732308,8880.370155023993,0.0,121.92,0.0,295.15 +897,25157.96035249325,24457.96035249325,0.1864,2707.9603524932495,4651064.243023922,700.0,627900.0,18283.049101358632,19338389.142603613,15575.088748865383,14687324.8995797,true,897.0,897,0.875,2369.4653084315933,2707.9603524932495,338.49504406165624,0.0,0.0,897,24457.96035249325,0.0,2369.4653084315933,2369.4653084315933,2261407.7415537466,700.0,627900.0,957.5476895127775,1127788.9279862081,0.0,128815.08016290903,0.0,0.0,1411.9176189188156,1002385.8710610487,0.0,2417.8623435782815,-2369.4653084315933,-4069681.212645932,true,true,12.51732308,8892.887478103992,0.0,121.92,1644.2724500334996,897.0,12.51732308,8892.887478103992,0.0,121.92,0.0,295.15 +898,25157.96035249325,24457.96035249325,0.12,0.0,4651064.243023922,700.0,628600.0,5833.333333333334,19344222.475936946,5833.333333333334,14693158.232913034,true,898.0,898,0.875,0.0,0.0,0.0,0.0,0.0,898,24457.96035249325,0.0,-450.47475417775206,-450.47475417775206,2260957.2667995687,700.0,628600.0,942.2408255890183,1128731.1688117972,-2745.535581661755,126069.54458124728,0.0,0.0,1404.353774862085,1003790.2248359108,-51.53377296710045,2366.328570611181,-0.0,-4069681.212645932,true,true,12.38320891,8905.270687013992,0.0,121.92,1644.2724500334996,898.0,12.38320891,8905.270687013992,0.0,121.92,0.0,295.15 +899,22450.0,21750.0,0.12,0.0,4651064.243023922,700.0,629300.0,5833.333333333334,19350055.809270278,5833.333333333334,14698991.566246368,true,899.0,899,0.875,0.0,0.0,0.0,0.0,0.0,899,21750.0,0.0,-465.59524904338764,-465.59524904338764,2260491.6715505254,700.0,629300.0,912.1182149113199,1129643.2870267085,-2715.9608947997485,123353.58368644753,0.0,0.0,1389.2260861846378,1005179.4509220954,-50.97865533959681,2315.349915271584,-0.0,-4069681.212645932,true,true,12.24909473,8917.519781743991,0.0,121.92,1644.2724500334996,899.0,12.24909473,8917.519781743991,0.0,121.92,0.0,295.15 +900,22450.0,21750.0,0.12,0.0,4651064.243023922,700.0,630000.0,5833.333333333334,19355889.14260361,5833.333333333334,14704824.899579702,true,900.0,900,0.875,0.0,0.0,0.0,0.0,0.0,900,21750.0,0.0,-2302.5914615293414,-2302.5914615293414,2258189.080088996,700.0,630000.0,872.9629671225366,1130516.249993831,-4460.879441686492,118892.70424476103,0.0,0.0,1369.0558340507232,1006548.5067561462,-83.73082101610918,2231.619094255475,-0.0,-4069681.212645932,true,true,12.0255711,8929.545352843992,0.0,121.92,1644.2724500334996,900.0,12.0255711,8929.545352843992,0.0,121.92,0.0,295.15 +901,22450.0,21750.0,0.12,0.0,4651064.243023922,700.0,630700.0,5833.333333333334,19361722.47593694,5833.333333333334,14710658.232913036,true,901.0,901,0.875,0.0,0.0,0.0,0.0,0.0,901,21750.0,0.0,-502.76243092060474,-502.76243092060474,2257686.317658075,700.0,630700.0,834.9446338311274,1131351.194627662,-2637.0943195244763,116255.60992523655,0.0,0.0,1348.885582480794,1007897.392338627,-49.498327708049914,2182.120766547425,-0.0,-4069681.212645932,true,true,11.89145693,8941.436809773992,0.0,121.92,1644.2724500334996,901.0,11.89145693,8941.436809773992,0.0,121.92,0.0,295.15 +902,22450.0,21750.0,0.16240000000000002,1447.2246571307292,4652511.467681052,700.0,631400.0,13221.826706470005,19374944.30264341,11774.602049339275,14722432.834962375,true,902.0,902,0.875,1266.321574989388,1447.2246571307292,180.9030821413412,0.0,0.0,902,21750.0,0.0,1266.321574989388,1266.321574989388,2258952.6392330644,700.0,631400.0,816.356575297534,1132167.5512029594,-872.4593723099905,115383.15055292656,0.0,0.0,1338.8004566958293,1009236.1927953229,-16.37608469398493,2165.74468185344,-1266.321574989388,-4070947.5342209213,true,true,11.8467522,8953.28356197399,0.0,121.92,1644.2724500334996,902.0,11.8467522,8953.28356197399,0.0,121.92,0.0,295.15 +903,23897.22465713073,23197.22465713073,0.1816,2454.8939955807286,4654966.361676632,700.0,632100.0,17372.764292845422,19392317.066936255,14917.870297264693,14737350.70525964,true,903.0,903,0.875,2148.0322461331375,2454.8939955807286,306.86174944759114,0.0,0.0,903,23197.22465713073,0.0,2148.0322461331375,2148.0322461331375,2261100.6714791977,700.0,632100.0,811.7530711655421,1132979.304274125,0.0,115383.15055292656,0.0,0.0,1336.2791749675953,1010572.4719702904,0.0,2165.74468185344,-2148.0322461331375,-4073095.5664670547,true,true,11.8467522,8965.13031417399,0.0,121.92,1644.2724500334996,903.0,11.8467522,8965.13031417399,0.0,121.92,0.0,295.15 +904,24904.89399558073,24204.89399558073,0.1816,2454.8939955807286,4657421.255672213,700.0,632800.0,17372.764292845422,19409689.8312291,14917.870297264693,14752268.575556904,true,904.0,904,0.875,2148.0322461331375,2454.8939955807286,306.86174944759114,0.0,0.0,904,24204.89399558073,0.0,2148.0322461331375,2148.0322461331375,2263248.703725331,700.0,632800.0,811.7530711655421,1133791.0573452907,0.0,115383.15055292656,0.0,0.0,1336.2791749675953,1011908.751145258,0.0,2165.74468185344,-2148.0322461331375,-4075243.598713188,true,true,11.8467522,8976.97706637399,0.0,121.92,1644.2724500334996,904.0,11.8467522,8976.97706637399,0.0,121.92,0.0,295.15 +905,24904.89399558073,24204.89399558073,0.132,418.5226088226869,4657839.778281036,700.0,633500.0,8473.656127444598,19418163.487356544,8055.13351862191,14760323.709075525,true,905.0,905,0.875,366.20728271985104,418.5226088226869,52.315326102835854,0.0,0.0,905,24204.89399558073,0.0,366.20728271985104,366.20728271985104,2263614.9110080507,700.0,633500.0,802.5980481462832,1134593.655393437,-1735.0602522667537,113648.09030065981,0.0,0.0,1331.2366120751128,1013239.9877573331,-32.56712523479136,2133.1775566186484,-366.20728271985104,-4075609.8059959076,true,true,11.75734275,8988.734409123988,0.0,121.92,1644.2724500334996,905.0,11.75734275,8988.734409123988,0.0,121.92,0.0,295.15 +906,22868.52260882269,22168.52260882269,0.16240000000000002,1410.1438056589407,4659249.922086695,700.0,634200.0,12993.49634026441,19431156.983696807,11583.352534605468,14771907.06161013,true,906.0,906,0.875,1233.875829951573,1410.1438056589407,176.26797570736767,0.0,0.0,906,22168.52260882269,0.0,1233.875829951573,1233.875829951573,2264848.786838002,700.0,634200.0,788.9949839284826,1135382.6503773655,-862.600881426891,112785.48941923292,0.0,0.0,1323.6727680183824,1014563.6605253514,-16.19104056840125,2116.9865160502472,-1233.875829951573,-4076843.681825859,true,true,11.71263803,9000.447047153988,0.0,121.92,1644.2724500334996,906.0,11.71263803,9000.447047153988,0.0,121.92,0.0,295.15 +907,23860.14380565894,23160.14380565894,0.1792,2406.4531551969244,4661656.375241892,700.0,634900.0,17335.118053554266,19448492.101750363,14928.664898357341,14786835.726508487,true,907.0,907,0.875,2105.646510797309,2406.4531551969244,300.8066443996154,0.0,0.0,907,23160.14380565894,0.0,2105.646510797309,2105.646510797309,2266954.433348799,700.0,634900.0,784.4950239431748,1136167.1454013088,0.0,112785.48941923292,0.0,0.0,1321.151486854134,1015884.8120122056,0.0,2116.9865160502472,-2105.646510797309,-4078949.328336656,true,true,11.71263803,9012.159685183988,0.0,121.92,1644.2724500334996,907.0,11.71263803,9012.159685183988,0.0,121.92,0.0,295.15 +908,24856.453155196923,24156.453155196923,0.12,0.0,4661656.375241892,700.0,635600.0,5833.333333333334,19454325.435083695,5833.333333333334,14792669.059841821,true,908.0,908,0.875,0.0,0.0,0.0,0.0,0.0,908,24156.453155196923,0.0,-531.6039743088604,-531.6039743088604,2266422.8293744903,700.0,635600.0,771.09786723211,1136938.2432685408,-2568.086435805657,110217.40298342727,0.0,0.0,1313.5876422334177,1017198.3996544391,-48.20304796873122,2068.783468081516,-0.0,-4078949.328336656,true,true,11.57852385,9023.738209033987,0.0,121.92,1644.2724500334996,908.0,11.57852385,9023.738209033987,0.0,121.92,0.0,295.15 +909,22450.0,21750.0,0.12,0.0,4661656.375241892,700.0,636300.0,5833.333333333334,19460158.768417027,5833.333333333334,14798502.393175155,true,909.0,909,0.875,0.0,0.0,0.0,0.0,0.0,909,21750.0,0.0,-542.9366434770149,-542.9366434770149,2265879.8927310132,700.0,636300.0,744.7628731337587,1137683.0061416745,-2538.5115431247573,107678.89144030251,0.0,0.0,1298.4599529919853,1018496.8596074311,-47.64792647800159,2021.1355416035142,-0.0,-4078949.328336656,true,true,11.44440967,9035.182618703988,0.0,121.92,1644.2724500334996,909.0,11.44440967,9035.182618703988,0.0,121.92,0.0,295.15 +910,22450.0,21750.0,0.1792,2311.6792885770324,4663968.05453047,700.0,637000.0,16806.24603000576,19476965.014447033,14494.566741428729,14812996.959916584,true,910.0,910,0.875,2022.7193775049032,2311.6792885770324,288.9599110721292,0.0,0.0,910,21750.0,0.0,2022.7193775049032,2022.7193775049032,2267902.6121085184,700.0,637000.0,731.823269133634,1138414.8294108082,0.0,107678.89144030251,0.0,0.0,1290.896108371269,1019787.7557158024,0.0,2021.1355416035142,-2022.7193775049032,-4080972.047714161,true,true,11.44440967,9046.627028373989,0.0,121.92,1644.2724500334996,910.0,11.44440967,9046.627028373989,0.0,121.92,0.0,295.15 +911,24761.679288577034,24061.679288577034,0.23500000000000001,5290.722623689718,4669258.77715416,700.0,637700.0,25492.436696551988,19502457.451143585,20201.71407286227,14833198.673989447,true,911.0,911,0.875,4629.382295728503,5290.722623689718,661.3403279612148,0.0,0.0,911,24061.679288577034,0.0,4629.382295728503,4629.382295728503,2272531.994404247,700.0,637700.0,744.7628731337587,1139159.5922839418,2538.5115431247573,110217.40298342727,0.0,0.0,1298.4599529919853,1021086.2156687945,47.64792647800159,2068.783468081516,-4629.382295728503,-4085601.43000989,true,true,11.57852385,9058.205552223988,0.0,121.92,1644.2724500334996,911.0,11.57852385,9058.205552223988,0.0,121.92,0.0,295.15 +912,27740.72262368972,27040.72262368972,0.16,1361.7999746315206,4670620.577128791,700.0,638400.0,12886.249841447005,19515343.700985033,11524.449866815485,14844723.123856263,true,912.0,912,0.875,1191.5749778025806,1361.7999746315206,170.22499682894,0.0,0.0,912,27040.72262368972,0.0,1191.5749778025806,1191.5749778025806,2273723.5693820496,700.0,638400.0,753.4734622071352,1139913.065746149,-849.4566767774891,109367.94630664977,0.0,0.0,1303.5025158844676,1022389.7181846789,-15.944323511532993,2052.8391445699826,-1191.5749778025806,-4086793.0049876925,true,true,11.53381912,9069.739371343989,0.0,121.92,1644.2724500334996,912.0,11.53381912,9069.739371343989,0.0,121.92,0.0,295.15 +913,23811.79997463152,23111.79997463152,0.12,0.0,4670620.577128791,700.0,639100.0,5833.333333333334,19521177.034318365,5833.333333333334,14850556.457189597,true,913.0,913,0.875,0.0,0.0,0.0,0.0,0.0,913,23111.79997463152,0.0,-546.5788726751621,-546.5788726751621,2273176.9905093745,700.0,639100.0,736.1196770615325,1140649.1854232105,-2528.6530573871983,106839.29324926257,0.0,0.0,1293.417390099503,1023683.1355747784,-47.46288244899939,2005.3762621209833,-0.0,-4086793.0049876925,true,true,11.39970495,9081.139076293988,0.0,121.92,1644.2724500334996,913.0,11.39970495,9081.139076293988,0.0,121.92,0.0,295.15 +914,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,639800.0,5833.333333333334,19527010.367651697,5833.333333333334,14856389.790522931,true,914.0,914,0.875,0.0,0.0,0.0,0.0,0.0,914,21750.0,0.0,-5598.745019824338,-5598.745019824338,2267578.2454895503,700.0,639800.0,685.6610973104235,1141334.846520521,-7408.510204191812,99430.78304507076,0.0,0.0,1263.1620127446092,1024946.297587523,-139.05792568755868,1866.3183364334245,-0.0,-4086793.0049876925,true,true,10.99736242,9092.136438713987,0.0,121.92,1644.2724500334996,914.0,10.99736242,9092.136438713987,0.0,121.92,0.0,295.15 +915,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,640500.0,5833.333333333334,19532843.70098503,5833.333333333334,14862223.123856265,true,915.0,915,0.875,0.0,0.0,0.0,0.0,0.0,915,21750.0,0.0,-7037.032955429962,-7037.032955429962,2260541.2125341203,700.0,640500.0,606.7804233765929,1141941.6269438977,-8693.374893353921,90737.40815171684,0.0,0.0,1212.7363832558005,1026159.0339707788,-163.17486870843518,1703.1434677249893,-0.0,-4086793.0049876925,true,true,10.50561044,9102.642049153987,0.0,121.92,1644.2724500334996,915.0,10.50561044,9102.642049153987,0.0,121.92,0.0,295.15 +916,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,641200.0,5833.333333333334,19538677.03431836,5833.333333333334,14868056.457189599,true,916.0,916,0.875,0.0,0.0,0.0,0.0,0.0,916,21750.0,0.0,-8271.943117013,-8271.943117013,2252269.269417107,700.0,641200.0,520.4091594953464,1142462.036103393,-9761.35698488172,80976.05116683512,0.0,0.0,1152.2256282076216,1027311.2595989865,-183.22091983424627,1519.9225478907429,-0.0,-4086793.0049876925,true,true,9.924449014,9112.566498167987,0.0,121.92,1644.2724500334996,916.0,9.924449014,9112.566498167987,0.0,121.92,0.0,295.15 +917,22450.0,21750.0,0.12,0.0,4670620.577128791,700.0,641900.0,5833.333333333334,19544510.367651694,5833.333333333334,14873889.790522933,true,917.0,917,0.875,0.0,0.0,0.0,0.0,0.0,917,21750.0,0.0,-2836.498930106017,-2836.498930106017,2249432.770487001,700.0,641900.0,458.16157526439224,1142920.1976786572,-4317.934053555459,76658.11711327966,0.0,0.0,1104.3212806162423,1028415.5808796027,-81.04773243119234,1438.8748154595505,-0.0,-4086793.0049876925,true,true,9.656220663,9122.222718830988,0.0,121.92,1644.2724500334996,917.0,9.656220663,9122.222718830988,0.0,121.92,0.0,295.15 +918,22450.0,21750.0,0.16720000000000002,1747.1809794496635,4672367.758108241,700.0,642600.0,14636.249877091288,19559146.617528785,12889.068897641624,14886778.859420575,true,918.0,918,0.875,1528.7833570184555,1747.1809794496635,218.397622431208,0.0,0.0,918,21750.0,0.0,1528.7833570184555,1528.7833570184555,2250961.55384402,700.0,642600.0,439.5897651360588,1143359.7874437934,0.0,76658.11711327966,0.0,0.0,1089.1935918823967,1029504.774471485,0.0,1438.8748154595505,-1528.7833570184555,-4088321.788344711,true,true,9.656220663,9131.878939493989,0.0,121.92,1644.2724500334996,918.0,9.656220663,9131.878939493989,0.0,121.92,0.0,295.15 +919,24197.180979449662,23497.180979449662,0.184,2581.8955400231557,4674949.653648264,700.0,643300.0,17836.388804473674,19576983.006333258,15254.493264450519,14902033.352685025,true,919.0,919,0.875,2259.158597520261,2581.8955400231557,322.73694250289464,0.0,0.0,919,23497.180979449662,0.0,2259.158597520261,2259.158597520261,2253220.71244154,700.0,643300.0,442.64954372159184,1143802.436987515,711.4404255184759,77369.55753879814,0.0,0.0,1091.714873328638,1030596.4893448137,13.353754951555224,1452.2285704111057,-2259.158597520261,-4090580.946942231,true,true,9.700925388,9141.57986488199,0.0,121.92,1644.2724500334996,919.0,9.700925388,9141.57986488199,0.0,121.92,0.0,295.15 +920,25031.895540023157,24331.895540023157,0.29250000000000004,9445.436945678564,4684395.090593942,700.0,644000.0,34685.25451514039,19611668.2608484,25239.817569461826,14927273.170254488,true,920.0,920,0.875,8264.757327468744,9445.436945678564,1180.6796182098205,0.0,0.0,920,24331.895540023157,0.0,8264.757327468744,8264.757327468744,2261485.4697690085,700.0,644000.0,474.0318369571718,1144276.4688244723,6550.838398332325,83920.39593713047,0.0,0.0,1116.9276881858395,1031713.4170329996,122.95940399340795,1575.1879744045136,-8264.757327468744,-4098845.7042696998,true,true,10.10326792,9151.683132801989,0.0,121.92,1644.2724500334996,920.0,10.10326792,9151.683132801989,0.0,121.92,0.0,295.15 +921,31895.436945678564,31195.436945678564,0.29250000000000004,8971.918180895844,4693367.008774838,700.0,644700.0,33066.38694323365,19644734.64779163,24094.468762337805,14951367.639016826,true,921.0,921,0.875,7850.428408283863,8971.918180895844,1121.4897726119807,0.0,0.0,921,31195.436945678564,0.0,7850.428408283863,7850.428408283863,2269335.898177292,700.0,644700.0,530.7253440629648,1144807.1941685353,6046.422093972408,89966.81803110287,0.0,0.0,1159.7894731667288,1032873.2065061663,113.49149708176121,1688.679471486275,-7850.428408283863,-4106696.1326779835,true,true,10.46090572,9162.144038521988,0.0,121.92,1644.2724500334996,921.0,10.46090572,9162.144038521988,0.0,121.92,0.0,295.15 +922,31421.918180895846,30721.918180895846,0.28,7470.059383160823,4700837.068157999,700.0,645400.0,29178.78351128865,19673913.43130292,21708.724128127826,14973076.363144953,true,922.0,922,0.875,6536.3019602657205,7470.059383160823,933.7574228951025,0.0,0.0,922,30721.918180895846,0.0,6536.3019602657205,6536.3019602657205,2275872.200137558,700.0,645400.0,580.6726312441465,1145387.8667997795,4672.832726032571,94639.65075713545,0.0,0.0,1195.0874134141052,1034068.2939195804,87.70918957489839,1776.3886610611733,-6536.3019602657205,-4113232.434638249,true,true,10.72913407,9172.873172591988,0.0,121.92,1644.2724500334996,922.0,10.72913407,9172.873172591988,0.0,121.92,0.0,295.15 +923,29920.059383160824,29220.059383160824,0.20800000000000002,3930.811421135484,4704767.879579134,700.0,646100.0,22263.51644776675,19696176.947750688,18332.705026631265,14991409.068171585,true,923.0,923,0.875,3439.4599934935486,3930.811421135484,491.3514276419355,0.0,0.0,923,29220.059383160824,0.0,3439.4599934935486,3439.4599934935486,2279311.6601310517,700.0,646100.0,610.5727904847815,1145998.4395902643,1583.8997002114656,96223.55045734691,0.0,0.0,1215.2576649840344,1035283.5515845645,29.72983781326655,1806.1184988744399,-3439.4599934935486,-4116671.894631743,true,true,10.81854352,9183.691716111987,0.0,121.92,1644.2724500334996,923.0,10.81854352,9183.691716111987,0.0,121.92,0.0,295.15 +924,26380.811421135484,25680.811421135484,0.20800000000000002,3975.1585327045427,4708743.0381118385,700.0,646800.0,22476.723714925687,19718653.671465613,18501.565182221144,15009910.633353807,true,924.0,924,0.875,3478.263716116475,3975.1585327045427,496.8948165880679,0.0,0.0,924,25680.811421135484,0.0,3478.263716116475,3478.263716116475,2282789.923847168,700.0,646800.0,625.9002709116227,1146624.339861176,1597.0440959784364,97820.59455332534,0.0,0.0,1225.342790768999,1036508.8943753334,29.976558457416758,1836.0950573318567,-3478.263716116475,-4120150.1583478595,true,true,10.90795297,9194.599669081987,0.0,121.92,1644.2724500334996,924.0,10.90795297,9194.599669081987,0.0,121.92,0.0,295.15 +925,26425.158532704543,25725.158532704543,0.265,6882.818717386428,4715625.856829225,700.0,647500.0,28614.410254288407,19747268.0817199,21731.59153690198,15031642.224890709,true,925.0,925,0.875,6022.4663777131245,6882.818717386428,860.3523396733035,0.0,0.0,925,25725.158532704543,0.0,6022.4663777131245,6022.4663777131245,2288812.3902248815,700.0,647500.0,653.3367529164735,1147277.6766140924,4050.1170629425164,101870.71161626786,0.0,0.0,1242.9917611746798,1037751.8861365081,76.02080067945532,1912.115858011312,-6022.4663777131245,-4126172.6247255728,true,true,11.1314766,9205.731145681986,0.0,121.92,1644.2724500334996,925.0,11.1314766,9205.731145681986,0.0,121.92,0.0,295.15 +926,29332.818717386428,28632.818717386428,0.20800000000000002,4132.678658962306,4719758.535488187,700.0,648200.0,23234.032014241853,19770502.113734145,19101.35335527955,15050743.578245988,true,926.0,926,0.875,3616.0938265920176,4132.678658962306,516.5848323702885,0.0,0.0,926,28632.818717386428,0.0,3616.0938265920176,3616.0938265920176,2292428.4840514734,700.0,648200.0,681.5635323879594,1147959.2401464805,1643.049481897957,103513.76109816582,0.0,0.0,1260.6407315803606,1039012.5268680884,30.840080725740645,1942.9559387370525,-3616.0938265920176,-4129788.7185521647,true,true,11.22088605,9216.952031731986,0.0,121.92,1644.2724500334996,926.0,11.22088605,9216.952031731986,0.0,121.92,0.0,295.15 +927,26582.678658962308,25882.678658962308,0.1936,3204.658700285793,4722963.194188473,700.0,648900.0,20168.69163370761,19790670.805367853,16964.03293342182,15067707.61117941,true,927.0,927,0.875,2804.076362750069,3204.658700285793,400.58233753572404,0.0,0.0,927,25882.678658962308,0.0,2804.076362750069,2804.076362750069,2295232.5604142235,700.0,648900.0,693.905431503963,1148653.1455779844,826.4537967430404,104340.21489490886,0.0,0.0,1268.2045756370915,1040280.7314437255,15.512558865974277,1958.468497603027,-2804.076362750069,-4132592.7949149148,true,true,11.26559077,9228.217622501985,0.0,121.92,1644.2724500334996,927.0,11.26559077,9228.217622501985,0.0,121.92,0.0,295.15 +928,25654.658700285792,24954.658700285792,0.196,3223.7452003790268,4726186.939388852,700.0,649600.0,20019.108165199115,19810689.913533054,16795.362964820088,15084502.97414423,true,928.0,928,0.875,2820.7770503316483,3223.7452003790268,402.96815004737846,0.0,0.0,928,24954.658700285792,0.0,2820.7770503316483,2820.7770503316483,2298053.337464555,700.0,649600.0,702.2155883763056,1149355.3611663608,829.7400809218527,105169.95497583071,0.0,0.0,1273.2471385295737,1041553.9785822551,15.574242503915828,1974.0427401069428,-2820.7770503316483,-4135413.5719652465,true,true,11.3102955,9239.527918001984,0.0,121.92,1644.2724500334996,928.0,11.3102955,9239.527918001984,0.0,121.92,0.0,295.15 +929,25673.745200379028,24973.745200379028,0.20800000000000002,4224.328677473436,4730411.268066325,700.0,650300.0,23674.65710323767,19834364.57063629,19450.328425764234,15103953.302569995,true,929.0,929,0.875,3696.2875927892565,4224.328677473436,528.0410846841796,0.0,0.0,929,24973.745200379028,0.0,3696.2875927892565,3696.2875927892565,2301749.6250573443,700.0,650300.0,714.8048141930619,1150070.165980554,1669.338273431864,106839.29324926257,0.0,0.0,1280.81098315029,1042834.7895654053,31.333522014040316,2005.376262120983,-3696.2875927892565,-4139109.8595580356,true,true,11.39970495,9250.927622951984,0.0,121.92,1644.2724500334996,929.0,11.39970495,9250.927622951984,0.0,121.92,0.0,295.15 +930,26674.328677473437,25974.328677473437,0.12,0.0,4730411.268066325,700.0,651000.0,5833.333333333334,19840197.903969623,5833.333333333334,15109786.635903329,true,930.0,930,0.875,0.0,0.0,0.0,0.0,0.0,930,25974.328677473437,0.0,-557.1045878017741,-557.1045878017741,2301192.5204695426,700.0,651000.0,710.5918296478429,1150780.7578102017,-2499.078354353717,104340.21489490886,0.0,0.0,1278.289701422056,1044113.0792668274,-46.907764517956146,1958.468497603027,-0.0,-4139109.8595580356,true,true,11.26559077,9262.193213721983,0.0,121.92,1644.2724500334996,930.0,11.26559077,9262.193213721983,0.0,121.92,0.0,295.15 +931,22450.0,21750.0,0.128,314.1408300540935,4730725.408896379,700.0,651700.0,7922.9752347976055,19848120.879204422,7608.834404743512,15117395.470308073,true,931.0,931,0.875,274.8732262973318,314.1408300540935,39.26760375676167,0.0,0.0,931,21750.0,0.0,274.8732262973318,274.8732262973318,2301467.39369584,700.0,651700.0,689.7750524688241,1151470.5328626705,-1649.621679046332,102690.59321586252,0.0,0.0,1265.6832939088576,1045378.7625607363,-30.96344103401797,1927.505056569009,-274.8732262973318,-4139384.732784333,true,true,11.17618132,9273.369395041982,0.0,121.92,1644.2724500334996,931.0,11.17618132,9273.369395041982,0.0,121.92,0.0,295.15 +932,22764.140830054093,22064.140830054093,0.1768,2219.6620142738066,4732945.070910653,700.0,652400.0,16513.925420100713,19864634.804624524,14294.263405826907,15131689.7337139,true,932.0,932,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,932,22064.140830054093,0.0,1942.2042624895807,1942.2042624895807,2303409.5979583296,700.0,652400.0,681.5635314732057,1152152.0963941438,0.0,102690.59321586252,0.0,0.0,1260.6407310163752,1046639.4032917527,0.0,1927.505056569009,-1942.2042624895807,-4141326.9370468226,true,true,11.17618132,9284.545576361981,0.0,121.92,1644.2724500334996,932.0,11.17618132,9284.545576361981,0.0,121.92,0.0,295.15 +933,24669.662014273807,23969.662014273807,0.1768,2219.6620142738066,4735164.732924927,700.0,653100.0,16513.925420100713,19881148.730044626,14294.263405826907,15145983.997119728,true,933.0,933,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,933,23969.662014273807,0.0,1942.2042624895807,1942.2042624895807,2305351.802220819,700.0,653100.0,681.5635314732057,1152833.659925617,0.0,102690.59321586252,0.0,0.0,1260.6407310163752,1047900.0440227691,0.0,1927.505056569009,-1942.2042624895807,-4143269.141309312,true,true,11.17618132,9295.72175768198,0.0,121.92,1644.2724500334996,933.0,11.17618132,9295.72175768198,0.0,121.92,0.0,295.15 +934,24669.662014273807,23969.662014273807,0.12,0.0,4735164.732924927,700.0,653800.0,5833.333333333334,19886982.063377958,5833.333333333334,15151817.330453062,true,934.0,934,0.875,0.0,0.0,0.0,0.0,0.0,934,23969.662014273807,0.0,-573.3235073270697,-573.3235073270697,2304778.478713492,700.0,653800.0,669.368850078189,1153503.0287756952,-2449.7866857256167,100240.8065301369,0.0,0.0,1253.0768869596443,1049153.1209097288,-45.98255863928627,1881.5224979297227,-0.0,-4143269.141309312,true,true,11.04206715,9306.76382483198,0.0,121.92,1644.2724500334996,934.0,11.04206715,9306.76382483198,0.0,121.92,0.0,295.15 +935,22450.0,21750.0,0.128,277.40832270123127,4735442.141247628,700.0,654500.0,7636.00252110337,19894618.065899063,7358.594198402138,15159175.924651464,true,935.0,935,0.875,242.73228236357738,277.40832270123127,34.67604033765389,0.0,0.0,935,21750.0,0.0,242.73228236357738,242.73228236357738,2305021.2109958557,700.0,654500.0,649.3691321545542,1154152.3979078499,-1616.7606903639685,98624.04583977294,0.0,0.0,1240.4704800104312,1050393.5913897392,-30.346639437439478,1851.1758584922832,-242.73228236357738,-4143511.873591676,true,true,10.9526577,9317.71648253198,0.0,121.92,1644.2724500334996,935.0,10.9526577,9317.71648253198,0.0,121.92,0.0,295.15 +936,22727.40832270123,22027.40832270123,0.128,263.23247891953673,4735705.373726548,700.0,655200.0,7525.253741558881,19902143.31964062,7262.021262639345,15166437.945914105,true,936.0,936,0.875,230.32841905459463,263.23247891953673,32.9040598649421,0.0,0.0,936,22027.40832270123,0.0,230.32841905459463,230.32841905459463,2305251.53941491,700.0,655200.0,633.6592782194152,1154786.0571860692,-1603.6162945969975,97020.42954517594,0.0,0.0,1230.385354225467,1051623.9767439647,-30.099918793290016,1821.0759396989931,-230.32841905459463,-4143742.2020107303,true,true,10.86324825,9328.57973078198,0.0,121.92,1644.2724500334996,936.0,10.86324825,9328.57973078198,0.0,121.92,0.0,295.15 +937,22713.232478919537,22013.232478919537,0.1744,2115.7063578386874,4737821.080084386,700.0,655900.0,16145.10526283651,19918288.42490346,14029.398904997823,15180467.344819102,true,937.0,937,0.875,1851.2430631088514,2115.7063578386874,264.463294729836,0.0,0.0,937,22013.232478919537,0.0,1851.2430631088514,1851.2430631088514,2307102.782478019,700.0,655900.0,625.9002717758669,1155411.957457845,0.0,97020.42954517594,0.0,0.0,1225.3427913329845,1052849.3195352978,0.0,1821.0759396989931,-1851.2430631088514,-4145593.4450738393,true,true,10.86324825,9339.44297903198,0.0,121.92,1644.2724500334996,937.0,10.86324825,9339.44297903198,0.0,121.92,0.0,295.15 +938,24565.706357838688,23865.706357838688,0.20800000000000002,3997.440966668765,4741818.521051055,700.0,656600.0,22583.850801292137,19940872.275704753,18586.409834623373,15199053.754653726,true,938.0,938,0.875,3497.7608458351697,3997.440966668765,499.68012083359554,0.0,0.0,938,23865.706357838688,0.0,3497.7608458351697,3497.7608458351697,2310600.5433238545,700.0,656600.0,633.6592782194152,1156045.6167360644,1603.6162945969975,98624.04583977294,0.0,0.0,1230.385354225467,1054079.7048895233,30.099918793290016,1851.1758584922832,-3497.7608458351697,-4149091.2059196746,true,true,10.9526577,9350.395636731979,0.0,121.92,1644.2724500334996,938.0,10.9526577,9350.395636731979,0.0,121.92,0.0,295.15 +939,26447.440966668764,25747.440966668764,0.265,6916.835784951069,4748735.356836006,700.0,657300.0,28742.776546985166,19969615.052251738,21825.940762034097,15220879.69541576,true,939.0,939,0.875,6052.231311832185,6916.835784951069,864.604473118884,0.0,0.0,939,25747.440966668764,0.0,6052.231311832185,6052.231311832185,2316652.7746356865,700.0,657300.0,661.3204135987122,1156706.9371496632,4066.547376089585,102690.59321586252,0.0,0.0,1248.0343240671623,1055327.7392135905,76.32919807672575,1927.505056569009,-6052.231311832185,-4155143.4372315067,true,true,11.17618132,9361.571818051978,0.0,121.92,1644.2724500334996,939.0,11.17618132,9361.571818051978,0.0,121.92,0.0,295.15 +940,29366.83578495107,28666.83578495107,0.1768,2219.6620142738066,4750955.01885028,700.0,658000.0,16513.925420100713,19986128.97767184,14294.263405826907,15235173.958821587,true,940.0,940,0.875,1942.2042624895807,2219.6620142738066,277.4577517842258,0.0,0.0,940,28666.83578495107,0.0,1942.2042624895807,1942.2042624895807,2318594.978898176,700.0,658000.0,681.5635314732057,1157388.5006811365,0.0,102690.59321586252,0.0,0.0,1260.6407310163752,1056588.379944607,0.0,1927.505056569009,-1942.2042624895807,-4157085.641493996,true,true,11.17618132,9372.747999371977,0.0,121.92,1644.2724500334996,940.0,11.17618132,9372.747999371977,0.0,121.92,0.0,295.15 +941,24669.662014273807,23969.662014273807,0.12,0.0,4750955.01885028,700.0,658700.0,5833.333333333334,19991962.31100517,5833.333333333334,15241007.292154921,true,941.0,941,0.875,0.0,0.0,0.0,0.0,0.0,941,23969.662014273807,0.0,-1405.1047676397538,-1405.1047676397538,2317189.8741305363,700.0,658700.0,665.3365180561832,1158053.8371991927,-3259.8101707917626,99430.78304507076,0.0,0.0,1250.5556052314105,1057838.9355498382,-61.18672013558456,1866.3183364334243,-0.0,-4157085.641493996,true,true,10.99736242,9383.745361791976,0.0,121.92,1644.2724500334996,941.0,10.99736242,9383.745361791976,0.0,121.92,0.0,295.15 +942,22450.0,21750.0,0.1744,2159.816697960325,4753114.835548241,700.0,659400.0,16398.031525001865,20008360.342530172,14238.21482704154,15255245.506981963,true,942.0,942,0.875,1889.8396107152846,2159.816697960325,269.9770872450406,0.0,0.0,942,21750.0,0.0,1889.8396107152846,1889.8396107152846,2319079.7137412517,700.0,659400.0,649.3691312688386,1158703.2063304617,0.0,99430.78304507076,0.0,0.0,1240.470479446446,1059079.4060292847,0.0,1866.3183364334243,-1889.8396107152846,-4158975.4811047115,true,true,10.99736242,9394.742724211976,0.0,121.92,1644.2724500334996,942.0,10.99736242,9394.742724211976,0.0,121.92,0.0,295.15 +943,24609.816697960327,23909.816697960327,0.12,0.0,4753114.835548241,700.0,660100.0,5833.333333333334,20014193.675863504,5833.333333333334,15261078.840315297,true,943.0,943,0.875,0.0,0.0,0.0,0.0,0.0,943,23909.816697960327,0.0,-2218.2852945700915,-2218.2852945700915,2316861.4284466817,700.0,660100.0,629.7718075814728,1159332.978138043,-4000.8255758761084,95429.95746919465,0.0,0.0,1227.8640719332475,1060307.270101218,-75.0955982087037,1791.2227382247206,-0.0,-4158975.4811047115,true,true,10.77383879,9405.516563001976,0.0,121.92,1644.2724500334996,943.0,10.77383879,9405.516563001976,0.0,121.92,0.0,295.15 +944,22450.0,21750.0,0.25,5834.610917173108,4758949.446465414,700.0,660800.0,26138.44366869243,20040332.119532198,20303.832751519323,15281382.673066817,true,944.0,944,0.875,5105.284552526469,5834.610917173108,729.3263646466385,0.0,0.0,944,21750.0,0.0,5105.284552526469,5105.284552526469,2321966.7129992084,700.0,660800.0,625.9002709116223,1159958.8784089547,3194.088370578286,98624.04583977294,0.0,0.0,1225.3427907689988,1061532.612891987,59.953120267562525,1851.1758584922832,-5105.284552526469,-4164080.765657238,true,true,10.9526577,9416.469220701976,0.0,121.92,1644.2724500334996,944.0,10.9526577,9416.469220701976,0.0,121.92,0.0,295.15 +945,28284.610917173108,27584.610917173108,0.28625,7882.728529587887,4766832.174995002,700.0,661500.0,29983.331107730606,20070315.45063993,22100.60257814272,15303483.27564496,true,945.0,945,0.875,6897.387463389401,7882.728529587887,985.3410661984863,0.0,0.0,945,27584.610917173108,0.0,6897.387463389401,6897.387463389401,2328864.100462598,700.0,661500.0,665.3365189563594,1160624.214927911,4889.715258392876,103513.76109816582,0.0,0.0,1250.555605795396,1062783.1684977824,91.78008024476944,1942.9559387370525,-6897.387463389401,-4170978.1531206276,true,true,11.22088605,9427.690106751976,0.0,121.92,1644.2724500334996,945.0,11.22088605,9427.690106751976,0.0,121.92,0.0,295.15 +946,30332.728529587886,29632.728529587886,0.265,7122.504544083483,4773954.679539085,700.0,662200.0,29518.88507201314,20099834.33571194,22396.380527929658,15325879.65617289,true,946.0,946,0.875,6232.191476073048,7122.504544083483,890.313068010435,0.0,0.0,946,29632.728529587886,0.0,6232.191476073048,6232.191476073048,2335096.291938671,700.0,662200.0,710.5918296478434,1161334.8067575588,4165.130342136687,107678.89144030251,0.0,0.0,1278.2897014220562,1064061.4581992044,78.17960286646121,2021.1355416035137,-6232.191476073048,-4177210.3445967007,true,true,11.44440967,9439.134516421977,0.0,121.92,1644.2724500334996,946.0,11.44440967,9439.134516421977,0.0,121.92,0.0,295.15 +947,29572.504544083484,28872.504544083484,0.12,0.0,4773954.679539085,700.0,662900.0,5833.333333333334,20105667.669045273,5833.333333333334,15331712.989506224,true,947.0,947,0.875,0.0,0.0,0.0,0.0,0.0,947,28872.504544083484,0.0,-2254.428413933249,-2254.428413933249,2332841.863524738,700.0,662900.0,710.5918296478434,1162045.3985872066,-4165.130342136687,103513.76109816582,0.0,0.0,1278.2897014220562,1065339.7479006264,-78.17960286646121,1942.9559387370525,-0.0,-4177210.3445967007,true,true,11.22088605,9450.355402471976,0.0,121.92,1644.2724500334996,947.0,11.22088605,9450.355402471976,0.0,121.92,0.0,295.15 +948,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,663600.0,5833.333333333334,20111501.002378605,5833.333333333334,15337546.322839558,true,948.0,948,0.875,0.0,0.0,0.0,0.0,0.0,948,21750.0,0.0,-7157.310814112974,-7157.310814112974,2325684.552710625,700.0,663600.0,645.4176063110826,1162690.8161935178,-8874.110341030375,94639.65075713545,0.0,0.0,1237.9491982821976,1066577.6970989085,-166.56727767587927,1776.3886610611733,-0.0,-4177210.3445967007,true,true,10.72913407,9461.084536541975,0.0,121.92,1644.2724500334996,948.0,10.72913407,9461.084536541975,0.0,121.92,0.0,295.15 +949,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,664300.0,5833.333333333334,20117334.335711937,5833.333333333334,15343379.656172892,true,949.0,949,0.875,0.0,0.0,0.0,0.0,0.0,949,21750.0,0.0,-13709.26926005884,-13709.26926005884,2311975.283450566,700.0,664300.0,530.7253435984163,1163221.5415371163,-15116.055331959957,79523.59542517549,0.0,0.0,1159.7894728283377,1067737.4865717369,-283.7287445256381,1492.659916535535,-0.0,-4177210.3445967007,true,true,9.835039564,9470.919576105976,0.0,121.92,1644.2724500334996,949.0,9.835039564,9470.919576105976,0.0,121.92,0.0,295.15 +950,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,665000.0,5833.333333333334,20123167.66904527,5833.333333333334,15349212.989506226,true,950.0,950,0.875,0.0,0.0,0.0,0.0,0.0,950,21750.0,0.0,-11921.125432595825,-11921.125432595825,2300054.1580179706,700.0,665000.0,406.8577746052386,1163628.3993117216,-13142.75289553779,66380.8425296377,0.0,0.0,1061.4594957481497,1068798.946067485,-246.68980741142406,1245.970109124111,-0.0,-4177210.3445967007,true,true,8.985649783,9479.905225888977,0.0,121.92,1644.2724500334996,950.0,8.985649783,9479.905225888977,0.0,121.92,0.0,295.15 +951,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,665700.0,5833.333333333334,20129001.0023786,5833.333333333334,15355046.32283956,true,951.0,951,0.875,0.0,0.0,0.0,0.0,0.0,951,21750.0,0.0,-18609.792499565556,-18609.792499565556,2281444.365518405,700.0,665700.0,276.1859006480107,1163904.5852123697,-19453.70598335574,46927.13654628195,0.0,0.0,932.8741411438726,1069731.820208629,-365.14655800169936,880.8235511224118,-0.0,-4177210.3445967007,true,true,7.555098574,9487.460324462976,0.0,121.92,1644.2724500334996,951.0,7.555098574,9487.460324462976,0.0,121.92,0.0,295.15 +952,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,666400.0,5833.333333333334,20134834.335711934,5833.333333333334,15360879.656172894,true,952.0,952,0.875,0.0,0.0,0.0,0.0,0.0,952,21750.0,0.0,-15924.005739591918,-15924.005739591918,2265520.359778813,700.0,666400.0,154.70197202581846,1164059.2871843956,-16537.293143155388,30389.843403126564,0.0,0.0,768.9908460666251,1070500.8110546956,-310.40541452897276,570.418136593439,-0.0,-4177210.3445967007,true,true,6.079842639,9493.540167101975,0.0,121.92,1644.2724500334996,952.0,6.079842639,9493.540167101975,0.0,121.92,0.0,295.15 +953,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,667100.0,5833.333333333334,20140667.669045266,5833.333333333334,15366712.989506228,true,953.0,953,0.875,0.0,0.0,0.0,0.0,0.0,953,21750.0,0.0,-12524.943587030239,-12524.943587030239,2252995.416191783,700.0,667100.0,74.4372010436826,1164133.7243854392,-12958.73133951072,17431.112063615845,0.0,0.0,602.5862695431363,1071103.3973242387,-243.23571810633786,327.1824184871012,-0.0,-4177210.3445967007,true,true,4.604586705,9498.144753806975,0.0,121.92,1644.2724500334996,953.0,4.604586705,9498.144753806975,0.0,121.92,0.0,295.15 +954,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,667800.0,5833.333333333334,20146501.002378598,5833.333333333334,15372546.322839562,true,954.0,954,0.875,0.0,0.0,0.0,0.0,0.0,954,21750.0,0.0,-9091.822337742968,-9091.822337742968,2243903.59385404,700.0,667800.0,28.23154468499448,1164161.9559301243,-9380.169553434154,8050.9425101816905,0.0,0.0,436.1816930196476,1071539.5790172582,-176.06602201345643,151.11639647364476,-0.0,-4177210.3445967007,true,true,3.12933077,9501.274084576975,0.0,121.92,1644.2724500334996,954.0,3.12933077,9501.274084576975,0.0,121.92,0.0,295.15 +955,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,668500.0,5833.333333333334,20152334.33571193,5833.333333333334,15378379.656172896,true,955.0,955,0.875,0.0,0.0,0.0,0.0,0.0,955,21750.0,0.0,-5634.047406756002,-5634.047406756002,2238269.546447284,700.0,668500.0,6.679557070649019,1164168.6354871949,-5801.607754640927,2249.3347555407636,0.0,0.0,269.7771164961588,1071809.3561337544,-108.89632568188298,42.22007079176177,-0.0,-4177210.3445967007,true,true,1.654074836,9502.928159412975,0.0,121.92,1644.2724500334996,955.0,1.654074836,9502.928159412975,0.0,121.92,0.0,295.15 +956,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,669200.0,5833.333333333334,20158167.669045262,5833.333333333334,15384212.98950623,true,956.0,956,0.875,0.0,0.0,0.0,0.0,0.0,956,21750.0,0.0,-2161.024260916646,-2161.024260916646,2236108.5221863673,700.0,669200.0,0.3757923215411603,1164169.0112795164,-2223.0459637129175,26.288791827846126,0.0,0.0,103.37253997267001,1071912.728673727,-41.72662949793998,0.4934412938217889,-0.0,-4177210.3445967007,true,true,0.178818901,9503.106978313976,0.0,121.92,1644.2724500334996,956.0,0.178818901,9503.106978313976,0.0,121.92,0.0,295.15 +957,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,669900.0,5833.333333333334,20164001.002378594,5833.333333333334,15390046.322839564,true,957.0,957,0.875,0.0,0.0,0.0,0.0,0.0,957,21750.0,0.0,-16.69675831990641,-16.69675831990641,2236091.825428047,700.0,669900.0,0.0003489605274117505,1164169.011628477,-26.2887918279776,-1.3147527511137014e-10,0.0,0.0,10.085125841363176,1071922.8137995685,-0.49344129381939833,2.3905877277741183e-12,-0.0,-4177210.3445967007,true,true,0.0,9503.106978313976,0.0,121.92,1644.2724500334996,957.0,0.0,9503.106978313976,0.0,121.92,0.0,295.15 +958,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,670600.0,5833.333333333334,20169834.335711926,5833.333333333334,15395879.656172898,true,958.0,958,0.875,0.0,0.0,0.0,0.0,0.0,958,21750.0,0.0,0.0,0.0,2236091.825428047,700.0,670600.0,0.0,1164169.011628477,0.0,-1.3147527511137014e-10,0.0,0.0,0.0,1071922.8137995685,0.0,2.3905877277741183e-12,-0.0,-4177210.3445967007,true,true,0.0,9503.106978313976,0.0,121.92,1644.2724500334996,958.0,0.0,9503.106978313976,0.0,121.92,0.0,295.15 +959,22450.0,21750.0,0.12,0.0,4773954.679539085,700.0,671300.0,5833.333333333334,20175667.66904526,5833.333333333334,15401712.989506232,true,959.0,959,0.875,0.0,0.0,0.0,0.0,0.0,959,21750.0,0.0,0.0,0.0,2236091.825428047,700.0,671300.0,0.0,1164169.011628477,0.0,-1.3147527511137014e-10,0.0,0.0,0.0,1071922.8137995685,0.0,2.3905877277741183e-12,-0.0,-4177210.3445967007,true,true,0.0,9503.106978313976,0.0,121.92,1644.2724500334996,959.0,0.0,9503.106978313976,0.0,121.92,0.0,295.15 +960,22450.0,21750.0,0.14400000000000002,822.8858044250761,4774777.56534351,700.0,672000.0,10575.595864063027,20186243.26490932,9752.710059637951,15411465.699565869,true,960.0,960,0.875,720.0250788719416,822.8858044250761,102.86072555313456,0.0,0.0,960,21750.0,0.0,720.0250788719416,720.0250788719416,2236811.850506919,700.0,672000.0,0.043620066072829394,1164169.055248543,657.2197971695749,657.2197971694435,0.0,0.0,50.425629263214425,1071973.2394288317,12.336032373079432,12.336032373081823,-720.0250788719416,-4177930.3696755725,true,true,0.894094506,9504.001072819976,0.0,121.92,1644.2724500334996,960.0,0.894094506,9504.001072819976,0.0,121.92,0.0,295.15 +961,23272.885804425077,22572.885804425077,0.22,4821.22816572823,4779598.793509238,700.0,672700.0,25096.491662401048,20211339.75657172,20275.26349667282,15431740.963062542,true,961.0,961,0.875,4218.5746450122015,4821.22816572823,602.6535207160287,0.0,0.0,961,22572.885804425077,0.0,4218.5746450122015,4218.5746450122015,2241030.425151931,700.0,672700.0,2.121118403676834,1164171.1763669467,3958.1062249474926,4615.326022116936,0.0,0.0,184.05354675997395,1072157.2929755917,74.29375490105805,86.62978727413987,-4218.5746450122015,-4182148.9443205846,true,true,2.36935044,9506.370423259976,0.0,121.92,1644.2724500334996,961.0,2.36935044,9506.370423259976,0.0,121.92,0.0,295.15 +962,27271.22816572823,26571.22816572823,0.29250000000000004,9192.266236285755,4788791.059745524,700.0,673400.0,33819.713628327365,20245159.470200047,24627.44739204161,15456368.410454582,true,962.0,962,0.875,8043.232956750036,9192.266236285755,1149.0332795357199,0.0,0.0,962,26571.22816572823,0.0,8043.232956750036,8043.232956750036,2249073.658108681,700.0,673400.0,14.643359766287459,1164185.819726713,7536.66802249111,12151.994044608045,0.0,0.0,350.4581232834627,1072507.7510988752,141.4634512091763,228.09323848331616,-8043.232956750036,-4190192.1772773345,true,true,3.844606375,9510.215029634976,0.0,121.92,1644.2724500334996,962.0,3.844606375,9510.215029634976,0.0,121.92,0.0,295.15 +963,31642.266236285755,30942.266236285755,0.33,13585.942511002311,4802377.002256527,700.0,674100.0,43290.734881825185,20288450.205081873,29704.792370822874,15486073.202825405,true,963.0,963,0.875,11887.699697127022,13585.942511002311,1698.2428138752894,0.0,0.0,963,30942.266236285755,0.0,11887.699697127022,11887.699697127022,2260961.357805808,700.0,674100.0,46.97404017726804,1164232.7937668902,11115.229809817289,23267.223854425334,0.0,0.0,516.8626998069516,1073024.613798682,208.63314732551282,436.726385808829,-11887.699697127022,-4202079.876974462,true,true,5.319862309,9515.534891943975,0.0,121.92,1644.2724500334996,963.0,5.319862309,9515.534891943975,0.0,121.92,0.0,295.15 +964,36035.942511002315,35335.942511002315,0.35,18013.006100323655,4820390.008356851,700.0,674800.0,53465.731715210444,20341915.936797082,35452.72561488679,15521525.928440291,true,964.0,964,0.875,15761.3803377832,18013.006100323655,2251.625762540456,0.0,0.0,964,35335.942511002315,0.0,15761.3803377832,15761.3803377832,2276722.738143591,700.0,674800.0,108.51860551572359,1164341.312372406,14693.791612212344,37961.01546663768,0.0,0.0,683.2672763304403,1073707.8810750125,275.80284372469254,712.5292295335215,-15761.3803377832,-4217841.257312245,true,true,6.795118244,9522.330010187974,0.0,121.92,1644.2724500334996,964.0,6.795118244,9522.330010187974,0.0,121.92,0.0,295.15 +965,40463.006100323655,39763.006100323655,0.33999999999999997,15547.924276893042,4835937.932633744,700.0,675500.0,47788.01257909719,20389703.94937618,32240.088302204145,15553766.016742496,true,965.0,965,0.875,13604.433742281411,15547.924276893042,1943.4905346116302,0.0,0.0,965,39763.006100323655,0.0,13604.433742281411,13604.433742281411,2290327.1718858727,700.0,675500.0,190.65122047223792,1164531.9635928783,12357.375234862255,50318.39070149993,0.0,0.0,824.4590382787204,1074532.3401132913,231.94824866819718,944.4774782017187,-13604.433742281411,-4231445.691054526,true,true,7.823326926,9530.153337113974,0.0,121.92,1644.2724500334996,965.0,7.823326926,9530.153337113974,0.0,121.92,0.0,295.15 +966,37997.92427689304,37297.92427689304,0.29250000000000004,8929.961319928294,4844867.893953672,700.0,676200.0,32922.94468351553,20422626.894059695,23992.98336358724,15577759.000106083,true,966.0,966,0.875,7813.716154937258,8929.961319928294,1116.2451649910363,0.0,0.0,966,37297.92427689304,0.0,7813.716154937258,7813.716154937258,2298140.88804081,700.0,676200.0,256.5180545519494,1164788.4816474302,6524.549531086411,56842.94023258634,0.0,0.0,910.1826080149052,1075442.5227213062,122.46596128399227,1066.943439485711,-7813.716154937258,-4239259.407209463,true,true,8.315078904,9538.468416017973,0.0,121.92,1644.2724500334996,966.0,8.315078904,9538.468416017973,0.0,121.92,0.0,295.15 +967,31379.961319928294,30679.961319928294,0.3175,11808.57261478694,4856676.466568459,700.0,676900.0,39397.07910169115,20462023.97316139,27588.50648690421,15605347.506592987,true,967.0,967,0.875,10332.501037938573,11808.57261478694,1476.0715768483678,0.0,0.0,967,30679.961319928294,0.0,10332.501037938573,10332.501037938573,2308473.3890787484,700.0,676900.0,313.58714113416886,1165102.0687885643,8879.039454968335,65721.97968755467,0.0,0.0,973.214644565724,1076415.737365872,166.65979727034525,1233.6032367560563,-10332.501037938573,-4249591.908247402,true,true,8.940945058,9547.409361075974,0.0,121.92,1644.2724500334996,967.0,8.940945058,9547.409361075974,0.0,121.92,0.0,295.15 +968,34258.57261478694,33558.57261478694,0.30500000000000005,10265.657338911098,4866942.12390737,700.0,677600.0,35952.97488167573,20497976.948043063,25687.317542764627,15631034.824135752,true,968.0,968,0.875,8982.45017154721,10265.657338911098,1283.2071673638875,0.0,0.0,968,33558.57261478694,0.0,8982.45017154721,8982.45017154721,2317455.8392502954,700.0,677600.0,378.5487334126411,1165480.617521977,7428.226751238988,73150.20643879366,0.0,0.0,1036.2466811165427,1077451.9840469884,139.4280057790397,1373.031242535096,-8982.45017154721,-4258574.358418949,true,true,9.432697036,9556.842058111974,0.0,121.92,1644.2724500334996,968.0,9.432697036,9556.842058111974,0.0,121.92,0.0,295.15 +969,32715.6573389111,32015.6573389111,0.29250000000000004,9161.410388738037,4876103.5342961075,700.0,678300.0,33714.22355124115,20531691.171594303,24552.813162503113,15655587.637298256,true,969.0,969,0.875,8016.234090145782,9161.410388738037,1145.176298592255,0.0,0.0,969,32015.6573389111,0.0,8016.234090145782,8016.234090145782,2325472.073340441,700.0,678300.0,436.54411938377126,1165917.1616413607,6373.388986381814,79523.59542517547,0.0,0.0,1086.6723103797572,1078538.6563573682,119.62867400043929,1492.6599165355353,-8016.234090145782,-4266590.592509095,true,true,9.835039564,9566.677097675974,0.0,121.92,1644.2724500334996,969.0,9.835039564,9566.677097675974,0.0,121.92,0.0,295.15 +970,31611.410388738037,30911.410388738037,0.30500000000000005,10473.073835350215,4886576.608131458,700.0,679000.0,36633.02896836135,20568324.200562663,26159.955133011135,15681747.592431268,true,970.0,970,0.875,9163.939605931439,10473.073835350215,1309.1342294187762,0.0,0.0,970,30911.410388738037,0.0,9163.939605931439,9163.939605931439,2334636.0129463724,700.0,679000.0,496.85981503672747,1166414.0214563974,7393.722767407227,86917.3181925827,0.0,0.0,1134.5766583659263,1079673.2330157342,138.78036512155848,1631.4402816570937,-9163.939605931439,-4275754.532115026,true,true,10.28208682,9576.959184495974,0.0,121.92,1644.2724500334996,970.0,10.28208682,9576.959184495974,0.0,121.92,0.0,295.15 +971,32923.07383535022,32223.073835350217,0.33999999999999997,15666.774231948886,4902243.382363407,700.0,679700.0,48137.571270437904,20616461.7718331,32470.797038489018,15714218.389469756,true,971.0,971,0.875,13708.427452955275,15666.774231948886,1958.3467789936112,0.0,0.0,971,32223.073835350217,0.0,13708.427452955275,13708.427452955275,2348344.440399328,700.0,679700.0,584.355533787518,1166998.376990185,11706.727647190228,98624.04583977292,0.0,0.0,1197.608695142339,1080870.8417108767,219.73557683518942,1851.1758584922832,-13708.427452955275,-4289462.959567982,true,true,10.9526577,9587.911842195974,0.0,121.92,1644.2724500334996,971.0,10.9526577,9587.911842195974,0.0,121.92,0.0,295.15 +972,38116.77423194889,37416.77423194889,0.3516666666666666,19773.327950121813,4922016.710313529,700.0,680400.0,58217.994170962505,20674679.766004063,38444.66622084069,15752663.055690596,true,972.0,972,0.875,17301.661956356587,19773.327950121813,2471.6659937652257,0.0,0.0,972,37416.77423194889,0.0,17301.661956356587,17301.661956356587,2365646.102355684,700.0,680400.0,714.8048141930616,1167713.181804378,15024.04446088687,113648.0903006598,0.0,0.0,1280.8109831502898,1082151.652694027,282.0016981263647,2133.177556618648,-17301.661956356587,-4306764.621524339,true,true,11.75734275,9599.669184945973,0.0,121.92,1644.2724500334996,972.0,11.75734275,9599.669184945973,0.0,121.92,0.0,295.15 +973,42223.32795012181,41523.32795012181,0.335,14871.028316801328,4936887.73863033,700.0,681100.0,46480.68154269053,20721160.447546754,31609.653225889204,15784272.708916485,true,973.0,973,0.875,13012.149777201163,14871.028316801328,1858.8785396001658,0.0,0.0,973,41523.32795012181,0.0,13012.149777201163,13012.149777201163,2378658.252132885,700.0,681100.0,849.0693394874753,1168562.2511438655,10607.527450105157,124255.61775076496,0.0,0.0,1356.4494265375247,1083508.1021205646,199.10356107100466,2332.2811176896525,-13012.149777201163,-4319776.77130154,true,true,12.29379945,9611.962984395974,0.0,121.92,1644.2724500334996,973.0,12.29379945,9611.962984395974,0.0,121.92,0.0,295.15 +974,37321.02831680133,36621.02831680133,0.29250000000000004,9054.97520656629,4945942.713836896,700.0,681800.0,33350.342586551415,20754510.790133305,24295.367379985124,15808568.076296471,true,974.0,974,0.875,7923.103305745504,9054.97520656629,1131.8719008207863,0.0,0.0,974,36621.02831680133,0.0,7923.103305745504,7923.103305745504,2386581.3554386306,700.0,681800.0,937.1750250423974,1169499.426168908,5481.2132744607015,129736.83102522566,0.0,0.0,1401.832493133851,1084909.9346136984,102.88251310855414,2435.1636307982067,-7923.103305745504,-4327699.8746072855,true,true,12.56202781,9624.525012205973,0.0,121.92,1644.2724500334996,974.0,12.56202781,9624.525012205973,0.0,121.92,0.0,295.15 +975,31504.97520656629,30804.97520656629,0.25,5994.505947957574,4951937.219784854,700.0,682500.0,26778.023791830296,20781288.813925136,20783.517843872723,15829351.594140343,true,975.0,975,0.875,5245.192704462877,5994.505947957574,749.3132434946965,0.0,0.0,975,30804.97520656629,0.0,5245.192704462877,5245.192704462877,2391826.5481430935,700.0,682500.0,983.4259756663673,1170482.8521445743,2784.9687674925394,132521.7997927182,0.0,0.0,1424.5240264320141,1086334.4586401305,52.273934871957,2487.4375656701636,-5245.192704462877,-4332945.067311748,true,true,12.69614198,9637.221154185974,0.0,121.92,1644.2724500334996,975.0,12.69614198,9637.221154185974,0.0,121.92,0.0,295.15 +976,28444.505947957572,27744.505947957572,0.20800000000000002,3876.0154737735065,4955813.235258628,700.0,683200.0,22000.074393141855,20803288.888318278,18124.058919368348,15847475.653059712,true,976.0,976,0.875,3391.513539551818,3876.0154737735065,484.5019342216883,0.0,0.0,976,27744.505947957572,0.0,3391.513539551818,3391.513539551818,2395218.061682645,700.0,683200.0,1004.461119889405,1171487.3132644638,934.8952595537647,133456.69505227197,0.0,0.0,1434.6091522169786,1087769.0677923474,17.548007891670075,2504.985573561834,-3391.513539551818,-4336336.5808513,true,true,12.74084671,9649.962000895974,0.0,121.92,1644.2724500334996,976.0,12.74084671,9649.962000895974,0.0,121.92,0.0,295.15 +977,26326.015473773507,25626.015473773507,0.1864,2796.4534809765923,4958609.688739604,700.0,683900.0,18757.797644724207,20822046.685963,15961.344163747615,15863436.99722346,true,977.0,977,0.875,2446.896795854518,2796.4534809765923,349.5566851220742,0.0,0.0,977,25626.015473773507,0.0,2446.896795854518,2446.896795854518,2397664.9584784997,700.0,683900.0,1009.7663619093055,1172497.079626373,0.0,133456.69505227197,0.0,0.0,1437.1304339452126,1089206.1982262926,0.0,2504.985573561834,-2446.896795854518,-4338783.477647155,true,true,12.74084671,9662.702847605973,0.0,121.92,1644.2724500334996,977.0,12.74084671,9662.702847605973,0.0,121.92,0.0,295.15 +978,25246.453480976594,24546.453480976594,0.1864,2796.4534809765923,4961406.142220581,700.0,684600.0,18757.797644724207,20840804.483607724,15961.344163747615,15879398.341387207,true,978.0,978,0.875,2446.896795854518,2796.4534809765923,349.5566851220742,0.0,0.0,978,24546.453480976594,0.0,2446.896795854518,2446.896795854518,2400111.855274354,700.0,684600.0,1009.7663619093055,1173506.8459882822,0.0,133456.69505227197,0.0,0.0,1437.1304339452126,1090643.3286602378,0.0,2504.985573561834,-2446.896795854518,-4341230.3744430095,true,true,12.74084671,9675.443694315973,0.0,121.92,1644.2724500334996,978.0,12.74084671,9675.443694315973,0.0,121.92,0.0,295.15 +979,25246.453480976594,24546.453480976594,0.12,0.0,4961406.142220581,700.0,685300.0,5833.333333333334,20846637.816941056,5833.333333333334,15885231.67472054,true,979.0,979,0.875,0.0,0.0,0.0,0.0,0.0,979,24546.453480976594,0.0,-5141.003476991629,-5141.003476991629,2394970.8517973623,700.0,685300.0,967.8438146084426,1174474.6898028906,-7387.150471024702,126069.54458124728,0.0,0.0,1416.9601823752832,1092060.288842613,-138.6570029506537,2366.32857061118,-0.0,-4341230.3744430095,true,true,12.38320891,9687.826903225972,0.0,121.92,1644.2724500334996,979.0,12.38320891,9687.826903225972,0.0,121.92,0.0,295.15 +980,22450.0,21750.0,0.136,526.7045458216281,4961932.846766403,700.0,686000.0,9019.886366335499,20855657.70330739,8493.18182051387,15893724.856541054,true,980.0,980,0.875,460.8664775939246,526.7045458216281,65.8380682277035,0.0,0.0,980,21750.0,0.0,460.8664775939246,460.8664775939246,2395431.718274956,700.0,686000.0,917.0933936488705,1175391.7831965396,-1813.9268304823047,124255.61775076497,0.0,0.0,1391.7473673488864,1093452.036209962,-34.047452921527515,2332.2811176896525,-460.8664775939246,-4341691.240920603,true,true,12.29379945,9700.120702675973,0.0,121.92,1644.2724500334996,980.0,12.29379945,9700.120702675973,0.0,121.92,0.0,295.15 +981,22976.704545821627,22276.704545821627,0.12,0.0,4961932.846766403,700.0,686700.0,5833.333333333334,20861491.036640722,5833.333333333334,15899558.189874388,true,981.0,981,0.875,0.0,0.0,0.0,0.0,0.0,981,22276.704545821627,0.0,-475.31427959368864,-475.31427959368864,2394956.4039953626,700.0,686700.0,892.3974294066116,1176284.1806259463,-2696.244098270654,121559.37365249431,0.0,0.0,1379.1409598356877,1094831.1771697977,-50.608570565334006,2281.6725471243185,-0.0,-4341691.240920603,true,true,12.15968528,9712.280387955972,0.0,121.92,1644.2724500334996,981.0,12.15968528,9712.280387955972,0.0,121.92,0.0,295.15 +982,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,687400.0,5833.333333333334,20867324.369974054,5833.333333333334,15905391.523207722,true,982.0,982,0.875,0.0,0.0,0.0,0.0,0.0,982,21750.0,0.0,-1395.5357046754648,-1395.5357046754648,2393560.868290687,700.0,687400.0,858.5737602981075,1177142.7543862443,-3548.986880605484,118010.38677188882,0.0,0.0,1361.4919899939923,1096192.6691597917,-66.61457436208029,2215.057972762238,-0.0,-4341691.240920603,true,true,11.98086638,9724.261254335972,0.0,121.92,1644.2724500334996,982.0,11.98086638,9724.261254335972,0.0,121.92,0.0,295.15 +983,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,688100.0,5833.333333333334,20873157.703307386,5833.333333333334,15911224.856541056,true,983.0,983,0.875,0.0,0.0,0.0,0.0,0.0,983,21750.0,0.0,-507.0907599607714,-507.0907599607714,2393053.777530726,700.0,688100.0,825.6157303219805,1177968.3701165663,-2627.2362189622645,115383.15055292656,0.0,0.0,1343.8430195883116,1097536.51217938,-49.31329090879901,2165.744681853439,-0.0,-4341691.240920603,true,true,11.8467522,9736.108006535971,0.0,121.92,1644.2724500334996,983.0,11.8467522,9736.108006535971,0.0,121.92,0.0,295.15 +984,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,688800.0,5833.333333333334,20878991.03664072,5833.333333333334,15917058.18987439,true,984.0,984,0.875,0.0,0.0,0.0,0.0,0.0,984,21750.0,0.0,-2281.292251183721,-2281.292251183721,2390772.4852795424,700.0,688800.0,788.9949839284826,1178757.3651004948,-4313.004793045029,111070.14575988153,0.0,0.0,1323.6727680183824,1098860.1849473985,-80.95521008555681,2084.7894717678823,-0.0,-4341691.240920603,true,true,11.62322858,9747.73123511597,0.0,121.92,1644.2724500334996,984.0,11.62322858,9747.73123511597,0.0,121.92,0.0,295.15 +985,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,689500.0,5833.333333333334,20884824.36997405,5833.333333333334,15922891.523207724,true,985.0,985,0.875,0.0,0.0,0.0,0.0,0.0,985,21750.0,0.0,-539.2268287752191,-539.2268287752191,2390233.258450767,700.0,689500.0,753.4734631851496,1179510.83856368,-2548.369841420113,108521.77591846143,0.0,0.0,1303.5025164484532,1100163.687463847,-47.832966988708876,2036.9565047791734,-0.0,-4341691.240920603,true,true,11.4891144,9759.22034951597,0.0,121.92,1644.2724500334996,985.0,11.4891144,9759.22034951597,0.0,121.92,0.0,295.15 +986,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,690200.0,5833.333333333334,20890657.703307383,5833.333333333334,15928724.856541058,true,986.0,986,0.875,0.0,0.0,0.0,0.0,0.0,986,21750.0,0.0,-2257.6823493752063,-2257.6823493752063,2387975.576101392,700.0,690200.0,719.0344170389658,1180229.872980719,-4181.561023552564,104340.21489490886,0.0,0.0,1283.3322643145384,1101447.0197281616,-78.48800717614667,1958.4684976030267,-0.0,-4341691.240920603,true,true,11.26559077,9770.48594028597,0.0,121.92,1644.2724500334996,986.0,11.26559077,9770.48594028597,0.0,121.92,0.0,295.15 +987,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,690900.0,5833.333333333334,20896491.036640715,5833.333333333334,15934558.189874392,true,987.0,987,0.875,0.0,0.0,0.0,0.0,0.0,987,21750.0,0.0,-7992.804363599984,-7992.804363599984,2379982.771737792,700.0,690900.0,649.3691312688386,1180879.242111988,-9700.564137773415,94639.65075713545,0.0,0.0,1240.470479446446,1102687.490207608,-182.07983654185355,1776.388661061173,-0.0,-4341691.240920603,true,true,10.72913407,9781.215074355969,0.0,121.92,1644.2724500334996,987.0,10.72913407,9781.215074355969,0.0,121.92,0.0,295.15 +988,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,691600.0,5833.333333333334,20902324.369974047,5833.333333333334,15940391.523207726,true,988.0,988,0.875,0.0,0.0,0.0,0.0,0.0,988,21750.0,0.0,-13709.26926005884,-13709.26926005884,2366273.5024777334,700.0,691600.0,530.7253435984163,1181409.9674555864,-15116.055331959957,79523.59542517549,0.0,0.0,1159.7894728283377,1103847.2796804365,-283.7287445256381,1492.6599165355349,-0.0,-4341691.240920603,true,true,9.835039564,9791.05011391997,0.0,121.92,1644.2724500334996,988.0,9.835039564,9791.05011391997,0.0,121.92,0.0,295.15 +989,22450.0,21750.0,0.12,0.0,4961932.846766403,700.0,692300.0,5833.333333333334,20908157.70330738,5833.333333333334,15946224.85654106,true,989.0,989,0.875,0.0,0.0,0.0,0.0,0.0,989,21750.0,0.0,-2095.140763762001,-2095.140763762001,2364178.3617139715,700.0,692300.0,448.8116304564986,1181858.779086043,-3573.6326542764773,75949.96277089902,0.0,0.0,1096.7574362211203,1104944.0371166577,-67.07717616314252,1425.5827403723924,-0.0,-4341691.240920603,true,true,9.611515937,9800.66162985697,0.0,121.92,1644.2724500334996,989.0,9.611515937,9800.66162985697,0.0,121.92,0.0,295.15 +990,22450.0,21750.0,0.16720000000000002,1734.47268879474,4963667.319455198,700.0,693000.0,14560.243354035525,20922717.946661413,12825.770665240785,15959050.627206301,true,990.0,990,0.875,1517.6636026953975,1734.47268879474,216.8090860993425,0.0,0.0,990,21750.0,0.0,1517.6636026953975,1517.6636026953975,2365696.025316667,700.0,693000.0,433.51257381828,1182292.291659861,0.0,75949.96277089902,0.0,0.0,1084.1510288771174,1106028.1881455348,0.0,1425.5827403723924,-1517.6636026953975,-4343208.904523299,true,true,9.611515937,9810.27314579397,0.0,121.92,1644.2724500334996,990.0,9.611515937,9810.27314579397,0.0,121.92,0.0,295.15 +991,24184.47268879474,23484.47268879474,0.20800000000000002,4238.567970783865,4967905.887425981,700.0,693700.0,23743.115244153196,20946461.061905567,19504.54727336933,15978555.17447967,true,991.0,991,0.875,3708.7469744358823,4238.567970783865,529.820996347983,0.0,0.0,991,23484.47268879474,0.0,3708.7469744358823,3708.7469744358823,2369404.772291103,700.0,693700.0,442.64954365298934,1182734.941203514,2134.321292359348,78084.28406325837,0.0,0.0,1091.7148732722394,1107119.903018807,40.06126515130583,1465.6440055236983,-3708.7469744358823,-4346917.651497735,true,true,9.745630113,9820.01877590697,0.0,121.92,1644.2724500334996,991.0,9.745630113,9820.01877590697,0.0,121.92,0.0,295.15 +992,26688.567970783864,25988.567970783864,0.28,7750.5041029581125,4975656.39152894,700.0,694400.0,30180.371796278967,20976641.433701847,22429.867693320855,16000985.042172993,true,992.0,992,0.875,6781.691090088349,7750.5041029581125,968.813012869764,0.0,0.0,992,25988.567970783864,0.0,6781.691090088349,6781.691090088349,2376186.4633811912,700.0,694400.0,474.0318365981325,1183208.9730401123,5095.096474668295,83179.38053792666,0.0,0.0,1116.9276879038466,1108236.830706711,95.63509091807472,1561.279096441773,-6781.691090088349,-4353699.342587823,true,true,10.05856319,9830.07733909697,0.0,121.92,1644.2724500334996,992.0,10.05856319,9830.07733909697,0.0,121.92,0.0,295.15 +993,30200.50410295811,29500.50410295811,0.25,6250.15819208733,4981906.549721027,700.0,695100.0,27800.63276834932,21004442.066470195,21550.47457626199,16022535.516749255,true,993.0,993,0.875,5468.8884180764135,6250.15819208733,781.2697740109161,0.0,0.0,993,29500.50410295811,0.0,5468.8884180764135,5468.8884180764135,2381655.351799268,700.0,695100.0,513.6065125515006,1183722.5795526637,3737.9376546560616,86917.31819258272,0.0,0.0,1147.1830656535303,1109384.0137723645,70.16118521532044,1631.4402816570935,-5468.8884180764135,-4359168.2310059,true,true,10.28208682,9840.35942591697,0.0,121.92,1644.2724500334996,993.0,10.28208682,9840.35942591697,0.0,121.92,0.0,295.15 +994,28700.15819208733,28000.15819208733,0.124,166.0536737871037,4982072.603394814,700.0,695800.0,6984.303820863739,21011426.370291058,6818.250147076636,16029353.766896332,true,994.0,994,0.875,145.29696456371573,166.0536737871037,20.756709223387958,0.0,0.0,994,28000.15819208733,0.0,145.29696456371573,145.29696456371573,2381800.6487638317,700.0,695800.0,523.8328938474393,1184246.4124465112,-1505.0333256096048,85412.28486697312,0.0,0.0,1154.7469102742466,1110538.7606826387,-28.24951394836529,1603.1907677087281,-145.29696456371573,-4359313.527970463,true,true,10.19267737,9850.55210328697,0.0,121.92,1644.2724500334996,994.0,10.19267737,9850.55210328697,0.0,121.92,0.0,295.15 +995,22616.053673787104,21916.053673787104,0.1696,1904.8053999813317,4983977.408794795,700.0,696500.0,15358.522405550306,21026784.892696608,13453.717005568975,16042807.483901901,true,995.0,995,0.875,1666.7047249836653,1904.8053999813317,238.10067499766637,0.0,0.0,995,21916.053673787104,0.0,1666.7047249836653,1666.7047249836653,2383467.3534888155,700.0,696500.0,517.0003776019009,1184763.4128241132,0.0,85412.28486697312,0.0,0.0,1149.7043473817644,1111688.4650300206,0.0,1603.1907677087281,-1666.7047249836653,-4360980.232695446,true,true,10.19267737,9860.744780656969,0.0,121.92,1644.2724500334996,995.0,10.19267737,9860.744780656969,0.0,121.92,0.0,295.15 +996,24354.80539998133,23654.80539998133,0.196,3670.7001642053215,4987648.108959001,700.0,697200.0,22299.49063370062,21049084.383330308,18628.7904694953,16061436.274371397,true,996.0,996,0.875,3211.8626436796562,3670.7001642053215,458.83752052566524,0.0,0.0,996,23654.80539998133,0.0,3211.8626436796562,3211.8626436796562,2386679.216132495,700.0,697200.0,523.8328938474393,1185287.2457179606,1505.0333256096048,86917.31819258272,0.0,0.0,1154.7469102742466,1112843.2119402948,28.24951394836529,1631.4402816570935,-3211.8626436796562,-4364192.095339126,true,true,10.28208682,9871.026867476969,0.0,121.92,1644.2724500334996,996.0,10.28208682,9871.026867476969,0.0,121.92,0.0,295.15 +997,26120.700164205322,25420.700164205322,0.12,0.0,4987648.108959001,700.0,697900.0,5833.333333333334,21054917.71666364,5833.333333333334,16067269.60770473,true,997.0,997,0.875,0.0,0.0,0.0,0.0,0.0,997,25420.700164205322,0.0,-622.2678871790627,-622.2678871790627,2386056.948245316,700.0,697900.0,520.4091599538554,1185807.6548779146,-2252.6209234319535,84664.69726915077,0.0,0.0,1152.2256285460128,1113995.4375688408,-42.28175224697732,1589.1585294101162,-0.0,-4364192.095339126,true,true,10.14797264,9881.174840116968,0.0,121.92,1644.2724500334996,997.0,10.14797264,9881.174840116968,0.0,121.92,0.0,295.15 +998,22450.0,21750.0,0.1696,1891.3020763166555,4989539.411035317,700.0,698600.0,15278.903751867072,21070196.62041551,13387.601675550417,16080657.20938028,true,998.0,998,0.875,1654.8893167770736,1891.3020763166555,236.41275953958188,0.0,0.0,998,21750.0,0.0,1654.8893167770736,1654.8893167770736,2387711.837562093,700.0,698600.0,510.2275328517772,1186317.8824107663,0.0,84664.69726915077,0.0,0.0,1144.6617839252965,1115140.099352766,0.0,1589.1585294101162,-1654.8893167770736,-4365846.984655903,true,true,10.14797264,9891.322812756967,0.0,121.92,1644.2724500334996,998.0,10.14797264,9891.322812756967,0.0,121.92,0.0,295.15 +999,24341.302076316657,23641.302076316657,0.1696,1891.3020763166555,4991430.713111633,700.0,699300.0,15278.903751867072,21085475.524167378,13387.601675550417,16094044.81105583,true,999.0,999,0.875,1654.8893167770736,1891.3020763166555,236.41275953958188,0.0,0.0,999,23641.302076316657,0.0,1654.8893167770736,1654.8893167770736,2389366.7268788703,700.0,699300.0,510.2275328517772,1186828.109943618,0.0,84664.69726915077,0.0,0.0,1144.6617839252965,1116284.7611366913,0.0,1589.1585294101162,-1654.8893167770736,-4367501.8739726795,true,true,10.14797264,9901.470785396967,0.0,121.92,1644.2724500334996,999.0,10.14797264,9901.470785396967,0.0,121.92,0.0,295.15 +1000,24341.302076316657,23641.302076316657,0.29250000000000004,9016.235252073206,5000446.9483637065,700.0,700000.0,33217.898297686166,21118693.422465064,24201.66304561296,16118246.474101443,true,1000.0,1000,0.875,7889.205845564055,9016.235252073206,1127.0294065091502,0.0,0.0,1000,23641.302076316657,0.0,7889.205845564055,7889.205845564055,2397255.9327244344,700.0,700000.0,537.6779891878742,1187365.787932806,6072.710882566083,90737.40815171685,0.0,0.0,1164.8320354952257,1117449.5931721865,113.98493831487275,1703.143467724989,-7889.205845564055,-4375391.079818243,true,true,10.50561044,9911.976395836966,0.0,121.92,1644.2724500334996,1000.0,10.50561044,9911.976395836966,0.0,121.92,0.0,295.15 +1001,31466.235252073206,30766.235252073206,0.265,6579.945172908674,5007026.893536615,700.0,700700.0,27471.491218523297,21146164.913683586,20891.546045614625,16139138.020147057,true,1001.0,1001,0.875,5757.45202629509,6579.945172908674,822.493146613584,0.0,0.0,1001,30766.235252073206,0.0,5757.45202629509,5757.45202629509,2403013.3847507294,700.0,700700.0,584.3555329619527,1187950.1434657678,3902.2426054185994,94639.65075713545,0.0,0.0,1197.6086945783534,1118647.2018667648,73.24519333618417,1776.3886610611733,-5757.45202629509,-4381148.531844539,true,true,10.72913407,9922.705529906965,0.0,121.92,1644.2724500334996,1001.0,10.72913407,9922.705529906965,0.0,121.92,0.0,295.15 +1002,29029.945172908672,28329.945172908672,0.28,7694.062885700793,5014720.956422316,700.0,701400.0,29978.796020359976,21176143.709703945,22284.73313465918,16161422.753281716,true,1002.0,1002,0.875,6732.305024988194,7694.062885700793,961.7578607125988,0.0,0.0,1002,28329.945172908672,0.0,6732.305024988194,6732.305024988194,2409745.6897757174,700.0,701400.0,625.9002709116227,1188576.0437366795,4791.132287935321,99430.78304507077,0.0,0.0,1225.342790768999,1119872.5446575338,89.92967537225101,1866.3183364334243,-6732.305024988194,-4387880.836869527,true,true,10.99736242,9933.702892326965,0.0,121.92,1644.2724500334996,1002.0,10.99736242,9933.702892326965,0.0,121.92,0.0,295.15 +1003,30144.062885700794,29444.062885700794,0.20800000000000002,4064.7273506183224,5018785.683772935,700.0,702100.0,22907.34303181886,21199051.052735765,18842.615681200536,16180265.368962917,true,1003.0,1003,0.875,3556.636431791032,4064.7273506183224,508.09091882729035,0.0,0.0,1003,29444.062885700794,0.0,3556.636431791032,3556.636431791032,2413302.3262075083,700.0,702100.0,657.3205021939968,1189233.3642388736,1623.33288751239,101054.11593258315,0.0,0.0,1245.5130423389282,1121118.0576998726,30.469999745717175,1896.7883361791414,-3556.636431791032,-4391437.473301318,true,true,11.08677187,9944.789664196964,0.0,121.92,1644.2724500334996,1003.0,11.08677187,9944.789664196964,0.0,121.92,0.0,295.15 +1004,26514.727350618323,25814.727350618323,0.22,5075.902333791998,5023861.586106727,700.0,702800.0,26254.101517236355,21225305.154253002,21178.199183444358,16201443.568146361,true,1004.0,1004,0.875,4441.414542067998,5075.902333791998,634.4877917240001,0.0,0.0,1004,25814.727350618323,0.0,4441.414542067998,4441.414542067998,2417743.740749576,700.0,702800.0,677.4823240752958,1189910.8465629488,2459.6451655826645,103513.76109816582,0.0,0.0,1258.1194498521268,1122376.1771497247,46.167602557911074,1942.9559387370525,-4441.414542067998,-4395878.887843385,true,true,11.22088605,9956.010550246963,0.0,121.92,1644.2724500334996,1004.0,11.22088605,9956.010550246963,0.0,121.92,0.0,295.15 +1005,27525.902333791997,26825.902333791997,0.25,6137.275802641789,5029998.861909369,700.0,703500.0,27349.103210567155,21252654.25746357,21211.827407925368,16222655.395554285,true,1005.0,1005,0.875,5370.116327311565,6137.275802641789,767.1594753302234,0.0,0.0,1005,26825.902333791997,0.0,5370.116327311565,5370.116327311565,2423113.8570768875,700.0,703500.0,706.3954325730705,1190617.2419955218,3325.532151096757,106839.29324926258,0.0,0.0,1275.7684202578077,1123651.9455699825,62.42032338393042,2005.376262120983,-5370.116327311565,-4401249.004170697,true,true,11.39970495,9967.410255196963,0.0,121.92,1644.2724500334996,1005.0,11.39970495,9967.410255196963,0.0,121.92,0.0,295.15 +1006,28587.275802641787,27887.275802641787,0.196,3281.4581828566247,5033280.320092225,700.0,704200.0,20313.56215743176,21272967.819621004,17032.103974575133,16239687.49952886,true,1006.0,1006,0.875,2871.2759099995465,3281.4581828566247,410.18227285707826,0.0,0.0,1006,27887.275802641787,0.0,2871.2759099995465,2871.2759099995465,2425985.132986887,700.0,704200.0,727.543612270065,1191344.785607792,839.5981910399303,107678.89144030251,0.0,0.0,1288.3748272070206,1124940.3203971896,15.759279482530792,2021.1355416035137,-2871.2759099995465,-4404120.280080697,true,true,11.44440967,9978.854664866964,0.0,121.92,1644.2724500334996,1006.0,11.44440967,9978.854664866964,0.0,121.92,0.0,295.15 +1007,25731.458182856626,25031.458182856626,0.16,1326.3553930909995,5034606.675485317,700.0,704900.0,12664.721206818747,21285632.540827822,11338.365813727747,16251025.86534259,true,1007.0,1007,0.875,1160.5609689546245,1326.3553930909995,165.79442413637503,0.0,0.0,1007,25031.458182856626,0.0,1160.5609689546245,1160.5609689546245,2427145.6939558415,700.0,704900.0,727.543612270065,1192072.3292200621,-839.5981910399303,106839.29324926258,0.0,0.0,1288.3748272070206,1126228.6952243967,-15.759279482530792,2005.376262120983,-1160.5609689546245,-4405280.841049652,true,true,11.39970495,9990.254369816963,0.0,121.92,1644.2724500334996,1007.0,11.39970495,9990.254369816963,0.0,121.92,0.0,295.15 +1008,23776.355393091,23076.355393091,0.12,0.0,5034606.675485317,700.0,705600.0,5833.333333333334,21291465.874161154,5833.333333333334,16256859.198675923,true,1008.0,1008,0.875,0.0,0.0,0.0,0.0,0.0,1008,23076.355393091,0.0,-2251.1085120461435,-2251.1085120461435,2424894.585443795,700.0,705600.0,702.2155883763056,1192774.5448084385,-4148.700033400049,102690.59321586254,0.0,0.0,1273.2471385295737,1127501.9423629262,-77.87120555197411,1927.505056569009,-0.0,-4405280.841049652,true,true,11.17618132,10001.430551136962,0.0,121.92,1644.2724500334996,1008.0,11.17618132,10001.430551136962,0.0,121.92,0.0,295.15 +1009,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,706300.0,5833.333333333334,21297299.207494486,5833.333333333334,16262692.532009257,true,1009.0,1009,0.875,0.0,0.0,0.0,0.0,0.0,1009,21750.0,0.0,-5513.551261864985,-5513.551261864985,2419381.03418193,700.0,706300.0,645.4176054289632,1193419.9624138675,-7260.635746667871,95429.95746919466,0.0,0.0,1237.949197718212,1128739.8915606444,-136.28231834428826,1791.2227382247206,-0.0,-4405280.841049652,true,true,10.77383879,10012.204389926963,0.0,121.92,1644.2724500334996,1009.0,10.77383879,10012.204389926963,0.0,121.92,0.0,295.15 +1010,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,707000.0,5833.333333333334,21303132.54082782,5833.333333333334,16268525.865342591,true,1010.0,1010,0.875,0.0,0.0,0.0,0.0,0.0,1010,21750.0,0.0,-1399.8066954137637,-1399.8066954137637,2417981.2274865163,700.0,707000.0,595.4976076806397,1194015.4600215482,-3141.5106074188498,92288.44686177581,0.0,0.0,1205.1725386350843,1129945.0640992795,-58.96623431063786,1732.2565039140827,-0.0,-4405280.841049652,true,true,10.59501989,10022.799409816962,0.0,121.92,1644.2724500334996,1010.0,10.59501989,10022.799409816962,0.0,121.92,0.0,295.15 +1011,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,707700.0,5833.333333333334,21308965.87416115,5833.333333333334,16274359.198675925,true,1011.0,1011,0.875,0.0,0.0,0.0,0.0,0.0,1011,21750.0,0.0,-2180.299859693081,-2180.299859693081,2415800.927626823,700.0,707700.0,562.4900698869907,1194577.950091435,-3852.9509478165046,88435.49591395931,0.0,0.0,1182.4810059009064,1131127.5451051805,-72.31998766447373,1659.936516249609,-0.0,-4405280.841049652,true,true,10.37149627,10033.170906086962,0.0,121.92,1644.2724500334996,1011.0,10.37149627,10033.170906086962,0.0,121.92,0.0,295.15 +1012,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,708400.0,5833.333333333334,21314799.207494482,5833.333333333334,16280192.532009259,true,1012.0,1012,0.875,0.0,0.0,0.0,0.0,0.0,1012,21750.0,0.0,-618.4844709052221,-618.4844709052221,2415182.443155918,700.0,708400.0,534.1941258082862,1195112.1442172434,-2272.3375178174856,86163.15839614182,0.0,0.0,1162.3107543309773,1132289.8558595115,-42.65183322700004,1617.284683022609,-0.0,-4405280.841049652,true,true,10.23738209,10043.408288176961,0.0,121.92,1644.2724500334996,1012.0,10.23738209,10043.408288176961,0.0,121.92,0.0,295.15 +1013,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,709100.0,5833.333333333334,21320632.540827814,5833.333333333334,16286025.865342593,true,1013.0,1013,0.875,0.0,0.0,0.0,0.0,0.0,1013,21750.0,0.0,-1384.8941280189263,-1384.8941280189263,2413797.549027899,700.0,709100.0,510.22753285177686,1195622.3717500952,-2983.7778582151636,83179.38053792666,0.0,0.0,1144.6617839252963,1133434.5176434368,-56.00558658083572,1561.2790964417732,-0.0,-4405280.841049652,true,true,10.05856319,10053.46685136696,0.0,121.92,1644.2724500334996,1013.0,10.05856319,10053.46685136696,0.0,121.92,0.0,295.15 +1014,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,709800.0,5833.333333333334,21326465.874161147,5833.333333333334,16291859.198675927,true,1014.0,1014,0.875,0.0,0.0,0.0,0.0,0.0,1014,21750.0,0.0,-2121.9528802667282,-2121.9528802667282,2411675.596147632,700.0,709800.0,480.48116153794797,1196102.8529116332,-3655.785112751166,79523.59542517549,0.0,0.0,1121.9702508527275,1134556.4878942894,-68.61917990623803,1492.659916535535,-0.0,-4405280.841049652,true,true,9.835039564,10063.301890930961,0.0,121.92,1644.2724500334996,1014.0,9.835039564,10063.301890930961,0.0,121.92,0.0,295.15 +1015,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,710500.0,5833.333333333334,21332299.20749448,5833.333333333334,16297692.53200926,true,1015.0,1015,0.875,0.0,0.0,0.0,0.0,0.0,1015,21750.0,0.0,-1368.0706911425218,-1368.0706911425218,2410307.5254564895,700.0,710500.0,451.91400410552706,1196554.7669157388,-2865.478311895824,76658.11711327966,0.0,0.0,1099.2787177237599,1135655.766612013,-53.7851010759847,1438.8748154595505,-0.0,-4405280.841049652,true,true,9.656220663,10072.958111593962,0.0,121.92,1644.2724500334996,1015.0,9.656220663,10072.958111593962,0.0,121.92,0.0,295.15 +1016,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,711200.0,5833.333333333334,21338132.54082781,5833.333333333334,16303525.865342595,true,1016.0,1016,0.875,0.0,0.0,0.0,0.0,0.0,1016,21750.0,0.0,-6283.465355440145,-6283.465355440145,2404024.0601010495,700.0,711200.0,406.8577746052386,1196961.624690344,-7608.962210823534,69049.15490245612,0.0,0.0,1061.4594957481497,1136717.2261077613,-142.8204149699991,1296.0544004895514,-0.0,-4405280.841049652,true,true,9.164468684,10082.122580277963,0.0,121.92,1644.2724500334996,1016.0,9.164468684,10082.122580277963,0.0,121.92,0.0,295.15 +1017,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,711900.0,5833.333333333334,21343965.874161143,5833.333333333334,16309359.198675929,true,1017.0,1017,0.875,0.0,0.0,0.0,0.0,0.0,1017,21750.0,0.0,-17825.06413448635,-17825.06413448635,2386198.995966563,700.0,711900.0,299.1900329821921,1197260.8147233264,-18730.76420095619,50318.390701499935,0.0,0.0,958.0869557754799,1137675.3130635368,-351.5769222878327,944.4774782017187,-0.0,-4405280.841049652,true,true,7.823326926,10089.945907203963,0.0,121.92,1644.2724500334996,1017.0,7.823326926,10089.945907203963,0.0,121.92,0.0,295.15 +1018,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,712600.0,5833.333333333334,21349799.207494475,5833.333333333334,16315192.532009263,true,1018.0,1018,0.875,0.0,0.0,0.0,0.0,0.0,1018,21750.0,0.0,-16537.622884461296,-16537.622884461296,2369661.373082102,700.0,712600.0,173.68972136237082,1197434.5044446888,-17187.940742882525,33130.449958617406,0.0,0.0,799.2462236471132,1138474.559287184,-322.6180865882553,621.8593916134633,-0.0,-4405280.841049652,true,true,6.348070991,10096.293978194963,0.0,121.92,1644.2724500334996,1018.0,6.348070991,10096.293978194963,0.0,121.92,0.0,295.15 +1019,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,713300.0,5833.333333333334,21355632.540827807,5833.333333333334,16321025.865342597,true,1019.0,1019,0.875,0.0,0.0,0.0,0.0,0.0,1019,21750.0,0.0,-13145.763800202758,-13145.763800202758,2356515.609281899,700.0,713300.0,86.2218816277595,1197520.7263263166,-13609.3789387968,19521.071019820607,0.0,0.0,632.8416471236244,1139107.4009343076,-255.44839015734206,366.4110014561213,-0.0,-4405280.841049652,true,true,4.872815057,10101.166793251963,0.0,121.92,1644.2724500334996,1019.0,4.872815057,10101.166793251963,0.0,121.92,0.0,295.15 +1020,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,714000.0,5833.333333333334,21361465.87416114,5833.333333333334,16326859.19867593,true,1020.0,1020,0.875,0.0,0.0,0.0,0.0,0.0,1020,21750.0,0.0,-9718.135539046629,-9718.135539046629,2346797.4737428525,700.0,714000.0,34.523237587262855,1197555.2495639038,-10030.817153161288,9490.25386665932,0.0,0.0,466.43707060013566,1139573.8380049078,-188.27869407273917,178.13230738338214,-0.0,-4405280.841049652,true,true,3.397559122,10104.564352373964,0.0,121.92,1644.2724500334996,1020.0,3.397559122,10104.564352373964,0.0,121.92,0.0,295.15 +1021,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,714700.0,5833.333333333334,21367299.20749447,5833.333333333334,16332692.532009264,true,1021.0,1021,0.875,0.0,0.0,0.0,0.0,0.0,1021,21750.0,0.0,-6264.143517503177,-6264.143517503177,2340533.3302253494,700.0,714700.0,9.18834335659429,1197564.4379072604,-6452.2553570878035,3037.9985095715156,0.0,0.0,300.03249402024835,1139873.870498928,-121.10899779221543,57.02330959116671,-0.0,-4405280.841049652,true,true,1.922303187,10106.486655560964,0.0,121.92,1644.2724500334996,1021.0,1.922303187,10106.486655560964,0.0,121.92,0.0,295.15 +1022,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,715400.0,5833.333333333334,21373132.540827803,5833.333333333334,16338525.865342598,true,1022.0,1022,0.875,0.0,0.0,0.0,0.0,0.0,1022,21750.0,0.0,-2793.193191209225,-2793.193191209225,2337740.13703414,700.0,715400.0,0.8117530711655422,1197565.2496603315,-2873.6935602792555,164.30494929226006,0.0,0.0,133.62791749675952,1140007.4984164247,-53.93930149789451,3.084008093272196,-0.0,-4405280.841049652,true,true,0.447047253,10106.933702813963,0.0,121.92,1644.2724500334996,1022.0,0.447047253,10106.933702813963,0.0,121.92,0.0,295.15 +1023,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,716100.0,5833.333333333334,21378965.874161135,5833.333333333334,16344359.198675932,true,1023.0,1023,0.875,0.0,0.0,0.0,0.0,0.0,1023,21750.0,0.0,-142.17069024579726,-142.17069024579726,2337597.966343894,700.0,716100.0,0.005452508259103674,1197565.2551128399,-164.30494929239373,-1.3366729945119005e-10,0.0,0.0,25.212814631607213,1140032.7112310564,-3.084008093269858,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1023.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1024,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,716800.0,5833.333333333334,21384799.207494467,5833.333333333334,16350192.532009266,true,1024.0,1024,0.875,0.0,0.0,0.0,0.0,0.0,1024,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,716800.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1024.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1025,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,717500.0,5833.333333333334,21390632.5408278,5833.333333333334,16356025.8653426,true,1025.0,1025,0.875,0.0,0.0,0.0,0.0,0.0,1025,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,717500.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1025.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1026,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,718200.0,5833.333333333334,21396465.87416113,5833.333333333334,16361859.198675934,true,1026.0,1026,0.875,0.0,0.0,0.0,0.0,0.0,1026,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,718200.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1026.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1027,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,718900.0,5833.333333333334,21402299.207494464,5833.333333333334,16367692.532009268,true,1027.0,1027,0.875,0.0,0.0,0.0,0.0,0.0,1027,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,718900.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1027.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1028,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,719600.0,5833.333333333334,21408132.540827796,5833.333333333334,16373525.865342602,true,1028.0,1028,0.875,0.0,0.0,0.0,0.0,0.0,1028,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,719600.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1028.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1029,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,720300.0,5833.333333333334,21413965.874161128,5833.333333333334,16379359.198675936,true,1029.0,1029,0.875,0.0,0.0,0.0,0.0,0.0,1029,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,720300.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1029.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1030,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,721000.0,5833.333333333334,21419799.20749446,5833.333333333334,16385192.53200927,true,1030.0,1030,0.875,0.0,0.0,0.0,0.0,0.0,1030,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,721000.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1030.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1031,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,721700.0,5833.333333333334,21425632.540827792,5833.333333333334,16391025.865342604,true,1031.0,1031,0.875,0.0,0.0,0.0,0.0,0.0,1031,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,721700.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1031.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1032,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,722400.0,5833.333333333334,21431465.874161124,5833.333333333334,16396859.198675938,true,1032.0,1032,0.875,0.0,0.0,0.0,0.0,0.0,1032,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,722400.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1032.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1033,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,723100.0,5833.333333333334,21437299.207494456,5833.333333333334,16402692.532009272,true,1033.0,1033,0.875,0.0,0.0,0.0,0.0,0.0,1033,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,723100.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1033.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1034,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,723800.0,5833.333333333334,21443132.54082779,5833.333333333334,16408525.865342606,true,1034.0,1034,0.875,0.0,0.0,0.0,0.0,0.0,1034,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,723800.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1034.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1035,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,724500.0,5833.333333333334,21448965.87416112,5833.333333333334,16414359.19867594,true,1035.0,1035,0.875,0.0,0.0,0.0,0.0,0.0,1035,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,724500.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1035.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1036,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,725200.0,5833.333333333334,21454799.207494453,5833.333333333334,16420192.532009274,true,1036.0,1036,0.875,0.0,0.0,0.0,0.0,0.0,1036,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,725200.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1036.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1037,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,725900.0,5833.333333333334,21460632.540827785,5833.333333333334,16426025.865342608,true,1037.0,1037,0.875,0.0,0.0,0.0,0.0,0.0,1037,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,725900.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1037.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1038,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,726600.0,5833.333333333334,21466465.874161117,5833.333333333334,16431859.198675942,true,1038.0,1038,0.875,0.0,0.0,0.0,0.0,0.0,1038,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,726600.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1038.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1039,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,727300.0,5833.333333333334,21472299.20749445,5833.333333333334,16437692.532009276,true,1039.0,1039,0.875,0.0,0.0,0.0,0.0,0.0,1039,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,727300.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1039.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1040,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,728000.0,5833.333333333334,21478132.54082778,5833.333333333334,16443525.86534261,true,1040.0,1040,0.875,0.0,0.0,0.0,0.0,0.0,1040,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,728000.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1040.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1041,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,728700.0,5833.333333333334,21483965.874161113,5833.333333333334,16449359.198675944,true,1041.0,1041,0.875,0.0,0.0,0.0,0.0,0.0,1041,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,728700.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1041.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1042,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,729400.0,5833.333333333334,21489799.207494445,5833.333333333334,16455192.532009277,true,1042.0,1042,0.875,0.0,0.0,0.0,0.0,0.0,1042,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,729400.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1042.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1043,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,730100.0,5833.333333333334,21495632.540827777,5833.333333333334,16461025.865342611,true,1043.0,1043,0.875,0.0,0.0,0.0,0.0,0.0,1043,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,730100.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1043.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1044,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,730800.0,5833.333333333334,21501465.87416111,5833.333333333334,16466859.198675945,true,1044.0,1044,0.875,0.0,0.0,0.0,0.0,0.0,1044,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,730800.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1044.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1045,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,731500.0,5833.333333333334,21507299.20749444,5833.333333333334,16472692.53200928,true,1045.0,1045,0.875,0.0,0.0,0.0,0.0,0.0,1045,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,731500.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1045.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1046,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,732200.0,5833.333333333334,21513132.540827774,5833.333333333334,16478525.865342613,true,1046.0,1046,0.875,0.0,0.0,0.0,0.0,0.0,1046,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,732200.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1046.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1047,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,732900.0,5833.333333333334,21518965.874161106,5833.333333333334,16484359.198675947,true,1047.0,1047,0.875,0.0,0.0,0.0,0.0,0.0,1047,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,732900.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1047.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1048,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,733600.0,5833.333333333334,21524799.207494438,5833.333333333334,16490192.532009281,true,1048.0,1048,0.875,0.0,0.0,0.0,0.0,0.0,1048,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,733600.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1048.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1049,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,734300.0,5833.333333333334,21530632.54082777,5833.333333333334,16496025.865342615,true,1049.0,1049,0.875,0.0,0.0,0.0,0.0,0.0,1049,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,734300.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1049.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1050,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,735000.0,5833.333333333334,21536465.874161102,5833.333333333334,16501859.19867595,true,1050.0,1050,0.875,0.0,0.0,0.0,0.0,0.0,1050,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,735000.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1050.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1051,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,735700.0,5833.333333333334,21542299.207494434,5833.333333333334,16507692.532009283,true,1051.0,1051,0.875,0.0,0.0,0.0,0.0,0.0,1051,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,735700.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1051.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1052,22450.0,21750.0,0.12,0.0,5034606.675485317,700.0,736400.0,5833.333333333334,21548132.540827766,5833.333333333334,16513525.865342617,true,1052.0,1052,0.875,0.0,0.0,0.0,0.0,0.0,1052,21750.0,0.0,0.0,0.0,2337597.966343894,700.0,736400.0,0.0,1197565.2551128399,0.0,-1.3366729945119005e-10,0.0,0.0,0.0,1140032.7112310564,0.0,2.3381296898605797e-12,-0.0,-4405280.841049652,true,true,0.0,10106.933702813963,0.0,121.92,1644.2724500334996,1052.0,0.0,10106.933702813963,0.0,121.92,0.0,295.15 +1053,22450.0,21750.0,0.128,310.06274006228875,5034916.738225379,700.0,737100.0,7891.1151567366305,21556023.655984502,7581.052416674342,16521106.917759292,true,1053.0,1053,0.875,271.30489755450265,310.06274006228875,38.75784250778611,0.0,0.0,1053,21750.0,0.0,271.30489755450265,271.30489755450265,2337869.271241449,700.0,737100.0,0.009421934240117264,1197565.264534774,236.59912645179844,236.59912645166477,0.0,0.0,30.255377524089532,1140062.9666085804,4.440971644374586,4.4409716443769245,-271.30489755450265,-4405552.145947206,true,true,0.536456703,10107.470159516963,0.0,121.92,1644.2724500334996,1053.0,0.536456703,10107.470159516963,0.0,121.92,0.0,295.15 +1054,22760.062740062287,22060.062740062287,0.1888,2936.0645970350456,5037852.802822414,700.0,737800.0,19258.816721583928,21575282.472706087,16322.752124548882,16537429.66988384,true,1054.0,1054,0.875,2569.056522405665,2936.0645970350456,367.00807462938064,0.0,0.0,1054,22060.062740062287,0.0,2569.056522405665,2569.056522405665,2340438.3277638545,700.0,737800.0,0.7666662807024109,1197566.0312010548,2392.2800622265013,2628.879188678166,0.0,0.0,131.10663605051838,1140194.073244631,44.90315784794314,49.344129492320064,-2569.056522405665,-4408121.202469612,true,true,1.788189012,10109.258348528963,0.0,121.92,1644.2724500334996,1054.0,1.788189012,10109.258348528963,0.0,121.92,0.0,295.15 +1055,25386.064597035045,24686.064597035045,0.28,7468.2359189521,5045321.038741366,700.0,738500.0,29172.27113911464,21604454.743845202,21704.03522016254,16559133.705104003,true,1055.0,1055,0.875,6534.706429083088,7468.2359189521,933.5294898690127,0.0,0.0,1055,24686.064597035045,0.0,6534.706429083088,6534.706429083088,2346973.0341929374,700.0,738500.0,7.86740780533094,1197573.89860886,6126.931554283969,8755.810742962134,0.0,0.0,284.90480528640285,1140478.9780499174,115.00266170738516,164.34679119970522,-6534.706429083088,-4414655.908898694,true,true,3.263444946,10112.521793474963,0.0,121.92,1644.2724500334996,1055.0,3.263444946,10112.521793474963,0.0,121.92,0.0,295.15 +1056,29918.2359189521,29218.2359189521,0.3175,11851.710944453755,5057172.74968582,700.0,739200.0,39532.94785654726,21643987.691701747,27681.236912093504,16586814.942016097,true,1056.0,1056,0.875,10370.247076397036,11851.710944453755,1481.4638680567186,0.0,0.0,1056,29218.2359189521,0.0,10370.247076397036,10370.247076397036,2357343.2812693343,700.0,739200.0,31.271983246328865,1197605.1705921064,9705.49335329772,18461.304096259853,0.0,0.0,451.3093818098916,1140930.2874317272,182.17235804309774,346.519149242803,-10370.247076397036,-4425026.155975091,true,true,4.738700881,10117.260494355964,0.0,121.92,1644.2724500334996,1056.0,4.738700881,10117.260494355964,0.0,121.92,0.0,295.15 +1057,34301.71094445376,33601.71094445376,0.33999999999999997,16264.338765241135,5073437.088451061,700.0,739900.0,49895.1140154151,21693882.805717163,33630.77525017397,16620445.71726627,true,1057.0,1057,0.875,14231.296419585993,16264.338765241135,2033.0423456551416,0.0,0.0,1057,33601.71094445376,0.0,14231.296419585993,14231.296419585993,2371574.5776889203,700.0,739900.0,80.18526796700294,1197685.3558600734,13284.05513915377,31745.359235413624,0.0,0.0,617.7139583333803,1141548.0013900606,249.34205413183997,595.861203374643,-14231.296419585993,-4439257.452394677,true,true,6.213956815,10123.474451170963,0.0,121.92,1644.2724500334996,1057.0,6.213956815,10123.474451170963,0.0,121.92,0.0,295.15 +1058,38714.33876524113,38014.33876524113,0.3516666666666666,19399.00911175056,5092836.097562812,700.0,740600.0,57153.58041256085,21751036.386129722,37754.57130081029,16658200.288567081,true,1058.0,1058,0.875,16974.132972781743,19399.00911175056,2424.876138968819,0.0,0.0,1058,38014.33876524113,0.0,16974.132972781743,16974.132972781743,2388548.710661702,700.0,740600.0,160.8687806667652,1197846.22464074,15738.771085095746,47484.13032050937,0.0,0.0,779.0759719079883,1142327.0773619686,295.4171351112423,891.2783384858853,-16974.132972781743,-4456231.585367459,true,true,7.599803299,10131.074254469962,0.0,121.92,1644.2724500334996,1058.0,7.599803299,10131.074254469962,0.0,121.92,0.0,295.15 +1059,41849.009111750565,41149.009111750565,0.3175,11488.52113139514,5104324.618694208,700.0,741300.0,38389.042933528,21789425.42906325,26900.52180213286,16685100.810369214,true,1059.0,1059,0.875,10052.455989970747,11488.52113139514,1436.065141424393,0.0,0.0,1059,41149.009111750565,0.0,10052.455989970747,10052.455989970747,2398601.1666516727,700.0,741300.0,243.9390852791123,1198090.1637260192,8749.238554414122,56233.36887492349,0.0,0.0,895.054919224661,1143222.1322811933,164.2234310528525,1055.5017695387378,-10052.455989970747,-4466284.04135743,true,true,8.270374179,10139.344628648962,0.0,121.92,1644.2724500334996,1059.0,8.270374179,10139.344628648962,0.0,121.92,0.0,295.15 +1060,33938.521131395144,33238.521131395144,0.33,12512.642156468382,5116837.260850676,700.0,742000.0,40038.3095650557,21829463.738628305,27525.667408587316,16712626.477777801,true,1060.0,1060,0.875,10948.561886909834,12512.642156468382,1564.080269558548,0.0,0.0,1060,33238.521131395144,0.0,10948.561886909834,10948.561886909834,2409549.7285385826,700.0,742000.0,311.1562439418471,1198401.319969961,9488.610812631186,65721.97968755467,0.0,0.0,970.6933631194827,1144192.8256443127,178.10146721731846,1233.6032367560563,-10948.561886909834,-4477232.603244339,true,true,8.940945058,10148.285573706962,0.0,121.92,1644.2724500334996,1060.0,8.940945058,10148.285573706962,0.0,121.92,0.0,295.15 +1061,34962.642156468384,34262.642156468384,0.33999999999999997,16053.100262541306,5132890.361113218,700.0,742700.0,49273.82430159208,21878737.5629299,33220.72403905078,16745847.201816853,true,1061.0,1061,0.875,14046.462729723642,16053.100262541306,2006.6375328176637,0.0,0.0,1061,34262.642156468384,0.0,14046.462729723642,14046.462729723642,2423596.191268306,700.0,742700.0,398.2219338992979,1198799.5419038602,12362.304375703674,78084.28406325835,0.0,0.0,1053.895651353028,1145246.7212956657,232.04076876764228,1465.6440055236985,-14046.462729723642,-4491279.065974062,true,true,9.745630113,10158.031203819963,0.0,121.92,1644.2724500334996,1061.0,9.745630113,10158.031203819963,0.0,121.92,0.0,295.15 +1062,38503.10026254131,37803.10026254131,0.3175,12135.575906597176,5145025.937019815,700.0,743400.0,40427.01072943993,21919164.573659338,28291.43482284275,16774138.636639696,true,1062.0,1062,0.875,10618.628918272529,12135.575906597176,1516.9469883246475,0.0,0.0,1062,37803.10026254131,0.0,10618.628918272529,10618.628918272529,2434214.8201865787,700.0,743400.0,490.2644173977315,1199289.806321258,8833.034129324356,86917.31819258271,0.0,0.0,1129.5340954170451,1146376.2553910827,165.79627613339517,1631.4402816570937,-10618.628918272529,-4501897.694892335,true,true,10.28208682,10168.313290639962,0.0,121.92,1644.2724500334996,1062.0,10.28208682,10168.313290639962,0.0,121.92,0.0,295.15 +1063,34585.57590659718,33885.57590659718,0.30500000000000005,10992.433138845763,5156018.37015866,700.0,744100.0,38335.84635687135,21957500.42001621,27343.413218025584,16801482.04985772,true,1063.0,1063,0.875,9618.378996490042,10992.433138845763,1374.0541423557206,0.0,0.0,1063,33885.57590659718,0.0,9618.378996490042,9618.378996490042,2443833.1991830687,700.0,744100.0,566.0957649040934,1199855.902086162,7722.332564552728,94639.65075713543,0.0,0.0,1185.0022876291405,1147561.2576787118,144.9483794040796,1776.3886610611733,-9618.378996490042,-4511516.073888825,true,true,10.72913407,10179.042424709962,0.0,121.92,1644.2724500334996,1063.0,10.72913407,10179.042424709962,0.0,121.92,0.0,295.15 +1064,33442.433138845765,32742.433138845765,0.29250000000000004,9598.753693228804,5165617.123851889,700.0,744800.0,35209.414335824964,21992709.834352035,25610.660642596158,16827092.71050032,true,1064.0,1064,0.875,8398.909481575203,9598.753693228804,1199.8442116536007,0.0,0.0,1064,32742.433138845765,0.0,8398.909481575203,8398.909481575203,2452232.108664644,700.0,744800.0,633.6592773480427,1200489.56136351,6414.465175447712,101054.11593258314,0.0,0.0,1230.3853536614813,1148791.6430323732,120.39967511796819,1896.7883361791414,-8398.909481575203,-4519914.9833704,true,true,11.08677187,10190.129196579961,0.0,121.92,1644.2724500334996,1064.0,11.08677187,10190.129196579961,0.0,121.92,0.0,295.15 +1065,32048.753693228806,31348.753693228806,0.30500000000000005,9963.315240260683,5175580.43909215,700.0,745500.0,34961.689312330105,22027671.523664366,24998.374072069422,16852091.08457239,true,1065.0,1065,0.875,8717.900835228098,9963.315240260683,1245.414405032585,0.0,0.0,1065,31348.753693228806,0.0,8717.900835228098,8717.900835228098,2460950.009499872,700.0,745500.0,698.0522652830352,1201187.613628793,6624.7755077193515,107678.8914403025,0.0,0.0,1270.7258568013397,1150062.3688891744,124.34720542437229,2021.1355416035137,-8717.900835228098,-4528632.884205628,true,true,11.44440967,10201.573606249962,0.0,121.92,1644.2724500334996,1065.0,11.44440967,10201.573606249962,0.0,121.92,0.0,295.15 +1066,32413.315240260683,31713.315240260683,0.3175,11352.63286946551,5186933.071961615,700.0,746200.0,37961.04840776538,22065632.572072133,26608.415538299872,16878699.50011069,true,1066.0,1066,0.875,9933.55376078232,11352.63286946551,1419.0791086831887,0.0,0.0,1066,31713.315240260683,0.0,9933.55376078232,9933.55376078232,2470883.5632606545,700.0,746200.0,771.0978662389034,1201958.7114950318,7704.259112624059,115383.15055292656,0.0,0.0,1313.5876416694323,1151375.9565308439,144.60914024992542,2165.744681853439,-9933.55376078232,-4538566.43796641,true,true,11.8467522,10213.420358449961,0.0,121.92,1644.2724500334996,1066.0,11.8467522,10213.420358449961,0.0,121.92,0.0,295.15 +1067,33802.63286946551,33102.63286946551,0.23500000000000001,5538.2951540358345,5192471.367115651,700.0,746900.0,26545.9368256844,22092178.50889782,21007.641671648566,16899707.14178234,true,1067.0,1067,0.875,4846.008259781355,5538.2951540358345,692.2868942544792,0.0,0.0,1067,33102.63286946551,0.0,4846.008259781355,4846.008259781355,2475729.5715204356,700.0,746900.0,825.6157303219805,1202784.3272253538,2627.2362189622645,118010.38677188882,0.0,0.0,1343.8430195883116,1152719.7995504322,49.31329090879901,2215.057972762238,-4846.008259781355,-4543412.446226192,true,true,11.98086638,10225.40122482996,0.0,121.92,1644.2724500334996,1067.0,11.98086638,10225.40122482996,0.0,121.92,0.0,295.15 +1068,27988.295154035834,27288.295154035834,0.29250000000000004,8775.05400515458,5201246.421120806,700.0,747600.0,32393.3470261695,22124571.855923988,23618.29302101492,16923325.434803355,true,1068.0,1068,0.875,7678.1722545102575,8775.05400515458,1096.881750644322,0.0,0.0,1068,27288.295154035834,0.0,7678.1722545102575,7678.1722545102575,2483407.743774946,700.0,747600.0,868.1488445557432,1203652.4760699095,5343.1969145586945,123353.58368644751,0.0,0.0,1366.5345528864746,1154086.3341033186,100.291942509345,2315.349915271583,-7678.1722545102575,-4551090.618480702,true,true,12.24909473,10237.65031955996,0.0,121.92,1644.2724500334996,1068.0,12.24909473,10237.65031955996,0.0,121.92,0.0,295.15 +1069,31225.05400515458,30525.05400515458,0.28625,7936.754314630945,5209183.175435437,700.0,748300.0,30172.06747469326,22154743.92339868,22235.313160062316,16945560.747963417,true,1069.0,1069,0.875,6944.660025302077,7936.754314630945,992.0942893288684,0.0,0.0,1069,30525.05400515458,0.0,6944.660025302077,6944.660025302077,2490352.4038002477,700.0,748300.0,922.0866322084482,1204574.562702118,4543.0319189054735,127896.61560535298,0.0,0.0,1394.2686490771202,1155480.6027523957,85.27282511103483,2400.622740382618,-6944.660025302077,-4558035.278506004,true,true,12.47261836,10250.12293791996,0.0,121.92,1644.2724500334996,1069.0,12.47261836,10250.12293791996,0.0,121.92,0.0,295.15 +1070,30386.754314630947,29686.754314630947,0.265,7025.951695967306,5216209.127131404,700.0,749000.0,29154.534701763416,22183898.458100446,22128.58300579611,16967689.330969214,true,1070.0,1070,0.875,6147.707733971392,7025.951695967306,878.2439619959132,0.0,0.0,1070,29686.754314630947,0.0,6147.707733971392,6147.707733971392,2496500.1115342192,700.0,749000.0,967.8438146084426,1205542.4065167264,3693.575235512339,131590.1908408653,0.0,0.0,1416.9601823752832,1156897.562934771,69.32850147532703,2469.9512418579448,-6147.707733971392,-4564182.986239975,true,true,12.65143726,10262.774375179959,0.0,121.92,1644.2724500334996,1070.0,12.65143726,10262.774375179959,0.0,121.92,0.0,295.15 +1071,29475.951695967306,28775.951695967306,0.12,0.0,5216209.127131404,700.0,749700.0,5833.333333333334,22189731.791433778,5833.333333333334,16973522.664302547,true,1071.0,1071,0.875,0.0,0.0,0.0,0.0,0.0,1071,28775.951695967306,0.0,-434.69867426491624,-434.69867426491624,2496065.4128599544,700.0,749700.0,973.0194384315259,1206515.425955158,-2775.1106779563092,128815.080162909,0.0,0.0,1419.4814635395317,1158317.0443983106,-52.088898279664605,2417.86234357828,-0.0,-4564182.986239975,true,true,12.51732308,10275.291698259958,0.0,121.92,1644.2724500334996,1071.0,12.51732308,10275.291698259958,0.0,121.92,0.0,295.15 +1072,22450.0,21750.0,0.12,0.0,5216209.127131404,700.0,750400.0,5833.333333333334,22195565.12476711,5833.333333333334,16979355.99763588,true,1072.0,1072,0.875,0.0,0.0,0.0,0.0,0.0,1072,21750.0,0.0,-2313.6050125599213,-2313.6050125599213,2493751.8078473946,700.0,750400.0,932.127414067149,1207447.553369225,-4559.462412144059,124255.61775076494,0.0,0.0,1399.311211405617,1159716.3556097161,-85.58122588862797,2332.281117689652,-0.0,-4564182.986239975,true,true,12.29379945,10287.585497709959,0.0,121.92,1644.2724500334996,1072.0,12.29379945,10287.585497709959,0.0,121.92,0.0,295.15 +1073,22450.0,21750.0,0.12,0.0,5216209.127131404,700.0,751100.0,5833.333333333334,22201398.45810044,5833.333333333334,16985189.33096921,true,1073.0,1073,0.875,0.0,0.0,0.0,0.0,0.0,1073,21750.0,0.0,-2304.6060187210624,-2304.6060187210624,2491447.2018286735,700.0,751100.0,882.6445388610508,1208330.197908086,-4477.30973645687,119778.30801430807,0.0,0.0,1374.0983969432057,1161090.4540066593,-84.03921806844889,2248.241899621203,-0.0,-4564182.986239975,true,true,12.07027583,10299.655773539958,0.0,121.92,1644.2724500334996,1073.0,12.07027583,10299.655773539958,0.0,121.92,0.0,295.15 +1074,22450.0,21750.0,0.1816,2537.2180003338285,5218746.345131738,700.0,751800.0,17826.090310208307,22219224.54841065,15288.872309874478,17000478.203279085,true,1074.0,1074,0.875,2220.0657502921,2537.2180003338285,317.1522500417286,0.0,0.0,1074,21750.0,0.0,2220.0657502921,2220.0657502921,2493667.2675789655,700.0,751800.0,858.5737602981075,1209188.771668384,0.0,119778.30801430807,0.0,0.0,1361.4919899939923,1162451.9459966533,0.0,2248.241899621203,-2220.0657502921,-4566403.051990268,true,true,12.07027583,10311.726049369958,0.0,121.92,1644.2724500334996,1074.0,12.07027583,10311.726049369958,0.0,121.92,0.0,295.15 +1075,24987.21800033383,24287.21800033383,0.12,0.0,5218746.345131738,700.0,752500.0,5833.333333333334,22225057.881743982,5833.333333333334,17006311.536612418,true,1075.0,1075,0.875,0.0,0.0,0.0,0.0,0.0,1075,24287.21800033383,0.0,-4075.823306740551,-4075.823306740551,2489591.444272225,700.0,752500.0,825.6157303219805,1210014.387398706,-6130.217713648287,113648.09030065978,0.0,0.0,1343.8430195883116,1163795.7890162417,-115.06434300255579,2133.1775566186475,-0.0,-4566403.051990268,true,true,11.75734275,10323.483392119957,0.0,121.92,1644.2724500334996,1075.0,11.75734275,10323.483392119957,0.0,121.92,0.0,295.15 +1076,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,753200.0,5833.333333333334,22230891.215077315,5833.333333333334,17012144.86994575,true,1076.0,1076,0.875,0.0,0.0,0.0,0.0,0.0,1076,21750.0,0.0,-13310.430361669883,-13310.430361669883,2476281.013910555,700.0,753200.0,714.8048141930616,1210729.1922128992,-15024.04446088687,98624.04583977291,0.0,0.0,1280.8109831502898,1165076.599999392,-282.0016981263647,1851.1758584922827,-0.0,-4566403.051990268,true,true,10.9526577,10334.436049819957,0.0,121.92,1644.2724500334996,1076.0,10.9526577,10334.436049819957,0.0,121.92,0.0,295.15 +1077,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,753900.0,5833.333333333334,22236724.548410647,5833.333333333334,17017978.20327908,true,1077.0,1077,0.875,0.0,0.0,0.0,0.0,0.0,1077,21750.0,0.0,-13983.464011363565,-13983.464011363565,2462297.549899191,700.0,753900.0,566.095764904093,1211295.2879778033,-15444.66530184629,83179.38053792663,0.0,0.0,1185.0022876291403,1166261.602287021,-289.8967620505099,1561.2790964417727,-0.0,-4566403.051990268,true,true,10.05856319,10344.494613009956,0.0,121.92,1644.2724500334996,1077.0,10.05856319,10344.494613009956,0.0,121.92,0.0,295.15 +1078,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,754600.0,5833.333333333334,22242557.88174398,5833.333333333334,17023811.536612414,true,1078.0,1078,0.875,0.0,0.0,0.0,0.0,0.0,1078,21750.0,0.0,-5791.2838163990045,-5791.2838163990045,2456506.266082792,700.0,754600.0,464.4664631892949,1211759.7544409926,-7229.417767027643,75949.96277089899,0.0,0.0,1109.3638435087248,1167370.9661305298,-135.69635606938056,1425.5827403723922,-0.0,-4566403.051990268,true,true,9.611515937,10354.106128946956,0.0,121.92,1644.2724500334996,1078.0,9.611515937,10354.106128946956,0.0,121.92,0.0,295.15 +1079,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,755300.0,5833.333333333334,22248391.21507731,5833.333333333334,17029644.869945746,true,1079.0,1079,0.875,0.0,0.0,0.0,0.0,0.0,1079,21750.0,0.0,-4874.050312505836,-4874.050312505836,2451632.215770286,700.0,755300.0,406.8577746052386,1212166.6122155979,-6225.514516435229,69724.44825446376,0.0,0.0,1061.4594957481497,1168432.425626278,-116.85306642399509,1308.729673948397,-0.0,-4566403.051990268,true,true,9.20917341,10363.315302356956,0.0,121.92,1644.2724500334996,1079.0,9.20917341,10363.315302356956,0.0,121.92,0.0,295.15 +1080,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,756000.0,5833.333333333334,22254224.548410643,5833.333333333334,17035478.203279078,true,1080.0,1080,0.875,0.0,0.0,0.0,0.0,0.0,1080,21750.0,0.0,-15512.353976716528,-15512.353976716528,2436119.8617935693,700.0,756000.0,313.58714113416886,1212480.199356732,-16489.644710190758,53234.803544273,0.0,0.0,973.214644565724,1169405.6402708436,-309.5110522256618,999.2186217227352,-0.0,-4566403.051990268,true,true,8.046850552,10371.362152908956,0.0,121.92,1644.2724500334996,1080.0,8.046850552,10371.362152908956,0.0,121.92,0.0,295.15 +1081,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,756700.0,5833.333333333334,22260057.881743975,5833.333333333334,17041311.53661241,true,1081.0,1081,0.875,0.0,0.0,0.0,0.0,0.0,1081,21750.0,0.0,-15543.537104922045,-15543.537104922045,2420576.3246886474,700.0,756700.0,195.94678914802216,1212676.14614588,-16266.189975536578,36968.61356873643,0.0,0.0,832.022882617444,1170237.6631534612,-305.31680115093235,693.9018205718028,-0.0,-4566403.051990268,true,true,6.705708793,10378.067861701957,0.0,121.92,1644.2724500334996,1081.0,6.705708793,10378.067861701957,0.0,121.92,0.0,295.15 +1082,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,757400.0,5833.333333333334,22265891.215077307,5833.333333333334,17047144.869945742,true,1082.0,1082,0.875,0.0,0.0,0.0,0.0,0.0,1082,21750.0,0.0,-11538.991188785352,-11538.991188785352,2409037.333499862,700.0,757400.0,110.93900665658364,1212787.0851525366,-12110.917798427517,24857.695770308914,0.0,0.0,688.3098392793212,1170925.9729927406,-227.32223629373965,466.5795842780631,-0.0,-4566403.051990268,true,true,5.498681211,10383.566542912957,0.0,121.92,1644.2724500334996,1082.0,5.498681211,10383.566542912957,0.0,121.92,0.0,295.15 +1083,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,758100.0,5833.333333333334,22271724.54841064,5833.333333333334,17052978.203279074,true,1083.0,1083,0.875,0.0,0.0,0.0,0.0,0.0,1083,21750.0,0.0,-4040.439598811062,-4040.439598811062,2404996.893901051,700.0,758100.0,69.86246483902484,1212856.9476173758,-4613.682978600243,20244.012791708672,0.0,0.0,589.979862255532,1171515.952854996,-86.59894730537631,379.9806369726868,-0.0,-4566403.051990268,true,true,4.962224507,10388.528767419957,0.0,121.92,1644.2724500334996,1083.0,4.962224507,10388.528767419957,0.0,121.92,0.0,295.15 +1084,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,758800.0,5833.333333333334,22277557.88174397,5833.333333333334,17058811.536612406,true,1084.0,1084,0.875,0.0,0.0,0.0,0.0,0.0,1084,21750.0,0.0,-1213.336669800846,-1213.336669800846,2403783.55723125,700.0,758800.0,55.715435990423586,1212912.6630533661,-1782.7086954488248,18461.304096259846,0.0,0.0,547.1180773874396,1172063.0709323834,-33.4614877298845,346.5191492428023,-0.0,-4566403.051990268,true,true,4.738700881,10393.267468300957,0.0,121.92,1644.2724500334996,1084.0,4.738700881,10393.267468300957,0.0,121.92,0.0,295.15 +1085,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,759500.0,5833.333333333334,22283391.215077303,5833.333333333334,17064644.86994574,true,1085.0,1085,0.875,0.0,0.0,0.0,0.0,0.0,1085,21750.0,0.0,-1501.8787092038656,-1501.8787092038656,2402281.678522046,700.0,759500.0,47.66482391161534,1212960.3278772777,-2030.8091743712848,16430.49492188856,0.0,0.0,519.3839813095913,1172582.454913693,-38.11834005378715,308.40080918901515,-0.0,-4566403.051990268,true,true,4.470472529,10397.737940829957,0.0,121.92,1644.2724500334996,1085.0,4.470472529,10397.737940829957,0.0,121.92,0.0,295.15 +1086,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,760200.0,5833.333333333334,22289224.548410635,5833.333333333334,17070478.20327907,true,1086.0,1086,0.875,0.0,0.0,0.0,0.0,0.0,1086,21750.0,0.0,-1099.9627853746183,-1099.9627853746183,2401181.7157366714,700.0,760200.0,40.42966714293786,1213000.7575444207,-1601.9732587248811,14828.521663163678,0.0,0.0,491.6498851753443,1173074.1047988683,-30.069078968019408,278.3317302209957,-0.0,-4566403.051990268,true,true,4.246948902,10401.984889731957,0.0,121.92,1644.2724500334996,1086.0,4.246948902,10401.984889731957,0.0,121.92,0.0,295.15 +1087,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,760900.0,5833.333333333334,22295057.881743968,5833.333333333334,17076311.536612403,true,1087.0,1087,0.875,0.0,0.0,0.0,0.0,0.0,1087,21750.0,0.0,-741.3293836964052,-741.3293836964052,2400440.386352975,700.0,760900.0,35.0861054506984,1213035.8436498714,-1222.4288209565434,13606.092842207134,0.0,0.0,468.9583519899782,1173543.0631508583,-22.945020180538386,255.38671004045733,-0.0,-4566403.051990268,true,true,4.068130001,10406.053019732957,0.0,121.92,1644.2724500334996,1087.0,4.068130001,10406.053019732957,0.0,121.92,0.0,295.15 +1088,22450.0,21750.0,0.12,0.0,5218746.345131738,700.0,761600.0,5833.333333333334,22300891.2150773,5833.333333333334,17082144.869945735,true,1088.0,1088,0.875,0.0,0.0,0.0,0.0,0.0,1088,21750.0,0.0,-712.2704802547668,-712.2704802547668,2399728.1158727203,700.0,761600.0,30.750794331472743,1213066.594444203,-1169.8512373005917,12436.241604906541,0.0,0.0,448.7881003072519,1173991.8512511656,-21.95813759289969,233.42857244755766,-0.0,-4566403.051990268,true,true,3.8893111,10409.942330832957,0.0,121.92,1644.2724500334996,1088.0,3.8893111,10409.942330832957,0.0,121.92,0.0,295.15 +1089,22450.0,21750.0,0.124,199.80610679073285,5218946.151238529,700.0,762300.0,7256.500861215588,22308147.715938516,7056.694754424855,17089201.56470016,true,1089.0,1089,0.875,174.83034344189124,199.80610679073285,24.97576334884161,0.0,0.0,1089,21750.0,0.0,174.83034344189124,174.83034344189124,2399902.9462161623,700.0,762300.0,28.23154468499448,1213094.825988888,-284.2475602985086,12151.994044608033,0.0,0.0,436.1816930196476,1174428.0329441852,-5.335333964242216,228.09323848331545,-174.83034344189124,-4566577.88233371,true,true,3.844606375,10413.786937207957,0.0,121.92,1644.2724500334996,1089.0,3.844606375,10413.786937207957,0.0,121.92,0.0,295.15 +1090,22649.806106790733,21949.806106790733,0.15600000000000003,1199.931984501665,5220146.083223031,700.0,763000.0,12179.051182702979,22320326.76712122,10979.119198201313,17100180.683898363,true,1090.0,1090,0.875,1049.940486438957,1199.931984501665,149.99149806270816,0.0,0.0,1090,21949.806106790733,0.0,1049.940486438957,1049.940486438957,2400952.8867026013,700.0,763000.0,28.723944344784705,1213123.5499332328,571.7812195387614,12723.775264146794,0.0,0.0,438.7029744658887,1174866.735918651,10.732348089522032,238.82558657283747,-1049.940486438957,-4567627.822820148,true,true,3.934015825,10417.720953032956,0.0,121.92,1644.2724500334996,1090.0,3.934015825,10417.720953032956,0.0,121.92,0.0,295.15 +1091,23649.931984501665,22949.931984501665,0.15600000000000003,1229.0783833347662,5221375.161606366,700.0,763700.0,12365.887072658756,22332692.65419388,11136.808689323989,17111317.492587686,true,1091.0,1091,0.875,1075.4435854179203,1229.0783833347662,153.63479791684586,0.0,0.0,1091,22949.931984501665,0.0,1075.4435854179203,1075.4435854179203,2402028.330288019,700.0,763700.0,30.750794331472743,1213154.3007275644,584.9256219213482,13308.700886068142,0.0,0.0,448.7881003072519,1175315.5240189584,10.979068857847556,249.80465543068502,-1075.4435854179203,-4568703.266405567,true,true,4.023425276,10421.744378308957,0.0,121.92,1644.2724500334996,1091.0,4.023425276,10421.744378308957,0.0,121.92,0.0,295.15 +1092,23679.078383334767,22979.078383334767,0.12,0.0,5221375.161606366,700.0,764400.0,5833.333333333334,22338525.98752721,5833.333333333334,17117150.825921018,true,1092.0,1092,0.875,0.0,0.0,0.0,0.0,0.0,1092,22979.078383334767,0.0,-412.33311657663637,-412.33311657663637,2401615.9971714425,700.0,764400.0,30.23542870708126,1213184.5361562714,-872.459281161601,12436.241604906541,0.0,0.0,446.26681886101073,1175761.7908378195,-16.37608298312737,233.42857244755766,-0.0,-4568703.266405567,true,true,3.8893111,10425.633689408956,0.0,121.92,1644.2724500334996,1092.0,3.8893111,10425.633689408956,0.0,121.92,0.0,295.15 +1093,22450.0,21750.0,0.124,199.80610679073285,5221574.967713157,700.0,765100.0,7256.500861215588,22345782.488388427,7056.694754424855,17124207.520675443,true,1093.0,1093,0.875,174.83034344189124,199.80610679073285,24.97576334884161,0.0,0.0,1093,21750.0,0.0,174.83034344189124,174.83034344189124,2401790.8275148845,700.0,765100.0,28.23154468499448,1213212.7677009564,-284.2475602985086,12151.994044608033,0.0,0.0,436.1816930196476,1176197.972530839,-5.335333964242216,228.09323848331545,-174.83034344189124,-4568878.096749009,true,true,3.844606375,10429.478295783956,0.0,121.92,1644.2724500334996,1093.0,3.844606375,10429.478295783956,0.0,121.92,0.0,295.15 +1094,22649.806106790733,21949.806106790733,0.12,0.0,5221574.967713157,700.0,765800.0,5833.333333333334,22351615.82172176,5833.333333333334,17130040.854008775,true,1094.0,1094,0.875,0.0,0.0,0.0,0.0,0.0,1094,21949.806106790733,0.0,-1223.7199069153396,-1223.7199069153396,2400567.107607969,700.0,765800.0,24.941386701435896,1213237.709087658,-1636.4772957755172,10515.516748832515,0.0,0.0,418.53272278316234,1176616.5052536223,-30.716720624420702,197.37651785889474,-0.0,-4568878.096749009,true,true,3.576378023,10433.054673806957,0.0,121.92,1644.2724500334996,1094.0,3.576378023,10433.054673806957,0.0,121.92,0.0,295.15 +1095,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,766500.0,5833.333333333334,22357449.15505509,5833.333333333334,17135874.187342107,true,1095.0,1095,0.875,0.0,0.0,0.0,0.0,0.0,1095,21750.0,0.0,-2114.2399253167687,-2114.2399253167687,2398452.867682652,700.0,766500.0,18.40221535800934,1213256.111303016,-2464.5742386508387,8050.942510181676,0.0,0.0,378.1922193613111,1176994.6974729835,-46.260121385250685,151.11639647364404,-0.0,-4568878.096749009,true,true,3.12933077,10436.184004576957,0.0,121.92,1644.2724500334996,1095.0,3.12933077,10436.184004576957,0.0,121.92,0.0,295.15 +1096,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,767200.0,5833.333333333334,22363282.488388423,5833.333333333334,17141707.52067544,true,1096.0,1096,0.875,0.0,0.0,0.0,0.0,0.0,1096,21750.0,0.0,-3705.3592660305153,-3705.3592660305153,2394747.5084166215,700.0,767200.0,9.421934261193188,1213265.5332372773,-3943.3187815473157,4107.62372863436,0.0,0.0,302.55377546648947,1177297.25124845,-74.01619421088212,77.10020226276193,-0.0,-4568878.096749009,true,true,2.235236264,10438.419240840956,0.0,121.92,1644.2724500334996,1096.0,2.235236264,10438.419240840956,0.0,121.92,0.0,295.15 +1097,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,767900.0,5833.333333333334,22369115.821721755,5833.333333333334,17147540.85400877,true,1097.0,1097,0.875,0.0,0.0,0.0,0.0,0.0,1097,21750.0,0.0,-995.7790272344416,-995.7790272344416,2393751.729389387,700.0,767900.0,4.245802746309739,1213269.7790400237,-1209.284424969051,2898.339303665309,0.0,0.0,231.95789452054868,1177529.2091429706,-22.69829953224901,54.401902730512916,-0.0,-4568878.096749009,true,true,1.877598462,10440.296839302957,0.0,121.92,1644.2724500334996,1097.0,1.877598462,10440.296839302957,0.0,121.92,0.0,295.15 +1098,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,768600.0,5833.333333333334,22374949.155055087,5833.333333333334,17153374.187342104,true,1098.0,1098,0.875,0.0,0.0,0.0,0.0,0.0,1098,21750.0,0.0,-1648.0302715308517,-1648.0302715308517,2392103.699117856,700.0,768600.0,1.7144430762497151,1213271.4934830999,-1787.6378460666385,1110.7014575986707,0.0,0.0,171.44713947236963,1177700.656282443,-33.554008012832455,20.84789471768046,-0.0,-4568878.096749009,true,true,1.162322858,10441.459162160956,0.0,121.92,1644.2724500334996,1098.0,1.162322858,10441.459162160956,0.0,121.92,0.0,295.15 +1099,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,769300.0,5833.333333333334,22380782.48838842,5833.333333333334,17159207.520675436,true,1099.0,1099,0.875,0.0,0.0,0.0,0.0,0.0,1099,21750.0,0.0,-873.1398700203347,-873.1398700203347,2391230.5592478355,700.0,769300.0,0.25439222543158274,1213271.7478753254,-946.396508306423,164.30494929224767,0.0,0.0,90.76613268506568,1177791.4224151282,-17.763886624408947,3.084008093271514,-0.0,-4568878.096749009,true,true,0.447047253,10441.906209413955,0.0,121.92,1644.2724500334996,1099.0,0.447047253,10441.906209413955,0.0,121.92,0.0,295.15 +1100,22450.0,21750.0,0.12,0.0,5221574.967713157,700.0,770000.0,5833.333333333334,22386615.82172175,5833.333333333334,17165040.854008768,true,1100.0,1100,0.875,0.0,0.0,0.0,0.0,0.0,1100,21750.0,0.0,-142.17069024579726,-142.17069024579726,2391088.3885575896,700.0,770000.0,0.005452508259103674,1213271.7533278337,-164.30494929239373,-1.460591647628462e-10,0.0,0.0,25.212814631607213,1177816.6352297598,-3.084008093269858,1.6560086635308835e-12,-0.0,-4568878.096749009,true,true,0.0,10441.906209413955,0.0,121.92,1644.2724500334996,1100.0,0.0,10441.906209413955,0.0,121.92,0.0,295.15 +1101,22450.0,21750.0,0.12,4.7944873715885725,5221579.762200529,700.0,770700.0,5873.287394763239,22392489.109116513,5868.49290739165,17170909.346916158,true,1101.0,1101,0.875,4.195176450140001,4.7944873715885725,0.5993109214485717,0.0,0.0,1101,21750.0,0.0,4.195176450140001,4.195176450140001,2391092.5837340397,700.0,770700.0,5.452508149333234e-6,1213271.7533332861,1.643049470871913,1.6430494707258538,0.0,0.0,2.521281446241158,1177819.1565112062,0.030840080518781524,0.030840080520437532,-4.195176450140001,-4568882.291925459,true,true,0.044704725,10441.950914138955,0.0,121.92,1644.2724500334996,1101.0,0.044704725,10441.950914138955,0.0,121.92,0.0,295.15 +1102,22454.79448737159,21754.79448737159,0.124,87.127972164718,5221666.890172694,700.0,771400.0,6347.806227134823,22398836.91534365,6260.678254970105,17177170.025171127,true,1102.0,1102,0.875,76.23697564412825,87.127972164718,10.890996520589752,0.0,0.0,1102,21754.79448737159,0.0,76.23697564412825,76.23697564412825,2391168.820709684,700.0,771400.0,0.0018702103310796435,1213271.7552034964,57.50673236259794,59.14978183332379,0.0,0.0,17.648970236485194,1177836.8054814427,1.0794028347140356,1.1102429152344733,-76.23697564412825,-4568958.528901103,true,true,0.268228352,10442.219142490956,0.0,121.92,1644.2724500334996,1102.0,0.268228352,10442.219142490956,0.0,121.92,0.0,295.15 +1103,22537.12797216472,21837.12797216472,0.136,484.322236478105,5222151.212409172,700.0,772100.0,8708.251738809595,22407545.16708246,8223.92950233149,17185393.954673458,true,1103.0,1103,0.875,423.7819569183419,484.322236478105,60.54027955976312,0.0,0.0,1103,21837.12797216472,0.0,423.7819569183419,423.7819569183419,2391592.6026666025,700.0,772100.0,0.05805830801377445,1213271.8132618044,361.47088859027974,420.62067042360354,0.0,0.0,55.46819221209528,1177892.2736736548,6.784817807953136,7.895060723187609,-423.7819569183419,-4569382.3108580215,true,true,0.715275605,10442.934418095956,0.0,121.92,1644.2724500334996,1103.0,0.715275605,10442.934418095956,0.0,121.92,0.0,295.15 +1104,22934.322236478103,22234.322236478103,0.1744,2140.2496648522915,5224291.462074025,700.0,772800.0,16285.83523424479,22423831.002316702,14145.585569392499,17199539.54024285,true,1104.0,1104,0.875,1872.718456745755,2140.2496648522915,267.5312081065365,0.0,0.0,1104,22234.322236478103,0.0,1872.718456745755,1872.718456745755,2393465.321123348,700.0,772800.0,0.7666662807024109,1213272.5799280852,1708.771470288679,2129.3921407122825,0.0,0.0,131.10663605051838,1178023.3803097054,32.073684125855365,39.96874484904298,-1872.718456745755,-4571255.029314768,true,true,1.60937011,10444.543788205956,0.0,121.92,1644.2724500334996,1104.0,1.60937011,10444.543788205956,0.0,121.92,0.0,295.15 +1105,24590.24966485229,23890.24966485229,0.265,6938.370154705862,5231229.83222873,700.0,773500.0,28824.03831964476,22452655.040636346,21885.668164938896,17221425.20840779,true,1105.0,1105,0.875,6071.073885367629,6938.370154705862,867.2962693382324,0.0,0.0,1105,23890.24966485229,0.0,6071.073885367629,6071.073885367629,2399536.395008716,700.0,773500.0,6.311959867393796,1213278.8918879526,5693.1664915480615,7822.558632260344,0.0,0.0,264.7345535472779,1178288.1148632527,106.86088040489594,146.8296252539389,-6071.073885367629,-4577326.103200135,true,true,3.084626045,10447.628414250956,0.0,121.92,1644.2724500334996,1105.0,3.084626045,10447.628414250956,0.0,121.92,0.0,295.15 +1106,29388.370154705863,28688.370154705863,0.30500000000000005,10539.339721898768,5241769.171950629,700.0,774200.0,36850.29417015989,22489505.334806506,26310.954448261124,17247736.16285605,true,1106.0,1106,0.875,9221.922256661423,10539.339721898768,1317.4174652373458,0.0,0.0,1106,28688.370154705863,0.0,9221.922256661423,9221.922256661423,2408758.3172653774,700.0,774200.0,26.318215919850086,1213305.2101038725,8607.936289628213,16430.494921888556,0.0,0.0,426.09656717828443,1178714.211430431,161.57118393507622,308.40080918901515,-9221.922256661423,-4586548.025456796,true,true,4.470472529,10452.098886779955,0.0,121.92,1644.2724500334996,1106.0,4.470472529,10452.098886779955,0.0,121.92,0.0,295.15 +1107,32989.33972189877,32289.339721898767,0.33,12943.52943332479,5254712.701383954,700.0,774900.0,41344.02858583269,22530849.36339234,28400.499152507902,17276136.662008557,true,1107.0,1107,0.875,11325.588254159191,12943.52943332479,1617.9411791655984,0.0,0.0,1107,32289.339721898767,0.0,11325.588254159191,11325.588254159191,2420083.9055195367,700.0,774900.0,64.62504712415351,1213369.8351509967,10489.227957004678,26919.722878893233,0.0,0.0,574.8521734652879,1179289.0636038964,196.8830765650735,505.28388575408866,-11325.588254159191,-4597873.613710956,true,true,5.722204837,10457.821091616956,0.0,121.92,1644.2724500334996,1107.0,5.722204837,10457.821091616956,0.0,121.92,0.0,295.15 +1108,35393.52943332479,34693.52943332479,0.265,7044.4419655374195,5261757.143349491,700.0,775600.0,29224.30930391479,22560073.67269625,22179.86733837737,17298316.529346935,true,1108.0,1108,0.875,6163.886719845242,7044.4419655374195,880.5552456921778,0.0,0.0,1108,34693.52943332479,0.0,6163.886719845242,6163.886719845242,2426247.792239382,700.0,775600.0,104.95441539502589,1213474.7895663916,5284.047172124855,32203.770051018088,0.0,0.0,675.7034319917168,1179964.767035888,99.18170033364402,604.4655860877326,-6163.886719845242,-4604037.500430801,true,true,6.258661541,10464.079753157956,0.0,121.92,1644.2724500334996,1108.0,6.258661541,10464.079753157956,0.0,121.92,0.0,295.15 +1109,29494.44196553742,28794.44196553742,0.196,3691.518455978318,5265448.66180547,700.0,776300.0,22405.70640805264,22582479.379104305,18714.18795207432,17317030.71729901,true,1109.0,1109,0.875,3230.078648981028,3691.518455978318,461.4398069972899,0.0,0.0,1109,28794.44196553742,0.0,3230.078648981028,3230.078648981028,2429477.870888363,700.0,776300.0,126.22079517922248,1213601.0103615709,2341.3455217198293,34545.115572737915,0.0,0.0,718.5652168598092,1180683.3322527478,43.9471152221668,648.4127013098994,-3230.078648981028,-4607267.579079782,true,true,6.482185167,10470.561938324956,0.0,121.92,1644.2724500334996,1109.0,6.482185167,10470.561938324956,0.0,121.92,0.0,295.15 +1110,26141.518455978316,25441.518455978316,0.30500000000000005,9807.700126640793,5275256.36193211,700.0,777000.0,34451.47582505178,22616930.854929358,24643.775698410984,17341674.492997423,true,1110.0,1110,0.875,8581.737610810695,9807.700126640793,1225.9625158300987,0.0,0.0,1110,25441.518455978316,0.0,8581.737610810695,8581.737610810695,2438059.608499174,700.0,777000.0,154.7019720258185,1213755.7123335968,7516.951422592578,42062.06699533049,0.0,0.0,768.9908460666252,1181452.3230988146,141.09337012567445,789.5060714355739,-8581.737610810695,-4615849.316690592,true,true,7.152756046,10477.714694370956,0.0,121.92,1644.2724500334996,1110.0,7.152756046,10477.714694370956,0.0,121.92,0.0,295.15 +1111,32257.700126640793,31557.700126640793,0.335,14928.779532776158,5290185.141464886,700.0,777700.0,46653.07323216763,22663583.928161524,31724.293699391477,17373398.786696814,true,1111.0,1111,0.875,13062.682091179138,14928.779532776158,1866.0974415970195,0.0,0.0,1111,31557.700126640793,0.0,13062.682091179138,13062.682091179138,2451122.2905903533,700.0,777700.0,216.20188130804675,1213971.914214905,11765.877411749612,53827.944407080104,0.0,0.0,859.7569786952922,1182312.0800775099,220.84581942618684,1010.3518908617607,-13062.682091179138,-4628911.998781771,true,true,8.091555277,10485.806249647956,0.0,121.92,1644.2724500334996,1111.0,8.091555277,10485.806249647956,0.0,121.92,0.0,295.15 +1112,37378.779532776156,36678.779532776156,0.33999999999999997,15290.803593651983,5305475.945058539,700.0,778400.0,47031.77527544701,22710615.70343697,31740.971681795032,17405139.75837861,true,1112.0,1112,0.875,13379.453144445484,15290.803593651983,1911.3504492064985,0.0,0.0,1112,36678.779532776156,0.0,13379.453144445484,13379.453144445484,2464501.743734799,700.0,778400.0,301.55828085491146,1214273.4724957598,11894.035280474556,65721.97968755466,0.0,0.0,960.6082372217212,1183272.6883147317,223.2513458942948,1233.6032367560556,-13379.453144445484,-4642291.4519262165,true,true,8.940945058,10494.747194705957,0.0,121.92,1644.2724500334996,1112.0,8.940945058,10494.747194705957,0.0,121.92,0.0,295.15 +1113,37740.80359365198,37040.80359365198,0.29250000000000004,9454.245682816474,5314930.190741355,700.0,779100.0,34715.36985578281,22745331.073292755,25261.124172966338,17430400.882551577,true,1113.0,1113,0.875,8272.464972464415,9454.245682816474,1181.780710352059,0.0,0.0,1113,37040.80359365198,0.0,8272.464972464415,8272.464972464415,2472774.208707263,700.0,779100.0,375.79232147965234,1214649.2648172395,6736.502919517991,72458.48260707266,0.0,0.0,1033.7253996703016,1184306.413714402,126.44433179646937,1360.047568552525,-8272.464972464415,-4650563.916898681,true,true,9.387992311,10504.135187016956,0.0,121.92,1644.2724500334996,1113.0,9.387992311,10504.135187016956,0.0,121.92,0.0,295.15 +1114,31904.245682816472,31204.245682816472,0.196,3298.8656666378765,5318229.056407993,700.0,779800.0,20402.375850193246,22765733.449142948,17103.51018355537,17447504.39273513,true,1114.0,1114,0.875,2886.507458308142,3298.8656666378765,412.3582083297347,0.0,0.0,1114,31204.245682816472,0.0,2886.507458308142,2886.507458308142,2475660.7161655715,700.0,779800.0,409.7638906038589,1215059.0287078433,1386.733762383714,73845.21636945636,0.0,0.0,1063.980777194391,1185370.3944915964,26.029028126177998,1386.076596678703,-2886.507458308142,-4653450.424356989,true,true,9.477401761,10513.612588777956,0.0,121.92,1644.2724500334996,1114.0,9.477401761,10513.612588777956,0.0,121.92,0.0,295.15 +1115,25748.865666637877,25048.865666637877,0.1816,2516.0147491197868,5320745.071157113,700.0,780500.0,17709.332318941557,22783442.78146189,15193.317569821771,17462697.710304953,true,1115.0,1115,0.875,2201.5129054798135,2516.0147491197868,314.50184363997323,0.0,0.0,1115,25048.865666637877,0.0,2201.5129054798135,2201.5129054798135,2477862.2290710513,700.0,780500.0,418.56520403034614,1215477.5939118736,698.2960452614277,74543.51241471778,0.0,0.0,1071.544621589513,1186441.939113186,13.107034598526546,1399.1836312772296,-2201.5129054798135,-4655651.937262468,true,true,9.522106487,10523.134695264956,0.0,121.92,1644.2724500334996,1115.0,9.522106487,10523.134695264956,0.0,121.92,0.0,295.15 +1116,24966.014749119786,24266.014749119786,0.1816,2532.388844477013,5323277.46000159,700.0,781200.0,17799.4980422743,22801242.279504165,15267.109197797286,17477964.819502752,true,1116.0,1116,0.875,2215.8402389173866,2532.388844477013,316.5486055596266,0.0,0.0,1116,24266.014749119786,0.0,2215.8402389173866,2215.8402389173866,2480078.069309969,700.0,781200.0,424.50221129221734,1215902.096123166,701.5821286197132,75245.0945433375,0.0,0.0,1076.587184538394,1187518.5262977243,13.168714467062118,1412.3523457442916,-2215.8402389173866,-4657867.777501386,true,true,9.566811212,10532.701506476957,0.0,121.92,1644.2724500334996,1116.0,9.566811212,10532.701506476957,0.0,121.92,0.0,295.15 +1117,24982.388844477013,24282.388844477013,0.20800000000000002,4214.349314161086,5327491.80931575,700.0,781900.0,23626.67939500522,22824868.95889917,19412.330080844134,17497377.149583597,true,1117.0,1117,0.875,3687.5556498909505,4214.349314161086,526.7936642701357,0.0,0.0,1117,24282.388844477013,0.0,3687.5556498909505,3687.5556498909505,2483765.62495986,700.0,781900.0,436.54411938377126,1216338.6402425496,2124.4629954606085,77369.55753879811,0.0,0.0,1086.6723103797572,1188605.1986081041,39.87622466681347,1452.228570411105,-3687.5556498909505,-4661555.333151276,true,true,9.700925388,10542.402431864957,0.0,121.92,1644.2724500334996,1117.0,9.700925388,10542.402431864957,0.0,121.92,0.0,295.15 +1118,26664.349314161085,25964.349314161085,0.29250000000000004,8576.124412901596,5336067.933728652,700.0,782600.0,31713.245856073827,22856582.204755243,23137.121443172233,17520514.271026768,true,1118.0,1118,0.875,7504.108861288897,8576.124412901596,1072.0155516126988,0.0,0.0,1118,25964.349314161085,0.0,7504.108861288897,7504.108861288897,2491269.733821149,700.0,782600.0,470.8289296721101,1216809.4691722216,5809.822999128513,83179.38053792663,0.0,0.0,1114.4064064576055,1189719.6050145617,109.0505260306675,1561.2790964417725,-7504.108861288897,-4669059.442012565,true,true,10.05856319,10552.460995054957,0.0,121.92,1644.2724500334996,1118.0,10.05856319,10552.460995054957,0.0,121.92,0.0,295.15 +1119,31026.124412901598,30326.124412901598,0.25,6250.15819208733,5342318.091920739,700.0,783300.0,27800.63276834932,22884382.83752359,21550.47457626199,17542064.74560303,true,1119.0,1119,0.875,5468.8884180764135,6250.15819208733,781.2697740109161,0.0,0.0,1119,30326.124412901598,0.0,5468.8884180764135,5468.8884180764135,2496738.6222392255,700.0,783300.0,513.6065125515006,1217323.075684773,3737.9376546560616,86917.3181925827,0.0,0.0,1147.1830656535303,1190866.7880802152,70.16118521532044,1631.440281657093,-5468.8884180764135,-4674528.330430642,true,true,10.28208682,10562.743081874956,0.0,121.92,1644.2724500334996,1119.0,10.28208682,10562.743081874956,0.0,121.92,0.0,295.15 +1120,28700.15819208733,28000.15819208733,0.29250000000000004,9149.602246985864,5351467.694167725,700.0,784000.0,33673.8538358491,22918056.69135944,24524.251588863233,17566588.99719189,true,1120.0,1120,0.875,8005.90196611263,9149.602246985864,1143.7002808732332,0.0,0.0,1120,28000.15819208733,0.0,8005.90196611263,8005.90196611263,2504744.524205338,700.0,784000.0,558.8997190327635,1217881.9754038057,6151.577260108245,93068.89545269094,0.0,0.0,1179.959724736658,1192046.7478049519,115.46526223496363,1746.9055438920566,-8005.90196611263,-4682534.232396754,true,true,10.63972462,10573.382806494956,0.0,121.92,1644.2724500334996,1120.0,10.63972462,10573.382806494956,0.0,121.92,0.0,295.15 +1121,31599.602246985865,30899.602246985865,0.29250000000000004,8561.80637102245,5360029.500538747,700.0,784700.0,31664.295285546836,22949720.986644987,23102.488914524387,17589691.486106414,true,1121.0,1121,0.875,7491.580574644644,8561.80637102245,1070.2257963778065,0.0,0.0,1121,30899.602246985865,0.0,7491.580574644644,7491.580574644644,2512236.104779983,700.0,784700.0,614.3809262501679,1218496.356330056,5555.1503870819815,98624.04583977292,0.0,0.0,1217.7789467122682,1193264.5267516642,104.2703146002258,1851.1758584922825,-7491.580574644644,-4690025.812971399,true,true,10.9526577,10584.335464194955,0.0,121.92,1644.2724500334996,1121.0,10.9526577,10584.335464194955,0.0,121.92,0.0,295.15 +1122,31011.806371022452,30311.806371022452,0.265,6916.835784951069,5366946.336323698,700.0,785400.0,28742.776546985166,22978463.763191972,21825.940762034097,17611517.42686845,true,1122.0,1122,0.875,6052.231311832185,6916.835784951069,864.604473118884,0.0,0.0,1122,30311.806371022452,0.0,6052.231311832185,6052.231311832185,2518288.336091815,700.0,785400.0,661.3204135987122,1219157.6767436548,4066.547376089585,102690.59321586251,0.0,0.0,1248.0343240671623,1194512.5610757314,76.32919807672575,1927.5050565690083,-6052.231311832185,-4696078.044283232,true,true,11.17618132,10595.511645514955,0.0,121.92,1644.2724500334996,1122.0,11.17618132,10595.511645514955,0.0,121.92,0.0,295.15 +1123,29366.83578495107,28666.83578495107,0.16,1257.5211151714964,5368203.85743887,700.0,786100.0,12234.506969821852,22990698.270161793,10976.985854650356,17622494.4127231,true,1123.0,1123,0.875,1100.3309757750594,1257.5211151714964,157.19013939643696,0.0,0.0,1123,28666.83578495107,0.0,1100.3309757750594,1100.3309757750594,2519388.66706759,700.0,786100.0,677.4823240752954,1219835.15906773,-819.8815995946654,101870.71161626784,0.0,0.0,1258.1194498521265,1195770.6805255834,-15.389198557696954,1912.1158580113113,-1100.3309757750594,-4697178.375259006,true,true,11.1314766,10606.643122114954,0.0,121.92,1644.2724500334996,1123.0,11.1314766,10606.643122114954,0.0,121.92,0.0,295.15 +1124,23707.521115171498,23007.521115171498,0.15600000000000003,1246.3114645953776,5369450.168903465,700.0,786800.0,12476.35554227806,23003174.625704072,11230.044077682682,17633724.456800785,true,1124.0,1124,0.875,1090.5225315209555,1246.3114645953776,155.78893307442218,0.0,0.0,1124,23007.521115171498,0.0,1090.5225315209555,1090.5225315209555,2520479.189599111,700.0,786800.0,669.368850078189,1220504.5279178082,-816.5956836847073,101054.11593258314,0.0,0.0,1253.0768869596443,1197023.757412543,-15.327521832170431,1896.7883361791407,-1090.5225315209555,-4698268.897790527,true,true,11.08677187,10617.729893984953,0.0,121.92,1644.2724500334996,1124.0,11.08677187,10617.729893984953,0.0,121.92,0.0,295.15 +1125,23696.31146459538,22996.31146459538,0.20800000000000002,4109.953842707339,5373560.122746172,700.0,787500.0,23124.77808993913,23026299.403794013,19014.82424723179,17652739.28104802,true,1125.0,1125,0.875,3596.2096123689216,4109.953842707339,513.7442303384178,0.0,0.0,1125,22996.31146459538,0.0,3596.2096123689216,3596.2096123689216,2524075.3992114803,700.0,787500.0,673.4174405757889,1221177.945358384,1636.4772832793726,102690.59321586251,0.0,0.0,1255.5981681238927,1198279.355580667,30.716720389867387,1927.505056569008,-3596.2096123689216,-4701865.107402896,true,true,11.17618132,10628.906075304953,0.0,121.92,1644.2724500334996,1125.0,11.17618132,10628.906075304953,0.0,121.92,0.0,295.15 +1126,26559.95384270734,25859.95384270734,0.25,6106.673689892849,5379666.796436065,700.0,788200.0,27226.694759571397,23053526.098553583,21120.021069678547,17673859.302117698,true,1126.0,1126,0.875,5343.339478656243,6106.673689892849,763.3342112366063,0.0,0.0,1126,25859.95384270734,0.0,5343.339478656243,5343.339478656243,2529418.7386901365,700.0,788200.0,698.0522652830352,1221875.997623667,3312.3877538596817,106002.9809697222,0.0,0.0,1270.7258568013397,1199550.0814374683,62.173602712186515,1989.6786592811945,-5343.339478656243,-4707208.446881552,true,true,11.35500022,10640.261075524953,0.0,121.92,1644.2724500334996,1126.0,11.35500022,10640.261075524953,0.0,121.92,0.0,295.15 +1127,28556.67368989285,27856.67368989285,0.25,6229.5373711100065,5385896.333807175,700.0,788900.0,27718.149484440026,23081244.248038024,21488.61211333002,17695347.91423103,true,1127.0,1127,0.875,5450.845199721256,6229.5373711100065,778.6921713887505,0.0,0.0,1127,27856.67368989285,0.0,5450.845199721256,5450.845199721256,2534869.583889858,700.0,788900.0,731.823269133634,1222607.8208928006,3364.965336927565,109367.94630664976,0.0,0.0,1290.896108371269,1200840.9775458395,63.16048528878698,2052.8391445699817,-5450.845199721256,-4712659.292081273,true,true,11.53381912,10651.794894644954,0.0,121.92,1644.2724500334996,1127.0,11.53381912,10651.794894644954,0.0,121.92,0.0,295.15 +1128,28679.537371110007,27979.537371110007,0.20800000000000002,4340.603073645875,5390236.936880821,700.0,789600.0,24233.668623297475,23105477.916661322,19893.0655496516,17715240.97978068,true,1128.0,1128,0.875,3798.0276894401404,4340.603073645875,542.5753842057347,0.0,0.0,1128,27979.537371110007,0.0,3798.0276894401404,3798.0276894401404,2538667.611579298,700.0,789600.0,757.8541113977777,1223365.6750041984,1702.1994532317615,111070.14575988152,0.0,0.0,1306.0237976127014,1202147.0013434521,31.950327197900013,2084.789471767882,-3798.0276894401404,-4716457.319770713,true,true,11.62322858,10663.418123224954,0.0,121.92,1644.2724500334996,1128.0,11.62322858,10663.418123224954,0.0,121.92,0.0,295.15 +1129,26790.603073645874,26090.603073645874,0.25,6416.136039401033,5396653.072920223,700.0,790300.0,28464.54415760413,23133942.460818928,22048.408118203097,17737289.387898885,true,1129.0,1129,0.875,5614.119034475903,6416.136039401033,802.0170049251292,0.0,0.0,1129,26090.603073645874,0.0,5614.119034475903,5614.119034475903,2544281.730613774,700.0,790300.0,784.4950239431748,1224150.1700281417,3443.8317144697166,114513.97747435124,0.0,0.0,1321.151486854134,1203468.1528303062,64.64080920887787,2149.4302809767596,-5614.119034475903,-4722071.438805189,true,true,11.80204748,10675.220170704953,0.0,121.92,1644.2724500334996,1129.0,11.80204748,10675.220170704953,0.0,121.92,0.0,295.15 +1130,28866.136039401033,28166.136039401033,0.20800000000000002,4482.691639063894,5401135.764559287,700.0,791000.0,24916.78672626872,23158859.247545198,20434.095087204827,17757723.48298609,true,1130.0,1130,0.875,3922.3551841809076,4482.691639063894,560.3364548829868,0.0,0.0,1130,28166.136039401033,0.0,3922.3551841809076,3922.3551841809076,2548204.0857979553,700.0,791000.0,811.7530721933598,1224961.923100335,1741.6324508853031,116255.60992523654,0.0,0.0,1336.279175531581,1204804.4320058378,32.690485570663874,2182.1207665474235,-3922.3551841809076,-4725993.79398937,true,true,11.89145693,10687.111627634953,0.0,121.92,1644.2724500334996,1130.0,11.89145693,10687.111627634953,0.0,121.92,0.0,295.15 +1131,26932.691639063894,26232.691639063894,0.23500000000000001,5566.197558336512,5406701.962117624,700.0,791700.0,26664.670461006433,23185523.918006204,21098.47290266992,17778821.95588876,true,1131.0,1131,0.875,4870.422863544448,5566.197558336512,695.7746947920641,0.0,0.0,1131,26232.691639063894,0.0,4870.422863544448,4870.422863544448,2553074.5086614997,700.0,791700.0,834.9446338311274,1225796.867734166,2637.0943195244763,118892.70424476101,0.0,0.0,1348.885582480794,1206153.3175883186,49.498327708049914,2231.6190942554736,-4870.422863544448,-4730864.216852915,true,true,12.0255711,10699.137198734954,0.0,121.92,1644.2724500334996,1131.0,12.0255711,10699.137198734954,0.0,121.92,0.0,295.15 +1132,28016.197558336513,27316.197558336513,0.196,3560.0114472727305,5410261.973564897,700.0,792400.0,21734.75228200373,23207258.67028821,18174.740834731,17796996.69672349,true,1132.0,1132,0.875,3115.0100163636394,3560.0114472727305,445.00143090909114,0.0,0.0,1132,27316.197558336513,0.0,3115.0100163636394,3115.0100163636394,2556189.5186778633,700.0,792400.0,853.812733185085,1226650.680467351,885.6037695470659,119778.30801430807,0.0,0.0,1358.9707082657585,1207512.2882965843,16.62280536572958,2248.241899621203,-3115.0100163636394,-4733979.226869279,true,true,12.07027583,10711.207474564953,0.0,121.92,1644.2724500334996,1132.0,12.07027583,10711.207474564953,0.0,121.92,0.0,295.15 +1133,26010.01144727273,25310.01144727273,0.1816,2537.2180003338285,5412799.1915652305,700.0,793100.0,17826.090310208307,23225084.760598417,15288.872309874478,17812285.569033366,true,1133.0,1133,0.875,2220.0657502921,2537.2180003338285,317.1522500417286,0.0,0.0,1133,25310.01144727273,0.0,2220.0657502921,2220.0657502921,2558409.5844281553,700.0,793100.0,858.5737602981075,1227509.2542276492,0.0,119778.30801430807,0.0,0.0,1361.4919899939923,1208873.7802865782,0.0,2248.241899621203,-2220.0657502921,-4736199.292619571,true,true,12.07027583,10723.277750394953,0.0,121.92,1644.2724500334996,1133.0,12.07027583,10723.277750394953,0.0,121.92,0.0,295.15 +1134,24987.21800033383,24287.21800033383,0.1816,2537.2180003338285,5415336.409565564,700.0,793800.0,17826.090310208307,23242910.850908626,15288.872309874478,17827574.44134324,true,1134.0,1134,0.875,2220.0657502921,2537.2180003338285,317.1522500417286,0.0,0.0,1134,24287.21800033383,0.0,2220.0657502921,2220.0657502921,2560629.6501784474,700.0,793800.0,858.5737602981075,1228367.8279879473,0.0,119778.30801430807,0.0,0.0,1361.4919899939923,1210235.2722765722,0.0,2248.241899621203,-2220.0657502921,-4738419.358369864,true,true,12.07027583,10735.348026224952,0.0,121.92,1644.2724500334996,1134.0,12.07027583,10735.348026224952,0.0,121.92,0.0,295.15 +1135,24987.21800033383,24287.21800033383,0.16240000000000002,1497.7792760434834,5416834.188841607,700.0,794500.0,13533.123620957407,23256443.974529583,12035.344344913923,17839609.785688154,true,1135.0,1135,0.875,1310.5568665380479,1497.7792760434834,187.2224095054355,0.0,0.0,1135,24287.21800033383,0.0,1310.5568665380479,1310.5568665380479,2561940.2070449856,700.0,794500.0,853.812733185085,1229221.6407211323,-885.6037695470659,118892.704244761,0.0,0.0,1358.9707082657585,1211594.2429848379,-16.62280536572958,2231.6190942554736,-1310.5568665380479,-4739729.915236401,true,true,12.0255711,10747.373597324953,0.0,121.92,1644.2724500334996,1135.0,12.0255711,10747.373597324953,0.0,121.92,0.0,295.15 +1136,23947.779276043482,23247.779276043482,0.16240000000000002,1485.0206840608037,5418319.209525668,700.0,795200.0,13454.56086244337,23269898.535392027,11969.540178382566,17851579.325866535,true,1136.0,1136,0.875,1299.3930985532031,1485.0206840608037,185.62758550760054,0.0,0.0,1136,23247.779276043482,0.0,1299.3930985532031,1299.3930985532031,2563239.600143539,700.0,795200.0,844.343547545365,1230065.9842686777,-882.3174728722024,118010.38677188879,0.0,0.0,1353.9281453732763,1212948.171130211,-16.56112149323583,2215.0579727622376,-1299.3930985532031,-4741029.308334955,true,true,11.98086638,10759.354463704953,0.0,121.92,1644.2724500334996,1136.0,11.98086638,10759.354463704953,0.0,121.92,0.0,295.15 +1137,23935.020684060804,23235.020684060804,0.1816,2504.0482146168265,5420823.257740285,700.0,795900.0,17643.437305158735,23287541.972697187,15139.389090541908,17866718.714957077,true,1137.0,1137,0.875,2191.0421877897234,2504.0482146168265,313.00602682710314,0.0,0.0,1137,23235.020684060804,0.0,2191.0421877897234,2191.0421877897234,2565430.6423313287,700.0,795900.0,839.6353235806953,1230905.6195922582,0.0,118010.38677188879,0.0,0.0,1351.4068642090278,1214299.5779944202,0.0,2215.0579727622376,-2191.0421877897234,-4743220.3505227445,true,true,11.98086638,10771.335330084952,0.0,121.92,1644.2724500334996,1137.0,11.98086638,10771.335330084952,0.0,121.92,0.0,295.15 +1138,24954.048214616825,24254.048214616825,0.12,0.0,5420823.257740285,700.0,796600.0,5833.333333333334,23293375.30603052,5833.333333333334,17872552.04829041,true,1138.0,1138,0.875,0.0,0.0,0.0,0.0,0.0,1138,24254.048214616825,0.0,-507.0907599607714,-507.0907599607714,2564923.551571368,700.0,796600.0,825.6157303219805,1231731.2353225802,-2627.2362189622645,115383.15055292653,0.0,0.0,1343.8430195883116,1215643.4210140086,-49.31329090879901,2165.7446818534386,-0.0,-4743220.3505227445,true,true,11.8467522,10783.182082284951,0.0,121.92,1644.2724500334996,1138.0,11.8467522,10783.182082284951,0.0,121.92,0.0,295.15 +1139,22450.0,21750.0,0.16240000000000002,1434.7855101585733,5422258.043250443,700.0,797300.0,13145.230973882839,23306520.537004404,11710.445463724265,17884262.493754134,true,1139.0,1139,0.875,1255.4373213887516,1434.7855101585733,179.34818876982172,0.0,0.0,1139,21750.0,0.0,1255.4373213887516,1255.4373213887516,2566178.9888927564,700.0,797300.0,807.1669070373962,1232538.4022296176,-869.1730785753125,114513.97747435121,0.0,0.0,1333.7578938033469,1216977.1789078119,-16.314400876678945,2149.4302809767596,-1255.4373213887516,-4744475.787844134,true,true,11.80204748,10794.984129764951,0.0,121.92,1644.2724500334996,1139.0,11.80204748,10794.984129764951,0.0,121.92,0.0,295.15 +1140,23884.785510158574,23184.785510158574,0.12,0.0,5422258.043250443,700.0,798000.0,5833.333333333334,23312353.870337736,5833.333333333334,17890095.827087466,true,1140.0,1140,0.875,0.0,0.0,0.0,0.0,0.0,1140,23184.785510158574,0.0,-1402.826012881286,-1402.826012881286,2564776.162879875,700.0,798000.0,784.4950239431748,1233322.8972535608,-3443.8317144697166,111070.14575988149,0.0,0.0,1321.151486854134,1218298.330394666,-64.64080920887787,2084.789471767882,-0.0,-4744475.787844134,true,true,11.62322858,10806.60735834495,0.0,121.92,1644.2724500334996,1140.0,11.62322858,10806.60735834495,0.0,121.92,0.0,295.15 +1141,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,798700.0,5833.333333333334,23318187.203671068,5833.333333333334,17895929.160420798,true,1141.0,1141,0.875,0.0,0.0,0.0,0.0,0.0,1141,21750.0,0.0,-2267.0428926056675,-2267.0428926056675,2562509.1199872694,700.0,798700.0,744.7628741042208,1234067.6601276651,-4230.85251061896,106839.29324926253,0.0,0.0,1298.4599535559707,1219596.790348222,-79.4132096468994,2005.3762621209826,-0.0,-4744475.787844134,true,true,11.39970495,10818.00706329495,0.0,121.92,1644.2724500334996,1141.0,11.39970495,10818.00706329495,0.0,121.92,0.0,295.15 +1142,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,799400.0,5833.333333333334,23324020.5370044,5833.333333333334,17901762.49375413,true,1142.0,1142,0.875,0.0,0.0,0.0,0.0,0.0,1142,21750.0,0.0,-5598.745019824338,-5598.745019824338,2556910.374967445,700.0,799400.0,685.6610973104235,1234753.3212249756,-7408.510204191812,99430.78304507071,0.0,0.0,1263.1620127446092,1220859.9523609667,-139.05792568755868,1866.3183364334238,-0.0,-4744475.787844134,true,true,10.99736242,10829.00442571495,0.0,121.92,1644.2724500334996,1142.0,10.99736242,10829.00442571495,0.0,121.92,0.0,295.15 +1143,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,800100.0,5833.333333333334,23329853.870337732,5833.333333333334,17907595.827087462,true,1143.0,1143,0.875,0.0,0.0,0.0,0.0,0.0,1143,21750.0,0.0,-7037.032955429962,-7037.032955429962,2549873.342012015,700.0,800100.0,606.7804233765929,1235360.1016483523,-8693.374893353921,90737.4081517168,0.0,0.0,1212.7363832558005,1222072.6887442225,-163.17486870843518,1703.1434677249886,-0.0,-4744475.787844134,true,true,10.50561044,10839.510036154948,0.0,121.92,1644.2724500334996,1143.0,10.50561044,10839.510036154948,0.0,121.92,0.0,295.15 +1144,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,800800.0,5833.333333333334,23335687.203671064,5833.333333333334,17913429.160420794,true,1144.0,1144,0.875,0.0,0.0,0.0,0.0,0.0,1144,21750.0,0.0,-13433.569635681231,-13433.569635681231,2536439.772376334,700.0,800800.0,496.85981451806185,1235856.9614628705,-14787.445380817833,75949.96277089896,0.0,0.0,1134.5766579711362,1223207.2654021936,-277.5607273525964,1425.5827403723922,-0.0,-4744475.787844134,true,true,9.611515937,10849.121552091949,0.0,121.92,1644.2724500334996,1144.0,9.611515937,10849.121552091949,0.0,121.92,0.0,295.15 +1145,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,801500.0,5833.333333333334,23341520.537004396,5833.333333333334,17919262.493754126,true,1145.0,1145,0.875,0.0,0.0,0.0,0.0,0.0,1145,21750.0,0.0,-8983.92161279282,-8983.92161279282,2527455.850763541,700.0,801500.0,389.70916720993597,1236246.6706300804,-10227.983083344325,65721.97968755463,0.0,0.0,1046.3318069579059,1224253.5972091516,-191.97950361633644,1233.6032367560558,-0.0,-4744475.787844134,true,true,8.940945058,10858.06249714995,0.0,121.92,1644.2724500334996,1145.0,8.940945058,10858.06249714995,0.0,121.92,0.0,295.15 +1146,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,802200.0,5833.333333333334,23347353.87033773,5833.333333333334,17925095.82708746,true,1146.0,1146,0.875,0.0,0.0,0.0,0.0,0.0,1146,21750.0,0.0,-14459.699581075129,-14459.699581075129,2512996.151182466,700.0,802200.0,287.5346150460783,1236534.2052451265,-15403.588986054745,50318.390701499884,0.0,0.0,945.4805484878756,1225199.0777576396,-289.12575855433755,944.4774782017182,-0.0,-4744475.787844134,true,true,7.823326926,10865.88582407595,0.0,121.92,1644.2724500334996,1146.0,7.823326926,10865.88582407595,0.0,121.92,0.0,295.15 +1147,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,802900.0,5833.333333333334,23353187.20367106,5833.333333333334,17930929.16042079,true,1147.0,1147,0.875,0.0,0.0,0.0,0.0,0.0,1147,21750.0,0.0,-7361.676730426242,-7361.676730426242,2505634.47445204,700.0,802900.0,204.98909254787833,1236739.1943376744,-8256.323706169424,42062.06699533046,0.0,0.0,844.6292899614467,1226043.707047601,-154.9714067661441,789.5060714355741,-0.0,-4744475.787844134,true,true,7.152756046,10873.038580121949,0.0,121.92,1644.2724500334996,1147.0,7.152756046,10873.038580121949,0.0,121.92,0.0,295.15 +1148,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,803600.0,5833.333333333334,23359020.537004393,5833.333333333334,17936762.493754122,true,1148.0,1148,0.875,0.0,0.0,0.0,0.0,0.0,1148,21750.0,0.0,-9139.73526798422,-9139.73526798422,2496494.739184056,700.0,803600.0,147.21772289700587,1236886.4120605714,-9858.296944312408,32203.77005101805,0.0,0.0,756.3844387790208,1226800.09148638,-185.04048534784127,604.4655860877328,-0.0,-4744475.787844134,true,true,6.258661541,10879.29724166295,0.0,121.92,1644.2724500334996,1148.0,6.258661541,10879.29724166295,0.0,121.92,0.0,295.15 +1149,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,804300.0,5833.333333333334,23364853.870337725,5833.333333333334,17942595.827087454,true,1149.0,1149,0.875,0.0,0.0,0.0,0.0,0.0,1149,21750.0,0.0,-12938.952330734322,-12938.952330734322,2483555.786853322,700.0,804300.0,82.16506281889619,1236968.5771233903,-13392.496415183821,18811.27363583423,0.0,0.0,622.7565212822612,1227422.8480076622,-251.37749965165852,353.0880864360743,-0.0,-4744475.787844134,true,true,4.783405606,10884.08064726895,0.0,121.92,1644.2724500334996,1149.0,4.783405606,10884.08064726895,0.0,121.92,0.0,295.15 +1150,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,805000.0,5833.333333333334,23370687.203671057,5833.333333333334,17948429.160420787,true,1150.0,1150,0.875,0.0,0.0,0.0,0.0,0.0,1150,21750.0,0.0,-9509.45851602982,-9509.45851602982,2474046.328337292,700.0,805000.0,32.331961749274896,1237000.9090851396,-9813.934619110332,8997.339016723898,0.0,0.0,456.3519447023739,1227879.1999523647,-184.20780337113453,168.8802830649398,-0.0,-4744475.787844134,true,true,3.308149671,10887.38879693995,0.0,121.92,1644.2724500334996,1150.0,3.308149671,10887.38879693995,0.0,121.92,0.0,295.15 +1151,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,805700.0,5833.333333333334,23376520.53700439,5833.333333333334,17954262.49375412,true,1151.0,1151,0.875,0.0,0.0,0.0,0.0,0.0,1151,21750.0,0.0,-6054.170975386927,-6054.170975386927,2467992.157361905,700.0,805700.0,8.29258349130573,1237009.201668631,-6235.372820023076,2761.9661967008215,0.0,0.0,289.94736817888514,1228169.1473205436,-117.03810703404224,51.84217603089755,-0.0,-4744475.787844134,true,true,1.832893737,10889.22169067695,0.0,121.92,1644.2724500334996,1151.0,1.832893737,10889.22169067695,0.0,121.92,0.0,295.15 +1152,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,806400.0,5833.333333333334,23382353.87033772,5833.333333333334,17960095.82708745,true,1152.0,1152,0.875,0.0,0.0,0.0,0.0,0.0,1152,21750.0,0.0,-2582.495166445757,-2582.495166445757,2465409.6621954595,700.0,806400.0,0.6414821435603179,1237009.8431507747,-2656.8110293890954,105.15516731172602,0.0,0.0,123.54279165539637,1228292.690112199,-49.868410855618116,1.973765175279432,-0.0,-4744475.787844134,true,true,0.357637802,10889.57932847895,0.0,121.92,1644.2724500334996,1152.0,0.357637802,10889.57932847895,0.0,121.92,0.0,295.15 +1153,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,807100.0,5833.333333333334,23388187.203671053,5833.333333333334,17965929.160420783,true,1153.0,1153,0.875,0.0,0.0,0.0,0.0,0.0,1153,21750.0,0.0,-86.95588912024235,-86.95588912024235,2465322.7063063392,700.0,807100.0,0.002791684219294004,1237009.8459424588,-105.1551673119104,-1.84385839929746e-10,0.0,0.0,20.170251682726352,1228312.8603638816,-1.9737651752775933,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1153.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1154,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,807800.0,5833.333333333334,23394020.537004385,5833.333333333334,17971762.493754115,true,1154.0,1154,0.875,0.0,0.0,0.0,0.0,0.0,1154,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,807800.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1154.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1155,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,808500.0,5833.333333333334,23399853.870337717,5833.333333333334,17977595.827087447,true,1155.0,1155,0.875,0.0,0.0,0.0,0.0,0.0,1155,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,808500.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1155.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1156,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,809200.0,5833.333333333334,23405687.20367105,5833.333333333334,17983429.16042078,true,1156.0,1156,0.875,0.0,0.0,0.0,0.0,0.0,1156,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,809200.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1156.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1157,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,809900.0,5833.333333333334,23411520.53700438,5833.333333333334,17989262.49375411,true,1157.0,1157,0.875,0.0,0.0,0.0,0.0,0.0,1157,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,809900.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1157.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1158,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,810600.0,5833.333333333334,23417353.870337714,5833.333333333334,17995095.827087443,true,1158.0,1158,0.875,0.0,0.0,0.0,0.0,0.0,1158,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,810600.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1158.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1159,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,811300.0,5833.333333333334,23423187.203671046,5833.333333333334,18000929.160420775,true,1159.0,1159,0.875,0.0,0.0,0.0,0.0,0.0,1159,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,811300.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1159.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1160,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,812000.0,5833.333333333334,23429020.537004378,5833.333333333334,18006762.493754108,true,1160.0,1160,0.875,0.0,0.0,0.0,0.0,0.0,1160,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,812000.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1160.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1161,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,812700.0,5833.333333333334,23434853.87033771,5833.333333333334,18012595.82708744,true,1161.0,1161,0.875,0.0,0.0,0.0,0.0,0.0,1161,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,812700.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1161.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1162,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,813400.0,5833.333333333334,23440687.203671042,5833.333333333334,18018429.16042077,true,1162.0,1162,0.875,0.0,0.0,0.0,0.0,0.0,1162,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,813400.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1162.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1163,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,814100.0,5833.333333333334,23446520.537004374,5833.333333333334,18024262.493754104,true,1163.0,1163,0.875,0.0,0.0,0.0,0.0,0.0,1163,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,814100.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1163.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1164,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,814800.0,5833.333333333334,23452353.870337706,5833.333333333334,18030095.827087436,true,1164.0,1164,0.875,0.0,0.0,0.0,0.0,0.0,1164,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,814800.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1164.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1165,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,815500.0,5833.333333333334,23458187.20367104,5833.333333333334,18035929.160420768,true,1165.0,1165,0.875,0.0,0.0,0.0,0.0,0.0,1165,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,815500.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1165.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1166,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,816200.0,5833.333333333334,23464020.53700437,5833.333333333334,18041762.4937541,true,1166.0,1166,0.875,0.0,0.0,0.0,0.0,0.0,1166,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,816200.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1166.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1167,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,816900.0,5833.333333333334,23469853.870337702,5833.333333333334,18047595.827087432,true,1167.0,1167,0.875,0.0,0.0,0.0,0.0,0.0,1167,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,816900.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1167.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1168,22450.0,21750.0,0.12,0.0,5422258.043250443,700.0,817600.0,5833.333333333334,23475687.203671034,5833.333333333334,18053429.160420764,true,1168.0,1168,0.875,0.0,0.0,0.0,0.0,0.0,1168,21750.0,0.0,0.0,0.0,2465322.7063063392,700.0,817600.0,0.0,1237009.8459424588,0.0,-1.84385839929746e-10,0.0,0.0,0.0,1228312.8603638816,0.0,1.8387513733841843e-12,-0.0,-4744475.787844134,true,true,0.0,10889.57932847895,0.0,121.92,1644.2724500334996,1168.0,0.0,10889.57932847895,0.0,121.92,0.0,295.15 +1169,22450.0,21750.0,0.14800000000000002,904.2088091284415,5423162.252059571,700.0,818300.0,10839.248710327307,23486526.45238136,9935.039901198865,18063364.200321965,true,1169.0,1169,0.875,791.1827079873864,904.2088091284415,113.02610114105516,0.0,0.0,1169,21750.0,0.0,791.1827079873864,791.1827079873864,2466113.8890143265,700.0,818300.0,0.05049567893915037,1237009.8964381379,724.5848259163639,724.5848259161795,0.0,0.0,52.94691070945558,1228365.807274591,13.600475682627815,13.600475682629654,-791.1827079873864,-4745266.970552121,true,true,0.938799231,10890.518127709951,0.0,121.92,1644.2724500334996,1169.0,0.938799231,10890.518127709951,0.0,121.92,0.0,295.15 +1170,23354.208809128442,22654.208809128442,0.22,4953.454950386079,5428115.707009957,700.0,819000.0,25697.522501754906,23512223.974883117,20744.067551368826,18084108.267873332,true,1170.0,1170,0.875,4334.273081587819,4953.454950386079,619.1818687982595,0.0,0.0,1170,22654.208809128442,0.0,4334.273081587819,4334.273081587819,2470448.162095914,700.0,819000.0,2.3002769207802647,1237012.1967150585,4066.547494655964,4791.132320572144,0.0,0.0,189.0961097088548,1228554.9033842997,76.32920030222022,89.92967598484987,-4334.273081587819,-4749601.243633709,true,true,2.414055166,10892.932182875951,0.0,121.92,1644.2724500334996,1170.0,2.414055166,10892.932182875951,0.0,121.92,0.0,295.15 +1171,27403.45495038608,26703.45495038608,0.29250000000000004,9325.021088770909,5437440.728098728,700.0,819700.0,34273.57637186635,23546497.551254984,24948.55528309544,18109056.823156428,true,1171.0,1171,0.875,8159.393452674545,9325.021088770909,1165.6276360963639,0.0,0.0,1171,26703.45495038608,0.0,8159.393452674545,8159.393452674545,2478607.5555485887,700.0,819700.0,15.284585645136026,1237027.4813007037,7645.109284334358,12436.241604906501,0.0,0.0,355.5006862323436,1228910.404070532,143.49889646270796,233.42857244755783,-8159.393452674545,-4757760.637086383,true,true,3.8893111,10896.821493975951,0.0,121.92,1644.2724500334996,1171.0,3.8893111,10896.821493975951,0.0,121.92,0.0,295.15 +1172,31775.02108877091,31075.02108877091,0.335,13719.551185007402,5451160.279283735,700.0,820400.0,43043.43637315642,23589540.98762814,29323.88518814902,18138380.708344575,true,1172.0,1172,0.875,12004.607286881477,13719.551185007402,1714.9438981259245,0.0,0.0,1172,31075.02108877091,0.0,12004.607286881477,12004.607286881477,2490612.1628354704,700.0,820400.0,48.362346930702145,1237075.8436476344,11223.671084377205,23659.91268928371,0.0,0.0,521.9052627558324,1229432.3093332879,210.66859281773674,444.09716526529456,-12004.607286881477,-4769765.244373265,true,true,5.364567035,10902.18606101095,0.0,121.92,1644.2724500334996,1172.0,5.364567035,10902.18606101095,0.0,121.92,0.0,295.15 +1173,36169.5511850074,35469.5511850074,0.35,18147.79429031682,5469308.073574052,700.0,821100.0,53850.84082947663,23643391.828457616,35703.04653915981,18174083.754883736,true,1173.0,1173,0.875,15879.320004027215,18147.79429031682,2268.4742862896037,0.0,0.0,1173,35469.5511850074,0.0,15879.320004027215,15879.320004027215,2506491.4828394977,700.0,821100.0,110.93900665658364,1237186.782654291,14802.232869204148,38462.14555848786,0.0,0.0,688.3098392793212,1230120.6191725673,277.8382888871626,721.9354541524572,-15879.320004027215,-4785644.564377292,true,true,6.839822969,10909.02588397995,0.0,121.92,1644.2724500334996,1173.0,6.839822969,10909.02588397995,0.0,121.92,0.0,295.15 +1174,40597.794290316815,39897.794290316815,0.355,22620.499526784435,5491928.573100837,700.0,821800.0,65691.54796277305,23709083.37642039,43071.04843598862,18217154.803319726,true,1174.0,1174,0.875,19792.93708593638,22620.499526784435,2827.5624408480544,0.0,0.0,1174,39897.794290316815,0.0,19792.93708593638,19792.93708593638,2526284.419925434,700.0,821800.0,212.4200107018856,1237399.202664993,18380.794674098433,56842.94023258629,0.0,0.0,854.7144158028099,1230975.3335883701,345.00798533325326,1066.9434394857103,-19792.93708593638,-4805437.501463229,true,true,8.315078904,10917.340962883949,0.0,121.92,1644.2724500334996,1174.0,8.315078904,10917.340962883949,0.0,121.92,0.0,295.15 +1175,45070.499526784435,44370.499526784435,0.35333333333333333,20520.5376071141,5512449.110707951,700.0,822500.0,60058.125303153116,23769141.501723543,39537.587696039016,18256692.391015764,true,1175.0,1175,0.875,17955.47040622484,20520.5376071141,2565.0672008892616,0.0,0.0,1175,44370.499526784435,0.0,17955.47040622484,17955.47040622484,2544239.890331659,700.0,822500.0,341.1676563245569,1237740.3703213176,16307.266206207323,73150.20643879361,0.0,0.0,1000.9487406435724,1231976.2823290138,306.08780304938495,1373.0312425350953,-17955.47040622484,-4823392.971869454,true,true,9.432697036,10926.773659919949,0.0,121.92,1644.2724500334996,1175.0,9.432697036,10926.773659919949,0.0,121.92,0.0,295.15 +1176,42970.5376071141,42270.5376071141,0.35,17834.33874411757,5530283.449452069,700.0,823200.0,52955.25355462163,23822096.755278163,35120.914810504066,18291813.30582627,true,1176.0,1176,0.875,15605.046401102874,17834.33874411757,2229.292343014695,0.0,0.0,1176,42270.5376071141,0.0,15605.046401102874,15605.046401102874,2559844.936732762,700.0,823200.0,467.64048301127605,1238208.0108043288,13767.111753789042,86917.31819258265,0.0,0.0,1111.88512518056,1233088.1674541943,258.40903912199775,1631.440281657093,-15605.046401102874,-4838998.018270557,true,true,10.28208682,10937.055746739949,0.0,121.92,1644.2724500334996,1176.0,10.28208682,10937.055746739949,0.0,121.92,0.0,295.15 +1177,40284.33874411757,39584.33874411757,0.25,6414.182197923338,5536697.631649992,700.0,823900.0,28456.728791693353,23850553.484069858,22042.546593770014,18313855.85242004,true,1177.0,1177,0.875,5612.409423182921,6414.182197923338,801.7727747404169,0.0,0.0,1177,39584.33874411757,0.0,5612.409423182921,5612.409423182921,2565457.3461559447,700.0,823900.0,548.2203978649552,1238756.2312021938,3820.0899591341295,90737.40815171678,0.0,0.0,1172.395880115942,1234260.5633343102,71.70318606789543,1703.1434677249883,-5612.409423182921,-4844610.4276937395,true,true,10.50561044,10947.561357179948,0.0,121.92,1644.2724500334996,1177.0,10.50561044,10947.561357179948,0.0,121.92,0.0,295.15 +1178,28864.18219792334,28164.18219792334,0.12,0.0,5536697.631649992,700.0,824600.0,5833.333333333334,23856386.81740319,5833.333333333334,18319689.18575337,true,1178.0,1178,0.875,0.0,0.0,0.0,0.0,0.0,1178,28164.18219792334,0.0,-2171.1768672211274,-2171.1768672211274,2563286.1692887237,700.0,824600.0,548.2203978649552,1239304.4516000587,-3820.0899591341295,86917.31819258265,0.0,0.0,1172.395880115942,1235432.959214426,-71.70318606789543,1631.440281657093,-0.0,-4844610.4276937395,true,true,10.28208682,10957.843443999947,0.0,121.92,1644.2724500334996,1178.0,10.28208682,10957.843443999947,0.0,121.92,0.0,295.15 +1179,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,825300.0,5833.333333333334,23862220.150736522,5833.333333333334,18325522.519086704,true,1179.0,1179,0.875,0.0,0.0,0.0,0.0,0.0,1179,21750.0,0.0,-2147.309261666351,-2147.309261666351,2561138.8600270576,700.0,825300.0,513.6065125515006,1239818.0581126101,-3737.9376546560616,83179.38053792658,0.0,0.0,1147.1830656535303,1236580.1422800797,-70.16118521532044,1561.2790964417725,-0.0,-4844610.4276937395,true,true,10.05856319,10967.902007189947,0.0,121.92,1644.2724500334996,1179.0,10.05856319,10967.902007189947,0.0,121.92,0.0,295.15 +1180,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,826000.0,5833.333333333334,23868053.484069854,5833.333333333334,18331355.852420036,true,1180.0,1180,0.875,0.0,0.0,0.0,0.0,0.0,1180,21750.0,0.0,-16294.966884437825,-16294.966884437825,2544843.8931426196,700.0,826000.0,418.56520403034614,1240236.6233166405,-17457.400850371967,65721.97968755462,0.0,0.0,1071.544621589513,1237651.6869016693,-327.675859685717,1233.6032367560556,-0.0,-4844610.4276937395,true,true,8.940945058,10976.842952247947,0.0,121.92,1644.2724500334996,1180.0,8.940945058,10976.842952247947,0.0,121.92,0.0,295.15 +1181,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,826700.0,5833.333333333334,23873886.817403186,5833.333333333334,18337189.185753368,true,1181.0,1181,0.875,0.0,0.0,0.0,0.0,0.0,1181,21750.0,0.0,-19077.644139977016,-19077.644139977016,2525766.2490026425,700.0,826700.0,269.52218856006243,1240506.1455052006,-19898.972405177938,45823.00728237668,0.0,0.0,925.3102967487507,1238576.997198418,-373.5042201078922,860.0990166481633,-0.0,-4844610.4276937395,true,true,7.465689123,10984.308641370948,0.0,121.92,1644.2724500334996,1181.0,7.465689123,10984.308641370948,0.0,121.92,0.0,295.15 +1182,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,827400.0,5833.333333333334,23879720.15073652,5833.333333333334,18343022.5190867,true,1182.0,1182,0.875,0.0,0.0,0.0,0.0,0.0,1182,21750.0,0.0,-15719.14458984546,-15719.14458984546,2510047.104412797,700.0,827400.0,148.69481282630025,1240654.840318027,-16320.410599254537,29502.596683122145,0.0,0.0,758.9057202252619,1239335.9029186433,-306.3345236424856,553.7644930056778,-0.0,-4844610.4276937395,true,true,5.990433189,10990.299074559947,0.0,121.92,1644.2724500334996,1182.0,5.990433189,10990.299074559947,0.0,121.92,0.0,295.15 +1183,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,828100.0,5833.333333333334,23885553.48406985,5833.333333333334,18348855.852420032,true,1183.0,1183,0.875,0.0,0.0,0.0,0.0,0.0,1183,21750.0,0.0,-12317.750528774688,-12317.750528774688,2497729.353884022,700.0,828100.0,70.76197057259785,1240725.6022885996,-12741.848815456684,16760.74786766546,0.0,0.0,592.5011437017731,1239928.4040623452,-239.1648275923756,314.5996654133022,-0.0,-4844610.4276937395,true,true,4.515177254,10994.814251813947,0.0,121.92,1644.2724500334996,1183.0,4.515177254,10994.814251813947,0.0,121.92,0.0,295.15 +1184,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,828800.0,5833.333333333334,23891386.817403182,5833.333333333334,18354689.185753364,true,1184.0,1184,0.875,0.0,0.0,0.0,0.0,0.0,1184,21750.0,0.0,-8882.867362504645,-8882.867362504645,2488846.4865215174,700.0,828800.0,26.318215919850086,1240751.9205045195,-9163.287014384749,7597.460853280712,0.0,0.0,426.09656717828443,1240354.5006295235,-171.99513121803076,142.60453419527144,-0.0,-4844610.4276937395,true,true,3.03992132,10997.854173133946,0.0,121.92,1644.2724500334996,1184.0,3.03992132,10997.854173133946,0.0,121.92,0.0,295.15 +1185,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,829500.0,5833.333333333334,23897220.150736514,5833.333333333334,18360522.519086696,true,1185.0,1185,0.875,0.0,0.0,0.0,0.0,0.0,1185,21750.0,0.0,-5423.900567168558,-5423.900567168558,2483422.585954349,700.0,829500.0,5.958102988951918,1240757.8786075085,-5584.725225735447,2012.7356275452657,0.0,0.0,259.69199065479563,1240614.1926201782,-104.82543507685916,37.779099118412276,-0.0,-4844610.4276937395,true,true,1.564665385,10999.418838518946,0.0,121.92,1644.2724500334996,1185.0,1.564665385,10999.418838518946,0.0,121.92,0.0,295.15 +1186,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,830200.0,5833.333333333334,23903053.484069847,5833.333333333334,18366355.85242003,true,1186.0,1186,0.875,0.0,0.0,0.0,0.0,0.0,1186,21750.0,0.0,-1950.2555682764255,-1950.2555682764255,2481472.3303860724,700.0,830200.0,0.27618590079828664,1240758.1547934094,-2006.1634295149545,6.572198030311256,0.0,0.0,93.28741413130685,1240707.4800343094,-37.65573879357602,0.12336032483625559,-0.0,-4844610.4276937395,true,true,0.089409451,10999.508247969947,0.0,121.92,1644.2724500334996,1186.0,0.089409451,10999.508247969947,0.0,121.92,0.0,295.15 +1187,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,830900.0,5833.333333333334,23908886.81740318,5833.333333333334,18372189.18575336,true,1187.0,1187,0.875,0.0,0.0,0.0,0.0,0.0,1187,21750.0,0.0,-1.6529517863882033,-1.6529517863882033,2481470.677434286,700.0,830900.0,0.000043620066658271756,1240758.1548370295,-6.5721980305011485,-1.8989254613188677e-10,0.0,0.0,5.04256294888086,1240712.5225972582,-0.12336032483457314,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1187.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1188,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,831600.0,5833.333333333334,23914720.15073651,5833.333333333334,18378022.519086692,true,1188.0,1188,0.875,0.0,0.0,0.0,0.0,0.0,1188,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,831600.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1188.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1189,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,832300.0,5833.333333333334,23920553.484069843,5833.333333333334,18383855.852420025,true,1189.0,1189,0.875,0.0,0.0,0.0,0.0,0.0,1189,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,832300.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1189.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1190,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,833000.0,5833.333333333334,23926386.817403175,5833.333333333334,18389689.185753357,true,1190.0,1190,0.875,0.0,0.0,0.0,0.0,0.0,1190,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,833000.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1190.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1191,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,833700.0,5833.333333333334,23932220.150736507,5833.333333333334,18395522.51908669,true,1191.0,1191,0.875,0.0,0.0,0.0,0.0,0.0,1191,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,833700.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1191.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1192,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,834400.0,5833.333333333334,23938053.48406984,5833.333333333334,18401355.85242002,true,1192.0,1192,0.875,0.0,0.0,0.0,0.0,0.0,1192,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,834400.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1192.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1193,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,835100.0,5833.333333333334,23943886.81740317,5833.333333333334,18407189.185753353,true,1193.0,1193,0.875,0.0,0.0,0.0,0.0,0.0,1193,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,835100.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1193.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1194,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,835800.0,5833.333333333334,23949720.150736503,5833.333333333334,18413022.519086685,true,1194.0,1194,0.875,0.0,0.0,0.0,0.0,0.0,1194,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,835800.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1194.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1195,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,836500.0,5833.333333333334,23955553.484069835,5833.333333333334,18418855.852420017,true,1195.0,1195,0.875,0.0,0.0,0.0,0.0,0.0,1195,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,836500.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1195.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1196,22450.0,21750.0,0.12,0.0,5536697.631649992,700.0,837200.0,5833.333333333334,23961386.817403167,5833.333333333334,18424689.18575335,true,1196.0,1196,0.875,0.0,0.0,0.0,0.0,0.0,1196,21750.0,0.0,0.0,0.0,2481470.677434286,700.0,837200.0,0.0,1240758.1548370295,0.0,-1.8989254613188677e-10,0.0,0.0,0.0,1240712.5225972582,0.0,1.68244584930477e-12,-0.0,-4844610.4276937395,true,true,0.0,10999.508247969947,0.0,121.92,1644.2724500334996,1196.0,0.0,10999.508247969947,0.0,121.92,0.0,295.15 +1197,22450.0,21750.0,0.12,13.415045627752276,5536711.04669562,700.0,837900.0,5945.125380231269,23967331.9427834,5931.710334603517,18430620.896087952,true,1197.0,1197,0.875,11.738164924283241,13.415045627752276,1.6768807034690347,0.0,0.0,1197,21750.0,0.0,11.738164924283241,11.738164924283241,2481482.41559921,700.0,837900.0,0.000043620066658271756,1240758.1548806496,6.5721980305011485,6.572198030311256,0.0,0.0,5.04256294888086,1240717.565160207,0.12336032483457314,0.12336032483625559,-11.738164924283241,-4844622.165858664,true,true,0.089409451,10999.597657420947,0.0,121.92,1644.2724500334996,1197.0,0.089409451,10999.597657420947,0.0,121.92,0.0,295.15 +1198,22463.415045627753,21763.415045627753,0.132,471.7921922764773,5537182.838887896,700.0,838600.0,8877.213577852099,23976209.156361252,8405.42138557562,18439026.317473527,true,1198.0,1198,0.875,412.81816824191765,471.7921922764773,58.97402403455965,0.0,0.0,1198,21763.415045627753,0.0,412.81816824191765,412.81816824191765,2481895.233767452,700.0,838600.0,0.0267881730664018,1240758.1816688227,363.11393732608417,369.6861353563954,0.0,0.0,42.86178486809241,1240760.4269450752,6.81565787467468,6.939018199510936,-412.81816824191765,-4845034.984026905,true,true,0.670570879,11000.268228299947,0.0,121.92,1644.2724500334996,1198.0,0.670570879,11000.268228299947,0.0,121.92,0.0,295.15 +1199,22921.792192276476,22221.792192276476,0.1744,2057.868811132437,5539240.707699029,700.0,839300.0,15813.467953741037,23992022.624314994,13755.5991426086,18452781.916616134,true,1199.0,1199,0.875,1800.6352097408821,2057.868811132437,257.23360139155466,0.0,0.0,1199,22221.792192276476,0.0,1800.6352097408821,1800.6352097408821,2483695.8689771933,700.0,839300.0,0.6815635314732058,1240758.8632323542,1643.04949218887,2012.7356275452655,0.0,0.0,126.06407310163752,1240886.4910181768,30.840080918901343,37.779099118412276,-1800.6352097408821,-4846835.619236646,true,true,1.564665385,11001.832893684947,0.0,121.92,1644.2724500334996,1199.0,1.564665385,11001.832893684947,0.0,121.92,0.0,295.15 +1200,24507.868811132437,23807.868811132437,0.25,6033.42785709912,5545274.135556128,700.0,840000.0,26933.71142839648,24018956.33574339,20900.28357129736,18473682.200187434,true,1200.0,1200,0.875,5279.24937496173,6033.42785709912,754.1784821373903,0.0,0.0,1200,23807.868811132437,0.0,5279.24937496173,5279.24937496173,2488975.118352155,700.0,840000.0,5.452508255444662,1240764.3157406095,4929.148477669211,6941.884105214477,0.0,0.0,252.1281462596736,1241138.6191644364,92.52024277739989,130.29934189581218,-5279.24937496173,-4852114.868611608,true,true,2.905807144,11004.738700828946,0.0,121.92,1644.2724500334996,1200.0,2.905807144,11004.738700828946,0.0,121.92,0.0,295.15 +1201,28483.42785709912,27783.42785709912,0.30500000000000005,10786.782082387877,5556060.917638516,700.0,840700.0,37661.58059799304,24056617.916341383,26874.798515605158,18500556.99870304,true,1201.0,1201,0.875,9438.434322089393,10786.782082387877,1348.347760298484,0.0,0.0,1201,27783.42785709912,0.0,9438.434322089393,9438.434322089393,2498413.5526742446,700.0,840700.0,23.613433767117364,1240787.9291743767,8837.963214741707,15779.847319956185,0.0,0.0,410.9688783880404,1241549.5880428243,165.88879519252868,296.18813708834085,-9438.434322089393,-4861553.302933697,true,true,4.381063078,11009.119763906947,0.0,121.92,1644.2724500334996,1201.0,4.381063078,11009.119763906947,0.0,121.92,0.0,295.15 +1202,33236.78208238788,32536.78208238788,0.30500000000000005,9867.546293534457,5565928.46393205,700.0,841400.0,34647.69276568674,24091265.60910707,24780.146472152286,18525337.145175193,true,1202.0,1202,0.875,8634.10300684265,9867.546293534457,1233.4432866918069,0.0,0.0,1202,32536.78208238788,0.0,8634.10300684265,8634.10300684265,2507047.655681087,700.0,841400.0,56.489250504496354,1240844.418424881,7880.065369327518,23659.9126892837,0.0,0.0,549.6393588336808,1242099.227401658,147.9090281769536,444.09716526529445,-8634.10300684265,-4870187.405940539,true,true,5.364567035,11014.484330941947,0.0,121.92,1644.2724500334996,1202.0,5.364567035,11014.484330941947,0.0,121.92,0.0,295.15 +1203,32317.546293534455,31617.546293534455,0.22,5100.757476421243,5571029.221408471,700.0,842100.0,26367.07943827838,24117632.688545346,21266.321961857135,18546603.46713705,true,1203.0,1203,0.875,4463.162791868588,5100.757476421243,637.594684552655,0.0,0.0,1203,31617.546293534455,0.0,4463.162791868588,4463.162791868588,2511510.818472956,700.0,842100.0,84.17718011734617,1240928.5956049985,3682.073906343327,27341.98659562703,0.0,0.0,627.7990841747436,1242727.0264858326,69.11262123317108,513.2097864984655,-4463.162791868588,-4874650.568732408,true,true,5.766909562,11020.251240503947,0.0,121.92,1644.2724500334996,1203.0,5.766909562,11020.251240503947,0.0,121.92,0.0,295.15 +1204,27550.757476421244,26850.757476421244,0.16,1350.0355074826268,5572379.256915954,700.0,842800.0,12812.721921766415,24130445.410467114,11462.686414283788,18558066.153551333,true,1204.0,1204,0.875,1181.2810690472984,1350.0355074826268,168.75443843532844,0.0,0.0,1204,26850.757476421244,0.0,1181.2810690472984,1181.2810690472984,2512692.099542003,700.0,842800.0,94.73176392472222,1241023.3273689232,425.5498252314475,27767.536420858476,0.0,0.0,653.0118988063507,1243380.038384639,7.987581084778076,521.1973675832436,-1181.2810690472984,-4875831.849801456,true,true,5.811614288,11026.062854791948,0.0,121.92,1644.2724500334996,1204.0,5.811614288,11026.062854791948,0.0,121.92,0.0,295.15 +1205,23800.035507482626,23100.035507482626,0.12,0.0,5572379.256915954,700.0,843500.0,5833.333333333334,24136278.743800446,5833.333333333334,18563899.486884665,true,1205.0,1205,0.875,0.0,0.0,0.0,0.0,0.0,1205,23100.035507482626,0.0,-977.1369677293557,-977.1369677293557,2511714.962574274,700.0,843500.0,91.4779087376231,1241114.805277661,-1682.482687869567,26085.05373298891,0.0,0.0,645.4480544112287,1244025.4864390502,-31.58024300864061,489.617124574603,-0.0,-4875831.849801456,true,true,5.632795386,11031.695650177948,0.0,121.92,1644.2724500334996,1205.0,5.632795386,11031.695650177948,0.0,121.92,0.0,295.15 +1206,22450.0,21750.0,0.1696,1805.819428883467,5574185.076344837,700.0,844200.0,14774.87870803931,24151053.622508485,12969.059279155843,18576868.54616382,true,1206.0,1206,0.875,1580.0920002730336,1805.819428883467,225.72742861043344,0.0,0.0,1206,21750.0,0.0,1580.0920002730336,1580.0920002730336,2513295.054574547,700.0,844200.0,89.35060172691969,1241204.1558793879,834.6691459042803,26919.72287889319,0.0,0.0,640.4054914623479,1244665.8919305126,15.666761179485702,505.2838857540887,-1580.0920002730336,-4877411.941801729,true,true,5.722204837,11037.417855014948,0.0,121.92,1644.2724500334996,1206.0,5.722204837,11037.417855014948,0.0,121.92,0.0,295.15 +1207,24255.819428883467,23555.819428883467,0.1792,2340.9781283247726,5576526.054473163,700.0,844900.0,16969.74401966949,24168023.366528153,14628.76589134472,18591497.312055163,true,1207.0,1207,0.875,2048.355862284176,2340.9781283247726,292.6222660405965,0.0,0.0,1207,23555.819428883467,0.0,2048.355862284176,2048.355862284176,2515343.410436831,700.0,844900.0,94.73176392472222,1241298.8876433126,1276.6494566561166,28196.372335549306,0.0,0.0,653.0118988063507,1245318.903829319,23.962742896986367,529.2466286510751,-2048.355862284176,-4879460.297664013,true,true,5.856319013,11043.274174027949,0.0,121.92,1644.2724500334996,1207.0,5.856319013,11043.274174027949,0.0,121.92,0.0,295.15 +1208,24790.978128324772,24090.978128324772,0.14800000000000002,867.0144241073166,5577393.06889727,700.0,845600.0,10587.935298022408,24178611.301826175,9720.920873915093,18601218.232929077,true,1208.0,1208,0.875,758.637621093902,867.0144241073166,108.37680301341459,0.0,0.0,1208,24090.978128324772,0.0,758.637621093902,758.637621093902,2516102.048057925,700.0,845600.0,98.0618778924291,1241396.949521205,0.0,28196.372335549306,0.0,0.0,660.5757432014728,1245979.4795725204,0.0,529.2466286510751,-758.637621093902,-4880218.935285106,true,true,5.856319013,11049.13049304095,0.0,121.92,1644.2724500334996,1208.0,5.856319013,11049.13049304095,0.0,121.92,0.0,295.15 +1209,23317.014424107318,22617.014424107318,0.23500000000000001,5570.745776954092,5582963.814674224,700.0,846300.0,26684.02458278337,24205295.32640896,21113.27880582928,18622331.511734907,true,1209.0,1209,0.875,4874.402554834831,5570.745776954092,696.3432221192616,0.0,0.0,1209,22617.014424107318,0.0,4874.402554834831,4874.402554834831,2520976.4506127597,700.0,846300.0,108.51860554259576,1241505.4681267475,4007.3977154687386,32203.770051018044,0.0,0.0,683.2672763868388,1246662.746848907,75.21895743665766,604.4655860877327,-4874.402554834831,-4885093.3378399415,true,true,6.258661541,11055.38915458195,0.0,121.92,1644.2724500334996,1209.0,6.258661541,11055.38915458195,0.0,121.92,0.0,295.15 +1210,28020.745776954092,27320.745776954092,0.29250000000000004,9475.106543449974,5592438.921217673,700.0,847000.0,34786.689037435804,24240082.015446395,25311.58249398583,18647643.094228894,true,1210.0,1210,0.875,8290.718225518727,9475.106543449974,1184.388317931247,0.0,0.0,1210,27320.745776954092,0.0,8290.718225518727,8290.718225518727,2529267.1688382784,700.0,847000.0,139.97883663870027,1241645.4469633861,7270.493999389044,39474.26405040709,0.0,0.0,743.7780314914164,1247406.5248803985,136.46735799956664,740.9329440872993,-8290.718225518727,-4893384.056065461,true,true,6.92923242,11062.31838700195,0.0,121.92,1644.2724500334996,1210.0,6.92923242,11062.31838700195,0.0,121.92,0.0,295.15 +1211,31925.106543449976,31225.106543449976,0.30500000000000005,10476.34574260277,5602915.266960276,700.0,847700.0,36643.75653312383,24276725.77197952,26167.41079052106,18673810.505019415,true,1211.0,1211,0.875,9166.802524777424,10476.34574260277,1309.5432178253468,0.0,0.0,1211,31225.106543449976,0.0,9166.802524777424,9166.802524777424,2538433.971363056,700.0,847700.0,187.17438494677413,1241832.6213483328,8009.866270102224,47484.13032050931,0.0,0.0,819.4164753298395,1248225.9413557283,150.34539439858528,891.2783384858847,-9166.802524777424,-4902550.858590238,true,true,7.599803299,11069.918190300948,0.0,121.92,1644.2724500334996,1211.0,7.599803299,11069.918190300948,0.0,121.92,0.0,295.15 +1212,32926.345742602774,32226.345742602774,0.3175,12203.494363938122,5615118.761324215,700.0,848400.0,40640.927130513766,24317366.69911003,28437.432766575643,18702247.93778599,true,1212.0,1212,0.875,10678.057568445856,12203.494363938122,1525.4367954922654,0.0,0.0,1212,32226.345742602774,0.0,10678.057568445856,10678.057568445856,2549112.028931502,700.0,848400.0,246.00635469815484,1242078.627703031,9358.809912076973,56842.94023258629,0.0,0.0,897.5762006709024,1249123.517556399,175.6651009998257,1066.9434394857103,-10678.057568445856,-4913228.916158684,true,true,8.315078904,11078.233269204948,0.0,121.92,1644.2724500334996,1212.0,8.315078904,11078.233269204948,0.0,121.92,0.0,295.15 +1213,34653.49436393812,33953.49436393812,0.29250000000000004,9513.234024674592,5624631.995348889,700.0,849100.0,34917.03940059689,24352283.738510627,25403.8053759223,18727651.743161913,true,1213.0,1213,0.875,8324.079771590268,9513.234024674592,1189.1542530843235,0.0,0.0,1213,33953.49436393812,0.0,8324.079771590268,8324.079771590268,2557436.108703092,700.0,849100.0,306.33220267020187,1242384.9599057012,6922.167507888866,63765.107740475156,0.0,0.0,965.6508001706019,1250089.1683565697,129.92926086059876,1196.872700346309,-8324.079771590268,-4921552.995930274,true,true,8.806830882,11087.040100086948,0.0,121.92,1644.2724500334996,1213.0,8.806830882,11087.040100086948,0.0,121.92,0.0,295.15 +1214,31963.23402467459,31263.23402467459,0.3175,11714.645398696619,5636346.640747586,700.0,849800.0,39101.245350225574,24391384.983860854,27386.599951528955,18755038.34311344,true,1214.0,1214,0.875,10250.314723859541,11714.645398696619,1464.3306748370778,0.0,0.0,1214,31263.23402467459,0.0,10250.314723859541,10250.314723859541,2567686.4234269517,700.0,849800.0,367.60343378068563,1242752.5633394818,8693.37486659746,72458.48260707261,0.0,0.0,1026.1615552751794,1251115.3299118448,163.17486820621585,1360.047568552525,-10250.314723859541,-4931803.310654134,true,true,9.387992311,11096.428092397948,0.0,121.92,1644.2724500334996,1214.0,9.387992311,11096.428092397948,0.0,121.92,0.0,295.15 +1215,34164.64539869662,33464.64539869662,0.23500000000000001,5768.143041446927,5642114.783789033,700.0,850500.0,27524.012942327347,24418908.996803183,21755.869900880418,18776794.213014323,true,1215.0,1215,0.875,5047.125161266061,5768.143041446927,721.0178801808661,0.0,0.0,1215,33464.64539869662,0.0,5047.125161266061,5047.125161266061,2572733.5485882177,700.0,850500.0,418.56520403034614,1243171.1285435122,3491.4801638263343,75949.96277089894,0.0,0.0,1071.544621589513,1252186.8745334344,65.53517181986707,1425.5827403723922,-5047.125161266061,-4936850.4358153995,true,true,9.611515937,11106.039608334948,0.0,121.92,1644.2724500334996,1215.0,9.611515937,11106.039608334948,0.0,121.92,0.0,295.15 +1216,28218.14304144693,27518.14304144693,0.20800000000000002,4238.567970783865,5646353.3517598165,700.0,851200.0,23743.115244153196,24442652.112047337,19504.54727336933,18796298.76028769,true,1216.0,1216,0.875,3708.7469744358823,4238.567970783865,529.820996347983,0.0,0.0,1216,27518.14304144693,0.0,3708.7469744358823,3708.7469744358823,2576442.295562654,700.0,851200.0,442.64954365298934,1243613.7780871652,2134.321292359348,78084.2840632583,0.0,0.0,1091.7148732722394,1253278.5894067066,40.06126515130583,1465.644005523698,-3708.7469744358823,-4940559.182789835,true,true,9.745630113,11115.785238447948,0.0,121.92,1644.2724500334996,1216.0,9.745630113,11115.785238447948,0.0,121.92,0.0,295.15 +1217,26688.567970783864,25988.567970783864,0.16720000000000002,1772.791681946666,5648126.143441763,700.0,851900.0,14789.423935087714,24457441.535982426,13016.632253141048,18809315.39254083,true,1217.0,1217,0.875,1551.1927217033326,1772.791681946666,221.5989602433333,0.0,0.0,1217,25988.567970783864,0.0,1551.1927217033326,1551.1927217033326,2577993.4882843574,700.0,851900.0,451.91400403597083,1244065.6920912012,0.0,78084.2840632583,0.0,0.0,1099.2787176673617,1254377.868124374,0.0,1465.644005523698,-1551.1927217033326,-4942110.375511538,true,true,9.745630113,11125.530868560949,0.0,121.92,1644.2724500334996,1217.0,9.745630113,11125.530868560949,0.0,121.92,0.0,295.15 +1218,24222.791681946666,23522.791681946666,0.12,0.0,5648126.143441763,700.0,852600.0,5833.333333333334,24463274.86931576,5833.333333333334,18815148.725874163,true,1218.0,1218,0.875,0.0,0.0,0.0,0.0,0.0,1218,23522.791681946666,0.0,-640.0181405854249,-640.0181405854249,2577353.4701437717,700.0,852600.0,442.64954365298934,1244508.3416348542,-2134.321292359348,75949.96277089894,0.0,0.0,1091.7148732722394,1255469.5829976462,-40.06126515130583,1425.5827403723922,-0.0,-4942110.375511538,true,true,9.611515937,11135.142384497949,0.0,121.92,1644.2724500334996,1218.0,9.611515937,11135.142384497949,0.0,121.92,0.0,295.15 +1219,22450.0,21750.0,0.12,0.0,5648126.143441763,700.0,853300.0,5833.333333333334,24469108.20264909,5833.333333333334,18820982.059207495,true,1219.0,1219,0.875,0.0,0.0,0.0,0.0,0.0,1219,21750.0,0.0,-643.1631494288114,-643.1631494288114,2576710.3069943427,700.0,853300.0,424.50221122550295,1244932.8438460797,-2104.7464014426205,73845.21636945632,0.0,0.0,1076.5871844819953,1256546.1701821282,-39.50614369368908,1386.076596678703,-0.0,-4942110.375511538,true,true,9.477401761,11144.619786258949,0.0,121.92,1644.2724500334996,1219.0,9.477401761,11144.619786258949,0.0,121.92,0.0,295.15 +1220,22450.0,21750.0,0.20800000000000002,4166.105075250066,5652292.248517013,700.0,854000.0,23394.735938702237,24492502.938587792,19228.63086345217,18840210.690070946,true,1220.0,1220,0.875,3645.3419408438076,4166.105075250066,520.7631344062584,0.0,0.0,1220,21750.0,0.0,3645.3419408438076,3645.3419408438076,2580355.6489351867,700.0,854000.0,424.50221122550295,1245357.346057305,2104.7464014426205,75949.96277089894,0.0,0.0,1076.5871844819953,1257622.7573666102,39.50614369368908,1425.5827403723922,-3645.3419408438076,-4945755.717452382,true,true,9.611515937,11154.231302195949,0.0,121.92,1644.2724500334996,1220.0,9.611515937,11154.231302195949,0.0,121.92,0.0,295.15 +1221,26616.105075250067,25916.105075250067,0.20800000000000002,4238.567970783865,5656530.816487797,700.0,854700.0,23743.115244153196,24516246.053831946,19504.54727336933,18859715.237344313,true,1221.0,1221,0.875,3708.7469744358823,4238.567970783865,529.820996347983,0.0,0.0,1221,25916.105075250067,0.0,3708.7469744358823,3708.7469744358823,2584064.395909623,700.0,854700.0,442.64954365298934,1245799.9956009581,2134.321292359348,78084.2840632583,0.0,0.0,1091.7148732722394,1258714.4722398825,40.06126515130583,1465.644005523698,-3708.7469744358823,-4949464.464426817,true,true,9.745630113,11163.97693230895,0.0,121.92,1644.2724500334996,1221.0,9.745630113,11163.97693230895,0.0,121.92,0.0,295.15 +1222,26688.567970783864,25988.567970783864,0.196,3461.4972900681155,5659992.313777865,700.0,855400.0,21232.129030959768,24537478.182862908,17770.63174089165,18877485.869085204,true,1222.0,1222,0.875,3028.810128809601,3461.4972900681155,432.6871612585146,0.0,0.0,1222,25988.567970783864,0.0,3028.810128809601,3028.810128809601,2587093.206038432,700.0,855400.0,458.1615752643924,1246258.1571762224,1439.3113619171293,79523.59542517543,0.0,0.0,1104.3212806162426,1259818.7935204988,27.0159110118367,1492.6599165355349,-3028.810128809601,-4952493.274555627,true,true,9.835039564,11173.81197187295,0.0,121.92,1644.2724500334996,1222.0,9.835039564,11173.81197187295,0.0,121.92,0.0,295.15 +1223,25911.497290068117,25211.497290068117,0.14800000000000002,952.3564183801708,5660944.670196245,700.0,856100.0,11164.570394460612,24548642.753257368,10212.213976080442,18887698.083061285,true,1223.0,1223,0.875,833.3118660826494,952.3564183801708,119.04455229752136,0.0,0.0,1223,25211.497290068117,0.0,833.3118660826494,833.3118660826494,2587926.517904515,700.0,856100.0,461.3068382735643,1246719.464014496,-721.2987385151914,78802.29668666024,0.0,0.0,1106.8425620624835,1260925.6360825612,-13.53879573820693,1479.1211207973279,-833.3118660826494,-4953326.5864217095,true,true,9.790334838,11183.60230671095,0.0,121.92,1644.2724500334996,1223.0,9.790334838,11183.60230671095,0.0,121.92,0.0,295.15 +1224,23402.35641838017,22702.35641838017,0.124,104.64116966280368,5661049.311365908,700.0,856800.0,6489.041690829062,24555131.794948198,6384.400521166258,18894082.483582452,true,1224.0,1224,0.875,91.56102345495322,104.64116966280368,13.080146207850461,0.0,0.0,1224,22702.35641838017,0.0,91.56102345495322,91.56102345495322,2588018.07892797,700.0,856800.0,451.91400403597083,1247171.378018532,-1432.7391478621566,77369.55753879808,0.0,0.0,1099.2787176673617,1262024.9148002286,-26.892550386222545,1452.2285704111052,-91.56102345495322,-4953418.147445165,true,true,9.700925388,11193.303232098951,0.0,121.92,1644.2724500334996,1224.0,9.700925388,11193.303232098951,0.0,121.92,0.0,295.15 +1225,22554.641169662802,21854.641169662802,0.124,94.33458166391918,5661143.645947572,700.0,857500.0,6405.9240456767675,24561537.718993876,6311.589464012848,18900394.073046464,true,1225.0,1225,0.875,82.54275895592929,94.33458166391918,11.791822707989894,0.0,0.0,1225,21854.641169662802,0.0,82.54275895592929,82.54275895592929,2588100.621686926,700.0,857500.0,439.58976506777304,1247610.9677835996,-1419.5947678991292,75949.96277089894,0.0,0.0,1089.1935918259985,1263114.1083920544,-26.645830038713054,1425.5827403723922,-82.54275895592929,-4953500.69020412,true,true,9.611515937,11202.914748035952,0.0,121.92,1644.2724500334996,1225.0,9.611515937,11202.914748035952,0.0,121.92,0.0,295.15 +1226,22544.33458166392,21844.33458166392,0.16720000000000002,1734.47268879474,5662878.118636367,700.0,858200.0,14560.243354035525,24576097.96234791,12825.770665240785,18913219.843711704,true,1226.0,1226,0.875,1517.6636026953975,1734.47268879474,216.8090860993425,0.0,0.0,1226,21844.33458166392,0.0,1517.6636026953975,1517.6636026953975,2589618.2852896214,700.0,858200.0,433.51257381828,1248044.4803574178,0.0,75949.96277089894,0.0,0.0,1084.1510288771174,1264198.2594209316,0.0,1425.5827403723922,-1517.6636026953975,-4955018.353806816,true,true,9.611515937,11212.526263972952,0.0,121.92,1644.2724500334996,1226.0,9.611515937,11212.526263972952,0.0,121.92,0.0,295.15 +1227,24184.47268879474,23484.47268879474,0.14800000000000002,907.4585383236245,5663785.577174691,700.0,858900.0,10861.206340024488,24586959.168687936,9953.747801700863,18923173.591513406,true,1227.0,1227,0.875,794.0262210331714,907.4585383236245,113.43231729045306,0.0,0.0,1227,23484.47268879474,0.0,794.0262210331714,794.0262210331714,2590412.3115106546,700.0,858900.0,430.4950957918748,1248474.9754532096,-704.8682275614793,75245.09454333746,0.0,0.0,1081.6297474308763,1265279.8891683624,-13.230394628100415,1412.3523457442918,-794.0262210331714,-4955812.380027849,true,true,9.566811212,11222.093075184952,0.0,121.92,1644.2724500334996,1227.0,9.566811212,11222.093075184952,0.0,121.92,0.0,295.15 +1228,23357.458538323626,22657.458538323626,0.12,0.0,5663785.577174691,700.0,859600.0,5833.333333333334,24592792.502021268,5833.333333333334,18929006.92484674,true,1228.0,1228,0.875,0.0,0.0,0.0,0.0,0.0,1228,22657.458538323626,0.0,-7594.593276152172,-7594.593276152172,2582817.7182345022,700.0,859600.0,389.7091672099357,1248864.6846204195,-8864.252013699832,66380.84252963762,0.0,0.0,1046.3318069579057,1266326.2209753203,-166.3822366201811,1245.9701091241106,-0.0,-4955812.380027849,true,true,8.985649783,11231.078724967952,0.0,121.92,1644.2724500334996,1228.0,8.985649783,11231.078724967952,0.0,121.92,0.0,295.15 +1229,22450.0,21750.0,0.12,0.0,5663785.577174691,700.0,860300.0,5833.333333333334,24598625.8353546,5833.333333333334,18934840.25818007,true,1229.0,1229,0.875,0.0,0.0,0.0,0.0,0.0,1229,21750.0,0.0,-2640.1381185817872,-2640.1381185817872,2580177.5801159204,700.0,860300.0,338.596051647782,1249203.2806720673,-3903.885597039641,62476.95693259798,0.0,0.0,998.4274591409325,1267324.6484344613,-73.27603233086057,1172.6940767932501,-0.0,-4955812.380027849,true,true,8.717421431,11239.796146398952,0.0,121.92,1644.2724500334996,1229.0,8.717421431,11239.796146398952,0.0,121.92,0.0,295.15 +1230,22450.0,21750.0,0.12,0.0,5663785.577174691,700.0,861000.0,5833.333333333334,24604459.168687932,5833.333333333334,18940673.591513403,true,1230.0,1230,0.875,0.0,0.0,0.0,0.0,0.0,1230,21750.0,0.0,-651.6191893981224,-651.6191893981224,2579525.9609265225,700.0,861000.0,316.03066633544637,1249519.3113384028,-1907.5804480314348,60569.37648456655,0.0,0.0,975.735926011965,1268300.3843604734,-35.805333714099106,1136.888743079151,-0.0,-4955812.380027849,true,true,8.583307256,11248.379453654952,0.0,121.92,1644.2724500334996,1230.0,8.583307256,11248.379453654952,0.0,121.92,0.0,295.15 +1231,22450.0,21750.0,0.20800000000000002,4450.995057189844,5668236.57223188,700.0,861700.0,24764.399313412712,24629223.568001345,20313.404256222868,18960986.995769627,true,1231.0,1231,0.875,3894.620675041114,4450.995057189844,556.3743821487305,0.0,0.0,1231,21750.0,0.0,3894.620675041114,3894.620675041114,2583420.581601564,700.0,861700.0,318.48685231581305,1249837.7981907185,2550.012809666063,63119.38929423261,0.0,0.0,978.2572075146049,1269278.641567988,47.86380554463323,1184.7525486237842,-3894.620675041114,-4959707.000702891,true,true,8.762126157,11257.141579811952,0.0,121.92,1644.2724500334996,1231.0,8.762126157,11257.141579811952,0.0,121.92,0.0,295.15 +1232,26900.995057189844,26200.995057189844,0.1912,3023.887481661989,5671260.459713543,700.0,862400.0,19476.398962667306,24648699.966964014,16452.511481005316,18977439.507250633,true,1232.0,1232,0.875,2645.9015464542404,3023.887481661989,377.98593520774875,0.0,0.0,1232,26200.995057189844,0.0,2645.9015464542404,2645.9015464542404,2586066.483148018,700.0,862400.0,333.49167517286133,1250171.2898658914,1294.7229914268405,64414.11228565945,0.0,0.0,993.3848962484503,1270272.0264642364,24.30198360608816,1209.0545322298724,-2645.9015464542404,-4962352.902249345,true,true,8.851535607,11265.993115418953,0.0,121.92,1644.2724500334996,1232.0,8.851535607,11265.993115418953,0.0,121.92,0.0,295.15 +1233,25473.88748166199,24773.88748166199,0.1912,3062.443859805262,5674322.903573348,700.0,863100.0,19678.05366006936,24668378.020624083,16615.609800264097,18994055.117050897,true,1233.0,1233,0.875,2679.6383773296043,3062.443859805262,382.80548247565775,0.0,0.0,1233,24773.88748166199,0.0,2679.6383773296043,2679.6383773296043,2588746.1215253477,700.0,863100.0,343.75224881844815,1250515.04211471,1307.8674018951594,65721.97968755462,0.0,0.0,1003.4700220898135,1271275.4964863262,24.54870452618335,1233.6032367560558,-2679.6383773296043,-4965032.540626674,true,true,8.940945058,11274.934060476953,0.0,121.92,1644.2724500334996,1233.0,8.940945058,11274.934060476953,0.0,121.92,0.0,295.15 +1234,25512.443859805262,24812.443859805262,0.12,0.0,5674322.903573348,700.0,863800.0,5833.333333333334,24674211.353957415,5833.333333333334,18999888.45038423,true,1234.0,1234,0.875,0.0,0.0,0.0,0.0,0.0,1234,24812.443859805262,0.0,-1973.9883350366188,-1973.9883350366188,2586772.133190311,700.0,863800.0,336.0374021881232,1250851.0795168981,-3245.022754956628,62476.95693259799,0.0,0.0,995.9061776946916,1272271.402664021,-60.90915996280563,1172.6940767932501,-0.0,-4965032.540626674,true,true,8.717421431,11283.651481907953,0.0,121.92,1644.2724500334996,1234.0,8.717421431,11283.651481907953,0.0,121.92,0.0,295.15 +1235,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,864500.0,5833.333333333334,24680044.687290747,5833.333333333334,19005721.78371756,true,1235.0,1235,0.875,0.0,0.0,0.0,0.0,0.0,1235,21750.0,0.0,-11177.722787897766,-11177.722787897766,2575594.4104024135,700.0,864500.0,276.1859006480107,1251127.2654175463,-12158.566231098117,50318.39070149987,0.0,0.0,932.8741411438726,1273204.2768051648,-228.2165985915319,944.4774782017182,-0.0,-4965032.540626674,true,true,7.823326926,11291.474808833953,0.0,121.92,1644.2724500334996,1235.0,7.823326926,11291.474808833953,0.0,121.92,0.0,295.15 +1236,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,865200.0,5833.333333333334,24685878.02062408,5833.333333333334,19011555.117050894,true,1236.0,1236,0.875,0.0,0.0,0.0,0.0,0.0,1236,21750.0,0.0,-10019.701513345493,-10019.701513345493,2565574.708889068,700.0,865200.0,195.94678918786877,1251323.212206734,-10844.126651092785,39474.26405040709,0.0,0.0,832.0228826738424,1274036.2996878386,-203.5445341144187,740.9329440872996,-0.0,-4965032.540626674,true,true,6.92923242,11298.404041253953,0.0,121.92,1644.2724500334996,1236.0,6.92923242,11298.404041253953,0.0,121.92,0.0,295.15 +1237,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,865900.0,5833.333333333334,24691711.35395741,5833.333333333334,19017388.450384226,true,1237.0,1237,0.875,0.0,0.0,0.0,0.0,0.0,1237,21750.0,0.0,-11081.677194013635,-11081.677194013635,2554493.0316950544,700.0,865900.0,126.22079517922248,1251449.4330019134,-11706.727629548612,27767.536420858476,0.0,0.0,718.5652168598092,1274754.8649046985,-219.73557650405576,521.1973675832438,-0.0,-4965032.540626674,true,true,5.811614288,11304.215655541953,0.0,121.92,1644.2724500334996,1237.0,5.811614288,11304.215655541953,0.0,121.92,0.0,295.15 +1238,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,866600.0,5833.333333333334,24697544.687290743,5833.333333333334,19023221.783717558,true,1238.0,1238,0.875,0.0,0.0,0.0,0.0,0.0,1238,21750.0,0.0,-10903.602653000222,-10903.602653000222,2543589.4290420543,700.0,866600.0,66.34066794980204,1251515.7736698631,-11337.041498969964,16430.494921888512,0.0,0.0,579.8947364141688,1275334.7596411125,-212.7965583942284,308.4008091890154,-0.0,-4965032.540626674,true,true,4.470472529,11308.686128070953,0.0,121.92,1644.2724500334996,1238.0,4.470472529,11308.686128070953,0.0,121.92,0.0,295.15 +1239,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,867300.0,5833.333333333334,24703378.020624075,5833.333333333334,19029055.11705089,true,1239.0,1239,0.875,0.0,0.0,0.0,0.0,0.0,1239,21750.0,0.0,-5540.372772986647,-5540.372772986647,2538049.056269068,700.0,867300.0,31.799028143382223,1251547.5726980064,-5914.978173056042,10515.51674883247,0.0,0.0,453.83066325613277,1275788.5903043686,-111.0242913301204,197.37651785889497,-0.0,-4965032.540626674,true,true,3.576378023,11312.262506093954,0.0,121.92,1644.2724500334996,1239.0,3.576378023,11312.262506093954,0.0,121.92,0.0,295.15 +1240,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,868000.0,5833.333333333334,24709211.353957407,5833.333333333334,19034888.450384222,true,1240.0,1240,0.875,0.0,0.0,0.0,0.0,0.0,1240,21750.0,0.0,-4318.94971792251,-4318.94971792251,2533730.106551145,700.0,868000.0,14.961682648637149,1251562.534380655,-4600.53857871689,5914.97817011558,0.0,0.0,352.9794047297039,1276141.5697090984,-86.35222658396157,111.0242912749334,-0.0,-4965032.540626674,true,true,2.682283517,11314.944789610954,0.0,121.92,1644.2724500334996,1240.0,2.682283517,11314.944789610954,0.0,121.92,0.0,295.15 +1241,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,868700.0,5833.333333333334,24715044.68729074,5833.333333333334,19040721.783717554,true,1241.0,1241,0.875,0.0,0.0,0.0,0.0,0.0,1241,21750.0,0.0,-3090.198488704966,-3090.198488704966,2530639.9080624403,700.0,868700.0,5.452508255444662,1251567.9868889104,-3286.0989814374707,2628.879188678109,0.0,0.0,252.1281462596736,1276393.697855358,-61.68016178261377,49.34412949231963,-0.0,-4965032.540626674,true,true,1.788189012,11316.732978622955,0.0,121.92,1644.2724500334996,1241.0,1.788189012,11316.732978622955,0.0,121.92,0.0,295.15 +1242,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,869400.0,5833.333333333334,24720878.02062407,5833.333333333334,19046555.117050886,true,1242.0,1242,0.875,0.0,0.0,0.0,0.0,0.0,1242,21750.0,0.0,-1466.66164528917,-1466.66164528917,2529173.2464171513,700.0,869400.0,1.4973950798833795,1251569.4842839902,-1601.9732565196732,1026.905932158436,0.0,0.0,163.8832950772476,1276557.5811504351,-30.069078926627657,19.275050565691974,-0.0,-4965032.540626674,true,true,1.117618132,11317.850596754955,0.0,121.92,1644.2724500334996,1242.0,1.117618132,11317.850596754955,0.0,121.92,0.0,295.15 +1243,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,870100.0,5833.333333333334,24726711.353957403,5833.333333333334,19052388.45038422,true,1243.0,1243,0.875,0.0,0.0,0.0,0.0,0.0,1243,21750.0,0.0,-883.3007190800487,-883.3007190800487,2528289.9456980713,700.0,870100.0,0.1786677904094994,1251569.6629517807,-946.3965070568084,80.50942510162747,0.0,0.0,80.68100678730396,1276638.2621572225,-17.763886600953644,1.51116396473833,-0.0,-4965032.540626674,true,true,0.312933077,11318.163529831956,0.0,121.92,1644.2724500334996,1243.0,0.312933077,11318.163529831956,0.0,121.92,0.0,295.15 +1244,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,870800.0,5833.333333333334,24732544.687290736,5833.333333333334,19058221.78371755,true,1244.0,1244,0.875,0.0,0.0,0.0,0.0,0.0,1244,21750.0,0.0,-64.36974861973837,-64.36974861973837,2528225.5759494514,700.0,870800.0,0.0018702103310796435,1251569.664821991,-80.50942510181822,-1.907523028421565e-10,0.0,0.0,17.648970236485194,1276655.911127459,-1.511163964736424,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1244.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1245,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,871500.0,5833.333333333334,24738378.020624068,5833.333333333334,19064055.117050882,true,1245.0,1245,0.875,0.0,0.0,0.0,0.0,0.0,1245,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,871500.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1245.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1246,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,872200.0,5833.333333333334,24744211.3539574,5833.333333333334,19069888.450384215,true,1246.0,1246,0.875,0.0,0.0,0.0,0.0,0.0,1246,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,872200.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1246.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1247,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,872900.0,5833.333333333334,24750044.68729073,5833.333333333334,19075721.783717547,true,1247.0,1247,0.875,0.0,0.0,0.0,0.0,0.0,1247,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,872900.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1247.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1248,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,873600.0,5833.333333333334,24755878.020624064,5833.333333333334,19081555.11705088,true,1248.0,1248,0.875,0.0,0.0,0.0,0.0,0.0,1248,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,873600.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1248.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1249,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,874300.0,5833.333333333334,24761711.353957396,5833.333333333334,19087388.45038421,true,1249.0,1249,0.875,0.0,0.0,0.0,0.0,0.0,1249,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,874300.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1249.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1250,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,875000.0,5833.333333333334,24767544.687290728,5833.333333333334,19093221.783717543,true,1250.0,1250,0.875,0.0,0.0,0.0,0.0,0.0,1250,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,875000.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1250.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1251,22450.0,21750.0,0.12,0.0,5674322.903573348,700.0,875700.0,5833.333333333334,24773378.02062406,5833.333333333334,19099055.117050875,true,1251.0,1251,0.875,0.0,0.0,0.0,0.0,0.0,1251,21750.0,0.0,0.0,0.0,2528225.5759494514,700.0,875700.0,0.0,1251569.664821991,0.0,-1.907523028421565e-10,0.0,0.0,0.0,1276655.911127459,0.0,1.9060308886764687e-12,-0.0,-4965032.540626674,true,true,0.0,11318.163529831956,0.0,121.92,1644.2724500334996,1251.0,0.0,11318.163529831956,0.0,121.92,0.0,295.15 +1252,22450.0,21750.0,0.128,220.12254231489132,5674543.026115663,700.0,876400.0,7188.457361835089,24780566.477985896,6968.334819520197,19106023.451870397,true,1252.0,1252,0.875,192.60722452552992,220.12254231489132,27.515317789361404,0.0,0.0,1252,21750.0,0.0,192.60722452552992,192.60722452552992,2528418.183173977,700.0,876400.0,0.005452508259103674,1251569.6702744993,164.30494929239373,164.304949292203,0.0,0.0,25.212814631607213,1276681.1239420907,3.084008093269858,3.084008093271764,-192.60722452552992,-4965225.1478512,true,true,0.447047253,11318.610577084955,0.0,121.92,1644.2724500334996,1252.0,0.447047253,11318.610577084955,0.0,121.92,0.0,295.15 +1253,22670.12254231489,21970.12254231489,0.12,57.679142090614,5674600.705257754,700.0,877100.0,6313.992850755118,24786880.47083665,6256.313708664504,19112279.76557906,true,1253.0,1253,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1253,21970.12254231489,0.0,50.46924932928725,50.46924932928725,2528468.652423306,700.0,877100.0,0.043620066072829394,1251569.7138945654,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276731.549571354,0.0,3.084008093271764,-50.46924932928725,-4965275.617100529,true,true,0.447047253,11319.057624337955,0.0,121.92,1644.2724500334996,1253.0,0.447047253,11319.057624337955,0.0,121.92,0.0,295.15 +1254,22507.679142090616,21807.679142090616,0.12,57.679142090614,5674658.384399844,700.0,877800.0,6313.992850755118,24793194.463687405,6256.313708664504,19118536.079287723,true,1254.0,1254,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1254,21807.679142090616,0.0,50.46924932928725,50.46924932928725,2528519.121672635,700.0,877800.0,0.043620066072829394,1251569.7575146314,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276781.9752006172,0.0,3.084008093271764,-50.46924932928725,-4965326.086349859,true,true,0.447047253,11319.504671590954,0.0,121.92,1644.2724500334996,1254.0,0.447047253,11319.504671590954,0.0,121.92,0.0,295.15 +1255,22507.679142090616,21807.679142090616,0.12,57.679142090614,5674716.063541935,700.0,878500.0,6313.992850755118,24799508.45653816,6256.313708664504,19124792.392996386,true,1255.0,1255,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1255,21807.679142090616,0.0,50.46924932928725,50.46924932928725,2528569.590921964,700.0,878500.0,0.043620066072829394,1251569.8011346974,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276832.4008298805,0.0,3.084008093271764,-50.46924932928725,-4965376.555599188,true,true,0.447047253,11319.951718843953,0.0,121.92,1644.2724500334996,1255.0,0.447047253,11319.951718843953,0.0,121.92,0.0,295.15 +1256,22507.679142090616,21807.679142090616,0.12,57.679142090614,5674773.742684025,700.0,879200.0,6313.992850755118,24805822.449388914,6256.313708664504,19131048.70670505,true,1256.0,1256,0.875,50.46924932928725,57.679142090614,7.209892761326749,0.0,0.0,1256,21807.679142090616,0.0,50.46924932928725,50.46924932928725,2528620.060171293,700.0,879200.0,0.043620066072829394,1251569.8447547634,0.0,164.304949292203,0.0,0.0,50.425629263214425,1276882.8264591438,0.0,3.084008093271764,-50.46924932928725,-4965427.024848518,true,true,0.447047253,11320.398766096952,0.0,121.92,1644.2724500334996,1256.0,0.447047253,11320.398766096952,0.0,121.92,0.0,295.15 +1257,22507.679142090616,21807.679142090616,0.132,373.4582001142193,5675147.200884139,700.0,879900.0,8132.259091774389,24813954.70848069,7758.80089166017,19138807.50759671,true,1257.0,1257,0.875,326.7759250999419,373.4582001142193,46.68227501427742,0.0,0.0,1257,21807.679142090616,0.0,326.7759250999419,326.7759250999419,2528946.836096393,700.0,879900.0,0.09583328521147606,1251569.9405880487,256.3157211313559,420.62067042355886,0.0,0.0,65.55331805345847,1276948.3797771973,4.8110526299160945,7.895060723187859,-326.7759250999419,-4965753.800773618,true,true,0.715275605,11321.114041701952,0.0,121.92,1644.2724500334996,1257.0,0.715275605,11321.114041701952,0.0,121.92,0.0,295.15 +1258,22823.45820011422,22123.45820011422,0.16,1365.1366376968836,5676512.337521836,700.0,880600.0,12907.103985605521,24826861.812466294,11541.967347908638,19150349.474944618,true,1258.0,1258,0.875,1194.494557984773,1365.1366376968836,170.64207971211044,0.0,0.0,1258,22123.45820011422,0.0,1194.494557984773,1194.494557984773,2530141.3306543776,700.0,880600.0,0.5307253440629649,1251570.4713133927,1058.1238732077943,1478.7445436313533,0.0,0.0,115.97894731667289,1277064.358724514,19.861012116242772,27.75607283943063,-1194.494557984773,-4966948.295331603,true,true,1.341141759,11322.455183460952,0.0,121.92,1644.2724500334996,1258.0,1.341141759,11322.455183460952,0.0,121.92,0.0,295.15 +1259,23815.136637696884,23115.136637696884,0.1648,1542.9515593757349,5678055.289081212,700.0,881300.0,13610.142957377033,24840471.95542367,12067.191398001298,19162416.66634262,true,1259.0,1259,0.875,1350.082614453768,1542.9515593757349,192.8689449219669,0.0,0.0,1259,23115.136637696884,0.0,1350.082614453768,1350.082614453768,2531491.4132688316,700.0,881300.0,1.8702103328725608,1251572.3415237255,1150.1346450467558,2628.879188678109,0.0,0.0,176.4897024212505,1277240.8484269353,21.588056652889,49.34412949231963,-1350.082614453768,-4968298.377946056,true,true,1.788189012,11324.243372472953,0.0,121.92,1644.2724500334996,1259.0,1.788189012,11324.243372472953,0.0,121.92,0.0,295.15 +1260,23992.951559375735,23292.951559375735,0.17200000000000001,1985.5895118544438,5680040.878593067,700.0,882000.0,15613.89251078165,24856085.847934455,13628.302998927207,19176044.969341546,true,1260.0,1260,0.875,1737.3908228726384,1985.5895118544438,248.1986889818054,0.0,0.0,1260,23292.951559375735,0.0,1737.3908228726384,1737.3908228726384,2533228.804091704,700.0,882000.0,3.974878517922778,1251576.3164022435,1478.7445399562066,4107.623728634316,0.0,0.0,226.91533162806638,1277467.7637585634,27.756072770442543,77.10020226276217,-1737.3908228726384,-4970035.768768929,true,true,2.235236264,11326.478608736952,0.0,121.92,1644.2724500334996,1260.0,2.235236264,11326.478608736952,0.0,121.92,0.0,295.15 +1261,24435.589511854443,23735.589511854443,0.1936,3144.818281742082,5683185.6968748085,700.0,882700.0,19859.598562717365,24875945.446497172,16714.780280975283,19192759.74962252,true,1261.0,1261,0.875,2751.715996524322,3144.818281742082,393.10228521776025,0.0,0.0,1261,23735.589511854443,0.0,2751.715996524322,2751.715996524322,2535980.5200882284,700.0,882700.0,7.867407800658743,1251584.183810044,2413.6397046127686,6521.263433247084,0.0,0.0,284.9048052300043,1277752.6685637934,45.30407888089005,122.40428114365221,-2751.715996524322,-4972787.484765453,true,true,2.816397693,11329.295006429953,0.0,121.92,1644.2724500334996,1261.0,2.816397693,11329.295006429953,0.0,121.92,0.0,295.15 +1262,25594.818281742082,24894.818281742082,0.22,5080.814930548649,5688266.511805357,700.0,883400.0,26276.43150249386,24902221.877999667,21195.61657194521,19213955.366194464,true,1262.0,1262,0.875,4445.713064230067,5080.814930548649,635.1018663185814,0.0,0.0,1262,24894.818281742082,0.0,4445.713064230067,4445.713064230067,2540426.2331524584,700.0,883400.0,15.944262804612375,1251600.1280728488,3994.2533155853857,10515.51674883247,0.0,0.0,360.54324912482593,1278113.2118129183,74.97223671524274,197.37651785889494,-4445.713064230067,-4977233.197829683,true,true,3.576378023,11332.871384452954,0.0,121.92,1644.2724500334996,1262.0,3.576378023,11332.871384452954,0.0,121.92,0.0,295.15 +1263,27530.814930548648,26830.814930548648,0.28,7441.865320897917,5695708.377126255,700.0,884100.0,29078.09043177827,24931299.968431447,21636.225110880354,19235591.591305345,true,1263.0,1263,0.875,6511.632155785677,7441.865320897917,930.2331651122395,0.0,0.0,1263,26830.814930548648,0.0,6511.632155785677,6511.632155785677,2546937.8653082442,700.0,884100.0,31.799028143382223,1251631.927100992,5914.978173056042,16430.494921888512,0.0,0.0,453.83066325613277,1278567.0424761744,111.0242913301204,308.4008091890154,-6511.632155785677,-4983744.829985469,true,true,4.470472529,11337.341856981953,0.0,121.92,1644.2724500334996,1263.0,4.470472529,11337.341856981953,0.0,121.92,0.0,295.15 +1264,29891.865320897916,29191.865320897916,0.184,2605.2269130071954,5698313.604039262,700.0,884800.0,17963.189744604322,24949263.15817605,15357.962831597128,19250949.554136943,true,1264.0,1264,0.875,2279.573548881296,2605.2269130071954,325.6533641258993,0.0,0.0,1264,29191.865320897916,0.0,2279.573548881296,2279.573548881296,2549217.4388571256,700.0,884800.0,46.974040177268016,1251678.9011411692,1684.1257260203947,18114.62064790891,0.0,0.0,516.8626998069515,1279083.9051759813,31.611082876681838,340.0118920656972,-2279.573548881296,-4986024.40353435,true,true,4.693996155,11342.035853136953,0.0,121.92,1644.2724500334996,1264.0,4.693996155,11342.035853136953,0.0,121.92,0.0,295.15 +1265,25055.226913007195,24355.226913007195,0.12,0.0,5698313.604039262,700.0,885500.0,5833.333333333334,24955096.49150938,5833.333333333334,19256782.887470275,true,1265.0,1265,0.875,0.0,0.0,0.0,0.0,0.0,1265,24355.226913007195,0.0,-2799.9027880981075,-2799.9027880981075,2546417.5360690276,700.0,885500.0,43.62006602892123,1251722.5212071983,-3286.098984745276,14828.521663163632,0.0,0.0,504.25629246294864,1279588.1614684444,-61.680161844701246,278.33173022099595,-0.0,-4986024.40353435,true,true,4.246948902,11346.282802038953,0.0,121.92,1644.2724500334996,1265.0,4.246948902,11346.282802038953,0.0,121.92,0.0,295.15 +1266,22450.0,21750.0,0.12,0.0,5698313.604039262,700.0,886200.0,5833.333333333334,24960929.824842714,5833.333333333334,19262616.220803607,true,1266.0,1266,0.875,0.0,0.0,0.0,0.0,0.0,1266,21750.0,0.0,-2527.371534053781,-2527.371534053781,2543890.164534974,700.0,886200.0,31.799028143382202,1251754.3202353416,-2957.489079912411,11871.03258325122,0.0,0.0,453.83066325613265,1280041.9921317005,-55.51214554088505,222.8195846801109,-0.0,-4986024.40353435,true,true,3.79990165,11350.082703688953,0.0,121.92,1644.2724500334996,1266.0,3.79990165,11350.082703688953,0.0,121.92,0.0,295.15 +1267,22450.0,21750.0,0.12,0.0,5698313.604039262,700.0,886900.0,5833.333333333334,24966763.158176046,5833.333333333334,19268449.55413694,true,1267.0,1267,0.875,0.0,0.0,0.0,0.0,0.0,1267,21750.0,0.0,-1996.7848292853987,-1996.7848292853987,2541893.3797056885,700.0,886900.0,22.75484910773055,1251777.0750844493,-2380.778716591958,9490.253866659263,0.0,0.0,405.926315495558,1280447.918447196,-44.68727729672922,178.13230738338166,-0.0,-4986024.40353435,true,true,3.397559122,11353.480262810954,0.0,121.92,1644.2724500334996,1267.0,3.397559122,11353.480262810954,0.0,121.92,0.0,295.15 +1268,22450.0,21750.0,0.20800000000000002,4264.863480091449,5702578.467519353,700.0,887600.0,23869.535961978116,24990632.694138024,19604.672481886668,19288054.226618826,true,1268.0,1268,0.875,3731.7555450800173,4264.863480091449,533.1079350114314,0.0,0.0,1268,21750.0,0.0,3731.7555450800173,3731.7555450800173,2545625.1352507686,700.0,887600.0,24.050708568792974,1251801.1257930181,3233.5213974874864,12723.775264146749,0.0,0.0,413.4901598342815,1280861.4086070303,60.69327918945601,238.82558657283766,-3731.7555450800173,-4989756.15907943,true,true,3.934015825,11357.414278635953,0.0,121.92,1644.2724500334996,1268.0,3.934015825,11357.414278635953,0.0,121.92,0.0,295.15 +1269,26714.863480091448,26014.863480091448,0.29250000000000004,8952.001395125086,5711530.468914478,700.0,888300.0,32998.29536794901,25023630.989505973,24046.29397282392,19312100.52059165,true,1269.0,1269,0.875,7833.001220734451,8952.001395125086,1119.000174390635,0.0,0.0,1269,26014.863480091448,0.0,7833.001220734451,7833.001220734451,2553458.136471503,700.0,888300.0,42.32450645597278,1251843.4502994742,7157.123592146964,19880.898856293712,0.0,0.0,499.21372957046634,1281360.6223366007,134.33939256104742,373.1649791338851,-7833.001220734451,-4997589.1603001645,true,true,4.917519782,11362.331798417954,0.0,121.92,1644.2724500334996,1269.0,4.917519782,11362.331798417954,0.0,121.92,0.0,295.15 +1270,31402.001395125088,30702.001395125088,0.33999999999999997,15165.357267266652,5726695.826181745,700.0,889000.0,46662.81549196075,25070293.804997932,31497.458224694095,19343597.978816345,true,1270.0,1270,0.875,13269.687608858321,15165.357267266652,1895.669658408331,0.0,0.0,1270,30702.001395125088,0.0,13269.687608858321,13269.687608858321,2566727.824080361,700.0,889000.0,85.19544150275728,1251928.645740977,12322.871194724332,32203.770051018044,0.0,0.0,630.3203656773833,1281990.942702278,231.3006069538478,604.4655860877328,-13269.687608858321,-5010858.847909023,true,true,6.258661541,11368.590459958954,0.0,121.92,1644.2724500334996,1270.0,6.258661541,11368.590459958954,0.0,121.92,0.0,295.15 +1271,37615.35726726665,36915.35726726665,0.35,18869.94965570459,5745565.775837449,700.0,889700.0,55914.14187344169,25126207.946871374,37044.1922177371,19380642.171034083,true,1271.0,1271,0.875,16511.205948741517,18869.94965570459,2358.7437069630723,0.0,0.0,1271,36915.35726726665,0.0,16511.205948741517,16511.205948741517,2583239.0300291027,700.0,889700.0,162.4356734414682,1252091.0814144185,15280.360269491268,47484.13032050931,0.0,0.0,781.597253410628,1282772.5399556886,286.81275239815193,891.2783384858848,-16511.205948741517,-5027370.053857764,true,true,7.599803299,11376.190263257953,0.0,121.92,1644.2724500334996,1271.0,7.599803299,11376.190263257953,0.0,121.92,0.0,295.15 +1272,41319.94965570459,40619.94965570459,0.35,18811.028439606307,5764376.804277056,700.0,890400.0,55745.79554173231,25181953.742413107,36934.767102126,19417576.93813621,true,1272.0,1272,0.875,16459.64988465552,18811.028439606307,2351.3785549507884,0.0,0.0,1272,40619.94965570459,0.0,16459.64988465552,16459.64988465552,2599698.6799137583,700.0,890400.0,265.13980045960426,1252356.2212148781,14992.82661208868,62476.956932598,0.0,0.0,920.2677337998698,1283692.8076894884,281.41573830736536,1172.6940767932501,-16459.64988465552,-5043829.703742419,true,true,8.717421431,11384.907684688953,0.0,121.92,1644.2724500334996,1272.0,8.717421431,11384.907684688953,0.0,121.92,0.0,295.15 +1273,41261.02843960631,40561.02843960631,0.33,13202.524529721035,5777579.328806777,700.0,891100.0,42128.86221127586,25224082.604624383,28926.337681554825,19446503.275817763,true,1273.0,1273,0.875,11552.208963505906,13202.524529721035,1650.3155662151294,0.0,0.0,1273,40561.02843960631,0.0,11552.208963505906,11552.208963505906,2611250.888877264,700.0,891100.0,362.21080494571305,1252718.432019824,9981.525674474618,72458.48260707261,0.0,0.0,1021.1189923262987,1284713.9266818147,187.353491759275,1360.047568552525,-11552.208963505906,-5055381.912705925,true,true,9.387992311,11394.295676999953,0.0,121.92,1644.2724500334996,1273.0,9.387992311,11394.295676999953,0.0,121.92,0.0,295.15 +1274,35652.524529721035,34952.524529721035,0.28625,8271.99772761489,5785851.326534391,700.0,891800.0,31343.223502584766,25255425.828126967,23071.225774969877,19469574.501592733,true,1274.0,1274,0.875,7237.998011663029,8271.99772761489,1033.9997159518607,0.0,0.0,1274,34952.524529721035,0.0,7237.998011663029,7237.998011663029,2618488.8868889273,700.0,891800.0,427.4916525215372,1253145.9236723455,5625.801456185683,78084.2840632583,0.0,0.0,1079.1084659846351,1285793.0351477994,105.5964369711729,1465.6440055236978,-7237.998011663029,-5062619.910717588,true,true,9.745630113,11404.041307112953,0.0,121.92,1644.2724500334996,1274.0,9.745630113,11404.041307112953,0.0,121.92,0.0,295.15 +1275,30721.99772761489,30021.99772761489,0.22,5165.572517304946,5791016.899051696,700.0,892500.0,26661.693260477026,25282087.521387443,21496.12074317208,19491070.622335903,true,1275.0,1275,0.875,4519.875952641828,5165.572517304946,645.6965646631179,0.0,0.0,1275,30021.99772761489,0.0,4519.875952641828,4519.875952641828,2623008.7628415693,700.0,892500.0,464.4664631892949,1253610.3901355348,2891.7671035767644,80976.05116683507,0.0,0.0,1109.3638435087248,1286902.3989913082,54.27854236704434,1519.9225478907422,-4519.875952641828,-5067139.786670229,true,true,9.924449014,11413.965756126954,0.0,121.92,1644.2724500334996,1275.0,9.924449014,11413.965756126954,0.0,121.92,0.0,295.15 +1276,27615.572517304947,26915.572517304947,0.29250000000000004,8795.33494910062,5799812.234000796,700.0,893200.0,32462.68358666878,25314550.20497411,23667.34863756816,19514737.970973473,true,1276.0,1276,0.875,7695.918080463041,8795.33494910062,1099.4168686375779,0.0,0.0,1276,26915.572517304947,0.0,7695.918080463041,7695.918080463041,2630704.6809220323,700.0,893200.0,503.5140996906904,1254113.9042352254,5941.267025747592,86917.31819258266,0.0,0.0,1139.6192212584083,1288042.0182125666,111.51773376635083,1631.440281657093,-7695.918080463041,-5074835.7047506925,true,true,10.28208682,11424.247842946954,0.0,121.92,1644.2724500334996,1276.0,10.28208682,11424.247842946954,0.0,121.92,0.0,295.15 +1277,31245.33494910062,30545.33494910062,0.28,7322.145479677999,5807134.379480475,700.0,893900.0,28650.519570278564,25343200.72454439,21328.374090600566,19536066.345064074,true,1277.0,1277,0.875,6406.877294718249,7322.145479677999,915.2681849597502,0.0,0.0,1277,30545.33494910062,0.0,6406.877294718249,6406.877294718249,2637111.5582167506,700.0,893900.0,551.7649157333773,1254665.6691509588,4593.9663514306985,91511.28454401337,0.0,0.0,1174.917161844176,1289216.9353744108,86.22886570999675,1717.6691473670899,-6406.877294718249,-5081242.582045411,true,true,10.55031517,11434.798158116953,0.0,121.92,1644.2724500334996,1277.0,10.55031517,11434.798158116953,0.0,121.92,0.0,295.15 +1278,29772.145479677998,29072.145479677998,0.265,6613.30944273073,5813747.688923205,700.0,894600.0,27597.394123512186,25370798.118667904,20984.084680781456,19557050.429744855,true,1278.0,1278,0.875,5786.645762389388,6613.30944273073,826.6636803413412,0.0,0.0,1278,29072.145479677998,0.0,5786.645762389388,5786.645762389388,2642898.20397914,700.0,894600.0,591.7679888796802,1255257.4371398385,3918.672925181243,95429.9574691946,0.0,0.0,1202.6512574708356,1290419.5866318818,73.55359085763014,1791.22273822472,-5786.645762389388,-5087029.2278078,true,true,10.77383879,11445.571996906954,0.0,121.92,1644.2724500334996,1278.0,10.77383879,11445.571996906954,0.0,121.92,0.0,295.15 +1279,29063.30944273073,28363.30944273073,0.25,5834.610917173108,5819582.299840379,700.0,895300.0,26138.44366869243,25396936.562336598,20303.832751519323,19577354.262496375,true,1279.0,1279,0.875,5105.284552526469,5834.610917173108,729.3263646466385,0.0,0.0,1279,28363.30944273073,0.0,5105.284552526469,5105.284552526469,2648003.488531667,700.0,895300.0,625.9002709116223,1255883.33741075,3194.088370578286,98624.0458397729,0.0,0.0,1225.3427907689988,1291644.9294226507,59.953120267562525,1851.1758584922825,-5105.284552526469,-5092134.512360327,true,true,10.9526577,11456.524654606954,0.0,121.92,1644.2724500334996,1279.0,10.9526577,11456.524654606954,0.0,121.92,0.0,295.15 +1280,28284.610917173108,27584.610917173108,0.1744,2145.040070350624,5821727.339910729,700.0,896000.0,16313.303155680183,25413249.865492277,14168.26308532956,19591522.525581703,true,1280.0,1280,0.875,1876.9100615567959,2145.040070350624,268.130008793828,0.0,0.0,1280,27584.610917173108,0.0,1876.9100615567959,1876.9100615567959,2649880.3985932237,700.0,896000.0,641.4821444388471,1256524.819555189,0.0,98624.0458397729,0.0,0.0,1235.427917117949,1292880.3573397687,0.0,1851.1758584922825,-1876.9100615567959,-5094011.422421884,true,true,10.9526577,11467.477312306954,0.0,121.92,1644.2724500334996,1280.0,10.9526577,11467.477312306954,0.0,121.92,0.0,295.15 +1281,24595.040070350624,23895.040070350624,0.12,0.0,5821727.339910729,700.0,896700.0,5833.333333333334,25419083.19882561,5833.333333333334,19597355.858915035,true,1281.0,1281,0.875,0.0,0.0,0.0,0.0,0.0,1281,23895.040070350624,0.0,-2214.3161367117764,-2214.3161367117764,2647666.082456512,700.0,896700.0,622.0446337520815,1257146.864188941,-3984.395082637499,94639.6507571354,0.0,0.0,1222.8215096047506,1294103.1788493735,-74.78719743110983,1776.3886610611726,-0.0,-5094011.422421884,true,true,10.72913407,11478.206446376953,0.0,121.92,1644.2724500334996,1281.0,10.72913407,11478.206446376953,0.0,121.92,0.0,295.15 +1282,22450.0,21750.0,0.12,0.0,5821727.339910729,700.0,897400.0,5833.333333333334,25424916.53215894,5833.333333333334,19603189.192248367,true,1282.0,1282,0.875,0.0,0.0,0.0,0.0,0.0,1282,21750.0,0.0,-2193.5235712144777,-2193.5235712144777,2645472.5588852973,700.0,897400.0,584.3555329619527,1257731.2197219029,-3902.2426054185994,90737.40815171681,0.0,0.0,1197.6086945783534,1295300.7875439518,-73.24519333618417,1703.1434677249883,-0.0,-5094011.422421884,true,true,10.50561044,11488.712056816952,0.0,121.92,1644.2724500334996,1282.0,10.50561044,11488.712056816952,0.0,121.92,0.0,295.15 +1283,22450.0,21750.0,0.17200000000000001,2001.2549156125392,5823728.594826342,700.0,898100.0,15704.970439607785,25440621.50259855,13703.715523995246,19616892.907772362,true,1283.0,1283,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1283,21750.0,0.0,1751.0980511609719,1751.0980511609719,2647223.6569364583,700.0,898100.0,566.0957640958169,1258297.3154859988,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1296485.789831017,0.0,1703.1434677249883,-1751.0980511609719,-5095762.520473044,true,true,10.50561044,11499.217667256951,0.0,121.92,1644.2724500334996,1283.0,10.50561044,11499.217667256951,0.0,121.92,0.0,295.15 +1284,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5825729.849741954,700.0,898800.0,15704.970439607785,25456326.47303816,13703.715523995246,19630596.623296358,true,1284.0,1284,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1284,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2648974.7549876194,700.0,898800.0,566.0957640958169,1258863.4112500947,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1297670.792118082,0.0,1703.1434677249883,-1751.0980511609719,-5097513.618524205,true,true,10.50561044,11509.72327769695,0.0,121.92,1644.2724500334996,1284.0,10.50561044,11509.72327769695,0.0,121.92,0.0,295.15 +1285,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5827731.104657567,700.0,899500.0,15704.970439607785,25472031.44347777,13703.715523995246,19644300.338820353,true,1285.0,1285,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1285,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2650725.8530387804,700.0,899500.0,566.0957640958169,1259429.5070141905,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1298855.7944051472,0.0,1703.1434677249883,-1751.0980511609719,-5099264.7165753655,true,true,10.50561044,11520.22888813695,0.0,121.92,1644.2724500334996,1285.0,10.50561044,11520.22888813695,0.0,121.92,0.0,295.15 +1286,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5829732.35957318,700.0,900200.0,15704.970439607785,25487736.413917378,13703.715523995246,19658004.05434435,true,1286.0,1286,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1286,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2652476.9510899414,700.0,900200.0,566.0957640958169,1259995.6027782864,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1300040.7966922123,0.0,1703.1434677249883,-1751.0980511609719,-5101015.814626526,true,true,10.50561044,11530.734498576949,0.0,121.92,1644.2724500334996,1286.0,10.50561044,11530.734498576949,0.0,121.92,0.0,295.15 +1287,24451.25491561254,23751.25491561254,0.17200000000000001,2001.2549156125392,5831733.614488793,700.0,900900.0,15704.970439607785,25503441.384356987,13703.715523995246,19671707.769868344,true,1287.0,1287,0.875,1751.0980511609719,2001.2549156125392,250.15686445156734,0.0,0.0,1287,23751.25491561254,0.0,1751.0980511609719,1751.0980511609719,2654228.0491411025,700.0,900900.0,566.0957640958169,1260561.6985423823,0.0,90737.40815171681,0.0,0.0,1185.002287065155,1301225.7989792775,0.0,1703.1434677249883,-1751.0980511609719,-5102766.912677687,true,true,10.50561044,11541.240109016948,0.0,121.92,1644.2724500334996,1287.0,10.50561044,11541.240109016948,0.0,121.92,0.0,295.15 +1288,24451.25491561254,23751.25491561254,0.265,6579.945172908674,5838313.559661701,700.0,901600.0,27471.491218523297,25530912.87557551,20891.546045614625,19692599.31591396,true,1288.0,1288,0.875,5757.45202629509,6579.945172908674,822.493146613584,0.0,0.0,1288,23751.25491561254,0.0,5757.45202629509,5757.45202629509,2659985.5011673975,700.0,901600.0,584.3555329619527,1261146.0540753442,3902.2426054185994,94639.6507571354,0.0,0.0,1197.6086945783534,1302423.4076738558,73.24519333618417,1776.3886610611726,-5757.45202629509,-5108524.364703982,true,true,10.72913407,11551.969243086947,0.0,121.92,1644.2724500334996,1288.0,10.72913407,11551.969243086947,0.0,121.92,0.0,295.15 +1289,29029.945172908672,28329.945172908672,0.1912,2999.6086809773187,5841313.168342679,700.0,902300.0,19349.417787538277,25550262.293363046,16349.809106560959,19708949.125020523,true,1289.0,1289,0.875,2624.657595855154,2999.6086809773187,374.95108512216484,0.0,0.0,1289,28329.945172908672,0.0,2624.657595855154,2624.657595855154,2662610.1587632527,700.0,902300.0,606.7804233765929,1261752.834498721,790.306712059213,95429.95746919462,0.0,0.0,1212.7363832558005,1303636.1440571116,14.834077163547308,1791.22273822472,-2624.657595855154,-5111149.022299837,true,true,10.77383879,11562.743081876948,0.0,121.92,1644.2724500334996,1289.0,10.77383879,11562.743081876948,0.0,121.92,0.0,295.15 +1290,25449.60868097732,24749.60868097732,0.25,5834.610917173108,5847147.779259852,700.0,903000.0,26138.44366869243,25576400.73703174,20303.832751519323,19729252.957772043,true,1290.0,1290,0.875,5105.284552526469,5834.610917173108,729.3263646466385,0.0,0.0,1290,24749.60868097732,0.0,5105.284552526469,5105.284552526469,2667715.4433157793,700.0,903000.0,625.9002709116223,1262378.7347696326,3194.088370578286,98624.04583977291,0.0,0.0,1225.3427907689988,1304861.4868478805,59.953120267562525,1851.1758584922825,-5105.284552526469,-5116254.306852364,true,true,10.9526577,11573.695739576948,0.0,121.92,1644.2724500334996,1290.0,10.9526577,11573.695739576948,0.0,121.92,0.0,295.15 +1291,28284.610917173108,27584.610917173108,0.20800000000000002,4042.225076533021,5851190.004336385,700.0,903700.0,22799.159021793366,25599199.896053534,18756.933945260345,19748009.891717304,true,1291.0,1291,0.875,3536.9469419663933,4042.225076533021,505.2781345666276,0.0,0.0,1291,27584.610917173108,0.0,3536.9469419663933,3536.9469419663933,2671252.3902577455,700.0,903700.0,649.3691321545542,1263028.1039017872,1616.7606903639685,100240.80653013688,0.0,0.0,1240.4704800104312,1306101.957327891,30.346639437439478,1881.522497929722,-3536.9469419663933,-5119791.25379433,true,true,11.04206715,11584.737806726947,0.0,121.92,1644.2724500334996,1291.0,11.04206715,11584.737806726947,0.0,121.92,0.0,295.15 +1292,26492.22507653302,25792.22507653302,0.22,5049.388550174555,5856239.3928865595,700.0,904400.0,26133.584318975252,25625333.48037251,21084.195768800695,19769094.087486103,true,1292.0,1292,0.875,4418.214981402736,5049.388550174555,631.1735687718192,0.0,0.0,1292,25792.22507653302,0.0,4418.214981402736,4418.214981402736,2675670.6052391483,700.0,904400.0,669.368850078189,1263697.4727518654,2449.7866857256167,102690.5932158625,0.0,0.0,1253.0768869596443,1307355.0342148505,45.98255863928627,1927.5050565690083,-4418.214981402736,-5124209.468775732,true,true,11.17618132,11595.913988046947,0.0,121.92,1644.2724500334996,1292.0,11.17618132,11595.913988046947,0.0,121.92,0.0,295.15 +1293,27499.388550174554,26799.388550174554,0.25,6106.673689892849,5862346.066576452,700.0,905100.0,27226.694759571397,25652560.17513208,21120.021069678547,19790214.108555783,true,1293.0,1293,0.875,5343.339478656243,6106.673689892849,763.3342112366063,0.0,0.0,1293,26799.388550174554,0.0,5343.339478656243,5343.339478656243,2681013.9447178044,700.0,905100.0,698.0522652830352,1264395.5250171483,3312.3877538596817,106002.98096972218,0.0,0.0,1270.7258568013397,1308625.7600716518,62.173602712186515,1989.6786592811948,-5343.339478656243,-5129552.808254389,true,true,11.35500022,11607.268988266947,0.0,121.92,1644.2724500334996,1293.0,11.35500022,11607.268988266947,0.0,121.92,0.0,295.15 +1294,28556.67368989285,27856.67368989285,0.20800000000000002,4247.430365968618,5866593.4969424205,700.0,905800.0,23785.722913310663,25676345.89804539,19538.292547342044,19809752.401103124,true,1294.0,1294,0.875,3716.5015702225414,4247.430365968618,530.928795746077,0.0,0.0,1294,27856.67368989285,0.0,3716.5015702225414,3716.5015702225414,2684730.446288027,700.0,905800.0,723.2806718411389,1265118.8056889896,1675.9104705802972,107678.89144030248,0.0,0.0,1285.8535454787868,1309911.6136171306,31.456882322318386,2021.135541603513,-3716.5015702225414,-5133269.309824612,true,true,11.44440967,11618.713397936948,0.0,121.92,1644.2724500334996,1294.0,11.44440967,11618.713397936948,0.0,121.92,0.0,295.15 +1295,26697.43036596862,25997.43036596862,0.196,3300.848581137842,5869894.345523559,700.0,906500.0,20412.492760907357,25696758.3908063,17111.644179769515,19826864.045282893,true,1295.0,1295,0.875,2888.2425084956117,3300.848581137842,412.6060726422302,0.0,0.0,1295,25997.43036596862,0.0,2888.2425084956117,2888.2425084956117,2687618.6887965226,700.0,906500.0,736.1196770615325,1265854.925366051,842.8844781589164,108521.7759184614,0.0,0.0,1293.417390099503,1311205.03100723,15.820963175659735,2036.9565047791727,-2888.2425084956117,-5136157.552333107,true,true,11.4891144,11630.202512336948,0.0,121.92,1644.2724500334996,1295.0,11.4891144,11630.202512336948,0.0,121.92,0.0,295.15 +1296,25750.84858113784,25050.84858113784,0.23500000000000001,5317.918614905628,5875212.264138464,700.0,907200.0,25608.16431874735,25722366.555125047,20290.24570384172,19847154.290986735,true,1296.0,1296,0.875,4653.1787880424245,5317.918614905628,664.7398268632032,0.0,0.0,1296,25050.84858113784,0.0,4653.1787880424245,4653.1787880424245,2692271.867584565,700.0,907200.0,753.4734631851496,1266608.3988292362,2548.369841420113,111070.1457598815,0.0,0.0,1303.5025164484532,1312508.5335236785,47.832966988708876,2084.7894717678814,-4653.1787880424245,-5140810.73112115,true,true,11.62322858,11641.825740916947,0.0,121.92,1644.2724500334996,1296.0,11.62322858,11641.825740916947,0.0,121.92,0.0,295.15 +1297,27767.918614905626,27067.918614905626,0.20800000000000002,4387.652715316127,5879599.91685378,700.0,907900.0,24459.868823635225,25746826.423948683,20072.2161083191,19867226.507095054,true,1297.0,1297,0.875,3839.1961259016107,4387.652715316127,548.4565894145162,0.0,0.0,1297,27067.918614905626,0.0,3839.1961259016107,3839.1961259016107,2696111.063710467,700.0,907900.0,775.54649830621,1267383.9453275423,1715.3436593513845,112785.4894192329,0.0,0.0,1316.1089239616515,1313824.6424476402,32.1970442823642,2116.9865160502454,-3839.1961259016107,-5144649.927247051,true,true,11.71263803,11653.538378946947,0.0,121.92,1644.2724500334996,1297.0,11.71263803,11653.538378946947,0.0,121.92,0.0,295.15 +1298,26837.652715316126,26137.652715316126,0.30500000000000005,10612.997906508213,5890212.914760288,700.0,908600.0,37091.79641478102,25783918.220363464,26478.798508272805,19893705.305603325,true,1298.0,1298,0.875,9286.373168194687,10612.997906508213,1326.624738313527,0.0,0.0,1298,26137.652715316126,0.0,9286.373168194687,9286.373168194687,2705397.4368786616,700.0,908600.0,820.9774511244888,1268204.9227786667,6992.818595075178,119778.30801430807,0.0,0.0,1341.3217384240631,1315165.9641860642,131.25538357095704,2248.2418996212023,-9286.373168194687,-5153936.300415246,true,true,12.07027583,11665.608654776946,0.0,121.92,1644.2724500334996,1298.0,12.07027583,11665.608654776946,0.0,121.92,0.0,295.15 +1299,33062.997906508215,32362.997906508215,0.30500000000000005,10991.19403926532,5901204.1087995535,700.0,909300.0,38331.78373529612,25822250.00409876,27340.589696030802,19921045.895299356,true,1299.0,1299,0.875,9617.294784357155,10991.19403926532,1373.899254908165,0.0,0.0,1299,32362.997906508215,0.0,9617.294784357155,9617.294784357155,2715014.731663019,700.0,909300.0,897.3007015690653,1269102.2234802358,7203.128927346806,126981.43694165489,0.0,0.0,1381.6622415639217,1316547.626427628,135.20291387736114,2383.4448134985632,-9617.294784357155,-5163553.595199603,true,true,12.42791363,11678.036568406946,0.0,121.92,1644.2724500334996,1299.0,12.42791363,11678.036568406946,0.0,121.92,0.0,295.15 +1300,33441.19403926532,32741.19403926532,0.28625,8082.726632804736,5909286.835432358,700.0,910000.0,30682.014437745805,25852932.018536508,22599.28780494107,19943645.1831043,true,1300.0,1300,0.875,7072.385803704145,8082.726632804736,1010.3408291005917,0.0,0.0,1300,32741.19403926532,0.0,7072.385803704145,7072.385803704145,2722087.117466723,700.0,910000.0,962.6865754872817,1270064.910055723,4608.753899210433,131590.1908408653,0.0,0.0,1414.4389006470494,1317962.065328275,86.50642835938032,2469.9512418579434,-7072.385803704145,-5170625.981003307,true,true,12.65143726,11690.688005666945,0.0,121.92,1644.2724500334996,1300.0,12.65143726,11690.688005666945,0.0,121.92,0.0,295.15 +1301,30532.726632804737,29832.726632804737,0.30500000000000005,10496.52492173897,5919783.360354097,700.0,910700.0,36709.91777619334,25889641.9363127,26213.392854454367,19969858.575958755,true,1301.0,1301,0.875,9184.4593065216,10496.52492173897,1312.0656152173706,0.0,0.0,1301,29832.726632804737,0.0,9184.4593065216,9184.4593065216,2731271.576773245,700.0,910700.0,1025.7941019195234,1271090.7041576426,6590.271364818964,138180.46220568428,0.0,0.0,1444.6942780019433,1319406.759606277,123.6995617811686,2593.650803639112,-9184.4593065216,-5179810.440309828,true,true,12.96437033,11703.652375996946,0.0,121.92,1644.2724500334996,1301.0,12.96437033,11703.652375996946,0.0,121.92,0.0,295.15 +1302,32946.52492173897,32246.524921738972,0.20800000000000002,4007.7216323819034,5923791.0819864785,700.0,911400.0,22633.277078759147,25912275.21339146,18625.555446377242,19988484.131405134,true,1302.0,1302,0.875,3506.7564283341653,4007.7216323819034,500.9652040477381,0.0,0.0,1302,32246.524921738972,0.0,3506.7564283341653,3506.7564283341653,2734778.3332015793,700.0,911400.0,1069.361954453522,1272160.0661120962,954.6118554094829,139135.07406109376,0.0,0.0,1464.8645295718727,1320871.624135849,17.918088899287984,2611.5688925383997,-3506.7564283341653,-5183317.196738162,true,true,13.00907506,11716.661451056945,0.0,121.92,1644.2724500334996,1302.0,13.00907506,11716.661451056945,0.0,121.92,0.0,295.15 +1303,26457.7216323819,25757.7216323819,0.1696,1784.796045390427,5925575.878031869,700.0,912100.0,14650.92007895299,25926926.133470412,12866.124033562563,20001350.255438697,true,1303.0,1303,0.875,1561.6965397166236,1784.796045390427,223.09950567380338,0.0,0.0,1303,25757.7216323819,0.0,1561.6965397166236,1561.6965397166236,2736340.029741296,700.0,912100.0,1069.361954453522,1273229.4280665498,-954.6118554094829,138180.46220568428,0.0,0.0,1464.8645295718727,1322336.488665421,-17.918088899287984,2593.650803639112,-1561.6965397166236,-5184878.893277879,true,true,12.96437033,11729.625821386946,0.0,121.92,1644.2724500334996,1303.0,12.96437033,11729.625821386946,0.0,121.92,0.0,295.15 +1304,24234.796045390427,23534.796045390427,0.12,0.0,5925575.878031869,700.0,912800.0,5833.333333333334,25932759.466803744,5833.333333333334,20007183.58877203,true,1304.0,1304,0.875,0.0,0.0,0.0,0.0,0.0,1304,23534.796045390427,0.0,-7094.273708734388,-7094.273708734388,2729245.756032562,700.0,912800.0,1009.7663607204914,1274239.1944272702,-9365.382042775273,128815.080162909,0.0,0.0,1437.130433381227,1323773.6190988023,-175.78846006083322,2417.862343578279,-0.0,-5184878.893277879,true,true,12.51732308,11742.143144466945,0.0,121.92,1644.2724500334996,1304.0,12.51732308,11742.143144466945,0.0,121.92,0.0,295.15 +1305,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,913500.0,5833.333333333334,25938592.800137077,5833.333333333334,20013016.92210536,true,1305.0,1305,0.875,0.0,0.0,0.0,0.0,0.0,1305,21750.0,0.0,-26983.851683688637,-26983.851683688637,2702261.904348873,700.0,913500.0,798.0464638211758,1275037.2408910913,-28574.273632772118,100240.80653013688,0.0,0.0,1328.7153309108646,1325102.3344297132,-536.3398456485579,1881.5224979297209,-0.0,-5184878.893277879,true,true,11.04206715,11753.185211616945,0.0,121.92,1644.2724500334996,1305.0,11.04206715,11753.185211616945,0.0,121.92,0.0,295.15 +1306,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,914200.0,5833.333333333334,25944426.13347041,5833.333333333334,20018850.255438693,true,1306.0,1306,0.875,0.0,0.0,0.0,0.0,0.0,1306,21750.0,0.0,-23768.377258577224,-23768.377258577224,2678493.5270902957,700.0,914200.0,534.1941259638097,1275571.4350170551,-24995.71198679938,75245.0945433375,0.0,0.0,1162.3107544437744,1326264.645184157,-469.1701521854303,1412.3523457442907,-0.0,-5184878.893277879,true,true,9.566811212,11762.752022828945,0.0,121.92,1644.2724500334996,1306.0,9.566811212,11762.752022828945,0.0,121.92,0.0,295.15 +1307,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,914900.0,5833.333333333334,25950259.46680374,5833.333333333334,20024683.588772025,true,1307.0,1307,0.875,0.0,0.0,0.0,0.0,0.0,1307,21750.0,0.0,-20487.20701125712,-20487.20701125712,2658006.3200790384,700.0,914900.0,336.03740218812305,1275907.4724192433,-21417.1501362574,53827.9444070801,0.0,0.0,995.9061776946913,1327260.5513618516,-402.0004548825308,1010.3518908617599,-0.0,-5184878.893277879,true,true,8.091555277,11770.843578105945,0.0,121.92,1644.2724500334996,1307.0,8.091555277,11770.843578105945,0.0,121.92,0.0,295.15 +1308,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,915600.0,5833.333333333334,25956092.800137073,5833.333333333334,20030516.922105357,true,1308.0,1308,0.875,0.0,0.0,0.0,0.0,0.0,1308,21750.0,0.0,-17149.746639288245,-17149.746639288245,2640856.5734397504,700.0,915600.0,194.1708472432873,1276101.6432664867,-17838.588329304926,35989.35607777517,0.0,0.0,829.5016011712027,1328090.0529630228,-334.8307583978083,675.5211324639515,-0.0,-5184878.893277879,true,true,6.616299343,11777.459877448946,0.0,121.92,1644.2724500334996,1308.0,6.616299343,11777.459877448946,0.0,121.92,0.0,295.15 +1309,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,916300.0,5833.333333333334,25961926.133470405,5833.333333333334,20036350.25543869,true,1309.0,1309,0.875,0.0,0.0,0.0,0.0,0.0,1309,21750.0,0.0,-13765.401569316318,-13765.401569316318,2627091.171870434,700.0,916300.0,99.18901493915054,1276200.8322814258,-14260.026546536168,21729.329531239004,0.0,0.0,663.0970246477139,1328753.1499876706,-267.6610623670144,407.86007009693714,-0.0,-5184878.893277879,true,true,5.141043408,11782.600920856947,0.0,121.92,1644.2724500334996,1309.0,5.141043408,11782.600920856947,0.0,121.92,0.0,295.15 +1310,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,917000.0,5833.333333333334,25967759.466803737,5833.333333333334,20042183.58877202,true,1310.0,1310,0.875,0.0,0.0,0.0,0.0,0.0,1310,21750.0,0.0,-10343.577202887654,-10343.577202887654,2616747.5946675465,700.0,917000.0,41.68645939660767,1276242.5187408223,-10681.464744435134,11047.86478680387,0.0,0.0,496.69244812422517,1329249.8424357949,-200.4913659733535,207.36870412358363,-0.0,-5184878.893277879,true,true,3.665787474,11786.266708330946,0.0,121.92,1644.2724500334996,1310.0,3.665787474,11786.266708330946,0.0,121.92,0.0,295.15 +1311,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,917700.0,5833.333333333334,25973592.80013707,5833.333333333334,20048016.922105353,true,1311.0,1311,0.875,0.0,0.0,0.0,0.0,0.0,1311,21750.0,0.0,-6893.6790203291375,-6893.6790203291375,2609853.9156472175,700.0,917700.0,12.257734736553637,1276254.776475559,-7102.90295681493,3944.96182998894,0.0,0.0,330.2878716007364,1329580.1303073957,-133.32166985149806,74.04703427208557,-0.0,-5184878.893277879,true,true,2.190531539,11788.457239869946,0.0,121.92,1644.2724500334996,1311.0,2.190531539,11788.457239869946,0.0,121.92,0.0,295.15 +1312,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,918400.0,5833.333333333334,25979426.1334704,5833.333333333334,20053850.255438685,true,1312.0,1312,0.875,0.0,0.0,0.0,0.0,0.0,1312,21750.0,0.0,-3425.112442957111,-3425.112442957111,2606428.8032042603,700.0,918400.0,1.4973950798833802,1276256.2738706388,-3524.3411595653433,420.6206704235965,0.0,0.0,163.88329507724762,1329744.0136024728,-66.15197354889884,7.895060723186731,-0.0,-5184878.893277879,true,true,0.715275605,11789.172515474946,0.0,121.92,1644.2724500334996,1312.0,0.715275605,11789.172515474946,0.0,121.92,0.0,295.15 +1313,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,919100.0,5833.333333333334,25985259.466803733,5833.333333333334,20059683.588772018,true,1313.0,1313,0.875,0.0,0.0,0.0,0.0,0.0,1313,21750.0,0.0,-388.15289425123626,-388.15289425123626,2606040.6503100093,700.0,919100.0,0.022333473848022808,1276256.2962041127,-420.62067042374963,-1.531361704110168e-10,0.0,0.0,40.340503421851245,1329784.3541058947,-7.895060723185952,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1313.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1314,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,919800.0,5833.333333333334,25991092.800137065,5833.333333333334,20065516.92210535,true,1314.0,1314,0.875,0.0,0.0,0.0,0.0,0.0,1314,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,919800.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1314.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1315,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,920500.0,5833.333333333334,25996926.133470397,5833.333333333334,20071350.25543868,true,1315.0,1315,0.875,0.0,0.0,0.0,0.0,0.0,1315,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,920500.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1315.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1316,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,921200.0,5833.333333333334,26002759.46680373,5833.333333333334,20077183.588772014,true,1316.0,1316,0.875,0.0,0.0,0.0,0.0,0.0,1316,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,921200.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1316.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1317,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,921900.0,5833.333333333334,26008592.80013706,5833.333333333334,20083016.922105346,true,1317.0,1317,0.875,0.0,0.0,0.0,0.0,0.0,1317,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,921900.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1317.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1318,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,922600.0,5833.333333333334,26014426.133470394,5833.333333333334,20088850.255438678,true,1318.0,1318,0.875,0.0,0.0,0.0,0.0,0.0,1318,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,922600.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1318.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1319,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,923300.0,5833.333333333334,26020259.466803726,5833.333333333334,20094683.58877201,true,1319.0,1319,0.875,0.0,0.0,0.0,0.0,0.0,1319,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,923300.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1319.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1320,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,924000.0,5833.333333333334,26026092.800137058,5833.333333333334,20100516.922105342,true,1320.0,1320,0.875,0.0,0.0,0.0,0.0,0.0,1320,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,924000.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1320.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1321,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,924700.0,5833.333333333334,26031926.13347039,5833.333333333334,20106350.255438674,true,1321.0,1321,0.875,0.0,0.0,0.0,0.0,0.0,1321,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,924700.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1321.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1322,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,925400.0,5833.333333333334,26037759.466803722,5833.333333333334,20112183.588772006,true,1322.0,1322,0.875,0.0,0.0,0.0,0.0,0.0,1322,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,925400.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1322.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1323,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,926100.0,5833.333333333334,26043592.800137054,5833.333333333334,20118016.92210534,true,1323.0,1323,0.875,0.0,0.0,0.0,0.0,0.0,1323,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,926100.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1323.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1324,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,926800.0,5833.333333333334,26049426.133470386,5833.333333333334,20123850.25543867,true,1324.0,1324,0.875,0.0,0.0,0.0,0.0,0.0,1324,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,926800.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1324.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1325,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,927500.0,5833.333333333334,26055259.46680372,5833.333333333334,20129683.588772003,true,1325.0,1325,0.875,0.0,0.0,0.0,0.0,0.0,1325,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,927500.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1325.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1326,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,928200.0,5833.333333333334,26061092.80013705,5833.333333333334,20135516.922105335,true,1326.0,1326,0.875,0.0,0.0,0.0,0.0,0.0,1326,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,928200.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1326.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1327,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,928900.0,5833.333333333334,26066926.133470383,5833.333333333334,20141350.255438667,true,1327.0,1327,0.875,0.0,0.0,0.0,0.0,0.0,1327,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,928900.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1327.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1328,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,929600.0,5833.333333333334,26072759.466803715,5833.333333333334,20147183.588772,true,1328.0,1328,0.875,0.0,0.0,0.0,0.0,0.0,1328,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,929600.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1328.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1329,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,930300.0,5833.333333333334,26078592.800137047,5833.333333333334,20153016.92210533,true,1329.0,1329,0.875,0.0,0.0,0.0,0.0,0.0,1329,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,930300.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1329.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1330,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,931000.0,5833.333333333334,26084426.13347038,5833.333333333334,20158850.255438663,true,1330.0,1330,0.875,0.0,0.0,0.0,0.0,0.0,1330,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,931000.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1330.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1331,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,931700.0,5833.333333333334,26090259.46680371,5833.333333333334,20164683.588771995,true,1331.0,1331,0.875,0.0,0.0,0.0,0.0,0.0,1331,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,931700.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1331.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1332,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,932400.0,5833.333333333334,26096092.800137043,5833.333333333334,20170516.922105327,true,1332.0,1332,0.875,0.0,0.0,0.0,0.0,0.0,1332,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,932400.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1332.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1333,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,933100.0,5833.333333333334,26101926.133470375,5833.333333333334,20176350.25543866,true,1333.0,1333,0.875,0.0,0.0,0.0,0.0,0.0,1333,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,933100.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1333.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1334,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,933800.0,5833.333333333334,26107759.466803707,5833.333333333334,20182183.58877199,true,1334.0,1334,0.875,0.0,0.0,0.0,0.0,0.0,1334,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,933800.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1334.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1335,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,934500.0,5833.333333333334,26113592.80013704,5833.333333333334,20188016.922105324,true,1335.0,1335,0.875,0.0,0.0,0.0,0.0,0.0,1335,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,934500.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1335.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1336,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,935200.0,5833.333333333334,26119426.13347037,5833.333333333334,20193850.255438656,true,1336.0,1336,0.875,0.0,0.0,0.0,0.0,0.0,1336,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,935200.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1336.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1337,22450.0,21750.0,0.12,0.0,5925575.878031869,700.0,935900.0,5833.333333333334,26125259.466803703,5833.333333333334,20199683.588771988,true,1337.0,1337,0.875,0.0,0.0,0.0,0.0,0.0,1337,21750.0,0.0,0.0,0.0,2606040.6503100093,700.0,935900.0,0.0,1276256.2962041127,0.0,-1.531361704110168e-10,0.0,0.0,0.0,1329784.3541058947,0.0,7.789324740770098e-13,-0.0,-5184878.893277879,true,true,0.0,11789.172515474946,0.0,121.92,1644.2724500334996,1337.0,0.0,11789.172515474946,0.0,121.92,0.0,295.15 +1338,22450.0,21750.0,0.132,473.6717459321594,5926049.549777801,700.0,936600.0,8891.452620698177,26134150.919424403,8417.780874766018,20208101.369646754,true,1338.0,1338,0.875,414.4627776906395,473.6717459321594,59.208968241519926,0.0,0.0,1338,21750.0,0.0,414.4627776906395,414.4627776906395,2606455.1130876997,700.0,936600.0,0.01840221533331099,1276256.314606328,369.68613535658534,369.6861353564322,0.0,0.0,37.81922191921155,1329822.1733278139,6.9390181995092535,6.939018199510032,-414.4627776906395,-5185293.35605557,true,true,0.670570879,11789.843086353945,0.0,121.92,1644.2724500334996,1338.0,0.670570879,11789.843086353945,0.0,121.92,0.0,295.15 +1339,22923.67174593216,22223.67174593216,0.20800000000000002,4160.252044150284,5930209.801821952,700.0,937300.0,23366.596366107133,26157517.51579051,19206.34432195685,20227307.71396871,true,1339.0,1339,0.875,3640.220538631498,4160.252044150284,520.0315055187857,0.0,0.0,1339,22223.67174593216,0.0,3640.220538631498,3640.220538631498,2610095.3336263313,700.0,937300.0,1.3633833313570598,1276257.6779896594,3415.8998949288366,3785.586030285269,0.0,0.0,158.84073212836674,1329981.0140599422,64.11652824293756,71.05554644244759,-3640.220538631498,-5188933.576594201,true,true,2.145826814,11791.988913167945,0.0,121.92,1644.2724500334996,1339.0,2.145826814,11791.988913167945,0.0,121.92,0.0,295.15 +1340,26610.252044150286,25910.252044150286,0.29250000000000004,8528.797780118522,5938738.599602071,700.0,938000.0,31551.4454021146,26189068.961192627,23022.64762199608,20250330.361590706,true,1340.0,1340,0.875,7462.698057603708,8528.797780118522,1066.0997225148149,0.0,0.0,1340,25910.252044150286,0.0,7462.698057603708,7462.698057603708,2617558.031683935,700.0,938000.0,11.70483949187577,1276269.3828291513,6994.461685048273,10780.047715333541,0.0,0.0,325.24530865185557,1330306.259368594,131.28622441170364,202.34177085415124,-7462.698057603708,-5196396.274651805,true,true,3.621082748,11795.609995915946,0.0,121.92,1644.2724500334996,1340.0,3.621082748,11795.609995915946,0.0,121.92,0.0,295.15 +1341,30978.797780118522,30278.797780118522,0.33,12918.35309454493,5951656.952696616,700.0,938700.0,41267.73665013615,26230336.697842762,28349.383555591216,20278679.745146297,true,1341.0,1341,0.875,11303.558957726813,12918.35309454493,1614.7941368181164,0.0,0.0,1341,30278.797780118522,0.0,11303.558957726813,11303.558957726813,2628861.5906416615,700.0,938700.0,40.42966714293786,1276309.8124962943,10573.023484650075,21353.071199983617,0.0,0.0,491.6498851753443,1330797.9092537693,198.45592075845403,400.79769161260526,-11303.558957726813,-5207699.833609532,true,true,5.096338683,11800.706334598946,0.0,121.92,1644.2724500334996,1341.0,5.096338683,11800.706334598946,0.0,121.92,0.0,295.15 +1342,35368.35309454493,34668.35309454493,0.29250000000000004,9272.44503848686,5960929.397735103,700.0,939400.0,34093.82919140806,26264430.52703417,24821.3841529212,20303501.12929922,true,1342.0,1342,0.875,8113.389408676003,9272.44503848686,1159.0556298108568,0.0,0.0,1342,34668.35309454493,0.0,8113.389408676003,8113.389408676003,2636974.9800503375,700.0,939400.0,81.17114143074772,1276390.983637725,7275.4231491982955,28628.494349181914,0.0,0.0,620.2352397796216,1331418.144493549,136.55987826733804,537.3575698799433,-8113.389408676003,-5215813.223018208,true,true,5.901023738,11806.607358336947,0.0,121.92,1644.2724500334996,1342.0,5.901023738,11806.607358336947,0.0,121.92,0.0,295.15 +1343,31722.44503848686,31022.44503848686,0.3175,11242.981729006304,5972172.379464109,700.0,940100.0,37615.690485059225,26302046.21751923,26372.70875605292,20329873.83805527,true,1343.0,1343,0.875,9837.609012880515,11242.981729006304,1405.3727161257884,0.0,0.0,1343,31022.44503848686,0.0,9837.609012880515,9837.609012880515,2646812.589063218,700.0,940100.0,123.5821192266457,1276514.5657569517,8834.677124547265,37463.17147372918,0.0,0.0,713.5226539109284,1332131.66714746,165.82711519567806,703.1846850756214,-9837.609012880515,-5225650.832031088,true,true,6.750413519,11813.357771855946,0.0,121.92,1644.2724500334996,1343.0,6.750413519,11813.357771855946,0.0,121.92,0.0,295.15 +1344,33692.98172900631,32992.98172900631,0.3175,11495.759944753645,5983668.139408863,700.0,940800.0,38411.84234568077,26340458.059864912,26916.082400927127,20356789.920456197,true,1344.0,1344,0.875,10058.789951659439,11495.759944753645,1436.969993094206,0.0,0.0,1344,32992.98172900631,0.0,10058.789951659439,10058.789951659439,2656871.379014877,700.0,940800.0,176.9980089519999,1276691.5637659037,8910.257397267093,46373.42887099627,0.0,0.0,804.288786595994,1332935.9559340558,167.24575884435308,870.4304439199744,-10058.789951659439,-5235709.621982748,true,true,7.510393849,11820.868165704946,0.0,121.92,1644.2724500334996,1344.0,7.510393849,11820.868165704946,0.0,121.92,0.0,295.15 +1345,33945.75994475365,33245.75994475365,0.3175,11352.896240166237,5995021.03564903,700.0,941500.0,37961.87792178342,26378419.937786695,26608.981681617188,20383398.902137816,true,1345.0,1345,0.875,9933.784210145457,11352.896240166237,1419.1120300207804,0.0,0.0,1345,33245.75994475365,0.0,9933.784210145457,9933.784210145457,2666805.1632250226,700.0,941500.0,235.78581883170884,1276927.3495847355,8650.65557197501,55024.08444297128,0.0,0.0,884.9697933832979,1333820.925727439,162.37302595543886,1032.8034698754134,-9933.784210145457,-5245643.406192893,true,true,8.180964728,11829.049130432946,0.0,121.92,1644.2724500334996,1345.0,8.180964728,11829.049130432946,0.0,121.92,0.0,295.15 +1346,33802.896240166236,33102.896240166236,0.30500000000000005,10103.198044567533,6005124.233693597,700.0,942200.0,35420.32145759846,26413840.259244293,25317.123413030928,20408716.025550846,true,1346.0,1346,0.875,8840.298288996592,10103.198044567533,1262.8997555709411,0.0,0.0,1346,33102.896240166236,0.0,8840.298288996592,8840.298288996592,2675645.4615140194,700.0,942200.0,294.4907996254063,1277221.8403843609,7452.872489626751,62476.956932598034,0.0,0.0,953.0443928265989,1334773.9701202656,139.8906069178357,1172.694076793249,-8840.298288996592,-5254483.7044818895,true,true,8.717421431,11837.766551863946,0.0,121.92,1644.2724500334996,1346.0,8.717421431,11837.766551863946,0.0,121.92,0.0,295.15 +1347,32553.198044567533,31853.198044567533,0.28,7630.727636218535,6012754.961329815,700.0,942900.0,29752.59870078048,26443592.857945073,22121.871064561943,20430837.89661541,true,1347.0,1347,0.875,6676.886681691218,7630.727636218535,953.8409545273171,0.0,0.0,1347,31853.198044567533,0.0,6676.886681691218,6676.886681691218,2682322.3481957107,700.0,942900.0,343.75224881844815,1277565.5926331794,5231.469592952789,67708.42652555082,0.0,0.0,1003.4700220898135,1335777.4401423554,98.19481783016793,1270.888894623417,-6676.886681691218,-5261160.59116358,true,true,9.075059234,11846.841611097945,0.0,121.92,1644.2724500334996,1347.0,9.075059234,11846.841611097945,0.0,121.92,0.0,295.15 +1348,30080.727636218537,29380.727636218537,0.29250000000000004,9605.447828644898,6022360.40915846,700.0,943600.0,35232.30026887144,26478825.158213943,25626.852440226543,20456464.749055635,true,1348.0,1348,0.875,8404.766850064285,9605.447828644898,1200.6809785806126,0.0,0.0,1348,29380.727636218537,0.0,8404.766850064285,8404.766850064285,2690727.115045775,700.0,943600.0,392.53313578295587,1277958.1257689623,6835.085889166971,74543.5124147178,0.0,0.0,1048.8530884605457,1336826.293230816,128.2947366538116,1399.1836312772286,-8404.766850064285,-5269565.358013645,true,true,9.522106487,11856.363717584945,0.0,121.92,1644.2724500334996,1348.0,9.522106487,11856.363717584945,0.0,121.92,0.0,295.15 +1349,32055.447828644898,31355.447828644898,0.265,6705.720135264398,6029066.129293724,700.0,944300.0,27946.11371797886,26506771.271931924,21240.393582714463,20477705.142638348,true,1349.0,1349,0.875,5867.505118356348,6705.720135264398,838.2150169080496,0.0,0.0,1349,31355.447828644898,0.0,5867.505118356348,5867.505118356348,2696594.6201641317,700.0,944300.0,439.58976506777304,1278397.71553403,4258.784271942478,78802.29668666028,0.0,0.0,1089.1935918259985,1337915.486822642,79.93748952009814,1479.1211207973267,-5867.505118356348,-5275432.863132001,true,true,9.790334838,11866.154052422946,0.0,121.92,1644.2724500334996,1349.0,9.790334838,11866.154052422946,0.0,121.92,0.0,295.15 +1350,29155.720135264397,28455.720135264397,0.196,3482.117871894214,6032548.247165618,700.0,945000.0,21337.336081092926,26528108.608013015,17855.218209198712,20495560.360847548,true,1350.0,1350,0.875,3046.8531379074375,3482.117871894214,435.2647339867767,0.0,0.0,1350,28455.720135264397,0.0,3046.8531379074375,3046.8531379074375,2699641.4733020393,700.0,945000.0,464.4664631892949,1278862.1819972193,1445.883559874126,80248.18024653441,0.0,0.0,1109.3638435087248,1339024.8506661507,27.13927133529188,1506.2603921326186,-3046.8531379074375,-5278479.7162699085,true,true,9.879744289,11876.033796711947,0.0,121.92,1644.2724500334996,1350.0,9.879744289,11876.033796711947,0.0,121.92,0.0,295.15 +1351,25932.117871894214,25232.117871894214,0.20800000000000002,4385.25018300902,6036933.497348627,700.0,945700.0,24448.318187543362,26552556.926200558,20063.068004534343,20515623.42885208,true,1351.0,1351,0.875,3837.0939101328922,4385.25018300902,548.1562728761273,0.0,0.0,1351,25232.117871894214,0.0,3837.0939101328922,3837.0939101328922,2703478.5672121723,700.0,945700.0,480.48116117565974,1279342.663158395,2193.47099186525,82441.65123839966,0.0,0.0,1121.9702505707348,1340146.8209167214,41.17150652124778,1547.4318986538663,-3837.0939101328922,-5282316.810180041,true,true,10.01385846,11886.047655171948,0.0,121.92,1644.2724500334996,1351.0,10.01385846,11886.047655171948,0.0,121.92,0.0,295.15 +1352,26835.25018300902,26135.25018300902,0.12,0.0,6036933.497348627,700.0,946400.0,5833.333333333334,26558390.25953389,5833.333333333334,20521456.762185413,true,1352.0,1352,0.875,0.0,0.0,0.0,0.0,0.0,1352,26135.25018300902,0.0,-1376.1295902156437,-1376.1295902156437,2702102.4376219567,700.0,946400.0,477.2492360023803,1279819.9123943974,-2918.055813224185,79523.59542517547,0.0,0.0,1119.4489691244937,1341266.269885846,-54.77198211833273,1492.6599165355335,-0.0,-5282316.810180041,true,true,9.835039564,11895.882694735948,0.0,121.92,1644.2724500334996,1352.0,9.835039564,11895.882694735948,0.0,121.92,0.0,295.15 +1353,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,947100.0,5833.333333333334,26564223.59286722,5833.333333333334,20527290.095518745,true,1353.0,1353,0.875,0.0,0.0,0.0,0.0,0.0,1353,21750.0,0.0,-1368.0706911425218,-1368.0706911425218,2700734.366930814,700.0,947100.0,451.91400410552706,1280271.826398503,-2865.478311895824,76658.11711327964,0.0,0.0,1099.2787177237599,1342365.5486035696,-53.7851010759847,1438.8748154595487,-0.0,-5282316.810180041,true,true,9.656220663,11905.538915398949,0.0,121.92,1644.2724500334996,1353.0,9.656220663,11905.538915398949,0.0,121.92,0.0,295.15 +1354,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,947800.0,5833.333333333334,26570056.926200554,5833.333333333334,20533123.428852078,true,1354.0,1354,0.875,0.0,0.0,0.0,0.0,0.0,1354,21750.0,0.0,-2072.664851579834,-2072.664851579834,2698661.702079234,700.0,947800.0,424.50221129221734,1280696.3286097953,-3507.9106744859905,73150.20643879366,0.0,0.0,1076.587184538394,1343442.135788108,-65.84357292445459,1373.0312425350942,-0.0,-5282316.810180041,true,true,9.432697036,11914.971612434949,0.0,121.92,1644.2724500334996,1354.0,9.432697036,11914.971612434949,0.0,121.92,0.0,295.15 +1355,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,948500.0,5833.333333333334,26575890.259533886,5833.333333333334,20538956.76218541,true,1355.0,1355,0.875,0.0,0.0,0.0,0.0,0.0,1355,21750.0,0.0,-2736.642154259307,-2736.642154259307,2695925.059924975,700.0,948500.0,392.5331357196344,1281088.861745515,-4101.051536337544,69049.15490245611,0.0,0.0,1048.853088404147,1344490.988876512,-76.97684204554449,1296.0544004895496,-0.0,-5282316.810180041,true,true,9.164468684,11924.13608111895,0.0,121.92,1644.2724500334996,1355.0,9.164468684,11924.13608111895,0.0,121.92,0.0,295.15 +1356,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,949200.0,5833.333333333334,26581723.592867218,5833.333333333334,20544790.09551874,true,1356.0,1356,0.875,0.0,0.0,0.0,0.0,0.0,1356,21750.0,0.0,-2006.2965813629278,-2006.2965813629278,2693918.763343612,700.0,949200.0,362.21080494571305,1281451.0725504607,-3327.175214901444,65721.97968755466,0.0,0.0,1021.1189923262987,1345512.1078688384,-62.4511637334952,1233.6032367560545,-0.0,-5282316.810180041,true,true,8.940945058,11933.07702617695,0.0,121.92,1644.2724500334996,1356.0,8.940945058,11933.07702617695,0.0,121.92,0.0,295.15 +1357,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,949900.0,5833.333333333334,26587556.92620055,5833.333333333334,20550623.428852074,true,1357.0,1357,0.875,0.0,0.0,0.0,0.0,0.0,1357,21750.0,0.0,-1314.417570551779,-1314.417570551779,2692604.3457730603,700.0,949900.0,338.5960517051614,1281789.6686021658,-2602.590393322,63119.38929423266,0.0,0.0,998.4274591973312,1346510.5353280357,-48.85068813227151,1184.752548623783,-0.0,-5282316.810180041,true,true,8.762126157,11941.83915233395,0.0,121.92,1644.2724500334996,1357.0,8.762126157,11941.83915233395,0.0,121.92,0.0,295.15 +1358,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,950600.0,5833.333333333334,26593390.259533882,5833.333333333334,20556456.762185406,true,1358.0,1358,0.875,0.0,0.0,0.0,0.0,0.0,1358,21750.0,0.0,-5753.104680208087,-5753.104680208087,2686851.2410928523,700.0,950600.0,301.5582809080259,1282091.2268830738,-6886.020419309186,56233.36887492347,0.0,0.0,960.6082372781195,1347471.143565314,-129.25077908504696,1055.501769538736,-0.0,-5282316.810180041,true,true,8.270374179,11950.10952651295,0.0,121.92,1644.2724500334996,1358.0,8.270374179,11950.10952651295,0.0,121.92,0.0,295.15 +1359,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,951300.0,5833.333333333334,26599223.592867214,5833.333333333334,20562290.095518738,true,1359.0,1359,0.875,0.0,0.0,0.0,0.0,0.0,1359,21750.0,0.0,-4863.948912997435,-4863.948912997435,2681987.292179855,700.0,951300.0,254.39222519447864,1282345.6191082683,-5914.978173423559,50318.39070149991,0.0,0.0,907.6613265686641,1348378.8048918825,-111.02429133701906,944.4774782017168,-0.0,-5282316.810180041,true,true,7.823326926,11957.93285343895,0.0,121.92,1644.2724500334996,1359.0,7.823326926,11957.93285343895,0.0,121.92,0.0,295.15 +1360,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,952000.0,5833.333333333334,26605056.926200546,5833.333333333334,20568123.42885207,true,1360.0,1360,0.875,0.0,0.0,0.0,0.0,0.0,1360,21750.0,0.0,-4619.6834681948985,-4619.6834681948985,2677367.6087116604,700.0,952000.0,214.30538448891616,1282559.9244927573,-5586.3682748387855,44732.022426661126,0.0,0.0,857.2356973054495,1349236.040589188,-104.85627515047919,839.6212030512377,-0.0,-5282316.810180041,true,true,7.376279673,11965.30913311195,0.0,121.92,1644.2724500334996,1360.0,7.376279673,11965.30913311195,0.0,121.92,0.0,295.15 +1361,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,952700.0,5833.333333333334,26610890.25953388,5833.333333333334,20573956.762185402,true,1361.0,1361,0.875,0.0,0.0,0.0,0.0,0.0,1361,21750.0,0.0,-4370.9687766538,-4370.9687766538,2672996.6399350064,700.0,952700.0,178.66779052190432,1282738.5922832792,-5257.758376254,39474.264050407124,0.0,0.0,806.8100680422352,1350042.8506572302,-98.68825896393952,740.9329440872982,-0.0,-5282316.810180041,true,true,6.92923242,11972.23836553195,0.0,121.92,1644.2724500334996,1361.0,6.92923242,11972.23836553195,0.0,121.92,0.0,295.15 +1362,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,953400.0,5833.333333333334,26616723.59286721,5833.333333333334,20579790.095518734,true,1362.0,1362,0.875,0.0,0.0,0.0,0.0,0.0,1362,21750.0,0.0,-6523.204489258494,-6523.204489258494,2666473.435445748,700.0,953400.0,139.97883663870027,1282878.5711199178,-7270.493999389044,32203.77005101808,0.0,0.0,743.7780314914164,1350786.6286887217,-136.46735799956664,604.4655860877316,-0.0,-5282316.810180041,true,true,6.258661541,11978.49702707295,0.0,121.92,1644.2724500334996,1362.0,6.258661541,11978.49702707295,0.0,121.92,0.0,295.15 +1363,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,954100.0,5833.333333333334,26622556.926200543,5833.333333333334,20585623.428852066,true,1363.0,1363,0.875,0.0,0.0,0.0,0.0,0.0,1363,21750.0,0.0,-11838.655994498038,-11838.655994498038,2654634.7794512496,700.0,954100.0,85.19544150275728,1282963.7665614206,-12322.871194724332,19880.89885629375,0.0,0.0,630.3203656773833,1351416.949054399,-231.3006069538478,373.1649791338838,-0.0,-5282316.810180041,true,true,4.917519782,11983.41454685495,0.0,121.92,1644.2724500334996,1363.0,4.917519782,11983.41454685495,0.0,121.92,0.0,295.15 +1364,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,954800.0,5833.333333333334,26628390.259533875,5833.333333333334,20591456.7621854,true,1364.0,1364,0.875,0.0,0.0,0.0,0.0,0.0,1364,21750.0,0.0,-9024.728336725719,-9024.728336725719,2645610.051114524,700.0,954800.0,37.398754122774015,1283001.1653155433,-9365.382107461242,10515.516748832506,0.0,0.0,479.0434778877399,1351895.9925322868,-175.78846127499014,197.37651785889364,-0.0,-5282316.810180041,true,true,3.576378023,11986.990924877951,0.0,121.92,1644.2724500334996,1364.0,3.576378023,11986.990924877951,0.0,121.92,0.0,295.15 +1365,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,955500.0,5833.333333333334,26634223.592867207,5833.333333333334,20597290.09551873,true,1365.0,1365,0.875,0.0,0.0,0.0,0.0,0.0,1365,21750.0,0.0,-5841.346113767217,-5841.346113767217,2639768.705000757,700.0,955500.0,12.540594505473415,1283013.7059100487,-6072.710922259745,4442.805826572761,0.0,0.0,332.80915304697754,1352228.8016853337,-113.98493905992348,83.39157879897016,-0.0,-5282316.810180041,true,true,2.324645715,11989.315570592951,0.0,121.92,1644.2724500334996,1365.0,2.324645715,11989.315570592951,0.0,121.92,0.0,295.15 +1366,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,956200.0,5833.333333333334,26640056.92620054,5833.333333333334,20603123.428852063,true,1366.0,1366,0.875,0.0,0.0,0.0,0.0,0.0,1366,21750.0,0.0,-3283.388500095565,-3283.388500095565,2636485.3165006614,700.0,956200.0,2.489249950667005,1283016.1951599994,-3415.8998944142895,1026.9059321584718,0.0,0.0,194.13867260133713,1352422.9403579351,-64.11652823327952,19.275050565690634,-0.0,-5282316.810180041,true,true,1.117618132,11990.433188724952,0.0,121.92,1644.2724500334996,1366.0,1.117618132,11990.433188724952,0.0,121.92,0.0,295.15 +1367,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,956900.0,5833.333333333334,26645890.25953387,5833.333333333334,20608956.762185395,true,1367.0,1367,0.875,0.0,0.0,0.0,0.0,0.0,1367,21750.0,0.0,-983.0637507320638,-983.0637507320638,2635502.252749929,700.0,956900.0,0.08519544143415073,1283016.280355441,-1026.9059321586267,-1.5484147297684103e-10,0.0,0.0,63.03203655081876,1352485.972394486,-19.275050565690066,5.684341886080801e-13,-0.0,-5282316.810180041,true,true,0.0,11990.433188724952,0.0,121.92,1644.2724500334996,1367.0,0.0,11990.433188724952,0.0,121.92,0.0,295.15 +1368,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,957600.0,5833.333333333334,26651723.592867203,5833.333333333334,20614790.095518727,true,1368.0,1368,0.875,0.0,0.0,0.0,0.0,0.0,1368,21750.0,0.0,0.0,0.0,2635502.252749929,700.0,957600.0,0.0,1283016.280355441,0.0,-1.5484147297684103e-10,0.0,0.0,0.0,1352485.972394486,0.0,5.684341886080801e-13,-0.0,-5282316.810180041,true,true,0.0,11990.433188724952,0.0,121.92,1644.2724500334996,1368.0,0.0,11990.433188724952,0.0,121.92,0.0,295.15 +1369,22450.0,21750.0,0.12,0.0,6036933.497348627,700.0,958300.0,5833.333333333334,26657556.926200535,5833.333333333334,20620623.42885206,true,1369.0,1369,0.875,0.0,0.0,0.0,0.0,0.0,1369,21750.0,0.0,0.0,0.0,2635502.252749929,700.0,958300.0,0.0,1283016.280355441,0.0,-1.5484147297684103e-10,0.0,0.0,0.0,1352485.972394486,0.0,5.684341886080801e-13,-0.0,-5282316.810180041,true,true,0.0,11990.433188724952,0.0,121.92,1644.2724500334996,1369.0,0.0,11990.433188724952,0.0,121.92,0.0,295.15 diff --git a/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt b/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt index c9a85765..c7802787 100644 --- a/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt +++ b/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt @@ -97,6 +97,7 @@ ['veh']['state']['speed_ach_meters_per_second'] ['veh']['state']['dist_meters'] ['veh']['state']['grade_curr'] +['veh']['state']['elev_curr_meters'] ['veh']['state']['mass_kilograms'] ['veh']['history']['i'] ['veh']['history']['pwr_prop_fwd_max_watts'] @@ -123,6 +124,7 @@ ['veh']['history']['speed_ach_meters_per_second'] ['veh']['history']['dist_meters'] ['veh']['history']['grade_curr'] +['veh']['history']['elev_curr_meters'] ['veh']['history']['mass_kilograms'] ['cyc']['init_elev_meters'] ['cyc']['time_seconds'] @@ -142,4 +144,4 @@ ['sim_params']['trace_miss_tol']['tol_dist_frac'] ['sim_params']['trace_miss_tol']['tol_speed'] ['sim_params']['trace_miss_tol']['tol_speed_frac'] -['sim_params']['f2_air_density'] +['sim_params']['f2_const_air_density'] diff --git a/python/fastsim/tests/test_speedup.py b/python/fastsim/tests/test_speedup.py index fbeb00ae..3c38ec48 100644 --- a/python/fastsim/tests/test_speedup.py +++ b/python/fastsim/tests/test_speedup.py @@ -75,7 +75,7 @@ def test_conv_speedup(): # minimum allowed f3 / f2 speed ratio # there is some wiggle room on these but we're trying to get 10x speedup # relative to fastsim-2 with `save_interval` of `None` - min_speed_ratio_si_none = 3.8 + min_speed_ratio_si_none = 3.6 min_speed_ratio_si_1 = 2.0 # load 2016 Toyota Prius Two from file From 50df430a032ded4f4d302bdebef040bb6e53c430 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Wed, 4 Dec 2024 16:16:47 -0700 Subject: [PATCH 07/12] updated version --- fastsim-cli/Cargo.toml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/fastsim-cli/Cargo.toml b/fastsim-cli/Cargo.toml index 46212974..ef44dc4f 100644 --- a/fastsim-cli/Cargo.toml +++ b/fastsim-cli/Cargo.toml @@ -1,6 +1,6 @@ [package] name = "fastsim-cli" -version = "0.1.0" +version = "1.0.0" edition.workspace = true # See more keys and their definitions at https://doc.rust-lang.org/cargo/reference/manifest.html From 249cf7eb6b20367766ee071257394bb955864eb5 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Mon, 9 Dec 2024 13:42:05 -0700 Subject: [PATCH 08/12] added HVACOption and CabinOption match combinations working on ReversibleEnergyStorage thermal controls moved HVAC to own module --- Cargo.lock | 4 +- .../f3-vehicles/2010 Mazda 3 i-Stop.yaml | 3 +- cal_and_val/f3-vehicles/2012 Ford Focus.yaml | 3 +- cal_and_val/f3-vehicles/2012 Ford Fusion.yaml | 3 +- .../f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml | 3 +- .../f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml | 3 +- .../2016 CHEVROLET Malibu 4cyl 2WD.yaml | 3 +- .../f3-vehicles/2016 CHEVROLET Spark EV.yaml | 3 +- .../f3-vehicles/2016 FORD C-MAX HEV.yaml | 8 +- .../2016 FORD Escape 4cyl 2WD.yaml | 3 +- .../2016 FORD Explorer 4cyl 2WD.yaml | 3 +- .../2016 HYUNDAI Elantra 4cyl 2WD.yaml | 3 +- .../2016 Hyundai Tucson Fuel Cell.yaml | 8 +- .../f3-vehicles/2016 KIA Optima Hybrid.yaml | 8 +- cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml | 3 +- .../f3-vehicles/2016 MITSUBISHI i-MiEV.yaml | 3 +- .../f3-vehicles/2016 Nissan Leaf 30 kWh.yaml | 3 +- .../f3-vehicles/2016 TESLA Model S60 2WD.yaml | 3 +- .../2016 TOYOTA Camry 4cyl 2WD.yaml | 3 +- .../2016 TOYOTA Corolla 4cyl 2WD.yaml | 3 +- .../2016 TOYOTA Highlander Hybrid.yaml | 8 +- .../2016 Toyota Prius Two FWD.yaml | 8 +- .../f3-vehicles/2017 CHEVROLET Bolt.yaml | 3 +- .../f3-vehicles/2017 Maruti Dzire VDI.yaml | 3 +- .../2017 Toyota Highlander 3.5 L.yaml | 3 +- .../2020 Chevrolet Colorado 2WD Diesel.yaml | 3 +- .../2020 Hero Splendor+ 100cc.yaml | 3 +- .../f3-vehicles/2020 VW Golf 1.5TSI.yaml | 3 +- .../f3-vehicles/2020 VW Golf 2.0TDI.yaml | 3 +- .../f3-vehicles/2021 BMW iX xDrive40.yaml | 3 +- cal_and_val/f3-vehicles/2021 Cupra Born.yaml | 3 +- .../2021 Fiat Panda Mild Hybrid.yaml | 3 +- .../f3-vehicles/2021 Honda N-Box G.yaml | 3 +- cal_and_val/f3-vehicles/2021 Peugot 3008.yaml | 3 +- .../2022 Ford F-150 Lightning 4WD.yaml | 3 +- .../2022 MINI Cooper SE Hardtop 2 door.yaml | 3 +- .../2022 Renault Megane E-Tech.yaml | 3 +- .../2022 Renault Zoe ZE50 R135.yaml | 3 +- .../f3-vehicles/2022 Tesla Model 3 RWD.yaml | 3 +- .../f3-vehicles/2022 Tesla Model Y RWD.yaml | 3 +- .../2022 Toyota RAV4 Hybrid LE.yaml | 8 +- .../2022 Toyota Yaris Hybrid Mid.yaml | 8 +- .../2022 Volvo XC40 Recharge twin.yaml | 3 +- .../2023 Mitsubishi Pajero Sport.yaml | 3 +- ...2023 Polestar 2 Long range Dual motor.yaml | 3 +- .../f3-vehicles/2023 Volvo C40 Recharge.yaml | 3 +- .../f3-vehicles/2024 BYD Dolphin Active.yaml | 3 +- .../f3-vehicles/2024 Toyota Vios 1.5 G.yaml | 3 +- .../f3-vehicles/2024 VinFast VF e34.yaml | 3 +- .../2024 Volkswagen Polo 1.0 MPI.yaml | 3 +- cal_and_val/f3-vehicles/BYD ATTO 3.yaml | 3 +- cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml | 3 +- .../Class 4 Truck (Isuzu NPR HD).yaml | 3 +- cal_and_val/f3-vehicles/Line Haul Conv.yaml | 3 +- .../f3-vehicles/Maruti Swift 4cyl 2WD.yaml | 3 +- cal_and_val/f3-vehicles/Nissan Navara.yaml | 3 +- .../Regional Delivery Class 8 Truck.yaml | 3 +- .../f3-vehicles/Renault Clio IV diesel.yaml | 3 +- .../Renault Megane 1.5 dCi Authentique.yaml | 3 +- .../Toyota Corolla Cross Hybrid.yaml | 8 +- .../f3-vehicles/Toyota Etios Liva diesel.yaml | 3 +- .../Toyota Hilux Double Cab 4WD.yaml | 3 +- cal_and_val/f3-vehicles/Toyota Mirai.yaml | 8 +- .../resources/vehicles/2012_Ford_Fusion.yaml | 3 +- .../vehicles/2016_TOYOTA_Prius_Two.yaml | 8 +- .../vehicles/2022_Renault_Zoe_ZE50_R135.yaml | 3 +- fastsim-core/src/prelude.rs | 8 +- fastsim-core/src/simdrive.rs | 17 +- fastsim-core/src/vehicle/bev.rs | 2 +- fastsim-core/src/vehicle/cabin.rs | 248 +-------------- fastsim-core/src/vehicle/conv.rs | 5 +- fastsim-core/src/vehicle/hev.rs | 100 +++--- fastsim-core/src/vehicle/hvac.rs | 289 ++++++++++++++++++ fastsim-core/src/vehicle/mod.rs | 11 +- .../vehicle/powertrain/electric_machine.rs | 9 +- .../src/vehicle/powertrain/fuel_converter.rs | 136 +++++++-- .../powertrain/reversible_energy_storage.rs | 85 +++--- fastsim-core/src/vehicle/powertrain/traits.rs | 2 +- .../src/vehicle/powertrain/transmission.rs | 6 +- fastsim-core/src/vehicle/powertrain_type.rs | 14 +- fastsim-core/src/vehicle/vehicle_model.rs | 60 ++-- .../vehicle_model/fastsim2_interface.rs | 49 +-- 82 files changed, 806 insertions(+), 484 deletions(-) create mode 100644 fastsim-core/src/vehicle/hvac.rs diff --git a/Cargo.lock b/Cargo.lock index 4564d500..dc64c74e 100644 --- a/Cargo.lock +++ b/Cargo.lock @@ -1,6 +1,6 @@ # This file is automatically @generated by Cargo. # It is not intended for manual editing. -version = 3 +version = 4 [[package]] name = "adler" @@ -493,7 +493,7 @@ checksum = "9fc0510504f03c51ada170672ac806f1f105a88aa97a5281117e1ddc3368e51a" [[package]] name = "fastsim-cli" -version = "0.1.0" +version = "1.0.0" dependencies = [ "fastsim-core 1.0.0", ] diff --git a/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml b/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml index 91a3af7d..af1dbc49 100644 --- a/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml +++ b/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.6 mass_kilograms: 1473.9 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2012 Ford Focus.yaml b/cal_and_val/f3-vehicles/2012 Ford Focus.yaml index e3f965d8..02d5d035 100644 --- a/cal_and_val/f3-vehicles/2012 Ford Focus.yaml +++ b/cal_and_val/f3-vehicles/2012 Ford Focus.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.6 mass_kilograms: 1473.9 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml b/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml index ef7878b8..40a654be 100644 --- a/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml +++ b/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.72 mass_kilograms: 1644.2724500334996 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.875 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml index ad074b26..170f3b27 100644 --- a/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1606.0927171041076 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml index f7c3db1d..39c39bd7 100644 --- a/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1950.3695157008785 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml index 45720a15..b3886f02 100644 --- a/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1666.874756172356 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml b/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml index 217443a0..2d26cce5 100644 --- a/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml +++ b/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.7 wheel_base_meters: 2.38 mass_kilograms: 1435.996 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml b/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml index e2207b95..f71087c5 100644 --- a/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1950.3693212520827 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml index 809bbd60..8976566a 100644 --- a/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1893.6704171330643 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml index 2991531d..b2557ad2 100644 --- a/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 2403.9617607817445 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml index 0bda4355..bc743160 100644 --- a/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1610.1752055806355 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml b/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml index 432bcb31..374e826a 100644 --- a/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml +++ b/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.53 wheel_base_meters: 2.69 mass_kilograms: 2177.165764419529 -pwr_aux_watts: 280.0 +pwr_aux_base_watts: 280.0 +pwr_aux_max_watts: 560.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml b/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml index d179c7a2..03a3b735 100644 --- a/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1893.6707541501114 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml b/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml index 0ae3798b..49ca6287 100644 --- a/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml +++ b/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1612.897 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml b/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml index 22a2ca47..78521849 100644 --- a/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml +++ b/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1440.0778 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml b/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml index 6bb1cfc0..5000d23e 100644 --- a/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml +++ b/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1636.03 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml b/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml index fbe0aebf..94ba4311 100644 --- a/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.96 mass_kilograms: 2270.152 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml index 0fd7503e..d97250d0 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 1893.6707212387912 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml index 836cb58f..2595d397 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.6 mass_kilograms: 1553.4758391698351 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml index f998533e..f4d2eefb 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 2403.962034901285 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml b/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml index ce192f9c..9b59a067 100644 --- a/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml +++ b/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.7 mass_kilograms: 1635.0 -pwr_aux_watts: 1050.0 +pwr_aux_base_watts: 1050.0 +pwr_aux_max_watts: 2100.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml b/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml index 206cbc86..33e99057 100644 --- a/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml +++ b/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.7 wheel_base_meters: 2.6 mass_kilograms: 1757.77 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml b/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml index e7f48e0a..755c66d9 100644 --- a/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml +++ b/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.45 mass_kilograms: 972.5 -pwr_aux_watts: 950.0 +pwr_aux_base_watts: 950.0 +pwr_aux_max_watts: 1900.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml b/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml index aacd8de1..257264de 100644 --- a/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml +++ b/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.72 mass_kilograms: 2270.0 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.875 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml b/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml index bdb67fd1..28a51f81 100644 --- a/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml +++ b/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 3.26 mass_kilograms: 2325.0 -pwr_aux_watts: 1500.0 +pwr_aux_base_watts: 1500.0 +pwr_aux_max_watts: 3000.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml b/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml index 64f2b923..add626fc 100644 --- a/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml +++ b/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 1.236 mass_kilograms: 172.0 -pwr_aux_watts: 0.0 +pwr_aux_base_watts: 0.0 +pwr_aux_max_watts: 0.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml b/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml index aef5a30d..ddfc2ef2 100644 --- a/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml +++ b/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.636 mass_kilograms: 1416.0 -pwr_aux_watts: 750.0 +pwr_aux_base_watts: 750.0 +pwr_aux_max_watts: 1500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml b/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml index b8bfb817..b990cd00 100644 --- a/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml +++ b/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.636 mass_kilograms: 1390.0 -pwr_aux_watts: 1000.0 +pwr_aux_base_watts: 1000.0 +pwr_aux_max_watts: 2000.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml b/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml index 6f004fa0..a4420af0 100644 --- a/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml +++ b/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 3.0 mass_kilograms: 2600.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Cupra Born.yaml b/cal_and_val/f3-vehicles/2021 Cupra Born.yaml index cd33e08e..fcd35072 100644 --- a/cal_and_val/f3-vehicles/2021 Cupra Born.yaml +++ b/cal_and_val/f3-vehicles/2021 Cupra Born.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.766 mass_kilograms: 1927.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml b/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml index 25653249..a2a330d5 100644 --- a/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 1200.0 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml b/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml index 3c1dad23..dcd96e4f 100644 --- a/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml +++ b/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.52 mass_kilograms: 1050.0 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml b/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml index d7405cd9..582a4eff 100644 --- a/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml +++ b/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 1700.0 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml b/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml index a8ad6a20..cedb4d7e 100644 --- a/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml +++ b/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.6 mass_kilograms: 2728.358 -pwr_aux_watts: 200.0 +pwr_aux_base_watts: 200.0 +pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml b/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml index 86b3be93..a48288bd 100644 --- a/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml +++ b/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.495 mass_kilograms: 1587.573 -pwr_aux_watts: 200.0 +pwr_aux_base_watts: 200.0 +pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml b/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml index f26b7864..fc5afed2 100644 --- a/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml +++ b/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.685 mass_kilograms: 1706.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml b/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml index f78aaf22..704702de 100644 --- a/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml +++ b/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.588 mass_kilograms: 1600.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml b/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml index eb12d59f..2b19763e 100644 --- a/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml +++ b/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.87528 mass_kilograms: 1752.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml b/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml index 1b9ebcd5..3413ad1f 100644 --- a/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml +++ b/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.89 mass_kilograms: 1909.0 -pwr_aux_watts: 200.0 +pwr_aux_base_watts: 200.0 +pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml b/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml index a9442796..36c5faa2 100644 --- a/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml +++ b/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.68986 mass_kilograms: 1814.369 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.97 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml b/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml index ac093c06..d8f13970 100644 --- a/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml +++ b/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.56 mass_kilograms: 1670.0 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.97 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml b/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml index 4eac9129..cab47ce0 100644 --- a/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml +++ b/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.702 mass_kilograms: 2267.962 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml b/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml index 4bfca504..d39e0319 100644 --- a/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml +++ b/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.8 mass_kilograms: 2080.0 -pwr_aux_watts: 1500.0 +pwr_aux_base_watts: 1500.0 +pwr_aux_max_watts: 3000.0 trans_eff: 0.9 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml b/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml index dddf6378..2e670656 100644 --- a/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml +++ b/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.73558 mass_kilograms: 2173.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml b/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml index 1da8a26c..6e698387 100644 --- a/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml +++ b/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.702 mass_kilograms: 2237.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml b/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml index 13c3e94e..d2fe4f20 100644 --- a/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml +++ b/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.7 mass_kilograms: 1405.0 -pwr_aux_watts: 200.0 +pwr_aux_base_watts: 200.0 +pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml b/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml index 63d9d04f..5d29e3f2 100644 --- a/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml +++ b/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.62 mass_kilograms: 1105.0 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml b/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml index 4d06af0d..087ee85a 100644 --- a/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml +++ b/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.6108 mass_kilograms: 1606.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml b/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml index 5788ac9e..14d21917 100644 --- a/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml +++ b/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.552 mass_kilograms: 1202.0 -pwr_aux_watts: 800.0 +pwr_aux_base_watts: 800.0 +pwr_aux_max_watts: 1600.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/BYD ATTO 3.yaml b/cal_and_val/f3-vehicles/BYD ATTO 3.yaml index e51b5ef0..dd0f491b 100644 --- a/cal_and_val/f3-vehicles/BYD ATTO 3.yaml +++ b/cal_and_val/f3-vehicles/BYD ATTO 3.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.588 mass_kilograms: 1950.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml b/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml index 91365dd8..918ffe56 100644 --- a/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml +++ b/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 1.236 mass_kilograms: 183.0 -pwr_aux_watts: 0.0 +pwr_aux_base_watts: 0.0 +pwr_aux_max_watts: 0.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml b/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml index 245d5389..21edd20e 100644 --- a/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml +++ b/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.5 wheel_base_meters: 4.08 mass_kilograms: 6590.0 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.94 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Line Haul Conv.yaml b/cal_and_val/f3-vehicles/Line Haul Conv.yaml index 92d71057..f7543df9 100644 --- a/cal_and_val/f3-vehicles/Line Haul Conv.yaml +++ b/cal_and_val/f3-vehicles/Line Haul Conv.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.7536 mass_kilograms: 21000.0 -pwr_aux_watts: 10000.0 +pwr_aux_base_watts: 10000.0 +pwr_aux_max_watts: 20000.0 trans_eff: 0.8 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml index 4489b46f..dbfb100e 100644 --- a/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.7 wheel_base_meters: 2.45 mass_kilograms: 950.0 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Nissan Navara.yaml b/cal_and_val/f3-vehicles/Nissan Navara.yaml index df1ac1c5..97d32767 100644 --- a/cal_and_val/f3-vehicles/Nissan Navara.yaml +++ b/cal_and_val/f3-vehicles/Nissan Navara.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 2200.0 -pwr_aux_watts: 800.0 +pwr_aux_base_watts: 800.0 +pwr_aux_max_watts: 1600.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml b/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml index cad5d07a..82c2b373 100644 --- a/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml +++ b/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.7536 mass_kilograms: 15076.0 -pwr_aux_watts: 10000.0 +pwr_aux_base_watts: 10000.0 +pwr_aux_max_watts: 20000.0 trans_eff: 0.85 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml b/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml index f8e2bdae..0910d4ed 100644 --- a/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml +++ b/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 1150.0 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml b/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml index 550155b8..980549ab 100644 --- a/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml +++ b/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 1550.0 -pwr_aux_watts: 800.0 +pwr_aux_base_watts: 800.0 +pwr_aux_max_watts: 1600.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml b/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml index dc81f2f4..32f4b30d 100644 --- a/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml +++ b/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.56 mass_kilograms: 1750.0 -pwr_aux_watts: 500.0 +pwr_aux_base_watts: 500.0 +pwr_aux_max_watts: 1000.0 trans_eff: 0.97 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml b/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml index a3e144dd..2b3e3b42 100644 --- a/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml +++ b/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 1100.0 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml b/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml index a037262f..9131d763 100644 --- a/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml +++ b/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.3 mass_kilograms: 2600.0 -pwr_aux_watts: 900.0 +pwr_aux_base_watts: 900.0 +pwr_aux_max_watts: 1800.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Mirai.yaml b/cal_and_val/f3-vehicles/Toyota Mirai.yaml index 3a3d221f..64a307f8 100644 --- a/cal_and_val/f3-vehicles/Toyota Mirai.yaml +++ b/cal_and_val/f3-vehicles/Toyota Mirai.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.78 mass_kilograms: 1929.5047475207882 -pwr_aux_watts: 300.0 +pwr_aux_base_watts: 300.0 +pwr_aux_max_watts: 600.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml b/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml index ef7878b8..40a654be 100755 --- a/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml +++ b/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml @@ -241,7 +241,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.72 mass_kilograms: 1644.2724500334996 -pwr_aux_watts: 700.0 +pwr_aux_base_watts: 700.0 +pwr_aux_max_watts: 1400.0 trans_eff: 0.875 save_interval: 1 state: diff --git a/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml b/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml index ce192f9c..9b59a067 100755 --- a/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml +++ b/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml @@ -654,9 +654,10 @@ pt_type: save_interval: 1 pt_cntrl: RGWDB: - speed_soc_accel_buffer: 17.8816 - speed_soc_accel_buffer_coeff: 1.0 + speed_soc_disch_buffer: 17.8816 + speed_soc_disch_buffer_coeff: 1.0 speed_soc_fc_on_buffer: 19.66976 + speed_soc_fc_on_buffer_coeff: 1.0 speed_soc_regen_buffer: 13.4112 speed_soc_regen_buffer_coeff: 1.0 fc_min_time_on: 5.0 @@ -685,7 +686,8 @@ chassis: drive_axle_weight_frac: 0.59 wheel_base_meters: 2.7 mass_kilograms: 1635.0 -pwr_aux_watts: 1050.0 +pwr_aux_base_watts: 1050.0 +pwr_aux_max_watts: 2100.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml b/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml index f78aaf22..704702de 100644 --- a/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml +++ b/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml @@ -93,7 +93,8 @@ chassis: drive_axle_weight_frac: 0.61 wheel_base_meters: 2.588 mass_kilograms: 1600.0 -pwr_aux_watts: 250.0 +pwr_aux_base_watts: 250.0 +pwr_aux_max_watts: 500.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/fastsim-core/src/prelude.rs b/fastsim-core/src/prelude.rs index 1c9d58dc..ca5b846d 100755 --- a/fastsim-core/src/prelude.rs +++ b/fastsim-core/src/prelude.rs @@ -5,7 +5,13 @@ pub use crate::drive_cycle::{Cycle, CycleElement}; pub use crate::gas_properties::{get_sphere_conv_params, Air, Octane, TE_STD_AIR}; pub use crate::simdrive::{SimDrive, SimParams}; pub use crate::utils::{Pyo3Vec2Wrapper, Pyo3Vec3Wrapper, Pyo3VecBoolWrapper, Pyo3VecWrapper}; -pub use crate::vehicle::cabin::{CabinOption, LumpedCabin}; +pub use crate::vehicle::cabin::{ + CabinOption, LumpedCabin, LumpedCabinState, LumpedCabinStateHistoryVec, +}; +pub use crate::vehicle::hvac::{ + HVACOption, HVACSystemForLumpedCabin, HVACSystemForLumpedCabinState, + HVACSystemForLumpedCabinStateHistoryVec, +}; pub use crate::vehicle::powertrain::electric_machine::{ ElectricMachine, ElectricMachineState, ElectricMachineStateHistoryVec, }; diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index 89344a8a..66e47235 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -183,11 +183,23 @@ impl SimDrive { } /// Solves current time step - /// # Arguments pub fn solve_step(&mut self) -> anyhow::Result<()> { let i = self.veh.state.i; let dt = self.cyc.dt_at_i(i)?; let speed_prev = self.veh.state.speed_ach; + // TODO: make sure `pwr_aux` is updated in here and propagated to `set_curr_pwr_out_max` + // maybe make a static `pwr_aux_max` and controls like: + // ``` + // pub enum HVACAuxPriority { + // /// Prioritize [ReversibleEnergyStorage] thermal management + // ReversibleEnergyStorage + // /// Prioritize [Cabin] and [ReversibleEnergyStorage] proportionally to their requests + // Proportional + // } + // ``` + self.veh + .solve_thermal(self.cyc.temp_amb_air[i], self.veh.state, dt) + .with_context(|| format_dbg!())?; self.veh .set_curr_pwr_out_max(dt) .with_context(|| anyhow!(format_dbg!()))?; @@ -199,9 +211,6 @@ impl SimDrive { self.veh .solve_powertrain(dt) .with_context(|| anyhow!(format_dbg!()))?; - self.veh - .solve_thermal(self.cyc.temp_amb_air[i], self.veh.state, dt) - .with_context(|| format_dbg!())?; self.veh.set_cumulative(dt); Ok(()) } diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index 9c30d2a2..a47f65bc 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -141,7 +141,7 @@ impl Powertrain for BatteryElectricVehicle { fn solve_thermal( &mut self, te_amb: si::Temperature, - _heat_demand: si::Power, + _pwr_thrl_fc_to_cab: si::Power, _veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index a33551a8..d541f247 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -17,7 +17,9 @@ impl Init for CabinOption { fn init(&mut self) -> anyhow::Result<()> { match self { Self::LumpedCabin(scc) => scc.init()?, - Self::LumpedCabinWithShell => {} + Self::LumpedCabinWithShell => { + todo!() + } Self::None => {} } Ok(()) @@ -41,11 +43,9 @@ pub struct LumpedCabin { pub length: si::Length, /// cabin width, modeled as a flat plate pub width: si::Length, - /// HVAC model - pub hvac: HVACSystemForSCC, + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: LumpedCabinState, - #[serde(default)] - #[serde(skip_serializing_if = "LumpedCabinStateHistoryVec::is_empty")] + #[serde(default, skip_serializing_if = "LumpedCabinStateHistoryVec::is_empty")] pub history: LumpedCabinStateHistoryVec, // TODO: add `save_interval` and associated method } @@ -62,23 +62,17 @@ impl LumpedCabin { /// Solve temperatures, HVAC powers, and cumulative energies of cabin and HVAC system /// Arguments: /// - `te_amb_air`: ambient air temperature - /// - `te_fc`: [FuelConverter] temperature, as appropriate for [PowertrainType] + /// - `veh_state`: current [VehicleState] + /// - 'pwr_thermal_from_hvac`: power to cabin from HVAC system /// - `dt`: simulation time step size pub fn solve( &mut self, te_amb_air: si::Temperature, - te_fc: Option, veh_state: VehicleState, + pwr_thermal_from_hvac: si::Power, dt: si::Time, ) -> anyhow::Result<()> { - self.state.pwr_thermal_from_hvac = self.hvac.get_pwr_thermal_from_hvac( - te_amb_air, - te_fc, - self.state, - self.heat_capacitance, - dt, - )?; - + self.state.pwr_thermal_from_hvac = pwr_thermal_from_hvac; // flat plate model for isothermal, mixed-flow from Incropera and deWitt, Fundamentals of Heat and Mass // Transfer, 7th Edition let cab_te_film_ext = 0.5 * (self.state.temp + te_amb_air); @@ -135,7 +129,6 @@ pub struct LumpedCabinState { /// time step counter pub i: u32, /// lumped cabin temperature - // TODO: make sure this gets updated pub temp: si::Temperature, /// lumped cabin temperature at previous simulation time step // TODO: make sure this gets updated @@ -158,226 +151,3 @@ pub struct LumpedCabinState { impl Init for LumpedCabinState {} impl SerdeAPI for LumpedCabinState {} - -#[fastsim_api] -#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -/// HVAC system for [LumpedCabin] -pub struct HVACSystemForSCC { - /// set point temperature - pub te_set: si::Temperature, - /// deadband range. any cabin temperature within this range of - /// `te_set` results in no HVAC power draw - pub te_deadband: si::Temperature, - /// HVAC proportional gain - pub p: si::ThermalConductance, - /// HVAC integral gain [W / K / s], resets at zero crossing events - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub i: f64, - /// value at which [Self::i] stops accumulating - pub pwr_i_max: si::Power, - /// HVAC derivative gain [W / K * s] - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub d: f64, - /// max HVAC thermal power - pub pwr_thermal_max: si::Power, - /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by - /// coefficient of performance (COP) - pub frac_of_ideal_cop: f64, - /// heat source - #[api(skip_get, skip_set)] - pub heat_source: CabinHeatSource, - /// max allowed aux load - pub pwr_aux_max: si::Power, - /// coefficient of performance of vapor compression cycle - pub state: HVACSystemForSCCState, - #[serde(default)] - #[serde(skip_serializing_if = "HVACSystemForSCCStateHistoryVec::is_empty")] - pub history: HVACSystemForSCCStateHistoryVec, -} -impl Init for HVACSystemForSCC {} -impl SerdeAPI for HVACSystemForSCC {} -impl HVACSystemForSCC { - pub fn get_pwr_thermal_from_hvac( - &mut self, - te_amb_air: si::Temperature, - te_fc: Option, - cab_state: LumpedCabinState, - cab_heat_cap: si::HeatCapacity, - dt: si::Time, - ) -> anyhow::Result { - let pwr_from_hvac = if cab_state.temp <= self.te_set + self.te_deadband - && cab_state.temp >= self.te_set - self.te_deadband - { - // inside deadband; no hvac power is needed - - self.state.pwr_i = si::Power::ZERO; // reset to 0.0 - self.state.pwr_p = si::Power::ZERO; - self.state.pwr_d = si::Power::ZERO; - si::Power::ZERO - } else { - let te_delta_vs_set = cab_state.temp - self.te_set; - let te_delta_vs_amb: si::Temperature = cab_state.temp - te_amb_air; - - self.state.pwr_p = -self.p * te_delta_vs_set; - self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; - self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); - self.state.pwr_d = - -self.d * uc::J / uc::KELVIN * ((cab_state.temp - cab_state.temp_prev) / dt); - - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - cab_state.temp / (5.0 * uc::KELVIN) - } else { - cab_state.temp / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - - if cab_state.temp > self.te_set + self.te_deadband { - // COOLING MODE; cabin is hotter than set point - - if self.state.pwr_i > si::Power::ZERO { - // If `pwr_i` is greater than zero, reset to switch from heating to cooling - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thermal_from_hvac = - (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) - .max(-self.pwr_thermal_max); - - if (-pwr_thermal_from_hvac / self.state.cop) > self.pwr_aux_max { - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - pwr_thermal_from_hvac = -self.state.pwr_aux * self.state.cop; - } else { - self.state.pwr_aux = pwr_thermal_from_hvac / self.state.cop; - } - self.state.pwr_thermal_req = si::Power::ZERO; - pwr_thermal_from_hvac - } else { - // HEATING MODE; cabin is colder than set point - - if self.state.pwr_i < si::Power::ZERO { - // If `pwr_i` is less than zero reset to switch from cooling to heating - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thermal_from_hvac = - (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) - .min(self.pwr_thermal_max); - - // Assumes blower has negligible impact on aux load, may want to revise later - match self.heat_source { - CabinHeatSource::FuelConverter => { - ensure!( - te_fc.is_some(), - "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", - format_dbg!() - ); - // limit heat transfer to be substantially less than what is physically possible - // i.e. the engine can't drop below cabin temperature to heat the cabin - pwr_thermal_from_hvac = pwr_thermal_from_hvac - .min( - cab_heat_cap * - (te_fc.unwrap() - cab_state.temp) - * 0.1 // so that it's substantially less - / dt, - ) - .max(si::Power::ZERO); - self.state.cop = f64::NAN * uc::R; - self.state.pwr_thermal_req = pwr_thermal_from_hvac; - // Assumes aux power needed for heating is incorporated into based aux load. - // TODO: refine this, perhaps by making aux power - // proportional to heating power, to account for blower power - self.state.pwr_aux = si::Power::ZERO; - // TODO: think about what to do for PHEV, which needs careful consideration here - // HEV probably also needs careful consideration - // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on - } - CabinHeatSource::ResistanceHeater => { - self.state.cop = uc::R; - self.state.pwr_thermal_req = si::Power::ZERO; - self.state.pwr_aux = pwr_thermal_from_hvac; - } - CabinHeatSource::HeatPump => { - self.state.pwr_thermal_req = si::Power::ZERO; - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - // TODO: make sure this is right for heating! - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - cab_state.temp / (5.0 * uc::KELVIN) - } else { - cab_state.temp / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - self.state.pwr_thermal_req = si::Power::ZERO; - if (pwr_thermal_from_hvac / self.state.cop) > self.pwr_aux_max { - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - pwr_thermal_from_hvac = -self.state.pwr_aux * self.state.cop; - } else { - self.state.pwr_aux = pwr_thermal_from_hvac / self.state.cop; - } - } - } - pwr_thermal_from_hvac - } - }; - Ok(pwr_from_hvac) - } -} - -#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] -pub enum CabinHeatSource { - /// [FuelConverter], if applicable, provides heat for HVAC system - FuelConverter, - /// Resistance heater provides heat for HVAC system - ResistanceHeater, - /// Heat pump provides heat for HVAC system - HeatPump, -} -impl Init for CabinHeatSource {} -impl SerdeAPI for CabinHeatSource {} - -#[fastsim_api] -#[derive( - Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, -)] -pub struct HVACSystemForSCCState { - /// time step counter - pub i: u32, - /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain - pub pwr_p: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain - pub energy_p: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain - pub pwr_i: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain - pub energy_i: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain - pub pwr_d: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain - pub energy_d: si::Energy, - /// coefficient of performance (i.e. efficiency) of vapor compression cycle - pub cop: si::Ratio, - /// Aux power demand from HVAC system - pub pwr_aux: si::Power, - /// Cumulative aux energy for HVAC system - pub energy_aux: si::Energy, - /// Thermal power demand by HVAC system from thermal component (e.g. [FuelConverter]) - pub pwr_thermal_req: si::Power, - /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) - pub energy_thermal_req: si::Energy, -} -impl Init for HVACSystemForSCCState {} -impl SerdeAPI for HVACSystemForSCCState {} diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index 73da4c32..fd743ef2 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -56,11 +56,12 @@ impl Powertrain for Box { fn solve_thermal( &mut self, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { - self.fc.solve_thermal(te_amb, heat_demand, veh_state, dt) + self.fc + .solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) } fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index 47b2b098..2db9d659 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -24,12 +24,10 @@ pub struct HybridElectricVehicle { #[serde(default)] pub sim_params: HEVSimulationParams, /// field for tracking current state - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: HEVState, /// vector of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "HEVStateHistoryVec::is_empty")] + #[serde(default, skip_serializing_if = "HEVStateHistoryVec::is_empty")] pub history: HEVStateHistoryVec, /// vector of SOC balance iterations #[serde(default)] @@ -81,7 +79,7 @@ impl Powertrain for Box { })? { self.state.fc_on_causes.push(FCOnCause::OnTimeTooShort) } - }, + } HEVPowertrainControls::Placeholder => { todo!() } @@ -93,13 +91,13 @@ impl Powertrain for Box { HEVPowertrainControls::RGWDB(rgwb) => { (0.5 * veh_state.mass * (rgwb - .speed_soc_accel_buffer + .speed_soc_disch_buffer .with_context(|| format_dbg!())? .powi(typenum::P2::new()) - veh_state.speed_ach.powi(typenum::P2::new()))) .max(si::Energy::ZERO) * rgwb - .speed_soc_accel_buffer_coeff + .speed_soc_disch_buffer_coeff .with_context(|| format_dbg!())? } HEVPowertrainControls::Placeholder => { @@ -173,6 +171,11 @@ impl Powertrain for Box { _enabled: bool, dt: si::Time, ) -> anyhow::Result<()> { + // TODO: address these concerns + // - add a transmission here + // - what happens when the fc is on and producing more power than the + // transmission requires? It seems like the excess goes straight to the battery, + // but it should probably go thourgh the em somehow. let (fc_pwr_out_req, em_pwr_out_req) = self .pt_cntrl .get_pwr_fc_and_em( @@ -193,6 +196,7 @@ impl Powertrain for Box { .em .get_pwr_in_req(em_pwr_out_req, dt) .with_context(|| format_dbg!())?; + // TODO: `res_pwr_out_req` probably does not include charging from the engine self.res .solve(res_pwr_out_req, dt) .with_context(|| format_dbg!())?; @@ -202,12 +206,12 @@ impl Powertrain for Box { fn solve_thermal( &mut self, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { self.fc - .solve_thermal(te_amb, heat_demand, veh_state, dt) + .solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) .with_context(|| format_dbg!())?; self.res .solve_thermal(te_amb, dt) @@ -322,7 +326,7 @@ impl FCOnCauses { } } -// TODO: figure out why this is not turning in the dataframe but is in teh pydict +// TODO: figure out why this is not appearing in the dataframe but is in the pydict #[fastsim_api] #[derive(Clone, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative)] pub struct HEVState { @@ -334,8 +338,6 @@ pub struct HEVState { /// Number of `walk` iterations required to achieve SOC balance (i.e. SOC /// ends at same starting value, ensuring no net [ReversibleEnergyStorage] usage) pub soc_bal_iters: u32, - /// buffer at which FC is forced on - pub soc_fc_on_buffer: si::Ratio, } impl Init for HEVState {} @@ -431,8 +433,9 @@ pub enum HEVAuxControls { #[derive(Clone, Debug, PartialEq, Deserialize, Serialize)] pub enum HEVPowertrainControls { /// Controls that attempt to match fastsim-2 - RGWDB(RESGreedyWithDynamicBuffers), - /// Controls that have a dynamically updated discharge buffer but are otherwise similar to [Self::Fastsim2] + RGWDB(Box), + /// Controls that have a dynamically updated discharge buffer but are + /// otherwise similar to [Self::Fastsim2] Placeholder, } @@ -456,7 +459,7 @@ impl Init for HEVPowertrainControls { impl HEVPowertrainControls { fn get_pwr_fc_and_em( - &self, + &mut self, pwr_out_req: si::Power, veh_state: VehicleState, hev_state: &mut HEVState, @@ -464,8 +467,6 @@ impl HEVPowertrainControls { em_state: &ElectricMachineState, res: &ReversibleEnergyStorage, ) -> anyhow::Result<(si::Power, si::Power)> { - // TODO: - // - [ ] make buffers soft limits that aren't enforced, just suggested let fc_state = &fc.state; if pwr_out_req >= si::Power::ZERO { ensure!( @@ -484,8 +485,8 @@ impl HEVPowertrainControls { fc_state.pwr_prop_max.get::() ); // positive net power out of the powertrain - let (fc_pwr, em_pwr) = match &self { - HEVPowertrainControls::RGWDB(rgwb) => { + let (fc_pwr, em_pwr) = match self { + HEVPowertrainControls::RGWDB(ref mut rgwb) => { // cannot exceed ElectricMachine max output power. Excess demand will be handled by `fc` let em_pwr = pwr_out_req.min(em_state.pwr_mech_fwd_out_max); let frac_pwr_demand_fc_forced_on: si::Ratio = rgwb @@ -496,7 +497,6 @@ impl HEVPowertrainControls { .with_context(|| format_dbg!())?; // If the motor cannot produce more than the required power times a // `fc_pwr_frac_demand_forced_on`, then the engine should be on - // TODO: account for transmission efficiency here or somewhere if pwr_out_req > frac_pwr_demand_fc_forced_on * (em_state.pwr_mech_fwd_out_max + fc_state.pwr_out_max) @@ -512,21 +512,22 @@ impl HEVPowertrainControls { hev_state.fc_on_causes.push(FCOnCause::VehicleSpeedTooHigh); } - hev_state.soc_fc_on_buffer = { - (0.5 * veh_state.mass + rgwb.state.soc_fc_on_buffer = { + let energy_delta_to_buffer_speed = 0.5 + * veh_state.mass * (rgwb .speed_soc_fc_on_buffer .with_context(|| format_dbg!())? .powi(typenum::P2::new()) - - veh_state.speed_ach.powi(typenum::P2::new()))) - .max(si::Energy::ZERO) + - veh_state.speed_ach.powi(typenum::P2::new())); + energy_delta_to_buffer_speed.max(si::Energy::ZERO) * rgwb - .speed_soc_accel_buffer_coeff + .speed_soc_fc_on_buffer_coeff .with_context(|| format_dbg!())? } / res.energy_capacity_usable() + res.min_soc; - if res.state.soc < hev_state.soc_fc_on_buffer { + if res.state.soc < rgwb.state.soc_fc_on_buffer { hev_state.fc_on_causes.push(FCOnCause::ChargingForLowSOC) } if pwr_out_req - em_state.pwr_mech_fwd_out_max >= si::Power::ZERO { @@ -574,12 +575,14 @@ impl HEVPowertrainControls { pub struct RESGreedyWithDynamicBuffers { /// RES energy delta from minimum SOC corresponding to kinetic energy of /// vehicle at this speed that triggers ramp down in RES discharge. - pub speed_soc_accel_buffer: Option, + pub speed_soc_disch_buffer: Option, /// Coefficient for modifying amount of accel buffer - pub speed_soc_accel_buffer_coeff: Option, + pub speed_soc_disch_buffer_coeff: Option, /// RES energy delta from minimum SOC corresponding to kinetic energy of /// vehicle at this speed that triggers FC to be forced on. pub speed_soc_fc_on_buffer: Option, + /// Coefficient for modifying amount of [Self::speed_soc_fc_on_buffer] + pub speed_soc_fc_on_buffer_coeff: Option, /// RES energy delta from maximum SOC corresponding to kinetic energy of /// vehicle at current speed minus kinetic energy of vehicle at this speed /// triggers ramp down in RES discharge @@ -591,34 +594,42 @@ pub struct RESGreedyWithDynamicBuffers { pub fc_min_time_on: Option, /// Speed at which [fuelconverter] is forced on. pub speed_fc_forced_on: Option, - /// Fraction of total aux and powertrain power demand at which + /// Fraction of total aux and powertrain rated power at which /// [FuelConverter] is forced on. pub frac_pwr_demand_fc_forced_on: Option, /// Force engine, if on, to run at this fraction of power at which peak - /// efficiency occurs or the required power, whichever is greater. If SOC - /// is below min buffer, engine will run at this level and charge. - /// to 1. + /// efficiency occurs or the required power, whichever is greater. If SOC is + /// below min buffer or engine is otherwise forced on and battery has room + /// to receive charge, engine will run at this level and charge. pub frac_of_most_eff_pwr_to_run_fc: Option, /// Fraction of available charging capacity to use toward running the engine /// efficiently. // NOTE: this is inherited from fastsim-2 and has no effect here. After // further thought, either remove it or use it. pub frac_res_chrg_for_fc: si::Ratio, + // TODO: put `save_interval` in here // NOTE: this is inherited from fastsim-2 and has no effect here. After // further thought, either remove it or use it. /// Fraction of available discharging capacity to use toward running the /// engine efficiently. pub frac_res_dschrg_for_fc: si::Ratio, + /// current state of control variables + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] + pub state: RGWDBState, + #[serde(default, skip_serializing_if = "RGWDBStateHistoryVec::is_empty")] + /// history of current state + pub history: RGWDBStateHistoryVec, } impl Init for RESGreedyWithDynamicBuffers { fn init(&mut self) -> anyhow::Result<()> { // TODO: make sure these values propagate to the documented defaults above - self.speed_soc_accel_buffer = self.speed_soc_accel_buffer.or(Some(40.0 * uc::MPH)); - self.speed_soc_accel_buffer_coeff = self.speed_soc_accel_buffer_coeff.or(Some(1.0 * uc::R)); + self.speed_soc_disch_buffer = self.speed_soc_disch_buffer.or(Some(40.0 * uc::MPH)); + self.speed_soc_disch_buffer_coeff = self.speed_soc_disch_buffer_coeff.or(Some(1.0 * uc::R)); self.speed_soc_fc_on_buffer = self .speed_soc_fc_on_buffer - .or(Some(self.speed_soc_accel_buffer.unwrap() * 1.1)); + .or(Some(self.speed_soc_disch_buffer.unwrap() * 1.1)); + self.speed_soc_fc_on_buffer_coeff = self.speed_soc_fc_on_buffer_coeff.or(Some(1.0 * uc::R)); self.speed_soc_regen_buffer = self.speed_soc_regen_buffer.or(Some(30. * uc::MPH)); self.speed_soc_regen_buffer_coeff = self.speed_soc_regen_buffer_coeff.or(Some(1.0 * uc::R)); self.fc_min_time_on = self.fc_min_time_on.or(Some(uc::S * 5.0)); @@ -631,3 +642,22 @@ impl Init for RESGreedyWithDynamicBuffers { Ok(()) } } + +#[fastsim_api] +#[derive(Clone, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative)] +/// State for [RESGreedyWithDynamicBuffers ] +pub struct RGWDBState { + /// time step index + pub i: usize, + /// Vector of posssible reasons the fc is forced on + #[api(skip_get, skip_set)] + pub fc_on_causes: FCOnCauses, + /// Number of `walk` iterations required to achieve SOC balance (i.e. SOC + /// ends at same starting value, ensuring no net [ReversibleEnergyStorage] usage) + pub soc_bal_iters: u32, + /// buffer at which FC is forced on + pub soc_fc_on_buffer: si::Ratio, +} + +impl Init for RGWDBState {} +impl SerdeAPI for RGWDBState {} diff --git a/fastsim-core/src/vehicle/hvac.rs b/fastsim-core/src/vehicle/hvac.rs new file mode 100644 index 00000000..446f7cc2 --- /dev/null +++ b/fastsim-core/src/vehicle/hvac.rs @@ -0,0 +1,289 @@ +use super::*; + +/// Options for handling HVAC system +#[derive(Clone, Default, Debug, Serialize, Deserialize, PartialEq, IsVariant)] +pub enum HVACOption { + /// Basic single thermal capacitance cabin thermal model, including + /// HVAC system and controls, accounting for possiblity of + /// [ReversibleEnergyStorage] with thermal management + LumpedCabin(Box), + /// Cabin with interior and shell capacitances + LumpedCabinWithShell, + /// [ReversibleEnergyStorage] thermal management with no cabin + ReversibleEnergyStorageOnly, + /// no cabin thermal model + #[default] + None, +} +impl Init for HVACOption { + fn init(&mut self) -> anyhow::Result<()> { + match self { + Self::LumpedCabin(scc) => scc.init()?, + Self::LumpedCabinWithShell => { + todo!() + } + Self::ReversibleEnergyStorageOnly => { + todo!() + } + Self::None => {} + } + Ok(()) + } +} +impl SerdeAPI for HVACOption {} + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// HVAC system for [LumpedCabin] +pub struct HVACSystemForLumpedCabin { + /// set point temperature + pub te_set: si::Temperature, + /// deadband range. any cabin temperature within this range of + /// `te_set` results in no HVAC power draw + pub te_deadband: si::Temperature, + /// HVAC proportional gain + pub p: si::ThermalConductance, + /// HVAC integral gain [W / K / s], resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i: f64, + /// value at which [Self::i] stops accumulating + pub pwr_i_max: si::Power, + /// HVAC derivative gain [W / K * s] + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d: f64, + /// max HVAC thermal power + pub pwr_thermal_max: si::Power, + /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by + /// coefficient of performance (COP) + pub frac_of_ideal_cop: f64, + /// heat source + #[api(skip_get, skip_set)] + pub heat_source: CabinHeatSource, + /// max allowed aux load + pub pwr_aux_max: si::Power, + /// coefficient of performance of vapor compression cycle + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] + pub state: HVACSystemForLumpedCabinState, + #[serde( + default, + skip_serializing_if = "HVACSystemForLumpedCabinStateHistoryVec::is_empty" + )] + pub history: HVACSystemForLumpedCabinStateHistoryVec, +} +impl Init for HVACSystemForLumpedCabin {} +impl SerdeAPI for HVACSystemForLumpedCabin {} +impl HVACSystemForLumpedCabin { + pub fn solve( + &mut self, + te_amb_air: si::Temperature, + te_fc: Option, + cab_state: LumpedCabinState, + cab_heat_cap: si::HeatCapacity, + dt: si::Time, + ) -> anyhow::Result<(si::Power, si::Power)> { + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = if cab_state.temp + <= self.te_set + self.te_deadband + && cab_state.temp >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p = si::Power::ZERO; + self.state.pwr_d = si::Power::ZERO; + (si::Power::ZERO, si::Power::ZERO) + } else { + // outside deadband + let te_delta_vs_set = cab_state.temp - self.te_set; + let te_delta_vs_amb: si::Temperature = cab_state.temp - te_amb_air; + + self.state.pwr_p = -self.p * te_delta_vs_set; + self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); + self.state.pwr_d = + -self.d * uc::J / uc::KELVIN * ((cab_state.temp - cab_state.temp_prev) / dt); + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temp / (5.0 * uc::KELVIN) + } else { + cab_state.temp / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = + if cab_state.temp > self.te_set + self.te_deadband { + // COOLING MODE; cabin is hotter than set point + + if self.state.pwr_i > si::Power::ZERO { + // If `pwr_i` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cab = + (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) + .max(-self.pwr_thermal_max); + + if (-pwr_thrml_hvac_to_cab / self.state.cop) > self.pwr_aux_max { + // TODO: maybe change this to a static `pwr_aux_max` + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + pwr_thrml_hvac_to_cab = -self.state.pwr_aux * self.state.cop; + } else { + // TODO: maybe change this to a static `pwr_aux_max` + self.state.pwr_aux = pwr_thrml_hvac_to_cab / self.state.cop; + } + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + (pwr_thrml_hvac_to_cab, pwr_thrml_fc_to_cabin) + } else { + // HEATING MODE; cabin is colder than set point + + if self.state.pwr_i < si::Power::ZERO { + // If `pwr_i` is less than zero reset to switch from cooling to heating + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cabin = + (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) + .min(self.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + let pwr_thrml_fc_to_cabin = self + .handle_heat_source( + te_fc, + te_delta_vs_amb, + &mut pwr_thrml_hvac_to_cabin, + cab_heat_cap, + cab_state, + dt, + ) + .with_context(|| format_dbg!())?; + (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) + }; + (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) + }; + Ok((pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin)) + } + + fn handle_heat_source( + &mut self, + te_fc: Option, + te_delta_vs_amb: si::Temperature, + pwr_thrml_hvac_to_cabin: &mut si::Power, + cab_heat_cap: si::HeatCapacity, + cab_state: LumpedCabinState, + dt: si::Time, + ) -> anyhow::Result { + let pwr_thrml_fc_to_cabin = match self.heat_source { + CabinHeatSource::FuelConverter => { + ensure!( + te_fc.is_some(), + "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", + format_dbg!() + ); + // limit heat transfer to be substantially less than what is physically possible + // i.e. the engine can't drop below cabin temperature to heat the cabin + *pwr_thrml_hvac_to_cabin = pwr_thrml_hvac_to_cabin + .min( + cab_heat_cap * + (te_fc.unwrap() - cab_state.temp) + * 0.1 // so that it's substantially less + / dt, + ) + .max(si::Power::ZERO); + self.state.cop = f64::NAN * uc::R; + let pwr_thrml_fc_to_cabin = *pwr_thrml_hvac_to_cabin; + // Assumes aux power needed for heating is incorporated into based aux load. + // TODO: refine this, perhaps by making aux power + // proportional to heating power, to account for blower power + self.state.pwr_aux = si::Power::ZERO; + // TODO: think about what to do for PHEV, which needs careful consideration here + // HEV probably also needs careful consideration + // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on + pwr_thrml_fc_to_cabin + } + CabinHeatSource::ResistanceHeater => { + self.state.cop = uc::R; + self.state.pwr_aux = *pwr_thrml_hvac_to_cabin; // COP is 1 so does not matter + #[allow(clippy::let_and_return)] // for readability + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + pwr_thrml_fc_to_cabin + } + CabinHeatSource::HeatPump => { + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + // TODO: make sure this is right for heating! + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temp / (5.0 * uc::KELVIN) + } else { + cab_state.temp / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + if (*pwr_thrml_hvac_to_cabin / self.state.cop) > self.pwr_aux_max { + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + *pwr_thrml_hvac_to_cabin = -self.state.pwr_aux * self.state.cop; + } else { + self.state.pwr_aux = *pwr_thrml_hvac_to_cabin / self.state.cop; + } + #[allow(clippy::let_and_return)] // for readability + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + pwr_thrml_fc_to_cabin + } + }; + Ok(pwr_thrml_fc_to_cabin) + } +} + +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] +pub enum CabinHeatSource { + /// [FuelConverter], if applicable, provides heat for HVAC system + FuelConverter, + /// Resistance heater provides heat for HVAC system + ResistanceHeater, + /// Heat pump provides heat for HVAC system + HeatPump, +} +impl Init for CabinHeatSource {} +impl SerdeAPI for CabinHeatSource {} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct HVACSystemForLumpedCabinState { + /// time step counter + pub i: u32, + /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain + pub pwr_p: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain + pub energy_p: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain + pub pwr_i: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain + pub energy_i: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain + pub pwr_d: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain + pub energy_d: si::Energy, + /// coefficient of performance (i.e. efficiency) of vapor compression cycle + pub cop: si::Ratio, + /// Au power demand from HVAC system + pub pwr_aux: si::Power, + /// Cumulative aux energy for HVAC system + pub energy_aux: si::Energy, + /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub energy_thermal_req: si::Energy, +} +impl Init for HVACSystemForLumpedCabinState {} +impl SerdeAPI for HVACSystemForLumpedCabinState {} diff --git a/fastsim-core/src/vehicle/mod.rs b/fastsim-core/src/vehicle/mod.rs index 968f4980..35f28f7a 100755 --- a/fastsim-core/src/vehicle/mod.rs +++ b/fastsim-core/src/vehicle/mod.rs @@ -6,21 +6,16 @@ pub(crate) use crate::imports::*; pub use crate::prelude::*; -// powertrain types pub mod bev; +pub mod cabin; +pub mod chassis; pub mod conv; pub mod hev; - -// powertrain components +pub mod hvac; pub mod powertrain; - -// vehicle model -pub mod cabin; -pub mod chassis; pub mod powertrain_type; pub mod traits; pub mod vehicle_model; - pub use bev::BatteryElectricVehicle; pub use chassis::Chassis; pub use conv::ConventionalVehicle; diff --git a/fastsim-core/src/vehicle/powertrain/electric_machine.rs b/fastsim-core/src/vehicle/powertrain/electric_machine.rs index 35a702e8..829de3f5 100755 --- a/fastsim-core/src/vehicle/powertrain/electric_machine.rs +++ b/fastsim-core/src/vehicle/powertrain/electric_machine.rs @@ -85,12 +85,13 @@ pub struct ElectricMachine { #[serde(skip_serializing_if = "Option::is_none")] pub save_interval: Option, /// struct for tracking current state - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: ElectricMachineState, /// Custom vector of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "ElectricMachineStateHistoryVec::is_empty")] + #[serde( + default, + skip_serializing_if = "ElectricMachineStateHistoryVec::is_empty" + )] pub history: ElectricMachineStateHistoryVec, } diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index bd9cc1bc..0b60075b 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -83,12 +83,13 @@ pub struct FuelConverter { #[serde(skip_serializing_if = "Option::is_none")] pub save_interval: Option, /// struct for tracking current state - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: FuelConverterState, /// Custom vector of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "FuelConverterStateHistoryVec::is_empty")] + #[serde( + default, + skip_serializing_if = "FuelConverterStateHistoryVec::is_empty" + )] pub history: FuelConverterStateHistoryVec, #[serde(skip)] // phantom private field to prevent direct instantiation in other modules @@ -276,6 +277,7 @@ impl FuelConverter { ) ); self.state.pwr_prop = pwr_out_req; + // TODO: make this temperature dependent self.state.eff = if fc_on { uc::R * self @@ -292,7 +294,7 @@ impl FuelConverter { })? } else { si::Ratio::ZERO - }; + } * self.thrml.temp_eff_coeff().unwrap_or(1.0 * uc::R); ensure!( (self.state.eff >= 0.0 * uc::R && self.state.eff <= 1.0 * uc::R), format!( @@ -324,13 +326,13 @@ impl FuelConverter { pub fn solve_thermal( &mut self, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { let veh_speed = veh_state.speed_ach; self.thrml - .solve(&self.state, te_amb, heat_demand, veh_speed, dt) + .solve(&self.state, te_amb, pwr_thrl_fc_to_cab, veh_speed, dt) .with_context(|| format_dbg!()) } @@ -405,6 +407,7 @@ pub enum FuelConverterThermalOption { #[default] None, } + impl Init for FuelConverterThermalOption { fn init(&mut self) -> anyhow::Result<()> { match self { @@ -420,26 +423,40 @@ impl FuelConverterThermalOption { /// # Arguments /// - `fc_state`: [FuelConverter] state /// - `te_amb`: ambient temperature - /// - `heat_demand`: heat demand from HVAC system + /// - `pwr_thrl_fc_to_cab`: heat demand from HVAC system /// - `veh_speed`: current achieved speed fn solve( &mut self, fc_state: &FuelConverterState, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { match self { Self::FuelConverterThermal(fct) => fct - .solve(fc_state, te_amb, heat_demand, veh_speed, dt) + .solve(fc_state, te_amb, pwr_thrl_fc_to_cab, veh_speed, dt) .with_context(|| format_dbg!())?, Self::None => { + ensure!( + pwr_thrl_fc_to_cab == si::Power::ZERO, + format_dbg!( + "`FuelConverterThermal needs to be configured to provide heat demand`" + ) + ); // TODO: make sure this triggers error if appropriate } } Ok(()) } + + /// If appropriately configured, returns temperature-dependent efficiency coefficient + fn temp_eff_coeff(&self) -> Option { + match self { + Self::FuelConverterThermal(fct) => Some(fct.state.eff_coeff), + Self::None => None, + } + } } #[fastsim_api] @@ -470,13 +487,17 @@ pub struct FuelConverterThermal { /// Radiator effectiveness -- ratio of active heat rejection from /// radiator to passive heat rejection, always greater than 1 pub radiator_effectiveness: si::Ratio, + /// Model for [FuelConverter] dependence on efficiency + #[api(skip_get, skip_set)] + pub fc_eff_model: FCTempEffModel, /// struct for tracking current state - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: FuelConverterThermalState, /// Custom vector of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "FuelConverterThermalStateHistoryVec::is_empty")] + #[serde( + default, + skip_serializing_if = "FuelConverterThermalStateHistoryVec::is_empty" + )] pub history: FuelConverterThermalStateHistoryVec, // TODO: add `save_interval` and associated methods } @@ -518,14 +539,14 @@ impl FuelConverterThermal { /// # Arguments /// - `fc_state`: [FuelConverter] state /// - `te_amb`: ambient temperature - /// - `heat_demand`: heat demand from HVAC system + /// - `pwr_thrl_fc_to_cab`: heat demand from HVAC system /// - `veh_speed`: current achieved speed /// - `dt`: simulation time step size fn solve( &mut self, fc_state: &FuelConverterState, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { @@ -587,11 +608,36 @@ impl FuelConverterThermal { let delta_temp: si::Temperature = (((self.htc_from_comb * (self.state.te_adiabatic - self.state.temperature)) .min(self.max_frac_from_comb * heat_gen) - - heat_demand + - pwr_thrl_fc_to_cab - self.state.heat_to_amb) * dt) / self.heat_capacitance; self.state.temperature += delta_temp; + + self.state.eff_coeff = match self.fc_eff_model { + FCTempEffModel::Linear(FCTempEffModelLinear { + offset, + slope_per_kelvin: slope, + minimum, + }) => minimum.max( + (offset + slope * uc::R / uc::KELVIN * self.state.temperature).min(1.0 * uc::R), + ), + FCTempEffModel::Exponential(FCTempEffModelExponential { + offset, + lag, + minimum, + }) => ((1.0 + - f64::exp({ + (-1.0 / { + let exp_denom: si::Ratio = + (lag / uc::KELVIN) * (self.state.temperature - offset); + exp_denom + }) + .get::() + })) + * uc::R) + .max(minimum), + }; Ok(()) } } @@ -631,6 +677,8 @@ pub struct FuelConverterThermalState { pub htc_to_amb: si::HeatTransferCoeff, /// Current heat transfer to ambient pub heat_to_amb: si::Power, + /// Efficency coefficient, used to modify [FuelConverter] effciency based on temperature + pub eff_coeff: si::Ratio, } impl Init for FuelConverterThermalState {} @@ -643,6 +691,60 @@ impl Default for FuelConverterThermalState { temperature: *TE_STD_AIR, htc_to_amb: Default::default(), heat_to_amb: Default::default(), + eff_coeff: uc::R, + } + } +} + +/// Model variants for how FC efficiency depends on temperature +#[derive(Debug, Clone, Deserialize, Serialize, PartialEq)] +pub enum FCTempEffModel { + /// Linear temperature dependence + Linear(FCTempEffModelLinear), + /// Exponential temperature dependence + Exponential(FCTempEffModelExponential), +} + +impl Default for FCTempEffModel { + fn default() -> Self { + FCTempEffModel::Exponential(FCTempEffModelExponential::default()) + } +} + +#[derive(Debug, Clone, Deserialize, Serialize, PartialEq)] +pub struct FCTempEffModelLinear { + pub offset: si::Ratio, + /// Change in efficiency factor per change in temperature [K] + pub slope_per_kelvin: f64, + pub minimum: si::Ratio, +} + +impl Default for FCTempEffModelLinear { + fn default() -> Self { + Self { + offset: 0.0 * uc::R, + slope_per_kelvin: 25.0, + minimum: 0.2 * uc::R, + } + } +} + +#[derive(Debug, Clone, Deserialize, Serialize, PartialEq)] +pub struct FCTempEffModelExponential { + /// temperature at which `fc_eta_temp_coeff` begins to grow + pub offset: si::Temperature, + /// exponential lag parameter [K^-1] + pub lag: f64, + /// minimum value that `fc_eta_temp_coeff` can take + pub minimum: si::Ratio, +} + +impl Default for FCTempEffModelExponential { + fn default() -> Self { + Self { + offset: 0.0 * uc::KELVIN + *uc::CELSIUS_TO_KELVIN, + lag: 25.0, + minimum: 0.2 * uc::R, } } } diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index 894b8631..aba3de5a 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -95,12 +95,13 @@ pub struct ReversibleEnergyStorage { #[serde(skip_serializing_if = "Option::is_none")] pub save_interval: Option, /// struct for tracking current state - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: ReversibleEnergyStorageState, /// Custom vector of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "ReversibleEnergyStorageStateHistoryVec::is_empty")] + #[serde( + default, + skip_serializing_if = "ReversibleEnergyStorageStateHistoryVec::is_empty" + )] pub history: ReversibleEnergyStorageStateHistoryVec, } @@ -236,8 +237,7 @@ impl ReversibleEnergyStorage { /// # Arguments /// - `fc_state`: [ReversibleEnergyStorage] state /// - `te_amb`: ambient temperature - /// - `heat_demand`: heat demand from HVAC system - /// - `veh_speed`: current achieved speed + /// - `dt`: time step size pub fn solve_thermal(&mut self, te_amb: si::Temperature, dt: si::Time) -> anyhow::Result<()> { self.thrml .solve(self.state, te_amb, dt) @@ -270,16 +270,17 @@ impl ReversibleEnergyStorage { chrg_buffer: si::Energy, ) -> anyhow::Result<()> { // to protect against excessive topping off of the battery - let soc_buffer = (chrg_buffer / (self.energy_capacity * (self.max_soc - self.min_soc))) + let soc_buffer_delta = (chrg_buffer + / (self.energy_capacity * (self.max_soc - self.min_soc))) .max(si::Ratio::ZERO); - ensure!(soc_buffer >= si::Ratio::ZERO, "{}", format_dbg!()); - self.state.soc_regen_buffer = self.max_soc - soc_buffer; + ensure!(soc_buffer_delta >= si::Ratio::ZERO, "{}", format_dbg!()); + self.state.soc_regen_buffer = self.max_soc - soc_buffer_delta; let pwr_max_for_dt = ((self.max_soc - self.state.soc) * self.energy_capacity / dt).max(si::Power::ZERO); - self.state.pwr_charge_max = if self.state.soc <= self.max_soc - soc_buffer { + self.state.pwr_charge_max = if self.state.soc <= self.state.soc_regen_buffer { self.pwr_out_max - } else if self.state.soc < self.max_soc && soc_buffer > si::Ratio::ZERO { - self.pwr_out_max * (self.max_soc - self.state.soc) / soc_buffer + } else if self.state.soc < self.max_soc && soc_buffer_delta > si::Ratio::ZERO { + self.pwr_out_max * (self.max_soc - self.state.soc) / soc_buffer_delta } else { // current SOC is less than both si::Power::ZERO @@ -292,7 +293,7 @@ impl ReversibleEnergyStorage { format_dbg!(), stringify!(self.state.pwr_charge_max), self.state.pwr_charge_max.get::().format_eng(None), - format_dbg!(soc_buffer) + format_dbg!(soc_buffer_delta) ); Ok(()) @@ -307,15 +308,15 @@ impl ReversibleEnergyStorage { disch_buffer: si::Energy, ) -> anyhow::Result<()> { // to protect against excessive bottoming out of the battery - let soc_buffer = (disch_buffer / self.energy_capacity_usable()).max(si::Ratio::ZERO); - ensure!(soc_buffer >= si::Ratio::ZERO, "{}", format_dbg!()); - self.state.soc_accel_buffer = self.min_soc + soc_buffer; + let soc_buffer_delta = (disch_buffer / self.energy_capacity_usable()).max(si::Ratio::ZERO); + ensure!(soc_buffer_delta >= si::Ratio::ZERO, "{}", format_dbg!()); + self.state.soc_disch_buffer = self.min_soc + soc_buffer_delta; let pwr_max_for_dt = ((self.state.soc - self.min_soc) * self.energy_capacity / dt).max(si::Power::ZERO); - self.state.pwr_disch_max = if self.state.soc > self.min_soc + soc_buffer { + self.state.pwr_disch_max = if self.state.soc > self.state.soc_disch_buffer { self.pwr_out_max - } else if self.state.soc > self.min_soc && soc_buffer > si::Ratio::ZERO { - self.pwr_out_max * (self.state.soc - self.min_soc) / soc_buffer + } else if self.state.soc > self.min_soc && soc_buffer_delta > si::Ratio::ZERO { + self.pwr_out_max * (self.state.soc - self.min_soc) / soc_buffer_delta } else { // current SOC is less than both si::Power::ZERO @@ -328,7 +329,7 @@ impl ReversibleEnergyStorage { format_dbg!(), stringify!(self.state.pwr_disch_max), self.state.pwr_disch_max.get::().format_eng(None), - format_dbg!(soc_buffer) + format_dbg!(soc_buffer_delta) ); Ok(()) @@ -426,7 +427,7 @@ impl ReversibleEnergyStorage { /// If thermal model is appropriately configured, returns current lumped [Self] temperature pub fn temperature(&self) -> Option { match &self.thrml { - RESThermalOption::RESThermal(rest) => Some(rest.state.temperature), + RESThermalOption::RESLumpedThermal(rest) => Some(rest.state.temperature), RESThermalOption::None => None, } } @@ -549,10 +550,12 @@ pub struct ReversibleEnergyStorageState { /// state of charge (SOC) pub soc: si::Ratio, - /// max state of charge (SOC) buffer for regen + /// SOC at which [ReversibleEnergyStorage] regen power begins linearly + /// derating as it approaches maximum SOC pub soc_regen_buffer: si::Ratio, - /// min state of charge (SOC) buffer for acceleration - pub soc_accel_buffer: si::Ratio, + /// SOC at which [ReversibleEnergyStorage] discharge power begins linearly + /// derating as it approaches minimum SOC + pub soc_disch_buffer: si::Ratio, /// Chemical <-> Electrical conversion efficiency based on current power demand pub eff: si::Ratio, /// State of Health (SOH) @@ -594,7 +597,7 @@ impl Default for ReversibleEnergyStorageState { i: Default::default(), soc: uc::R * 0.5, soc_regen_buffer: uc::R * 1., - soc_accel_buffer: si::Ratio::ZERO, + soc_disch_buffer: si::Ratio::ZERO, eff: si::Ratio::ZERO, soh: 0., pwr_out_electrical: si::Power::ZERO, @@ -617,7 +620,7 @@ impl SerdeAPI for ReversibleEnergyStorageState {} #[derive(Clone, Default, Debug, Serialize, Deserialize, PartialEq, IsVariant)] pub enum RESThermalOption { /// Basic thermal plant for [ReversibleEnergyStorage] - RESThermal(Box), + RESLumpedThermal(Box), /// no thermal plant for [ReversibleEnergyStorage] #[default] None, @@ -625,7 +628,7 @@ pub enum RESThermalOption { impl Init for RESThermalOption { fn init(&mut self) -> anyhow::Result<()> { match self { - Self::RESThermal(rest) => rest.init()?, + Self::RESLumpedThermal(rest) => rest.init()?, Self::None => {} } Ok(()) @@ -635,10 +638,9 @@ impl SerdeAPI for RESThermalOption {} impl RESThermalOption { /// Solve change in temperature and other thermal effects /// # Arguments - /// - `fc_state`: [ReversibleEnergyStorage] state + /// - `res_state`: [ReversibleEnergyStorage] state /// - `te_amb`: ambient temperature - /// - `heat_demand`: heat demand from HVAC system - /// - `veh_speed`: current achieved speed + /// - `dt`: time step size fn solve( &mut self, res_state: ReversibleEnergyStorageState, @@ -646,7 +648,7 @@ impl RESThermalOption { dt: si::Time, ) -> anyhow::Result<()> { match self { - Self::RESThermal(rest) => rest + Self::RESLumpedThermal(rest) => rest .solve(res_state, te_amb, dt) .with_context(|| format_dbg!())?, Self::None => { @@ -660,25 +662,27 @@ impl RESThermalOption { #[fastsim_api] #[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] /// Struct for modeling [ReversibleEnergyStorage] (e.g. battery) thermal plant -pub struct RESThermal { +pub struct RESLumpedThermal { /// [ReversibleEnergyStorage] thermal capacitance pub heat_capacitance: si::HeatCapacity, - /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml]to ambient + /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml] to ambient pub htc_to_amb: si::HeatTransferCoeff, - /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml]to cabin + /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml] to cabin pub htc_to_cab: si::HeatTransferCoeff, /// Thermal management system pub cntrl_sys: RESThermalControlSystem, /// current state + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: RESThermalState, /// history of state + #[serde(default, skip_serializing_if = "RESThermalStateHistoryVec::is_empty")] pub history: RESThermalStateHistoryVec, // TODO: add `save_interval` and associated methods } -impl SerdeAPI for RESThermal {} -impl Init for RESThermal {} -impl RESThermal { +impl SerdeAPI for RESLumpedThermal {} +impl Init for RESLumpedThermal {} +impl RESLumpedThermal { fn solve( &mut self, res_state: ReversibleEnergyStorageState, @@ -743,9 +747,12 @@ pub struct RESThermalControlSystem { /// max allowed aux load pub pwr_aux_max: si::Power, /// coefficient of performance of vapor compression cycle + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: RESThermalControlSystemState, - #[serde(default)] - #[serde(skip_serializing_if = "RESThermalControlSystemStateHistoryVec::is_empty")] + #[serde( + default, + skip_serializing_if = "RESThermalControlSystemStateHistoryVec::is_empty" + )] pub history: RESThermalControlSystemStateHistoryVec, // TODO: add `save_interval` and associated methods } diff --git a/fastsim-core/src/vehicle/powertrain/traits.rs b/fastsim-core/src/vehicle/powertrain/traits.rs index 72e8ed53..83322400 100644 --- a/fastsim-core/src/vehicle/powertrain/traits.rs +++ b/fastsim-core/src/vehicle/powertrain/traits.rs @@ -38,7 +38,7 @@ pub trait Powertrain { fn solve_thermal( &mut self, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()>; diff --git a/fastsim-core/src/vehicle/powertrain/transmission.rs b/fastsim-core/src/vehicle/powertrain/transmission.rs index 3a40b0e6..0f3f01c8 100644 --- a/fastsim-core/src/vehicle/powertrain/transmission.rs +++ b/fastsim-core/src/vehicle/powertrain/transmission.rs @@ -17,12 +17,10 @@ pub struct Transmission { #[serde(skip_serializing_if = "Option::is_none")] pub save_interval: Option, /// struct for tracking current state - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: TransmissionState, /// Custom vector of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "TransmissionStateHistoryVec::is_empty")] + #[serde(default, skip_serializing_if = "TransmissionStateHistoryVec::is_empty")] pub history: TransmissionStateHistoryVec, } diff --git a/fastsim-core/src/vehicle/powertrain_type.rs b/fastsim-core/src/vehicle/powertrain_type.rs index b0e11f13..bf16de9c 100644 --- a/fastsim-core/src/vehicle/powertrain_type.rs +++ b/fastsim-core/src/vehicle/powertrain_type.rs @@ -50,14 +50,20 @@ impl Powertrain for PowertrainType { fn solve_thermal( &mut self, te_amb: si::Temperature, - heat_demand: si::Power, + pwr_thrl_fc_to_cab: si::Power, veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { match self { - Self::ConventionalVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_state, dt), - Self::HybridElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_state, dt), - Self::BatteryElectricVehicle(v) => v.solve_thermal(te_amb, heat_demand, veh_state, dt), + Self::ConventionalVehicle(v) => { + v.solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) + } + Self::HybridElectricVehicle(v) => { + v.solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) + } + Self::BatteryElectricVehicle(v) => { + v.solve_thermal(te_amb, si::Power::ZERO, veh_state, dt) + } } } diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index 45a07a74..26730b3b 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -121,14 +121,20 @@ pub struct Vehicle { #[api(skip_get, skip_set)] pub cabin: CabinOption, + /// HVAC model + #[serde(default, skip_serializing_if = "HVACOption::is_none")] + #[api(skip_get, skip_set)] + pub hvac: HVACOption, + /// Total vehicle mass #[api(skip_get, skip_set)] #[serde(skip_serializing_if = "Option::is_none")] pub(crate) mass: Option, - /// power required by auxilliary systems (e.g. HVAC, stereo) - /// TODO: make this an enum to allow for future variations - pub pwr_aux: si::Power, + /// Baseline power required by auxilliary systems + pub pwr_aux_base: si::Power, + /// Max power available for auxilliary systems + pub pwr_aux_max: si::Power, /// transmission efficiency // TODO: check if `trans_eff` is redundant (most likely) and fix @@ -141,12 +147,10 @@ pub struct Vehicle { #[serde(skip_serializing_if = "Option::is_none")] save_interval: Option, /// current state of vehicle - #[serde(default)] - #[serde(skip_serializing_if = "EqDefault::eq_default")] + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: VehicleState, /// Vector-like history of [Self::state] - #[serde(default)] - #[serde(skip_serializing_if = "VehicleStateHistoryVec::is_empty")] + #[serde(default, skip_serializing_if = "VehicleStateHistoryVec::is_empty")] pub history: VehicleStateHistoryVec, } @@ -399,7 +403,7 @@ impl Vehicle { /// Solves for energy consumption pub fn solve_powertrain(&mut self, dt: si::Time) -> anyhow::Result<()> { // TODO: do something more sophisticated with pwr_aux - self.state.pwr_aux = self.pwr_aux; + self.state.pwr_aux = self.pwr_aux_base; self.pt_type .solve( self.state.pwr_tractive, @@ -419,7 +423,7 @@ impl Vehicle { // TODO: account for traction limits here self.pt_type - .set_curr_pwr_prop_out_max(self.pwr_aux, dt, self.state) + .set_curr_pwr_prop_out_max(self.pwr_aux_base, dt, self.state) .with_context(|| anyhow!(format_dbg!()))?; (self.state.pwr_prop_fwd_max, self.state.pwr_prop_bwd_max) = self @@ -432,24 +436,46 @@ impl Vehicle { pub fn solve_thermal( &mut self, - te_amb: si::Temperature, + te_amb_air: si::Temperature, veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { let te_fc: Option = self.fc().and_then(|fc| fc.temperature()); - let heat_demand = match &mut self.cabin { - CabinOption::LumpedCabin(lc) => { - lc.solve(te_amb, te_fc, veh_state, dt) + let pwr_thrml_fc_to_cabin = match (&mut self.cabin, &mut self.hvac) { + (CabinOption::None, HVACOption::None) => si::Power::ZERO, + (CabinOption::LumpedCabin(lc), HVACOption::LumpedCabin(lc_hvac)) => { + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = lc_hvac + .solve(te_amb_air, te_fc, lc.state, lc.heat_capacitance, dt) .with_context(|| format_dbg!())?; - lc.hvac.state.pwr_thermal_req + lc.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) + .with_context(|| format_dbg!())?; + pwr_thrml_fc_to_cab + } + (CabinOption::LumpedCabinWithShell, HVACOption::LumpedCabinWithShell) => { + bail!("{}\nNot yet implemented.", format_dbg!()) } - CabinOption::LumpedCabinWithShell => { + (CabinOption::None, HVACOption::ReversibleEnergyStorageOnly) => { bail!("{}\nNot yet implemented.", format_dbg!()) } - CabinOption::None => si::Power::ZERO, + (CabinOption::None, _) => { + bail!( + "{}\n`CabinOption::is_none` must be true if `HVACOption::is_none` is true.", + format_dbg!() + ) + } + (_, HVACOption::None) => { + bail!( + "{}\n`CabinOption::is_none` must be true if `HVACOption::is_none` is true.", + format_dbg!() + ) + } + _ => todo!( + "This match needs more match arms to be fully correct in validating model config." + ), }; + self.pt_type - .solve_thermal(te_amb, heat_demand, veh_state, dt) + .solve_thermal(te_amb_air, pwr_thrml_fc_to_cabin, veh_state, dt) .with_context(|| format_dbg!())?; Ok(()) } diff --git a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs index 802d2408..85c0e196 100644 --- a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs +++ b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs @@ -16,7 +16,10 @@ impl TryFrom for Vehicle { pt_type, chassis: Chassis::try_from(&f2veh)?, cabin: Default::default(), - pwr_aux: f2veh.aux_kw * uc::KW, + hvac: Default::default(), + pwr_aux_base: f2veh.aux_kw * uc::KW, + // high value to make sure it has no effect + pwr_aux_max: f2veh.aux_kw * 2. * uc::KW, trans_eff: f2veh.trans_eff * uc::R, state: Default::default(), save_interval, @@ -95,25 +98,29 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { Ok(PowertrainType::ConventionalVehicle(Box::new(conv))) } HEV => { - let pt_cntrl = HEVPowertrainControls::RGWDB(hev::RESGreedyWithDynamicBuffers { - speed_soc_fc_on_buffer: None, - speed_soc_accel_buffer: None, - speed_soc_accel_buffer_coeff: None, - speed_soc_regen_buffer: None, - speed_soc_regen_buffer_coeff: None, - // note that this exists in `fastsim-2` but has no apparent effect! - fc_min_time_on: None, - speed_fc_forced_on: Some(f2veh.mph_fc_on * uc::MPH), - frac_pwr_demand_fc_forced_on: Some( - f2veh.kw_demand_fc_on - / (f2veh.fc_max_kw + f2veh.ess_max_kw.min(f2veh.mc_max_kw)) - * uc::R, - ), - frac_of_most_eff_pwr_to_run_fc: None, - // TODO: make sure these actually do something, if deemed worthwhile - frac_res_chrg_for_fc: f2veh.ess_chg_to_fc_max_eff_perc * uc::R, - frac_res_dschrg_for_fc: f2veh.ess_dischg_to_fc_max_eff_perc * uc::R, - }); + let pt_cntrl = + HEVPowertrainControls::RGWDB(Box::new(hev::RESGreedyWithDynamicBuffers { + speed_soc_fc_on_buffer: None, + speed_soc_fc_on_buffer_coeff: None, + speed_soc_disch_buffer: None, + speed_soc_disch_buffer_coeff: None, + speed_soc_regen_buffer: None, + speed_soc_regen_buffer_coeff: None, + // note that this exists in `fastsim-2` but has no apparent effect! + fc_min_time_on: None, + speed_fc_forced_on: Some(f2veh.mph_fc_on * uc::MPH), + frac_pwr_demand_fc_forced_on: Some( + f2veh.kw_demand_fc_on + / (f2veh.fc_max_kw + f2veh.ess_max_kw.min(f2veh.mc_max_kw)) + * uc::R, + ), + frac_of_most_eff_pwr_to_run_fc: None, + // TODO: make sure these actually do something, if deemed worthwhile + frac_res_chrg_for_fc: f2veh.ess_chg_to_fc_max_eff_perc * uc::R, + frac_res_dschrg_for_fc: f2veh.ess_dischg_to_fc_max_eff_perc * uc::R, + state: Default::default(), + history: Default::default(), + })); let mut hev = HybridElectricVehicle { fs: { let mut fs = FuelStorage { @@ -279,7 +286,7 @@ impl Vehicle { _ => 1.0, }, alt_eff_doc: None, - aux_kw: self.pwr_aux.get::(), + aux_kw: self.pwr_aux_base.get::(), aux_kw_doc: None, cargo_kg: self .chassis From eca8d19498ea9c7f5e33439667fdab13b5bad0b3 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Tue, 17 Dec 2024 11:18:32 -0700 Subject: [PATCH 09/12] provisioned for HVAC that connects to cabin and battery left `todo!()` to jog memory about where to resume work --- fastsim-core/src/vehicle/hvac.rs | 265 +++++++++++++++++++++- fastsim-core/src/vehicle/vehicle_model.rs | 17 +- 2 files changed, 274 insertions(+), 8 deletions(-) diff --git a/fastsim-core/src/vehicle/hvac.rs b/fastsim-core/src/vehicle/hvac.rs index 446f7cc2..6d009140 100644 --- a/fastsim-core/src/vehicle/hvac.rs +++ b/fastsim-core/src/vehicle/hvac.rs @@ -3,10 +3,10 @@ use super::*; /// Options for handling HVAC system #[derive(Clone, Default, Debug, Serialize, Deserialize, PartialEq, IsVariant)] pub enum HVACOption { - /// Basic single thermal capacitance cabin thermal model, including - /// HVAC system and controls, accounting for possiblity of - /// [ReversibleEnergyStorage] with thermal management + /// HVAC system for [LumpedCabin] LumpedCabin(Box), + /// HVAC system for [LumpedCabin] and [ReversibleEnergyStorage] + LumpedCabinAndRES(Box), /// Cabin with interior and shell capacitances LumpedCabinWithShell, /// [ReversibleEnergyStorage] thermal management with no cabin @@ -18,7 +18,8 @@ pub enum HVACOption { impl Init for HVACOption { fn init(&mut self) -> anyhow::Result<()> { match self { - Self::LumpedCabin(scc) => scc.init()?, + Self::LumpedCabin(cab) => cab.init()?, + Self::LumpedCabinAndRES(cab) => cab.init()?, Self::LumpedCabinWithShell => { todo!() } @@ -287,3 +288,259 @@ pub struct HVACSystemForLumpedCabinState { } impl Init for HVACSystemForLumpedCabinState {} impl SerdeAPI for HVACSystemForLumpedCabinState {} + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// HVAC system for [LumpedCabin] and [ReversibleEnergyStorage] +pub struct HVACSystemForLumpedCabinAndRES { + /// set point temperature + pub te_set: si::Temperature, + /// deadband range. any cabin temperature within this range of + /// `te_set` results in no HVAC power draw + pub te_deadband: si::Temperature, + /// HVAC proportional gain + pub p: si::ThermalConductance, + /// HVAC integral gain [W / K / s], resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i: f64, + /// value at which [Self::i] stops accumulating + pub pwr_i_max: si::Power, + /// HVAC derivative gain [W / K * s] + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d: f64, + /// max HVAC thermal power + pub pwr_thermal_max: si::Power, + /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by + /// coefficient of performance (COP) + pub frac_of_ideal_cop: f64, + /// heat source + #[api(skip_get, skip_set)] + pub heat_source: CabinHeatSource, + /// max allowed aux load + pub pwr_aux_max: si::Power, + /// coefficient of performance of vapor compression cycle + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] + pub state: HVACSystemForLumpedCabinAndRESState, + #[serde( + default, + skip_serializing_if = "HVACSystemForLumpedCabinAndRESStateHistoryVec::is_empty" + )] + pub history: HVACSystemForLumpedCabinAndRESStateHistoryVec, +} +impl Init for HVACSystemForLumpedCabinAndRES {} +impl SerdeAPI for HVACSystemForLumpedCabinAndRES {} +impl HVACSystemForLumpedCabinAndRES { + pub fn solve( + &mut self, + te_amb_air: si::Temperature, + te_fc: Option, + cab_state: LumpedCabinState, + cab_heat_cap: si::HeatCapacity, + dt: si::Time, + ) -> anyhow::Result<(si::Power, si::Power)> { + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = if cab_state.temp + <= self.te_set + self.te_deadband + && cab_state.temp >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p = si::Power::ZERO; + self.state.pwr_d = si::Power::ZERO; + (si::Power::ZERO, si::Power::ZERO) + } else { + // outside deadband + let te_delta_vs_set = cab_state.temp - self.te_set; + let te_delta_vs_amb: si::Temperature = cab_state.temp - te_amb_air; + + self.state.pwr_p = -self.p * te_delta_vs_set; + self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); + self.state.pwr_d = + -self.d * uc::J / uc::KELVIN * ((cab_state.temp - cab_state.temp_prev) / dt); + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temp / (5.0 * uc::KELVIN) + } else { + cab_state.temp / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = + if cab_state.temp > self.te_set + self.te_deadband { + // COOLING MODE; cabin is hotter than set point + + if self.state.pwr_i > si::Power::ZERO { + // If `pwr_i` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cab = + (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) + .max(-self.pwr_thermal_max); + + if (-pwr_thrml_hvac_to_cab / self.state.cop) > self.pwr_aux_max { + // TODO: maybe change this to a static `pwr_aux_max` + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + pwr_thrml_hvac_to_cab = -self.state.pwr_aux * self.state.cop; + } else { + // TODO: maybe change this to a static `pwr_aux_max` + self.state.pwr_aux = pwr_thrml_hvac_to_cab / self.state.cop; + } + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + (pwr_thrml_hvac_to_cab, pwr_thrml_fc_to_cabin) + } else { + // HEATING MODE; cabin is colder than set point + + if self.state.pwr_i < si::Power::ZERO { + // If `pwr_i` is less than zero reset to switch from cooling to heating + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cabin = + (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) + .min(self.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + let pwr_thrml_fc_to_cabin = self + .handle_heat_source( + te_fc, + te_delta_vs_amb, + &mut pwr_thrml_hvac_to_cabin, + cab_heat_cap, + cab_state, + dt, + ) + .with_context(|| format_dbg!())?; + (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) + }; + (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) + }; + Ok((pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin)) + } + + fn handle_heat_source( + &mut self, + te_fc: Option, + te_delta_vs_amb: si::Temperature, + pwr_thrml_hvac_to_cabin: &mut si::Power, + cab_heat_cap: si::HeatCapacity, + cab_state: LumpedCabinState, + dt: si::Time, + ) -> anyhow::Result { + let pwr_thrml_fc_to_cabin = match self.heat_source { + CabinHeatSource::FuelConverter => { + ensure!( + te_fc.is_some(), + "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", + format_dbg!() + ); + // limit heat transfer to be substantially less than what is physically possible + // i.e. the engine can't drop below cabin temperature to heat the cabin + *pwr_thrml_hvac_to_cabin = pwr_thrml_hvac_to_cabin + .min( + cab_heat_cap * + (te_fc.unwrap() - cab_state.temp) + * 0.1 // so that it's substantially less + / dt, + ) + .max(si::Power::ZERO); + self.state.cop = f64::NAN * uc::R; + let pwr_thrml_fc_to_cabin = *pwr_thrml_hvac_to_cabin; + // Assumes aux power needed for heating is incorporated into based aux load. + // TODO: refine this, perhaps by making aux power + // proportional to heating power, to account for blower power + self.state.pwr_aux = si::Power::ZERO; + // TODO: think about what to do for PHEV, which needs careful consideration here + // HEV probably also needs careful consideration + // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on + pwr_thrml_fc_to_cabin + } + CabinHeatSource::ResistanceHeater => { + self.state.cop = uc::R; + self.state.pwr_aux = *pwr_thrml_hvac_to_cabin; // COP is 1 so does not matter + #[allow(clippy::let_and_return)] // for readability + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + pwr_thrml_fc_to_cabin + } + CabinHeatSource::HeatPump => { + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + // TODO: make sure this is right for heating! + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temp / (5.0 * uc::KELVIN) + } else { + cab_state.temp / te_delta_vs_amb.abs() + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + if (*pwr_thrml_hvac_to_cabin / self.state.cop) > self.pwr_aux_max { + self.state.pwr_aux = self.pwr_aux_max; + // correct if limit is exceeded + *pwr_thrml_hvac_to_cabin = -self.state.pwr_aux * self.state.cop; + } else { + self.state.pwr_aux = *pwr_thrml_hvac_to_cabin / self.state.cop; + } + #[allow(clippy::let_and_return)] // for readability + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + pwr_thrml_fc_to_cabin + } + }; + Ok(pwr_thrml_fc_to_cabin) + } +} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct HVACSystemForLumpedCabinAndRESState { + /// time step counter + pub i: u32, + /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain + pub pwr_p: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain + pub energy_p: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain + pub pwr_i: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain + pub energy_i: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain + pub pwr_d: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain + pub energy_d: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to proportional gain + pub pwr_p_res: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to proportional gain + pub energy_p_res: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to integral gain + pub pwr_i_res: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to integral gain + pub energy_i_res: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to derivative gain + pub pwr_d_res: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to derivative gain + pub energy_d_res: si::Energy, + /// coefficient of performance (i.e. efficiency) of vapor compression cycle + pub cop: si::Ratio, + /// Au power demand from HVAC system + pub pwr_aux: si::Power, + /// Cumulative aux energy for HVAC system + pub energy_aux: si::Energy, + /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub energy_thermal_req: si::Energy, +} +impl Init for HVACSystemForLumpedCabinAndRESState {} +impl SerdeAPI for HVACSystemForLumpedCabinAndRESState {} diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index bb7976d6..bd7fbb50 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -451,11 +451,20 @@ impl Vehicle { let te_fc: Option = self.fc().and_then(|fc| fc.temperature()); let pwr_thrml_fc_to_cabin = match (&mut self.cabin, &mut self.hvac) { (CabinOption::None, HVACOption::None) => si::Power::ZERO, - (CabinOption::LumpedCabin(lc), HVACOption::LumpedCabin(lc_hvac)) => { - let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = lc_hvac - .solve(te_amb_air, te_fc, lc.state, lc.heat_capacitance, dt) + (CabinOption::LumpedCabin(cab), HVACOption::LumpedCabin(hvac)) => { + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = hvac + .solve(te_amb_air, te_fc, cab.state, cab.heat_capacitance, dt) .with_context(|| format_dbg!())?; - lc.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) + cab.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) + .with_context(|| format_dbg!())?; + pwr_thrml_fc_to_cab + } + (CabinOption::LumpedCabin(cab), HVACOption::LumpedCabinAndRES(hvac)) => { + todo!("Connect HVAC system to RES."); + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = hvac + .solve(te_amb_air, te_fc, cab.state, cab.heat_capacitance, dt) + .with_context(|| format_dbg!())?; + cab.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) .with_context(|| format_dbg!())?; pwr_thrml_fc_to_cab } From 95a2d031dc28c59a894c001654c4435d6df263e1 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Wed, 18 Dec 2024 16:12:18 -0700 Subject: [PATCH 10/12] almost to the point of being ready to merge into fastsim-3 then make demos and re-merge after that but first, troubleshoot compiler errors --- .../src/history_vec_derive.rs | 6 + fastsim-core/src/prelude.rs | 3 +- fastsim-core/src/simdrive.rs | 5 +- fastsim-core/src/vehicle/bev.rs | 4 +- fastsim-core/src/vehicle/cabin.rs | 14 +- fastsim-core/src/vehicle/conv.rs | 2 +- fastsim-core/src/vehicle/hev.rs | 2 +- fastsim-core/src/vehicle/hvac.rs | 518 +----------------- .../vehicle/hvac/hvac_sys_for_lumped_cabin.rs | 253 +++++++++ .../hvac/hvac_sys_for_lumped_cabin_and_res.rs | 470 ++++++++++++++++ .../src/vehicle/powertrain/fuel_converter.rs | 4 +- .../powertrain/reversible_energy_storage.rs | 245 ++------- fastsim-core/src/vehicle/powertrain/traits.rs | 2 +- fastsim-core/src/vehicle/powertrain_type.rs | 2 +- fastsim-core/src/vehicle/vehicle_model.rs | 42 +- .../vehicle_model/fastsim2_interface.rs | 2 - 16 files changed, 841 insertions(+), 733 deletions(-) create mode 100644 fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs create mode 100644 fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs diff --git a/fastsim-core/fastsim-proc-macros/src/history_vec_derive.rs b/fastsim-core/fastsim-proc-macros/src/history_vec_derive.rs index 5fabe3b2..0a6fdb0b 100755 --- a/fastsim-core/fastsim-proc-macros/src/history_vec_derive.rs +++ b/fastsim-core/fastsim-proc-macros/src/history_vec_derive.rs @@ -124,6 +124,12 @@ pub(crate) fn history_vec_derive(input: TokenStream) -> TokenStream { } state_vec } + + // TODO: flesh this out + // /// Returns fieldnames of any fields that are constant throughout history + // pub fn names_of_static_fields(&self) -> Vec { + + // } } impl Default for #new_name { diff --git a/fastsim-core/src/prelude.rs b/fastsim-core/src/prelude.rs index ca5b846d..572eb27c 100755 --- a/fastsim-core/src/prelude.rs +++ b/fastsim-core/src/prelude.rs @@ -20,7 +20,8 @@ pub use crate::vehicle::powertrain::fuel_converter::{ FuelConverterThermalOption, }; pub use crate::vehicle::powertrain::reversible_energy_storage::{ - ReversibleEnergyStorage, ReversibleEnergyStorageState, ReversibleEnergyStorageStateHistoryVec, + RESLumpedThermal, RESLumpedThermalState, RESThermalOption, ReversibleEnergyStorage, + ReversibleEnergyStorageState, ReversibleEnergyStorageStateHistoryVec, }; pub use crate::vehicle::PowertrainType; pub use crate::vehicle::Vehicle; diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index 1663a271..b8abd11e 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -189,8 +189,7 @@ impl SimDrive { let i = self.veh.state.i; let dt = self.cyc.dt_at_i(i)?; let speed_prev = self.veh.state.speed_ach; - // TODO: make sure `pwr_aux` is updated in here and propagated to `set_curr_pwr_out_max` - // maybe make a static `pwr_aux_max` and controls like: + // maybe make controls like: // ``` // pub enum HVACAuxPriority { // /// Prioritize [ReversibleEnergyStorage] thermal management @@ -200,7 +199,7 @@ impl SimDrive { // } // ``` self.veh - .solve_thermal(self.cyc.temp_amb_air[i], self.veh.state, dt) + .solve_thermal(self.cyc.temp_amb_air[i], dt) .with_context(|| format_dbg!())?; self.veh .set_curr_pwr_out_max(dt) diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index d3eb975c..b0f2b4e8 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -142,8 +142,8 @@ impl Powertrain for BatteryElectricVehicle { fn solve_thermal( &mut self, te_amb: si::Temperature, - _pwr_thrl_fc_to_cab: si::Power, - _veh_state: VehicleState, + _pwr_thrml_fc_to_cab: si::Power, + _veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()> { self.res diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index 8d7a61f2..b9bdc1ce 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -69,14 +69,14 @@ impl LumpedCabin { pub fn solve( &mut self, te_amb_air: si::Temperature, - veh_state: VehicleState, + veh_state: &mut VehicleState, pwr_thermal_from_hvac: si::Power, dt: si::Time, ) -> anyhow::Result<()> { self.state.pwr_thermal_from_hvac = pwr_thermal_from_hvac; // flat plate model for isothermal, mixed-flow from Incropera and deWitt, Fundamentals of Heat and Mass // Transfer, 7th Edition - let cab_te_film_ext = 0.5 * (self.state.temp + te_amb_air); + let cab_te_film_ext = 0.5 * (self.state.temperature + te_amb_air); self.state.reynolds_for_plate = Air::get_density(Some(cab_te_film_ext), Some(veh_state.elev_curr)) * veh_state.speed_ach @@ -107,15 +107,15 @@ impl LumpedCabin { * Air::get_therm_cond(cab_te_film_ext).with_context(|| format_dbg!())? / self.length) + 1.0 / self.cab_htc_to_amb); - (self.length * self.width) * htc_overall_moving * (te_amb_air - self.state.temp) + (self.length * self.width) * htc_overall_moving * (te_amb_air - self.state.temperature) } else { (self.length * self.width) / (1.0 / self.cab_htc_to_amb_stop + 1.0 / self.cab_htc_to_amb) - * (te_amb_air - self.state.temp) + * (te_amb_air - self.state.temperature) }; - self.state.temp_prev = self.state.temp; - self.state.temp += (self.state.pwr_thermal_from_hvac + self.state.pwr_thermal_from_amb) + self.state.temp_prev = self.state.temperature; + self.state.temperature += (self.state.pwr_thermal_from_hvac + self.state.pwr_thermal_from_amb) / self.heat_capacitance * dt; Ok(()) @@ -130,7 +130,7 @@ pub struct LumpedCabinState { /// time step counter pub i: u32, /// lumped cabin temperature - pub temp: si::Temperature, + pub temperature: si::Temperature, /// lumped cabin temperature at previous simulation time step // TODO: make sure this gets updated pub temp_prev: si::Temperature, diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index c2522830..31f500a4 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -58,7 +58,7 @@ impl Powertrain for Box { &mut self, te_amb: si::Temperature, pwr_thrl_fc_to_cab: si::Power, - veh_state: VehicleState, + veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()> { self.fc diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index a1c03dcb..c2283dc4 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -208,7 +208,7 @@ impl Powertrain for Box { &mut self, te_amb: si::Temperature, pwr_thrl_fc_to_cab: si::Power, - veh_state: VehicleState, + veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()> { self.fc diff --git a/fastsim-core/src/vehicle/hvac.rs b/fastsim-core/src/vehicle/hvac.rs index 6d009140..e0a9cffa 100644 --- a/fastsim-core/src/vehicle/hvac.rs +++ b/fastsim-core/src/vehicle/hvac.rs @@ -1,5 +1,11 @@ use super::*; +pub mod hvac_sys_for_lumped_cabin; +pub use hvac_sys_for_lumped_cabin::*; + +pub mod hvac_sys_for_lumped_cabin_and_res; +pub use hvac_sys_for_lumped_cabin_and_res::*; + /// Options for handling HVAC system #[derive(Clone, Default, Debug, Serialize, Deserialize, PartialEq, IsVariant)] pub enum HVACOption { @@ -32,515 +38,3 @@ impl Init for HVACOption { } } impl SerdeAPI for HVACOption {} - -#[fastsim_api] -#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -/// HVAC system for [LumpedCabin] -pub struct HVACSystemForLumpedCabin { - /// set point temperature - pub te_set: si::Temperature, - /// deadband range. any cabin temperature within this range of - /// `te_set` results in no HVAC power draw - pub te_deadband: si::Temperature, - /// HVAC proportional gain - pub p: si::ThermalConductance, - /// HVAC integral gain [W / K / s], resets at zero crossing events - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub i: f64, - /// value at which [Self::i] stops accumulating - pub pwr_i_max: si::Power, - /// HVAC derivative gain [W / K * s] - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub d: f64, - /// max HVAC thermal power - pub pwr_thermal_max: si::Power, - /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by - /// coefficient of performance (COP) - pub frac_of_ideal_cop: f64, - /// heat source - #[api(skip_get, skip_set)] - pub heat_source: CabinHeatSource, - /// max allowed aux load - pub pwr_aux_max: si::Power, - /// coefficient of performance of vapor compression cycle - #[serde(default, skip_serializing_if = "EqDefault::eq_default")] - pub state: HVACSystemForLumpedCabinState, - #[serde( - default, - skip_serializing_if = "HVACSystemForLumpedCabinStateHistoryVec::is_empty" - )] - pub history: HVACSystemForLumpedCabinStateHistoryVec, -} -impl Init for HVACSystemForLumpedCabin {} -impl SerdeAPI for HVACSystemForLumpedCabin {} -impl HVACSystemForLumpedCabin { - pub fn solve( - &mut self, - te_amb_air: si::Temperature, - te_fc: Option, - cab_state: LumpedCabinState, - cab_heat_cap: si::HeatCapacity, - dt: si::Time, - ) -> anyhow::Result<(si::Power, si::Power)> { - let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = if cab_state.temp - <= self.te_set + self.te_deadband - && cab_state.temp >= self.te_set - self.te_deadband - { - // inside deadband; no hvac power is needed - - self.state.pwr_i = si::Power::ZERO; // reset to 0.0 - self.state.pwr_p = si::Power::ZERO; - self.state.pwr_d = si::Power::ZERO; - (si::Power::ZERO, si::Power::ZERO) - } else { - // outside deadband - let te_delta_vs_set = cab_state.temp - self.te_set; - let te_delta_vs_amb: si::Temperature = cab_state.temp - te_amb_air; - - self.state.pwr_p = -self.p * te_delta_vs_set; - self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; - self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); - self.state.pwr_d = - -self.d * uc::J / uc::KELVIN * ((cab_state.temp - cab_state.temp_prev) / dt); - - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - cab_state.temp / (5.0 * uc::KELVIN) - } else { - cab_state.temp / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - - let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = - if cab_state.temp > self.te_set + self.te_deadband { - // COOLING MODE; cabin is hotter than set point - - if self.state.pwr_i > si::Power::ZERO { - // If `pwr_i` is greater than zero, reset to switch from heating to cooling - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thrml_hvac_to_cab = - (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) - .max(-self.pwr_thermal_max); - - if (-pwr_thrml_hvac_to_cab / self.state.cop) > self.pwr_aux_max { - // TODO: maybe change this to a static `pwr_aux_max` - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - pwr_thrml_hvac_to_cab = -self.state.pwr_aux * self.state.cop; - } else { - // TODO: maybe change this to a static `pwr_aux_max` - self.state.pwr_aux = pwr_thrml_hvac_to_cab / self.state.cop; - } - let pwr_thrml_fc_to_cabin = si::Power::ZERO; - (pwr_thrml_hvac_to_cab, pwr_thrml_fc_to_cabin) - } else { - // HEATING MODE; cabin is colder than set point - - if self.state.pwr_i < si::Power::ZERO { - // If `pwr_i` is less than zero reset to switch from cooling to heating - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thrml_hvac_to_cabin = - (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) - .min(self.pwr_thermal_max); - - // Assumes blower has negligible impact on aux load, may want to revise later - let pwr_thrml_fc_to_cabin = self - .handle_heat_source( - te_fc, - te_delta_vs_amb, - &mut pwr_thrml_hvac_to_cabin, - cab_heat_cap, - cab_state, - dt, - ) - .with_context(|| format_dbg!())?; - (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) - }; - (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) - }; - Ok((pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin)) - } - - fn handle_heat_source( - &mut self, - te_fc: Option, - te_delta_vs_amb: si::Temperature, - pwr_thrml_hvac_to_cabin: &mut si::Power, - cab_heat_cap: si::HeatCapacity, - cab_state: LumpedCabinState, - dt: si::Time, - ) -> anyhow::Result { - let pwr_thrml_fc_to_cabin = match self.heat_source { - CabinHeatSource::FuelConverter => { - ensure!( - te_fc.is_some(), - "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", - format_dbg!() - ); - // limit heat transfer to be substantially less than what is physically possible - // i.e. the engine can't drop below cabin temperature to heat the cabin - *pwr_thrml_hvac_to_cabin = pwr_thrml_hvac_to_cabin - .min( - cab_heat_cap * - (te_fc.unwrap() - cab_state.temp) - * 0.1 // so that it's substantially less - / dt, - ) - .max(si::Power::ZERO); - self.state.cop = f64::NAN * uc::R; - let pwr_thrml_fc_to_cabin = *pwr_thrml_hvac_to_cabin; - // Assumes aux power needed for heating is incorporated into based aux load. - // TODO: refine this, perhaps by making aux power - // proportional to heating power, to account for blower power - self.state.pwr_aux = si::Power::ZERO; - // TODO: think about what to do for PHEV, which needs careful consideration here - // HEV probably also needs careful consideration - // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on - pwr_thrml_fc_to_cabin - } - CabinHeatSource::ResistanceHeater => { - self.state.cop = uc::R; - self.state.pwr_aux = *pwr_thrml_hvac_to_cabin; // COP is 1 so does not matter - #[allow(clippy::let_and_return)] // for readability - let pwr_thrml_fc_to_cabin = si::Power::ZERO; - pwr_thrml_fc_to_cabin - } - CabinHeatSource::HeatPump => { - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - // TODO: make sure this is right for heating! - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - cab_state.temp / (5.0 * uc::KELVIN) - } else { - cab_state.temp / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - if (*pwr_thrml_hvac_to_cabin / self.state.cop) > self.pwr_aux_max { - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - *pwr_thrml_hvac_to_cabin = -self.state.pwr_aux * self.state.cop; - } else { - self.state.pwr_aux = *pwr_thrml_hvac_to_cabin / self.state.cop; - } - #[allow(clippy::let_and_return)] // for readability - let pwr_thrml_fc_to_cabin = si::Power::ZERO; - pwr_thrml_fc_to_cabin - } - }; - Ok(pwr_thrml_fc_to_cabin) - } -} - -#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] -pub enum CabinHeatSource { - /// [FuelConverter], if applicable, provides heat for HVAC system - FuelConverter, - /// Resistance heater provides heat for HVAC system - ResistanceHeater, - /// Heat pump provides heat for HVAC system - HeatPump, -} -impl Init for CabinHeatSource {} -impl SerdeAPI for CabinHeatSource {} - -#[fastsim_api] -#[derive( - Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, -)] -pub struct HVACSystemForLumpedCabinState { - /// time step counter - pub i: u32, - /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain - pub pwr_p: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain - pub energy_p: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain - pub pwr_i: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain - pub energy_i: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain - pub pwr_d: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain - pub energy_d: si::Energy, - /// coefficient of performance (i.e. efficiency) of vapor compression cycle - pub cop: si::Ratio, - /// Au power demand from HVAC system - pub pwr_aux: si::Power, - /// Cumulative aux energy for HVAC system - pub energy_aux: si::Energy, - /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) - pub energy_thermal_req: si::Energy, -} -impl Init for HVACSystemForLumpedCabinState {} -impl SerdeAPI for HVACSystemForLumpedCabinState {} - -#[fastsim_api] -#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -/// HVAC system for [LumpedCabin] and [ReversibleEnergyStorage] -pub struct HVACSystemForLumpedCabinAndRES { - /// set point temperature - pub te_set: si::Temperature, - /// deadband range. any cabin temperature within this range of - /// `te_set` results in no HVAC power draw - pub te_deadband: si::Temperature, - /// HVAC proportional gain - pub p: si::ThermalConductance, - /// HVAC integral gain [W / K / s], resets at zero crossing events - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub i: f64, - /// value at which [Self::i] stops accumulating - pub pwr_i_max: si::Power, - /// HVAC derivative gain [W / K * s] - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub d: f64, - /// max HVAC thermal power - pub pwr_thermal_max: si::Power, - /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by - /// coefficient of performance (COP) - pub frac_of_ideal_cop: f64, - /// heat source - #[api(skip_get, skip_set)] - pub heat_source: CabinHeatSource, - /// max allowed aux load - pub pwr_aux_max: si::Power, - /// coefficient of performance of vapor compression cycle - #[serde(default, skip_serializing_if = "EqDefault::eq_default")] - pub state: HVACSystemForLumpedCabinAndRESState, - #[serde( - default, - skip_serializing_if = "HVACSystemForLumpedCabinAndRESStateHistoryVec::is_empty" - )] - pub history: HVACSystemForLumpedCabinAndRESStateHistoryVec, -} -impl Init for HVACSystemForLumpedCabinAndRES {} -impl SerdeAPI for HVACSystemForLumpedCabinAndRES {} -impl HVACSystemForLumpedCabinAndRES { - pub fn solve( - &mut self, - te_amb_air: si::Temperature, - te_fc: Option, - cab_state: LumpedCabinState, - cab_heat_cap: si::HeatCapacity, - dt: si::Time, - ) -> anyhow::Result<(si::Power, si::Power)> { - let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = if cab_state.temp - <= self.te_set + self.te_deadband - && cab_state.temp >= self.te_set - self.te_deadband - { - // inside deadband; no hvac power is needed - - self.state.pwr_i = si::Power::ZERO; // reset to 0.0 - self.state.pwr_p = si::Power::ZERO; - self.state.pwr_d = si::Power::ZERO; - (si::Power::ZERO, si::Power::ZERO) - } else { - // outside deadband - let te_delta_vs_set = cab_state.temp - self.te_set; - let te_delta_vs_amb: si::Temperature = cab_state.temp - te_amb_air; - - self.state.pwr_p = -self.p * te_delta_vs_set; - self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; - self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); - self.state.pwr_d = - -self.d * uc::J / uc::KELVIN * ((cab_state.temp - cab_state.temp_prev) / dt); - - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - cab_state.temp / (5.0 * uc::KELVIN) - } else { - cab_state.temp / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - - let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) = - if cab_state.temp > self.te_set + self.te_deadband { - // COOLING MODE; cabin is hotter than set point - - if self.state.pwr_i > si::Power::ZERO { - // If `pwr_i` is greater than zero, reset to switch from heating to cooling - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thrml_hvac_to_cab = - (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) - .max(-self.pwr_thermal_max); - - if (-pwr_thrml_hvac_to_cab / self.state.cop) > self.pwr_aux_max { - // TODO: maybe change this to a static `pwr_aux_max` - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - pwr_thrml_hvac_to_cab = -self.state.pwr_aux * self.state.cop; - } else { - // TODO: maybe change this to a static `pwr_aux_max` - self.state.pwr_aux = pwr_thrml_hvac_to_cab / self.state.cop; - } - let pwr_thrml_fc_to_cabin = si::Power::ZERO; - (pwr_thrml_hvac_to_cab, pwr_thrml_fc_to_cabin) - } else { - // HEATING MODE; cabin is colder than set point - - if self.state.pwr_i < si::Power::ZERO { - // If `pwr_i` is less than zero reset to switch from cooling to heating - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thrml_hvac_to_cabin = - (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) - .min(self.pwr_thermal_max); - - // Assumes blower has negligible impact on aux load, may want to revise later - let pwr_thrml_fc_to_cabin = self - .handle_heat_source( - te_fc, - te_delta_vs_amb, - &mut pwr_thrml_hvac_to_cabin, - cab_heat_cap, - cab_state, - dt, - ) - .with_context(|| format_dbg!())?; - (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) - }; - (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin) - }; - Ok((pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin)) - } - - fn handle_heat_source( - &mut self, - te_fc: Option, - te_delta_vs_amb: si::Temperature, - pwr_thrml_hvac_to_cabin: &mut si::Power, - cab_heat_cap: si::HeatCapacity, - cab_state: LumpedCabinState, - dt: si::Time, - ) -> anyhow::Result { - let pwr_thrml_fc_to_cabin = match self.heat_source { - CabinHeatSource::FuelConverter => { - ensure!( - te_fc.is_some(), - "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", - format_dbg!() - ); - // limit heat transfer to be substantially less than what is physically possible - // i.e. the engine can't drop below cabin temperature to heat the cabin - *pwr_thrml_hvac_to_cabin = pwr_thrml_hvac_to_cabin - .min( - cab_heat_cap * - (te_fc.unwrap() - cab_state.temp) - * 0.1 // so that it's substantially less - / dt, - ) - .max(si::Power::ZERO); - self.state.cop = f64::NAN * uc::R; - let pwr_thrml_fc_to_cabin = *pwr_thrml_hvac_to_cabin; - // Assumes aux power needed for heating is incorporated into based aux load. - // TODO: refine this, perhaps by making aux power - // proportional to heating power, to account for blower power - self.state.pwr_aux = si::Power::ZERO; - // TODO: think about what to do for PHEV, which needs careful consideration here - // HEV probably also needs careful consideration - // There needs to be an engine temperature (e.g. 60°C) below which the engine is forced on - pwr_thrml_fc_to_cabin - } - CabinHeatSource::ResistanceHeater => { - self.state.cop = uc::R; - self.state.pwr_aux = *pwr_thrml_hvac_to_cabin; // COP is 1 so does not matter - #[allow(clippy::let_and_return)] // for readability - let pwr_thrml_fc_to_cabin = si::Power::ZERO; - pwr_thrml_fc_to_cabin - } - CabinHeatSource::HeatPump => { - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - // TODO: make sure this is right for heating! - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - cab_state.temp / (5.0 * uc::KELVIN) - } else { - cab_state.temp / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - if (*pwr_thrml_hvac_to_cabin / self.state.cop) > self.pwr_aux_max { - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - *pwr_thrml_hvac_to_cabin = -self.state.pwr_aux * self.state.cop; - } else { - self.state.pwr_aux = *pwr_thrml_hvac_to_cabin / self.state.cop; - } - #[allow(clippy::let_and_return)] // for readability - let pwr_thrml_fc_to_cabin = si::Power::ZERO; - pwr_thrml_fc_to_cabin - } - }; - Ok(pwr_thrml_fc_to_cabin) - } -} - -#[fastsim_api] -#[derive( - Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, -)] -pub struct HVACSystemForLumpedCabinAndRESState { - /// time step counter - pub i: u32, - /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain - pub pwr_p: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain - pub energy_p: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain - pub pwr_i: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain - pub energy_i: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain - pub pwr_d: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain - pub energy_d: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to proportional gain - pub pwr_p_res: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to proportional gain - pub energy_p_res: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to integral gain - pub pwr_i_res: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to integral gain - pub energy_i_res: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to derivative gain - pub pwr_d_res: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to derivative gain - pub energy_d_res: si::Energy, - /// coefficient of performance (i.e. efficiency) of vapor compression cycle - pub cop: si::Ratio, - /// Au power demand from HVAC system - pub pwr_aux: si::Power, - /// Cumulative aux energy for HVAC system - pub energy_aux: si::Energy, - /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) - pub energy_thermal_req: si::Energy, -} -impl Init for HVACSystemForLumpedCabinAndRESState {} -impl SerdeAPI for HVACSystemForLumpedCabinAndRESState {} diff --git a/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs new file mode 100644 index 00000000..9d6b537c --- /dev/null +++ b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs @@ -0,0 +1,253 @@ +use super::*; + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// HVAC system for [LumpedCabin] +pub struct HVACSystemForLumpedCabin { + /// set point temperature + pub te_set: si::Temperature, + /// deadband range. any cabin temperature within this range of + /// `te_set` results in no HVAC power draw + pub te_deadband: si::Temperature, + /// HVAC proportional gain + pub p: si::ThermalConductance, + /// HVAC integral gain [W / K / s], resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i: f64, + /// value at which state.i stops accumulating + pub pwr_i_max: si::Power, + /// HVAC derivative gain [W / K * s] + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d: f64, + /// max HVAC thermal power + pub pwr_thermal_max: si::Power, + /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by + /// coefficient of performance (COP) + pub frac_of_ideal_cop: f64, + /// heat source + #[api(skip_get, skip_set)] + pub heat_source: CabinHeatSource, + /// max allowed aux load for HVAC + pub pwr_aux_for_hvac_max: si::Power, + /// coefficient of performance of vapor compression cycle + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] + pub state: HVACSystemForLumpedCabinState, + #[serde( + default, + skip_serializing_if = "HVACSystemForLumpedCabinStateHistoryVec::is_empty" + )] + pub history: HVACSystemForLumpedCabinStateHistoryVec, +} +impl Init for HVACSystemForLumpedCabin {} +impl SerdeAPI for HVACSystemForLumpedCabin {} +impl HVACSystemForLumpedCabin { + pub fn solve( + &mut self, + te_amb_air: si::Temperature, + te_fc: Option, + cab_state: LumpedCabinState, + cab_heat_cap: si::HeatCapacity, + dt: si::Time, + ) -> anyhow::Result<(si::Power, si::Power)> { + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin, cop) = if cab_state.temperature + <= self.te_set + self.te_deadband + && cab_state.temperature >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p = si::Power::ZERO; + self.state.pwr_d = si::Power::ZERO; + (si::Power::ZERO, si::Power::ZERO, f64::NAN * uc::R) + } else { + // outside deadband + let te_delta_vs_set = cab_state.temperature - self.te_set; + let te_delta_vs_amb: si::Temperature = cab_state.temperature - te_amb_air; + + self.state.pwr_p = -self.p * te_delta_vs_set; + self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); + self.state.pwr_d = + -self.d * uc::J / uc::KELVIN * ((cab_state.temperature - cab_state.temp_prev) / dt); + + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin, cop) = + if cab_state.temperature > self.te_set + self.te_deadband { + // COOLING MODE; cabin is hotter than set point + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temperature / (5.0 * uc::KELVIN) + } else { + cab_state.temperature / te_delta_vs_amb.abs() + }; + let cop = cop_ideal * self.frac_of_ideal_cop; + assert!(cop > 0.0 * uc::R); + + if self.state.pwr_i > si::Power::ZERO { + // If `pwr_i` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cab = + (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) + .max(-self.pwr_thermal_max); + + if (-pwr_thrml_hvac_to_cab / self.state.cop) > self.pwr_aux_for_hvac_max { + self.state.pwr_aux_for_hvac = self.pwr_aux_for_hvac_max; + // correct if limit is exceeded + pwr_thrml_hvac_to_cab = -self.state.pwr_aux_for_hvac * self.state.cop; + } else { + self.state.pwr_aux_for_hvac = -pwr_thrml_hvac_to_cab / self.state.cop; + } + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + (pwr_thrml_hvac_to_cab, pwr_thrml_fc_to_cabin, cop) + } else { + // HEATING MODE; cabin is colder than set point + + if self.state.pwr_i < si::Power::ZERO { + // If `pwr_i` is less than zero reset to switch from cooling to heating + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cabin = + (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) + .min(self.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + let (pwr_thrml_fc_to_cabin, cop) = self + .handle_heat_source( + te_fc, + te_delta_vs_amb, + &mut pwr_thrml_hvac_to_cabin, + cab_heat_cap, + cab_state, + dt, + ) + .with_context(|| format_dbg!())?; + (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin, cop) + }; + (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin, cop) + }; + self.state.cop = cop; + Ok((pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cabin)) + } + + fn handle_heat_source( + &mut self, + te_fc: Option, + te_delta_vs_amb: si::Temperature, + pwr_thrml_hvac_to_cabin: &mut si::Power, + cab_heat_cap: si::HeatCapacity, + cab_state: LumpedCabinState, + dt: si::Time, + ) -> anyhow::Result<(si::Power, si::Ratio)> { + let (pwr_thrml_fc_to_cabin, cop) = match self.heat_source { + CabinHeatSource::FuelConverter => { + ensure!( + te_fc.is_some(), + "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", + format_dbg!() + ); + // limit heat transfer to be substantially less than what is physically possible + // i.e. the engine can't drop below cabin temperature to heat the cabin + *pwr_thrml_hvac_to_cabin = pwr_thrml_hvac_to_cabin + .min( + cab_heat_cap * + (te_fc.unwrap() - cab_state.temperature) + * 0.1 // so that it's substantially less + / dt, + ) + .max(si::Power::ZERO); + let cop = f64::NAN * uc::R; + let pwr_thrml_fc_to_cabin = *pwr_thrml_hvac_to_cabin; + // Assumes aux power needed for heating is incorporated into based aux load. + // TODO: refine this, perhaps by making aux power + // proportional to heating power, to account for blower power + self.state.pwr_aux_for_hvac = si::Power::ZERO; + (pwr_thrml_fc_to_cabin, cop) + } + CabinHeatSource::ResistanceHeater => { + let cop = uc::R; + self.state.pwr_aux_for_hvac = *pwr_thrml_hvac_to_cabin; // COP is 1 so does not matter + #[allow(clippy::let_and_return)] // for readability + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + (pwr_thrml_fc_to_cabin, cop) + } + CabinHeatSource::HeatPump => { + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + // TODO: make sure this is consist with above commented equation for heating! + let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + cab_state.temperature / (5.0 * uc::KELVIN) + } else { + cab_state.temperature / te_delta_vs_amb.abs() + }; + let cop = cop_ideal * self.frac_of_ideal_cop; + assert!(cop > 0.0 * uc::R); + if (*pwr_thrml_hvac_to_cabin / self.state.cop) > self.pwr_aux_for_hvac_max { + self.state.pwr_aux_for_hvac = self.pwr_aux_for_hvac_max; + // correct if limit is exceeded + *pwr_thrml_hvac_to_cabin = -self.state.pwr_aux_for_hvac * self.state.cop; + } else { + self.state.pwr_aux_for_hvac = *pwr_thrml_hvac_to_cabin / self.state.cop; + } + #[allow(clippy::let_and_return)] // for readability + let pwr_thrml_fc_to_cabin = si::Power::ZERO; + (pwr_thrml_fc_to_cabin, cop) + } + }; + Ok((pwr_thrml_fc_to_cabin, cop)) + } +} + +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq, IsVariant)] +pub enum CabinHeatSource { + /// [FuelConverter], if applicable, provides heat for HVAC system + FuelConverter, + /// Resistance heater provides heat for HVAC system + ResistanceHeater, + /// Heat pump provides heat for HVAC system + HeatPump, +} +impl Init for CabinHeatSource {} +impl SerdeAPI for CabinHeatSource {} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct HVACSystemForLumpedCabinState { + /// time step counter + pub i: u32, + /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain + pub pwr_p: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain + pub energy_p: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain + pub pwr_i: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain + pub energy_i: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain + pub pwr_d: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain + pub energy_d: si::Energy, + /// coefficient of performance (i.e. efficiency) of vapor compression cycle + pub cop: si::Ratio, + /// Aux power demand from HVAC system + pub pwr_aux_for_hvac: si::Power, + /// Cumulative aux energy for HVAC system + pub energy_aux: si::Energy, + /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub energy_thermal_req: si::Energy, +} +impl Init for HVACSystemForLumpedCabinState {} +impl SerdeAPI for HVACSystemForLumpedCabinState {} diff --git a/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs new file mode 100644 index 00000000..016fed55 --- /dev/null +++ b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs @@ -0,0 +1,470 @@ +use super::*; + +#[fastsim_api] +#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] +/// HVAC system for [LumpedCabin] and [] +pub struct HVACSystemForLumpedCabinAndRES { + /// set point temperature + pub te_set: si::Temperature, + /// deadband range. any cabin temperature within this range of + /// `te_set` results in no HVAC power draw + pub te_deadband: si::Temperature, + /// HVAC proportional gain for cabin + pub p_cabin: si::ThermalConductance, + /// HVAC integral gain [W / K / s] for cabin, resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i_cabin: f64, + /// value at which state.i stops accumulating for cabin + pub pwr_i_max_cabin: si::Power, + /// HVAC derivative gain [W / K * s] for cabin + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d_cabin: f64, + /// max HVAC thermal power + /// HVAC proportional gain for [ReversibleEnergyStorage] + pub p_res: si::ThermalConductance, + /// HVAC integral gain [W / K / s] for [ReversibleEnergyStorage], resets at zero crossing events + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub i_res: f64, + /// value at which state.i stops accumulating for [ReversibleEnergyStorage] + pub pwr_i_max_res: si::Power, + /// HVAC derivative gain [W / K * s] for [ReversibleEnergyStorage] + /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this + pub d_res: f64, + /// max HVAC thermal power + pub pwr_thermal_max: si::Power, + /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by + /// coefficient of performance (COP) + pub frac_of_ideal_cop: f64, + /// cabin heat source + #[api(skip_get, skip_set)] + pub cabin_heat_source: CabinHeatSource, + /// res heat source + #[api(skip_get, skip_set)] + pub res_heat_source: RESHeatSource, + /// res cooling source + #[api(skip_get, skip_set)] + pub res_cooling_source: RESCoolingSource, + /// max allowed aux load + pub pwr_aux_for_hvac_max: si::Power, + /// coefficient of performance of vapor compression cycle + #[serde(default, skip_serializing_if = "EqDefault::eq_default")] + pub state: HVACSystemForLumpedCabinAndRESState, + #[serde( + default, + skip_serializing_if = "HVACSystemForLumpedCabinAndRESStateHistoryVec::is_empty" + )] + pub history: HVACSystemForLumpedCabinAndRESStateHistoryVec, +} +impl Init for HVACSystemForLumpedCabinAndRES {} +impl SerdeAPI for HVACSystemForLumpedCabinAndRES {} +impl HVACSystemForLumpedCabinAndRES { + /// # Arguments + /// - `te_amb_air`: ambient air temperature + /// - `te_fc`: [FuelConverter] temperature, if equipped + /// - `cab_state`: [Cabin] state + /// - `cab_heat_cap`: [Cabin] heat capacity + /// - `res_temp`: [ReversibleEnergyStorage] temperature + /// - `res_temp_prev`: [ReversibleEnergyStorage] temperature at previous time step + /// - `dt`: time step size + /// + /// # Returns + /// - `pwr_thrml_hvac_to_cabin`: thermal power flowing from HVAC system to cabin + /// - `pwr_thrml_fc_to_cabin`: thermal power flowing from [FuelConverter] to cabin + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from HVAC system to + /// [ReversibleEnergyStorage] `thrml` system + pub fn solve( + &mut self, + te_amb_air: si::Temperature, + te_fc: Option, + cab_state: LumpedCabinState, + cab_heat_cap: si::HeatCapacity, + res_temp: si::Temperature, + res_temp_prev: si::Temperature, + dt: si::Time, + ) -> anyhow::Result<(si::Power, si::Power, si::Power)> { + let mut pwr_thrml_hvac_to_cabin = self + .solve_for_cabin(te_fc, cab_state, cab_heat_cap, dt) + .with_context(|| format_dbg!())?; + let mut pwr_thrml_hvac_to_res: si::Power = self + .solve_for_res(res_temp, res_temp_prev, dt) + .with_context(|| format_dbg!())?; + let cop_ideal: si::Ratio = + if pwr_thrml_hvac_to_res + pwr_thrml_hvac_to_cabin > si::Power::ZERO { + // heating mode + // TODO: account for cabin and battery heat sources in COP calculation!!!! + + let (te_ref, te_delta_vs_amb) = if pwr_thrml_hvac_to_res > si::Power::ZERO { + // both powers are positive -- i.e. both are in heating mode + + let te_ref: si::Temperature = if cab_state.temperature > res_temp { + // cabin is hotter + cab_state.temperature + } else { + // battery is hotter + res_temp + }; + (te_ref, te_ref - te_amb_air) + } else if pwr_thrml_hvac_to_res >= si::Power::ZERO { + // `pwr_thrml_hvac_to_res` dominates need for heating + (res_temp, res_temp - te_amb_air) + } else { + // `pwr_thrml_hvac_to_res` dominates need for heating + (cab_state.temperature, cab_state.temperature - te_amb_air) + }; + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + // TODO: make sure this is consistent with above commented equation for heating! + if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cabin is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + te_ref / (5.0 * uc::KELVIN) + } else { + te_ref / te_delta_vs_amb.abs() + } + } else if pwr_thrml_hvac_to_res + pwr_thrml_hvac_to_cabin < si::Power::ZERO { + // cooling mode + // TODO: account for battery cooling source in COP calculation!!!! + + let (te_ref, te_delta_vs_amb) = if pwr_thrml_hvac_to_res < si::Power::ZERO { + // both powers are negative -- i.e. both are in cooling mode + + let te_ref: si::Temperature = if cab_state.temperature < res_temp { + // cabin is colder + cab_state.temperature + } else { + // battery is colder + res_temp + }; + (te_ref, te_ref - te_amb_air) + } else if pwr_thrml_hvac_to_res >= si::Power::ZERO { + // `pwr_thrml_hvac_to_cabin` dominates need for cooling + (cab_state.temperature, cab_state.temperature - te_amb_air) + } else { + // `pwr_thrml_hvac_to_res` dominates need for cooling + (res_temp, res_temp - te_amb_air) + }; + + // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits + // cop_ideal is t_h / (t_h - t_c) for heating + // cop_ideal is t_c / (t_h - t_c) for cooling + + // divide-by-zero protection and realistic limit on COP + if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { + // cooling-dominating component is cooler than ambient + threshold + // TODO: make this `5.0` not hardcoded + te_ref / (5.0 * uc::KELVIN) + } else { + te_ref / te_delta_vs_amb.abs() + } + } else { + si::Ratio::ZERO + }; + self.state.cop = cop_ideal * self.frac_of_ideal_cop; + assert!(self.state.cop > 0.0 * uc::R); + + let mut pwr_thrml_fc_to_cabin = si::Power::ZERO; + self.state.pwr_aux_for_hvac = if pwr_thrml_hvac_to_cabin > si::Power::ZERO { + match self.cabin_heat_source { + CabinHeatSource::FuelConverter => { + pwr_thrml_fc_to_cabin = pwr_thrml_hvac_to_cabin; + // NOTE: should make this scale with power demand + si::Power::ZERO + } + CabinHeatSource::ResistanceHeater => pwr_thrml_hvac_to_cabin, + CabinHeatSource::HeatPump => pwr_thrml_hvac_to_cabin * self.state.cop, + } + } else { + -pwr_thrml_hvac_to_cabin * self.state.cop + } + if pwr_thrml_hvac_to_res > si::Power::ZERO { + match self.res_heat_source { + RESHeatSource::ResistanceHeater => pwr_thrml_hvac_to_res, + RESHeatSource::HeatPump => pwr_thrml_hvac_to_res * self.state.cop, + RESHeatSource::None => { + pwr_thrml_hvac_to_res = si::Power::ZERO; + si::Power::ZERO + } + } + } else { + match self.res_cooling_source { + RESCoolingSource::HVAC => -pwr_thrml_hvac_to_res * self.state.cop, + RESCoolingSource::None => { + pwr_thrml_hvac_to_res = si::Power::ZERO; + si::Power::ZERO + } + } + }; + + self.state.pwr_aux_for_hvac = if self.state.pwr_aux_for_hvac > self.pwr_aux_for_hvac_max { + pwr_thrml_hvac_to_res = + self.pwr_aux_for_hvac_max * self.state.cop * pwr_thrml_hvac_to_res + / (pwr_thrml_hvac_to_res + pwr_thrml_hvac_to_cabin); + pwr_thrml_hvac_to_cabin = + self.pwr_aux_for_hvac_max * self.state.cop * pwr_thrml_hvac_to_cabin + / (pwr_thrml_hvac_to_res + pwr_thrml_hvac_to_cabin); + if pwr_thrml_hvac_to_cabin > si::Power::ZERO + && self.cabin_heat_source.is_fuel_converter() + { + pwr_thrml_fc_to_cabin = pwr_thrml_hvac_to_cabin; + } + self.pwr_aux_for_hvac_max + } else { + self.state.pwr_aux_for_hvac + }; + + Ok(( + pwr_thrml_hvac_to_cabin, + pwr_thrml_fc_to_cabin, + pwr_thrml_hvac_to_res, + )) + } + + fn solve_for_cabin( + &mut self, + te_fc: Option, + cab_state: LumpedCabinState, + cab_heat_cap: si::HeatCapacity, + dt: si::Time, + ) -> anyhow::Result { + let pwr_thrml_hvac_to_cabin = if cab_state.temperature <= self.te_set + self.te_deadband + && cab_state.temperature >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p = si::Power::ZERO; + self.state.pwr_d = si::Power::ZERO; + si::Power::ZERO + } else { + // outside deadband + let te_delta_vs_set = cab_state.temperature - self.te_set; + + self.state.pwr_p = -self.p_cabin * te_delta_vs_set; + self.state.pwr_i -= self.i_cabin * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i = self + .state + .pwr_i + .max(-self.pwr_i_max_cabin) + .min(self.pwr_i_max_cabin); + self.state.pwr_d = -self.d_cabin * uc::J / uc::KELVIN + * ((cab_state.temperature - cab_state.temp_prev) / dt); + + let pwr_thrml_hvac_to_cabin: si::Power = + if cab_state.temperature > self.te_set + self.te_deadband { + // COOLING MODE; cabin is hotter than set point + + if self.state.pwr_i > si::Power::ZERO { + // If `pwr_i` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cab = + (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) + .max(-self.pwr_thermal_max); + + if (-pwr_thrml_hvac_to_cab / self.state.cop) > self.pwr_aux_for_hvac_max { + self.state.pwr_aux_for_hvac = self.pwr_aux_for_hvac_max; + // correct if limit is exceeded + pwr_thrml_hvac_to_cab = -self.state.pwr_aux_for_hvac * self.state.cop; + } else { + self.state.pwr_aux_for_hvac = pwr_thrml_hvac_to_cab / self.state.cop; + } + pwr_thrml_hvac_to_cab + } else { + // HEATING MODE; cabin is colder than set point + + if self.state.pwr_i < si::Power::ZERO { + // If `pwr_i` is less than zero reset to switch from cooling to heating + self.state.pwr_i = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_cabin: si::Power = + (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) + .min(self.pwr_thermal_max); + + // Assumes blower has negligible impact on aux load, may want to revise later + self.handle_cabin_heat_source( + te_fc, + &mut pwr_thrml_hvac_to_cabin, + cab_heat_cap, + cab_state, + dt, + ) + .with_context(|| format_dbg!())?; + pwr_thrml_hvac_to_cabin + }; + pwr_thrml_hvac_to_cabin + }; + Ok(pwr_thrml_hvac_to_cabin) + } + + fn solve_for_res( + &mut self, + // reversible energy storage temp + res_temp: si::Temperature, + // reversible energy storage temp at previous time step + res_temp_prev: si::Temperature, + dt: si::Time, + ) -> anyhow::Result { + let pwr_thrml_hvac_to_res = if res_temp <= self.te_set + self.te_deadband + && res_temp >= self.te_set - self.te_deadband + { + // inside deadband; no hvac power is needed + + self.state.pwr_i_res = si::Power::ZERO; // reset to 0.0 + self.state.pwr_p_res = si::Power::ZERO; + self.state.pwr_d_res = si::Power::ZERO; + si::Power::ZERO + } else { + // outside deadband + let te_delta_vs_set = res_temp - self.te_set; + self.state.pwr_p_res = -self.p_res * te_delta_vs_set; + self.state.pwr_i_res -= self.i_res * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; + self.state.pwr_i_res = self + .state + .pwr_i_res + .max(-self.pwr_i_max_res) + .min(self.pwr_i_max_res); + self.state.pwr_d_res = + -self.d_res * uc::J / uc::KELVIN * ((res_temp - res_temp_prev) / dt); + + let pwr_thrml_hvac_to_res: si::Power = if res_temp > self.te_set + self.te_deadband { + // COOLING MODE; Reversible Energy Storage is hotter than set point + + if self.state.pwr_i_res > si::Power::ZERO { + // If `pwr_i_res` is greater than zero, reset to switch from heating to cooling + self.state.pwr_i_res = si::Power::ZERO; + } + let mut pwr_thrml_hvac_to_res = + (self.state.pwr_p_res + self.state.pwr_i_res + self.state.pwr_d_res) + .max(-self.pwr_thermal_max); + + if (-pwr_thrml_hvac_to_res / self.state.cop) > self.pwr_aux_for_hvac_max { + self.state.pwr_aux_for_hvac = self.pwr_aux_for_hvac_max; + // correct if limit is exceeded + pwr_thrml_hvac_to_res = -self.state.pwr_aux_for_hvac * self.state.cop; + } else { + self.state.pwr_aux_for_hvac = pwr_thrml_hvac_to_res / self.state.cop; + } + pwr_thrml_hvac_to_res + } else { + // HEATING MODE; Reversible Energy Storage is colder than set point + + if self.state.pwr_i_res < si::Power::ZERO { + // If `pwr_i_res` is less than zero reset to switch from cooling to heating + self.state.pwr_i_res = si::Power::ZERO; + } + let pwr_thrml_hvac_to_res = + (-self.state.pwr_p_res - self.state.pwr_i_res - self.state.pwr_d_res) + .min(self.pwr_thermal_max); + pwr_thrml_hvac_to_res + }; + pwr_thrml_hvac_to_res + }; + Ok(pwr_thrml_hvac_to_res) + } + + fn handle_cabin_heat_source( + &mut self, + te_fc: Option, + pwr_thrml_hvac_to_cabin: &mut si::Power, + cab_heat_cap: si::HeatCapacity, + cab_state: LumpedCabinState, + dt: si::Time, + ) -> anyhow::Result<()> { + match self.cabin_heat_source { + CabinHeatSource::FuelConverter => { + ensure!( + te_fc.is_some(), + "{}\nExpected vehicle with [FuelConverter] with thermal plant model.", + format_dbg!() + ); + // limit heat transfer to be substantially less than what is physically possible + // i.e. the engine can't drop below cabin temperature to heat the cabin + *pwr_thrml_hvac_to_cabin = pwr_thrml_hvac_to_cabin + .min( + cab_heat_cap * + (te_fc.unwrap() - cab_state.temperature) + * 0.1 // so that it's substantially less + / dt, + ) + .max(si::Power::ZERO); + } + CabinHeatSource::ResistanceHeater => { + *pwr_thrml_hvac_to_cabin = si::Power::ZERO; + } + CabinHeatSource::HeatPump => { + *pwr_thrml_hvac_to_cabin = si::Power::ZERO; + } + }; + Ok(()) + } +} + +#[fastsim_api] +#[derive( + Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, +)] +pub struct HVACSystemForLumpedCabinAndRESState { + /// time step counter + pub i: u32, + /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain + pub pwr_p: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain + pub energy_p: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain + pub pwr_i: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain + pub energy_i: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain + pub pwr_d: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain + pub energy_d: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to proportional gain + pub pwr_p_res: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to proportional gain + pub energy_p_res: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to integral gain + pub pwr_i_res: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to integral gain + pub energy_i_res: si::Energy, + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to derivative gain + pub pwr_d_res: si::Power, + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to derivative gain + pub energy_d_res: si::Energy, + /// coefficient of performance (i.e. efficiency) of vapor compression cycle + pub cop: si::Ratio, + /// Au power demand from HVAC system + pub pwr_aux_for_hvac: si::Power, + /// Cumulative aux energy for HVAC system + pub energy_aux: si::Energy, + /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) + pub energy_thermal_req: si::Energy, +} +impl Init for HVACSystemForLumpedCabinAndRESState {} +impl SerdeAPI for HVACSystemForLumpedCabinAndRESState {} + +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] +/// Heat source for [RESLumpedThermal] +pub enum RESHeatSource { + /// Resistance heater provides heat for HVAC system + ResistanceHeater, + /// Heat pump provides heat for HVAC system + HeatPump, + /// The battery is not actively heated + None, +} +impl Init for RESHeatSource {} +impl SerdeAPI for RESHeatSource {} + +#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] +/// Cooling source for [RESLumpedThermal] +pub enum RESCoolingSource { + /// Vapor compression system used for cabin HVAC also cools [RESLumpedThermal] + HVAC, + /// [RESLumpedThermal] is not actively cooled + None, +} +impl Init for RESCoolingSource {} +impl SerdeAPI for RESCoolingSource {} diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index f386f9a1..0ae34112 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -300,8 +300,6 @@ impl FuelConverter { ) ); - // TODO: consider how idle is handled. The goal is to make it so that even if `self.state.pwr_aux` is - // zero, there will be fuel consumption to overcome internal dissipation. self.state.pwr_fuel = if self.state.fc_on { ((pwr_out_req + self.state.pwr_aux) / self.state.eff).max(self.pwr_idle_fuel) } else { @@ -324,7 +322,7 @@ impl FuelConverter { &mut self, te_amb: si::Temperature, pwr_thrl_fc_to_cab: si::Power, - veh_state: VehicleState, + veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()> { let veh_speed = veh_state.speed_ach; diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index afd3574e..613ac8b8 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -253,10 +253,18 @@ impl ReversibleEnergyStorage { /// # Arguments /// - `fc_state`: [ReversibleEnergyStorage] state /// - `te_amb`: ambient temperature + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from HVAC system to [ReversibleEnergyStorage] + /// - `te_cab`: cabin temperature for heat transfer interaction with [ReversiblEnergyStorage] /// - `dt`: time step size - pub fn solve_thermal(&mut self, te_amb: si::Temperature, dt: si::Time) -> anyhow::Result<()> { + pub fn solve_thermal( + &mut self, + te_amb: si::Temperature, + pwr_thrml_hvac_to_res: si::Power, + te_cab: si::Temperature, + dt: si::Time, + ) -> anyhow::Result<()> { self.thrml - .solve(self.state, te_amb, dt) + .solve(self.state, te_amb, pwr_thrml_hvac_to_res, te_cab, dt) .with_context(|| format_dbg!()) } @@ -496,6 +504,15 @@ impl ReversibleEnergyStorage { RESThermalOption::None => None, } } + + /// If thermal model is appropriately configured, returns lumped [Self] + /// temperature at previous time step + pub fn temp_prev(&self) -> Option { + match &self.thrml { + RESThermalOption::RESLumpedThermal(rest) => Some(rest.state.temp_prev), + RESThermalOption::None => None, + } + } } impl SetCumulative for ReversibleEnergyStorage { @@ -706,16 +723,19 @@ impl RESThermalOption { /// # Arguments /// - `res_state`: [ReversibleEnergyStorage] state /// - `te_amb`: ambient temperature + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from HVAC system to [ReversibleEnergyStorage] /// - `dt`: time step size fn solve( &mut self, res_state: ReversibleEnergyStorageState, te_amb: si::Temperature, + pwr_thrml_hvac_to_res: si::Power, + te_cab: si::Temperature, dt: si::Time, ) -> anyhow::Result<()> { match self { Self::RESLumpedThermal(rest) => rest - .solve(res_state, te_amb, dt) + .solve(res_state, te_amb, pwr_thrml_hvac_to_res, te_cab, dt) .with_context(|| format_dbg!())?, Self::None => { // TODO: make sure this triggers error if appropriate @@ -732,17 +752,18 @@ pub struct RESLumpedThermal { /// [ReversibleEnergyStorage] thermal capacitance pub heat_capacitance: si::HeatCapacity, /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml] to ambient - pub htc_to_amb: si::HeatTransferCoeff, + pub htc_to_amb: si::ThermalConductance, /// parameter for heat transfer coeff from [ReversibleEnergyStorage::thrml] to cabin - pub htc_to_cab: si::HeatTransferCoeff, - /// Thermal management system - pub cntrl_sys: RESThermalControlSystem, + pub htc_to_cab: si::ThermalConductance, /// current state #[serde(default, skip_serializing_if = "EqDefault::eq_default")] - pub state: RESThermalState, + pub state: RESLumpedThermalState, /// history of state - #[serde(default, skip_serializing_if = "RESThermalStateHistoryVec::is_empty")] - pub history: RESThermalStateHistoryVec, + #[serde( + default, + skip_serializing_if = "RESLumpedThermalStateHistoryVec::is_empty" + )] + pub history: RESLumpedThermalStateHistoryVec, // TODO: add `save_interval` and associated methods } @@ -753,204 +774,54 @@ impl RESLumpedThermal { &mut self, res_state: ReversibleEnergyStorageState, te_amb: si::Temperature, + pwr_thrml_hvac_to_res: si::Power, + te_cab: si::Temperature, dt: si::Time, ) -> anyhow::Result<()> { - todo!(); + self.state.temp_prev = self.state.temperature; + self.state.pwr_thrml_from_cabin = self.htc_to_cab * (te_cab - self.state.temperature); + self.state.pwr_thrml_from_amb = self.htc_to_cab * (te_amb - self.state.temperature); + self.state.temperature += (pwr_thrml_hvac_to_res + + res_state.pwr_out_electrical * (1.0 * uc::R - res_state.eff) + + self.state.pwr_thrml_from_cabin + + self.state.pwr_thrml_from_amb) + / self.heat_capacitance + * dt; Ok(()) } } #[fastsim_api] #[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative)] -pub struct RESThermalState { +pub struct RESLumpedThermalState { /// time step index pub i: usize, /// Current thermal mass temperature pub temperature: si::Temperature, /// Thermal mass temperature at previous time step pub temp_prev: si::Temperature, + /// Thermal power flow to [RESLumpedThermal] from cabin + pub pwr_thrml_from_cabin: si::Power, + /// Thermal power flow to [RESLumpedThermal] from ambient + pub pwr_thrml_from_amb: si::Power, + /// Cumulatev thermal energy flow to [RESLumpedThermal] from cabin + pub energy_thrml_from_cabin: si::Energy, + /// Cumulatev thermal energy flow to [RESLumpedThermal] from ambient + pub energy_thrml_from_amb: si::Energy, } -impl Init for RESThermalState {} -impl SerdeAPI for RESThermalState {} -impl Default for RESThermalState { +impl Init for RESLumpedThermalState {} +impl SerdeAPI for RESLumpedThermalState {} +impl Default for RESLumpedThermalState { fn default() -> Self { Self { i: Default::default(), temperature: *TE_STD_AIR, temp_prev: *TE_STD_AIR, + pwr_thrml_from_cabin: Default::default(), + energy_thrml_from_cabin: Default::default(), + pwr_thrml_from_amb: Default::default(), + energy_thrml_from_amb: Default::default(), } } } - -#[fastsim_api] -#[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -/// HVAC system for [LumpedCabin] -pub struct RESThermalControlSystem { - /// set point temperature - pub te_set: si::Temperature, - /// deadband range. any cabin temperature within this range of - /// `te_set` results in no HVAC power draw - pub te_deadband: si::Temperature, - /// HVAC proportional gain - pub p: si::ThermalConductance, - /// HVAC integral gain [W / K / s], resets at zero crossing events - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub i: f64, - /// value at which [Self::i] stops accumulating - pub pwr_i_max: si::Power, - /// HVAC derivative gain [W / K * s] - /// NOTE: `uom` crate does not have this unit, but it may be possible to make a custom unit for this - pub d: f64, - /// max HVAC thermal power - pub pwr_thermal_max: si::Power, - /// coefficient between 0 and 1 to calculate HVAC efficiency by multiplying by - /// coefficient of performance (COP) - pub frac_of_ideal_cop: f64, - /// heat source - #[api(skip_get, skip_set)] - pub heat_source: RESHeatSource, - /// max allowed aux load - pub pwr_aux_max: si::Power, - /// coefficient of performance of vapor compression cycle - #[serde(default, skip_serializing_if = "EqDefault::eq_default")] - pub state: RESThermalControlSystemState, - #[serde( - default, - skip_serializing_if = "RESThermalControlSystemStateHistoryVec::is_empty" - )] - pub history: RESThermalControlSystemStateHistoryVec, - // TODO: add `save_interval` and associated methods -} -impl Init for RESThermalControlSystem {} -impl SerdeAPI for RESThermalControlSystem {} -impl RESThermalControlSystem { - pub fn get_pwr_thermal( - &mut self, - te_amb_air: si::Temperature, - res_thrml_state: RESThermalState, - dt: si::Time, - ) -> anyhow::Result { - let pwr_from_hvac = if res_thrml_state.temperature <= self.te_set + self.te_deadband - && res_thrml_state.temperature >= self.te_set - self.te_deadband - { - // inside deadband; no hvac power is needed - - self.state.pwr_i = si::Power::ZERO; // reset to 0.0 - self.state.pwr_p = si::Power::ZERO; - self.state.pwr_d = si::Power::ZERO; - si::Power::ZERO - } else { - let te_delta_vs_set = res_thrml_state.temperature - self.te_set; - let te_delta_vs_amb: si::Temperature = res_thrml_state.temperature - te_amb_air; - - self.state.pwr_p = -self.p * te_delta_vs_set; - self.state.pwr_i -= self.i * uc::W / uc::KELVIN / uc::S * te_delta_vs_set * dt; - self.state.pwr_i = self.state.pwr_i.max(-self.pwr_i_max).min(self.pwr_i_max); - self.state.pwr_d = -self.d * uc::J / uc::KELVIN - * ((res_thrml_state.temperature - res_thrml_state.temp_prev) / dt); - - // https://en.wikipedia.org/wiki/Coefficient_of_performance#Theoretical_performance_limits - // cop_ideal is t_h / (t_h - t_c) for heating - // cop_ideal is t_c / (t_h - t_c) for cooling - - // divide-by-zero protection and realistic limit on COP - let cop_ideal = if te_delta_vs_amb.abs() < 5.0 * uc::KELVIN { - // cabin is cooler than ambient + threshold - // TODO: make this `5.0` not hardcoded - res_thrml_state.temperature / (5.0 * uc::KELVIN) - } else { - res_thrml_state.temperature / te_delta_vs_amb.abs() - }; - self.state.cop = cop_ideal * self.frac_of_ideal_cop; - assert!(self.state.cop > 0.0 * uc::R); - - if res_thrml_state.temperature > self.te_set + self.te_deadband { - // COOLING MODE; cabin is hotter than set point - - if self.state.pwr_i > si::Power::ZERO { - // If `pwr_i` is greater than zero, reset to switch from heating to cooling - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thermal_from_hvac = - (self.state.pwr_p + self.state.pwr_i + self.state.pwr_d) - .max(-self.pwr_thermal_max); - - if (-pwr_thermal_from_hvac / self.state.cop) > self.pwr_aux_max { - self.state.pwr_aux = self.pwr_aux_max; - // correct if limit is exceeded - pwr_thermal_from_hvac = -self.state.pwr_aux * self.state.cop; - } else { - self.state.pwr_aux = pwr_thermal_from_hvac / self.state.cop; - } - pwr_thermal_from_hvac - } else { - // HEATING MODE; cabin is colder than set point - - if self.state.pwr_i < si::Power::ZERO { - // If `pwr_i` is less than zero reset to switch from cooling to heating - self.state.pwr_i = si::Power::ZERO; - } - let mut pwr_thermal_from_hvac = - (-self.state.pwr_p - self.state.pwr_i - self.state.pwr_d) - .min(self.pwr_thermal_max); - - // Assumes blower has negligible impact on aux load, may want to revise later - match &self.heat_source { - RESHeatSource::SelfHeating => { - todo!() - } - RESHeatSource::HeatPump => { - todo!() - } - RESHeatSource::None => {} - } - pwr_thermal_from_hvac - } - }; - Ok(pwr_from_hvac) - } -} - -#[derive(Clone, Copy, Debug, Deserialize, Serialize, PartialEq)] -pub enum RESHeatSource { - /// Self heating - SelfHeating, - /// Heat pump provides heat for HVAC system - HeatPump, - /// No active heat source for [RESThermal] - None, -} -impl Init for RESHeatSource {} -impl SerdeAPI for RESHeatSource {} - -#[fastsim_api] -#[derive( - Clone, Copy, Debug, Default, Deserialize, Serialize, PartialEq, HistoryVec, SetCumulative, -)] -pub struct RESThermalControlSystemState { - /// time step counter - pub i: u32, - /// portion of total HVAC cooling/heating (negative/positive) power due to proportional gain - pub pwr_p: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to proportional gain - pub energy_p: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to integral gain - pub pwr_i: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to integral gain - pub energy_i: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power due to derivative gain - pub pwr_d: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain - pub energy_d: si::Energy, - /// coefficient of performance (i.e. efficiency) of vapor compression cycle - pub cop: si::Ratio, - /// Aux power demand from HVAC system - pub pwr_aux: si::Power, - /// Cumulative aux energy for HVAC system - pub energy_aux: si::Energy, - /// Cumulative energy demand by HVAC system from thermal component (e.g. [FuelConverter]) - pub energy_thermal_req: si::Energy, -} -impl Init for RESThermalControlSystemState {} -impl SerdeAPI for RESThermalControlSystemState {} diff --git a/fastsim-core/src/vehicle/powertrain/traits.rs b/fastsim-core/src/vehicle/powertrain/traits.rs index 83322400..93a845a7 100644 --- a/fastsim-core/src/vehicle/powertrain/traits.rs +++ b/fastsim-core/src/vehicle/powertrain/traits.rs @@ -39,7 +39,7 @@ pub trait Powertrain { &mut self, te_amb: si::Temperature, pwr_thrl_fc_to_cab: si::Power, - veh_state: VehicleState, + veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()>; diff --git a/fastsim-core/src/vehicle/powertrain_type.rs b/fastsim-core/src/vehicle/powertrain_type.rs index bf16de9c..3e1c39e6 100644 --- a/fastsim-core/src/vehicle/powertrain_type.rs +++ b/fastsim-core/src/vehicle/powertrain_type.rs @@ -51,7 +51,7 @@ impl Powertrain for PowertrainType { &mut self, te_amb: si::Temperature, pwr_thrl_fc_to_cab: si::Power, - veh_state: VehicleState, + veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()> { match self { diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index bd7fbb50..5c5c96fd 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -141,8 +141,6 @@ pub struct Vehicle { /// Baseline power required by auxilliary systems pub pwr_aux_base: si::Power, - /// Max power available for auxilliary systems - pub pwr_aux_max: si::Power, /// transmission efficiency // TODO: check if `trans_eff` is redundant (most likely) and fix @@ -410,8 +408,6 @@ impl Vehicle { /// Solves for energy consumption pub fn solve_powertrain(&mut self, dt: si::Time) -> anyhow::Result<()> { - // TODO: do something more sophisticated with pwr_aux - self.state.pwr_aux = self.pwr_aux_base; self.pt_type .solve( self.state.pwr_tractive, @@ -426,12 +422,11 @@ impl Vehicle { } pub fn set_curr_pwr_out_max(&mut self, dt: si::Time) -> anyhow::Result<()> { - // TODO: when a fancier model for `pwr_aux` is implemented, put it here // TODO: make transmission field in vehicle and make it be able to produce an efficiency - // TODO: account for traction limits here + // TODO: account for traction limits here or somewhere? self.pt_type - .set_curr_pwr_prop_out_max(self.pwr_aux_base, dt, self.state) + .set_curr_pwr_prop_out_max(self.state.pwr_aux, dt, self.state) .with_context(|| anyhow!(format_dbg!()))?; (self.state.pwr_prop_fwd_max, self.state.pwr_prop_bwd_max) = self @@ -445,27 +440,50 @@ impl Vehicle { pub fn solve_thermal( &mut self, te_amb_air: si::Temperature, - veh_state: VehicleState, dt: si::Time, ) -> anyhow::Result<()> { let te_fc: Option = self.fc().and_then(|fc| fc.temperature()); + let veh_state = &mut self.state; let pwr_thrml_fc_to_cabin = match (&mut self.cabin, &mut self.hvac) { - (CabinOption::None, HVACOption::None) => si::Power::ZERO, + (CabinOption::None, HVACOption::None) => { + veh_state.pwr_aux = self.pwr_aux_base; + si::Power::ZERO + } (CabinOption::LumpedCabin(cab), HVACOption::LumpedCabin(hvac)) => { let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = hvac .solve(te_amb_air, te_fc, cab.state, cab.heat_capacitance, dt) .with_context(|| format_dbg!())?; cab.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) .with_context(|| format_dbg!())?; + veh_state.pwr_aux = self.pwr_aux_base + hvac.state.pwr_aux_for_hvac; pwr_thrml_fc_to_cab } (CabinOption::LumpedCabin(cab), HVACOption::LumpedCabinAndRES(hvac)) => { - todo!("Connect HVAC system to RES."); - let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = hvac - .solve(te_amb_air, te_fc, cab.state, cab.heat_capacitance, dt) + let res = self.res_mut().with_context(|| format_dbg!("`HVACOption::LumpedCabinAndRES(...)` requires powertrain with `ReversibleEnergyStorage`"))?; + let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab, pwr_thrml_hvac_to_res) = hvac + .solve( + te_amb_air, + te_fc, + cab.state, + cab.heat_capacitance, + res.temperature().with_context(|| { + format_dbg!( + "`ReversibleEnergyStorage` must be configured with thermal model." + ) + })?, + res.temp_prev().with_context(|| { + format_dbg!( + "`ReversibleEnergyStorage` must be configured with thermal model." + ) + })?, + dt, + ) .with_context(|| format_dbg!())?; cab.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) .with_context(|| format_dbg!())?; + res.solve_thermal(te_amb_air, pwr_thrml_hvac_to_res, cab.state.temperature, dt) + .with_context(|| format_dbg!())?; + veh_state.pwr_aux = self.pwr_aux_base + hvac.state.pwr_aux_for_hvac; pwr_thrml_fc_to_cab } (CabinOption::LumpedCabinWithShell, HVACOption::LumpedCabinWithShell) => { diff --git a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs index 7d48558d..4c20ceb8 100644 --- a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs +++ b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs @@ -18,8 +18,6 @@ impl TryFrom for Vehicle { cabin: Default::default(), hvac: Default::default(), pwr_aux_base: f2veh.aux_kw * uc::KW, - // high value to make sure it has no effect - pwr_aux_max: f2veh.aux_kw * 2. * uc::KW, trans_eff: f2veh.trans_eff * uc::R, state: Default::default(), save_interval, From 8cd096ead842a1cabecdfb1ed2673924715b0460 Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Mon, 23 Dec 2024 14:21:46 -0700 Subject: [PATCH 11/12] battery thermal and cabin are connected doc cleanup --- .../f3-vehicles/2010 Mazda 3 i-Stop.yaml | 1 - cal_and_val/f3-vehicles/2012 Ford Focus.yaml | 1 - cal_and_val/f3-vehicles/2012 Ford Fusion.yaml | 1 - .../f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml | 1 - .../f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml | 1 - .../2016 CHEVROLET Malibu 4cyl 2WD.yaml | 1 - .../f3-vehicles/2016 CHEVROLET Spark EV.yaml | 3 +- .../f3-vehicles/2016 FORD C-MAX HEV.yaml | 3 +- .../2016 FORD Escape 4cyl 2WD.yaml | 1 - .../2016 FORD Explorer 4cyl 2WD.yaml | 1 - .../2016 HYUNDAI Elantra 4cyl 2WD.yaml | 1 - .../2016 Hyundai Tucson Fuel Cell.yaml | 3 +- .../f3-vehicles/2016 KIA Optima Hybrid.yaml | 3 +- cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml | 3 +- .../f3-vehicles/2016 MITSUBISHI i-MiEV.yaml | 3 +- .../f3-vehicles/2016 Nissan Leaf 30 kWh.yaml | 3 +- .../f3-vehicles/2016 TESLA Model S60 2WD.yaml | 3 +- .../2016 TOYOTA Camry 4cyl 2WD.yaml | 1 - .../2016 TOYOTA Corolla 4cyl 2WD.yaml | 1 - .../2016 TOYOTA Highlander Hybrid.yaml | 3 +- .../2016 Toyota Prius Two FWD.yaml | 3 +- .../f3-vehicles/2017 CHEVROLET Bolt.yaml | 3 +- .../f3-vehicles/2017 Maruti Dzire VDI.yaml | 1 - .../2017 Toyota Highlander 3.5 L.yaml | 1 - .../2020 Chevrolet Colorado 2WD Diesel.yaml | 1 - .../2020 Hero Splendor+ 100cc.yaml | 1 - .../f3-vehicles/2020 VW Golf 1.5TSI.yaml | 1 - .../f3-vehicles/2020 VW Golf 2.0TDI.yaml | 1 - .../f3-vehicles/2021 BMW iX xDrive40.yaml | 3 +- cal_and_val/f3-vehicles/2021 Cupra Born.yaml | 3 +- .../2021 Fiat Panda Mild Hybrid.yaml | 1 - .../f3-vehicles/2021 Honda N-Box G.yaml | 1 - cal_and_val/f3-vehicles/2021 Peugot 3008.yaml | 1 - .../2022 Ford F-150 Lightning 4WD.yaml | 3 +- .../2022 MINI Cooper SE Hardtop 2 door.yaml | 3 +- .../2022 Renault Megane E-Tech.yaml | 3 +- .../2022 Renault Zoe ZE50 R135.yaml | 3 +- .../f3-vehicles/2022 Tesla Model 3 RWD.yaml | 3 +- .../f3-vehicles/2022 Tesla Model Y RWD.yaml | 3 +- .../2022 Toyota RAV4 Hybrid LE.yaml | 3 +- .../2022 Toyota Yaris Hybrid Mid.yaml | 3 +- .../2022 Volvo XC40 Recharge twin.yaml | 3 +- .../2023 Mitsubishi Pajero Sport.yaml | 1 - ...2023 Polestar 2 Long range Dual motor.yaml | 3 +- .../f3-vehicles/2023 Volvo C40 Recharge.yaml | 3 +- .../f3-vehicles/2024 BYD Dolphin Active.yaml | 3 +- .../f3-vehicles/2024 Toyota Vios 1.5 G.yaml | 1 - .../f3-vehicles/2024 VinFast VF e34.yaml | 3 +- .../2024 Volkswagen Polo 1.0 MPI.yaml | 1 - cal_and_val/f3-vehicles/BYD ATTO 3.yaml | 3 +- cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml | 1 - .../Class 4 Truck (Isuzu NPR HD).yaml | 1 - cal_and_val/f3-vehicles/Line Haul Conv.yaml | 1 - .../f3-vehicles/Maruti Swift 4cyl 2WD.yaml | 1 - cal_and_val/f3-vehicles/Nissan Navara.yaml | 1 - .../Regional Delivery Class 8 Truck.yaml | 1 - .../f3-vehicles/Renault Clio IV diesel.yaml | 1 - .../Renault Megane 1.5 dCi Authentique.yaml | 1 - .../Toyota Corolla Cross Hybrid.yaml | 3 +- .../f3-vehicles/Toyota Etios Liva diesel.yaml | 1 - .../Toyota Hilux Double Cab 4WD.yaml | 1 - cal_and_val/f3-vehicles/Toyota Mirai.yaml | 3 +- .../fastsim-proc-macros/src/fastsim_api.rs | 3 +- .../resources/vehicles/2012_Ford_Fusion.yaml | 1 - .../vehicles/2016_TOYOTA_Prius_Two.yaml | 3 +- .../vehicles/2022_Renault_Zoe_ZE50_R135.yaml | 3 +- fastsim-core/src/drive_cycle.rs | 3 +- fastsim-core/src/gas_properties.rs | 4 +- fastsim-core/src/resources.rs | 1 + fastsim-core/src/simdrive.rs | 4 +- fastsim-core/src/utils/mod.rs | 3 +- fastsim-core/src/vehicle/bev.rs | 34 ++++--- fastsim-core/src/vehicle/cabin.rs | 18 ++-- fastsim-core/src/vehicle/conv.rs | 24 ++--- fastsim-core/src/vehicle/hev.rs | 49 ++++++++--- .../vehicle/hvac/hvac_sys_for_lumped_cabin.rs | 11 ++- .../hvac/hvac_sys_for_lumped_cabin_and_res.rs | 37 ++++---- .../vehicle/powertrain/electric_machine.rs | 57 ++++++------ .../src/vehicle/powertrain/fuel_converter.rs | 31 ++++--- .../vehicle/powertrain/prepare_eff_values.py | 14 +-- .../powertrain/reversible_energy_storage.rs | 88 +++++++++++-------- fastsim-core/src/vehicle/powertrain/traits.rs | 12 +-- .../src/vehicle/powertrain/transmission.rs | 2 +- fastsim-core/src/vehicle/powertrain_type.rs | 59 ++++++++----- fastsim-core/src/vehicle/vehicle_model.rs | 62 +++++++------ .../vehicle_model/fastsim2_interface.rs | 8 +- .../variable_path_list_expected.txt | 1 - 87 files changed, 339 insertions(+), 313 deletions(-) diff --git a/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml b/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml index af1dbc49..917134a6 100644 --- a/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml +++ b/cal_and_val/f3-vehicles/2010 Mazda 3 i-Stop.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1473.9 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2012 Ford Focus.yaml b/cal_and_val/f3-vehicles/2012 Ford Focus.yaml index 02d5d035..1578aaef 100644 --- a/cal_and_val/f3-vehicles/2012 Ford Focus.yaml +++ b/cal_and_val/f3-vehicles/2012 Ford Focus.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1473.9 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml b/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml index 40a654be..d0079c53 100644 --- a/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml +++ b/cal_and_val/f3-vehicles/2012 Ford Fusion.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.72 mass_kilograms: 1644.2724500334996 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.875 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml index 170f3b27..1c214056 100644 --- a/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 AUDI A3 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1606.0927171041076 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml index 39c39bd7..6f9bdf77 100644 --- a/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 BMW 328d 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1950.3695157008785 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml index b3886f02..b053cfba 100644 --- a/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 CHEVROLET Malibu 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1666.874756172356 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml b/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml index 2d26cce5..8ecc6d93 100644 --- a/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml +++ b/cal_and_val/f3-vehicles/2016 CHEVROLET Spark EV.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.38 mass_kilograms: 1435.996 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml b/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml index f71087c5..af05d2a8 100644 --- a/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD C-MAX HEV.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1950.3693212520827 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml index 8976566a..92bec2d7 100644 --- a/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD Escape 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1893.6704171330643 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml index b2557ad2..6db5ef78 100644 --- a/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 FORD Explorer 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 2403.9617607817445 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml index bc743160..d0f061cd 100644 --- a/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 HYUNDAI Elantra 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1610.1752055806355 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml b/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml index 374e826a..e78dc366 100644 --- a/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml +++ b/cal_and_val/f3-vehicles/2016 Hyundai Tucson Fuel Cell.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.69 mass_kilograms: 2177.165764419529 pwr_aux_base_watts: 280.0 -pwr_aux_max_watts: 560.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml b/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml index 03a3b735..0fb2dc3b 100644 --- a/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2016 KIA Optima Hybrid.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1893.6707541501114 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml b/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml index 49ca6287..60f0b541 100644 --- a/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml +++ b/cal_and_val/f3-vehicles/2016 Leaf 24 kWh.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.95 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1612.897 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml b/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml index 78521849..9ba9d0db 100644 --- a/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml +++ b/cal_and_val/f3-vehicles/2016 MITSUBISHI i-MiEV.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.95 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1440.0778 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml b/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml index 5000d23e..ce0c3d2a 100644 --- a/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml +++ b/cal_and_val/f3-vehicles/2016 Nissan Leaf 30 kWh.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.95 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1636.03 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml b/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml index 94ba4311..843064ea 100644 --- a/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TESLA Model S60 2WD.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.9 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.96 mass_kilograms: 2270.152 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml index d97250d0..1b29dfc0 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Camry 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1893.6707212387912 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml index 2595d397..46914087 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Corolla 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1553.4758391698351 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml b/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml index f4d2eefb..c2fb1a58 100644 --- a/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2016 TOYOTA Highlander Hybrid.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 2403.962034901285 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml b/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml index 9b59a067..41fa70b4 100644 --- a/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml +++ b/cal_and_val/f3-vehicles/2016 Toyota Prius Two FWD.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.7 mass_kilograms: 1635.0 pwr_aux_base_watts: 1050.0 -pwr_aux_max_watts: 2100.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml b/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml index 33e99057..e94f946d 100644 --- a/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml +++ b/cal_and_val/f3-vehicles/2017 CHEVROLET Bolt.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 1757.77 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml b/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml index 755c66d9..184a0f11 100644 --- a/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml +++ b/cal_and_val/f3-vehicles/2017 Maruti Dzire VDI.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.45 mass_kilograms: 972.5 pwr_aux_base_watts: 950.0 -pwr_aux_max_watts: 1900.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml b/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml index 257264de..ef9fffa2 100644 --- a/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml +++ b/cal_and_val/f3-vehicles/2017 Toyota Highlander 3.5 L.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.72 mass_kilograms: 2270.0 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.875 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml b/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml index 28a51f81..d4f2f881 100644 --- a/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml +++ b/cal_and_val/f3-vehicles/2020 Chevrolet Colorado 2WD Diesel.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 3.26 mass_kilograms: 2325.0 pwr_aux_base_watts: 1500.0 -pwr_aux_max_watts: 3000.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml b/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml index add626fc..0d12d1bd 100644 --- a/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml +++ b/cal_and_val/f3-vehicles/2020 Hero Splendor+ 100cc.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 1.236 mass_kilograms: 172.0 pwr_aux_base_watts: 0.0 -pwr_aux_max_watts: 0.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml b/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml index ddfc2ef2..ff641ee8 100644 --- a/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml +++ b/cal_and_val/f3-vehicles/2020 VW Golf 1.5TSI.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.636 mass_kilograms: 1416.0 pwr_aux_base_watts: 750.0 -pwr_aux_max_watts: 1500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml b/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml index b990cd00..4c1d0b3a 100644 --- a/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml +++ b/cal_and_val/f3-vehicles/2020 VW Golf 2.0TDI.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.636 mass_kilograms: 1390.0 pwr_aux_base_watts: 1000.0 -pwr_aux_max_watts: 2000.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml b/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml index a4420af0..ee13e08d 100644 --- a/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml +++ b/cal_and_val/f3-vehicles/2021 BMW iX xDrive40.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.96689295 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 3.0 mass_kilograms: 2600.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Cupra Born.yaml b/cal_and_val/f3-vehicles/2021 Cupra Born.yaml index fcd35072..5de332e4 100644 --- a/cal_and_val/f3-vehicles/2021 Cupra Born.yaml +++ b/cal_and_val/f3-vehicles/2021 Cupra Born.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.97902439 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.766 mass_kilograms: 1927.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml b/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml index a2a330d5..0bd05663 100644 --- a/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml +++ b/cal_and_val/f3-vehicles/2021 Fiat Panda Mild Hybrid.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 1200.0 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml b/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml index dcd96e4f..67bcaa7e 100644 --- a/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml +++ b/cal_and_val/f3-vehicles/2021 Honda N-Box G.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.52 mass_kilograms: 1050.0 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml b/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml index 582a4eff..3804d2b5 100644 --- a/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml +++ b/cal_and_val/f3-vehicles/2021 Peugot 3008.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 1700.0 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml b/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml index cedb4d7e..322ebec4 100644 --- a/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml +++ b/cal_and_val/f3-vehicles/2022 Ford F-150 Lightning 4WD.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.6 mass_kilograms: 2728.358 pwr_aux_base_watts: 200.0 -pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml b/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml index a48288bd..0dc2444f 100644 --- a/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml +++ b/cal_and_val/f3-vehicles/2022 MINI Cooper SE Hardtop 2 door.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 1.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.495 mass_kilograms: 1587.573 pwr_aux_base_watts: 200.0 -pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml b/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml index fc5afed2..6127fc47 100644 --- a/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml +++ b/cal_and_val/f3-vehicles/2022 Renault Megane E-Tech.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 1.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.685 mass_kilograms: 1706.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml b/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml index 704702de..3f3fa253 100644 --- a/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml +++ b/cal_and_val/f3-vehicles/2022 Renault Zoe ZE50 R135.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.588 mass_kilograms: 1600.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml b/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml index 2b19763e..675dcde3 100644 --- a/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml +++ b/cal_and_val/f3-vehicles/2022 Tesla Model 3 RWD.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.87528 mass_kilograms: 1752.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml b/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml index 3413ad1f..9574c908 100644 --- a/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml +++ b/cal_and_val/f3-vehicles/2022 Tesla Model Y RWD.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.89 mass_kilograms: 1909.0 pwr_aux_base_watts: 200.0 -pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml b/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml index 36c5faa2..81236209 100644 --- a/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml +++ b/cal_and_val/f3-vehicles/2022 Toyota RAV4 Hybrid LE.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.68986 mass_kilograms: 1814.369 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.97 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml b/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml index d8f13970..42738a5f 100644 --- a/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml +++ b/cal_and_val/f3-vehicles/2022 Toyota Yaris Hybrid Mid.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.56 mass_kilograms: 1670.0 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.97 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml b/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml index cab47ce0..45130b54 100644 --- a/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml +++ b/cal_and_val/f3-vehicles/2022 Volvo XC40 Recharge twin.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.981538462 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.702 mass_kilograms: 2267.962 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml b/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml index d39e0319..9d72c464 100644 --- a/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml +++ b/cal_and_val/f3-vehicles/2023 Mitsubishi Pajero Sport.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.8 mass_kilograms: 2080.0 pwr_aux_base_watts: 1500.0 -pwr_aux_max_watts: 3000.0 trans_eff: 0.9 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml b/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml index 2e670656..1a4519e4 100644 --- a/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml +++ b/cal_and_val/f3-vehicles/2023 Polestar 2 Long range Dual motor.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.981538462 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.73558 mass_kilograms: 2173.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml b/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml index 6e698387..517dec01 100644 --- a/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml +++ b/cal_and_val/f3-vehicles/2023 Volvo C40 Recharge.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.981538462 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.702 mass_kilograms: 2237.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml b/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml index d2fe4f20..505f6dfe 100644 --- a/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml +++ b/cal_and_val/f3-vehicles/2024 BYD Dolphin Active.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 1.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.7 mass_kilograms: 1405.0 pwr_aux_base_watts: 200.0 -pwr_aux_max_watts: 400.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml b/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml index 5d29e3f2..a3350f6d 100644 --- a/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml +++ b/cal_and_val/f3-vehicles/2024 Toyota Vios 1.5 G.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.62 mass_kilograms: 1105.0 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml b/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml index 087ee85a..508b9c52 100644 --- a/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml +++ b/cal_and_val/f3-vehicles/2024 VinFast VF e34.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 1.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.6108 mass_kilograms: 1606.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml b/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml index 14d21917..e3ddcaef 100644 --- a/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml +++ b/cal_and_val/f3-vehicles/2024 Volkswagen Polo 1.0 MPI.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.552 mass_kilograms: 1202.0 pwr_aux_base_watts: 800.0 -pwr_aux_max_watts: 1600.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/BYD ATTO 3.yaml b/cal_and_val/f3-vehicles/BYD ATTO 3.yaml index dd0f491b..811862ed 100644 --- a/cal_and_val/f3-vehicles/BYD ATTO 3.yaml +++ b/cal_and_val/f3-vehicles/BYD ATTO 3.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.588 mass_kilograms: 1950.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml b/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml index 918ffe56..2259093a 100644 --- a/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml +++ b/cal_and_val/f3-vehicles/Bajaj Boxer 150.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 1.236 mass_kilograms: 183.0 pwr_aux_base_watts: 0.0 -pwr_aux_max_watts: 0.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml b/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml index 21edd20e..0d99e27f 100644 --- a/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml +++ b/cal_and_val/f3-vehicles/Class 4 Truck (Isuzu NPR HD).yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 4.08 mass_kilograms: 6590.0 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.94 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Line Haul Conv.yaml b/cal_and_val/f3-vehicles/Line Haul Conv.yaml index f7543df9..44448232 100644 --- a/cal_and_val/f3-vehicles/Line Haul Conv.yaml +++ b/cal_and_val/f3-vehicles/Line Haul Conv.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.7536 mass_kilograms: 21000.0 pwr_aux_base_watts: 10000.0 -pwr_aux_max_watts: 20000.0 trans_eff: 0.8 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml b/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml index dbfb100e..37bc353c 100644 --- a/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml +++ b/cal_and_val/f3-vehicles/Maruti Swift 4cyl 2WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.45 mass_kilograms: 950.0 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Nissan Navara.yaml b/cal_and_val/f3-vehicles/Nissan Navara.yaml index 97d32767..e07f8c97 100644 --- a/cal_and_val/f3-vehicles/Nissan Navara.yaml +++ b/cal_and_val/f3-vehicles/Nissan Navara.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 2200.0 pwr_aux_base_watts: 800.0 -pwr_aux_max_watts: 1600.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml b/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml index 82c2b373..40feab45 100644 --- a/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml +++ b/cal_and_val/f3-vehicles/Regional Delivery Class 8 Truck.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.7536 mass_kilograms: 15076.0 pwr_aux_base_watts: 10000.0 -pwr_aux_max_watts: 20000.0 trans_eff: 0.85 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml b/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml index 0910d4ed..7c1b54f7 100644 --- a/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml +++ b/cal_and_val/f3-vehicles/Renault Clio IV diesel.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 1150.0 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml b/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml index 980549ab..e5c7c1f3 100644 --- a/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml +++ b/cal_and_val/f3-vehicles/Renault Megane 1.5 dCi Authentique.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 1550.0 pwr_aux_base_watts: 800.0 -pwr_aux_max_watts: 1600.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml b/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml index 32f4b30d..d3ef164a 100644 --- a/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml +++ b/cal_and_val/f3-vehicles/Toyota Corolla Cross Hybrid.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.56 mass_kilograms: 1750.0 pwr_aux_base_watts: 500.0 -pwr_aux_max_watts: 1000.0 trans_eff: 0.97 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml b/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml index 2b3e3b42..e4e5af9f 100644 --- a/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml +++ b/cal_and_val/f3-vehicles/Toyota Etios Liva diesel.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 1100.0 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml b/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml index 9131d763..5c52f3f6 100644 --- a/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml +++ b/cal_and_val/f3-vehicles/Toyota Hilux Double Cab 4WD.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.3 mass_kilograms: 2600.0 pwr_aux_base_watts: 900.0 -pwr_aux_max_watts: 1800.0 trans_eff: 0.95 save_interval: 1 state: diff --git a/cal_and_val/f3-vehicles/Toyota Mirai.yaml b/cal_and_val/f3-vehicles/Toyota Mirai.yaml index 64a307f8..ce79797b 100644 --- a/cal_and_val/f3-vehicles/Toyota Mirai.yaml +++ b/cal_and_val/f3-vehicles/Toyota Mirai.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.78 mass_kilograms: 1929.5047475207882 pwr_aux_base_watts: 300.0 -pwr_aux_max_watts: 600.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs b/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs index 6c06f41d..0d29e98b 100644 --- a/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs +++ b/fastsim-core/fastsim-proc-macros/src/fastsim_api.rs @@ -283,7 +283,8 @@ fn process_tuple_struct( self.0.len() } /// PyO3-exposed method to check if the vec-containing struct is empty. - fn is_empty(&self) -> bool { + #[pyo3(name = "is_empty")] + fn is_empty_py(&self) -> bool { self.0.is_empty() } } diff --git a/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml b/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml index 40a654be..d0079c53 100755 --- a/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml +++ b/fastsim-core/resources/vehicles/2012_Ford_Fusion.yaml @@ -242,7 +242,6 @@ chassis: wheel_base_meters: 2.72 mass_kilograms: 1644.2724500334996 pwr_aux_base_watts: 700.0 -pwr_aux_max_watts: 1400.0 trans_eff: 0.875 save_interval: 1 state: diff --git a/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml b/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml index 9b59a067..41fa70b4 100755 --- a/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml +++ b/fastsim-core/resources/vehicles/2016_TOYOTA_Prius_Two.yaml @@ -232,7 +232,7 @@ pt_type: pwr_idle_fuel_watts: 0.0 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -687,7 +687,6 @@ chassis: wheel_base_meters: 2.7 mass_kilograms: 1635.0 pwr_aux_base_watts: 1050.0 -pwr_aux_max_watts: 2100.0 trans_eff: 0.98 save_interval: 1 state: diff --git a/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml b/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml index 704702de..3f3fa253 100644 --- a/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml +++ b/fastsim-core/resources/vehicles/2022_Renault_Zoe_ZE50_R135.yaml @@ -14,7 +14,7 @@ pt_type: max_soc: 0.98 save_interval: 1 em: - eff_interp_fwd: + eff_interp_achieved: Interp1D: x: - 0.0 @@ -94,7 +94,6 @@ chassis: wheel_base_meters: 2.588 mass_kilograms: 1600.0 pwr_aux_base_watts: 250.0 -pwr_aux_max_watts: 500.0 trans_eff: 0.92 save_interval: 1 state: diff --git a/fastsim-core/src/drive_cycle.rs b/fastsim-core/src/drive_cycle.rs index 6a39b4b3..10e8e732 100644 --- a/fastsim-core/src/drive_cycle.rs +++ b/fastsim-core/src/drive_cycle.rs @@ -1,5 +1,6 @@ use crate::imports::*; use crate::prelude::*; +#[cfg(feature = "pyo3")] use crate::resources; use fastsim_2::cycle::RustCycle as Cycle2; @@ -74,7 +75,7 @@ lazy_static! { impl Init for Cycle { /// Sets `self.dist` and `self.elev` /// # Assumptions - /// - if `init_elev.is_none()`, then defaults to [ELEV_DEFAULT] + /// - if `init_elev.is_none()`, then defaults to [static@ELEV_DEFAULT] fn init(&mut self) -> anyhow::Result<()> { ensure!(self.time.len() == self.speed.len()); ensure!(self.grade.len() == self.len()); diff --git a/fastsim-core/src/gas_properties.rs b/fastsim-core/src/gas_properties.rs index 3304069b..1a9feeba 100644 --- a/fastsim-core/src/gas_properties.rs +++ b/fastsim-core/src/gas_properties.rs @@ -14,7 +14,7 @@ lazy_static! { } #[fastsim_api( - /// Returns density of air [kg/m^3] + /// Returns density of air \[kg/m^3\] /// Source: /// /// # Equations used @@ -23,7 +23,7 @@ lazy_static! { /// /// # Arguments /// * `te_air_deg_c` - optional ambient temperature [°C] of air, defaults to 22 C - /// * `h_m` - optional elevation [m] above sea level, defaults to 180 m + /// * `h_m` - optional elevation \[m\] above sea level, defaults to 180 m #[staticmethod] #[pyo3(name = "get_density")] pub fn get_density_py(te_air_deg_c: Option, h_m: Option) -> f64 { diff --git a/fastsim-core/src/resources.rs b/fastsim-core/src/resources.rs index 18c53b33..de3ebf73 100755 --- a/fastsim-core/src/resources.rs +++ b/fastsim-core/src/resources.rs @@ -3,6 +3,7 @@ pub const RESOURCES_DIR: Dir = include_dir!("$CARGO_MANIFEST_DIR/resources"); /// List the available resources in the resources directory /// - subdir: &str, a subdirectory to choose from the resources directory +/// /// NOTE: if subdir cannot be resolved, returns an empty list /// RETURNS: a vector of strings for resources that can be loaded pub fn list_resources(subdir: &str) -> Vec { diff --git a/fastsim-core/src/simdrive.rs b/fastsim-core/src/simdrive.rs index b8abd11e..27c17a9f 100644 --- a/fastsim-core/src/simdrive.rs +++ b/fastsim-core/src/simdrive.rs @@ -220,7 +220,7 @@ impl SimDrive { /// # Arguments /// - `speed`: prescribed or achieved speed // - `speed_prev`: previously achieved speed - /// - `dt`: time step size + /// - `dt`: simulation time step size pub fn set_pwr_prop_for_speed( &mut self, speed: si::Velocity, @@ -313,7 +313,7 @@ impl SimDrive { /// Sets achieved speed based on known current max power /// # Arguments /// - `cyc_speed`: prescribed speed - /// - `dt`: time step size + /// - `dt`: simulation time step size /// - `speed_prev`: previously achieved speed pub fn set_ach_speed( &mut self, diff --git a/fastsim-core/src/utils/mod.rs b/fastsim-core/src/utils/mod.rs index 356a1944..bfbe5ecf 100755 --- a/fastsim-core/src/utils/mod.rs +++ b/fastsim-core/src/utils/mod.rs @@ -106,7 +106,8 @@ pub fn abs_checked_x_val(x_val: f64, x_data: &[f64]) -> anyhow::Result { } } -pub(crate) const COMP_EPSILON: f64 = 1e-8; +// public to enable exposure in docs +pub const COMP_EPSILON: f64 = 1e-8; /// Returns true if `val1` and `val2` are within a relative/absolute `epsilon` of each other, /// depending on magnitude. diff --git a/fastsim-core/src/vehicle/bev.rs b/fastsim-core/src/vehicle/bev.rs index b0f2b4e8..db5769c8 100644 --- a/fastsim-core/src/vehicle/bev.rs +++ b/fastsim-core/src/vehicle/bev.rs @@ -139,19 +139,6 @@ impl Powertrain for BatteryElectricVehicle { Ok(()) } - fn solve_thermal( - &mut self, - te_amb: si::Temperature, - _pwr_thrml_fc_to_cab: si::Power, - _veh_state: &mut VehicleState, - dt: si::Time, - ) -> anyhow::Result<()> { - self.res - .solve_thermal(te_amb, dt) - .with_context(|| format_dbg!())?; - Ok(()) - } - fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { Ok(( self.em.state.pwr_mech_fwd_out_max, @@ -194,3 +181,24 @@ impl Powertrain for BatteryElectricVehicle { -self.em.state.pwr_mech_prop_out.min(si::Power::ZERO) } } + +impl BatteryElectricVehicle { + /// Solve change in temperature and other thermal effects + /// # Arguments + /// - `te_amb`: ambient temperature + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from [Vehicle::hvac] system to [ReversibleEnergyStorage::thrml] + /// - `te_cab`: cabin temperature for heat transfer interaction with [ReversibleEnergyStorage] + /// - `dt`: simulation time step size + pub fn solve_thermal( + &mut self, + te_amb: si::Temperature, + pwr_thrml_hvac_to_res: si::Power, + te_cab: Option, + dt: si::Time, + ) -> anyhow::Result<()> { + self.res + .solve_thermal(te_amb, pwr_thrml_hvac_to_res, te_cab, dt) + .with_context(|| format_dbg!())?; + Ok(()) + } +} diff --git a/fastsim-core/src/vehicle/cabin.rs b/fastsim-core/src/vehicle/cabin.rs index b9bdc1ce..f83ff083 100644 --- a/fastsim-core/src/vehicle/cabin.rs +++ b/fastsim-core/src/vehicle/cabin.rs @@ -64,15 +64,18 @@ impl LumpedCabin { /// Arguments: /// - `te_amb_air`: ambient air temperature /// - `veh_state`: current [VehicleState] - /// - 'pwr_thermal_from_hvac`: power to cabin from HVAC system + /// - 'pwr_thermal_from_hvac`: power to cabin from [Vehicle::hvac] system /// - `dt`: simulation time step size + /// # Returns + /// - `te_cab`: current cabin temperature, after solving cabin for current + /// simulation time step pub fn solve( &mut self, te_amb_air: si::Temperature, - veh_state: &mut VehicleState, + veh_state: &VehicleState, pwr_thermal_from_hvac: si::Power, dt: si::Time, - ) -> anyhow::Result<()> { + ) -> anyhow::Result { self.state.pwr_thermal_from_hvac = pwr_thermal_from_hvac; // flat plate model for isothermal, mixed-flow from Incropera and deWitt, Fundamentals of Heat and Mass // Transfer, 7th Edition @@ -115,10 +118,11 @@ impl LumpedCabin { }; self.state.temp_prev = self.state.temperature; - self.state.temperature += (self.state.pwr_thermal_from_hvac + self.state.pwr_thermal_from_amb) + self.state.temperature += (self.state.pwr_thermal_from_hvac + + self.state.pwr_thermal_from_amb) / self.heat_capacitance * dt; - Ok(()) + Ok(self.state.temperature) } } @@ -134,10 +138,10 @@ pub struct LumpedCabinState { /// lumped cabin temperature at previous simulation time step // TODO: make sure this gets updated pub temp_prev: si::Temperature, - /// Thermal power coming to cabin from HVAC system. Positive indicates + /// Thermal power coming to cabin from [Vehicle::hvac] system. Positive indicates /// heating, and negative indicates cooling. pub pwr_thermal_from_hvac: si::Power, - /// Cumulative thermal energy coming to cabin from HVAC system. Positive indicates + /// Cumulative thermal energy coming to cabin from [Vehicle::hvac] system. Positive indicates /// heating, and negative indicates cooling. pub energy_thermal_from_hvac: si::Energy, /// Thermal power coming to cabin from ambient air. Positive indicates diff --git a/fastsim-core/src/vehicle/conv.rs b/fastsim-core/src/vehicle/conv.rs index 31f500a4..231e0832 100644 --- a/fastsim-core/src/vehicle/conv.rs +++ b/fastsim-core/src/vehicle/conv.rs @@ -54,17 +54,6 @@ impl Powertrain for Box { Ok(()) } - fn solve_thermal( - &mut self, - te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, - veh_state: &mut VehicleState, - dt: si::Time, - ) -> anyhow::Result<()> { - self.fc - .solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) - } - fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { Ok((self.fc.state.pwr_prop_max, si::Power::ZERO)) } @@ -94,6 +83,19 @@ impl Powertrain for Box { } } +impl ConventionalVehicle { + pub fn solve_thermal( + &mut self, + te_amb: si::Temperature, + pwr_thrml_fc_to_cab: Option, + veh_state: &mut VehicleState, + dt: si::Time, + ) -> anyhow::Result<()> { + self.fc + .solve_thermal(te_amb, pwr_thrml_fc_to_cab, veh_state, dt) + } +} + impl Mass for ConventionalVehicle { fn mass(&self) -> anyhow::Result> { let derived_mass = self diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index c2283dc4..8c5a63a9 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -204,28 +204,46 @@ impl Powertrain for Box { Ok(()) } - fn solve_thermal( + fn pwr_regen(&self) -> si::Power { + // When `pwr_mech_prop_out` is negative, regen is happening. First, clip it at 0, and then negate it. + // see https://play.rust-lang.org/?version=stable&mode=debug&edition=2021&gist=e8f7af5a6e436dd1163fa3c70931d18d + // for example + -self.em.state.pwr_mech_prop_out.min(0. * uc::W) + } +} + +impl HybridElectricVehicle { + /// # Arguments + /// - `te_amb`: ambient temperature + /// - `pwr_thrml_fc_to_cab`: thermal power flow from [FuelConverter::thrml] + /// to [Vehicle::cabin], if cabin is equipped + /// - `veh_state`: current [VehicleState] + /// - `pwr_thrml_hvac_to_res`: thermal power flow from [Vehicle::hvac] -- + /// zero if `None` is passed + /// - `te_cab`: cabin temperature, required if [ReversibleEnergyStorage::thrml] is `Some` + /// - `dt`: simulation time step size + pub fn solve_thermal( &mut self, te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, + pwr_thrml_fc_to_cab: Option, veh_state: &mut VehicleState, + pwr_thrml_hvac_to_res: Option, + te_cab: Option, dt: si::Time, ) -> anyhow::Result<()> { self.fc - .solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) + .solve_thermal(te_amb, pwr_thrml_fc_to_cab, veh_state, dt) .with_context(|| format_dbg!())?; self.res - .solve_thermal(te_amb, dt) + .solve_thermal( + te_amb, + pwr_thrml_hvac_to_res.unwrap_or_default(), + te_cab, + dt, + ) .with_context(|| format_dbg!())?; Ok(()) } - - fn pwr_regen(&self) -> si::Power { - // When `pwr_mech_prop_out` is negative, regen is happening. First, clip it at 0, and then negate it. - // see https://play.rust-lang.org/?version=stable&mode=debug&edition=2021&gist=e8f7af5a6e436dd1163fa3c70931d18d - // for example - -self.em.state.pwr_mech_prop_out.min(0. * uc::W) - } } impl Mass for HybridElectricVehicle { @@ -326,6 +344,10 @@ impl FCOnCauses { fn push(&mut self, new: FCOnCause) { self.0.push(new) } + + fn is_empty(&self) -> bool { + self.0.is_empty() + } } // TODO: figure out why this is not appearing in the dataframe but is in the pydict @@ -438,8 +460,7 @@ pub enum HEVAuxControls { pub enum HEVPowertrainControls { /// Controls that attempt to match fastsim-2 RGWDB(Box), - /// Controls that have a dynamically updated discharge buffer but are - /// otherwise similar to [Self::Fastsim2] + /// place holder for future variants Placeholder, } @@ -597,7 +618,7 @@ pub struct RESGreedyWithDynamicBuffers { /// Minimum time engine must remain on if it was on during the previous /// simulation time step. pub fc_min_time_on: Option, - /// Speed at which [fuelconverter] is forced on. + /// Speed at which [FuelConverter] is forced on. pub speed_fc_forced_on: Option, /// Fraction of total aux and powertrain rated power at which /// [FuelConverter] is forced on. diff --git a/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs index 9d6b537c..eaea554c 100644 --- a/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs +++ b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin.rs @@ -41,6 +41,15 @@ pub struct HVACSystemForLumpedCabin { impl Init for HVACSystemForLumpedCabin {} impl SerdeAPI for HVACSystemForLumpedCabin {} impl HVACSystemForLumpedCabin { + /// # Arguments + /// - `te_amb_air`: ambient air temperature + /// - `te_fc`: [FuelConverter] temperature, if equipped + /// - `cab_state`: [LumpedCabinState] + /// - `cab_heat_cap`: cabin heat capacitance + /// - `dt`: simulation time step size + /// # Returns + /// - `pwr_thrml_hvac_to_cabin`: thermal power flow from [Vehicle::hvac] system to cabin + /// - `pwr_thrml_fc_to_cabin`: thermal power flow from [FuelConverter] to cabin via HVAC system pub fn solve( &mut self, te_amb_air: si::Temperature, @@ -242,7 +251,7 @@ pub struct HVACSystemForLumpedCabinState { pub energy_d: si::Energy, /// coefficient of performance (i.e. efficiency) of vapor compression cycle pub cop: si::Ratio, - /// Aux power demand from HVAC system + /// Aux power demand from [Vehicle::hvac] system pub pwr_aux_for_hvac: si::Power, /// Cumulative aux energy for HVAC system pub energy_aux: si::Energy, diff --git a/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs index 016fed55..7db3951c 100644 --- a/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs +++ b/fastsim-core/src/vehicle/hvac/hvac_sys_for_lumped_cabin_and_res.rs @@ -2,7 +2,7 @@ use super::*; #[fastsim_api] #[derive(Deserialize, Serialize, Debug, Clone, PartialEq, HistoryMethods)] -/// HVAC system for [LumpedCabin] and [] +/// HVAC system for [LumpedCabin] and [ReversibleEnergyStorage::thrml] pub struct HVACSystemForLumpedCabinAndRES { /// set point temperature pub te_set: si::Temperature, @@ -61,27 +61,27 @@ impl HVACSystemForLumpedCabinAndRES { /// # Arguments /// - `te_amb_air`: ambient air temperature /// - `te_fc`: [FuelConverter] temperature, if equipped - /// - `cab_state`: [Cabin] state - /// - `cab_heat_cap`: [Cabin] heat capacity - /// - `res_temp`: [ReversibleEnergyStorage] temperature - /// - `res_temp_prev`: [ReversibleEnergyStorage] temperature at previous time step - /// - `dt`: time step size + /// - `cab_state`: [LumpedCabinState] + /// - `cab_heat_cap`: [LumpedCabinState] heat capacity + /// - `res_temp`: [ReversibleEnergyStorage] temperatures at current and previous time step + /// - `dt`: simulation time step size /// /// # Returns - /// - `pwr_thrml_hvac_to_cabin`: thermal power flowing from HVAC system to cabin + /// - `pwr_thrml_hvac_to_cabin`: thermal power flowing from [Vehicle::hvac] system to cabin /// - `pwr_thrml_fc_to_cabin`: thermal power flowing from [FuelConverter] to cabin - /// - `pwr_thrml_hvac_to_res`: thermal power flowing from HVAC system to - /// [ReversibleEnergyStorage] `thrml` system + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from [Vehicle::hvac] system to + /// [ReversibleEnergyStorage] `thrml` system + #[allow(clippy::too_many_arguments)] // the order is reasonably protected by typing pub fn solve( &mut self, te_amb_air: si::Temperature, te_fc: Option, cab_state: LumpedCabinState, cab_heat_cap: si::HeatCapacity, - res_temp: si::Temperature, - res_temp_prev: si::Temperature, + res_temps: (si::Temperature, si::Temperature), dt: si::Time, ) -> anyhow::Result<(si::Power, si::Power, si::Power)> { + let (res_temp, res_temp_prev) = res_temps; let mut pwr_thrml_hvac_to_cabin = self .solve_for_cabin(te_fc, cab_state, cab_heat_cap, dt) .with_context(|| format_dbg!())?; @@ -355,6 +355,7 @@ impl HVACSystemForLumpedCabinAndRES { // If `pwr_i_res` is less than zero reset to switch from cooling to heating self.state.pwr_i_res = si::Power::ZERO; } + #[allow(clippy::let_and_return)] // for readability let pwr_thrml_hvac_to_res = (-self.state.pwr_p_res - self.state.pwr_i_res - self.state.pwr_d_res) .min(self.pwr_thermal_max); @@ -421,21 +422,21 @@ pub struct HVACSystemForLumpedCabinAndRESState { pub pwr_d: si::Power, /// portion of total HVAC cooling/heating (negative/positive) cumulative energy due to derivative gain pub energy_d: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to proportional gain + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage::thrml] due to proportional gain pub pwr_p_res: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to proportional gain + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage::thrml] due to proportional gain pub energy_p_res: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to integral gain + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage::thrml] due to integral gain pub pwr_i_res: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to integral gain + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage::thrml] due to integral gain pub energy_i_res: si::Energy, - /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage] due to derivative gain + /// portion of total HVAC cooling/heating (negative/positive) power to [ReversibleEnergyStorage::thrml] due to derivative gain pub pwr_d_res: si::Power, - /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage] due to derivative gain + /// portion of total HVAC cooling/heating (negative/positive) cumulative energy to [ReversibleEnergyStorage::thrml] due to derivative gain pub energy_d_res: si::Energy, /// coefficient of performance (i.e. efficiency) of vapor compression cycle pub cop: si::Ratio, - /// Au power demand from HVAC system + /// Au power demand from [Vehicle::hvac] system pub pwr_aux_for_hvac: si::Power, /// Cumulative aux energy for HVAC system pub energy_aux: si::Energy, diff --git a/fastsim-core/src/vehicle/powertrain/electric_machine.rs b/fastsim-core/src/vehicle/powertrain/electric_machine.rs index cb7dc8bf..1c8b24b3 100755 --- a/fastsim-core/src/vehicle/powertrain/electric_machine.rs +++ b/fastsim-core/src/vehicle/powertrain/electric_machine.rs @@ -59,14 +59,16 @@ use crate::pyo3::*; /// electronics. pub struct ElectricMachine { #[api(skip_set, skip_get)] - /// Efficiency array corresponding to [Self::pwr_out_frac_interp] and [Self::pwr_in_frac_interp] - /// eff_interp_fwd and eff_interp_bwd have the same f_x but different x - /// note that the Extrapolate field of this variable is changed in get_pwr_in_req() - pub eff_interp_fwd: Interpolator, + /// Efficiency interpolator corresponding to achieved output power + /// + /// Note that the Extrapolate field of this variable is changed in [Self::get_pwr_in_req] + pub eff_interp_achieved: Interpolator, #[serde(default)] #[api(skip_set, skip_get)] - /// if it is not provided, will be set during init - /// note that the Extrapolate field of this variable is changed in set_cur_pwr_prop_out_max() + /// Efficiency interpolator corresponding to max input power + /// If `None`, will be set during [Self::init]. + /// + /// Note that the Extrapolate field of this variable is changed in [Self::set_curr_pwr_prop_out_max] pub eff_interp_at_max_input: Option, /// Electrical input power fraction array at which efficiencies are evaluated. /// Calculated during runtime if not provided. @@ -108,7 +110,7 @@ impl ElectricMachine { /// component. Zero means no power can be sent to upstream compnents and positive /// values indicate upstream components can absorb energy. /// - `pwr_aux`: aux-related power required from this component - /// - `dt`: time step size + /// - `dt`: simulation time step size pub fn set_curr_pwr_prop_out_max( &mut self, pwr_in_fwd_lim: si::Power, @@ -200,7 +202,7 @@ impl ElectricMachine { /// Solves for this powertrain system/component efficiency and sets/returns power input required. /// # Arguments /// - `pwr_out_req`: propulsion-related power output required - /// - `dt`: time step size + /// - `dt`: simulation time step size pub fn get_pwr_in_req( &mut self, pwr_out_req: si::Power, @@ -242,17 +244,18 @@ impl ElectricMachine { self.state.pwr_out_req = pwr_out_req; // ensuring eff_interp_fwd has Extrapolate set to Error before calculating self.state.eff - self.eff_interp_fwd.set_extrapolate(Extrapolate::Error)?; + self.eff_interp_achieved + .set_extrapolate(Extrapolate::Error)?; self.state.eff = uc::R * self - .eff_interp_fwd + .eff_interp_achieved .interpolate( &[{ let pwr = |pwr_uncorrected: f64| -> anyhow::Result { Ok({ if self - .eff_interp_fwd + .eff_interp_achieved .x()? .first() .with_context(|| anyhow!(format_dbg!()))? @@ -307,7 +310,7 @@ impl SerdeAPI for ElectricMachine {} impl Init for ElectricMachine { fn init(&mut self) -> anyhow::Result<()> { let _ = self.mass().with_context(|| anyhow!(format_dbg!()))?; - let _ = check_interp_frac_data(self.eff_interp_fwd.x()?, InterpRange::Either) + let _ = check_interp_frac_data(self.eff_interp_achieved.x()?, InterpRange::Either) .with_context(|| "Invalid values for `ElectricMachine::pwr_out_frac_interp`; must range from [-1..1] or [0..1].")?; self.state.init().with_context(|| anyhow!(format_dbg!()))?; @@ -321,18 +324,18 @@ impl Init for ElectricMachine { // sets eff_interp_bwd to eff_interp_fwd, but changes the x-value. // TODO: what should the default strategy be for eff_interp_bwd? let eff_interp_at_max_input = Interp1D::new( - self.eff_interp_fwd + self.eff_interp_achieved .x()? .iter() - .zip(self.eff_interp_fwd.f_x()?) + .zip(self.eff_interp_achieved.f_x()?) .map(|(x, y)| x / y) .collect(), - self.eff_interp_fwd.f_x()?.to_owned(), + self.eff_interp_achieved.f_x()?.to_owned(), // TODO: should these be set to be the same as eff_interp_fwd, // as currently is done, or should they be set to be specific // Extrapolate and Strategy types? - self.eff_interp_fwd.strategy()?.to_owned(), - self.eff_interp_fwd.extrapolate()?.to_owned(), + self.eff_interp_achieved.strategy()?.to_owned(), + self.eff_interp_achieved.extrapolate()?.to_owned(), )?; self.eff_interp_at_max_input = Some(Interpolator::Interp1D(eff_interp_at_max_input)); } @@ -414,7 +417,7 @@ impl ElectricMachine { pub fn get_eff_max_fwd(&self) -> anyhow::Result { // since efficiency is all f64 between 0 and 1, NEG_INFINITY is safe Ok(self - .eff_interp_fwd + .eff_interp_achieved .f_x()? .iter() .fold(f64::NEG_INFINITY, |acc, curr| acc.max(*curr))) @@ -437,8 +440,8 @@ impl ElectricMachine { if (0.0..=1.0).contains(&eff_max) { let old_max_fwd = self.get_eff_max_fwd()?; let old_max_bwd = self.get_eff_max_bwd()?; - let f_x_fwd = self.eff_interp_fwd.f_x()?.to_owned(); - match &mut self.eff_interp_fwd { + let f_x_fwd = self.eff_interp_achieved.f_x()?.to_owned(); + match &mut self.eff_interp_achieved { Interpolator::Interp1D(interp1d) => { interp1d .set_f_x(f_x_fwd.iter().map(|x| x * eff_max / old_max_fwd).collect())?; @@ -478,7 +481,7 @@ impl ElectricMachine { pub fn get_eff_min_fwd(&self) -> anyhow::Result { // since efficiency is all f64 between 0 and 1, NEG_INFINITY is safe Ok(self - .eff_interp_fwd + .eff_interp_achieved .f_x() .with_context(|| "eff_interp_fwd does not have f_x field")? .iter() @@ -517,12 +520,12 @@ impl ElectricMachine { if eff_range == 0.0 { let f_x_fwd = vec![ eff_max_fwd; - self.eff_interp_fwd + self.eff_interp_achieved .f_x() .with_context(|| "eff_interp_fwd does not have f_x field")? .len() ]; - self.eff_interp_fwd.set_f_x(f_x_fwd)?; + self.eff_interp_achieved.set_f_x(f_x_fwd)?; let f_x_bwd = vec![ eff_max_bwd; match &self.eff_interp_at_max_input { @@ -548,8 +551,8 @@ impl ElectricMachine { "`eff_range` is already zero so it cannot be modified." )); } - let f_x_fwd = self.eff_interp_fwd.f_x()?.to_owned(); - match &mut self.eff_interp_fwd { + let f_x_fwd = self.eff_interp_achieved.f_x()?.to_owned(); + match &mut self.eff_interp_achieved { Interpolator::Interp1D(interp1d) => { interp1d.set_f_x( f_x_fwd @@ -562,8 +565,8 @@ impl ElectricMachine { } if self.get_eff_min_fwd()? < 0.0 { let x_neg = self.get_eff_min_fwd()?; - let f_x_fwd = self.eff_interp_fwd.f_x()?.to_owned(); - match &mut self.eff_interp_fwd { + let f_x_fwd = self.eff_interp_achieved.f_x()?.to_owned(); + match &mut self.eff_interp_achieved { Interpolator::Interp1D(interp1d) => { interp1d.set_f_x(f_x_fwd.iter().map(|x| x - x_neg).collect())?; } diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index 0ae34112..ef875670 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -204,7 +204,7 @@ impl FuelConverter { /// Sets maximum possible total power [FuelConverter] /// can produce. /// # Arguments - /// - `dt`: time step size + /// - `dt`: simulation time step size pub fn set_curr_pwr_out_max(&mut self, dt: si::Time) -> anyhow::Result<()> { if self.pwr_out_max_init == si::Power::ZERO { // TODO: think about how to initialize power @@ -238,7 +238,7 @@ impl FuelConverter { /// # Arguments /// - `pwr_out_req`: tractive power output required to achieve presribed speed /// - `fc_on`: whether component is actively running - /// - `dt`: time step size + /// - `dt`: simulation time step size pub fn solve( &mut self, pwr_out_req: si::Power, @@ -321,13 +321,13 @@ impl FuelConverter { pub fn solve_thermal( &mut self, te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, + pwr_thrml_fc_to_cab: Option, veh_state: &mut VehicleState, dt: si::Time, ) -> anyhow::Result<()> { let veh_speed = veh_state.speed_ach; self.thrml - .solve(&self.state, te_amb, pwr_thrl_fc_to_cab, veh_speed, dt) + .solve(&self.state, te_amb, pwr_thrml_fc_to_cab, veh_speed, dt) .with_context(|| format_dbg!()) } @@ -419,28 +419,33 @@ impl FuelConverterThermalOption { /// # Arguments /// - `fc_state`: [FuelConverter] state /// - `te_amb`: ambient temperature - /// - `pwr_thrl_fc_to_cab`: heat demand from HVAC system + /// - `pwr_thrml_fc_to_cab`: heat demand from [Vehicle::hvac] system -- zero if `None` is passed /// - `veh_speed`: current achieved speed fn solve( &mut self, fc_state: &FuelConverterState, te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, + pwr_thrml_fc_to_cab: Option, veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { match self { Self::FuelConverterThermal(fct) => fct - .solve(fc_state, te_amb, pwr_thrl_fc_to_cab, veh_speed, dt) + .solve( + fc_state, + te_amb, + pwr_thrml_fc_to_cab.unwrap_or_default(), + veh_speed, + dt, + ) .with_context(|| format_dbg!())?, Self::None => { ensure!( - pwr_thrl_fc_to_cab == si::Power::ZERO, + pwr_thrml_fc_to_cab.is_none(), format_dbg!( "`FuelConverterThermal needs to be configured to provide heat demand`" ) ); - // TODO: make sure this triggers error if appropriate } } Ok(()) @@ -536,14 +541,14 @@ impl FuelConverterThermal { /// # Arguments /// - `fc_state`: [FuelConverter] state /// - `te_amb`: ambient temperature - /// - `pwr_thrl_fc_to_cab`: heat demand from HVAC system + /// - `pwr_thrml_fc_to_cab`: heat demand from [Vehicle::hvac] system /// - `veh_speed`: current achieved speed /// - `dt`: simulation time step size fn solve( &mut self, fc_state: &FuelConverterState, te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, + pwr_thrml_fc_to_cab: si::Power, veh_speed: si::Velocity, dt: si::Time, ) -> anyhow::Result<()> { @@ -605,7 +610,7 @@ impl FuelConverterThermal { let delta_temp: si::Temperature = (((self.htc_from_comb * (self.state.te_adiabatic - self.state.temperature)) .min(self.max_frac_from_comb * heat_gen) - - pwr_thrl_fc_to_cab + - pwr_thrml_fc_to_cab - self.state.heat_to_amb) * dt) / self.heat_capacitance; @@ -711,7 +716,7 @@ impl Default for FCTempEffModel { #[derive(Debug, Clone, Deserialize, Serialize, PartialEq)] pub struct FCTempEffModelLinear { pub offset: si::Ratio, - /// Change in efficiency factor per change in temperature [K] + /// Change in efficiency factor per change in temperature /[K/] pub slope_per_kelvin: f64, pub minimum: si::Ratio, } diff --git a/fastsim-core/src/vehicle/powertrain/prepare_eff_values.py b/fastsim-core/src/vehicle/powertrain/prepare_eff_values.py index a7cff7c4..22b4830e 100644 --- a/fastsim-core/src/vehicle/powertrain/prepare_eff_values.py +++ b/fastsim-core/src/vehicle/powertrain/prepare_eff_values.py @@ -1,12 +1,12 @@ """ -Python file demonstrating how to take altrios formatted efficiency arrays and +Python file demonstrating how to take ALTRIOS formatted efficiency arrays and turn them into arrays that can be accepted into FASTSim-3 Interpolator with x being power, y being SOC, and z being temperature. """ import numpy as np -# efficiency array as a function of power and SOC at constant 23 degrees C, +# efficiency array as a function of power and SOC at constant 23 °C, # corresponds to eta_interp_values[0] in Altrios arr_2d = np.array([ [ @@ -154,8 +154,8 @@ ], ]) -# transposing the altrios array so that the outermost layer is now power, and -# the innermost layer SOC (in altrios, the outermost layer is SOC and innermost +# transposing the ALTRIOS array so that the outermost layer is now power, and +# the innermost layer SOC (in ALTRIOS, the outermost layer is SOC and innermost # is power), as required in order to use this array in a FASTSim-3 interpolator, # with x being power. arr_2d_transposed can now be used in FASTSim-3. arr_2d_transposed = np.transpose(arr_2d, (1,0)) @@ -449,9 +449,9 @@ ], ] -# transposing the altrios array so that the outermost layer is now power, and -# the innermost layer temperature (in altrios, the outermost layer is +# transposing the ALTRIOS array so that the outermost layer is now power, and +# the innermost layer temperature (in ALTRIOS, the outermost layer is # temperature and innermost is power), as required in order to use this array in # a FASTSim-3 interpolator, with x being power. arr_2d_transposed can now be # used in FASTSim-3. -arr_3d_transposed = np.transpose(arr_3d, (2,1,0)) \ No newline at end of file +arr_3d_transposed = np.transpose(arr_3d, (2,1,0)) diff --git a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs index 613ac8b8..f746936d 100644 --- a/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs +++ b/fastsim-core/src/vehicle/powertrain/reversible_energy_storage.rs @@ -253,14 +253,15 @@ impl ReversibleEnergyStorage { /// # Arguments /// - `fc_state`: [ReversibleEnergyStorage] state /// - `te_amb`: ambient temperature - /// - `pwr_thrml_hvac_to_res`: thermal power flowing from HVAC system to [ReversibleEnergyStorage] - /// - `te_cab`: cabin temperature for heat transfer interaction with [ReversiblEnergyStorage] - /// - `dt`: time step size + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from [Vehicle::hvac] system to [Self::thrml] + /// - `te_cab`: cabin temperature for heat transfer interaction with + /// [Self], required if [Self::thrml] is `Some` + /// - `dt`: simulation time step size pub fn solve_thermal( &mut self, te_amb: si::Temperature, pwr_thrml_hvac_to_res: si::Power, - te_cab: si::Temperature, + te_cab: Option, dt: si::Time, ) -> anyhow::Result<()> { self.thrml @@ -270,7 +271,7 @@ impl ReversibleEnergyStorage { /// Sets and returns max output and max regen power based on current state /// # Arguments - /// - `dt`: time step size + /// - `dt`: simulation time step size /// - `disch_buffer`: buffer offset from static SOC limit at which discharging is not allowed /// - `chrg_buffer`: buffer offset from static SOC limit at which charging is not allowed pub fn set_curr_pwr_out_max( @@ -286,7 +287,7 @@ impl ReversibleEnergyStorage { } /// # Arguments - /// - `dt`: time step size + /// - `dt`: simulation time step size /// - `buffer`: buffer below static maximum SOC above which charging is disabled pub fn set_pwr_charge_max( &mut self, @@ -324,7 +325,7 @@ impl ReversibleEnergyStorage { } /// # Arguments - /// - `dt`: time step size + /// - `dt`: simulation time step size /// - `buffer`: buffer above static minimum SOC above which charging is disabled pub fn set_pwr_disch_max( &mut self, @@ -450,11 +451,11 @@ impl ReversibleEnergyStorage { /// Sets the ReversibleEnergyStorage eff_interp Interpolator to be a 1D /// interpolator with the default x and f_x arrays - /// Source of default efficiency values: - /// x: values in the third sub-array (corresponding to power) in Altrios' - /// eta_interp_grid - /// f_x: efficiency array as a function of power at constant 50% SOC and 23 - /// degrees C corresponds to eta_interp_values[0][5] in Altrios + /// # Source of default efficiency values + /// - `x`: values in the third sub-array (corresponding to power) in ALTRIOS's + /// eta_interp_grid + /// - `f_x`: efficiency array as a function of power at constant 50% SOC and 23 + /// °C corresponds to `eta_interp_values[0][5]` in ALTRIOS #[cfg(all(feature = "yaml", feature = "resources"))] pub fn set_default_1d_interp(&mut self) -> anyhow::Result<()> { self.eff_interp = ninterp::Interpolator::from_resource("res/default_1d.yaml", false)?; @@ -462,16 +463,16 @@ impl ReversibleEnergyStorage { } /// Sets the ReversibleEnergyStorage eff_interp Interpolator to be a 2D - /// interpolator with the default x, y and f_xy arrays - /// Source of default efficiency values: - /// x: values in the third sub-array (corresponding to power) in Altrios' - /// eta_interp_grid - /// y: values in the second sub-array (corresponding to SOC) in - /// Altrios' eta_interp_grid - /// f_xy: efficiency array as a function of power and SOC at constant 23 - /// degrees C corresponds to eta_interp_values[0] in Altrios, transposed so - /// that the outermost layer is now power, and the innermost layer SOC (in - /// altrios, the outermost layer is SOC and innermost is power) + /// interpolator with the default x, y, and f_xy arrays + /// # Source of default efficiency values + /// - `x`: values in the third sub-array (corresponding to power) in ALTRIOS's + /// eta_interp_grid + /// - `y`: values in the second sub-array (corresponding to SOC) in + /// ALTRIOS's eta_interp_grid + /// - `f_xy`: efficiency array as a function of power and SOC at constant 23 + /// °C corresponds to `eta_interp_values[0]` in ALTRIOS, transposed so + /// that the outermost layer is now power and the innermost layer SOC (in + /// ALTRIOS, the outermost layer is SOC and innermost is power) #[cfg(all(feature = "yaml", feature = "resources"))] pub fn set_default_2d_interp(&mut self) -> anyhow::Result<()> { self.eff_interp = ninterp::Interpolator::from_resource("res/default_2d.yaml", false)?; @@ -479,18 +480,18 @@ impl ReversibleEnergyStorage { } /// Sets the ReversibleEnergyStorage eff_interp Interpolator to be a 3D - /// interpolator with the default x, y, z and f_xyz arrays - /// Source of default efficiency values: - /// x: values in the third sub-array (corresponding to power) in Altrios' - /// eta_interp_grid - /// y: values in the second sub-array (corresponding to SOC) in Altrios' - /// eta_interp_grid - /// z: values in the first sub-array (corresponding to temperature) in - /// Altrios' eta_interp_grid - /// f_xyz: efficiency array as a function of power, SOC, and temperature - /// corresponds to eta_interp_values in Altrios, transposed so that the - /// outermost layer is now power, and the innermost layer temperature (in - /// altrios, the outermost layer is temperature and innermost is power) + /// interpolator with the default x, y, z, and f_xyz arrays + /// # Source of default efficiency values + /// - `x`: values in the third sub-array (corresponding to power) in ALTRIOS's + /// eta_interp_grid + /// - `y`: values in the second sub-array (corresponding to SOC) in ALTRIOS's + /// eta_interp_grid + /// - `z`: values in the first sub-array (corresponding to temperature) in + /// ALTRIOS's eta_interp_grid + /// - `f_xyz`: efficiency array as a function of power, SOC, and temperature + /// corresponds to eta_interp_values in ALTRIOS, transposed so that the + /// outermost layer is now power, and the innermost layer temperature (in + /// ALTRIOS, the outermost layer is temperature and innermost is power) #[cfg(all(feature = "yaml", feature = "resources"))] pub fn set_default_3d_interp(&mut self) -> anyhow::Result<()> { self.eff_interp = ninterp::Interpolator::from_resource("res/default_3d.yaml", false)?; @@ -723,19 +724,30 @@ impl RESThermalOption { /// # Arguments /// - `res_state`: [ReversibleEnergyStorage] state /// - `te_amb`: ambient temperature - /// - `pwr_thrml_hvac_to_res`: thermal power flowing from HVAC system to [ReversibleEnergyStorage] - /// - `dt`: time step size + /// - `pwr_thrml_hvac_to_res`: thermal power flowing from [Vehicle::hvac] + /// system to [Self], required if [Self::is_none] is false + /// - `dt`: simulation time step size fn solve( &mut self, res_state: ReversibleEnergyStorageState, te_amb: si::Temperature, pwr_thrml_hvac_to_res: si::Power, - te_cab: si::Temperature, + te_cab: Option, dt: si::Time, ) -> anyhow::Result<()> { match self { Self::RESLumpedThermal(rest) => rest - .solve(res_state, te_amb, pwr_thrml_hvac_to_res, te_cab, dt) + .solve( + res_state, + te_amb, + pwr_thrml_hvac_to_res, + te_cab.with_context(|| { + format_dbg!( + "`te_cab` must be `Some` for [RESThermalOption::RESLumpedThermal]" + ) + })?, + dt, + ) .with_context(|| format_dbg!())?, Self::None => { // TODO: make sure this triggers error if appropriate diff --git a/fastsim-core/src/vehicle/powertrain/traits.rs b/fastsim-core/src/vehicle/powertrain/traits.rs index 93a845a7..fda73dc5 100644 --- a/fastsim-core/src/vehicle/powertrain/traits.rs +++ b/fastsim-core/src/vehicle/powertrain/traits.rs @@ -9,7 +9,7 @@ pub trait Powertrain { /// required. /// # Arguments /// - `pwr_aux`: aux-related power required from this component - /// - `dt`: time step size + /// - `dt`: simulation time step size fn set_curr_pwr_prop_out_max( &mut self, pwr_aux: si::Power, @@ -26,7 +26,7 @@ pub trait Powertrain { /// - `pwr_out_req`: propulsion-related power output required /// - `veh_state`: state of vehicle /// - `enabled`: whether the component is active in current time step (e.g. engine idling v. shut off) - /// - `dt`: time step size + /// - `dt`: simulation time step size fn solve( &mut self, pwr_out_req: si::Power, @@ -35,14 +35,6 @@ pub trait Powertrain { dt: si::Time, ) -> anyhow::Result<()>; - fn solve_thermal( - &mut self, - te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, - veh_state: &mut VehicleState, - dt: si::Time, - ) -> anyhow::Result<()>; - /// Returns regen power after `Powertrain::solve` has been called fn pwr_regen(&self) -> si::Power; } diff --git a/fastsim-core/src/vehicle/powertrain/transmission.rs b/fastsim-core/src/vehicle/powertrain/transmission.rs index 876f4446..8a816944 100644 --- a/fastsim-core/src/vehicle/powertrain/transmission.rs +++ b/fastsim-core/src/vehicle/powertrain/transmission.rs @@ -94,7 +94,7 @@ pub struct TransmissionState { pub pwr_out: si::Power, pub pwr_in: si::Power, - /// Power loss: [`pwr_in`] - [`pwr_out`] + /// Power loss: [Self::pwr_in] - [Self::pwr_out] pub pwr_loss: si::Power, pub energy_out: si::Energy, diff --git a/fastsim-core/src/vehicle/powertrain_type.rs b/fastsim-core/src/vehicle/powertrain_type.rs index 3e1c39e6..403683db 100644 --- a/fastsim-core/src/vehicle/powertrain_type.rs +++ b/fastsim-core/src/vehicle/powertrain_type.rs @@ -47,26 +47,6 @@ impl Powertrain for PowertrainType { } } - fn solve_thermal( - &mut self, - te_amb: si::Temperature, - pwr_thrl_fc_to_cab: si::Power, - veh_state: &mut VehicleState, - dt: si::Time, - ) -> anyhow::Result<()> { - match self { - Self::ConventionalVehicle(v) => { - v.solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) - } - Self::HybridElectricVehicle(v) => { - v.solve_thermal(te_amb, pwr_thrl_fc_to_cab, veh_state, dt) - } - Self::BatteryElectricVehicle(v) => { - v.solve_thermal(te_amb, si::Power::ZERO, veh_state, dt) - } - } - } - fn get_curr_pwr_prop_out_max(&self) -> anyhow::Result<(si::Power, si::Power)> { match self { Self::ConventionalVehicle(v) => v.get_curr_pwr_prop_out_max(), @@ -102,6 +82,45 @@ impl SaveInterval for PowertrainType { } impl PowertrainType { + /// # Arguments: + /// - `te_amb`: ambient temperature + /// - `pwr_thrml_fc_to_cab`: thermal power flow from [FuelConverter::thrml] to [Vehicle::cabin], if both are equipped + /// - `veh_state`: current state of vehicle + /// - `pwr_thrml_hvac_to_res`: thermal power flow from [Vehicle::hvac] + /// system, if equipped, to [ReversibleEnergyStorage::thrml] -- zero if `None` is + /// passed + /// - `te_cab`: [Vehicle::cabin] temperature, if equipped + /// - `dt`: simulation time step size + pub fn solve_thermal( + &mut self, + te_amb: si::Temperature, + pwr_thrml_fc_to_cab: Option, + veh_state: &mut VehicleState, + pwr_thrml_hvac_to_res: Option, + te_cab: Option, + dt: si::Time, + ) -> anyhow::Result<()> { + match self { + Self::ConventionalVehicle(v) => { + v.solve_thermal(te_amb, pwr_thrml_fc_to_cab, veh_state, dt) + } + Self::HybridElectricVehicle(v) => v.solve_thermal( + te_amb, + pwr_thrml_fc_to_cab, + veh_state, + pwr_thrml_hvac_to_res, + te_cab, + dt, + ), + Self::BatteryElectricVehicle(v) => v.solve_thermal( + te_amb, + pwr_thrml_hvac_to_res.unwrap_or_default(), + te_cab, + dt, + ), + } + } + pub fn conv_mut(&mut self) -> Option<&mut ConventionalVehicle> { match self { Self::ConventionalVehicle(conv) => Some(conv), diff --git a/fastsim-core/src/vehicle/vehicle_model.rs b/fastsim-core/src/vehicle/vehicle_model.rs index 5c5c96fd..86e4c741 100644 --- a/fastsim-core/src/vehicle/vehicle_model.rs +++ b/fastsim-core/src/vehicle/vehicle_model.rs @@ -443,48 +443,53 @@ impl Vehicle { dt: si::Time, ) -> anyhow::Result<()> { let te_fc: Option = self.fc().and_then(|fc| fc.temperature()); - let veh_state = &mut self.state; - let pwr_thrml_fc_to_cabin = match (&mut self.cabin, &mut self.hvac) { + let res_temp = self.res().and_then(|res| res.temperature()); + let res_temp_prev = self.res().and_then(|res| res.temp_prev()); + let (pwr_thrml_fc_to_cabin, pwr_thrml_hvac_to_res, te_cab): ( + Option, + Option, + Option, + ) = match (&mut self.cabin, &mut self.hvac) { (CabinOption::None, HVACOption::None) => { - veh_state.pwr_aux = self.pwr_aux_base; - si::Power::ZERO + self.state.pwr_aux = self.pwr_aux_base; + (None, None, None) } (CabinOption::LumpedCabin(cab), HVACOption::LumpedCabin(hvac)) => { let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab) = hvac .solve(te_amb_air, te_fc, cab.state, cab.heat_capacitance, dt) .with_context(|| format_dbg!())?; - cab.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) + let te_cab = cab + .solve(te_amb_air, &self.state, pwr_thrml_hvac_to_cabin, dt) .with_context(|| format_dbg!())?; - veh_state.pwr_aux = self.pwr_aux_base + hvac.state.pwr_aux_for_hvac; - pwr_thrml_fc_to_cab + self.state.pwr_aux = self.pwr_aux_base + hvac.state.pwr_aux_for_hvac; + (Some(pwr_thrml_fc_to_cab), None, Some(te_cab)) } (CabinOption::LumpedCabin(cab), HVACOption::LumpedCabinAndRES(hvac)) => { - let res = self.res_mut().with_context(|| format_dbg!("`HVACOption::LumpedCabinAndRES(...)` requires powertrain with `ReversibleEnergyStorage`"))?; let (pwr_thrml_hvac_to_cabin, pwr_thrml_fc_to_cab, pwr_thrml_hvac_to_res) = hvac .solve( te_amb_air, te_fc, cab.state, cab.heat_capacitance, - res.temperature().with_context(|| { - format_dbg!( - "`ReversibleEnergyStorage` must be configured with thermal model." - ) - })?, - res.temp_prev().with_context(|| { - format_dbg!( - "`ReversibleEnergyStorage` must be configured with thermal model." - ) - })?, + ( + res_temp + .with_context( + || "{}\n[HVACOption::LumpedCabinAndRES] requires [ReversibleEnergyStorage::thrml] to be `Some`" + )?, + res_temp_prev.unwrap() + ), dt, ) .with_context(|| format_dbg!())?; - cab.solve(te_amb_air, veh_state, pwr_thrml_hvac_to_cabin, dt) + let te_cab = cab + .solve(te_amb_air, &self.state, pwr_thrml_hvac_to_cabin, dt) .with_context(|| format_dbg!())?; - res.solve_thermal(te_amb_air, pwr_thrml_hvac_to_res, cab.state.temperature, dt) - .with_context(|| format_dbg!())?; - veh_state.pwr_aux = self.pwr_aux_base + hvac.state.pwr_aux_for_hvac; - pwr_thrml_fc_to_cab + self.state.pwr_aux = self.pwr_aux_base + hvac.state.pwr_aux_for_hvac; + ( + Some(pwr_thrml_fc_to_cab), + Some(pwr_thrml_hvac_to_res), + Some(te_cab), + ) } (CabinOption::LumpedCabinWithShell, HVACOption::LumpedCabinWithShell) => { bail!("{}\nNot yet implemented.", format_dbg!()) @@ -510,7 +515,14 @@ impl Vehicle { }; self.pt_type - .solve_thermal(te_amb_air, pwr_thrml_fc_to_cabin, veh_state, dt) + .solve_thermal( + te_amb_air, + pwr_thrml_fc_to_cabin, + &mut self.state, + pwr_thrml_hvac_to_res, + te_cab, + dt, + ) .with_context(|| format_dbg!())?; Ok(()) } @@ -534,7 +546,7 @@ pub struct VehicleState { pub pwr_tractive: si::Power, /// Tractive power required for prescribed speed pub pwr_tractive_for_cyc: si::Power, - /// integral of [Self::pwr_out] + /// integral of [Self::pwr_tractive] pub energy_tractive: si::Energy, /// time varying aux load pub pwr_aux: si::Power, diff --git a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs index 4c20ceb8..dbc34421 100644 --- a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs +++ b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs @@ -173,7 +173,7 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { }, em: ElectricMachine { state: Default::default(), - eff_interp_fwd: (Interpolator::Interp1D( + eff_interp_achieved: (Interpolator::Interp1D( Interp1D::new( f2veh.mc_perc_out_array.to_vec(), { @@ -223,7 +223,7 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { }, em: ElectricMachine { state: Default::default(), - eff_interp_fwd: (Interpolator::Interp1D(Interp1D::new( + eff_interp_achieved: (Interpolator::Interp1D(Interp1D::new( f2veh.mc_pwr_out_perc.to_vec(), f2veh.mc_eff_array.to_vec(), Strategy::LeftNearest, @@ -464,7 +464,7 @@ impl Vehicle { mc_eff_array: Default::default(), // calculated in `set_derived` mc_eff_map: self .em() - .map(|em| em.eff_interp_fwd.f_x()) + .map(|em| em.eff_interp_achieved.f_x()) .transpose()? .map(|f_x| f_x.to_vec()) .unwrap_or_else(|| vec![0., 1.]) @@ -492,7 +492,7 @@ impl Vehicle { // short array that can use xEV when implented. TODO: fix this when implementing xEV mc_pwr_out_perc: self .em() - .map(|em| em.eff_interp_fwd.x()) + .map(|em| em.eff_interp_achieved.x()) .transpose()? .map(|x| x.to_vec()) .unwrap_or_else(|| vec![0., 1.]) diff --git a/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt b/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt index 5434c271..420506fe 100644 --- a/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt +++ b/python/fastsim/resources/demos/demo_variable_paths/variable_path_list_expected.txt @@ -70,7 +70,6 @@ ['veh']['chassis']['wheel_base_meters'] ['veh']['mass_kilograms'] ['veh']['pwr_aux_base_watts'] -['veh']['pwr_aux_max_watts'] ['veh']['trans_eff'] ['veh']['save_interval'] ['veh']['state']['i'] From b1520ec792e14064349561fad64400f70c0f855c Mon Sep 17 00:00:00 2001 From: Chad Baker Date: Mon, 23 Dec 2024 15:06:37 -0700 Subject: [PATCH 12/12] HEV engine now has temperature-sensitive on/off controls all thermal models are hypothetically correctly implemented! --- fastsim-core/src/vehicle/hev.rs | 53 ++++++++++++++++--- .../src/vehicle/powertrain/fuel_converter.rs | 13 +++++ .../vehicle_model/fastsim2_interface.rs | 2 + 3 files changed, 60 insertions(+), 8 deletions(-) diff --git a/fastsim-core/src/vehicle/hev.rs b/fastsim-core/src/vehicle/hev.rs index 8c5a63a9..75cfb786 100644 --- a/fastsim-core/src/vehicle/hev.rs +++ b/fastsim-core/src/vehicle/hev.rs @@ -509,15 +509,46 @@ impl HEVPowertrainControls { em_state.pwr_mech_fwd_out_max.get::(), fc_state.pwr_prop_max.get::() ); + // positive net power out of the powertrain let (fc_pwr, em_pwr) = match self { - HEVPowertrainControls::RGWDB(ref mut rgwb) => { + HEVPowertrainControls::RGWDB(ref mut rgwdb) => { + match ( + fc.temperature(), + fc.temp_prev(), + rgwdb.temp_fc_forced_on, + rgwdb.temp_fc_allowed_off, + ) { + (None, None, None, None) => {} + ( + Some(temperature), + Some(temp_prev), + Some(temp_fc_forced_on), + Some(temp_fc_allowed_off), + ) => { + if + // temperature is currently below forced on threshold + temperature < temp_fc_forced_on || + // temperature was below forced on threshold and still has not exceeded allowed off threshold + (temp_prev < temp_fc_forced_on && temperature < temp_fc_allowed_off) + { + hev_state.fc_on_causes.push(FCOnCause::FCTemperatureTooLow); + } + } + _ => { + bail!( + "{}\n`fc.temperature()`, `fc.temp_prev()`, `rgwdb.temp_fc_forced_on`, and +`rgwdb.temp_fc_allowed_off` must all be `None` or `Some`", + format_dbg!() + ); + } + } // cannot exceed ElectricMachine max output power. Excess demand will be handled by `fc` let em_pwr = pwr_out_req.min(em_state.pwr_mech_fwd_out_max); - let frac_pwr_demand_fc_forced_on: si::Ratio = rgwb + let frac_pwr_demand_fc_forced_on: si::Ratio = rgwdb .frac_pwr_demand_fc_forced_on .with_context(|| format_dbg!())?; - let frac_of_most_eff_pwr_to_run_fc: si::Ratio = rgwb + let frac_of_most_eff_pwr_to_run_fc: si::Ratio = rgwdb .frac_of_most_eff_pwr_to_run_fc .with_context(|| format_dbg!())?; // If the motor cannot produce more than the required power times a @@ -532,27 +563,27 @@ impl HEVPowertrainControls { } if veh_state.speed_ach - > rgwb.speed_fc_forced_on.with_context(|| format_dbg!())? + > rgwdb.speed_fc_forced_on.with_context(|| format_dbg!())? { hev_state.fc_on_causes.push(FCOnCause::VehicleSpeedTooHigh); } - rgwb.state.soc_fc_on_buffer = { + rgwdb.state.soc_fc_on_buffer = { let energy_delta_to_buffer_speed = 0.5 * veh_state.mass - * (rgwb + * (rgwdb .speed_soc_fc_on_buffer .with_context(|| format_dbg!())? .powi(typenum::P2::new()) - veh_state.speed_ach.powi(typenum::P2::new())); energy_delta_to_buffer_speed.max(si::Energy::ZERO) - * rgwb + * rgwdb .speed_soc_fc_on_buffer_coeff .with_context(|| format_dbg!())? } / res.energy_capacity_usable() + res.min_soc; - if res.state.soc < rgwb.state.soc_fc_on_buffer { + if res.state.soc < rgwdb.state.soc_fc_on_buffer { hev_state.fc_on_causes.push(FCOnCause::ChargingForLowSOC) } if pwr_out_req - em_state.pwr_mech_fwd_out_max >= si::Power::ZERO { @@ -639,6 +670,12 @@ pub struct RESGreedyWithDynamicBuffers { /// Fraction of available discharging capacity to use toward running the /// engine efficiently. pub frac_res_dschrg_for_fc: si::Ratio, + /// temperature at which engine is forced on to warm up + #[serde(default, skip_serializing_if = "Option::is_none")] + pub temp_fc_forced_on: Option, + /// temperature at which engine is allowed to turn off due to being sufficiently warm + #[serde(default, skip_serializing_if = "Option::is_none")] + pub temp_fc_allowed_off: Option, /// current state of control variables #[serde(default, skip_serializing_if = "EqDefault::eq_default")] pub state: RGWDBState, diff --git a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs index ef875670..e59bf299 100755 --- a/fastsim-core/src/vehicle/powertrain/fuel_converter.rs +++ b/fastsim-core/src/vehicle/powertrain/fuel_converter.rs @@ -348,6 +348,15 @@ impl FuelConverter { FuelConverterThermalOption::None => None, } } + + /// If thermal model is appropriately configured, returns previous time step + /// lumped [Self] temperature + pub fn temp_prev(&self) -> Option { + match &self.thrml { + FuelConverterThermalOption::FuelConverterThermal(fct) => Some(fct.state.temp_prev), + FuelConverterThermalOption::None => None, + } + } } // impl FuelConverter { @@ -614,6 +623,7 @@ impl FuelConverterThermal { - self.state.heat_to_amb) * dt) / self.heat_capacitance; + self.state.temp_prev = self.state.temperature; self.state.temperature += delta_temp; self.state.eff_coeff = match self.fc_eff_model { @@ -675,6 +685,8 @@ pub struct FuelConverterThermalState { pub te_adiabatic: si::Temperature, /// Current engine thermal mass temperature (lumped engine block and coolant) pub temperature: si::Temperature, + /// Engine thermal mass temperature (lumped engine block and coolant) at previous time step + pub temp_prev: si::Temperature, /// Current heat transfer coefficient from [FuelConverter] to ambient pub htc_to_amb: si::HeatTransferCoeff, /// Current heat transfer to ambient @@ -691,6 +703,7 @@ impl Default for FuelConverterThermalState { i: Default::default(), te_adiabatic: *TE_ADIABATIC_STD, temperature: *TE_STD_AIR, + temp_prev: *TE_STD_AIR, htc_to_amb: Default::default(), heat_to_amb: Default::default(), eff_coeff: uc::R, diff --git a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs index dbc34421..d8fa82fc 100644 --- a/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs +++ b/fastsim-core/src/vehicle/vehicle_model/fastsim2_interface.rs @@ -115,6 +115,8 @@ impl TryFrom<&fastsim_2::vehicle::RustVehicle> for PowertrainType { // TODO: make sure these actually do something, if deemed worthwhile frac_res_chrg_for_fc: f2veh.ess_chg_to_fc_max_eff_perc * uc::R, frac_res_dschrg_for_fc: f2veh.ess_dischg_to_fc_max_eff_perc * uc::R, + temp_fc_forced_on: None, + temp_fc_allowed_off: None, state: Default::default(), history: Default::default(), }));