From 4a6a389f59cf9272515cdb3590bd7be35d183202 Mon Sep 17 00:00:00 2001
From: Thomas Fetzer <thomas.fetzer@iws.uni-stuttgart.de>
Date: Mon, 2 Jul 2018 16:37:48 +0200
Subject: [PATCH] [rans][oneeq] Add first compiling version of the one-equation
 Spalart-Allmaras model

---
 doc/doxygen/modules.txt                       |    6 +
 dumux/freeflow/rans/CMakeLists.txt            |    1 +
 dumux/freeflow/rans/oneeq/CMakeLists.txt      |   11 +
 dumux/freeflow/rans/oneeq/fluxvariables.hh    |   50 +
 dumux/freeflow/rans/oneeq/indices.hh          |   50 +
 dumux/freeflow/rans/oneeq/localresidual.hh    |   51 +
 dumux/freeflow/rans/oneeq/model.hh            |  176 +++
 dumux/freeflow/rans/oneeq/problem.hh          |  172 +++
 .../rans/oneeq/staggered/CMakeLists.txt       |    4 +
 .../rans/oneeq/staggered/fluxvariables.hh     |  150 +++
 .../rans/oneeq/staggered/localresidual.hh     |  121 ++
 dumux/freeflow/rans/oneeq/volumevariables.hh  |  323 ++++++
 dumux/freeflow/rans/oneeq/vtkoutputfields.hh  |   60 +
 dumux/freeflow/rans/problem.hh                |   20 +
 dumux/freeflow/rans/volumevariables.hh        |    8 +
 test/freeflow/rans/CMakeLists.txt             |   23 +-
 test/freeflow/rans/pdelab-oneeq.csv           | 1002 +++++++++++++++++
 test/freeflow/rans/pipelauferproblem.hh       |   31 +-
 test/freeflow/rans/test_pipe_laufer.cc        |    6 +
 19 files changed, 2249 insertions(+), 16 deletions(-)
 create mode 100644 dumux/freeflow/rans/oneeq/CMakeLists.txt
 create mode 100644 dumux/freeflow/rans/oneeq/fluxvariables.hh
 create mode 100644 dumux/freeflow/rans/oneeq/indices.hh
 create mode 100644 dumux/freeflow/rans/oneeq/localresidual.hh
 create mode 100644 dumux/freeflow/rans/oneeq/model.hh
 create mode 100644 dumux/freeflow/rans/oneeq/problem.hh
 create mode 100644 dumux/freeflow/rans/oneeq/staggered/CMakeLists.txt
 create mode 100644 dumux/freeflow/rans/oneeq/staggered/fluxvariables.hh
 create mode 100644 dumux/freeflow/rans/oneeq/staggered/localresidual.hh
 create mode 100644 dumux/freeflow/rans/oneeq/volumevariables.hh
 create mode 100644 dumux/freeflow/rans/oneeq/vtkoutputfields.hh
 create mode 100644 test/freeflow/rans/pdelab-oneeq.csv

diff --git a/doc/doxygen/modules.txt b/doc/doxygen/modules.txt
index a679188f94..9f341715ef 100644
--- a/doc/doxygen/modules.txt
+++ b/doc/doxygen/modules.txt
@@ -190,6 +190,12 @@
        * \brief Zero-equation or algebraic turbulence models
        * \copydetails ./freeflow/rans/zeroeq/model.hh
        */
