From 358db0fe3fdc16e4d5317b5f024f5a7a7df51087 Mon Sep 17 00:00:00 2001
From: Thomas Fetzer <thomas.fetzer@iws.uni-stuttgart.de>
Date: Thu, 15 Mar 2018 13:19:06 +0100
Subject: [PATCH] [zeroeq] Implement Baldwin-Lomax model

---
 doc/handbook/dumux-handbook.bib               |  11 +
 dumux/common/parameters.hh                    |   1 +
 dumux/freeflow/rans/problem.hh                |  45 +-
 dumux/freeflow/rans/zeroeq/indices.hh         |   1 +
 dumux/freeflow/rans/zeroeq/model.hh           |   1 +
 dumux/freeflow/rans/zeroeq/problem.hh         | 290 ++++++++
 dumux/freeflow/rans/zeroeq/volumevariables.hh |  22 +-
 test/freeflow/rans/pipelauferproblem.hh       |   6 +-
 test/freeflow/rans/test_pipe_laufer.cc        |   2 +-
 test/freeflow/rans/test_pipe_laufer.input     |   2 +-
 .../rans/test_pipe_laufer_reference.input     |   2 +-
 test/references/pipe_laufer_zeroeq.vtu        | 692 +++++++++++-------
 12 files changed, 759 insertions(+), 316 deletions(-)
 create mode 100644 dumux/freeflow/rans/zeroeq/problem.hh

diff --git a/doc/handbook/dumux-handbook.bib b/doc/handbook/dumux-handbook.bib
index f004e0e7fb..76dd9237c9 100644
--- a/doc/handbook/dumux-handbook.bib
+++ b/doc/handbook/dumux-handbook.bib
@@ -1621,3 +1621,14 @@ url={http://dx.doi.org/10.1007/s11242-015-0599-1}
   doi =       {10.2514/8.3713},
   url =       {http://dx.doi.org/10.2514/8.3713}
 }
+
+@Article{Baldwin1978a,
+  author =    {B. S. Baldwin and H. Lomax},
+  title =     {{Thin Layer Approximation and Algebraic Model for Seperated Turbulent Flows}},
+  journal =   {ACM Trans Math Software},
+  year =      {1978},
+  volume =    {78--257},
+  pages =     {1--9},
+  doi =       {10.2514/6.1978-257},
+  url =       {http://dx.doi.org/10.2514/6.1978-257}
+}
diff --git a/dumux/common/parameters.hh b/dumux/common/parameters.hh
index d2d56a6546..800f08248e 100644
--- a/dumux/common/parameters.hh
+++ b/dumux/common/parameters.hh
@@ -264,6 +264,7 @@ private:
         params["RANS.KarmanConstant"] = "0.41";
         params["RANS.FlowNormalAxis"] = "0";
         params["RANS.WallNormalAxis"] = "1";
+        params["RANS.EddyViscosityModel"] = "1";
     }
 };
 
diff --git a/dumux/freeflow/rans/problem.hh b/dumux/freeflow/rans/problem.hh
index be00967907..5391a6f819 100644
--- a/dumux/freeflow/rans/problem.hh
+++ b/dumux/freeflow/rans/problem.hh
@@ -48,9 +48,9 @@ namespace Dumux
  * Includes a specialized method used only by the staggered grid discretization.
  */
 template<class TypeTag>
-class RANSProblem : public NavierStokesParentProblem<TypeTag>
+class RANSProblem : public NavierStokesProblem<TypeTag>
 {
-    using ParentType = NavierStokesParentProblem<TypeTag>;
+    using ParentType = NavierStokesProblem<TypeTag>;
     using Implementation = typename GET_PROP_TYPE(TypeTag, Problem);
 
     using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
@@ -90,7 +90,7 @@ public:
         if (getParamFromGroup<bool>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "Problem.EnableGravity"))
             gravity_[dim-1]  = -9.81;
 
-        asImp_().updateStaticWallProperties();
+        updateStaticWallProperties();
     }
 
     /*!
@@ -106,20 +106,14 @@ public:
 
         // update size and initial values of the global vectors
         wallElementIDs_.resize(this->fvGridGeometry().elementMapper().size());
-        wallDistances_.resize(this->fvGridGeometry().elementMapper().size());
+        wallDistances_.resize(this->fvGridGeometry().elementMapper().size(), std::numeric_limits<Scalar>::max());
         neighborIDs_.resize(this->fvGridGeometry().elementMapper().size());
-        cellCenters_.resize(this->fvGridGeometry().elementMapper().size());
-        velocity_.resize(this->fvGridGeometry().elementMapper().size());
-        velocityGradients_.resize(this->fvGridGeometry().elementMapper().size());
-        kinematicViscosity_.resize(this->fvGridGeometry().elementMapper().size());
-        for (unsigned int i = 0; i < wallElementIDs_.size(); ++i)
-        {
-            wallDistances_[i] = std::numeric_limits<Scalar>::max();
-            cellCenters_[i] = GlobalPosition(0.0);
-            velocity_[i] = DimVector(0.0);
-            velocityGradients_[i] = DimMatrix(0.0);
-            kinematicViscosity_[i] = 0.0;
-        }
+        cellCenters_.resize(this->fvGridGeometry().elementMapper().size(), GlobalPosition(0.0));
+        velocity_.resize(this->fvGridGeometry().elementMapper().size(), DimVector(0.0));
+        velocityMaximum_.resize(this->fvGridGeometry().elementMapper().size(), DimVector(0.0));
+        velocityMinimum_.resize(this->fvGridGeometry().elementMapper().size(), DimVector(std::numeric_limits<Scalar>::max()));
+        velocityGradients_.resize(this->fvGridGeometry().elementMapper().size(), DimMatrix(0.0));
+        kinematicViscosity_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
 
         // retrieve all wall intersections and corresponding elements
         std::vector<unsigned int> wallElements;
@@ -190,8 +184,6 @@ public:
         }
     }
 
-
-
     /*!
      * \brief Update the dynamic (solution dependent) relations to the walls
      *
@@ -203,6 +195,8 @@ public:
      */
     void updateDynamicWallProperties(const SolutionVector& curSol) const
     {
+        using std::max;
+        using std::min;
         std::cout << "Update dynamic wall properties." << std::endl;
 
         // calculate cell-center-averaged velocities
@@ -224,10 +218,12 @@ public:
                 velocity_[elementID][dimIdx] = velocityTemp[dimIdx] * 0.5; // faces are equidistant to cell center
         }
 
-        // calculate cell-center-averaged velocity gradients
+        // 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);
+            unsigned int wallElementID = wallElementIDs_[elementID];
+
             for (unsigned int dimIdx = 0; dimIdx < dim; ++dimIdx)
             {
                 for (unsigned int velIdx = 0; velIdx < dim; ++velIdx)
@@ -238,6 +234,15 @@ public:
                           / (cellCenters_[neighborIDs_[elementID][dimIdx][1]][dimIdx]
                               - cellCenters_[neighborIDs_[elementID][dimIdx][0]][dimIdx]);
                 }
+
+                if (abs(velocity_[elementID][dimIdx]) > abs(velocityMaximum_[wallElementID][dimIdx]))
+                {
+                    velocityMaximum_[wallElementID][dimIdx] = velocity_[elementID][dimIdx];
+                }
+                if (abs(velocity_[elementID][dimIdx]) < abs(velocityMinimum_[wallElementID][dimIdx]))
+                {
+                    velocityMinimum_[wallElementID][dimIdx] = velocity_[elementID][dimIdx];
+                }
             }
         }
 
@@ -318,6 +323,8 @@ public:
     mutable std::vector<std::array<std::array<unsigned int, 2>, dim>> neighborIDs_;
     mutable std::vector<GlobalPosition> cellCenters_;
     mutable std::vector<DimVector> velocity_;
+    mutable std::vector<DimVector> velocityMaximum_;
+    mutable std::vector<DimVector> velocityMinimum_;
     mutable std::vector<DimMatrix> velocityGradients_;
     mutable std::vector<Scalar> kinematicViscosity_;
 
diff --git a/dumux/freeflow/rans/zeroeq/indices.hh b/dumux/freeflow/rans/zeroeq/indices.hh
index e37c261077..4cd6b208df 100644
--- a/dumux/freeflow/rans/zeroeq/indices.hh
+++ b/dumux/freeflow/rans/zeroeq/indices.hh
@@ -44,6 +44,7 @@ struct ZeroEqIndices
     static constexpr int noEddyViscosityModel = 0;
     static constexpr int prandtl = 1;
     static constexpr int modifiedVanDriest = 2;
+    static constexpr int baldwinLomax = 3;
 };
 
 // \}
diff --git a/dumux/freeflow/rans/zeroeq/model.hh b/dumux/freeflow/rans/zeroeq/model.hh
index 56a0acf0c8..e76bf11442 100644
--- a/dumux/freeflow/rans/zeroeq/model.hh
+++ b/dumux/freeflow/rans/zeroeq/model.hh
@@ -29,6 +29,7 @@
  * The following models are available:
  *  -# Prandtl's mixing length, e.g. \cite Oertel2012a
  *  -# Van-Driest modification, \cite vanDriest1956a and \cite Hanna1981a
+ *  -# Baldwin-Lomax, \cite Baldwin1978a
  */
 
 #ifndef DUMUX_ZEROEQ_MODEL_HH