+      /*!
+       * \ingroup RANSModel
+       * \defgroup OneEqModel 1-Eq. Models
+       * \brief One-equation turbulence model by Spalart-Allmaras
+       * \copydetails ./freeflow/oneeq/model.hh
+       */
       /*!
        * \ingroup RANSModel
        * \defgroup TwoEqModel 2-Eq. Models
diff --git a/dumux/freeflow/rans/CMakeLists.txt b/dumux/freeflow/rans/CMakeLists.txt
index 86696f58ef..100f4e5776 100644
--- a/dumux/freeflow/rans/CMakeLists.txt
+++ b/dumux/freeflow/rans/CMakeLists.txt
@@ -1,3 +1,4 @@
+add_subdirectory(oneeq)
 add_subdirectory(twoeq)
 add_subdirectory(zeroeq)
 
diff --git a/dumux/freeflow/rans/oneeq/CMakeLists.txt b/dumux/freeflow/rans/oneeq/CMakeLists.txt
new file mode 100644
index 0000000000..46d8713f6a
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/CMakeLists.txt
@@ -0,0 +1,11 @@
+add_subdirectory(staggered)
+
+install(FILES
+fluxvariables.hh
+indices.hh
+localresidual.hh
+model.hh
+problem.hh
+volumevariables.hh
+vtkoutputfields.hh
+DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/rans/oneeq)
diff --git a/dumux/freeflow/rans/oneeq/fluxvariables.hh b/dumux/freeflow/rans/oneeq/fluxvariables.hh
new file mode 100644
index 0000000000..2a4c61232d
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/fluxvariables.hh
@@ -0,0 +1,50 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+ /*!
+  * \file
+  * \ingroup OneEqModel
+  * \copydoc Dumux::OneEqFluxVariables
+  */
+#ifndef DUMUX_ONEEQFLUXVARIABLES_HH
+#define DUMUX_ONEEQFLUXVARIABLES_HH
+
+#include <dumux/common/properties.hh>
+#include <dumux/freeflow/navierstokes/fluxvariables.hh>
+#include <dumux/freeflow/rans/oneeq/staggered/fluxvariables.hh>
+
+namespace Dumux
+{
+
+// forward declaration
+template<class TypeTag, class BaseFluxVariables, DiscretizationMethod discMethod>
+class OneEqFluxVariablesImpl;
+
+/*!
+ * \ingroup OneEqModel
+ * \brief The flux variables class for the one-equation turbulence model by Spalart-Allmaras.
+          This is a convenience alias for that actual,
+          discretization-specific flux variables.
+ * \note  Not all specializations are currently implemented
+ */
+template<class TypeTag, class BaseFluxVariables>
+using OneEqFluxVariables = OneEqFluxVariablesImpl<TypeTag, BaseFluxVariables, GET_PROP_TYPE(TypeTag, FVGridGeometry)::discMethod>;
+
+} // end namespace
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/indices.hh b/dumux/freeflow/rans/oneeq/indices.hh
new file mode 100644
index 0000000000..4ad0551ab0
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/indices.hh
@@ -0,0 +1,50 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ * \ingroup OneEqModel
+ * \copydoc Dumux::OneEqIndices
+ */
+#ifndef DUMUX_ONEEQ_INDICES_HH
+#define DUMUX_ONEEQ_INDICES_HH
+
+#include <dumux/freeflow/navierstokes/indices.hh>
+
+namespace Dumux {
+
+// \{
+/*!
+ * \ingroup OneEqModel
+ * \brief The common indices for the isothermal one-equation turbulence model by Spalart-Allmaras
+ *
+ * \tparam dimension The dimension of the problem
+ * \tparam numComponents The number of considered transported components
+ */
+template<int dimension, int numComponents>
+struct OneEqIndices : public NavierStokesIndices<dimension>
+{
+public:
+    static constexpr auto viscosityTildeEqIdx = dimension + numComponents;
+    static constexpr auto viscosityTildeIdx = viscosityTildeEqIdx;
+};
+
+// \}
+} // end namespace
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/localresidual.hh b/dumux/freeflow/rans/oneeq/localresidual.hh
new file mode 100644
index 0000000000..5ae1823a0e
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/localresidual.hh
@@ -0,0 +1,51 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+ /*!
+  * \file
+  * \ingroup OneEqModel
+  * \copydoc Dumux::OneEqResidual
+  */
+#ifndef DUMUX_ONEEQ_LOCAL_RESIDUAL_HH
+#define DUMUX_ONEEQ_LOCAL_RESIDUAL_HH
+
+#include <dumux/common/properties.hh>
+#include <dumux/discretization/methods.hh>
+#include <dumux/freeflow/navierstokes/localresidual.hh>
+#include <dumux/freeflow/rans/oneeq/staggered/localresidual.hh>
+
+namespace Dumux
+{
+
+// forward declaration
+template<class TypeTag, class BaseLocalResidual, DiscretizationMethod discMethod>
+class OneEqResidualImpl;
+
+/*!
+ * \ingroup OneEqModel
+ * \brief The local residual class for the one-equation turbulence model by Spalart-Allmaras
+          This is a convenience alias for the actual,
+          discretization-specific local residual.
+ * \note  Not all specializations are currently implemented
+ */
+template<class TypeTag, class BaseLocalResidual>
+using OneEqResidual = OneEqResidualImpl<TypeTag, BaseLocalResidual, GET_PROP_TYPE(TypeTag, FVGridGeometry)::discMethod>;
+
+}
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/model.hh b/dumux/freeflow/rans/oneeq/model.hh
new file mode 100644
index 0000000000..c7ed7084c9
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/model.hh
@@ -0,0 +1,176 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ * \ingroup OneEqModel
+ *
+ * \brief A single-phase, isothermal one-equation turbulence model by Spalart-Allmaras
+ *
+ * \copydoc RANSModel
+ *
+ * \todo please doc me
+ */
+
+#ifndef DUMUX_ONEEQ_MODEL_HH
+#define DUMUX_ONEEQ_MODEL_HH
+
+#include <dumux/common/properties.hh>
+#include <dumux/freeflow/properties.hh>
+#include <dumux/freeflow/rans/model.hh>
+
+#include "fluxvariables.hh"
+#include "indices.hh"
+#include "localresidual.hh"
+#include "volumevariables.hh"
+#include "vtkoutputfields.hh"
+
+namespace Dumux
+{
+namespace Properties {
+
+/*!
+ * \ingroup OneEqModel
+ * \brief Traits for the Spalart-Allmaras model
+ */
+template<int dimension>
+struct OneEqModelTraits : RANSModelTraits<dimension>
+{
+    //! The dimension of the model
+    static constexpr int dim() { return dimension; }
+
+    //! There are as many momentum balance equations as dimensions,
+    //! one mass balance equation and two turbulent transport equations
+    static constexpr int numEq() { return dim()+1+1; }
+
+    //! The number of components
+    static constexpr int numComponents() { return 1; }
+
+    //! the indices
+    using Indices = OneEqIndices<dim(), numComponents()>;
+};
+
+///////////////////////////////////////////////////////////////////////////
+// default property values for the isothermal Spalart-Allmaras model
+///////////////////////////////////////////////////////////////////////////
+
+//! The type tag for the single-phase, isothermal Spalart-Allmaras model
+NEW_TYPE_TAG(OneEq, INHERITS_FROM(RANS));
+
+//!< states some specifics of the isothermal Spalart-Allmaras model
+SET_PROP(OneEq, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+public:
+    using type = OneEqModelTraits<dim>;
+};
+
+//! The flux variables
+SET_PROP(OneEq, FluxVariables)
+{
+private:
+    using BaseFluxVariables = NavierStokesFluxVariables<TypeTag>;
+public:
+    using type = OneEqFluxVariables<TypeTag, BaseFluxVariables>;
+};
+
+//! The local residual
+SET_PROP(OneEq, LocalResidual)
+{
+private:
+    using BaseLocalResidual = NavierStokesResidual<TypeTag>;
+public:
+    using type = OneEqResidual<TypeTag, BaseLocalResidual>;
+};
+
+//! Set the volume variables property
+SET_PROP(OneEq, VolumeVariables)
+{
+private:
+    using PV = typename GET_PROP_TYPE(TypeTag, PrimaryVariables);
+    using FSY = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    using FST = typename GET_PROP_TYPE(TypeTag, FluidState);
+    using MT = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+
+    using Traits = NavierStokesVolumeVariablesTraits<PV, FSY, FST, MT>;
+    using NSVolVars = NavierStokesVolumeVariables<Traits>;
+public:
+    using type = OneEqVolumeVariables<Traits, NSVolVars>;
+};
+
+//! The specific vtk output fields
+SET_PROP(OneEq, VtkOutputFields)
+{
+private:
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+public:
+    using type = OneEqVtkOutputFields<FVGridGeometry>;
+};
+
+//////////////////////////////////////////////////////////////////
+// default property values for the non-isothermal Spalart-Allmaras model
+//////////////////////////////////////////////////////////////////
+
+//! The type tag for the single-phase, isothermal Spalart-Allmaras model
+NEW_TYPE_TAG(OneEqNI, INHERITS_FROM(RANSNI));
+
+//! The model traits of the non-isothermal model
+SET_PROP(OneEqNI, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+    using IsothermalTraits = OneEqModelTraits<dim>;
+public:
+    using type = FreeflowNIModelTraits<IsothermalTraits>;
+};
+
+//! Set the volume variables property
+SET_PROP(OneEqNI, VolumeVariables)
+{
+private:
+    using PV = typename GET_PROP_TYPE(TypeTag, PrimaryVariables);
+    using FSY = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    using FST = typename GET_PROP_TYPE(TypeTag, FluidState);
+    using MT = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+
+    using Traits = NavierStokesVolumeVariablesTraits<PV, FSY, FST, MT>;
+    using NSVolVars = NavierStokesVolumeVariables<Traits>;
+public:
+    using type = OneEqVolumeVariables<Traits, NSVolVars>;
+};
+
+//! The specific non-isothermal vtk output fields
+SET_PROP(OneEqNI, VtkOutputFields)
+{
+private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using IsothermalFields = OneEqVtkOutputFields<FVGridGeometry>;
+public:
+    using type = FreeflowNonIsothermalVtkOutputFields<IsothermalFields, ModelTraits>;
+};
+
+// \}
+}
+
+} // end namespace
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/problem.hh b/dumux/freeflow/rans/oneeq/problem.hh
new file mode 100644
index 0000000000..d5a7df3d4b
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/problem.hh
@@ -0,0 +1,172 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ * \ingroup OneEqModel
+ * \copydoc Dumux::OneEqProblem
+ */
+#ifndef DUMUX_ONEEQ_PROBLEM_HH
+#define DUMUX_ONEEQ_PROBLEM_HH
+
+#include <dumux/common/properties.hh>
+#include <dumux/common/staggeredfvproblem.hh>
+#include <dumux/discretization/localview.hh>
+#include <dumux/discretization/staggered/elementsolution.hh>
+#include <dumux/discretization/methods.hh>
+#include <dumux/freeflow/rans/problem.hh>
+
+#include "model.hh"
+
+namespace Dumux
+{
+
+/*!
+ * \ingroup OneEqModel
+ * \brief One-equation turbulence problem base class.
+ *
+ * This implements some base functionality for one-equation Spalart-Allmaras model.
+ */
+template<class TypeTag>
+class OneEqProblem : public RANSProblem<TypeTag>
+{
+    using ParentType = RANSProblem<TypeTag>;
+    using Implementation = typename GET_PROP_TYPE(TypeTag, Problem);
+    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
+    using Grid = typename GridView::Grid;
+
+    using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
+    using DimVector = Dune::FieldVector<Scalar, Grid::dimension>;
+
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::LocalView;
+    using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace;
+
+    using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables);
+    using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector);
+    using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables);
+    using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables);
+    using Indices = typename GET_PROP_TYPE(TypeTag, ModelTraits)::Indices;
+
+public:
+    //! The constructor sets the gravity, if desired by the user.
+    OneEqProblem(std::shared_ptr<const FVGridGeometry> fvGridGeometry)
+    : ParentType(fvGridGeometry)
+    {
+        useStoredEddyViscosity_ = getParamFromGroup<bool>(this->paramGroup(),
+                                                          "RANS.UseStoredEddyViscosity", false);
+    }
+
+    /*!
+     * \brief Correct size of the static (solution independent) wall variables
+     */
+    void updateStaticWallProperties()
+    {
+        ParentType::updateStaticWallProperties();
+
+        // update size and initial values of the global vectors
+        storedDynamicEddyViscosity_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+        storedViscosityTilde_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+        storedViscosityTildeGradient_.resize(this->fvGridGeometry().elementMapper().size(), DimVector(0.0));
+    }
+
+    /*!
+     * \brief Update the dynamic (solution dependent) relations to the walls
+     *
+     * \param curSol The solution vector.
+     */
+    void updateDynamicWallProperties(const SolutionVector& curSol)
+    {
+        ParentType::updateDynamicWallProperties(curSol);
+
+        for (const auto& element : elements(this->fvGridGeometry().gridView()))
+        {
+            unsigned int elementID = this->fvGridGeometry().elementMapper().index(element);
+
+            auto fvGeometry = localView(this->fvGridGeometry());
+            fvGeometry.bindElement(element);
+            for (auto&& scv : scvs(fvGeometry))
+            {
+                const int dofIdx = scv.dofIndex();
+                const auto& cellCenterPriVars = curSol[FVGridGeometry::cellCenterIdx()][dofIdx];
+                PrimaryVariables priVars = makePriVarsFromCellCenterPriVars<PrimaryVariables>(cellCenterPriVars);
+                auto elemSol = elementSolution<typename FVGridGeometry::LocalView>(std::move(priVars));
+                // NOTE: first update the turbulence quantities
+                storedViscosityTilde_[elementID] = elemSol[0][Indices::viscosityTildeIdx];
+                // NOTE: then update the volVars
+                VolumeVariables volVars;
+                volVars.update(elemSol, asImp_(), element, scv);
+                storedDynamicEddyViscosity_[elementID] = volVars.calculateEddyViscosity();
+            }
+        }
+
+        // calculate cell-center-averaged velocity gradients, maximum, and minimum values
+        for (const auto& element : elements(this->fvGridGeometry().gridView()))
+        {
+            unsigned int elementID = this->fvGridGeometry().elementMapper().index(element);
+
+            for (unsigned int dimIdx = 0; dimIdx < Grid::dimension; ++dimIdx)
+            {
+                storedViscosityTildeGradient_[elementID][dimIdx]
+                    = (storedViscosityTilde_[ParentType::neighborID_[elementID][dimIdx][1]]
+                          - storedViscosityTilde_[ParentType::neighborID_[elementID][dimIdx][0]])
+                      / (ParentType::cellCenter_[ParentType::neighborID_[elementID][dimIdx][1]][dimIdx]
+                          - ParentType::cellCenter_[ParentType::neighborID_[elementID][dimIdx][0]][dimIdx]);
+            }
+
+            auto fvGeometry = localView(this->fvGridGeometry());
+            fvGeometry.bindElement(element);
+            for (auto&& scvf : scvfs(fvGeometry))
+            {
+                unsigned int normDim = scvf.directionIndex();
+                if (scvf.boundary() && asImp_().boundaryTypes(element, scvf).isDirichlet(Indices::viscosityTildeIdx))
+                {
+                    // face Value
+                    Scalar dirichletViscosityTilde = asImp_().dirichlet(element, scvf)[Indices::viscosityTildeIdx];
+
+                    unsigned int neighborID = ParentType::neighborID_[elementID][normDim][0];
+                    if (scvf.center()[normDim] < ParentType::cellCenter_[elementID][normDim])
+                        neighborID = ParentType::neighborID_[elementID][normDim][1];
+
+                    storedViscosityTildeGradient_[elementID][normDim]
+                        = (storedViscosityTilde_[neighborID] - dirichletViscosityTilde)
+                          / (ParentType::cellCenter_[neighborID][normDim] - scvf.center()[normDim]);
+                }
+            }
+        }
+    }
+
+public:
+    std::vector<Scalar> storedDynamicEddyViscosity_;
+    std::vector<Scalar> storedViscosityTilde_;
+    std::vector<DimVector> storedViscosityTildeGradient_;
+    bool useStoredEddyViscosity_;
+
+private:
+    //! Returns the implementation of the problem (i.e. static polymorphism)
+    Implementation &asImp_()
+    { return *static_cast<Implementation *>(this); }
+
+    //! \copydoc asImp_()
+    const Implementation &asImp_() const
+    { return *static_cast<const Implementation *>(this); }
+};
+
+}
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/staggered/CMakeLists.txt b/dumux/freeflow/rans/oneeq/staggered/CMakeLists.txt
new file mode 100644
index 0000000000..a5103121ca
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/staggered/CMakeLists.txt
@@ -0,0 +1,4 @@
+install(FILES
+fluxvariables.hh
+localresidual.hh
+DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/rans/oneeq/staggered)
diff --git a/dumux/freeflow/rans/oneeq/staggered/fluxvariables.hh b/dumux/freeflow/rans/oneeq/staggered/fluxvariables.hh
new file mode 100644
index 0000000000..da78ca5f5a
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/staggered/fluxvariables.hh
@@ -0,0 +1,150 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+ /*!
+  * \file
+  * \ingroup OneEqModel
+  * \copydoc Dumux::OneEqFluxVariablesImpl
+  */
+#ifndef DUMUX_ONEEQ_STAGGERED_FLUXVARIABLES_HH
+#define DUMUX_ONEEQ_STAGGERED_FLUXVARIABLES_HH
+
+#include <numeric>
+#include <dumux/common/properties.hh>
+#include <dumux/discretization/fluxvariablesbase.hh>
+#include <dumux/discretization/methods.hh>
+#include <dumux/freeflow/navierstokes/fluxvariables.hh>
+#include <dumux/freeflow/rans/oneeq/fluxvariables.hh>
+
+namespace Dumux
+{
+
+// forward declaration
+template<class TypeTag, class BaseFluxVariables, DiscretizationMethod discMethod>
+class OneEqFluxVariablesImpl;
+
+/*!
+ * \ingroup OneEqModel
+ * \brief The flux variables class for the one-equation model by Spalart-Allmaras
+ *        using the staggered grid discretization.
+ */
+template<class TypeTag, class BaseFluxVariables>
+class OneEqFluxVariablesImpl<TypeTag, BaseFluxVariables, DiscretizationMethod::staggered>
+: public BaseFluxVariables
+{
+    using ParentType = BaseFluxVariables;
+
+    using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables);
+
+    using GridVolumeVariables = typename GridVariables::GridVolumeVariables;
+    using ElementVolumeVariables = typename GridVolumeVariables::LocalView;
+    using VolumeVariables = typename GridVolumeVariables::VolumeVariables;
+
+    using GridFluxVariablesCache = typename GridVariables::GridFluxVariablesCache;
+    using FluxVariablesCache = typename GridFluxVariablesCache::FluxVariablesCache;
+
+    using GridFaceVariables = typename GridVariables::GridFaceVariables;
+    using ElementFaceVariables = typename GridFaceVariables::LocalView;
+    using FaceVariables = typename GridFaceVariables::FaceVariables;
+
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+    using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
+    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
+    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
+    using Element = typename GridView::template Codim<0>::Entity;
+    using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::LocalView;
+    using Indices = typename GET_PROP_TYPE(TypeTag, ModelTraits)::Indices;
+    using SubControlVolumeFace = typename FVElementGeometry::SubControlVolumeFace;
+    using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables);
+
+    static constexpr int viscosityTildeEqIdx = Indices::viscosityTildeEqIdx - ModelTraits::dim();
+
+public:
+
+    /*!
+    * \brief Computes the flux for the cell center residual.
+    */
+    CellCenterPrimaryVariables computeMassFlux(const Problem& problem,
+                                               const Element &element,
+                                               const FVElementGeometry& fvGeometry,
+                                               const ElementVolumeVariables& elemVolVars,
+                                               const ElementFaceVariables& elemFaceVars,
+                                               const SubControlVolumeFace &scvf,
+                                               const FluxVariablesCache& fluxVarsCache)
+    {
+        CellCenterPrimaryVariables flux = ParentType::computeMassFlux(problem, element, fvGeometry,
+                                                                      elemVolVars, elemFaceVars, scvf, fluxVarsCache);
+
+        // calculate advective flux
+        auto upwindTermK = [](const auto& volVars)
+        {
+            return volVars.viscosityTilde();
+        };
+
+        flux[viscosityTildeEqIdx]
+            = ParentType::advectiveFluxForCellCenter(problem, elemVolVars, elemFaceVars, scvf, upwindTermK);
+
+        // calculate diffusive flux
+        const auto& insideScv = fvGeometry.scv(scvf.insideScvIdx());
+        const auto& outsideScv = fvGeometry.scv(scvf.outsideScvIdx());
+        const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()];
+        const auto& outsideVolVars = elemVolVars[scvf.outsideScvIdx()];
+
+        // effective diffusion coefficients
+        Scalar insideCoeff = (insideVolVars.kinematicViscosity() + insideVolVars.viscosityTilde())
+                             / insideVolVars.sigma();
+        Scalar outsideCoeff = (outsideVolVars.kinematicViscosity() + outsideVolVars.viscosityTilde())
+                              / outsideVolVars.sigma();
+
+        // scale by extrusion factor
+        insideCoeff *= insideVolVars.extrusionFactor();
+        outsideCoeff *= outsideVolVars.extrusionFactor();
+
+        // average and distance
+        Scalar coeff = arithmeticMean(insideCoeff, outsideCoeff,
+                                        (insideScv.dofPosition() - scvf.ipGlobal()).two_norm(),
+                                        (outsideScv.dofPosition() - scvf.ipGlobal()).two_norm());
+        Scalar distance = 0.0;
+
+        // adapt boundary handling
+        if (scvf.boundary())
+        {
+            distance = (insideScv.dofPosition() - scvf.ipGlobal()).two_norm();
+            coeff = insideCoeff;
+        }
+        else
+        {
+            distance = (outsideScv.dofPosition() - insideScv.dofPosition()).two_norm();
+        }
+
+        const auto bcTypes = problem.boundaryTypes(element, scvf);
+        if (!(scvf.boundary() && (bcTypes.isOutflow(Indices::viscosityTildeEqIdx)
+                                  || bcTypes.isSymmetry())))
+        {
+            flux[viscosityTildeEqIdx]
+                += coeff / distance
+                   * (insideVolVars.viscosityTilde() - outsideVolVars.viscosityTilde())
+                   * scvf.area();
+        }
+        return flux;
+    }
+};
+
+} // end namespace
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/staggered/localresidual.hh b/dumux/freeflow/rans/oneeq/staggered/localresidual.hh
new file mode 100644
index 0000000000..096cd5b399
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/staggered/localresidual.hh
@@ -0,0 +1,121 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+ /*!
+  * \file
+  * \ingroup OneEqModel
+  * \copydoc Dumux::OneEqResidualImpl
+  */
+#ifndef DUMUX_STAGGERED_ONEEQ_LOCAL_RESIDUAL_HH
+#define DUMUX_STAGGERED_ONEEQ_LOCAL_RESIDUAL_HH
+
+#include <dune/common/hybridutilities.hh>
+#include <dumux/common/properties.hh>
+#include <dumux/discretization/methods.hh>
+#include <dumux/freeflow/navierstokes/localresidual.hh>
+
+namespace Dumux {
+
+// forward declaration
+template<class TypeTag, class BaseLocalResidual, DiscretizationMethod discMethod>
+class OneEqResidualImpl;
+
+/*!
+ * \ingroup OneEqModel
+ * \brief Element-wise calculation of the residual for one-equation turbulence models
+ *        using the staggered discretization
+ */
+template<class TypeTag, class BaseLocalResidual>
+class OneEqResidualImpl<TypeTag, BaseLocalResidual, DiscretizationMethod::staggered>
+: public BaseLocalResidual
+{
+    using ParentType = BaseLocalResidual;
+
+    using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables);
+
+    using GridVolumeVariables = typename GridVariables::GridVolumeVariables;
+    using ElementVolumeVariables = typename GridVolumeVariables::LocalView;
+    using VolumeVariables = typename GridVolumeVariables::VolumeVariables;
+
+    using GridFluxVariablesCache = typename GridVariables::GridFluxVariablesCache;
+    using ElementFluxVariablesCache = typename GridFluxVariablesCache::LocalView;
+    using FluxVariables = typename GET_PROP_TYPE(TypeTag, FluxVariables);
+
+    using GridFaceVariables = typename GridVariables::GridFaceVariables;
+    using ElementFaceVariables = typename GridFaceVariables::LocalView;
+
+    using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
+    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
+    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
+    using Element = typename GridView::template Codim<0>::Entity;
+    using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::LocalView;
+    using SubControlVolume = typename FVElementGeometry::SubControlVolume;
+    using CellCenterPrimaryVariables = typename GET_PROP_TYPE(TypeTag, CellCenterPrimaryVariables);
+    using Indices = typename GET_PROP_TYPE(TypeTag, ModelTraits)::Indices;
+    using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes);
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+
+    static constexpr int viscosityTildeEqIdx = Indices::viscosityTildeEqIdx - ModelTraits::dim();
+
+public:
+    using ParentType::ParentType;
+
+    //! Evaluate fluxes entering or leaving the cell center control volume.
+    CellCenterPrimaryVariables computeStorageForCellCenter(const Problem& problem,
+                                                           const SubControlVolume& scv,
+                                                           const VolumeVariables& volVars) const
+    {
+        CellCenterPrimaryVariables storage = ParentType::computeStorageForCellCenter(problem, scv, volVars);
+        storage[viscosityTildeEqIdx] = volVars.viscosityTilde();
+        return storage;
+    }
+
+    CellCenterPrimaryVariables computeSourceForCellCenter(const Problem& problem,
+                                                          const Element &element,
+                                                          const FVElementGeometry& fvGeometry,
+                                                          const ElementVolumeVariables& elemVolVars,
+                                                          const ElementFaceVariables& elemFaceVars,
+                                                          const SubControlVolume &scv) const
+    {
+        CellCenterPrimaryVariables source = ParentType::computeSourceForCellCenter(problem, element, fvGeometry,
+                                                                                   elemVolVars, elemFaceVars, scv);
+
+        const auto& volVars = elemVolVars[scv];
+
+        source[viscosityTildeEqIdx] += volVars.cb1() * (1.0 - volVars.ft2())
+                                       * volVars.stressTensorScalarProductTilde()
+                                       * volVars.viscosityTilde();
+
+        source[viscosityTildeEqIdx] -= (volVars.cw1() * volVars.fW()
+                                        - volVars.cb1() * volVars.ft2() / problem.karmanConstant() / problem.karmanConstant())
+                                       * volVars.viscosityTilde() * volVars.viscosityTilde()
+                                       / volVars.wallDistance() / volVars.wallDistance();
+
+        for (unsigned int dimIdx = 0; dimIdx < ModelTraits::dim(); ++dimIdx)
+        {
+            source[viscosityTildeEqIdx] += volVars.cb2() / volVars.sigma()
+                                           * volVars.storedViscosityTildeGradient()[dimIdx]
+                                           * volVars.storedViscosityTildeGradient()[dimIdx];
+        }
+
+        return source;
+    }
+};
+}
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/volumevariables.hh b/dumux/freeflow/rans/oneeq/volumevariables.hh
new file mode 100644
index 0000000000..c37b1f502c
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/volumevariables.hh
@@ -0,0 +1,323 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ * \ingroup OneEqModel
+ *
+ * \copydoc Dumux::OneEqVolumeVariables
+ */
+#ifndef DUMUX_ONEEQ_VOLUME_VARIABLES_HH
+#define DUMUX_ONEEQ_VOLUME_VARIABLES_HH
+
+#include <dumux/common/parameters.hh>
+#include <dumux/material/fluidstates/immiscible.hh>
+#include <dumux/freeflow/rans/volumevariables.hh>
+
+namespace Dumux
+{
+
+/*!
+ * \ingroup OneEqModel
+ * \brief Volume variables for the isothermal single-phase one-equation
+ *        turbulence model by Spalart-Allmaras
+ */
+template <class Traits, class NSVolumeVariables>
+class OneEqVolumeVariables
+:  public RANSVolumeVariables< Traits, OneEqVolumeVariables<Traits, NSVolumeVariables> >
+,  public NSVolumeVariables
+{
+    using ThisType = OneEqVolumeVariables<Traits, NSVolumeVariables>;
+    using RANSParentType = RANSVolumeVariables<Traits, ThisType>;
+    using NavierStokesParentType = NSVolumeVariables;
+
+    using Scalar = typename Traits::PrimaryVariables::value_type;
+    using DimVector = Dune::FieldVector<Scalar, Traits::ModelTraits::dim()>;
+
+    static constexpr bool enableEnergyBalance = Traits::ModelTraits::enableEnergyBalance();
+    static constexpr int fluidSystemPhaseIdx = Traits::ModelTraits::Indices::fluidSystemPhaseIdx;
+
+public:
+    //! export the underlying fluid system
+    using FluidSystem = typename Traits::FluidSystem;
+    //! export the indices type
+    using Indices = typename Traits::ModelTraits::Indices;
+
+    /*!
+     * \brief Update all quantities for a given control volume
+     *
+     * \param elemSol A vector containing all primary variables connected to the element
+     * \param problem The object specifying the problem which ought to
+     *                be simulated
+     * \param element An element which contains part of the control volume
+     * \param scv The sub-control volume
+     */
+    template<class ElementSolution, class Problem, class Element, class SubControlVolume>
+    void update(const ElementSolution &elemSol,
+                const Problem &problem,
+                const Element &element,
+                const SubControlVolume& scv)
+    {
+        NavierStokesParentType::update(elemSol, problem, element, scv);
+        updateRANSProperties(elemSol, problem, element, scv);
+    }
+
+    /*!
+     * \brief Update all turbulent quantities for a given control volume
+     *
+     * Wall and roughness related quantities are stored. Eddy viscosity is set.
+     *
+     * \param elemSol A vector containing all primary variables connected to the element
+     * \param problem The object specifying the problem which ought to be simulated
+     * \param element An element which contains part of the control volume
+     * \param scv The sub-control volume
+     */
+    template<class ElementSolution, class Problem, class Element, class SubControlVolume>
+    void updateRANSProperties(const ElementSolution &elemSol,
+                              const Problem &problem,
+                              const Element &element,
+                              const SubControlVolume& scv)
+    {
+        RANSParentType::updateRANSProperties(elemSol, problem, element, scv);
+        viscosityTilde_ = elemSol[0][Indices::viscosityTildeIdx];
+        storedViscosityTilde_ = problem.storedViscosityTilde_[RANSParentType::elementID()];
+        storedViscosityTildeGradient_ = problem.storedViscosityTildeGradient_[RANSParentType::elementID()];
+        stressTensorScalarProduct_ = problem.stressTensorScalarProduct_[RANSParentType::elementID()];
+        vorticityTensorScalarProduct_ = problem.vorticityTensorScalarProduct_[RANSParentType::elementID()];
+        if (problem.useStoredEddyViscosity_)
+            dynamicEddyViscosity_ = problem.storedDynamicEddyViscosity_[RANSParentType::elementID()];
+        else
+            dynamicEddyViscosity_ = calculateEddyViscosity();
+        calculateEddyDiffusivity(problem);
+    }
+
+    /*!
+     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow
+     */
+    Scalar dynamicEddyViscosity() const
+    { return dynamicEddyViscosity_; }
+
+    /*!
+     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
+     *        control volume.
+     */
+    Scalar effectiveViscosity() const
+    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
+
+    /*!
+     * \brief Returns the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$.
+     */
+    Scalar calculateEddyViscosity()
+    {
+        return viscosityTilde() * fv1() *  NavierStokesParentType::density();
+    }
+
+    /*!
+     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
+     *        of the fluid-flow in the sub-control volume.
+     */
+    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
+    Scalar effectiveThermalConductivity() const
+    {
+        return NavierStokesParentType::thermalConductivity()
+               + RANSParentType::eddyThermalConductivity();
+    }
+
+    /*!
+     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
+     *        on the kinematic eddy viscosity and the turbulent schmidt number
+     */
+    template<class Problem>
+    void calculateEddyDiffusivity(const Problem& problem)
+    {
+        eddyDiffusivity_ = RANSParentType::kinematicEddyViscosity()
+                           / problem.turbulentSchmidtNumber();
+    }
+
+    /*!
+     * \brief Returns the viscosity parameter \f$ m^2/s \f$
+     */
+    Scalar viscosityTilde() const
+    {
+        return viscosityTilde_;
+    }
+
+    /*!
+     * \brief Returns the viscosity parameter from the last iteration \f$ m^2/s \f$
+     */
+    Scalar storedViscosityTilde() const
+    {
+        return storedViscosityTilde_;
+    }
+
+    /*!
+     * \brief Returns the gradient of the viscosity parameter
+     */
+    DimVector storedViscosityTildeGradient() const
+    {
+        return storedViscosityTildeGradient_;
+    }
+
+    /*!
+     * \brief Returns the scalar product of the stress tensor
+     */
+    Scalar stressTensorScalarProduct() const
+    {
+        return stressTensorScalarProduct_;
+    }
+
+    /*!
+     * \brief Returns damping function for the eddy viscosity
+     */
+    Scalar fv1() const
+    {
+        return viscosityRatio() * viscosityRatio() * viscosityRatio()
+               / (viscosityRatio() * viscosityRatio() * viscosityRatio()
+                  + cv1() * cv1() * cv1());
+    }
+
+    //! \brief Returns a model function
+    Scalar fv2() const
+    { return 1.0 - viscosityRatio() / (1.0 + viscosityRatio() * fv1()); }
+
+    //! \brief Returns a model function
+    Scalar ft2() const
+    {
+        using std::exp;
+        return 0.0;
+//         return ct3() * exp(-ct4() * viscosityRatio()  * viscosityRatio());
+    }
+
+    //! \brief Returns a model function
+    Scalar fW() const
+    {
+        using std::pow;
+        return g() * pow(1.0 + pow(cw3(), 6.0) / (pow(g(), 6.0) + pow(cw3(), 6.0)), 1.0/6.0);
+    }
+
+    //! \brief Returns a model function
+    Scalar g() const
+    {
+        using std::pow;
+        return r() + cw2() * (pow(r(), 6.0) - r());
+    }
+
+    //! \brief Returns a model function
+    Scalar r() const
+    {
+        using std::min;
+        return min(10.0,
+                   viscosityTilde() / stressTensorScalarProductTilde()
+                   / RANSParentType::karmanConstant() / RANSParentType::karmanConstant()
+                   / RANSParentType::wallDistance() / RANSParentType::wallDistance());
+    }
+
+    //! \brief Returns the ratio of the kinematic viscosity and the viscosity parameter
+    Scalar viscosityRatio() const
+    { return viscosityTilde() / RANSParentType::kinematicViscosity(); }
+
+    //! \brief Returns a modified version of the stress tensor scalar product
+    Scalar stressTensorScalarProductTilde() const
+    {
+//         return std::max(0.3 * vorticityMagnitude(),
+//                vorticityMagnitude()
+//                + viscosityTilde() * fv2()
+//                  / RANSParentType::karmanConstant() / RANSParentType::karmanConstant()
+//                  / RANSParentType::wallDistance() / RANSParentType::wallDistance());
+        return vorticityMagnitude()
+               + viscosityTilde() * fv2()
+                 / RANSParentType::karmanConstant() / RANSParentType::karmanConstant()
+                 / RANSParentType::wallDistance() / RANSParentType::wallDistance();
+    }
+
+    //! \brief Returns the magnitude of the vorticity
+    Scalar vorticityMagnitude() const
+    {
+        using std::sqrt;
+        return sqrt(2.0 * vorticityTensorScalarProduct_);
+    }
+
+    //! \brief Returns a model constant
+    Scalar sigma() const
+    { return 2.0/3.0; }
+
+    //! \brief Returns a model constant
+    Scalar cb1() const
+    { return 0.1355; }
+
+    //! \brief Returns a model constant
+    Scalar cb2() const
+    { return 0.622; }
+
+    //! \brief Returns a model constant
+    Scalar cv1() const
+    { return 7.1; }
+
+    //! \brief Returns a model constant
+    Scalar ct3() const
+    { return 1.2; }
+
+    //! \brief Returns a model constant
+    Scalar ct4() const
+    { return 0.5; }
+
+    //! \brief Returns a model constant
+    Scalar cw1() const
+    {
+        return cb1() / RANSParentType::karmanConstant() / RANSParentType::karmanConstant()
+               + (1.0 + cb2()) / sigma();
+    }
+
+    //! \brief Returns a model constant
+    Scalar cw2() const
+    { return 0.3; }
+
+    //! \brief Returns a model constant
+    Scalar cw3() const
+    { return 2.0; }
+
+    /*!
+     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
+     */
+    Scalar eddyDiffusivity() const
+    { return eddyDiffusivity_; }
+
+     /*!
+     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
+     *
+     * \param compIIdx the index of the component which diffusive
+     * \param compJIdx the index of the component with respect to which compIIdx diffuses
+     */
+    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
+    {
+        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
+    }
+
+protected:
+    Scalar dynamicEddyViscosity_;
+    Scalar eddyDiffusivity_;
+    Scalar viscosityTilde_;
+    Scalar storedViscosityTilde_;
+    DimVector storedViscosityTildeGradient_;
+    Scalar stressTensorScalarProduct_;
+    Scalar vorticityTensorScalarProduct_;
+};
+
+}
+
+#endif
diff --git a/dumux/freeflow/rans/oneeq/vtkoutputfields.hh b/dumux/freeflow/rans/oneeq/vtkoutputfields.hh
new file mode 100644
index 0000000000..be9d913e2f
--- /dev/null
+++ b/dumux/freeflow/rans/oneeq/vtkoutputfields.hh
@@ -0,0 +1,60 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ * \ingroup OneEqModel
+ * \copydoc Dumux::OneEqVtkOutputFields
+ */
+#ifndef DUMUX_ONEEQ_VTK_OUTPUT_FIELDS_HH
+#define DUMUX_ONEEQ_VTK_OUTPUT_FIELDS_HH
+
+#include <dumux/freeflow/rans/vtkoutputfields.hh>
+
+namespace Dumux
+{
+
+/*!
+ * \ingroup OneEqModel
+ * \brief Adds vtk output fields for the one-equation turbulence model by Spalart-Allmaras
+ */
+template<class FVGridGeometry>
+class OneEqVtkOutputFields : public RANSVtkOutputFields<FVGridGeometry>
+{
+    enum { dim = FVGridGeometry::GridView::dimension };
+
+public:
+    //! Initialize the Reynolds-averaged Navier-Stokes specific vtk output fields.
+    template <class VtkOutputModule>
+    static void init(VtkOutputModule& vtk)
+    {
+        RANSVtkOutputFields<FVGridGeometry>::init(vtk);
+        add(vtk);
+    }
+
+    //! Add the OneEq specific vtk output fields.
+    template <class VtkOutputModule>
+    static void add(VtkOutputModule& vtk)
+    {
+        vtk.addVolumeVariable([](const auto& v){ return v.viscosityTilde(); }, "nu_tilde");
+    }
+};
+
+} // end namespace Dumux
+
+#endif
diff --git a/dumux/freeflow/rans/problem.hh b/dumux/freeflow/rans/problem.hh
index f7147298ad..aeca9d72fe 100644
--- a/dumux/freeflow/rans/problem.hh
+++ b/dumux/freeflow/rans/problem.hh
@@ -99,6 +99,7 @@ public:
         velocityMaximum_.resize(this->fvGridGeometry().elementMapper().size(), DimVector(0.0));
         velocityGradients_.resize(this->fvGridGeometry().elementMapper().size(), DimMatrix(0.0));
         stressTensorScalarProduct_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+        vorticityTensorScalarProduct_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
         flowNormalAxis_.resize(this->fvGridGeometry().elementMapper().size(), 0);
         wallNormalAxis_.resize(this->fvGridGeometry().elementMapper().size(), 1);
         kinematicViscosity_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