diff --git a/dumux/freeflow/rans/zeroeq/problem.hh b/dumux/freeflow/rans/zeroeq/problem.hh
new file mode 100644
index 0000000000..5e2705d1fe
--- /dev/null
+++ b/dumux/freeflow/rans/zeroeq/problem.hh
@@ -0,0 +1,290 @@
+// -*- 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 ZeroEqModel
+ * \copydoc Dumux::ZeroEqProblem
+ */
+#ifndef DUMUX_ZEROEQ_PROBLEM_HH
+#define DUMUX_ZEROEQ_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 ZeroEqModel
+ * \brief Zero-equation turbulence problem base class.
+ *
+ * This implements some base functionality for zero-equation models.
+ * \todo please doc me
+ */
+template<class TypeTag>
+class ZeroEqProblem : 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 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, Indices);
+
+    enum {
+        dim = Grid::dimension,
+      };
+    using GlobalPosition = Dune::FieldVector<Scalar, dim>;
+    using DimVector = Dune::FieldVector<Scalar, dim>;
+    using DimMatrix = Dune::FieldMatrix<Scalar, dim, dim>;
+
+    enum {
+        massBalanceIdx = Indices::massBalanceIdx,
+        momentumBalanceIdx = Indices::momentumBalanceIdx
+    };
+
+    using DofTypeIndices = typename GET_PROP(TypeTag, DofTypeIndices);
+    typename DofTypeIndices::CellCenterIdx cellCenterIdx;
+    typename DofTypeIndices::FaceIdx faceIdx;
+
+public:
+    //! The constructor sets the gravity, if desired by the user.
+    ZeroEqProblem(std::shared_ptr<const FVGridGeometry> fvGridGeometry)
+    : ParentType(fvGridGeometry)
+    {
+        if (getParamFromGroup<bool>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "Problem.EnableGravity"))
+            gravity_[dim-1]  = -9.81;
+
+        updateStaticWallProperties();
+    }
+
+    /*!
+     * \brief Update the static (solution independent) relations to the walls
+     *
+     * This function determines all element with a wall intersection,
+     * the wall distances and the relation to the neighboring elements.
+     */
+    void updateStaticWallProperties() const
+    {
+        std::cout << "Update static wall properties2. " << this->fvGridGeometry().elementMapper().size();
+        // update size and initial values of the global vectors
+        kinematicEddyViscosity_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+        std::cout << " " << kinematicEddyViscosity_.size();
+    }
+
+    /*!
+     * \brief Update the dynamic (solution dependent) relations to the walls
+     *
+     * \todo please doc me
+     *
+     * \param curSol The solution vector.
+     */
+    void updateDynamicWallProperties(const SolutionVector& curSol) const
+    {
+        ParentType::updateDynamicWallProperties(curSol);
+
+        std::cout << "Update dynamic wall properties2. " << kinematicEddyViscosity_.size() << std::endl << std::flush;
+
+//         kinematicEddyViscosity_.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+
+        std::vector<Scalar> kinematicEddyViscosityInner(this->fvGridGeometry().elementMapper().size(), 0.0);
+        std::vector<Scalar> kinematicEddyViscosityOuter(this->fvGridGeometry().elementMapper().size(), 0.0);
+        std::vector<Scalar> kinematicEddyViscosityDifference(this->fvGridGeometry().elementMapper().size(), 0.0);
+        std::vector<Scalar> switchingPosition(this->fvGridGeometry().elementMapper().size(), std::numeric_limits<Scalar>::max());
+
+        static const int eddyViscosityModel
+            = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.EddyViscosityModel");
+        if (eddyViscosityModel != Indices::baldwinLomax)
+            return;
+
+        using std::abs;
+        using std::exp;
+        using std::min;
+        using std::pow;
+        using std::sqrt;
+        const Scalar aPlus = 26.0;
+        const Scalar k = 0.0168;
+        const Scalar cCP = 1.6;
+        const Scalar cWake = 0.25;
+        const Scalar cKleb = 0.3;
+
+        static const Scalar karmanConstant
+            = getParamFromGroup<Scalar>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.KarmanConstant");
+        static const int flowNormalAxis
+            = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.FlowNormalAxis");
+        static const int wallNormalAxis
+            = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.WallNormalAxis");
+
+        std::vector<Scalar> storedFMax;
+        std::vector<Scalar> storedYFMax;
+        storedFMax.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+        storedYFMax.resize(this->fvGridGeometry().elementMapper().size(), 0.0);
+
+        // (1) calculate inner viscosity and Klebanoff function
+        for (const auto& element : elements(this->fvGridGeometry().gridView()))
+        {
+            unsigned int elementID = this->fvGridGeometry().elementMapper().index(element);
+            unsigned int wallElementID = this->wallElementIDs_[elementID];
+            Scalar wallDistance = this->wallDistances_[elementID];
+
+            Scalar omegaAbs = abs(this->velocityGradients_[elementID][flowNormalAxis][wallNormalAxis]
+                                  - this->velocityGradients_[elementID][wallNormalAxis][flowNormalAxis]);
+            Scalar uStar = sqrt(this->kinematicViscosity_[wallElementID]
+                                * abs(this->velocityGradients_[wallElementID][flowNormalAxis][wallNormalAxis]));
+            Scalar yPlus = wallDistance * uStar / this->kinematicViscosity_[elementID];
+            Scalar mixingLength = karmanConstant * wallDistance * (1.0 - exp(-yPlus / aPlus));
+            kinematicEddyViscosityInner[elementID] = mixingLength * mixingLength * omegaAbs;
+
+            Scalar f = wallDistance * omegaAbs * (1.0 - exp(-yPlus / aPlus));
+            if (f > storedFMax[wallElementID])
+            {
+                storedFMax[wallElementID] = f;
+                storedYFMax[wallElementID] = wallDistance;
+            }
+        }
+
+        // (2) calculate outer viscosity
+        for (const auto& element : elements(this->fvGridGeometry().gridView()))
+        {
+            unsigned int elementID = this->fvGridGeometry().elementMapper().index(element);
+            unsigned int wallElementID = this->wallElementIDs_[elementID];
+            Scalar wallDistance = this->wallDistances_[elementID];
+
+            Scalar maxVelocityNorm = 0.0;
+            Scalar minVelocityNorm = 0.0;
+            for (unsigned dimIdx = 0; dimIdx < dim; ++dimIdx)
+            {
+                maxVelocityNorm += this->velocityMaximum_[wallElementID][dimIdx]
+                                   * this->velocityMaximum_[wallElementID][dimIdx];
+                minVelocityNorm += this->velocityMinimum_[wallElementID][dimIdx]
+                                   * this->velocityMinimum_[wallElementID][dimIdx];
+            }
+            Scalar deltaU = sqrt(maxVelocityNorm) - sqrt(minVelocityNorm);
+            Scalar yFMax = storedYFMax[wallElementID];
+            Scalar fMax = storedFMax[wallElementID];
+            Scalar fWake = min(yFMax * fMax, cWake * yFMax * deltaU * deltaU / fMax);
+            Scalar fKleb = 1.0 / (1.0 + 5.5 * pow(cKleb * wallDistance / yFMax, 6.0));
+            kinematicEddyViscosityOuter[elementID] = k * cCP * fWake * fKleb;
+
+            kinematicEddyViscosityDifference[elementID]
+              = kinematicEddyViscosityInner[elementID] - kinematicEddyViscosityOuter[elementID];
+        }
+
+        // (3) switching point
+        for (const auto& element : elements(this->fvGridGeometry().gridView()))
+        {
+            unsigned int elementID = this->fvGridGeometry().elementMapper().index(element);
+            unsigned int wallElementID = this->wallElementIDs_[elementID];
+            Scalar wallDistance = this->wallDistances_[elementID];
+
+            // checks if sign switches, by multiplication
+            Scalar check = kinematicEddyViscosityDifference[wallElementID] * kinematicEddyViscosityDifference[elementID];
+            if (check < 0 // means sign has switched
+                && switchingPosition[wallElementID] > wallDistance)
+            {
+                switchingPosition[wallElementID] = wallDistance;
+            }
+        }
+
+        // (4) finally determine eddy viscosity
+        for (const auto& element : elements(this->fvGridGeometry().gridView()))
+        {
+            unsigned int elementID = this->fvGridGeometry().elementMapper().index(element);
+            unsigned int wallElementID = this->wallElementIDs_[elementID];
+            Scalar wallDistance = this->wallDistances_[elementID];
+
+            kinematicEddyViscosity_[elementID] = (wallDistance >= switchingPosition[wallElementID])
+                                                 ? kinematicEddyViscosityOuter[elementID]
+                                                 : kinematicEddyViscosityInner[elementID];
+        }
+    }
+
+    /*!
+     * \brief Returns the temperature \f$\mathrm{[K]}\f$ at a given global position.
+     *
+     * This is not specific to the discretization. By default it just
+     * calls temperature().
+     *
+     * \param globalPos The position in global coordinates where the temperature should be specified.
+     */
+    Scalar temperatureAtPos(const GlobalPosition &globalPos) const
+    { return asImp_().temperature(); }
+
+    /*!
+     * \brief Returns the temperature within the domain.
+     *
+     * This method MUST be overwritten by the actual problem.
+     */
+    Scalar temperature() const
+    { DUNE_THROW(Dune::NotImplemented, "temperature() method not implemented by the actual problem"); }
+
+    /*!
+     * \brief Returns the acceleration due to gravity.
+     *
+     * If the <tt>Problem.EnableGravity</tt> parameter is true, this means
+     * \f$\boldsymbol{g} = ( 0,\dots,\ -9.81)^T \f$, else \f$\boldsymbol{g} = ( 0,\dots, 0)^T \f$
+     */
+    const GlobalPosition &gravity() const
+    { return gravity_; }
+
+    //! Applys the initial face solution (velocities on the faces). Specialization for staggered grid discretization.
+    template <class T = TypeTag>
+    typename std::enable_if<GET_PROP_TYPE(T, FVGridGeometry)::discMethod == DiscretizationMethod::staggered, void>::type
+    applyInititalFaceSolution(SolutionVector& sol,
+                              const SubControlVolumeFace& scvf,
+                              const PrimaryVariables& initSol) const
+    {
+        typename GET_PROP(TypeTag, DofTypeIndices)::FaceIdx faceIdx;
+        const auto numEqCellCenter = GET_PROP_VALUE(TypeTag, NumEqCellCenter);
+        sol[faceIdx][scvf.dofIndex()][numEqCellCenter] = initSol[Indices::velocity(scvf.directionIndex())];
+    }
+
+public:
+    mutable std::vector<Scalar> kinematicEddyViscosity_;
+
+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); }
+
+    GlobalPosition gravity_;
+};
+
+}
+
+#endif
diff --git a/dumux/freeflow/rans/zeroeq/volumevariables.hh b/dumux/freeflow/rans/zeroeq/volumevariables.hh
index 4dcc3abf77..f0ae5780fb 100644
--- a/dumux/freeflow/rans/zeroeq/volumevariables.hh
+++ b/dumux/freeflow/rans/zeroeq/volumevariables.hh
@@ -103,14 +103,15 @@ public:
         using std::exp;
         using std::sqrt;
         Scalar kinematicEddyViscosity = 0.0;
-        static const Scalar karmanConstant = getParamFromGroup<Scalar>(GET_PROP_VALUE(TypeTag, ModelParameterGroup),
-                                                                       "RANS.KarmanConstant");
-        static const int flowNormalAxis = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup),
-                                                                 "RANS.FlowNormalAxis");
-        static const int wallNormalAxis = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup),
-                                                                 "RANS.WallNormalAxis");
-        static const int eddyViscosityModel = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup),
-                                                                     "RANS.EddyViscosityModel", 1);
+        static const Scalar karmanConstant
+            = getParamFromGroup<Scalar>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.KarmanConstant");
+        static const int flowNormalAxis
+            = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.FlowNormalAxis");
+        static const int wallNormalAxis
+            = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.WallNormalAxis");
+        static const int eddyViscosityModel
+            = getParamFromGroup<int>(GET_PROP_VALUE(TypeTag, ModelParameterGroup), "RANS.EddyViscosityModel");
+
         Scalar velGrad = abs(asImp_().velocityGradients()[flowNormalAxis][wallNormalAxis]);
         if (eddyViscosityModel == Indices::noEddyViscosityModel)
         {
@@ -128,6 +129,11 @@ public:
                                   / sqrt(1.0 - exp(-0.26 * asImp_().yPlus()));
             kinematicEddyViscosity = mixingLength * mixingLength * velGrad;
         }
+        else if (eddyViscosityModel == Indices::baldwinLomax)
+        {
+            unsigned int elementID = problem.fvGridGeometry().elementMapper().index(element);
+            kinematicEddyViscosity = problem.kinematicEddyViscosity_[elementID];
+        }
         else
         {
             DUNE_THROW(Dune::NotImplemented,
diff --git a/test/freeflow/rans/pipelauferproblem.hh b/test/freeflow/rans/pipelauferproblem.hh
index f1117543c3..a9b0e0c68b 100644
--- a/test/freeflow/rans/pipelauferproblem.hh
+++ b/test/freeflow/rans/pipelauferproblem.hh
@@ -31,7 +31,7 @@
 #include <dumux/material/components/air.hh>
 
 #include <dumux/freeflow/rans/zeroeq/model.hh>
-#include <dumux/freeflow/rans/problem.hh>
+#include <dumux/freeflow/rans/zeroeq/problem.hh>
 #include <dumux/discretization/staggered/freeflow/properties.hh>
 
 namespace Dumux
@@ -71,9 +71,9 @@ SET_BOOL_PROP(PipeLauferProblem, EnableGridVolumeVariablesCache, true);
  * John Laufers experiments in 1954 \cite Laufer1954a.
  */
 template <class TypeTag>
-class PipeLauferProblem : public RANSProblem<TypeTag>
+class PipeLauferProblem : public ZeroEqProblem<TypeTag>
 {
-    using ParentType = RANSProblem<TypeTag>;
+    using ParentType = ZeroEqProblem<TypeTag>;
 
     using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
     using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
diff --git a/test/freeflow/rans/test_pipe_laufer.cc b/test/freeflow/rans/test_pipe_laufer.cc
index a166c766e6..afd6e99c46 100644
--- a/test/freeflow/rans/test_pipe_laufer.cc
+++ b/test/freeflow/rans/test_pipe_laufer.cc
@@ -228,7 +228,7 @@ int main(int argc, char** argv) try
 
 
         char gnuplotFileName[255];
-        Dumux::GnuplotInterface<double> gnuplot;
+        Dumux::GnuplotInterface<Scalar> gnuplot;
         sprintf(gnuplotFileName, fileNameFormat.c_str(), "velProfiles", timeLoop->timeStepIndex());
         gnuplot.setOpenPlotWindow(shouldPlot);
         gnuplot.setDatafileSeparator(',');
diff --git a/test/freeflow/rans/test_pipe_laufer.input b/test/freeflow/rans/test_pipe_laufer.input
index 6038fce674..f507011c75 100644
--- a/test/freeflow/rans/test_pipe_laufer.input
+++ b/test/freeflow/rans/test_pipe_laufer.input
@@ -19,7 +19,7 @@ InletVelocity = 2.5 # [m/s]
 EnableGravity = false
 
 [RANS]
-EddyViscosityModel = 2
+EddyViscosityModel = 3
 
 [Newton]
 MaxSteps = 10
diff --git a/test/freeflow/rans/test_pipe_laufer_reference.input b/test/freeflow/rans/test_pipe_laufer_reference.input
index d6c8517bce..e33bbd4ca2 100644
--- a/test/freeflow/rans/test_pipe_laufer_reference.input
+++ b/test/freeflow/rans/test_pipe_laufer_reference.input
@@ -16,7 +16,7 @@ InletVelocity = 2.5 # [m/s]
 EnableGravity = false
 
 [RANS]
-EddyViscosityModel = 2
+EddyViscosityModel = 3
 
 [Newton]
 MaxSteps = 10
diff --git a/test/references/pipe_laufer_zeroeq.vtu b/test/references/pipe_laufer_zeroeq.vtu
index 2cdbbc2198..1fb68ef623 100644
--- a/test/references/pipe_laufer_zeroeq.vtu
+++ b/test/references/pipe_laufer_zeroeq.vtu
@@ -2,198 +2,126 @@
 <VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
   <UnstructuredGrid>
     <Piece NumberOfCells="256" NumberOfPoints="289">
-      <CellData Scalars="v_x [m/s]" Vectors="velocity_Air (m/s)">
-        <DataArray type="Float32" Name="v_x [m/s]" NumberOfComponents="1" format="ascii">
-          2.13262 1.63378 1.45626 1.38858 1.35497 1.33575 1.32409 1.31686 1.31236 1.30956 1.30784 1.30678
-          1.30613 1.30574 1.3055 1.30538 2.39901 2.2134 2.08512 2.01841 1.98203 1.9606 1.94746 1.93928
-          1.93418 1.93102 1.92908 1.92788 1.92716 1.92671 1.92645 1.92631 2.47479 2.40124 2.31871 2.26406
-          2.23121 2.21114 2.19866 2.19086 2.186 2.183 2.18115 2.18002 2.17933 2.17891 2.17866 2.17853
-          2.50434 2.48826 2.44523 2.4065 2.37998 2.36291 2.35209 2.3453 2.34107 2.33846 2.33685 2.33588
-          2.33528 2.33493 2.33471 2.33459 2.51624 2.53246 2.52257 2.50271 2.48538 2.47312 2.46507 2.45997
-          2.45679 2.45484 2.45365 2.45293 2.45249 2.45223 2.45207 2.45199 2.52012 2.55287 2.56821 2.56879
-          2.56382 2.55873 2.55502 2.5526 2.55111 2.55021 2.54967 2.54935 2.54916 2.54905 2.54898 2.54894
-          2.5208 2.55946 2.58949 2.60829 2.61802 2.62258 2.6248 2.62603 2.62678 2.62726 2.62756 2.62776
-          2.62788 2.62796 2.62801 2.62804 2.52078 2.56038 2.59515 2.62419 2.64713 2.66379 2.67503 2.68225
-          2.68674 2.6895 2.69118 2.69219 2.69281 2.69318 2.69341 2.69353 2.52078 2.56038 2.59515 2.62419
-          2.64713 2.66379 2.67503 2.68225 2.68674 2.6895 2.69118 2.69219 2.69281 2.69318 2.69341 2.69353
-          2.5208 2.55946 2.58949 2.60829 2.61802 2.62258 2.6248 2.62603 2.62678 2.62726 2.62756 2.62776
-          2.62788 2.62796 2.62801 2.62804 2.52012 2.55287 2.56821 2.56879 2.56382 2.55873 2.55502 2.5526
-          2.55111 2.55021 2.54967 2.54935 2.54916 2.54905 2.54898 2.54894 2.51624 2.53246 2.52257 2.50271
-          2.48538 2.47312 2.46507 2.45997 2.45679 2.45484 2.45365 2.45293 2.45249 2.45223 2.45207 2.45199
-          2.50434 2.48826 2.44523 2.4065 2.37998 2.36291 2.35209 2.3453 2.34107 2.33846 2.33685 2.33588
-          2.33528 2.33493 2.33471 2.33459 2.47479 2.40124 2.31871 2.26406 2.23121 2.21114 2.19866 2.19086
-          2.186 2.183 2.18115 2.18002 2.17933 2.17891 2.17866 2.17853 2.39901 2.2134 2.08512 2.01841
-          1.98203 1.9606 1.94746 1.93928 1.93418 1.93102 1.92908 1.92788 1.92716 1.92671 1.92645 1.92631
-          2.13262 1.63378 1.45626 1.38858 1.35497 1.33575 1.32409 1.31686 1.31236 1.30956 1.30784 1.30678
-          1.30613 1.30574 1.3055 1.30538
-        </DataArray>
-        <DataArray type="Float32" Name="dv_x/dx [m/s]" NumberOfComponents="1" format="ascii">
-          -0.798142 -0.541091 -0.196156 -0.0810303 -0.0422695 -0.0247018 -0.0151094 -0.00938475 -0.00583766 -0.00361623 -0.00222751 -0.00136475
-          -0.0008324 -0.000506099 -0.000290349 -0.000198264 -0.296984 -0.251114 -0.155987 -0.0824713 -0.0462516 -0.0276609 -0.0170579 -0.010618
-          -0.00660248 -0.00408479 -0.00251234 -0.00153694 -0.000935978 -0.000568147 -0.000325651 -0.000222419 -0.117681 -0.124867 -0.109743 -0.0699944
-          -0.0423375 -0.0260452 -0.0162235 -0.010123 -0.00629001 -0.00388436 -0.00238436 -0.0014561 -0.000885436 -0.000536889 -0.000307745 -0.000210366
-          -0.0257136 -0.0472887 -0.0654085 -0.0521929 -0.0348725 -0.0223131 -0.0140936 -0.00882044 -0.00547245 -0.00336959 -0.00206219 -0.00125612
-          -0.000762257 -0.00046149 -0.000264335 -0.000180683 0.0259567 0.00506323 -0.0238023 -0.0297549 -0.0236745 -0.0162447 -0.0105216 -0.00662312
-          -0.0040996 -0.00251139 -0.00152864 -0.000926678 -0.000560111 -0.000337991 -0.000193052 -0.000131705 0.0524063 0.038471 0.0127365 -0.0035053
-          -0.00804526 -0.00704689 -0.00490602 -0.00312172 -0.00191103 -0.00115095 -0.000688913 -0.000411542 -0.000245603 -0.000146495 -8.26616e-05 -5.58264e-05
-          0.0618537 0.0549512 0.0390662 0.0228294 0.011431 0.00541931 0.0027574 0.00158279 0.000985235 0.00063049 0.000403254 0.000255612
-          0.000160656 0.000100614 6.00179e-05 4.25075e-05 0.0633621 0.0594958 0.0510434 0.0415798 0.0316824 0.0223245 0.0147636 0.00936588
-          0.00580116 0.00354804 0.00215658 0.00130729 0.000791855 0.000480304 0.000277301 0.000191428 0.0633621 0.0594958 0.0510434 0.0415798
-          0.0316824 0.0223245 0.0147636 0.00936588 0.00580116 0.00354804 0.00215658 0.00130729 0.000791855 0.000480304 0.000277301 0.000191428
-          0.0618537 0.0549512 0.0390662 0.0228294 0.011431 0.00541931 0.0027574 0.00158279 0.000985235 0.00063049 0.000403254 0.000255612
-          0.000160656 0.000100614 6.00179e-05 4.25075e-05 0.0524063 0.038471 0.0127365 -0.0035053 -0.00804526 -0.00704689 -0.00490602 -0.00312172
-          -0.00191103 -0.00115095 -0.000688913 -0.000411542 -0.000245603 -0.000146495 -8.26616e-05 -5.58264e-05 0.0259567 0.00506323 -0.0238023 -0.0297549
-          -0.0236745 -0.0162447 -0.0105216 -0.00662312 -0.0040996 -0.00251139 -0.00152864 -0.000926678 -0.000560111 -0.000337991 -0.000193052 -0.000131705
-          -0.0257136 -0.0472887 -0.0654085 -0.0521929 -0.0348725 -0.0223131 -0.0140936 -0.00882044 -0.00547245 -0.00336959 -0.00206219 -0.00125612
-          -0.000762257 -0.00046149 -0.000264335 -0.000180683 -0.117681 -0.124867 -0.109743 -0.0699944 -0.0423375 -0.0260452 -0.0162235 -0.010123
-          -0.00629001 -0.00388436 -0.00238436 -0.0014561 -0.000885436 -0.000536889 -0.000307745 -0.000210366 -0.296984 -0.251114 -0.155987 -0.0824713
-          -0.0462516 -0.0276609 -0.0170579 -0.010618 -0.00660248 -0.00408479 -0.00251234 -0.00153694 -0.000935978 -0.000568147 -0.000325651 -0.000222419
-          -0.798142 -0.541091 -0.196156 -0.0810303 -0.0422695 -0.0247018 -0.0151094 -0.00938475 -0.00583766 -0.00361623 -0.00222751 -0.00136475
-          -0.0008324 -0.000506099 -0.000290349 -0.000198264
-        </DataArray>
-        <DataArray type="Float32" Name="dv_x/dy [m/s]" NumberOfComponents="1" format="ascii">
-          61.8508 134.574 146.008 146.232 145.59 145.076 144.731 144.511 144.373 144.289 144.237 144.206
-          144.188 144.176 144.17 144.166 33.1019 74.2445 83.434 84.694 84.7685 84.6858 84.6061 84.5511
-          84.5168 84.4964 84.4844 84.4774 84.4733 84.471 84.4696 84.4689 7.27781 18.9933 24.8833 26.8171
-          27.4986 27.8 27.9605 28.056 28.1158 28.1536 28.1775 28.1925 28.2018 28.2075 28.211 28.2128
-          2.04588 6.47686 10.0622 11.7791 12.5448 12.9306 13.1495 13.2824 13.3654 13.4175 13.4501 13.4703
-          13.4828 13.4904 13.495 13.4975 0.556356 2.27769 4.33571 5.72147 6.48133 6.90373 7.1541 7.30862
-          7.40523 7.46557 7.50301 7.52608 7.54023 7.54885 7.55411 7.55686 0.114764 0.679746 1.68513 2.65872
-          3.34038 3.76376 4.02232 4.18176 4.28062 4.34182 4.37952 4.40263 4.41674 4.42532 4.43054 4.43329
-          0.0119999 0.135167 0.484727 0.996469 1.49843 1.88971 2.15882 2.33197 2.4396 2.50537 2.54525 2.56935
-          2.5839 2.59268 2.59799 2.60077 -0.00020848 0.0132087 0.0806389 0.226279 0.414202 0.586545 0.714942 0.800132
-          0.853401 0.885806 0.905303 0.916997 0.924012 0.928226 0.930767 0.932091 0.00020848 -0.0132087 -0.0806389 -0.226279
-          -0.414202 -0.586545 -0.714942 -0.800132 -0.853401 -0.885806 -0.905303 -0.916997 -0.924012 -0.928226 -0.930767 -0.932091
-          -0.0119999 -0.135167 -0.484727 -0.996469 -1.49843 -1.88971 -2.15882 -2.33197 -2.4396 -2.50537 -2.54525 -2.56935
-          -2.5839 -2.59268 -2.59799 -2.60077 -0.114764 -0.679746 -1.68513 -2.65872 -3.34038 -3.76376 -4.02232 -4.18176
-          -4.28062 -4.34182 -4.37952 -4.40263 -4.41674 -4.42532 -4.43054 -4.43329 -0.556356 -2.27769 -4.33571 -5.72147
-          -6.48133 -6.90373 -7.1541 -7.30862 -7.40523 -7.46557 -7.50301 -7.52608 -7.54023 -7.54885 -7.55411 -7.55686
-          -2.04588 -6.47686 -10.0622 -11.7791 -12.5448 -12.9306 -13.1495 -13.2824 -13.3654 -13.4175 -13.4501 -13.4703
-          -13.4828 -13.4904 -13.495 -13.4975 -7.27781 -18.9933 -24.8833 -26.8171 -27.4986 -27.8 -27.9605 -28.056
-          -28.1158 -28.1536 -28.1775 -28.1925 -28.2018 -28.2075 -28.211 -28.2128 -33.1019 -74.2445 -83.434 -84.694
-          -84.7685 -84.6858 -84.6061 -84.5511 -84.5168 -84.4964 -84.4844 -84.4774 -84.4733 -84.471 -84.4696 -84.4689
-          -61.8508 -134.574 -146.008 -146.232 -145.59 -145.076 -144.731 -144.511 -144.373 -144.289 -144.237 -144.206
-          -144.188 -144.176 -144.17 -144.166
-        </DataArray>
+      <CellData Scalars="p [Pa]" Vectors="v [m/s]">
         <DataArray type="Float32" Name="p [Pa]" NumberOfComponents="1" format="ascii">
-          100001 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
+          100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000 100001 100001 100001 100001 100001 100001 100001 100001
-          100001 100001 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
-          100001 100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000
-          100001 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
+          100001 100000 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
+          100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100000
+          100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000 100001 100001 100001 100001 100001 100001 100001 100001
-          100001 100001 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
-          100001 100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000
-          100001 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
+          100001 100000 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
+          100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100000
+          100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000 100001 100001 100001 100001 100001 100001 100001 100001
-          100001 100001 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
-          100001 100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000
-          100001 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
+          100001 100000 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
+          100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100000
+          100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000 100001 100001 100001 100001 100001 100001 100001 100001
-          100001 100001 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
-          100001 100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000
-          100001 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
+          100001 100000 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
+          100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100000
+          100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000 100001 100001 100001 100001 100001 100001 100001 100001
-          100001 100001 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
-          100001 100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000
-          100001 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000
+          100001 100000 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
+          100001 100001 100001 100001 100001 100000 100000 100000 100000 100000 100000 100000
+          100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000
         </DataArray>
         <DataArray type="Float32" Name="p_rel [Pa]" NumberOfComponents="1" format="ascii">
-          1.42975 1.29795 1.17912 1.07435 0.977464 0.88541 0.796564 0.70988 0.624633 0.540319 0.456597 0.373246
-          0.290126 0.207145 0.124251 0.0414125 1.42971 1.29812 1.1792 1.07438 0.97748 0.885419 0.796569 0.709884
-          0.624635 0.54032 0.456598 0.373247 0.290126 0.207146 0.124251 0.0414125 1.42955 1.29829 1.17932 1.07444
-          0.977513 0.88544 0.796582 0.709891 0.62464 0.540323 0.4566 0.373248 0.290127 0.207146 0.124252 0.0414127
-          1.42928 1.29841 1.17946 1.07453 0.977564 0.885471 0.796601 0.709904 0.624648 0.540328 0.456603 0.37325
-          0.290128 0.207147 0.124252 0.0414129 1.42892 1.2985 1.17958 1.07462 0.977627 0.885511 0.796627 0.70992
-          0.624658 0.540334 0.456607 0.373252 0.290129 0.207148 0.124253 0.0414132 1.42848 1.29858 1.1797 1.07472
-          0.977702 0.885563 0.796661 0.709942 0.624672 0.540343 0.456612 0.373256 0.290131 0.207149 0.124253 0.0414138
-          1.428 1.29866 1.1798 1.07482 0.977787 0.885629 0.796708 0.709973 0.624692 0.540355 0.45662 0.37326
-          0.290134 0.207151 0.124254 0.0414147 1.42761 1.29872 1.17989 1.07491 0.977871 0.885702 0.796763 0.710011
-          0.624717 0.540371 0.456629 0.373266 0.290138 0.207153 0.124256 0.0414158 1.42761 1.29872 1.17989 1.07491
-          0.977871 0.885702 0.796763 0.710011 0.624717 0.540371 0.456629 0.373266 0.290138 0.207153 0.124256 0.0414158
-          1.428 1.29866 1.1798 1.07482 0.977787 0.885629 0.796708 0.709973 0.624692 0.540355 0.45662 0.37326
-          0.290134 0.207151 0.124254 0.0414147 1.42848 1.29858 1.1797 1.07472 0.977702 0.885563 0.796661 0.709942
-          0.624672 0.540343 0.456612 0.373256 0.290131 0.207149 0.124253 0.0414138 1.42892 1.2985 1.17958 1.07462
-          0.977627 0.885511 0.796627 0.70992 0.624658 0.540334 0.456607 0.373252 0.290129 0.207148 0.124253 0.0414132
-          1.42928 1.29841 1.17946 1.07453 0.977564 0.885471 0.796601 0.709904 0.624648 0.540328 0.456603 0.37325
-          0.290128 0.207147 0.124252 0.0414129 1.42955 1.29829 1.17932 1.07444 0.977513 0.88544 0.796582 0.709891
-          0.62464 0.540323 0.4566 0.373248 0.290127 0.207146 0.124252 0.0414127 1.42971 1.29812 1.1792 1.07438
-          0.97748 0.885419 0.796569 0.709884 0.624635 0.54032 0.456598 0.373247 0.290126 0.207146 0.124251 0.0414125
-          1.42975 1.29795 1.17912 1.07435 0.977464 0.88541 0.796564 0.70988 0.624633 0.540319 0.456597 0.373246
-          0.290126 0.207145 0.124251 0.0414125
+          1.30543 1.17114 1.0534 0.957444 0.867397 0.780484 0.700841 0.624126 0.545742 0.467086 0.389893 0.318209
+          0.249301 0.178674 0.107209 0.0356539 1.30533 1.17127 1.05352 0.957484 0.867414 0.780489 0.700836 0.624126
+          0.545745 0.467091 0.389894 0.318207 0.249299 0.178673 0.107209 0.0356541 1.30511 1.17134 1.05363 0.957553
+          0.867444 0.780539 0.700877 0.62414 0.54576 0.467106 0.389892 0.318194 0.249292 0.178671 0.107209 0.0356545
+          1.30481 1.1714 1.05374 0.957619 0.867464 0.780612 0.700949 0.624149 0.545765 0.467108 0.38993 0.318224
+          0.249288 0.178669 0.107209 0.0356557 1.30443 1.17146 1.05384 0.957674 0.867482 0.780689 0.701023 0.624157
+          0.545771 0.46711 0.390012 0.318306 0.249288 0.178669 0.10721 0.0356575 1.30397 1.17153 1.05393 0.957711
+          0.867497 0.780761 0.70109 0.624161 0.545775 0.467112 0.390105 0.318397 0.249287 0.178668 0.107209 0.0356632
+          1.30348 1.17159 1.05403 0.95775 0.867524 0.780819 0.701128 0.624161 0.545776 0.467117 0.390202 0.318491
+          0.249283 0.178665 0.107208 0.0356817 1.30308 1.17165 1.0541 0.957778 0.867543 0.78085 0.701155 0.624172
+          0.54579 0.467135 0.390273 0.31855 0.249282 0.178664 0.107208 0.0357212 1.30308 1.17165 1.0541 0.957778
+          0.867543 0.78085 0.701155 0.624172 0.54579 0.467135 0.390273 0.31855 0.249282 0.178664 0.107208 0.0357212
+          1.30348 1.17159 1.05403 0.95775 0.867524 0.780819 0.701128 0.624161 0.545776 0.467117 0.390202 0.318491
+          0.249283 0.178665 0.107208 0.0356817 1.30397 1.17153 1.05393 0.957711 0.867497 0.780761 0.70109 0.624161
+          0.545775 0.467112 0.390105 0.318397 0.249287 0.178668 0.107209 0.0356632 1.30443 1.17146 1.05384 0.957674
+          0.867482 0.780689 0.701023 0.624157 0.545771 0.46711 0.390012 0.318306 0.249288 0.178669 0.10721 0.0356575
+          1.30481 1.1714 1.05374 0.957619 0.867464 0.780612 0.700949 0.624149 0.545765 0.467108 0.38993 0.318224
+          0.249288 0.178669 0.107209 0.0356557 1.30511 1.17134 1.05363 0.957553 0.867444 0.780539 0.700877 0.62414
+          0.54576 0.467106 0.389892 0.318194 0.249292 0.178671 0.107209 0.0356545 1.30533 1.17127 1.05352 0.957484
+          0.867414 0.780489 0.700836 0.624126 0.545745 0.467091 0.389894 0.318207 0.249299 0.178673 0.107209 0.0356541
+          1.30543 1.17114 1.0534 0.957444 0.867397 0.780484 0.700841 0.624126 0.545742 0.467086 0.389893 0.318209
+          0.249301 0.178674 0.107209 0.0356539
         </DataArray>
         <DataArray type="Float32" Name="rho [kg/m^3]" NumberOfComponents="1" format="ascii">
-          1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012
-          1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012
-          1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012
-          1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012
-          1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012
-          1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012
-          1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012
-          1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012
-          1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012
-          1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23014 1.23013 1.23013
-          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012
-          1.23014 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012
+          1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
+          1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012
+          1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
+          1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012
+          1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
+          1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012
+          1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
+          1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012
+          1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
+          1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013
+          1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012
+          1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
           1.23012 1.23012 1.23012 1.23012
         </DataArray>
         <DataArray type="Float32" Name="nu [m^2/s]" NumberOfComponents="1" format="ascii">
-          1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05
-          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
-          1.43726e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05
+          1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
+          1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
           1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
         </DataArray>
         <DataArray type="Float32" Name="nu_t [m^2/s]" NumberOfComponents="1" format="ascii">
-          9.61001e-07 3.47433e-06 3.9828e-06 3.99303e-06 3.96368e-06 3.94026e-06 3.92455e-06 3.91454e-06 3.90829e-06 3.90446e-06 3.90212e-06 3.9007e-06
-          3.89985e-06 3.89934e-06 3.89903e-06 3.89887e-06 3.19653e-05 0.000122918 0.000145774 0.000148124 0.000147827 0.00014734 0.000146971 0.000146729
-          0.000146577 0.000146485 0.00014643 0.000146397 0.000146378 0.000146366 0.000146359 0.000146355 6.93421e-05 0.000271539 0.000368805 0.000397731
-          0.00040706 0.000410889 0.000412833 0.000413968 0.000414677 0.000415129 0.000415417 0.000415598 0.000415712 0.000415781 0.000415824 0.000415846
-          9.46381e-05 0.000382615 0.000605572 0.000709145 0.000754508 0.000777104 0.00078984 0.000797554 0.000802369 0.000805393 0.000807285 0.000808459
-          0.000809182 0.000809626 0.000809896 0.000810037 8.38816e-05 0.000384172 0.000736149 0.000971548 0.00110021 0.00117159 0.00121386 0.00123993
-          0.00125623 0.0012664 0.00127272 0.00127661 0.001279 0.00128045 0.00128134 0.0012818 4.43593e-05 0.000271933 0.000675049 0.00106508
-          0.00133807 0.00150758 0.00161109 0.00167491 0.00171449 0.00173898 0.00175407 0.00176332 0.00176897 0.0017724 0.0017745 0.00177559
-          1.04203e-05 0.000118075 0.000423484 0.000870572 0.00130911 0.00165094 0.00188605 0.00203731 0.00213134 0.0021888 0.00222364 0.00224469
-          0.0022574 0.00226507 0.00226971 0.00227214 3.82761e-07 2.42619e-05 0.000148119 0.000415635 0.000760816 0.00107738 0.00131322 0.0014697
-          0.00156755 0.00162707 0.00166288 0.00168436 0.00169725 0.00170499 0.00170965 0.00171209 3.82761e-07 2.42619e-05 0.000148119 0.000415635
-          0.000760816 0.00107738 0.00131322 0.0014697 0.00156755 0.00162707 0.00166288 0.00168436 0.00169725 0.00170499 0.00170965 0.00171209
-          1.04203e-05 0.000118075 0.000423484 0.000870572 0.00130911 0.00165094 0.00188605 0.00203731 0.00213134 0.0021888 0.00222364 0.00224469
-          0.0022574 0.00226507 0.00226971 0.00227214 4.43593e-05 0.000271933 0.000675049 0.00106508 0.00133807 0.00150758 0.00161109 0.00167491
-          0.00171449 0.00173898 0.00175407 0.00176332 0.00176897 0.0017724 0.0017745 0.00177559 8.38816e-05 0.000384172 0.000736149 0.000971548
-          0.00110021 0.00117159 0.00121386 0.00123993 0.00125623 0.0012664 0.00127272 0.00127661 0.001279 0.00128045 0.00128134 0.0012818
-          9.46381e-05 0.000382615 0.000605572 0.000709145 0.000754508 0.000777104 0.00078984 0.000797554 0.000802369 0.000805393 0.000807285 0.000808459
-          0.000809182 0.000809626 0.000809896 0.000810037 6.93421e-05 0.000271539 0.000368805 0.000397731 0.00040706 0.000410889 0.000412833 0.000413968
-          0.000414677 0.000415129 0.000415417 0.000415598 0.000415712 0.000415781 0.000415824 0.000415846 3.19653e-05 0.000122918 0.000145774 0.000148124
-          0.000147827 0.00014734 0.000146971 0.000146729 0.000146577 0.000146485 0.00014643 0.000146397 0.000146378 0.000146366 0.000146359 0.000146355
-          9.61001e-07 3.47433e-06 3.9828e-06 3.99303e-06 3.96368e-06 3.94026e-06 3.92455e-06 3.91454e-06 3.90829e-06 3.90446e-06 3.90212e-06 3.9007e-06
-          3.89985e-06 3.89934e-06 3.89903e-06 3.89887e-06
+          7.91604e-07 3.43486e-06 3.41343e-06 2.72149e-06 2.48886e-06 2.50844e-06 2.60859e-06 2.66875e-06 2.66939e-06 2.65304e-06 2.64253e-06 2.65448e-06
+          2.66491e-06 2.66445e-06 2.66207e-06 2.65949e-06 1.59309e-05 4.79202e-05 0.000114341 0.000146157 0.000134052 0.000131497 0.000130955 0.000130076
+          0.000128709 0.00012742 0.000127266 0.000128644 0.000129564 0.000129581 0.000129477 0.000129366 1.28196e-05 3.85614e-05 0.000113892 0.000201837
+          0.00022658 0.000233286 0.000370124 0.000387786 0.000396884 0.000400233 0.000395888 0.000394033 0.000391339 0.000388574 0.000386758 0.000385727
+          2.32091e-06 6.9813e-06 0.000104392 0.000201065 0.000225713 0.000232393 0.000370031 0.000387688 0.000396784 0.000402569 0.00039875 0.000603762
+          0.000609585 0.00061155 0.000612984 0.000614257 1.76256e-07 5.30179e-07 4.66189e-05 0.000190251 0.000213574 0.000219895 0.00036865 0.000386242
+          0.000395303 0.000401067 0.000397262 0.000603572 0.000609393 0.000611357 0.000612791 0.000614064 1.49726e-08 4.50377e-08 6.25642e-06 0.000116937
+          0.000131272 0.000135157 0.000353284 0.000370142 0.000378825 0.000384349 0.000380703 0.000601364 0.000607164 0.000609121 0.000610549 0.000611818
+          1.46502e-09 4.40678e-09 6.43413e-07 2.39486e-05 2.68843e-05 2.768e-05 0.00024879 0.000260662 0.000266777 0.000270667 0.0002681 0.000579989
+          0.000585583 0.00058747 0.000588847 0.000590071 1.57785e-10 4.74619e-10 6.96409e-08 2.88443e-06 3.23803e-06 3.33386e-06 6.69465e-05 7.01411e-05
+          7.17866e-05 7.28334e-05 7.21424e-05 0.000437258 0.000441475 0.000442897 0.000443936 0.000444858 1.57785e-10 4.74619e-10 6.96409e-08 2.88443e-06
+          3.23803e-06 3.33386e-06 6.69465e-05 7.01411e-05 7.17866e-05 7.28334e-05 7.21424e-05 0.000437258 0.000441475 0.000442897 0.000443936 0.000444858
+          1.46502e-09 4.40678e-09 6.43413e-07 2.39486e-05 2.68843e-05 2.768e-05 0.00024879 0.000260662 0.000266777 0.000270667 0.0002681 0.000579989
+          0.000585583 0.00058747 0.000588847 0.000590071 1.49726e-08 4.50377e-08 6.25642e-06 0.000116937 0.000131272 0.000135157 0.000353284 0.000370142
+          0.000378825 0.000384349 0.000380703 0.000601364 0.000607164 0.000609121 0.000610549 0.000611818 1.76256e-07 5.30179e-07 4.66189e-05 0.000190251
+          0.000213574 0.000219895 0.00036865 0.000386242 0.000395303 0.000401067 0.000397262 0.000603572 0.000609393 0.000611357 0.000612791 0.000614064
+          2.32091e-06 6.9813e-06 0.000104392 0.000201065 0.000225713 0.000232393 0.000370031 0.000387688 0.000396784 0.000402569 0.00039875 0.000603762
+          0.000609585 0.00061155 0.000612984 0.000614257 1.28196e-05 3.85614e-05 0.000113892 0.000201837 0.00022658 0.000233286 0.000370124 0.000387786
+          0.000396884 0.000400233 0.000395888 0.000394033 0.000391339 0.000388574 0.000386758 0.000385727 1.59309e-05 4.79202e-05 0.000114341 0.000146157
+          0.000134052 0.000131497 0.000130955 0.000130076 0.000128709 0.00012742 0.000127266 0.000128644 0.000129564 0.000129581 0.000129477 0.000129366
+          7.91604e-07 3.43486e-06 3.41343e-06 2.72149e-06 2.48886e-06 2.50844e-06 2.60859e-06 2.66875e-06 2.66939e-06 2.65304e-06 2.64253e-06 2.65448e-06
+          2.66491e-06 2.66445e-06 2.66207e-06 2.65949e-06
         </DataArray>
         <DataArray type="Float32" Name="l_w [m]" NumberOfComponents="1" format="ascii">
           0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461
@@ -220,118 +148,316 @@
           0.00179461 0.00179461 0.00179461 0.00179461
         </DataArray>
         <DataArray type="Float32" Name="y^+ [-]" NumberOfComponents="1" format="ascii">
-          3.72283 5.49138 5.71991 5.72429 5.71171 5.70162 5.69483 5.69049 5.68778 5.68612 5.6851 5.68448
-          5.68411 5.68389 5.68375 5.68368 12.6576 18.6707 19.4477 19.4626 19.4198 19.3855 19.3624 19.3477
-          19.3385 19.3328 19.3293 19.3272 19.326 19.3252 19.3248 19.3245 25.1664 37.1217 38.6666 38.6962
-          38.6112 38.543 38.4971 38.4677 38.4494 38.4381 38.4313 38.4271 38.4246 38.4231 38.4221 38.4217
-          42.6786 62.9532 65.5731 65.6233 65.479 65.3634 65.2856 65.2358 65.2048 65.1856 65.174 65.1669
-          65.1626 65.1601 65.1585 65.1577 67.1957 99.1173 103.242 103.321 103.094 102.912 102.789 102.711
-          102.662 102.632 102.614 102.603 102.596 102.592 102.589 102.588 101.52 149.747 155.979 156.098
-          155.755 155.48 155.295 155.177 155.103 155.057 155.029 155.013 155.002 154.996 154.993 154.991
-          149.573 220.628 229.81 229.986 229.481 229.075 228.803 228.628 228.519 228.452 228.411 228.387
-          228.372 228.363 228.357 228.354 216.848 319.863 333.174 333.429 332.696 332.109 331.713 331.46
-          331.303 331.206 331.146 331.11 331.089 331.076 331.068 331.064 216.848 319.863 333.174 333.429
-          332.696 332.109 331.713 331.46 331.303 331.206 331.146 331.11 331.089 331.076 331.068 331.064
-          149.573 220.628 229.81 229.986 229.481 229.075 228.803 228.628 228.519 228.452 228.411 228.387
-          228.372 228.363 228.357 228.354 101.52 149.747 155.979 156.098 155.755 155.48 155.295 155.177
-          155.103 155.057 155.029 155.013 155.002 154.996 154.993 154.991 67.1957 99.1173 103.242 103.321
-          103.094 102.912 102.789 102.711 102.662 102.632 102.614 102.603 102.596 102.592 102.589 102.588
-          42.6786 62.9532 65.5731 65.6233 65.479 65.3634 65.2856 65.2358 65.2048 65.1856 65.174 65.1669
-          65.1626 65.1601 65.1585 65.1577 25.1664 37.1217 38.6666 38.6962 38.6112 38.543 38.4971 38.4677
-          38.4494 38.4381 38.4313 38.4271 38.4246 38.4231 38.4221 38.4217 12.6576 18.6707 19.4477 19.4626
-          19.4198 19.3855 19.3624 19.3477 19.3385 19.3328 19.3293 19.3272 19.326 19.3252 19.3248 19.3245
-          3.72283 5.49138 5.71991 5.72429 5.71171 5.70162 5.69483 5.69049 5.68778 5.68612 5.6851 5.68448
-          5.68411 5.68389 5.68375 5.68368
+          4.00731 5.88574 5.87602 5.53497 5.40624 5.4174 5.47353 5.5065 5.50685 5.49794 5.49219 5.49872
+          5.50441 5.50415 5.50286 5.50145 13.6249 20.0115 19.9785 18.8189 18.3812 18.4192 18.61 18.7221
+          18.7233 18.693 18.6735 18.6957 18.715 18.7141 18.7097 18.7049 27.0894 39.7876 39.7219 37.4164
+          36.5462 36.6216 37.001 37.2239 37.2263 37.1661 37.1272 37.1714 37.2098 37.2081 37.1993 37.1898
+          45.9399 67.4742 67.3627 63.4529 61.9771 62.105 62.7485 63.1265 63.1305 63.0284 62.9625 63.0373
+          63.1025 63.0996 63.0848 63.0687 72.3304 106.235 106.06 99.904 97.5804 97.7819 98.795 99.3901
+          99.3964 99.2357 99.1319 99.2497 99.3524 99.3478 99.3244 99.299 109.277 160.501 160.236 150.936
+          147.425 147.729 149.26 150.159 150.169 149.926 149.769 149.947 150.102 150.095 150.06 150.022
+          161.003 236.473 236.082 222.38 217.208 217.656 219.911 221.236 221.25 220.892 220.661 220.923
+          221.152 221.142 221.09 221.033 233.418 342.833 342.267 322.402 314.903 315.553 318.823 320.743
+          320.763 320.245 319.91 320.29 320.621 320.607 320.531 320.449 233.418 342.833 342.267 322.402
+          314.903 315.553 318.823 320.743 320.763 320.245 319.91 320.29 320.621 320.607 320.531 320.449
+          161.003 236.473 236.082 222.38 217.208 217.656 219.911 221.236 221.25 220.892 220.661 220.923
+          221.152 221.142 221.09 221.033 109.277 160.501 160.236 150.936 147.425 147.729 149.26 150.159
+          150.169 149.926 149.769 149.947 150.102 150.095 150.06 150.022 72.3304 106.235 106.06 99.904
+          97.5804 97.7819 98.795 99.3901 99.3964 99.2357 99.1319 99.2497 99.3524 99.3478 99.3244 99.299
+          45.9399 67.4742 67.3627 63.4529 61.9771 62.105 62.7485 63.1265 63.1305 63.0284 62.9625 63.0373
+          63.1025 63.0996 63.0848 63.0687 27.0894 39.7876 39.7219 37.4164 36.5462 36.6216 37.001 37.2239
+          37.2263 37.1661 37.1272 37.1714 37.2098 37.2081 37.1993 37.1898 13.6249 20.0115 19.9785 18.8189
+          18.3812 18.4192 18.61 18.7221 18.7233 18.693 18.6735 18.6957 18.715 18.7141 18.7097 18.7049
+          4.00731 5.88574 5.87602 5.53497 5.40624 5.4174 5.47353 5.5065 5.50685 5.49794 5.49219 5.49872
+          5.50441 5.50415 5.50286 5.50145
         </DataArray>
         <DataArray type="Float32" Name="u^+ [-]" NumberOfComponents="1" format="ascii">
-          71.5274 37.1488 31.7892 30.2888 29.6206 29.2521 29.0313 28.8948 28.8097 28.7568 28.724 28.7038
-          28.6915 28.6839 28.6794 28.677 80.4622 50.3281 45.517 44.0271 43.3287 42.936 42.6989 42.552
-          42.4604 42.4035 42.3682 42.3466 42.3333 42.3253 42.3204 42.3178 83.0037 54.5992 50.6161 49.3853
-          48.776 48.4226 48.2066 48.0723 47.9885 47.9365 47.9045 47.8848 47.8727 47.8654 47.8609 47.8586
-          83.9947 56.578 53.3779 52.4924 52.0282 51.7464 51.5708 51.4609 51.3926 51.3503 51.3242 51.3083
-          51.2986 51.2927 51.2891 51.2872 84.394 57.583 55.0663 54.5909 54.3322 54.1598 54.0479 53.977
-          53.933 53.906 53.8895 53.8794 53.8733 53.8696 53.8673 53.8662 84.524 58.047 56.0625 56.0323
-          56.0471 56.0348 56.0199 56.0097 56.0036 56.0002 55.9984 55.9973 55.9967 55.9964 55.9962 55.996
-          84.5468 58.1967 56.527 56.8939 57.2319 57.4329 57.55 57.6207 57.6646 57.692 57.7091 57.7196
-          57.726 57.73 57.7324 57.7336 84.5463 58.2178 56.6507 57.2407 57.8682 58.3355 58.6514 58.8544
-          58.981 59.0588 59.1062 59.1349 59.1523 59.1628 59.1691 59.1724 84.5463 58.2178 56.6507 57.2407
-          57.8682 58.3355 58.6514 58.8544 58.981 59.0588 59.1062 59.1349 59.1523 59.1628 59.1691 59.1724
-          84.5468 58.1967 56.527 56.8939 57.2319 57.4329 57.55 57.6207 57.6646 57.692 57.7091 57.7196
-          57.726 57.73 57.7324 57.7336 84.524 58.047 56.0625 56.0323 56.0471 56.0348 56.0199 56.0097
-          56.0036 56.0002 55.9984 55.9973 55.9967 55.9964 55.9962 55.996 84.394 57.583 55.0663 54.5909
-          54.3322 54.1598 54.0479 53.977 53.933 53.906 53.8895 53.8794 53.8733 53.8696 53.8673 53.8662
-          83.9947 56.578 53.3779 52.4924 52.0282 51.7464 51.5708 51.4609 51.3926 51.3503 51.3242 51.3083
-          51.2986 51.2927 51.2891 51.2872 83.0037 54.5992 50.6161 49.3853 48.776 48.4226 48.2066 48.0723
-          47.9885 47.9365 47.9045 47.8848 47.8727 47.8654 47.8609 47.8586 80.4622 50.3281 45.517 44.0271
-          43.3287 42.936 42.6989 42.552 42.4604 42.4035 42.3682 42.3466 42.3333 42.3253 42.3204 42.3178
-          71.5274 37.1488 31.7892 30.2888 29.6206 29.2521 29.0313 28.8948 28.8097 28.7568 28.724 28.7038
-          28.6915 28.6839 28.6794 28.677
+          64.7357 31.3883 27.2772 28.3039 28.3064 27.5999 27.1576 26.9727 26.8436 26.6935 26.5944 26.6113
+          26.7045 26.7746 26.7969 26.7984 74.3532 45.5141 41.3797 41.5878 41.2813 40.6017 40.2941 40.1883
+          40.0601 39.8886 39.7756 39.8082 39.915 39.9846 40.0037 40.0019 77.3554 51.0261 48.405 48.829
+          48.2109 47.0297 46.0401 45.4637 45.1375 44.8735 44.7974 44.9598 45.1391 45.2137 45.2314 45.2282
+          78.3352 53.4862 52.7312 54.3918 54.0923 52.6449 51.0609 50.0123 49.4558 49.0801 48.8854 48.855
+          48.8824 48.8893 48.8708 48.8496 78.5377 54.2114 54.6046 57.7119 58.4776 57.5731 56.1043 54.9747
+          54.3313 53.9015 53.5262 53.129 52.8629 52.7308 52.6386 52.5814 78.5602 54.3277 55.0816 58.9487
+          60.6407 60.5744 59.7464 59.0534 58.7084 58.4839 58.2103 57.7737 57.3975 57.1711 57.0152 56.9253
+          78.5592 54.3337 55.138 59.1782 61.1863 61.5682 61.3042 61.1993 61.3983 61.6497 61.7672 61.6124
+          61.4195 61.3153 61.2452 61.208 78.557 54.3309 55.1378 59.1906 61.2292 61.6854 61.5829 61.7205
+          62.212 62.7871 63.2627 63.4924 63.6642 63.8792 64.0829 64.2297 78.557 54.3309 55.1378 59.1906
+          61.2292 61.6854 61.5829 61.7205 62.212 62.7871 63.2627 63.4924 63.6642 63.8792 64.0829 64.2297
+          78.5592 54.3337 55.138 59.1782 61.1863 61.5682 61.3042 61.1993 61.3983 61.6497 61.7672 61.6124
+          61.4195 61.3153 61.2452 61.208 78.5602 54.3277 55.0816 58.9487 60.6407 60.5744 59.7464 59.0534
+          58.7084 58.4839 58.2103 57.7737 57.3975 57.1711 57.0152 56.9253 78.5377 54.2114 54.6046 57.7119
+          58.4776 57.5731 56.1043 54.9747 54.3313 53.9015 53.5262 53.129 52.8629 52.7308 52.6386 52.5814
+          78.3352 53.4862 52.7312 54.3918 54.0923 52.6449 51.0609 50.0123 49.4558 49.0801 48.8854 48.855
+          48.8824 48.8893 48.8708 48.8496 77.3554 51.0261 48.405 48.829 48.2109 47.0297 46.0401 45.4637
+          45.1375 44.8735 44.7974 44.9598 45.1391 45.2137 45.2314 45.2282 74.3532 45.5141 41.3797 41.5878
+          41.2813 40.6017 40.2941 40.1883 40.0601 39.8886 39.7756 39.8082 39.915 39.9846 40.0037 40.0019
+          64.7357 31.3883 27.2772 28.3039 28.3064 27.5999 27.1576 26.9727 26.8436 26.6935 26.5944 26.6113
+          26.7045 26.7746 26.7969 26.7984
+        </DataArray>
+        <DataArray type="Float32" Name="v [m/s]" NumberOfComponents="3" format="ascii">
+          2.07761 0.00242566 0 1.47958 0.00100872 0 1.28367 0.000116346 0 1.25467 5.01633e-05 0
+          1.2256 0.000116804 0 1.19748 4.46895e-05 0 1.1905 -4.59206e-06 0 1.18952 1.02245e-05 0
+          1.1839 2.20458e-05 0 1.17538 2.69089e-05 0 1.16979 5.19381e-06 0 1.17192 -1.74653e-05 0
+          1.17724 -1.30807e-05 0 1.18028 -4.36506e-06 0 1.18099 3.29792e-07 0 1.18075 1.00823e-06 0
+          2.38628 0.00576564 0 2.14543 0.00303947 0 1.94733 0.000803427 0 1.84353 0.000364106 0
+          1.78739 0.000421248 0 1.76159 0.000109161 0 1.76636 -6.72977e-05 0 1.77234 3.05003e-05 0
+          1.76679 7.86246e-05 0 1.75639 0.000102967 0 1.74958 1.595e-05 0 1.7531 -6.87654e-05 0
+          1.75962 -4.47601e-05 0 1.76261 -1.41227e-05 0 1.76304 2.60302e-06 0 1.76251 4.33885e-06 0
+          2.48263 0.00687549 0 2.40526 0.00473684 0 2.27794 0.00213193 0 2.16452 0.0011467 0
+          2.08742 0.000957947 0 2.04048 0.000308256 0 2.01824 -5.43857e-05 0 2.00498 0.000118786 0
+          1.99072 0.000195434 0 1.97588 0.000236893 0 1.97047 -2.31556e-06 0 1.97997 -0.000185648 0
+          1.98992 -9.23057e-05 0 1.99312 -2.65716e-05 0 1.99343 8.11112e-06 0 1.99278 1.03936e-05 0
+          2.51407 0.00684927 0 2.52122 0.00552131 0 2.48153 0.00340614 0 2.41111 0.00225871 0
+          2.34207 0.00180186 0 2.28411 0.000906105 0 2.23834 0.000319355 0 2.20558 0.000410559 0
+          2.18118 0.000448728 0 2.16111 0.000466916 0 2.15029 -8.13628e-07 0 2.1515 -0.000313189 0
+          2.15494 -0.000130854 0 2.15515 -2.72753e-05 0 2.15383 2.61796e-05 0 2.15234 2.30065e-05 0
+          2.52057 0.00617368 0 2.5554 0.00531584 0 2.56969 0.00392201 0 2.55829 0.00310407 0
+          2.53194 0.00262586 0 2.49793 0.00174593 0 2.45943 0.00105029 0 2.42442 0.000968088 0
+          2.39621 0.000898299 0 2.37341 0.000836634 0 2.35442 0.000219041 0 2.33973 -0.000228061 0
+          2.33042 -6.47039e-05 0 2.32449 3.4199e-05 0 2.31988 8.72815e-05 0 2.31677 5.3971e-05 0
+          2.52129 0.00506216 0 2.56089 0.00443614 0 2.59214 0.00352134 0 2.61312 0.00310855 0
+          2.6256 0.00281725 0 2.62815 0.0022263 0 2.61908 0.00169947 0 2.6043 0.00154776 0
+          2.58925 0.00140605 0 2.57518 0.00126662 0 2.56046 0.000662849 0 2.54427 0.000152128 0
+          2.53032 0.00019143 0 2.52023 0.000220849 0 2.51276 0.000232876 0 2.50816 0.000119193 0
+          2.52126 0.00348503 0 2.56117 0.00306486 0 2.59479 0.00247386 0 2.62329 0.00227605 0
+          2.64923 0.00214303 0 2.67126 0.00186902 0 2.68737 0.00164046 0 2.69894 0.00156331 0
+          2.70788 0.0014686 0 2.71458 0.00134946 0 2.71691 0.000934151 0 2.71332 0.000535775 0
+          2.70763 0.000485029 0 2.70291 0.000443151 0 2.69919 0.000402238 0 2.69686 0.000192611 0
+          2.52119 0.0012828 0 2.56104 0.00112934 0 2.59478 0.00091324 0 2.62384 0.000845618 0
+          2.65108 0.000803274 0 2.67635 0.000726331 0 2.69959 0.000680249 0 2.72192 0.00067159 0
+          2.74377 0.000650975 0 2.76466 0.000613383 0 2.78269 0.000478085 0 2.79612 0.000334427 0
+          2.80658 0.000299122 0 2.81594 0.000266962 0 2.82425 0.000236302 0 2.83 0.000111446 0
+          2.52119 -0.0012828 0 2.56104 -0.00112934 0 2.59478 -0.00091324 0 2.62384 -0.000845618 0
+          2.65108 -0.000803274 0 2.67635 -0.000726331 0 2.69959 -0.000680249 0 2.72192 -0.00067159 0
+          2.74377 -0.000650975 0 2.76466 -0.000613383 0 2.78269 -0.000478085 0 2.79612 -0.000334427 0
+          2.80658 -0.000299122 0 2.81594 -0.000266962 0 2.82425 -0.000236302 0 2.83 -0.000111446 0
+          2.52126 -0.00348503 0 2.56117 -0.00306486 0 2.59479 -0.00247386 0 2.62329 -0.00227605 0
+          2.64923 -0.00214303 0 2.67126 -0.00186902 0 2.68737 -0.00164046 0 2.69894 -0.00156331 0
+          2.70788 -0.0014686 0 2.71458 -0.00134946 0 2.71691 -0.000934151 0 2.71332 -0.000535775 0
+          2.70763 -0.000485029 0 2.70291 -0.000443151 0 2.69919 -0.000402238 0 2.69686 -0.000192611 0
+          2.52129 -0.00506216 0 2.56089 -0.00443614 0 2.59214 -0.00352134 0 2.61312 -0.00310855 0
+          2.6256 -0.00281725 0 2.62815 -0.0022263 0 2.61908 -0.00169947 0 2.6043 -0.00154776 0
+          2.58925 -0.00140605 0 2.57518 -0.00126662 0 2.56046 -0.000662849 0 2.54427 -0.000152128 0
+          2.53032 -0.00019143 0 2.52023 -0.000220849 0 2.51276 -0.000232876 0 2.50816 -0.000119193 0
+          2.52057 -0.00617368 0 2.5554 -0.00531584 0 2.56969 -0.00392201 0 2.55829 -0.00310407 0
+          2.53194 -0.00262586 0 2.49793 -0.00174593 0 2.45943 -0.00105029 0 2.42442 -0.000968088 0
+          2.39621 -0.000898299 0 2.37341 -0.000836634 0 2.35442 -0.000219041 0 2.33973 0.000228061 0
+          2.33042 6.47039e-05 0 2.32449 -3.4199e-05 0 2.31988 -8.72815e-05 0 2.31677 -5.3971e-05 0
+          2.51407 -0.00684927 0 2.52122 -0.00552131 0 2.48153 -0.00340614 0 2.41111 -0.00225871 0
+          2.34207 -0.00180186 0 2.28411 -0.000906105 0 2.23834 -0.000319355 0 2.20558 -0.000410559 0
+          2.18118 -0.000448728 0 2.16111 -0.000466916 0 2.15029 8.13628e-07 0 2.1515 0.000313189 0
+          2.15494 0.000130854 0 2.15515 2.72753e-05 0 2.15383 -2.61796e-05 0 2.15234 -2.30065e-05 0
+          2.48263 -0.00687549 0 2.40526 -0.00473684 0 2.27794 -0.00213193 0 2.16452 -0.0011467 0
+          2.08742 -0.000957947 0 2.04048 -0.000308256 0 2.01824 5.43857e-05 0 2.00498 -0.000118786 0
+          1.99072 -0.000195434 0 1.97588 -0.000236893 0 1.97047 2.31556e-06 0 1.97997 0.000185648 0
+          1.98992 9.23057e-05 0 1.99312 2.65716e-05 0 1.99343 -8.11112e-06 0 1.99278 -1.03936e-05 0
+          2.38628 -0.00576564 0 2.14543 -0.00303947 0 1.94733 -0.000803427 0 1.84353 -0.000364106 0
+          1.78739 -0.000421248 0 1.76159 -0.000109161 0 1.76636 6.72977e-05 0 1.77234 -3.05003e-05 0
+          1.76679 -7.86246e-05 0 1.75639 -0.000102967 0 1.74958 -1.595e-05 0 1.7531 6.87654e-05 0
+          1.75962 4.47601e-05 0 1.76261 1.41227e-05 0 1.76304 -2.60302e-06 0 1.76251 -4.33885e-06 0
+          2.07761 -0.00242566 0 1.47958 -0.00100872 0 1.28367 -0.000116346 0 1.25467 -5.01633e-05 0
+          1.2256 -0.000116804 0 1.19748 -4.46895e-05 0 1.1905 4.59206e-06 0 1.18952 -1.02245e-05 0
+          1.1839 -2.20458e-05 0 1.17538 -2.69089e-05 0 1.16979 -5.19381e-06 0 1.17192 1.74653e-05 0
+          1.17724 1.30807e-05 0 1.18028 4.36506e-06 0 1.18099 -3.29792e-07 0 1.18075 -1.00823e-06 0
+        </DataArray>
+        <DataArray type="Float32" Name="dv_x/dx_ [m/s]" NumberOfComponents="3" format="ascii">
+          -0.95686 71.6647 0 -0.635157 154.597 0 -0.179922 154.087 0 -0.0464533 136.72 0
+          -0.0457548 130.434 0 -0.0280812 130.973 0 -0.00636892 133.701 0 -0.00527861 135.317 0
+          -0.0113137 135.334 0 -0.0112903 134.897 0 -0.0027612 134.615 0 0.0059661 134.935 0
+          0.00668688 135.215 0 0.00299378 135.202 0 0.00037709 135.139 0 -0.000371439 135.07 0
+          -0.385348 39.1814 0 -0.35116 89.551 0 -0.241522 96.1864 0 -0.127953 88.0195 0
+          -0.0655552 83.3731 0 -0.0168229 81.5524 0 0.00859883 80.0763 0 0.000348277 78.8884 0
+          -0.0127609 78.0526 0 -0.0137686 77.4415 0 -0.00262868 77.4585 0 0.00803264 78.1704 0
+          0.00760658 78.6185 0 0.00273242 78.6341 0 -7.92547e-05 78.5962 0 -0.00084692 78.5561 0
+          -0.123792 8.83074 0 -0.163751 25.9671 0 -0.192587 36.9134 0 -0.152414 39.2201 0
+          -0.0992347 38.3288 0 -0.0553436 36.1063 0 -0.0283987 32.6142 0 -0.0220144 29.9373 0
+          -0.0232791 28.6342 0 -0.0162027 27.9666 0 0.00326662 27.6889 0 0.0155584 27.53 0
+          0.0105211 27.3165 0 0.00280934 27.1246 0 -0.000268182 27.0035 0 -0.00103498 26.9377 0
+          0.0114385 1.87278 0 -0.0260362 7.41083 0 -0.0880861 14.4002 0 -0.111566 19.4353 0
+          -0.101605 21.9405 0 -0.0829837 22.5785 0 -0.0628222 21.7757 0 -0.0457291 20.7025 0
+          -0.0355761 20.0136 0 -0.024713 19.6207 0 -0.00768423 18.9506 0 0.00372169 17.7568 0
+          0.00291362 16.8062 0 -0.000891487 16.3555 0 -0.00224355 16.1127 0 -0.00237188 15.991 0
+          0.0557332 0.254612 0 0.0392977 1.39841 0 0.00230937 3.89971 0 -0.0301996 7.12168 0
+          -0.0482888 9.99591 0 -0.0580147 12.1292 0 -0.0588047 13.4232 0 -0.0505745 14.057 0
+          -0.0408131 14.3867 0 -0.0334319 14.5981 0 -0.0269454 14.4606 0 -0.0191991 13.8472 0
+          -0.0121905 13.2342 0 -0.00843178 12.8709 0 -0.00617655 12.6545 0 -0.00497851 12.5446 0
+          0.0633478 0.0174282 0 0.056677 0.145258 0 0.0417843 0.632041 0 0.0267666 1.63685 0
+          0.0120249 2.95342 0 -0.00521208 4.36494 0 -0.0190776 5.74016 0 -0.0238655 6.91287 0
+          -0.0232978 7.84874 0 -0.0230369 8.59144 0 -0.0247241 9.12835 0 -0.0241065 9.40803 0
+          -0.0192386 9.49903 0 -0.0140473 9.52962 0 -0.00964972 9.5519 0 -0.00736024 9.57169 0
+          0.0638551 -0.00186854 0 0.0588229 0.00272496 0 0.0496947 0.0475259 0 0.0435467 0.19288 0
+          0.038378 0.458353 0 0.0305152 0.867036 0 0.0221386 1.44807 0 0.0164115 2.11568 0
+          0.0125123 2.7794 0 0.00721903 3.40825 0 -0.00100371 3.99744 0 -0.00742319 4.52997 0
+          -0.0083278 4.9692 0 -0.00675228 5.31906 0 -0.00484026 5.60285 0 -0.00372104 5.78896 0
+          0.0637564 -0.00103646 0 0.0588739 -0.0019143 0 0.0502416 -0.000129744 0 0.0450384 0.00781458 0
+          0.0420084 0.0264059 0 0.038806 0.0723988 0 0.0364566 0.173897 0 0.0353462 0.327112 0
+          0.0341902 0.51074 0 0.0311362 0.712754 0 0.0251649 0.93622 0 0.0191133 1.17829 0
+          0.0158566 1.4083 0 0.0141348 1.60852 0 0.0112495 1.77987 0 0.00919434 1.89475 0
+          0.0637564 0.00103646 0 0.0588739 0.0019143 0 0.0502416 0.000129744 0 0.0450384 -0.00781458 0
+          0.0420084 -0.0264059 0 0.038806 -0.0723988 0 0.0364566 -0.173897 0 0.0353462 -0.327112 0
+          0.0341902 -0.51074 0 0.0311362 -0.712754 0 0.0251649 -0.93622 0 0.0191133 -1.17829 0
+          0.0158566 -1.4083 0 0.0141348 -1.60852 0 0.0112495 -1.77987 0 0.00919434 -1.89475 0
+          0.0638551 0.00186854 0 0.0588229 -0.00272496 0 0.0496947 -0.0475259 0 0.0435467 -0.19288 0
+          0.038378 -0.458353 0 0.0305152 -0.867036 0 0.0221386 -1.44807 0 0.0164115 -2.11568 0
+          0.0125123 -2.7794 0 0.00721903 -3.40825 0 -0.00100371 -3.99744 0 -0.00742319 -4.52997 0
+          -0.0083278 -4.9692 0 -0.00675228 -5.31906 0 -0.00484026 -5.60285 0 -0.00372104 -5.78896 0
+          0.0633478 -0.0174282 0 0.056677 -0.145258 0 0.0417843 -0.632041 0 0.0267666 -1.63685 0
+          0.0120249 -2.95342 0 -0.00521208 -4.36494 0 -0.0190776 -5.74016 0 -0.0238655 -6.91287 0
+          -0.0232978 -7.84874 0 -0.0230369 -8.59144 0 -0.0247241 -9.12835 0 -0.0241065 -9.40803 0
+          -0.0192386 -9.49903 0 -0.0140473 -9.52962 0 -0.00964972 -9.5519 0 -0.00736024 -9.57169 0
+          0.0557332 -0.254612 0 0.0392977 -1.39841 0 0.00230937 -3.89971 0 -0.0301996 -7.12168 0
+          -0.0482888 -9.99591 0 -0.0580147 -12.1292 0 -0.0588047 -13.4232 0 -0.0505745 -14.057 0
+          -0.0408131 -14.3867 0 -0.0334319 -14.5981 0 -0.0269454 -14.4606 0 -0.0191991 -13.8472 0
+          -0.0121905 -13.2342 0 -0.00843178 -12.8709 0 -0.00617655 -12.6545 0 -0.00497851 -12.5446 0
+          0.0114385 -1.87278 0 -0.0260362 -7.41083 0 -0.0880861 -14.4002 0 -0.111566 -19.4353 0
+          -0.101605 -21.9405 0 -0.0829837 -22.5785 0 -0.0628222 -21.7757 0 -0.0457291 -20.7025 0
+          -0.0355761 -20.0136 0 -0.024713 -19.6207 0 -0.00768423 -18.9506 0 0.00372169 -17.7568 0
+          0.00291362 -16.8062 0 -0.000891487 -16.3555 0 -0.00224355 -16.1127 0 -0.00237188 -15.991 0
+          -0.123792 -8.83074 0 -0.163751 -25.9671 0 -0.192587 -36.9134 0 -0.152414 -39.2201 0
+          -0.0992347 -38.3288 0 -0.0553436 -36.1063 0 -0.0283987 -32.6142 0 -0.0220144 -29.9373 0
+          -0.0232791 -28.6342 0 -0.0162027 -27.9666 0 0.00326662 -27.6889 0 0.0155584 -27.53 0
+          0.0105211 -27.3165 0 0.00280934 -27.1246 0 -0.000268182 -27.0035 0 -0.00103498 -26.9377 0
+          -0.385348 -39.1814 0 -0.35116 -89.551 0 -0.241522 -96.1864 0 -0.127953 -88.0195 0
+          -0.0655552 -83.3731 0 -0.0168229 -81.5524 0 0.00859883 -80.0763 0 0.000348277 -78.8884 0
+          -0.0127609 -78.0526 0 -0.0137686 -77.4415 0 -0.00262868 -77.4585 0 0.00803264 -78.1704 0
+          0.00760658 -78.6185 0 0.00273242 -78.6341 0 -7.92547e-05 -78.5962 0 -0.00084692 -78.5561 0
+          -0.95686 -71.6647 0 -0.635157 -154.597 0 -0.179922 -154.087 0 -0.0464533 -136.72 0
+          -0.0457548 -130.434 0 -0.0280812 -130.973 0 -0.00636892 -133.701 0 -0.00527861 -135.317 0
+          -0.0113137 -135.334 0 -0.0112903 -134.897 0 -0.0027612 -134.615 0 0.0059661 -134.935 0
+          0.00668688 -135.215 0 0.00299378 -135.202 0 0.00037709 -135.139 0 -0.000371439 -135.07 0
+        </DataArray>
+        <DataArray type="Float32" Name="dv_y/dx_ [m/s]" NumberOfComponents="3" format="ascii">
+          -0.0022671 0.775467 0 -0.00184745 0.471494 0 -0.000766845 0.159525 0 3.66296e-07 0.0728904 0
+          -4.37907e-06 0.0706851 0 -9.71167e-05 0.0149689 0 -2.7572e-05 -0.0145588 0 2.13103e-05 0.00470758 0
+          1.33476e-05 0.0131363 0 -1.34816e-05 0.017659 0 -3.54994e-05 0.00249735 0 -1.46196e-05 -0.0119107 0
+          1.04802e-05 -0.00735523 0 1.07284e-05 -0.0022655 0 4.29864e-06 0.000527793 0 1.0855e-06 0.000773293 0
+          -0.00436187 0.430479 0 -0.00396977 0.36066 0 -0.00214029 0.194989 0 -0.000305743 0.10608 0
+          -0.000203956 0.0813726 0 -0.000390837 0.0254976 0 -6.29287e-05 -0.00481706 0 0.000116738 0.0105023 0
+          5.79734e-05 0.0167737 0 -5.01397e-05 0.020314 0 -0.000137386 -0.00072646 0 -4.85681e-05 -0.01627 0
+          4.37142e-05 -0.00766426 0 3.78905e-05 -0.00214828 0 1.47692e-05 0.000752769 0 2.77732e-06 0.000907942 0
+          -0.00342184 0.0748794 0 -0.00379484 0.171496 0 -0.00287211 0.179848 0 -0.00093919 0.130918 0
+          -0.000670759 0.0954006 0 -0.000809866 0.0550691 0 -0.000151576 0.0267178 0 0.000199856 0.0262622 0
+          9.44853e-05 0.0255742 0 -0.0001582 0.025149 0 -0.000338032 -0.00115837 0 -7.19921e-05 -0.0168897 0
+          0.000127261 -0.00594911 0 8.03335e-05 -0.000908849 0 2.95722e-05 0.00162915 0 3.65192e-06 0.00128994 0
+          -0.00212474 -0.0346393 0 -0.00275451 0.0285776 0 -0.00261008 0.0883533 0 -0.00128342 0.0966105 0
+          -0.00108209 0.0823237 0 -0.001186 0.0709599 0 -0.000396437 0.054524 0 0.000103498 0.0419193 0
+          4.50857e-05 0.0346916 0 -0.000359633 0.0296016 0 -0.000624084 0.0109256 0 -0.000104032 -0.0020934 0
+          0.000228731 0.00136235 0 0.000125627 0.00299948 0 4.02255e-05 0.00390764 0 -5.07688e-06 0.00215087 0
+          -0.00137256 -0.0630051 0 -0.00180134 -0.038258 0 -0.00176941 0.00406146 0 -0.00103692 0.0299613 0
+          -0.00108651 0.035798 0 -0.00126045 0.0465438 0 -0.000622275 0.0486563 0 -0.000121594 0.0400922 0
+          -0.000105163 0.0337507 0 -0.000543406 0.0281939 0 -0.000851756 0.0233976 0 -0.000226996 0.0164049 0
+          0.000209808 0.0113622 0 0.000121588 0.0087477 0 1.58176e-05 0.00728715 0 -5.32968e-05 0.00339108 0
+          -0.00100163 -0.0677067 0 -0.00123266 -0.0566849 0 -0.00106207 -0.0364678 0 -0.000563268 -0.0208514 0
+          -0.000705803 -0.0121588 0 -0.000894228 0.00309965 0 -0.000542833 0.0148619 0 -0.000234735 0.014989 0
+          -0.000224906 0.0143614 0 -0.000594561 0.012914 0 -0.000891597 0.0180081 0 -0.000377135 0.0192352 0
+          5.49769e-05 0.0138436 0 3.31568e-05 0.0102984 0 -8.1325e-05 0.00793135 0 -0.000181893 0.00349129 0
+          -0.000672271 -0.0679808 0 -0.000808938 -0.0594808 0 -0.000631045 -0.0469129 0 -0.000264663 -0.0407043 0
+          -0.000325626 -0.0362262 0 -0.000402052 -0.0269805 0 -0.000244569 -0.0183331 0 -0.000137491 -0.01576 0
+          -0.000171082 -0.0135818 0 -0.000427557 -0.0117501 0 -0.000650944 -0.00332341 0 -0.000359298 0.00327909 0
+          -7.40989e-05 0.00193709 0 -6.62323e-05 0.000829451 0 -0.000200432 6.1613e-05 0 -0.000335403 -0.000139357 0
+          -0.000245538 -0.0678546 0 -0.000295645 -0.0596908 0 -0.000226974 -0.0482044 0 -8.79731e-05 -0.0444269 0
+          -9.54296e-05 -0.0419311 0 -9.84197e-05 -0.0369365 0 -4.3793e-05 -0.0330278 0 -2.34197e-05 -0.0318066 0
+          -4.65655e-05 -0.0301653 0 -0.000138312 -0.0279347 0 -0.000223164 -0.0200986 0 -0.000143171 -0.0123845 0
+          -5.39722e-05 -0.0111599 0 -5.02563e-05 -0.0101062 0 -0.000124413 -0.00908756 0 -0.00019977 -0.00432727 0
+          0.000245538 -0.0678546 0 0.000295645 -0.0596908 0 0.000226974 -0.0482044 0 8.79731e-05 -0.0444269 0
+          9.54296e-05 -0.0419311 0 9.84197e-05 -0.0369365 0 4.3793e-05 -0.0330278 0 2.34197e-05 -0.0318066 0
+          4.65655e-05 -0.0301653 0 0.000138312 -0.0279347 0 0.000223164 -0.0200986 0 0.000143171 -0.0123845 0
+          5.39722e-05 -0.0111599 0 5.02563e-05 -0.0101062 0 0.000124413 -0.00908756 0 0.00019977 -0.00432727 0
+          0.000672271 -0.0679808 0 0.000808938 -0.0594808 0 0.000631045 -0.0469129 0 0.000264663 -0.0407043 0
+          0.000325626 -0.0362262 0 0.000402052 -0.0269805 0 0.000244569 -0.0183331 0 0.000137491 -0.01576 0
+          0.000171082 -0.0135818 0 0.000427557 -0.0117501 0 0.000650944 -0.00332341 0 0.000359298 0.00327909 0
+          7.40989e-05 0.00193709 0 6.62323e-05 0.000829451 0 0.000200432 6.1613e-05 0 0.000335403 -0.000139357 0
+          0.00100163 -0.0677067 0 0.00123266 -0.0566849 0 0.00106207 -0.0364678 0 0.000563268 -0.0208514 0
+          0.000705803 -0.0121588 0 0.000894228 0.00309965 0 0.000542833 0.0148619 0 0.000234735 0.014989 0
+          0.000224906 0.0143614 0 0.000594561 0.012914 0 0.000891597 0.0180081 0 0.000377135 0.0192352 0
+          -5.49769e-05 0.0138436 0 -3.31568e-05 0.0102984 0 8.1325e-05 0.00793135 0 0.000181893 0.00349129 0
+          0.00137256 -0.0630051 0 0.00180134 -0.038258 0 0.00176941 0.00406146 0 0.00103692 0.0299613 0
+          0.00108651 0.035798 0 0.00126045 0.0465438 0 0.000622275 0.0486563 0 0.000121594 0.0400922 0
+          0.000105163 0.0337507 0 0.000543406 0.0281939 0 0.000851756 0.0233976 0 0.000226996 0.0164049 0
+          -0.000209808 0.0113622 0 -0.000121588 0.0087477 0 -1.58176e-05 0.00728715 0 5.32968e-05 0.00339108 0
+          0.00212474 -0.0346393 0 0.00275451 0.0285776 0 0.00261008 0.0883533 0 0.00128342 0.0966105 0
+          0.00108209 0.0823237 0 0.001186 0.0709599 0 0.000396437 0.054524 0 -0.000103498 0.0419193 0
+          -4.50857e-05 0.0346916 0 0.000359633 0.0296016 0 0.000624084 0.0109256 0 0.000104032 -0.0020934 0
+          -0.000228731 0.00136235 0 -0.000125627 0.00299948 0 -4.02255e-05 0.00390764 0 5.07688e-06 0.00215087 0
+          0.00342184 0.0748794 0 0.00379484 0.171496 0 0.00287211 0.179848 0 0.00093919 0.130918 0
+          0.000670759 0.0954006 0 0.000809866 0.0550691 0 0.000151576 0.0267178 0 -0.000199856 0.0262622 0
+          -9.44853e-05 0.0255742 0 0.0001582 0.025149 0 0.000338032 -0.00115837 0 7.19921e-05 -0.0168897 0
+          -0.000127261 -0.00594911 0 -8.03335e-05 -0.000908849 0 -2.95722e-05 0.00162915 0 -3.65192e-06 0.00128994 0
+          0.00436187 0.430479 0 0.00396977 0.36066 0 0.00214029 0.194989 0 0.000305743 0.10608 0
+          0.000203956 0.0813726 0 0.000390837 0.0254976 0 6.29287e-05 -0.00481706 0 -0.000116738 0.0105023 0
+          -5.79734e-05 0.0167737 0 5.01397e-05 0.020314 0 0.000137386 -0.00072646 0 4.85681e-05 -0.01627 0
+          -4.37142e-05 -0.00766426 0 -3.78905e-05 -0.00214828 0 -1.47692e-05 0.000752769 0 -2.77732e-06 0.000907942 0
+          0.0022671 0.775467 0 0.00184745 0.471494 0 0.000766845 0.159525 0 -3.66296e-07 0.0728904 0
+          4.37907e-06 0.0706851 0 9.71167e-05 0.0149689 0 2.7572e-05 -0.0145588 0 -2.13103e-05 0.00470758 0
+          -1.33476e-05 0.0131363 0 1.34816e-05 0.017659 0 3.54994e-05 0.00249735 0 1.46196e-05 -0.0119107 0
+          -1.04802e-05 -0.00735523 0 -1.07284e-05 -0.0022655 0 -4.29864e-06 0.000527793 0 -1.0855e-06 0.000773293 0
         </DataArray>
         <DataArray type="Float32" Name="velocity_Air (m/s)" NumberOfComponents="3" format="ascii">
-          2.13262 0.00210978 0 1.63378 0.000754932 0 1.45626 0.000264559 0 1.38858 0.000124064 0
-          1.35497 6.90012e-05 0 1.33575 4.13778e-05 0 1.32409 2.55775e-05 0 1.31686 1.5942e-05 0
-          1.31236 9.91864e-06 0 1.30956 6.13784e-06 0 1.30784 3.776e-06 0 1.30678 2.31129e-06 0
-          1.30613 1.4092e-06 0 1.30574 8.56871e-07 0 1.3055 5.21961e-07 0 1.30538 1.96187e-07 0
-          2.39901 0.00503147 0 2.2134 0.00219027 0 2.08512 0.000880058 0 2.01841 0.000433517 0
-          1.98203 0.000245138 0 1.9606 0.000147945 0 1.94746 9.16564e-05 0 1.93928 5.71496e-05 0
-          1.93418 3.55435e-05 0 1.93102 2.19822e-05 0 1.92908 1.35162e-05 0 1.92788 8.27002e-06 0
-          1.92715 5.04119e-06 0 1.92671 3.06511e-06 0 1.92644 1.86753e-06 0 1.9263 7.04405e-07 0
-          2.47479 0.00612713 0 2.40124 0.00341482 0 2.31871 0.00161587 0 2.26406 0.000849142 0
-          2.23121 0.000491787 0 2.21114 0.000299602 0 2.19866 0.000186208 0 2.19086 0.000116156 0
-          2.186 7.21939e-05 0 2.183 4.46063e-05 0 2.18115 2.74025e-05 0 2.18002 1.67547e-05 0
-          2.17933 1.02084e-05 0 2.17891 6.20486e-06 0 2.17865 3.78213e-06 0 2.17852 1.43226e-06 0
-          2.50434 0.00634255 0 2.48826 0.00428056 0 2.44523 0.00235742 0 2.4065 0.00133291 0
-          2.37998 0.000795716 0 2.36291 0.000490682 0 2.35209 0.000306199 0 2.3453 0.00019108 0
-          2.34107 0.000118638 0 2.33846 7.32007e-05 0 2.33685 4.49108e-05 0 2.33588 2.74313e-05 0
-          2.33528 1.67008e-05 0 2.33492 1.0145e-05 0 2.33471 6.18584e-06 0 2.33459 2.35038e-06 0
-          2.51624 0.00591593 0 2.53246 0.00460259 0 2.52257 0.002932 0 2.50271 0.00180671 0
-          2.48538 0.00112234 0 2.47312 0.000703572 0 2.46507 0.000441451 0 2.45997 0.000275612 0
-          2.45679 0.000170867 0 2.45484 0.000105217 0 2.45365 6.44358e-05 0 2.45293 3.92988e-05 0
-          2.45249 2.3899e-05 0 2.45223 1.45048e-05 0 2.45207 8.84403e-06 0 2.45199 3.36895e-06 0
-          2.52012 0.00493631 0 2.55287 0.00421277 0 2.56821 0.00306664 0 2.56879 0.00209225 0
-          2.56382 0.0013728 0 2.55873 0.000880862 0 2.55502 0.0005567 0 2.5526 0.000347621 0
-          2.55111 0.000214995 0 2.55021 0.000132009 0 2.54967 8.06346e-05 0 2.54935 4.90775e-05 0
-          2.54916 2.97996e-05 0 2.54905 1.80648e-05 0 2.54898 1.10112e-05 0 2.54894 4.20259e-06 0
-          2.5208 0.00341567 0 2.55946 0.0030503 0 2.58949 0.0024572 0 2.60829 0.00187079 0
-          2.61802 0.00132695 0 2.62258 0.000887136 0 2.6248 0.000569495 0 2.62603 0.000356465 0
-          2.62678 0.000219811 0 2.62726 0.00013438 0 2.62757 8.17471e-05 0 2.62776 4.959e-05 0
-          2.62788 3.00356e-05 0 2.62796 1.81743e-05 0 2.62801 1.10653e-05 0 2.62804 4.22614e-06 0
-          2.52078 0.00125817 0 2.56038 0.00113905 0 2.59515 0.00096551 0 2.62419 0.000792037 0
-          2.64713 0.000596434 0 2.66379 0.000412198 0 2.67503 0.000268177 0 2.68225 0.000168324 0
-          2.68674 0.000103614 0 2.6895 6.31491e-05 0 2.69118 3.82998e-05 0 2.69219 2.3176e-05 0
-          2.69281 1.40106e-05 0 2.69318 8.46602e-06 0 2.69341 5.14886e-06 0 2.69353 1.96617e-06 0
-          2.52078 -0.00125817 0 2.56038 -0.00113905 0 2.59515 -0.00096551 0 2.62419 -0.000792037 0
-          2.64713 -0.000596434 0 2.66379 -0.000412198 0 2.67503 -0.000268177 0 2.68225 -0.000168324 0
-          2.68674 -0.000103614 0 2.6895 -6.31491e-05 0 2.69118 -3.82998e-05 0 2.69219 -2.3176e-05 0
-          2.69281 -1.40106e-05 0 2.69318 -8.46602e-06 0 2.69341 -5.14886e-06 0 2.69353 -1.96617e-06 0
-          2.5208 -0.00341567 0 2.55946 -0.0030503 0 2.58949 -0.0024572 0 2.60829 -0.00187079 0
-          2.61802 -0.00132695 0 2.62258 -0.000887136 0 2.6248 -0.000569495 0 2.62603 -0.000356465 0
-          2.62678 -0.000219811 0 2.62726 -0.00013438 0 2.62757 -8.17471e-05 0 2.62776 -4.959e-05 0
-          2.62788 -3.00356e-05 0 2.62796 -1.81743e-05 0 2.62801 -1.10653e-05 0 2.62804 -4.22614e-06 0
-          2.52012 -0.00493631 0 2.55287 -0.00421277 0 2.56821 -0.00306664 0 2.56879 -0.00209225 0
-          2.56382 -0.0013728 0 2.55873 -0.000880862 0 2.55502 -0.0005567 0 2.5526 -0.000347621 0
-          2.55111 -0.000214995 0 2.55021 -0.000132009 0 2.54967 -8.06346e-05 0 2.54935 -4.90775e-05 0
-          2.54916 -2.97996e-05 0 2.54905 -1.80648e-05 0 2.54898 -1.10112e-05 0 2.54894 -4.20259e-06 0
-          2.51624 -0.00591593 0 2.53246 -0.00460259 0 2.52257 -0.002932 0 2.50271 -0.00180671 0
-          2.48538 -0.00112234 0 2.47312 -0.000703572 0 2.46507 -0.000441451 0 2.45997 -0.000275612 0
-          2.45679 -0.000170867 0 2.45484 -0.000105217 0 2.45365 -6.44358e-05 0 2.45293 -3.92988e-05 0
-          2.45249 -2.3899e-05 0 2.45223 -1.45048e-05 0 2.45207 -8.84403e-06 0 2.45199 -3.36895e-06 0
-          2.50434 -0.00634255 0 2.48826 -0.00428056 0 2.44523 -0.00235742 0 2.4065 -0.00133291 0
-          2.37998 -0.000795716 0 2.36291 -0.000490682 0 2.35209 -0.000306199 0 2.3453 -0.00019108 0
-          2.34107 -0.000118638 0 2.33846 -7.32007e-05 0 2.33685 -4.49108e-05 0 2.33588 -2.74313e-05 0
-          2.33528 -1.67008e-05 0 2.33492 -1.0145e-05 0 2.33471 -6.18584e-06 0 2.33459 -2.35038e-06 0
-          2.47479 -0.00612713 0 2.40124 -0.00341482 0 2.31871 -0.00161587 0 2.26406 -0.000849142 0
-          2.23121 -0.000491787 0 2.21114 -0.000299602 0 2.19866 -0.000186208 0 2.19086 -0.000116156 0
-          2.186 -7.21939e-05 0 2.183 -4.46063e-05 0 2.18115 -2.74025e-05 0 2.18002 -1.67547e-05 0
-          2.17933 -1.02084e-05 0 2.17891 -6.20486e-06 0 2.17865 -3.78213e-06 0 2.17852 -1.43226e-06 0
-          2.39901 -0.00503147 0 2.2134 -0.00219027 0 2.08512 -0.000880058 0 2.01841 -0.000433517 0
-          1.98203 -0.000245138 0 1.9606 -0.000147945 0 1.94746 -9.16564e-05 0 1.93928 -5.71496e-05 0
-          1.93418 -3.55435e-05 0 1.93102 -2.19822e-05 0 1.92908 -1.35162e-05 0 1.92788 -8.27002e-06 0
-          1.92715 -5.04119e-06 0 1.92671 -3.06511e-06 0 1.92644 -1.86753e-06 0 1.9263 -7.04405e-07 0
-          2.13262 -0.00210978 0 1.63378 -0.000754932 0 1.45626 -0.000264559 0 1.38858 -0.000124064 0
-          1.35497 -6.90012e-05 0 1.33575 -4.13778e-05 0 1.32409 -2.55775e-05 0 1.31686 -1.5942e-05 0
-          1.31236 -9.91864e-06 0 1.30956 -6.13784e-06 0 1.30784 -3.776e-06 0 1.30678 -2.31129e-06 0
-          1.30613 -1.4092e-06 0 1.30574 -8.56871e-07 0 1.3055 -5.21961e-07 0 1.30538 -1.96187e-07 0
+          2.07761 0.00242566 0 1.47957 0.00100872 0 1.28367 0.000116336 0 1.25468 5.01453e-05 0
+          1.22561 0.000116787 0 1.1975 4.46784e-05 0 1.19052 -4.59293e-06 0 1.18953 1.02362e-05 0
+          1.18391 2.20593e-05 0 1.17538 2.6933e-05 0 1.16978 5.26205e-06 0 1.17188 -1.73307e-05 0
+          1.17714 -1.28878e-05 0 1.18011 -4.15204e-06 0 1.18075 5.06639e-07 0 1.18047 1.08101e-06 0
+          2.38628 0.00576564 0 2.14543 0.00303948 0 1.94733 0.000803422 0 1.84352 0.000364102 0
+          1.78737 0.000421259 0 1.76156 0.000109178 0 1.76632 -6.72728e-05 0 1.7723 3.05429e-05 0
+          1.76675 7.86469e-05 0 1.75635 0.00010299 0 1.74955 1.60399e-05 0 1.75309 -6.85792e-05 0
+          1.75963 -4.45018e-05 0 1.76266 -1.38629e-05 0 1.76313 2.77535e-06 0 1.76263 4.39272e-06 0
+          2.48263 0.00687549 0 2.40526 0.00473685 0 2.27794 0.00213196 0 2.16452 0.00114677 0
+          2.08741 0.000958049 0 2.04046 0.00030835 0 2.01822 -5.431e-05 0 2.00495 0.000118866 0
+          1.99069 0.000195461 0 1.97585 0.000236882 0 1.97045 -2.33479e-06 0 1.97996 -0.000185671 0
+          1.98994 -9.23723e-05 0 1.99318 -2.67383e-05 0 1.99354 7.8219e-06 0 1.99293 1.0217e-05 0
+          2.51407 0.00684927 0 2.52122 0.00552131 0 2.48153 0.00340618 0 2.41111 0.00225882 0
+          2.34207 0.00180202 0 2.2841 0.000906265 0 2.23833 0.000319485 0 2.20557 0.000410678 0
+          2.18116 0.000448787 0 2.16109 0.00046691 0 2.15027 -9.35448e-07 0 2.1515 -0.000313439 0
+          2.15495 -0.000131277 0 2.15518 -2.79203e-05 0 2.15389 2.53645e-05 0 2.15243 2.25666e-05 0
+          2.52057 0.00617368 0 2.5554 0.00531584 0 2.56969 0.00392204 0 2.55829 0.00310417 0
+          2.53195 0.00262602 0 2.49793 0.00174611 0 2.45943 0.00105046 0 2.42443 0.000968236 0
+          2.39621 0.000898395 0 2.37341 0.000836654 0 2.35442 0.000218888 0 2.33973 -0.000228425 0
+          2.33042 -6.53359e-05 0 2.3245 3.32452e-05 0 2.3199 8.61041e-05 0 2.31679 5.33453e-05 0
+          2.52129 0.00506216 0 2.56089 0.00443614 0 2.59214 0.00352137 0 2.61312 0.00310863 0
+          2.6256 0.00281738 0 2.62815 0.00222645 0 2.61909 0.00169962 0 2.60431 0.00154789 0
+          2.58926 0.00140614 0 2.57519 0.00126665 0 2.56046 0.000662732 0 2.54428 0.000151795 0
+          2.53032 0.000190803 0 2.52022 0.000219873 0 2.51276 0.000231655 0 2.50815 0.000118542 0
+          2.52126 0.00348503 0 2.56117 0.00306486 0 2.59479 0.00247387 0 2.62329 0.00227611 0
+          2.64923 0.00214311 0 2.67127 0.00186911 0 2.68737 0.00164056 0 2.69894 0.00156339 0
+          2.70789 0.00146865 0 2.71459 0.00134947 0 2.71692 0.000934078 0 2.71333 0.000535553 0
+          2.70763 0.000484579 0 2.70291 0.000442433 0 2.69917 0.000401328 0 2.69684 0.000192124 0
+          2.52119 0.0012828 0 2.56104 0.00112934 0 2.59478 0.000913247 0 2.62384 0.000845638 0
+          2.65108 0.000803304 0 2.67635 0.000726364 0 2.69959 0.000680281 0 2.72193 0.000671616 0
+          2.74378 0.000650989 0 2.76466 0.000613382 0 2.7827 0.000478057 0 2.79612 0.000334349 0
+          2.80658 0.000298959 0 2.81593 0.000266699 0 2.82423 0.000235966 0 2.82997 0.000111265 0
+          2.52119 -0.0012828 0 2.56104 -0.00112934 0 2.59478 -0.000913247 0 2.62384 -0.000845638 0
+          2.65108 -0.000803304 0 2.67635 -0.000726364 0 2.69959 -0.000680281 0 2.72193 -0.000671616 0
+          2.74378 -0.000650989 0 2.76466 -0.000613382 0 2.7827 -0.000478057 0 2.79612 -0.000334349 0
+          2.80658 -0.000298959 0 2.81593 -0.000266699 0 2.82423 -0.000235966 0 2.82997 -0.000111265 0
+          2.52126 -0.00348503 0 2.56117 -0.00306486 0 2.59479 -0.00247387 0 2.62329 -0.00227611 0
+          2.64923 -0.00214311 0 2.67127 -0.00186911 0 2.68737 -0.00164056 0 2.69894 -0.00156339 0
+          2.70789 -0.00146865 0 2.71459 -0.00134947 0 2.71692 -0.000934078 0 2.71333 -0.000535553 0
+          2.70763 -0.000484579 0 2.70291 -0.000442433 0 2.69917 -0.000401328 0 2.69684 -0.000192124 0
+          2.52129 -0.00506216 0 2.56089 -0.00443614 0 2.59214 -0.00352137 0 2.61312 -0.00310863 0
+          2.6256 -0.00281738 0 2.62815 -0.00222645 0 2.61909 -0.00169962 0 2.60431 -0.00154789 0
+          2.58926 -0.00140614 0 2.57519 -0.00126665 0 2.56046 -0.000662732 0 2.54428 -0.000151795 0
+          2.53032 -0.000190803 0 2.52022 -0.000219873 0 2.51276 -0.000231655 0 2.50815 -0.000118542 0
+          2.52057 -0.00617368 0 2.5554 -0.00531584 0 2.56969 -0.00392204 0 2.55829 -0.00310417 0
+          2.53195 -0.00262602 0 2.49793 -0.00174611 0 2.45943 -0.00105046 0 2.42443 -0.000968236 0
+          2.39621 -0.000898395 0 2.37341 -0.000836654 0 2.35442 -0.000218888 0 2.33973 0.000228425 0
+          2.33042 6.53359e-05 0 2.3245 -3.32452e-05 0 2.3199 -8.61041e-05 0 2.31679 -5.33453e-05 0
+          2.51407 -0.00684927 0 2.52122 -0.00552131 0 2.48153 -0.00340618 0 2.41111 -0.00225882 0
+          2.34207 -0.00180202 0 2.2841 -0.000906265 0 2.23833 -0.000319485 0 2.20557 -0.000410678 0
+          2.18116 -0.000448787 0 2.16109 -0.00046691 0 2.15027 9.35448e-07 0 2.1515 0.000313439 0
+          2.15495 0.000131277 0 2.15518 2.79203e-05 0 2.15389 -2.53645e-05 0 2.15243 -2.25666e-05 0
+          2.48263 -0.00687549 0 2.40526 -0.00473685 0 2.27794 -0.00213196 0 2.16452 -0.00114677 0
+          2.08741 -0.000958049 0 2.04046 -0.00030835 0 2.01822 5.431e-05 0 2.00495 -0.000118866 0
+          1.99069 -0.000195461 0 1.97585 -0.000236882 0 1.97045 2.33479e-06 0 1.97996 0.000185671 0
+          1.98994 9.23723e-05 0 1.99318 2.67383e-05 0 1.99354 -7.8219e-06 0 1.99293 -1.0217e-05 0
+          2.38628 -0.00576564 0 2.14543 -0.00303948 0 1.94733 -0.000803422 0 1.84352 -0.000364102 0
+          1.78737 -0.000421259 0 1.76156 -0.000109178 0 1.76632 6.72728e-05 0 1.7723 -3.05429e-05 0
+          1.76675 -7.86469e-05 0 1.75635 -0.00010299 0 1.74955 -1.60399e-05 0 1.75309 6.85792e-05 0
+          1.75963 4.45018e-05 0 1.76266 1.38629e-05 0 1.76313 -2.77535e-06 0 1.76263 -4.39272e-06 0
+          2.07761 -0.00242566 0 1.47957 -0.00100872 0 1.28367 -0.000116336 0 1.25468 -5.01453e-05 0
+          1.22561 -0.000116787 0 1.1975 -4.46784e-05 0 1.19052 4.59293e-06 0 1.18953 -1.02362e-05 0
+          1.18391 -2.20593e-05 0 1.17538 -2.6933e-05 0 1.16978 -5.26205e-06 0 1.17188 1.73307e-05 0
+          1.17714 1.28878e-05 0 1.18011 4.15204e-06 0 1.18075 -5.06639e-07 0 1.18047 -1.08101e-06 0
         </DataArray>
         <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii">
           0 0 0 0 0 0 0 0 0 0 0 0
-- 
GitLab