@@ -325,6 +326,24 @@ public:
                 }
             }
 
+            Dune::FieldMatrix<Scalar, GridView::dimension, GridView::dimension> vorticityTensor(0.0);
+            for (unsigned int dimIdx = 0; dimIdx < dim; ++dimIdx)
+            {
+                for (unsigned int velIdx = 0; velIdx < dim; ++velIdx)
+                {
+                    vorticityTensor[dimIdx][velIdx] = 0.5 * velocityGradients_[elementID][dimIdx][velIdx]
+                                                      - 0.5 * velocityGradients_[elementID][velIdx][dimIdx];
+              }
+            }
+            vorticityTensorScalarProduct_[elementID] = 0.0;
+            for (unsigned int dimIdx = 0; dimIdx < dim; ++dimIdx)
+            {
+                for (unsigned int velIdx = 0; velIdx < dim; ++velIdx)
+                {
+                    vorticityTensorScalarProduct_[elementID] += vorticityTensor[dimIdx][velIdx] * vorticityTensor[dimIdx][velIdx];
+                }
+            }
+
             auto fvGeometry = localView(this->fvGridGeometry());
             fvGeometry.bindElement(element);
             for (auto&& scv : scvs(fvGeometry))
@@ -403,6 +422,7 @@ public:
     std::vector<DimVector> velocityMinimum_;
     std::vector<DimMatrix> velocityGradients_;
     std::vector<Scalar> stressTensorScalarProduct_;
+    std::vector<Scalar> vorticityTensorScalarProduct_;
     std::vector<unsigned int> wallNormalAxis_;
     std::vector<unsigned int> flowNormalAxis_;
     std::vector<Scalar> kinematicViscosity_;
diff --git a/dumux/freeflow/rans/volumevariables.hh b/dumux/freeflow/rans/volumevariables.hh
index a0182d4430..88a546b3ff 100644
--- a/dumux/freeflow/rans/volumevariables.hh
+++ b/dumux/freeflow/rans/volumevariables.hh
@@ -95,6 +95,7 @@ public:
         uStar_ = max(uStar_, 1e-10); // zero values lead to numerical problems in some turbulence models
         yPlus_ = wallDistance_ * uStar_ / problem.kinematicViscosity_[elementID_];
         uPlus_ = velocity_[flowNormalAxis] / uStar_;
+        karmanConstant_ = problem.karmanConstant();
     }
 
     /*!
@@ -127,6 +128,12 @@ public:
     Scalar wallDistance() const
     { return wallDistance_; }
 
+    /*!
+     * \brief Return the Karman constant
+     */
+    Scalar karmanConstant() const
+    { return karmanConstant_; }
+
     /*!
      * \brief Return the wall friction velocity \f$\mathrm{[m/s]}\f$
      */
@@ -166,6 +173,7 @@ protected:
     std::size_t elementID_;
     std::size_t wallElementID_;
     Scalar wallDistance_;
+    Scalar karmanConstant_;
     Scalar uStar_;
     Scalar yPlus_;
     Scalar uPlus_;
diff --git a/test/freeflow/rans/CMakeLists.txt b/test/freeflow/rans/CMakeLists.txt
index a0a14db0fd..fb2062d781 100644
--- a/test/freeflow/rans/CMakeLists.txt
+++ b/test/freeflow/rans/CMakeLists.txt
@@ -1,16 +1,7 @@
 add_input_file_links()
 dune_symlink_to_source_files(FILES laufer_re50000.csv laufer_re50000_u+y+.csv
                                    pdelab-kepsilon_twolayers.csv pdelab-kepsilon_wallfunction.csv
-                                   pdelab-komega.csv pdelab-lowrekepsilon.csv pdelab-zeroeq.csv)
-
-dune_add_test(NAME test_pipe_laufer_zeroeq
-              SOURCES test_pipe_laufer.cc
-              CMAKE_GUARD HAVE_UMFPACK
-              COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
-              CMD_ARGS  --script fuzzy
-                        --files ${CMAKE_SOURCE_DIR}/test/references/pipe_laufer_zeroeq.vtu
-                                ${CMAKE_CURRENT_BINARY_DIR}/pipe_laufer_reference-00044.vtu
-                        --command "${CMAKE_CURRENT_BINARY_DIR}/test_pipe_laufer_zeroeq test_pipe_laufer_reference.input")
+                                   pdelab-komega.csv pdelab-lowrekepsilon.csv pdelab-zeroeq.csv pdelab-oneeq.csv)
 
 add_executable(test_pipe_laufer_kepsilon EXCLUDE_FROM_ALL test_pipe_laufer.cc)
 target_compile_definitions(test_pipe_laufer_kepsilon PUBLIC "KEPSILON=1")
@@ -53,6 +44,18 @@ dune_add_test(NAME test_pipe_laufer_komega
                         --command "${CMAKE_CURRENT_BINARY_DIR}/test_pipe_laufer_komega test_pipe_laufer_reference.input")
 target_compile_definitions(test_pipe_laufer_komega PUBLIC "KOMEGA=1")
 
+add_executable(test_pipe_laufer_oneeq EXCLUDE_FROM_ALL test_pipe_laufer.cc)
+target_compile_definitions(test_pipe_laufer_oneeq PUBLIC "ONEEQ=1")
+
+dune_add_test(NAME test_pipe_laufer_zeroeq
+              SOURCES test_pipe_laufer.cc
+              CMAKE_GUARD HAVE_UMFPACK
+              COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
+              CMD_ARGS  --script fuzzy
+                        --files ${CMAKE_SOURCE_DIR}/test/references/pipe_laufer_zeroeq.vtu
+                                ${CMAKE_CURRENT_BINARY_DIR}/pipe_laufer_reference-00044.vtu
+                        --command "${CMAKE_CURRENT_BINARY_DIR}/test_pipe_laufer_zeroeq test_pipe_laufer_reference.input")
+
 dune_add_test(NAME test_pipe_zeroeqni
               SOURCES test_pipe_laufer.cc
               CMAKE_GUARD HAVE_UMFPACK
diff --git a/test/freeflow/rans/pdelab-oneeq.csv b/test/freeflow/rans/pdelab-oneeq.csv
new file mode 100644
index 0000000000..a51d719464
--- /dev/null
+++ b/test/freeflow/rans/pdelab-oneeq.csv
@@ -0,0 +1,1002 @@
+"pressure","velocityAtElementCenters:0","velocityAtElementCenters:1","velocityAtElementCenters:2","relVelocity:0","relVelocity:1","relVelocity:2","velocityGradients0:0","velocityGradients0:1","velocityGradients0:2","velocityGradients1:0","velocityGradients1:1","velocityGradients1:2","pn_rel","massMoleFrac","temperature","viscosity","density","eddyViscosity","distanceToWall","u^+","y^+","vtkValidPointMask","arc_length","Points:0","Points:1","Points:2"
+1e+05,0.17658,-1.6647e-07,0,0.063284,-1664.7,0,0.0012733,1333.6,0,4.0203e-08,-0.0012729,0,0.44091,1,298,1.5752e-05,1.1688,4.2277e-09,0.00013078,1.2183,1.2033,1,0,8,0,0
+1e+05,0.17658,-1.6647e-07,0,0.063284,-1664.7,0,0.0012733,1333.6,0,4.0203e-08,-0.0012729,0,0.44091,1,298,1.5752e-05,1.1688,4.2277e-09,0.00013078,1.2183,1.2033,1,0.0002469,8,0.0002469,0
+1e+05,0.5581,-9.5165e-07,0,0.20002,-9516.5,0,0.0039436,1231.1,0,2.306e-07,-0.0039425,0,0.44091,1,298,1.5752e-05,1.1688,4.6919e-07,0.00041849,3.8506,3.8506,1,0.0004938,8,0.0004938,0
+1e+05,0.95585,-2.7166e-06,0,0.34257,-27166,0,0.0060884,909.87,0,6.6179e-07,-0.0060865,0,0.44091,1,298,1.5752e-05,1.1688,4.4302e-06,0.00076375,6.595,7.0274,1,0.0007407,8,0.0007407,0
+1e+05,1.2492,-5.3251e-06,0,0.4477,-53251,0,0.0064733,514.17,0,1.2986e-06,-0.0064708,0,0.44091,1,298,1.5752e-05,1.1688,2.2102e-05,0.001178,8.619,10.84,1,0.0009876,8,0.0009876,0
+1e+05,1.2492,-5.3251e-06,0,0.4477,-53251,0,0.0064733,514.17,0,1.2986e-06,-0.0064708,0,0.44091,1,298,1.5752e-05,1.1688,2.2102e-05,0.001178,8.619,10.84,1,0.0012345,8,0.0012345,0
+1e+05,1.4245,-8.5386e-06,0,0.51053,-85386,0,0.0064603,266.72,0,2.0684e-06,-0.0064574,0,0.44091,1,298,1.5752e-05,1.1688,6.2104e-05,0.0016752,9.8285,15.414,1,0.0014814,8,0.0014814,0
+1e+05,1.4245,-8.5386e-06,0,0.51053,-85386,0,0.0064603,266.72,0,2.0684e-06,-0.0064574,0,0.44091,1,298,1.5752e-05,1.1688,6.2104e-05,0.0016752,9.8285,15.414,1,0.0017283,8,0.0017283,0
+1e+05,1.5409,-1.2419e-05,0,0.55226,-1.2419e+05,0,0.0065461,157.58,0,2.9712e-06,-0.0065431,0,0.44091,1,298,1.5752e-05,1.1688,0.00011621,0.0022718,10.632,20.904,1,0.0019752,8,0.0019752,0
+1e+05,1.5409,-1.2419e-05,0,0.55226,-1.2419e+05,0,0.0065461,157.58,0,2.9712e-06,-0.0065431,0,0.44091,1,298,1.5752e-05,1.1688,0.00011621,0.0022718,10.632,20.904,1,0.0022221,8,0.0022221,0
+1e+05,1.5409,-1.2419e-05,0,0.55226,-1.2419e+05,0,0.0065461,157.58,0,2.9712e-06,-0.0065431,0,0.44091,1,298,1.5752e-05,1.1688,0.00011621,0.0022718,10.632,20.904,1,0.002469,8,0.002469,0
+1e+05,1.6313,-1.7161e-05,0,0.58466,-1.7161e+05,0,0.0066933,106.86,0,4.0445e-06,-0.0066901,0,0.44091,1,298,1.5752e-05,1.1688,0.00017696,0.0029877,11.256,27.491,1,0.0027159,8,0.0027159,0
+1e+05,1.6313,-1.7161e-05,0,0.58466,-1.7161e+05,0,0.0066933,106.86,0,4.0445e-06,-0.0066901,0,0.44091,1,298,1.5752e-05,1.1688,0.00017696,0.0029877,11.256,27.491,1,0.0029628,8,0.0029628,0
+1e+05,1.6313,-1.7161e-05,0,0.58466,-1.7161e+05,0,0.0066933,106.86,0,4.0445e-06,-0.0066901,0,0.44091,1,298,1.5752e-05,1.1688,0.00017696,0.0029877,11.256,27.491,1,0.0032097,8,0.0032097,0
+1e+05,1.7092,-2.2983e-05,0,0.61258,-2.2983e+05,0,0.0068535,78.907,0,5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.0034566,8,0.0034566,0
+1e+05,1.7092,-2.2983e-05,0,0.61258,-2.2983e+05,0,0.0068535,78.907,0,5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.0037035,8,0.0037035,0
+1e+05,1.7092,-2.2983e-05,0,0.61258,-2.2983e+05,0,0.0068535,78.907,0,5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.0039504,8,0.0039504,0
+1e+05,1.7092,-2.2983e-05,0,0.61258,-2.2983e+05,0,0.0068535,78.907,0,5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.0041973,8,0.0041973,0
+1e+05,1.7805,-3.0127e-05,0,0.63811,-3.0127e+05,0,0.0069993,61.123,0,6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.0044442,8,0.0044442,0
+1e+05,1.7805,-3.0127e-05,0,0.63811,-3.0127e+05,0,0.0069993,61.123,0,6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.0046911,8,0.0046911,0
+1e+05,1.7805,-3.0127e-05,0,0.63811,-3.0127e+05,0,0.0069993,61.123,0,6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.004938,8,0.004938,0
+1e+05,1.7805,-3.0127e-05,0,0.63811,-3.0127e+05,0,0.0069993,61.123,0,6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.0051849,8,0.0051849,0
+1e+05,1.7805,-3.0127e-05,0,0.63811,-3.0127e+05,0,0.0069993,61.123,0,6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.0054318,8,0.0054318,0
+1e+05,1.8479,-3.8859e-05,0,0.66226,-3.8859e+05,0,0.0071136,48.673,0,8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.0056787,8,0.0056787,0
+1e+05,1.8479,-3.8859e-05,0,0.66226,-3.8859e+05,0,0.0071136,48.673,0,8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.0059256,8,0.0059256,0
+1e+05,1.8479,-3.8859e-05,0,0.66226,-3.8859e+05,0,0.0071136,48.673,0,8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.0061725,8,0.0061725,0
+1e+05,1.8479,-3.8859e-05,0,0.66226,-3.8859e+05,0,0.0071136,48.673,0,8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.0064194,8,0.0064194,0
+1e+05,1.8479,-3.8859e-05,0,0.66226,-3.8859e+05,0,0.0071136,48.673,0,8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.0066663,8,0.0066663,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.0069132,8,0.0069132,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.0071601,8,0.0071601,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.007407,8,0.007407,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.0076539,8,0.0076539,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.0079008,8,0.0079008,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.0081477,8,0.0081477,0
+1e+05,1.9129,-4.9469e-05,0,0.68558,-4.9469e+05,0,0.0071822,39.435,0,1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.0083946,8,0.0083946,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.0086415,8,0.0086415,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.0088884,8,0.0088884,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.0091353,8,0.0091353,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.0093822,8,0.0093822,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.0096291,8,0.0096291,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.009876,8,0.009876,0
+1e+05,1.9767,-6.2265e-05,0,0.70842,-6.2265e+05,0,0.0071905,32.338,0,1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.010123,8,0.010123,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.01037,8,0.01037,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.010617,8,0.010617,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.010864,8,0.010864,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.011111,8,0.011111,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.011357,8,0.011357,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.011604,8,0.011604,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.011851,8,0.011851,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.012098,8,0.012098,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.012345,8,0.012345,0
+1e+05,2.0397,-7.7549e-05,0,0.731,-7.7549e+05,0,0.0071226,26.762,0,1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.012592,8,0.012592,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.012839,8,0.012839,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.013086,8,0.013086,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.013333,8,0.013333,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.013579,8,0.013579,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.013826,8,0.013826,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.014073,8,0.014073,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.01432,8,0.01432,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.014567,8,0.014567,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.014814,8,0.014814,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.015061,8,0.015061,0
+1e+05,2.1025,-9.5582e-05,0,0.75353,-9.5582e+05,0,0.0069602,22.315,0,1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.015308,8,0.015308,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.015555,8,0.015555,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.015802,8,0.015802,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.016049,8,0.016049,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.016295,8,0.016295,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.016542,8,0.016542,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.016789,8,0.016789,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.017036,8,0.017036,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.017283,8,0.017283,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.01753,8,0.01753,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.017777,8,0.017777,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.018024,8,0.018024,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.018271,8,0.018271,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.018517,8,0.018517,0
+1e+05,2.1656,-0.00011653,0,0.77614,-1.1653e+06,0,0.006683,18.722,0,2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.018764,8,0.018764,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.019011,8,0.019011,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.019258,8,0.019258,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.019505,8,0.019505,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.019752,8,0.019752,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.019999,8,0.019999,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.020246,8,0.020246,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.020493,8,0.020493,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.02074,8,0.02074,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.020986,8,0.020986,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.021233,8,0.021233,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.02148,8,0.02148,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.021727,8,0.021727,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.021974,8,0.021974,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.022221,8,0.022221,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.022468,8,0.022468,0
+1e+05,2.2293,-0.00014036,0,0.79897,-1.4036e+06,0,0.0062679,15.786,0,2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.022715,8,0.022715,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.022962,8,0.022962,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.023209,8,0.023209,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.023456,8,0.023456,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.023702,8,0.023702,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.023949,8,0.023949,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.024196,8,0.024196,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.024443,8,0.024443,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.02469,8,0.02469,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.024937,8,0.024937,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.025184,8,0.025184,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.025431,8,0.025431,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.025678,8,0.025678,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.025925,8,0.025925,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.026171,8,0.026171,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.026418,8,0.026418,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.026665,8,0.026665,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.026912,8,0.026912,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.027159,8,0.027159,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.027406,8,0.027406,0
+1e+05,2.2939,-0.00016673,0,0.82212,-1.6673e+06,0,0.0056895,13.36,0,2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.027653,8,0.027653,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.0279,8,0.0279,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.028147,8,0.028147,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.028393,8,0.028393,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.02864,8,0.02864,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.028887,8,0.028887,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.029134,8,0.029134,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.029381,8,0.029381,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.029628,8,0.029628,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.029875,8,0.029875,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.030122,8,0.030122,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.030369,8,0.030369,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.030616,8,0.030616,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.030863,8,0.030863,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.031109,8,0.031109,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.031356,8,0.031356,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.031603,8,0.031603,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.03185,8,0.03185,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.032097,8,0.032097,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.032344,8,0.032344,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.032591,8,0.032591,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.032838,8,0.032838,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.033085,8,0.033085,0
+1e+05,2.3596,-0.00019474,0,0.84566,-1.9474e+06,0,0.0049195,11.327,0,2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.033331,8,0.033331,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.033578,8,0.033578,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.033825,8,0.033825,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.034072,8,0.034072,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.034319,8,0.034319,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.034566,8,0.034566,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.034813,8,0.034813,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.03506,8,0.03506,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.035307,8,0.035307,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.035554,8,0.035554,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.035801,8,0.035801,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.036047,8,0.036047,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.036294,8,0.036294,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.036541,8,0.036541,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.036788,8,0.036788,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.037035,8,0.037035,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.037282,8,0.037282,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.037529,8,0.037529,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.037776,8,0.037776,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.038023,8,0.038023,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.03827,8,0.03827,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.038516,8,0.038516,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.038763,8,0.038763,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.03901,8,0.03901,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.039257,8,0.039257,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.039504,8,0.039504,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.039751,8,0.039751,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.039998,8,0.039998,0
+1e+05,2.4265,-0.00022265,0,0.86962,-2.2265e+06,0,0.0039274,9.5965,0,3.0648e-05,-0.0039226,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.040245,8,0.040245,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.040492,8,0.040492,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.040739,8,0.040739,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.040985,8,0.040985,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.041232,8,0.041232,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.041479,8,0.041479,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.041726,8,0.041726,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.041973,8,0.041973,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.04222,8,0.04222,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.042467,8,0.042467,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.042714,8,0.042714,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.042961,8,0.042961,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.043208,8,0.043208,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.043454,8,0.043454,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.043701,8,0.043701,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.043948,8,0.043948,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.044195,8,0.044195,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.044442,8,0.044442,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.044689,8,0.044689,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.044936,8,0.044936,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.045183,8,0.045183,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.04543,8,0.04543,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.045676,8,0.045676,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.045923,8,0.045923,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.04617,8,0.04617,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.046417,8,0.046417,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.046664,8,0.046664,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.046911,8,0.046911,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.047158,8,0.047158,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.047405,8,0.047405,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.047652,8,0.047652,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.047899,8,0.047899,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.048145,8,0.048145,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.048392,8,0.048392,0
+1e+05,2.4944,-0.00024749,0,0.89396,-2.475e+06,0,0.0026817,8.0904,0,2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.048639,8,0.048639,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.048886,8,0.048886,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.049133,8,0.049133,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.04938,8,0.04938,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.049627,8,0.049627,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.049874,8,0.049874,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.050121,8,0.050121,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.050368,8,0.050368,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.050614,8,0.050614,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.050861,8,0.050861,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.051108,8,0.051108,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.051355,8,0.051355,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.051602,8,0.051602,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.051849,8,0.051849,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.052096,8,0.052096,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.052343,8,0.052343,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.05259,8,0.05259,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.052837,8,0.052837,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.053084,8,0.053084,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.05333,8,0.05333,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.053577,8,0.053577,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.053824,8,0.053824,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.054071,8,0.054071,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.054318,8,0.054318,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.054565,8,0.054565,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.054812,8,0.054812,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.055059,8,0.055059,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.055306,8,0.055306,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.055553,8,0.055553,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.055799,8,0.055799,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.056046,8,0.056046,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.056293,8,0.056293,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.05654,8,0.05654,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.056787,8,0.056787,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.057034,8,0.057034,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.057281,8,0.057281,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.057528,8,0.057528,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.057775,8,0.057775,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.058022,8,0.058022,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.058268,8,0.058268,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.058515,8,0.058515,0
+1e+05,2.5628,-0.00026444,0,0.91849,-2.6444e+06,0,0.0011551,6.7374,0,2.6641e-05,-0.0011501,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.058762,8,0.058762,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.059009,8,0.059009,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.059256,8,0.059256,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.059503,8,0.059503,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.05975,8,0.05975,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.059997,8,0.059997,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.060244,8,0.060244,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.060491,8,0.060491,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.060737,8,0.060737,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.060984,8,0.060984,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.061231,8,0.061231,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.061478,8,0.061478,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.061725,8,0.061725,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.061972,8,0.061972,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.062219,8,0.062219,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.062466,8,0.062466,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.062713,8,0.062713,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.062959,8,0.062959,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.063206,8,0.063206,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.063453,8,0.063453,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.0637,8,0.0637,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.063947,8,0.063947,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.064194,8,0.064194,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.064441,8,0.064441,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.064688,8,0.064688,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.064935,8,0.064935,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.065182,8,0.065182,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.065429,8,0.065429,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.065675,8,0.065675,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.065922,8,0.065922,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.066169,8,0.066169,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.066416,8,0.066416,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.066663,8,0.066663,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.06691,8,0.06691,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.067157,8,0.067157,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.067404,8,0.067404,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.067651,8,0.067651,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.067897,8,0.067897,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.068144,8,0.068144,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.068391,8,0.068391,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.068638,8,0.068638,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.068885,8,0.068885,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.069132,8,0.069132,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.069379,8,0.069379,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.069626,8,0.069626,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.069873,8,0.069873,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.07012,8,0.07012,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.070367,8,0.070367,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.070613,8,0.070613,0
+1e+05,2.6306,-0.00026618,0,0.94279,-2.6618e+06,0,-0.00066414,5.4622,0,2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.07086,8,0.07086,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.071107,8,0.071107,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.071354,8,0.071354,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.071601,8,0.071601,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.071848,8,0.071848,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.072095,8,0.072095,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.072342,8,0.072342,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.072589,8,0.072589,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.072835,8,0.072835,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.073082,8,0.073082,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.073329,8,0.073329,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.073576,8,0.073576,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.073823,8,0.073823,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.07407,8,0.07407,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.074317,8,0.074317,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.074564,8,0.074564,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.074811,8,0.074811,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.075058,8,0.075058,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.075305,8,0.075305,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.075551,8,0.075551,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.075798,8,0.075798,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.076045,8,0.076045,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.076292,8,0.076292,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.076539,8,0.076539,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.076786,8,0.076786,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.077033,8,0.077033,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.07728,8,0.07728,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.077527,8,0.077527,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.077773,8,0.077773,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.07802,8,0.07802,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.078267,8,0.078267,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.078514,8,0.078514,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.078761,8,0.078761,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.079008,8,0.079008,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.079255,8,0.079255,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.079502,8,0.079502,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.079749,8,0.079749,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.079996,8,0.079996,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.080242,8,0.080242,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.080489,8,0.080489,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.080736,8,0.080736,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.080983,8,0.080983,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.08123,8,0.08123,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.081477,8,0.081477,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.081724,8,0.081724,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.081971,8,0.081971,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.082218,8,0.082218,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.082465,8,0.082465,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.082712,8,0.082712,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.082958,8,0.082958,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.083205,8,0.083205,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.083452,8,0.083452,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.083699,8,0.083699,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.083946,8,0.083946,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.084193,8,0.084193,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.08444,8,0.08444,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.084687,8,0.084687,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.084934,8,0.084934,0
+1e+05,2.6953,-0.00024232,0,0.96599,-2.4232e+06,0,-0.0027416,4.169,0,1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.08518,8,0.08518,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.085427,8,0.085427,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.085674,8,0.085674,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.085921,8,0.085921,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.086168,8,0.086168,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.086415,8,0.086415,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.086662,8,0.086662,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.086909,8,0.086909,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.087156,8,0.087156,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.087403,8,0.087403,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.08765,8,0.08765,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.087896,8,0.087896,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.088143,8,0.088143,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.08839,8,0.08839,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.088637,8,0.088637,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.088884,8,0.088884,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.089131,8,0.089131,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.089378,8,0.089378,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.089625,8,0.089625,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.089872,8,0.089872,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.090118,8,0.090118,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.090365,8,0.090365,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.090612,8,0.090612,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.090859,8,0.090859,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.091106,8,0.091106,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.091353,8,0.091353,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.0916,8,0.0916,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.091847,8,0.091847,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.092094,8,0.092094,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.092341,8,0.092341,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.092588,8,0.092588,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.092834,8,0.092834,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.093081,8,0.093081,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.093328,8,0.093328,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.093575,8,0.093575,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.093822,8,0.093822,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.094069,8,0.094069,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.094316,8,0.094316,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.094563,8,0.094563,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.09481,8,0.09481,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.095056,8,0.095056,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.095303,8,0.095303,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.09555,8,0.09555,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.095797,8,0.095797,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.096044,8,0.096044,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.096291,8,0.096291,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.096538,8,0.096538,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.096785,8,0.096785,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.097032,8,0.097032,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.097279,8,0.097279,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.097525,8,0.097525,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.097772,8,0.097772,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.098019,8,0.098019,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.098266,8,0.098266,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.098513,8,0.098513,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.09876,8,0.09876,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.099007,8,0.099007,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.099254,8,0.099254,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.099501,8,0.099501,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.099748,8,0.099748,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.099995,8,0.099995,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10024,8,0.10024,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10049,8,0.10049,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10074,8,0.10074,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10098,8,0.10098,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10123,8,0.10123,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10148,8,0.10148,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10172,8,0.10172,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10197,8,0.10197,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10222,8,0.10222,0
+1e+05,2.752,-0.00017994,0,0.9863,-1.7994e+06,0,-0.0049062,2.7157,0,7.831e-06,0.0049116,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.10246,8,0.10246,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10271,8,0.10271,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10296,8,0.10296,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1032,8,0.1032,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10345,8,0.10345,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1037,8,0.1037,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10394,8,0.10394,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10419,8,0.10419,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10444,8,0.10444,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10469,8,0.10469,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10493,8,0.10493,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10518,8,0.10518,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10543,8,0.10543,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10567,8,0.10567,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10592,8,0.10592,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10617,8,0.10617,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10641,8,0.10641,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10666,8,0.10666,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10691,8,0.10691,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10715,8,0.10715,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1074,8,0.1074,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10765,8,0.10765,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1079,8,0.1079,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10814,8,0.10814,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10839,8,0.10839,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10864,8,0.10864,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10888,8,0.10888,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10913,8,0.10913,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10938,8,0.10938,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10962,8,0.10962,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.10987,8,0.10987,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11012,8,0.11012,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11036,8,0.11036,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11061,8,0.11061,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11086,8,0.11086,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11111,8,0.11111,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11135,8,0.11135,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1116,8,0.1116,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11185,8,0.11185,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11209,8,0.11209,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11234,8,0.11234,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11259,8,0.11259,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11283,8,0.11283,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11308,8,0.11308,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11333,8,0.11333,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11357,8,0.11357,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11382,8,0.11382,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11407,8,0.11407,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11431,8,0.11431,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11456,8,0.11456,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11481,8,0.11481,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11506,8,0.11506,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1153,8,0.1153,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11555,8,0.11555,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1158,8,0.1158,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11604,8,0.11604,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11629,8,0.11629,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11654,8,0.11654,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11678,8,0.11678,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11703,8,0.11703,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11728,8,0.11728,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11752,8,0.11752,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11777,8,0.11777,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11802,8,0.11802,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11827,8,0.11827,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11851,8,0.11851,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11876,8,0.11876,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11901,8,0.11901,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11925,8,0.11925,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1195,8,0.1195,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11975,8,0.11975,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.11999,8,0.11999,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12024,8,0.12024,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12049,8,0.12049,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12073,8,0.12073,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12098,8,0.12098,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12123,8,0.12123,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12147,8,0.12147,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12172,8,0.12172,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12197,8,0.12197,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12222,8,0.12222,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12246,8,0.12246,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12271,8,0.12271,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12296,8,0.12296,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1232,8,0.1232,0
+1e+05,2.7902,-6.8693e-05,0,1,-6.8693e+05,0,-0.0066018,0.95947,0,2.2868e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12345,8,0.12345,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1237,8,0.1237,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12394,8,0.12394,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12419,8,0.12419,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12444,8,0.12444,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12468,8,0.12468,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12493,8,0.12493,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12518,8,0.12518,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12543,8,0.12543,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12567,8,0.12567,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12592,8,0.12592,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12617,8,0.12617,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12641,8,0.12641,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12666,8,0.12666,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12691,8,0.12691,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12715,8,0.12715,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1274,8,0.1274,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12765,8,0.12765,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12789,8,0.12789,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12814,8,0.12814,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12839,8,0.12839,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12863,8,0.12863,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12888,8,0.12888,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12913,8,0.12913,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12938,8,0.12938,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12962,8,0.12962,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.12987,8,0.12987,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13012,8,0.13012,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13036,8,0.13036,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13061,8,0.13061,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13086,8,0.13086,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1311,8,0.1311,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13135,8,0.13135,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1316,8,0.1316,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13184,8,0.13184,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13209,8,0.13209,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13234,8,0.13234,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13259,8,0.13259,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13283,8,0.13283,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13308,8,0.13308,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13333,8,0.13333,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13357,8,0.13357,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13382,8,0.13382,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13407,8,0.13407,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13431,8,0.13431,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13456,8,0.13456,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13481,8,0.13481,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13505,8,0.13505,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1353,8,0.1353,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13555,8,0.13555,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13579,8,0.13579,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13604,8,0.13604,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13629,8,0.13629,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13654,8,0.13654,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13678,8,0.13678,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13703,8,0.13703,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13728,8,0.13728,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13752,8,0.13752,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13777,8,0.13777,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13802,8,0.13802,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13826,8,0.13826,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13851,8,0.13851,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13876,8,0.13876,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.139,8,0.139,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13925,8,0.13925,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1395,8,0.1395,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13975,8,0.13975,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.13999,8,0.13999,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14024,8,0.14024,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14049,8,0.14049,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14073,8,0.14073,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14098,8,0.14098,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14123,8,0.14123,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14147,8,0.14147,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14172,8,0.14172,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14197,8,0.14197,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14221,8,0.14221,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14246,8,0.14246,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14271,8,0.14271,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14296,8,0.14296,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1432,8,0.1432,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14345,8,0.14345,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.1437,8,0.1437,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14394,8,0.14394,0
+1e+05,2.7902,6.8692e-05,0,1,0.25806,0,-0.0066018,-0.95947,0,-2.2867e-06,0.0066073,0,0.44092,1,298,1.5752e-05,1.1688,0.0019079,0.11305,19.251,1040.2,1,0.14419,8,0.14419,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14444,8,0.14444,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14468,8,0.14468,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14493,8,0.14493,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14518,8,0.14518,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14542,8,0.14542,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14567,8,0.14567,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14592,8,0.14592,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14616,8,0.14616,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14641,8,0.14641,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14666,8,0.14666,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14691,8,0.14691,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14715,8,0.14715,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.1474,8,0.1474,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14765,8,0.14765,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14789,8,0.14789,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14814,8,0.14814,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14839,8,0.14839,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14863,8,0.14863,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14888,8,0.14888,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14913,8,0.14913,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14937,8,0.14937,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14962,8,0.14962,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.14987,8,0.14987,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15012,8,0.15012,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15036,8,0.15036,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15061,8,0.15061,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15086,8,0.15086,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.1511,8,0.1511,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15135,8,0.15135,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.1516,8,0.1516,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15184,8,0.15184,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15209,8,0.15209,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15234,8,0.15234,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15258,8,0.15258,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15283,8,0.15283,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15308,8,0.15308,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15332,8,0.15332,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15357,8,0.15357,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15382,8,0.15382,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15407,8,0.15407,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15431,8,0.15431,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15456,8,0.15456,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15481,8,0.15481,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15505,8,0.15505,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.1553,8,0.1553,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15555,8,0.15555,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15579,8,0.15579,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15604,8,0.15604,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15629,8,0.15629,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15653,8,0.15653,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15678,8,0.15678,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15703,8,0.15703,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15728,8,0.15728,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15752,8,0.15752,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15777,8,0.15777,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15802,8,0.15802,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15826,8,0.15826,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15851,8,0.15851,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15876,8,0.15876,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.159,8,0.159,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15925,8,0.15925,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.1595,8,0.1595,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15974,8,0.15974,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.15999,8,0.15999,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.16024,8,0.16024,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.16048,8,0.16048,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.16073,8,0.16073,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.16098,8,0.16098,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.16123,8,0.16123,0
+1e+05,2.752,0.00017994,0,0.9863,0.67599,0,-0.0049062,-2.7157,0,-7.8309e-06,0.0049117,0,0.44092,1,298,1.5752e-05,1.1688,0.0019673,0.093993,18.988,864.86,1,0.16147,8,0.16147,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16172,8,0.16172,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16197,8,0.16197,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16221,8,0.16221,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16246,8,0.16246,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16271,8,0.16271,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16295,8,0.16295,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.1632,8,0.1632,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16345,8,0.16345,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16369,8,0.16369,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16394,8,0.16394,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16419,8,0.16419,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16444,8,0.16444,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16468,8,0.16468,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16493,8,0.16493,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16518,8,0.16518,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16542,8,0.16542,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16567,8,0.16567,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16592,8,0.16592,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16616,8,0.16616,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16641,8,0.16641,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16666,8,0.16666,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.1669,8,0.1669,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16715,8,0.16715,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.1674,8,0.1674,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16765,8,0.16765,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16789,8,0.16789,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16814,8,0.16814,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16839,8,0.16839,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16863,8,0.16863,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16888,8,0.16888,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16913,8,0.16913,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16937,8,0.16937,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16962,8,0.16962,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.16987,8,0.16987,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17011,8,0.17011,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17036,8,0.17036,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17061,8,0.17061,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17085,8,0.17085,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.1711,8,0.1711,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17135,8,0.17135,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.1716,8,0.1716,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17184,8,0.17184,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17209,8,0.17209,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17234,8,0.17234,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17258,8,0.17258,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17283,8,0.17283,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17308,8,0.17308,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17332,8,0.17332,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17357,8,0.17357,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17382,8,0.17382,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17406,8,0.17406,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17431,8,0.17431,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17456,8,0.17456,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17481,8,0.17481,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17505,8,0.17505,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.1753,8,0.1753,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17555,8,0.17555,0
+1e+05,2.6953,0.00024232,0,0.96599,0.91036,0,-0.0027416,-4.169,0,-1.471e-05,0.0027469,0,0.44091,1,298,1.5752e-05,1.1688,0.0019811,0.07811,18.597,718.71,1,0.17579,8,0.17579,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17604,8,0.17604,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17629,8,0.17629,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17653,8,0.17653,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17678,8,0.17678,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17703,8,0.17703,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17727,8,0.17727,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17752,8,0.17752,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17777,8,0.17777,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17801,8,0.17801,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17826,8,0.17826,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17851,8,0.17851,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17876,8,0.17876,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.179,8,0.179,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17925,8,0.17925,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.1795,8,0.1795,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17974,8,0.17974,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.17999,8,0.17999,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18024,8,0.18024,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18048,8,0.18048,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18073,8,0.18073,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18098,8,0.18098,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18122,8,0.18122,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18147,8,0.18147,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18172,8,0.18172,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18197,8,0.18197,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18221,8,0.18221,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18246,8,0.18246,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18271,8,0.18271,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18295,8,0.18295,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.1832,8,0.1832,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18345,8,0.18345,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18369,8,0.18369,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18394,8,0.18394,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18419,8,0.18419,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18443,8,0.18443,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18468,8,0.18468,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18493,8,0.18493,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18518,8,0.18518,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18542,8,0.18542,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18567,8,0.18567,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18592,8,0.18592,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18616,8,0.18616,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18641,8,0.18641,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18666,8,0.18666,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.1869,8,0.1869,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18715,8,0.18715,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.1874,8,0.1874,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18764,8,0.18764,0
+1e+05,2.6306,0.00026618,0,0.94279,1,0,-0.00066415,-5.4622,0,-2.1442e-05,0.00066935,0,0.44091,1,298,1.5752e-05,1.1688,0.0019374,0.064874,18.15,596.92,1,0.18789,8,0.18789,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18814,8,0.18814,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18838,8,0.18838,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18863,8,0.18863,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18888,8,0.18888,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18913,8,0.18913,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18937,8,0.18937,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18962,8,0.18962,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.18987,8,0.18987,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19011,8,0.19011,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19036,8,0.19036,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19061,8,0.19061,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19085,8,0.19085,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.1911,8,0.1911,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19135,8,0.19135,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19159,8,0.19159,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19184,8,0.19184,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19209,8,0.19209,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19234,8,0.19234,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19258,8,0.19258,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19283,8,0.19283,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19308,8,0.19308,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19332,8,0.19332,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19357,8,0.19357,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19382,8,0.19382,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19406,8,0.19406,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19431,8,0.19431,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19456,8,0.19456,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.1948,8,0.1948,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19505,8,0.19505,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.1953,8,0.1953,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19554,8,0.19554,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19579,8,0.19579,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19604,8,0.19604,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19629,8,0.19629,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19653,8,0.19653,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19678,8,0.19678,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19703,8,0.19703,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19727,8,0.19727,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19752,8,0.19752,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19777,8,0.19777,0
+1e+05,2.5628,0.00026444,0,0.91849,0.99347,0,0.0011551,-6.7374,0,-2.6641e-05,-0.00115,0,0.4409,1,298,1.5752e-05,1.1688,0.0018465,0.053843,17.682,495.43,1,0.19801,8,0.19801,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.19826,8,0.19826,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.19851,8,0.19851,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.19875,8,0.19875,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.199,8,0.199,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.19925,8,0.19925,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.1995,8,0.1995,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.19974,8,0.19974,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.19999,8,0.19999,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20024,8,0.20024,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20048,8,0.20048,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20073,8,0.20073,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20098,8,0.20098,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20122,8,0.20122,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20147,8,0.20147,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20172,8,0.20172,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20196,8,0.20196,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20221,8,0.20221,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20246,8,0.20246,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.2027,8,0.2027,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20295,8,0.20295,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.2032,8,0.2032,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20345,8,0.20345,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20369,8,0.20369,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20394,8,0.20394,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20419,8,0.20419,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20443,8,0.20443,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20468,8,0.20468,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20493,8,0.20493,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20517,8,0.20517,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20542,8,0.20542,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20567,8,0.20567,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20591,8,0.20591,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20616,8,0.20616,0
+1e+05,2.4944,0.00024749,0,0.89396,0.92979,0,0.0026817,-8.0904,0,-2.9695e-05,-0.0026767,0,0.4409,1,298,1.5752e-05,1.1688,0.0017225,0.044652,17.21,410.85,1,0.20641,8,0.20641,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20666,8,0.20666,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.2069,8,0.2069,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20715,8,0.20715,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.2074,8,0.2074,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20764,8,0.20764,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20789,8,0.20789,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20814,8,0.20814,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20838,8,0.20838,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20863,8,0.20863,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20888,8,0.20888,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20912,8,0.20912,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20937,8,0.20937,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20962,8,0.20962,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.20987,8,0.20987,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21011,8,0.21011,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21036,8,0.21036,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21061,8,0.21061,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21085,8,0.21085,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.2111,8,0.2111,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21135,8,0.21135,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21159,8,0.21159,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21184,8,0.21184,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21209,8,0.21209,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21233,8,0.21233,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21258,8,0.21258,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21283,8,0.21283,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21307,8,0.21307,0
+1e+05,2.4265,0.00022265,0,0.86962,0.83647,0,0.0039273,-9.5965,0,-3.0648e-05,-0.0039225,0,0.4409,1,298,1.5752e-05,1.1688,0.001578,0.036992,16.742,340.37,1,0.21332,8,0.21332,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21357,8,0.21357,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21382,8,0.21382,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21406,8,0.21406,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21431,8,0.21431,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21456,8,0.21456,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.2148,8,0.2148,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21505,8,0.21505,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.2153,8,0.2153,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21554,8,0.21554,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21579,8,0.21579,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21604,8,0.21604,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21628,8,0.21628,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21653,8,0.21653,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21678,8,0.21678,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21703,8,0.21703,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21727,8,0.21727,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21752,8,0.21752,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21777,8,0.21777,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21801,8,0.21801,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21826,8,0.21826,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21851,8,0.21851,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.21875,8,0.21875,0
+1e+05,2.3596,0.00019474,0,0.84566,0.73159,0,0.0049195,-11.327,0,-2.9891e-05,-0.0049149,0,0.4409,1,298,1.5752e-05,1.1688,0.0014232,0.030608,16.28,281.64,1,0.219,8,0.219,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.21925,8,0.21925,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.21949,8,0.21949,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.21974,8,0.21974,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.21999,8,0.21999,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22023,8,0.22023,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22048,8,0.22048,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22073,8,0.22073,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22098,8,0.22098,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22122,8,0.22122,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22147,8,0.22147,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22172,8,0.22172,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22196,8,0.22196,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22221,8,0.22221,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22246,8,0.22246,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.2227,8,0.2227,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22295,8,0.22295,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.2232,8,0.2232,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22344,8,0.22344,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22369,8,0.22369,0
+1e+05,2.2939,0.00016673,0,0.82212,0.62637,0,0.0056895,-13.36,0,-2.7923e-05,-0.005685,0,0.4409,1,298,1.5752e-05,1.1688,0.0012659,0.025289,15.827,232.69,1,0.22394,8,0.22394,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22419,8,0.22419,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22443,8,0.22443,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22468,8,0.22468,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22493,8,0.22493,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22517,8,0.22517,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22542,8,0.22542,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22567,8,0.22567,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22591,8,0.22591,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22616,8,0.22616,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22641,8,0.22641,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22665,8,0.22665,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.2269,8,0.2269,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22715,8,0.22715,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22739,8,0.22739,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22764,8,0.22764,0
+1e+05,2.2293,0.00014036,0,0.79897,0.52732,0,0.0062679,-15.786,0,-2.5215e-05,-0.0062635,0,0.4409,1,298,1.5752e-05,1.1688,0.0011118,0.020856,15.381,191.9,1,0.22789,8,0.22789,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22814,8,0.22814,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22838,8,0.22838,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22863,8,0.22863,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22888,8,0.22888,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22912,8,0.22912,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22937,8,0.22937,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22962,8,0.22962,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.22986,8,0.22986,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.23011,8,0.23011,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.23036,8,0.23036,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.2306,8,0.2306,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.23085,8,0.23085,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.2311,8,0.2311,0
+1e+05,2.1656,0.00011653,0,0.77614,0.43778,0,0.006683,-18.722,0,-2.2155e-05,-0.0066787,0,0.4409,1,298,1.5752e-05,1.1688,0.00096482,0.017162,14.942,157.91,1,0.23135,8,0.23135,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23159,8,0.23159,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23184,8,0.23184,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23209,8,0.23209,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23233,8,0.23233,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23258,8,0.23258,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23283,8,0.23283,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23307,8,0.23307,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23332,8,0.23332,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23357,8,0.23357,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23381,8,0.23381,0
+1e+05,2.1025,9.5582e-05,0,0.75353,0.35908,0,0.0069602,-22.315,0,-1.9028e-05,-0.0069561,0,0.4409,1,298,1.5752e-05,1.1688,0.00082758,0.014084,14.507,129.59,1,0.23406,8,0.23406,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23431,8,0.23431,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23456,8,0.23456,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.2348,8,0.2348,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23505,8,0.23505,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.2353,8,0.2353,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23554,8,0.23554,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23579,8,0.23579,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23604,8,0.23604,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23628,8,0.23628,0
+1e+05,2.0397,7.7549e-05,0,0.731,0.29133,0,0.0071226,-26.762,0,-1.6027e-05,-0.0071186,0,0.4409,1,298,1.5752e-05,1.1688,0.00070165,0.011519,14.073,105.99,1,0.23653,8,0.23653,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23678,8,0.23678,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23702,8,0.23702,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23727,8,0.23727,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23752,8,0.23752,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23776,8,0.23776,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23801,8,0.23801,0
+1e+05,1.9767,6.2265e-05,0,0.70842,0.23392,0,0.0071905,-32.338,0,-1.3271e-05,-0.0071866,0,0.4409,1,298,1.5752e-05,1.1688,0.00058774,0.0093809,13.638,86.316,1,0.23826,8,0.23826,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.23851,8,0.23851,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.23875,8,0.23875,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.239,8,0.239,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.23925,8,0.23925,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.23949,8,0.23949,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.23974,8,0.23974,0
+1e+05,1.9129,4.9469e-05,0,0.68558,0.18585,0,0.0071822,-39.435,0,-1.0818e-05,-0.0071784,0,0.44091,1,298,1.5752e-05,1.1688,0.00048582,0.0075994,13.198,69.924,1,0.23999,8,0.23999,0
+1e+05,1.8479,3.8859e-05,0,0.66226,0.14599,0,0.0071136,-48.673,0,-8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.24023,8,0.24023,0
+1e+05,1.8479,3.8859e-05,0,0.66226,0.14599,0,0.0071136,-48.673,0,-8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.24048,8,0.24048,0
+1e+05,1.8479,3.8859e-05,0,0.66226,0.14599,0,0.0071136,-48.673,0,-8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.24073,8,0.24073,0
+1e+05,1.8479,3.8859e-05,0,0.66226,0.14599,0,0.0071136,-48.673,0,-8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.24097,8,0.24097,0
+1e+05,1.8479,3.8859e-05,0,0.66226,0.14599,0,0.0071136,-48.673,0,-8.6857e-06,-0.00711,0,0.44091,1,298,1.5752e-05,1.1688,0.00039523,0.0061149,12.75,56.265,1,0.24122,8,0.24122,0
+1e+05,1.7805,3.0127e-05,0,0.63811,0.11318,0,0.0069993,-61.123,0,-6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.24147,8,0.24147,0
+1e+05,1.7805,3.0127e-05,0,0.63811,0.11318,0,0.0069993,-61.123,0,-6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.24172,8,0.24172,0
+1e+05,1.7805,3.0127e-05,0,0.63811,0.11318,0,0.0069993,-61.123,0,-6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.24196,8,0.24196,0
+1e+05,1.7805,3.0127e-05,0,0.63811,0.11318,0,0.0069993,-61.123,0,-6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.24221,8,0.24221,0
+1e+05,1.7805,3.0127e-05,0,0.63811,0.11318,0,0.0069993,-61.123,0,-6.8648e-06,-0.0069958,0,0.44091,1,298,1.5752e-05,1.1688,0.00031475,0.0048778,12.285,44.882,1,0.24246,8,0.24246,0
+1e+05,1.7092,2.2983e-05,0,0.61258,0.086343,0,0.0068535,-78.907,0,-5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.2427,8,0.2427,0
+1e+05,1.7092,2.2983e-05,0,0.61258,0.086343,0,0.0068535,-78.907,0,-5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.24295,8,0.24295,0
+1e+05,1.7092,2.2983e-05,0,0.61258,0.086343,0,0.0068535,-78.907,0,-5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.2432,8,0.2432,0
+1e+05,1.7092,2.2983e-05,0,0.61258,0.086343,0,0.0068535,-78.907,0,-5.3293e-06,-0.0068501,0,0.44091,1,298,1.5752e-05,1.1688,0.00024266,0.0038469,11.793,35.396,1,0.24344,8,0.24344,0
+1e+05,1.6313,1.7161e-05,0,0.58466,0.064469,0,0.0066933,-106.86,0,-4.0445e-06,-0.0066901,0,0.44091,1,298,1.5752e-05,1.1688,0.00017696,0.0029877,11.256,27.491,1,0.24369,8,0.24369,0
+1e+05,1.6313,1.7161e-05,0,0.58466,0.064469,0,0.0066933,-106.86,0,-4.0445e-06,-0.0066901,0,0.44091,1,298,1.5752e-05,1.1688,0.00017696,0.0029877,11.256,27.491,1,0.24394,8,0.24394,0
+1e+05,1.6313,1.7161e-05,0,0.58466,0.064469,0,0.0066933,-106.86,0,-4.0445e-06,-0.0066901,0,0.44091,1,298,1.5752e-05,1.1688,0.00017696,0.0029877,11.256,27.491,1,0.24418,8,0.24418,0
+1e+05,1.5409,1.2419e-05,0,0.55226,0.046656,0,0.0065461,-157.58,0,-2.9712e-06,-0.0065431,0,0.44091,1,298,1.5752e-05,1.1688,0.00011621,0.0022718,10.632,20.904,1,0.24443,8,0.24443,0
+1e+05,1.5409,1.2419e-05,0,0.55226,0.046656,0,0.0065461,-157.58,0,-2.9712e-06,-0.0065431,0,0.44091,1,298,1.5752e-05,1.1688,0.00011621,0.0022718,10.632,20.904,1,0.24468,8,0.24468,0
+1e+05,1.5409,1.2419e-05,0,0.55226,0.046656,0,0.0065461,-157.58,0,-2.9712e-06,-0.0065431,0,0.44091,1,298,1.5752e-05,1.1688,0.00011621,0.0022718,10.632,20.904,1,0.24492,8,0.24492,0
+1e+05,1.4245,8.5386e-06,0,0.51053,0.032078,0,0.0064603,-266.72,0,-2.0684e-06,-0.0064574,0,0.44091,1,298,1.5752e-05,1.1688,6.2104e-05,0.0016752,9.8285,15.414,1,0.24517,8,0.24517,0
+1e+05,1.4245,8.5386e-06,0,0.51053,0.032078,0,0.0064603,-266.72,0,-2.0684e-06,-0.0064574,0,0.44091,1,298,1.5752e-05,1.1688,6.2104e-05,0.0016752,9.8285,15.414,1,0.24542,8,0.24542,0
+1e+05,1.2492,5.3251e-06,0,0.4477,0.020005,0,0.0064733,-514.17,0,-1.2986e-06,-0.0064708,0,0.44091,1,298,1.5752e-05,1.1688,2.2102e-05,0.001178,8.619,10.84,1,0.24567,8,0.24567,0
+1e+05,1.2492,5.3251e-06,0,0.4477,0.020005,0,0.0064733,-514.17,0,-1.2986e-06,-0.0064708,0,0.44091,1,298,1.5752e-05,1.1688,2.2102e-05,0.001178,8.619,10.84,1,0.24591,8,0.24591,0
+1e+05,0.95585,2.7166e-06,0,0.34257,0.010206,0,0.0060884,-909.87,0,-6.6179e-07,-0.0060865,0,0.44091,1,298,1.5752e-05,1.1688,4.4302e-06,0.00076375,6.595,7.0274,1,0.24616,8,0.24616,0
+1e+05,0.5581,9.5165e-07,0,0.20002,0.0035752,0,0.0039436,-1231.1,0,-2.306e-07,-0.0039425,0,0.44091,1,298,1.5752e-05,1.1688,4.6919e-07,0.00041849,3.8506,3.8506,1,0.24641,8,0.24641,0
+1e+05,0.17658,1.6647e-07,0,0.063284,0.0006254,0,0.0012733,-1333.6,0,-4.0203e-08,-0.0012729,0,0.44091,1,298,1.5752e-05,1.1688,4.2277e-09,0.00013078,1.2183,1.2033,1,0.24665,8,0.24665,0
+1e+05,0.17658,1.6647e-07,0,0.063284,0.0006254,0,0.0012733,-1333.6,0,-4.0203e-08,-0.0012729,0,0.44091,1,298,1.5752e-05,1.1688,4.2277e-09,0.00013078,1.2183,1.2033,1,0.2469,8,0.2469,0
diff --git a/test/freeflow/rans/pipelauferproblem.hh b/test/freeflow/rans/pipelauferproblem.hh
index 379b9139c3..b855873c9b 100644
--- a/test/freeflow/rans/pipelauferproblem.hh
+++ b/test/freeflow/rans/pipelauferproblem.hh
@@ -43,6 +43,9 @@
 #elif KOMEGA
 #include <dumux/freeflow/rans/twoeq/komega/model.hh>
 #include <dumux/freeflow/rans/twoeq/komega/problem.hh>
+#elif ONEEQ
+#include <dumux/freeflow/rans/oneeq/model.hh>
+#include <dumux/freeflow/rans/oneeq/problem.hh>
 #else
 #include <dumux/freeflow/rans/zeroeq/model.hh>
 #include <dumux/freeflow/rans/zeroeq/problem.hh>
@@ -64,6 +67,8 @@ NEW_TYPE_TAG(PipeLauferProblem, INHERITS_FROM(StaggeredFreeFlowModel, LowReKEpsi
 NEW_TYPE_TAG(PipeLauferProblem, INHERITS_FROM(StaggeredFreeFlowModel, KEpsilon));
 #elif KOMEGA
 NEW_TYPE_TAG(PipeLauferProblem, INHERITS_FROM(StaggeredFreeFlowModel, KOmega));
+#elif ONEEQ
+NEW_TYPE_TAG(PipeLauferProblem, INHERITS_FROM(StaggeredFreeFlowModel, OneEq));
 #else
 NEW_TYPE_TAG(PipeLauferProblem, INHERITS_FROM(StaggeredFreeFlowModel, ZeroEq));
 #endif
@@ -109,6 +114,10 @@ class PipeLauferProblem : public KEpsilonProblem<TypeTag>
 class PipeLauferProblem : public KOmegaProblem<TypeTag>
 {
     using ParentType = KOmegaProblem<TypeTag>;
+#elif ONEEQ
+class PipeLauferProblem : public OneEqProblem<TypeTag>
+{
+    using ParentType = OneEqProblem<TypeTag>;
 #else
 class PipeLauferProblem : public ZeroEqProblem<TypeTag>
 {
@@ -143,7 +152,7 @@ public:
         inletTemperature_ = getParam<Scalar>("Problem.InletTemperature", 283.15);
         wallTemperature_ = getParam<Scalar>("Problem.WallTemperature", 323.15);
         sandGrainRoughness_ = getParam<Scalar>("Problem.SandGrainRoughness", 0.0);
-        startWithZeroVelocity_ = getParam<bool>("RANS.StartWithZeroVelocity", false);
+        startWithZeroVelocity_ = getParam<bool>("Problem.StartWithZeroVelocity", false);
 
         FluidSystem::init();
         Dumux::TurbulenceProperties<Scalar, dimWorld, true> turbulenceProperties;
@@ -244,12 +253,14 @@ public:
 #if LOWREKEPSILON || KEPSILON || KOMEGA
             values.setDirichlet(Indices::turbulentKineticEnergyIdx);
             values.setDirichlet(Indices::dissipationIdx);
-
+#endif
 #if KOMEGA
             // set a fixed dissipation (omega) in one cell
             if (isOnWall(globalPos))
                 values.setDirichletCell(Indices::dissipationIdx);
 #endif
+#if ONEEQ
+            values.setDirichlet(Indices::viscosityTildeIdx);
 #endif
         }
         return values;
@@ -325,12 +336,20 @@ public:
 #endif
 
 #if LOWREKEPSILON || KEPSILON || KOMEGA
-        values[Indices::turbulentKineticEnergyEqIdx] = turbulentKineticEnergy_;
-        values[Indices::dissipationEqIdx] = dissipation_;
+        values[Indices::turbulentKineticEnergyIdx] = turbulentKineticEnergy_;
+        values[Indices::dissipationIdx] = dissipation_;
+        if (isOnWall(globalPos))
+        {
+            values[Indices::turbulentKineticEnergyIdx] = 0.0;
+            values[Indices::dissipationIdx] = 0.0;
+        }
+#endif
+
+#if ONEEQ
+        values[Indices::viscosityTildeIdx] = viscosityTilde_;
         if (isOnWall(globalPos))
         {
-            values[Indices::turbulentKineticEnergyEqIdx] = 0.0;
-            values[Indices::dissipationEqIdx] = 0.0;
+            values[Indices::viscosityTildeIdx] = 0.0;
         }
 #endif
 
diff --git a/test/freeflow/rans/test_pipe_laufer.cc b/test/freeflow/rans/test_pipe_laufer.cc
index f95b541544..68daca9b0a 100644
--- a/test/freeflow/rans/test_pipe_laufer.cc
+++ b/test/freeflow/rans/test_pipe_laufer.cc
@@ -252,6 +252,9 @@ int main(int argc, char** argv) try
 #elif KOMEGA
             gnuplot_lawOfTheWall.addFileToPlot("pdelab-komega.csv", "u 24:23 w l lw 2 t 'PDELab k-omega'");
             gnuplot_lawOfTheWall.addFileToPlot(std::string(fileName) + ".csv", "u 12:13 w l lc 7");
+#elif ONEEQ
+            gnuplot_lawOfTheWall.addFileToPlot("pdelab-oneeq.csv", "u 22:21 w l lw 2 t 'PDELab 1-Eq.'");
+            gnuplot_lawOfTheWall.addFileToPlot(std::string(fileName) + ".csv", "u 12:13 w l lc 7");
 #else
             gnuplot_lawOfTheWall.addFileToPlot("pdelab-zeroeq.csv", "u 22:21 w l lw 2 t 'PDELab 0-Eq.'");
             gnuplot_lawOfTheWall.addFileToPlot(std::string(fileName) + ".csv", "u 12:13 w l lc 7");
@@ -276,6 +279,9 @@ int main(int argc, char** argv) try
 #elif KOMEGA
             gnuplot_velocityProfile.addFileToPlot("pdelab-komega.csv", "u 5:($29/0.2456) w l lw 2 t 'PDELab k-omega'");
             gnuplot_velocityProfile.addFileToPlot(std::string(fileName) + ".csv", "u 7:($26/0.2456) w l lc 7");
+#elif ONEEQ
+            gnuplot_velocityProfile.addFileToPlot("pdelab-oneeq.csv", "u 5:($26/0.2456) w l lw 2 t 'PDELab 1-Eq.'");
+            gnuplot_velocityProfile.addFileToPlot(std::string(fileName) + ".csv", "u 7:($25/0.2456) w l lc 7");
 #else
             gnuplot_velocityProfile.addFileToPlot("pdelab-zeroeq.csv", "u 5:($26/0.2456) w l lw 2 t 'PDELab 0-Eq.'");
             gnuplot_velocityProfile.addFileToPlot(std::string(fileName) + ".csv", "u 7:($24/0.2456) w l lc 7");
-- 
GitLab