From d0755697d901b5808510bff1581f7a155a33ba4d Mon Sep 17 00:00:00 2001
From: Thomas Fetzer <thomas.fetzer@iws.uni-stuttgart.de>
Date: Tue, 17 Jul 2018 12:33:11 +0200
Subject: [PATCH] [rans][ni] Improve inheritance structure / fix calculation of
 the eddy thermal conductivity

previous implementation could potentially result in unwanted forward calls in the fluid system
---
 dumux/freeflow/rans/oneeq/volumevariables.hh  |  72 +----
 .../rans/twoeq/kepsilon/volumevariables.hh    |  74 +----
 .../rans/twoeq/komega/volumevariables.hh      |  72 +----
 .../twoeq/lowrekepsilon/volumevariables.hh    |  72 +----
 dumux/freeflow/rans/volumevariables.hh        | 173 ++++++----
 dumux/freeflow/rans/zeroeq/volumevariables.hh |  79 +----
 test/freeflow/rans/CMakeLists.txt             |   2 +-
 test/freeflow/ransnc/CMakeLists.txt           |  12 +-
 .../test_flatplate_kepsilon2cni.vtu           | 300 +++++++++---------
 .../test_flatplate_lowrekepsilon2cni.vtu      | 200 ++++++------
 test/references/test_flatplate_zeroeq2cni.vtu | 200 ++++++------
 11 files changed, 501 insertions(+), 755 deletions(-)

diff --git a/dumux/freeflow/rans/oneeq/volumevariables.hh b/dumux/freeflow/rans/oneeq/volumevariables.hh
index 657f08ed75..c4f8d7e1ce 100644
--- a/dumux/freeflow/rans/oneeq/volumevariables.hh
+++ b/dumux/freeflow/rans/oneeq/volumevariables.hh
@@ -39,12 +39,9 @@ namespace Dumux
  */
 template <class Traits, class NSVolumeVariables>
 class OneEqVolumeVariables
-:  public RANSVolumeVariables< Traits, OneEqVolumeVariables<Traits, NSVolumeVariables> >
-,  public NSVolumeVariables
+:  public RANSVolumeVariables<Traits, NSVolumeVariables>
 {
-    using ThisType = OneEqVolumeVariables<Traits, NSVolumeVariables>;
-    using RANSParentType = RANSVolumeVariables<Traits, ThisType>;
-    using NavierStokesParentType = NSVolumeVariables;
+    using RANSParentType = RANSVolumeVariables<Traits, NSVolumeVariables>;
 
     using Scalar = typename Traits::PrimaryVariables::value_type;
     using DimVector = Dune::FieldVector<Scalar, Traits::ModelTraits::dim()>;
@@ -73,7 +70,7 @@ public:
                 const Element &element,
                 const SubControlVolume& scv)
     {
-        NavierStokesParentType::update(elemSol, problem, element, scv);
+        RANSParentType::updateNavierStokesVolVars(elemSol, problem, element, scv);
         updateRANSProperties(elemSol, problem, element, scv);
     }
 
@@ -100,53 +97,19 @@ public:
         stressTensorScalarProduct_ = problem.stressTensorScalarProduct_[RANSParentType::elementID()];
         vorticityTensorScalarProduct_ = problem.vorticityTensorScalarProduct_[RANSParentType::elementID()];
         if (problem.useStoredEddyViscosity_)
-            dynamicEddyViscosity_ = problem.storedDynamicEddyViscosity_[RANSParentType::elementID()];
+            RANSParentType::setDynamicEddyViscosity_(problem.storedDynamicEddyViscosity_[RANSParentType::elementID()]);
         else
-            dynamicEddyViscosity_ = calculateEddyViscosity();
-        calculateEddyDiffusivity(problem);
+            RANSParentType::setDynamicEddyViscosity_(calculateEddyViscosity());
+        RANSParentType::calculateEddyDiffusivity(problem);
+        RANSParentType::calculateEddyThermalConductivity(problem);
     }
 
-    /*!
-     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow
-     */
-    Scalar dynamicEddyViscosity() const
-    { return dynamicEddyViscosity_; }
-
-    /*!
-     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
-     *        control volume.
-     */
-    Scalar effectiveViscosity() const
-    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
-
     /*!
      * \brief Returns the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$.
      */
     Scalar calculateEddyViscosity()
     {
-        return viscosityTilde() * fv1() *  NavierStokesParentType::density();
-    }
-
-    /*!
-     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
-     *        of the fluid-flow in the sub-control volume.
-     */
-    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
-    Scalar effectiveThermalConductivity() const
-    {
-        return NavierStokesParentType::thermalConductivity()
-               + RANSParentType::eddyThermalConductivity();
-    }
-
-    /*!
-     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
-     *        on the kinematic eddy viscosity and the turbulent schmidt number
-     */
-    template<class Problem>
-    void calculateEddyDiffusivity(const Problem& problem)
-    {
-        eddyDiffusivity_ = RANSParentType::kinematicEddyViscosity()
-                           / problem.turbulentSchmidtNumber();
+        return viscosityTilde() * fv1() *  RANSParentType::density();
     }
 
     /*!
@@ -314,26 +277,7 @@ public:
     Scalar cw3() const
     { return 2.0; }
 
-    /*!
-     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
-     */
-    Scalar eddyDiffusivity() const
-    { return eddyDiffusivity_; }
-
-     /*!
-     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
-     *
-     * \param compIIdx the index of the component which diffusive
-     * \param compJIdx the index of the component with respect to which compIIdx diffuses
-     */
-    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
-    {
-        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
-    }
-
 protected:
-    Scalar dynamicEddyViscosity_ = 0.0;
-    Scalar eddyDiffusivity_ = 0.0;
     Scalar viscosityTilde_ = 0.0;
     Scalar storedViscosityTilde_ = 0.0;
     DimVector storedViscosityTildeGradient_ = DimVector(0.0);
diff --git a/dumux/freeflow/rans/twoeq/kepsilon/volumevariables.hh b/dumux/freeflow/rans/twoeq/kepsilon/volumevariables.hh
index b06269c068..2691c01041 100644
--- a/dumux/freeflow/rans/twoeq/kepsilon/volumevariables.hh
+++ b/dumux/freeflow/rans/twoeq/kepsilon/volumevariables.hh
@@ -38,12 +38,9 @@ namespace Dumux
  */
 template <class Traits, class NSVolumeVariables>
 class KEpsilonVolumeVariables
-:  public RANSVolumeVariables< Traits, KEpsilonVolumeVariables<Traits, NSVolumeVariables> >
-,  public NSVolumeVariables
+:  public RANSVolumeVariables<Traits, NSVolumeVariables>
 {
-    using ThisType = KEpsilonVolumeVariables<Traits, NSVolumeVariables>;
-    using RANSParentType = RANSVolumeVariables<Traits, ThisType>;
-    using NavierStokesParentType = NSVolumeVariables;
+    using RANSParentType = RANSVolumeVariables<Traits, NSVolumeVariables>;
 
     using Scalar = typename Traits::PrimaryVariables::value_type;
 
@@ -72,7 +69,7 @@ public:
                 const Element &element,
                 const SubControlVolume& scv)
     {
-        NavierStokesParentType::update(elemSol, problem, element, scv);
+        RANSParentType::updateNavierStokesVolVars(elemSol, problem, element, scv);
         updateRANSProperties(elemSol, problem, element, scv);
     }
 
@@ -106,38 +103,15 @@ public:
         uPlusNominal_ = RANSParentType::velocity()[flowNormalAxis] / uStarNominal;
         cMu_ = problem.cMu();
         if (problem.useStoredEddyViscosity_)
-            dynamicEddyViscosity_ = problem.storedDynamicEddyViscosity_[RANSParentType::elementID()];
+            RANSParentType::setDynamicEddyViscosity_(problem.storedDynamicEddyViscosity_[RANSParentType::elementID()]);
         else
-            dynamicEddyViscosity_ = calculateEddyViscosity();
+            RANSParentType::setDynamicEddyViscosity_(calculateEddyViscosity());
         if (inNearWallRegion_)
         {
-            dynamicEddyViscosity_ = problem.zeroEqDynamicEddyViscosity_[RANSParentType::elementID()];
+            RANSParentType::setDynamicEddyViscosity_(problem.zeroEqDynamicEddyViscosity_[RANSParentType::elementID()]);
         }
-        calculateEddyDiffusivity(problem);
-    }
-
-    /*!
-     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow
-     */
-    Scalar dynamicEddyViscosity() const
-    { return dynamicEddyViscosity_; }
-
-    /*!
-     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
-     *        control volume.
-     */
-    Scalar effectiveViscosity() const
-    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
-
-    /*!
-     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
-     *        of the fluid-flow in the sub-control volume.
-     */
-    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
-    Scalar effectiveThermalConductivity() const
-    {
-        return NavierStokesParentType::thermalConductivity()
-               + RANSParentType::eddyThermalConductivity();
+        RANSParentType::calculateEddyDiffusivity(problem);
+        RANSParentType::calculateEddyThermalConductivity(problem);
     }
 
     /*!
@@ -146,18 +120,7 @@ public:
     Scalar calculateEddyViscosity()
     {
         return cMu() * turbulentKineticEnergy() * turbulentKineticEnergy()
-               / dissipation() *  NavierStokesParentType::density();
-    }
-
-    /*!
-     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
-     *        on the kinematic eddy viscosity and the turbulent schmidt number
-     */
-    template<class Problem>
-    void calculateEddyDiffusivity(const Problem& problem)
-    {
-        eddyDiffusivity_ = RANSParentType::kinematicEddyViscosity()
-                           / problem.turbulentSchmidtNumber();
+               / dissipation() *  RANSParentType::density();
     }
 
     /*!
@@ -248,26 +211,7 @@ public:
     Scalar uPlusNominal() const
     { return uPlusNominal_; }
 
-    /*!
-     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
-     */
-    Scalar eddyDiffusivity() const
-    { return eddyDiffusivity_; }
-
-     /*!
-     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
-     *
-     * \param compIIdx the index of the component which diffusive
-     * \param compJIdx the index of the component with respect to which compIIdx diffuses
-     */
-    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
-    {
-        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
-    }
-
 protected:
-    Scalar dynamicEddyViscosity_ = 0.0;
-    Scalar eddyDiffusivity_ = 0.0;
     Scalar turbulentKineticEnergy_ = 0.0;
     Scalar dissipation_ = 0.0;
     Scalar storedTurbulentKineticEnergy_ = 0.0;
diff --git a/dumux/freeflow/rans/twoeq/komega/volumevariables.hh b/dumux/freeflow/rans/twoeq/komega/volumevariables.hh
index 89bd7c1411..897ed12f83 100644
--- a/dumux/freeflow/rans/twoeq/komega/volumevariables.hh
+++ b/dumux/freeflow/rans/twoeq/komega/volumevariables.hh
@@ -39,12 +39,9 @@ namespace Dumux
  */
 template <class Traits, class NSVolumeVariables>
 class KOmegaVolumeVariables
-:  public RANSVolumeVariables< Traits, KOmegaVolumeVariables<Traits, NSVolumeVariables> >
-,  public NSVolumeVariables
+:  public RANSVolumeVariables<Traits, NSVolumeVariables>
 {
-    using ThisType = KOmegaVolumeVariables<Traits, NSVolumeVariables>;
-    using RANSParentType = RANSVolumeVariables<Traits, ThisType>;
-    using NavierStokesParentType = NSVolumeVariables;
+    using RANSParentType = RANSVolumeVariables<Traits, NSVolumeVariables>;
 
     using ModelTraits = typename Traits::ModelTraits;
     using Scalar = typename Traits::PrimaryVariables::value_type;
@@ -73,7 +70,7 @@ public:
                 const Element &element,
                 const SubControlVolume& scv)
     {
-        NavierStokesParentType::update(elemSol, problem, element, scv);
+        RANSParentType::updateNavierStokesVolVars(elemSol, problem, element, scv);
         updateRANSProperties(elemSol, problem, element, scv);
     }
 
@@ -103,10 +100,11 @@ public:
         storedTurbulentKineticEnergyGradient_ = problem.storedTurbulentKineticEnergyGradient_[RANSParentType::elementID()];
         stressTensorScalarProduct_ = problem.stressTensorScalarProduct_[RANSParentType::elementID()];
         if (problem.useStoredEddyViscosity_)
-            dynamicEddyViscosity_ = problem.storedDynamicEddyViscosity_[RANSParentType::elementID()];
+            RANSParentType::setDynamicEddyViscosity_(problem.storedDynamicEddyViscosity_[RANSParentType::elementID()]);
         else
-            dynamicEddyViscosity_ = calculateEddyViscosity(problem);
-        calculateEddyDiffusivity(problem);
+            RANSParentType::setDynamicEddyViscosity_(calculateEddyViscosity(problem));
+        RANSParentType::calculateEddyDiffusivity(problem);
+        RANSParentType::calculateEddyThermalConductivity(problem);
     }
 
     /*!
@@ -127,42 +125,7 @@ public:
             limitiedDissipation = (7.0 / 8.0) * sqrt(2.0 * stressTensorScalarProduct() / betaK());
         }
         return turbulentKineticEnergy() / max(dissipation(), limitiedDissipation)
-               * NavierStokesParentType::density();
-    }
-
-    /*!
-     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow
-     */
-    Scalar dynamicEddyViscosity() const
-    { return dynamicEddyViscosity_; }
-
-    /*!
-     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
-     *        control volume.
-     */
-    Scalar effectiveViscosity() const
-    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
-
-    /*!
-     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
-     *        of the fluid-flow in the sub-control volume.
-     */
-    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
-    Scalar effectiveThermalConductivity() const
-    {
-        return NavierStokesParentType::thermalConductivity()
-               + RANSParentType::eddyThermalConductivity();
-    }
-
-    /*!
-     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
-     *        on the kinematic eddy viscosity and the turbulent schmidt number
-     */
-    template<class Problem>
-    void calculateEddyDiffusivity(const Problem& problem)
-    {
-        eddyDiffusivity_ = RANSParentType::kinematicEddyViscosity()
-                           / problem.turbulentSchmidtNumber();
+               * RANSParentType::density();
     }
 
     /*!
@@ -241,27 +204,8 @@ public:
     const Scalar betaOmega() const
     { return betaOmega_; }
 
-    /*!
-     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
-     */
-    Scalar eddyDiffusivity() const
-    { return eddyDiffusivity_; }
-
-     /*!
-     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
-     *
-     * \param compIIdx the index of the component which diffusive
-     * \param compJIdx the index of the component with respect to which compIIdx diffuses
-     */
-    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
-    {
-        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
-    }
-
 protected:
     Scalar betaOmega_ = 0.0;
-    Scalar eddyDiffusivity_ = 0.0;
-    Scalar dynamicEddyViscosity_ = 0.0;
     Scalar dissipation_ = 0.0;
     Scalar turbulentKineticEnergy_ = 0.0;
     Scalar storedDissipation_ = 0.0;
diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/volumevariables.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/volumevariables.hh
index f9ba874a21..2c4dcaddc2 100644
--- a/dumux/freeflow/rans/twoeq/lowrekepsilon/volumevariables.hh
+++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/volumevariables.hh
@@ -38,12 +38,9 @@ namespace Dumux
  */
 template <class Traits, class NSVolumeVariables>
 class LowReKEpsilonVolumeVariables
-:  public RANSVolumeVariables< Traits, LowReKEpsilonVolumeVariables<Traits, NSVolumeVariables> >
-,  public NSVolumeVariables
+:  public RANSVolumeVariables<Traits, NSVolumeVariables>
 {
-    using ThisType = LowReKEpsilonVolumeVariables<Traits, NSVolumeVariables>;
-    using RANSParentType = RANSVolumeVariables<Traits, ThisType>;
-    using NavierStokesParentType = NSVolumeVariables;
+    using RANSParentType = RANSVolumeVariables<Traits, NSVolumeVariables>;
 
     using Scalar = typename Traits::PrimaryVariables::value_type;
 
@@ -71,7 +68,7 @@ public:
                 const Element &element,
                 const SubControlVolume& scv)
     {
-        NavierStokesParentType::update(elemSol, problem, element, scv);
+        RANSParentType::updateNavierStokesVolVars(elemSol, problem, element, scv);
         updateRANSProperties(elemSol, problem, element, scv);
     }
 
@@ -98,34 +95,11 @@ public:
         storedTurbulentKineticEnergy_ = problem.storedTurbulentKineticEnergy_[RANSParentType::elementID()];
         stressTensorScalarProduct_ = problem.stressTensorScalarProduct_[RANSParentType::elementID()];
         if (problem.useStoredEddyViscosity_)
-            dynamicEddyViscosity_ = problem.storedDynamicEddyViscosity_[RANSParentType::elementID()];
+            RANSParentType::setDynamicEddyViscosity_(problem.storedDynamicEddyViscosity_[RANSParentType::elementID()]);
         else
-            dynamicEddyViscosity_ = calculateEddyViscosity();
-        calculateEddyDiffusivity(problem);
-    }
-
-    /*!
-     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow
-     */
-    Scalar dynamicEddyViscosity() const
-    { return dynamicEddyViscosity_; }
-
-    /*!
-     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
-     *        control volume.
-     */
-    Scalar effectiveViscosity() const
-    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
-
-    /*!
-     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
-     *        of the fluid-flow in the sub-control volume.
-     */
-    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
-    Scalar effectiveThermalConductivity() const
-    {
-        return NavierStokesParentType::thermalConductivity()
-               + RANSParentType::eddyThermalConductivity();
+            RANSParentType::setDynamicEddyViscosity_(calculateEddyViscosity());
+        RANSParentType::calculateEddyDiffusivity(problem);
+        RANSParentType::calculateEddyThermalConductivity(problem);
     }
 
     /*!
@@ -134,18 +108,7 @@ public:
     Scalar calculateEddyViscosity()
     {
         return cMu() * fMu() * turbulentKineticEnergy() * turbulentKineticEnergy()
-               / dissipationTilde() *  NavierStokesParentType::density();
-    }
-
-    /*!
-     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
-     *        on the kinematic eddy viscosity and the turbulent schmidt number
-     */
-    template<class Problem>
-    void calculateEddyDiffusivity(const Problem& problem)
-    {
-        eddyDiffusivity_ = RANSParentType::kinematicEddyViscosity()
-                           / problem.turbulentSchmidtNumber();
+               / dissipationTilde() *  RANSParentType::density();
     }
 
     /*!
@@ -258,26 +221,7 @@ public:
                 * exp(-0.5 * RANSParentType::yPlus());
     }
 
-    /*!
-     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
-     */
-    Scalar eddyDiffusivity() const
-    { return eddyDiffusivity_; }
-
-     /*!
-     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
-     *
-     * \param compIIdx the index of the component which diffusive
-     * \param compJIdx the index of the component with respect to which compIIdx diffuses
-     */
-    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
-    {
-        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
-    }
-
 protected:
-    Scalar dynamicEddyViscosity_ = 0.0;
-    Scalar eddyDiffusivity_ = 0.0;
     Scalar turbulentKineticEnergy_ = 0.0;
     Scalar dissipationTilde_ = 0.0;
     Scalar storedTurbulentKineticEnergy_ = 0.0;
diff --git a/dumux/freeflow/rans/volumevariables.hh b/dumux/freeflow/rans/volumevariables.hh
index 88a546b3ff..2920a851e8 100644
--- a/dumux/freeflow/rans/volumevariables.hh
+++ b/dumux/freeflow/rans/volumevariables.hh
@@ -32,34 +32,45 @@
 
 namespace Dumux
 {
-
-// forward declaration
-template <class Traits, class Impl, bool enableEnergyBalance>
-class RANSVolumeVariablesImplementation;
-
-/*!
- * \ingroup RANSModel
- * \brief Volume variables for the single-phase Reynolds-Averaged Navier-Stokes models.
- *        The class is specialized for isothermal and non-isothermal models.
- */
-template <class Traits, class Impl>
-using RANSVolumeVariables = RANSVolumeVariablesImplementation<Traits, Impl, Traits::ModelTraits::enableEnergyBalance()>;
-
 /*!
  * \ingroup RANSModel
  * \brief Volume variables for the isothermal single-phase Reynolds-Averaged Navier-Stokes models.
  */
-template <class Traits, class Impl>
-class RANSVolumeVariablesImplementation<Traits, Impl, false>
+template <class Traits, class NSVolumeVariables>
+class RANSVolumeVariables
+: public NSVolumeVariables
 {
+    using NavierStokesParentType = NSVolumeVariables;
+
     using Scalar = typename Traits::PrimaryVariables::value_type;
 
     enum { dimWorld = Traits::ModelTraits::dim() };
     using DimVector = Dune::FieldVector<Scalar, dimWorld>;
     using DimMatrix = Dune::FieldMatrix<Scalar, dimWorld, dimWorld>;
 
+    static constexpr bool enableEnergyBalance = Traits::ModelTraits::enableEnergyBalance();
+    static constexpr int fluidSystemPhaseIdx = Traits::ModelTraits::Indices::fluidSystemPhaseIdx;
+
 public:
 
+    /*!
+     * \brief Update all quantities for a given control volume
+     *
+     * \param elemSol A vector containing all primary variables connected to the element
+     * \param problem The object specifying the problem which ought to
+     *                be simulated
+     * \param element An element which contains part of the control volume
+     * \param scv The sub-control volume
+     */
+    template<class ElementSolution, class Problem, class Element, class SubControlVolume>
+    void updateNavierStokesVolVars(const ElementSolution &elemSol,
+                                   const Problem &problem,
+                                   const Element &element,
+                                   const SubControlVolume& scv)
+    {
+        NavierStokesParentType::update(elemSol, problem, element, scv);
+    }
+
     /*!
      * \brief Update all turbulent quantities for a given control volume
      *
@@ -152,92 +163,116 @@ public:
     Scalar uPlus() const
     { return uPlus_; }
 
+    /*!
+     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow within the
+     *        control volume.
+     */
+    Scalar dynamicEddyViscosity() const
+    { return dynamicEddyViscosity_; }
+
+    /*!
+     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
+     *        control volume.
+     */
+    Scalar effectiveViscosity() const
+    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
+
     /*!
      * \brief Return the kinematic eddy viscosity \f$\mathrm{[m^2/s]}\f$ of the flow within the
      *        control volume.
      */
     Scalar kinematicEddyViscosity() const
-    { return asImp_().dynamicEddyViscosity() / asImp_().density(); }
+    { return dynamicEddyViscosity() / NavierStokesParentType::density(); }
 
     /*!
      * \brief Return the kinematic viscosity \f$\mathrm{[m^2/s]}\f$ of the fluid within the
      *        control volume.
      */
     Scalar kinematicViscosity() const
-    { return asImp_().viscosity() / asImp_().density(); }
-
-protected:
-    DimVector velocity_;
-    DimVector velocityMaximum_;
-    DimMatrix velocityGradients_;
-    std::size_t elementID_;
-    std::size_t wallElementID_;
-    Scalar wallDistance_;
-    Scalar karmanConstant_;
-    Scalar uStar_;
-    Scalar yPlus_;
-    Scalar uPlus_;
-
-    const Impl &asImp_() const { return *static_cast<const Impl*>(this); }
-    Impl &asImp_() { return *static_cast<Impl*>(this); }
-};
-
-/*!
- * \ingroup RANSModel
- * \brief Volume variables for the non-isothermal single-phase Reynolds-Averaged Navier-Stokes models.
- */
-template <class Traits, class Impl>
-class RANSVolumeVariablesImplementation<Traits, Impl, true>
-: public RANSVolumeVariablesImplementation<Traits, Impl, false>
-{
-    using ParentType = RANSVolumeVariablesImplementation<Traits, Impl, false>;
-    using Scalar = typename Traits::PrimaryVariables::value_type;
-
-public:
+    { return NavierStokesParentType::viscosity() / NavierStokesParentType::density(); }
 
     /*!
-     * \brief Update all turbulent quantities for a given control volume
-     *
-     * Wall related quantities are stored and the calculateEddyViscosity(...)
-     * function of the turbulence model implementation is called.
-     *
-     * \param elemSol A vector containing all primary variables connected to the element
-     * \param problem The object specifying the problem which ought to be simulated
-     * \param element An element which contains part of the control volume
-     * \param scv The sub-control volume
+     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
+     *        on the kinematic eddy viscosity and the turbulent Schmidt number
      */
-    template<class ElementSolution, class Problem, class Element, class SubControlVolume>
-    void updateRANSProperties(const ElementSolution &elemSol,
-                              const Problem &problem,
-                              const Element &element,
-                              const SubControlVolume& scv)
+    template<class Problem>
+    void calculateEddyDiffusivity(const Problem& problem)
     {
-        ParentType::updateRANSProperties(elemSol, problem, element, scv);
-        calculateEddyThermalConductivity(problem);
+        eddyDiffusivity_ = kinematicEddyViscosity()
+                           / problem.turbulentSchmidtNumber();
     }
 
     /*!
      * \brief Calculates the eddy thermal conductivity \f$\mathrm{[W/(m*K)]}\f$ based
-     *        on the kinematic eddy viscosity and the turbulent prandtl number
+     *        on the kinematic eddy viscosity and the turbulent Prandtl number
      */
-    template<class Problem>
+    template<class Problem, bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
     void calculateEddyThermalConductivity(const Problem& problem)
     {
-        eddyThermalConductivity_ = ParentType::kinematicEddyViscosity()
-                                   * ParentType::asImp_().density()
-                                   * ParentType::asImp_().heatCapacity()
+        eddyThermalConductivity_ = kinematicEddyViscosity()
+                                   * NavierStokesParentType::density()
+                                   * NavierStokesParentType::heatCapacity()
                                    / problem.turbulentPrandtlNumber();
     }
 
+    //! \brief Eddy thermal conductivity is zero for isothermal model
+    template<class Problem, bool eB = enableEnergyBalance, typename std::enable_if_t<!eB, int> = 0>
+    void calculateEddyThermalConductivity(const Problem& problem)
+    { eddyThermalConductivity_ = 0.0; }
+
+    /*!
+     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
+     */
+    Scalar eddyDiffusivity() const
+    { return eddyDiffusivity_; }
+
     /*!
      * \brief Returns the eddy thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
-     *        of the flow in the sub-control volume.
      */
     Scalar eddyThermalConductivity() const
     { return eddyThermalConductivity_; }
 
+     /*!
+     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
+     *
+     * \param compIIdx the index of the component which diffusive
+     * \param compJIdx the index of the component with respect to which compIIdx diffuses
+     */
+    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
+    {
+        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
+    }
+
+    /*!
+     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
+     *        of the fluid-flow in the sub-control volume.
+     */
+    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
+    Scalar effectiveThermalConductivity() const
+    {
+        return NavierStokesParentType::thermalConductivity() + eddyThermalConductivity();
+    }
+
 protected:
-    Scalar eddyThermalConductivity_;
+    /*!
+     * \brief Sets the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$
+     */
+    Scalar setDynamicEddyViscosity_(Scalar value)
+    { return dynamicEddyViscosity_  = value; }
+
+    DimVector velocity_;
+    DimVector velocityMaximum_;
+    DimMatrix velocityGradients_;
+    std::size_t elementID_;
+    std::size_t wallElementID_;
+    Scalar wallDistance_;
+    Scalar karmanConstant_;
+    Scalar uStar_;
+    Scalar yPlus_;
+    Scalar uPlus_;
+    Scalar dynamicEddyViscosity_ = 0.0;
+    Scalar eddyDiffusivity_ = 0.0;
+    Scalar eddyThermalConductivity_ = 0.0;
 };
 }
 
diff --git a/dumux/freeflow/rans/zeroeq/volumevariables.hh b/dumux/freeflow/rans/zeroeq/volumevariables.hh
index 2d6a5264db..838b56154d 100644
--- a/dumux/freeflow/rans/zeroeq/volumevariables.hh
+++ b/dumux/freeflow/rans/zeroeq/volumevariables.hh
@@ -39,18 +39,12 @@ namespace Dumux
  */
 template <class Traits, class NSVolumeVariables>
 class ZeroEqVolumeVariables
-:  public RANSVolumeVariables< Traits, ZeroEqVolumeVariables<Traits, NSVolumeVariables> >
-,  public NSVolumeVariables
+: public RANSVolumeVariables< Traits, NSVolumeVariables>
 {
-    using ThisType = ZeroEqVolumeVariables<Traits, NSVolumeVariables>;
-    using RANSParentType = RANSVolumeVariables<Traits, ThisType>;
-    using NavierStokesParentType = NSVolumeVariables;
+    using RANSParentType = RANSVolumeVariables<Traits, NSVolumeVariables>;
 
     using Scalar = typename Traits::PrimaryVariables::value_type;
 
-    static constexpr bool enableEnergyBalance = Traits::ModelTraits::enableEnergyBalance();
-    static constexpr int fluidSystemPhaseIdx = Traits::ModelTraits::Indices::fluidSystemPhaseIdx;
-
 public:
     //! export the underlying fluid system
     using FluidSystem = typename Traits::FluidSystem;
@@ -74,7 +68,7 @@ public:
                 const Element &element,
                 const SubControlVolume& scv)
     {
-        NavierStokesParentType::update(elemSol, problem, element, scv);
+        RANSParentType::updateNavierStokesVolVars(elemSol, problem, element, scv);
         updateRANSProperties(elemSol, problem, element, scv);
     }
 
@@ -95,32 +89,9 @@ public:
         RANSParentType::updateRANSProperties(elemSol, problem, element, scv);
         additionalRoughnessLength_ = problem.additionalRoughnessLength_[RANSParentType::elementID()];
         yPlusRough_ = wallDistanceRough() * RANSParentType::uStar() / RANSParentType::kinematicViscosity();
-        dynamicEddyViscosity_ = calculateEddyViscosity(elemSol, problem, element, scv, problem.eddyViscosityModel_);
-        calculateEddyDiffusivity(problem);
-    }
-
-    /*!
-     * \brief Return the dynamic eddy viscosity \f$\mathrm{[Pa s]}\f$ of the flow
-     */
-    Scalar dynamicEddyViscosity() const
-    { return dynamicEddyViscosity_; }
-
-    /*!
-     * \brief Return the effective dynamic viscosity \f$\mathrm{[Pa s]}\f$ of the fluid within the
-     *        control volume.
-     */
-    Scalar effectiveViscosity() const
-    { return NavierStokesParentType::viscosity() + dynamicEddyViscosity(); }
-
-    /*!
-     * \brief Returns the effective thermal conductivity \f$\mathrm{[W/(m*K)]}\f$
-     *        of the fluid-flow in the sub-control volume.
-     */
-    template<bool eB = enableEnergyBalance, typename std::enable_if_t<eB, int> = 0>
-    Scalar effectiveThermalConductivity() const
-    {
-        return NavierStokesParentType::thermalConductivity()
-               + RANSParentType::eddyThermalConductivity();
+        RANSParentType::setDynamicEddyViscosity_(calculateEddyViscosity(elemSol, problem, element, scv, problem.eddyViscosityModel_));
+        RANSParentType::calculateEddyDiffusivity(problem);
+        RANSParentType::calculateEddyThermalConductivity(problem);
     }
 
     /*!
@@ -173,18 +144,7 @@ public:
                        "The eddy viscosity model \"" << modelName << "\" is not implemented.");
         }
 
-        return kinematicEddyViscosity * NavierStokesParentType::density();
-    }
-
-    /*!
-     * \brief Calculates the eddy diffusivity \f$\mathrm{[m^2/s]}\f$ based
-     *        on the kinematic eddy viscosity and the turbulent schmidt number
-     */
-    template<class Problem>
-    void calculateEddyDiffusivity(const Problem& problem)
-    {
-        eddyDiffusivity_ = RANSParentType::kinematicEddyViscosity()
-                           / problem.turbulentSchmidtNumber();
+        return kinematicEddyViscosity * RANSParentType::density();
     }
 
     /*!
@@ -199,32 +159,7 @@ public:
     Scalar yPlusRough() const
     { return yPlusRough_; }
 
-    /*!
-     * \brief Returns the eddy diffusivity \f$\mathrm{[m^2/s]}\f$
-     */
-    Scalar eddyDiffusivity() const
-    { return eddyDiffusivity_; }
-
-     /*!
-     * \brief Returns the effective diffusion coefficient \f$\mathrm{[m^2/s]}\f$
-     *
-     * \param compIIdx the index of the component which diffusive
-     * \param compJIdx the index of the component with respect to which compIIdx diffuses
-     */
-    Scalar effectiveDiffusivity(int compIIdx, int compJIdx = fluidSystemPhaseIdx) const
-    {
-        return NavierStokesParentType::diffusionCoefficient(compIIdx, compJIdx) + eddyDiffusivity();
-    }
-
-    /*!
-     * \brief Return the fluid state of the control volume.
-     */
-    const FluidState& fluidState() const
-    { return NavierStokesParentType::fluidState_; }
-
 protected:
-    Scalar dynamicEddyViscosity_ = 0.0;
-    Scalar eddyDiffusivity_ = 0.0;
     Scalar additionalRoughnessLength_ = 0.0;
     Scalar yPlusRough_ = 0.0;
 };
diff --git a/test/freeflow/rans/CMakeLists.txt b/test/freeflow/rans/CMakeLists.txt
index 254c0037ad..b35fb9578a 100644
--- a/test/freeflow/rans/CMakeLists.txt
+++ b/test/freeflow/rans/CMakeLists.txt
@@ -69,6 +69,6 @@ dune_add_test(NAME test_pipe_zeroeqni
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/pipe_zeroeqni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/pipe_zeroeqni-00034.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/pipe_zeroeqni-00031.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_pipe_zeroeqni test_pipe_zeroeqni.input")
 target_compile_definitions(test_pipe_zeroeqni PUBLIC "NONISOTHERMAL=1")
diff --git a/test/freeflow/ransnc/CMakeLists.txt b/test/freeflow/ransnc/CMakeLists.txt
index cb68c99d44..cb2f49f9dd 100644
--- a/test/freeflow/ransnc/CMakeLists.txt
+++ b/test/freeflow/ransnc/CMakeLists.txt
@@ -14,7 +14,7 @@ dune_add_test(NAME test_flatplate_kepsilon2cni_twolayer
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_flatplate_kepsilon2cni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00036.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00033.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_flatplate_kepsilon2cni
                                        test_flatplate2cni.input")
 
@@ -24,7 +24,7 @@ dune_add_test(NAME test_flatplate_kepsilon2cni_wallfunction
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_flatplate_kepsilon2cni_wallfunction.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni_wallfunction-00025.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni_wallfunction-00024.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_flatplate_kepsilon2cni
                                        test_flatplate2cni_wallfunction.input")
 
@@ -39,7 +39,7 @@ dune_add_test(NAME test_flatplate_komega2cni
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_flatplate_komega2cni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00034.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00032.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_flatplate_komega2cni
                                        test_flatplate2cni.input
                                        -Newton.TargetSteps 12")
@@ -56,7 +56,7 @@ dune_add_test(NAME test_flatplate_lowrekepsilon2cni
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_flatplate_lowrekepsilon2cni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00033.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00032.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_flatplate_lowrekepsilon2cni test_flatplate2cni.input")
 target_compile_definitions(test_flatplate_lowrekepsilon2cni PUBLIC "LOWREKEPSILON=1" "NONISOTHERMAL=1")
 
@@ -71,7 +71,7 @@ dune_add_test(NAME test_flatplate_oneeq2cni
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_flatplate_oneeq2cni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00034.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00031.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_flatplate_oneeq2cni test_flatplate2cni.input")
 target_compile_definitions(test_flatplate_oneeq2cni PUBLIC "ONEEQ=1" "NONISOTHERMAL=1")
 
@@ -90,6 +90,6 @@ dune_add_test(NAME test_flatplate_zeroeq2cni
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_flatplate_zeroeq2cni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00034.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_flatplate2cni-00032.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_flatplate_zeroeq2cni test_flatplate2cni.input")
 target_compile_definitions(test_flatplate_zeroeq2cni PUBLIC "NONISOTHERMAL=1")
diff --git a/test/references/test_flatplate_kepsilon2cni.vtu b/test/references/test_flatplate_kepsilon2cni.vtu
index 6d21181ed9..c02c2215b4 100644
--- a/test/references/test_flatplate_kepsilon2cni.vtu
+++ b/test/references/test_flatplate_kepsilon2cni.vtu
@@ -479,160 +479,160 @@
           0.000178634 0.000175183 0.000172227 0.000169685 0.000167509 0.000165679 0.000164193 0.000163046
         </DataArray>
         <DataArray type="Float32" Name="dv_x/dx_" NumberOfComponents="3" format="ascii">
-          -0.110218 127.184 0 -0.0416626 6.67164 0 -0.000292019 4.37184 0 -9.08316e-05 3.78551 0
-          -5.33503e-05 3.46114 0 -3.39519e-05 3.25066 0 -2.10811e-05 3.12082 0 -1.2943e-05 3.03939 0
-          -6.88525e-06 2.99112 0 -4.1372e-06 2.97037 0 -0.108095 4.22417 0 -0.0416387 6.60595 0
-          -0.000978527 4.37064 0 -0.000308768 3.7843 0 -0.000181338 3.45995 0 -0.000115383 3.24953 0
-          -7.16306e-05 3.11977 0 -4.39736e-05 3.0384 0 -2.34007e-05 2.99018 0 -1.40753e-05 2.9694 0
-          -0.105159 4.12458 0 -0.0415784 6.5053 0 -0.00191272 4.36871 0 -0.000613919 3.78255 0
-          -0.000360512 3.45824 0 -0.000229341 3.24791 0 -0.000142349 3.11828 0 -8.7376e-05 3.037 0
-          -4.65183e-05 2.98885 0 -2.80156e-05 2.96801 0 -0.10112 3.98429 0 -0.0414424 6.36192 0
-          -0.00316798 4.3638 0 -0.00104091 3.77913 0 -0.000611255 3.45518 0 -0.000388753 3.24514 0
-          -0.000241234 3.11575 0 -0.000148052 3.03463 0 -7.88729e-05 2.98658 0 -4.75841e-05 2.96568 0
-          -0.0956096 3.78008 0 -0.0411512 6.14834 0 -0.00482039 4.34991 0 -0.00163683 3.77111 0
-          -0.000961668 3.4487 0 -0.000611473 3.23955 0 -0.000379346 3.11071 0 -0.000232787 3.02992 0
-          -0.000124138 2.98206 0 -7.50803e-05 2.96107 0 -0.0881998 3.46838 0 -0.0405443 5.80897 0
-          -0.00691474 4.30973 0 -0.00246131 3.74962 0 -0.00144905 3.43257 0 -0.000921449 3.22625 0
-          -0.000571624 3.09892 0 -0.000350814 3.01893 0 -0.000187393 2.97145 0 -0.000113761 2.95035 0
-          -0.0785193 2.99072 0 -0.0392947 5.25592 0 -0.00936442 4.19872 0 -0.00357233 3.68921 0
-          -0.00211653 3.38871 0 -0.0013477 3.19092 0 -0.000836786 3.06785 0 -0.000514045 2.99001 0
-          -0.000275482 2.94342 0 -0.000168228 2.9222 0 -0.0665513 2.34124 0 -0.0368126 4.42848 0
-          -0.0117546 3.92605 0 -0.00496356 3.52752 0 -0.00298836 3.27024 0 -0.00191265 3.09542 0
-          -0.00119227 2.98369 0 -0.000735195 2.91148 0 -0.000396856 2.86714 0 -0.000244854 2.84594 0
-          -0.0529828 1.63526 0 -0.0324407 3.38864 0 -0.0132609 3.38293 0 -0.0064086 3.16158 0
-          -0.0039853 2.98902 0 -0.00258696 2.8626 0 -0.00163228 2.77565 0 -0.0010181 2.71608 0
-          -0.00055894 2.67693 0 -0.000351613 2.65633 0 -0.0391948 1.04469 0 -0.0262308 2.33679 0
-          -0.0131293 2.57734 0 -0.00734859 2.53685 0 -0.00479862 2.47224 0 -0.00320458 2.41407 0
-          -0.00207939 2.36498 0 -0.00133292 2.32602 0 -0.000758622 2.29623 0 -0.00049428 2.27784 0
-          -0.0265719 0.626554 0 -0.019449 1.45751 0 -0.0115651 1.71355 0 -0.00729948 1.77628 0
-          -0.00502607 1.79141 0 -0.0034962 1.79041 0 -0.00237863 1.77725 0 -0.00160086 1.7601 0
-          -0.000967396 1.74205 0 -0.000663406 1.72813 0 -0.0161325 0.347454 0 -0.0133311 0.828672 0
-          -0.00934649 1.01915 0 -0.00642462 1.10165 0 -0.00463089 1.14513 0 -0.0033727 1.169 0
-          -0.00243903 1.17552 0 -0.00175059 1.17289 0 -0.00113808 1.16487 0 -0.000824752 1.15646 0
-          -0.0082149 0.175693 0 -0.0082892 0.436387 0 -0.00702979 0.562998 0 -0.00520644 0.62868 0
-          -0.00390714 0.670981 0 -0.00299128 0.697756 0 -0.00231398 0.709756 0 -0.00177791 0.713401 0
-          -0.00124026 0.711618 0 -0.000942624 0.707842 0 -0.00259871 0.0807978 0 -0.00432237 0.216143 0
-          -0.00487377 0.300682 0 -0.00391294 0.347983 0 -0.00302418 0.376703 0 -0.00247079 0.39513 0
-          -0.00207514 0.405908 0 -0.00170727 0.411084 0 -0.00126739 0.412266 0 -0.00100044 0.411358 0
-          0.0011697 0.0326064 0 -0.0011289 0.0980408 0 -0.00273656 0.154127 0 -0.00273091 0.191356 0
-          -0.00237185 0.212693 0 -0.00204025 0.225616 0 -0.00179446 0.234831 0 -0.00157088 0.240615 0
-          -0.00123134 0.243723 0 -0.00100176 0.244853 0 0.0033608 0.0102946 0 0.00121768 0.0367409 0
-          -0.000619565 0.0678955 0 -0.00124295 0.095038 0 -0.00146228 0.115625 0 -0.00146153 0.130301 0
-          -0.00139136 0.141159 0 -0.00130186 0.149187 0 -0.00107415 0.155004 0 -0.00089742 0.158422 0
-          0.00429636 0.00155212 0 0.00254749 0.0091775 0 0.000984272 0.0221534 0 0.000315409 0.0363399 0
-          -0.000121184 0.0504757 0 -0.000410538 0.063248 0 -0.000589031 0.0742636 0 -0.000687172 0.0837165 0
-          -0.00064191 0.0917048 0 -0.000565436 0.0971198 0 0.00445421 -0.000872114 0 0.00305851 3.81434e-06 0
-          0.00180754 0.00394105 0 0.00128779 0.00881146 0 0.000942099 0.0145755 0 0.00066405 0.0209234 0
-          0.000437612 0.0274956 0 0.000256597 0.0340588 0 0.0001235 0.0403751 0 7.02974e-05 0.0451353 0
-          0.004297 -0.000949707 0 0.00314961 -0.00148659 0 0.00208609 -0.000599882 0 0.00164576 0.000481573 0
-          0.00139399 0.0018787 0 0.00120572 0.0036389 0 0.00105417 0.00574143 0 0.000924025 0.00814075 0
-          0.000743734 0.0107258 0 0.000625539 0.0128862 0 0.00410706 -0.000781787 0 0.00311978 -0.00139434 0
-          0.00215224 -0.00107375 0 0.00172188 -0.000746834 0 0.00149506 -0.000328581 0 0.00134055 0.000242489 0
-          0.00122605 0.000991175 0 0.00112954 0.00192491 0 0.000954607 0.00300277 0 0.00082705 0.00398899 0
+          -0.110218 127.183 0 -0.0416625 6.67126 0 -0.000291914 4.37218 0 -9.08085e-05 3.78618 0
+          -5.33935e-05 3.46171 0 -3.40194e-05 3.2509 0 -2.11409e-05 3.12072 0 -1.29655e-05 3.03902 0
+          -6.85991e-06 2.99079 0 -4.0929e-06 2.97026 0 -0.108095 4.22375 0 -0.0416384 6.60557 0
+          -0.00097817 4.37099 0 -0.00030869 3.78497 0 -0.000181485 3.46052 0 -0.000115613 3.24976 0
+          -7.1834e-05 3.11967 0 -4.40497e-05 3.03804 0 -2.33143e-05 2.98985 0 -1.39246e-05 2.96929 0
+          -0.10516 4.12416 0 -0.0415779 6.50492 0 -0.00191201 4.36905 0 -0.000613764 3.78322 0
+          -0.000360805 3.45881 0 -0.000229798 3.24815 0 -0.000142753 3.11817 0 -8.7527e-05 3.03664 0
+          -4.63461e-05 2.98852 0 -2.77154e-05 2.96791 0 -0.101121 3.98387 0 -0.0414415 6.36155 0
+          -0.00316678 4.36415 0 -0.00104065 3.7798 0 -0.000611753 3.45575 0 -0.000389528 3.24538 0
+          -0.00024192 3.11564 0 -0.000148307 3.03426 0 -7.85797e-05 2.98625 0 -4.70741e-05 2.96557 0
+          -0.0956105 3.77969 0 -0.0411498 6.14799 0 -0.00481851 4.35025 0 -0.00163642 3.77178 0
+          -0.000962454 3.44926 0 -0.000612693 3.23978 0 -0.000380424 3.1106 0 -0.000233186 3.02956 0
+          -0.000123674 2.98174 0 -7.42758e-05 2.96097 0 -0.0882011 3.46806 0 -0.0405422 5.80869 0
+          -0.00691193 4.31007 0 -0.0024607 3.75027 0 -0.00145023 3.43312 0 -0.000923285 3.22647 0
+          -0.000573246 3.09881 0 -0.000351411 3.01858 0 -0.000186689 2.97114 0 -0.000112544 2.95025 0
+          -0.078521 2.99055 0 -0.0392919 5.25578 0 -0.00936049 4.19902 0 -0.00357144 3.6898 0
+          -0.00211825 3.38921 0 -0.00135037 3.19112 0 -0.000839146 3.06775 0 -0.000514908 2.98967 0
+          -0.000274445 2.94312 0 -0.000166443 2.92212 0 -0.0665532 2.34123 0 -0.0368091 4.42851 0
+          -0.0117495 3.92626 0 -0.00496232 3.52795 0 -0.00299071 3.27062 0 -0.00191635 3.09558 0
+          -0.00119556 2.98361 0 -0.000736391 2.91121 0 -0.000395379 2.8669 0 -0.000242328 2.84588 0
+          -0.0529844 1.6353 0 -0.0324369 3.38869 0 -0.0132552 3.38299 0 -0.00640697 3.16172 0
+          -0.00398815 2.98918 0 -0.00259164 2.86266 0 -0.00163653 2.77559 0 -0.00101965 2.71591 0
+          -0.000556985 2.67677 0 -0.000348278 2.65628 0 -0.0391963 1.04477 0 -0.0262272 2.33686 0
+          -0.0131237 2.57727 0 -0.00734679 2.53672 0 -0.00480142 2.47215 0 -0.00320955 2.41403 0
+          -0.00208411 2.36495 0 -0.0013347 2.32599 0 -0.000756424 2.29619 0 -0.000490488 2.27779 0
+          -0.0265727 0.626676 0 -0.0194465 1.45763 0 -0.0115611 1.71345 0 -0.00729803 1.77604 0
+          -0.00502814 1.79121 0 -0.00350029 1.79032 0 -0.00238281 1.77726 0 -0.00160255 1.76019 0
+          -0.000965525 1.74212 0 -0.000660069 1.72813 0 -0.0161321 0.347535 0 -0.0133302 0.82875 0
+          -0.00934505 1.01907 0 -0.00642391 1.10145 0 -0.00463195 1.14496 0 -0.0033751 1.16893 0
+          -0.00244168 1.17557 0 -0.00175168 1.17303 0 -0.00113686 1.16501 0 -0.000822563 1.15654 0
+          -0.00821395 0.175714 0 -0.0082895 0.436406 0 -0.00703042 0.562954 0 -0.00520641 0.628575 0
+          -0.003907 0.670881 0 -0.00299175 0.69772 0 -0.00231473 0.709805 0 -0.00177797 0.713528 0
+          -0.00123943 0.711757 0 -0.000941456 0.707937 0 -0.00259775 0.0807928 0 -0.00432301 0.216138 0
+          -0.00487521 0.300675 0 -0.00391354 0.347958 0 -0.00302363 0.376666 0 -0.00246974 0.395105 0
+          -0.00207398 0.405918 0 -0.00170629 0.411126 0 -0.00126692 0.412309 0 -0.00100027 0.411377 0
+          0.00117043 0.0325977 0 -0.00112929 0.0980313 0 -0.00273783 0.154131 0 -0.00273186 0.191364 0
+          -0.00237173 0.212692 0 -0.00203919 0.225605 0 -0.001793 0.234814 0 -0.00156983 0.240595 0
+          -0.00123126 0.243699 0 -0.00100216 0.244824 0 0.00336117 0.0102891 0 0.0012176 0.0367327 0
+          -0.000620213 0.0678955 0 -0.00124374 0.0950475 0 -0.00146264 0.115636 0 -0.00146122 0.130305 0
+          -0.00139057 0.141152 0 -0.00130122 0.14917 0 -0.00107414 0.154983 0 -0.000897748 0.158403 0
+          0.00429639 0.00155002 0 0.00254746 0.00917308 0 0.000984129 0.0221508 0 0.000315181 0.0363426 0
+          -0.000121418 0.0504832 0 -0.000410646 0.0632563 0 -0.000588949 0.0742685 0 -0.000687066 0.0837155 0
+          -0.000641974 0.0917003 0 -0.000565605 0.0971157 0 0.00445405 -0.000872591 0 0.00305839 2.50609e-06 0
+          0.00180753 0.00393958 0 0.00128791 0.00881111 0 0.000942245 0.0145773 0 0.000664122 0.0209272 0
+          0.000437568 0.0275001 0 0.000256409 0.0340626 0 0.000123235 0.0403778 0 7.00325e-05 0.0451376 0
+          0.00429681 -0.000949752 0 0.00314944 -0.00148676 0 0.00208606 -0.000600162 0 0.00164593 0.000481311 0
+          0.00139427 0.00187872 0 0.00120596 0.00363945 0 0.00105425 0.00574255 0 0.000923897 0.00814225 0
+          0.000743487 0.0107275 0 0.000625283 0.0128881 0 0.00410687 -0.000781782 0 0.00311962 -0.00139433 0
+          0.00215221 -0.00107377 0 0.00172206 -0.000746891 0 0.00149535 -0.000328648 0 0.00134082 0.000242506 0
+          0.00122617 0.000991355 0 0.00112945 0.00192529 0 0.000954398 0.00300337 0 0.000826824 0.00398975 0
         </DataArray>
         <DataArray type="Float32" Name="dv_y/dx_" NumberOfComponents="3" format="ascii">
-          1.03491e-07 0.180413 0 -1.81739e-05 0.00152682 0 -6.99192e-08 0.00031207 0 -1.04279e-08 0.000153573 0
-          -4.53159e-09 0.000103958 0 -3.20945e-09 6.31603e-05 0 -1.92662e-09 3.99268e-05 0 -1.3206e-09 2.47366e-05 0
-          -1.09639e-09 1.35925e-05 0 -1.07489e-09 2.89775e-06 0 6.90211e-07 0.176149 0 -6.10621e-05 0.00311441 0
-          -4.6559e-07 0.000648512 0 -7.05592e-08 0.000319009 0 -3.0654e-08 0.000215938 0 -2.17094e-08 0.00013115 0
-          -1.30273e-08 8.29022e-05 0 -8.9285e-09 5.13579e-05 0 -7.40434e-09 2.82247e-05 0 -7.25198e-09 6.08079e-06 0
-          2.48864e-06 0.169033 0 -0.000118978 0.0057257 0 -1.67555e-06 0.00122425 0 -2.5889e-07 0.000601946 0
-          -1.12434e-07 0.000407447 0 -7.96225e-08 0.000247347 0 -4.77576e-08 0.000156343 0 -3.27263e-08 9.68461e-05 0
-          -2.71027e-08 5.32369e-05 0 -2.65129e-08 1.16421e-05 0 6.82918e-06 0.159446 0 -0.000196002 0.00914811 0
-          -4.58577e-06 0.00203186 0 -7.27376e-07 0.000998926 0 -3.15799e-07 0.000676194 0 -2.2363e-07 0.000410249 0
-          -1.3405e-07 0.000259301 0 -9.18399e-08 0.00016061 0 -7.59197e-08 8.83272e-05 0 -7.41475e-08 1.97243e-05 0
-          1.62204e-05 0.146765 0 -0.000296192 0.0134626 0 -1.08498e-05 0.00315812 0 -1.78509e-06 0.00155477 0
-          -7.75158e-07 0.00105287 0 -5.48955e-07 0.00063839 0 -3.28798e-07 0.000403538 0 -2.25206e-07 0.000249963 0
-          -1.8571e-07 0.000137584 0 -1.80977e-07 3.16242e-05 0 3.51204e-05 0.130533 0 -0.000422342 0.0184957 0
-          -2.33537e-05 0.00469717 0 -4.04546e-06 0.00232589 0 -1.7601e-06 0.00157744 0 -1.24705e-06 0.000956303 0
-          -7.4625e-07 0.000604866 0 -5.1101e-07 0.000374878 0 -4.20044e-07 0.000206739 0 -4.08155e-07 4.94447e-05 0
-          7.06357e-05 0.110939 0 -0.000573855 0.0234517 0 -4.65291e-05 0.00668323 0 -8.6689e-06 0.00336306 0
-          -3.79721e-06 0.00229116 0 -2.69497e-06 0.00139158 0 -1.61174e-06 0.000882149 0 -1.10369e-06 0.000547933 0
-          -9.03793e-07 0.000303647 0 -8.75129e-07 7.67117e-05 0 0.000131715 0.0893095 0 -0.000744404 0.0267062 0
-          -8.54108e-05 0.00891549 0 -1.76133e-05 0.00464236 0 -7.85032e-06 0.00319731 0 -5.5997e-06 0.00195696 0
-          -3.3524e-06 0.00124878 0 -2.29809e-06 0.000780955 0 -1.87572e-06 0.0004382 0 -1.81024e-06 0.000119437 0
-          0.000224635 0.0678319 0 -0.000921544 0.0266374 0 -0.000141951 0.0107781 0 -3.3399e-05 0.00593381 0
-          -1.54111e-05 0.004167 0 -1.1122e-05 0.00260114 0 -6.69776e-06 0.00168625 0 -4.60931e-06 0.0010726 0
-          -3.76474e-06 0.000619283 0 -3.63232e-06 0.000187006 0 0.000346759 0.0482828 0 -0.00108985 0.0233391 0
-          -0.000210766 0.0114909 0 -5.76418e-05 0.00679511 0 -2.80288e-05 0.00488874 0 -2.06201e-05 0.00316341 0
-          -1.26073e-05 0.00211198 0 -8.75829e-06 0.00138838 0 -7.23777e-06 0.000844582 0 -7.04489e-06 0.000288853 0
-          0.000488418 0.0315163 0 -0.00123342 0.0185893 0 -0.000282189 0.0107938 0 -8.9363e-05 0.00689615 0
-          -4.61958e-05 0.00506568 0 -3.46596e-05 0.00345058 0 -2.17441e-05 0.00240696 0 -1.53526e-05 0.00166271 0
-          -1.3085e-05 0.00108799 0 -1.30538e-05 0.000423053 0 0.000640899 0.018056 0 -0.00133577 0.0138899 0
-          -0.000349532 0.00914479 0 -0.000125619 0.00630457 0 -6.89184e-05 0.00468653 0 -5.2172e-05 0.00340216 0
-          -3.38245e-05 0.00250692 0 -2.44109e-05 0.0018402 0 -2.19492e-05 0.00130547 0 -2.28268e-05 0.000569021 0
-          0.000796111 0.00814591 0 -0.00138147 0.00964449 0 -0.000408213 0.00720087 0 -0.000163434 0.00531419 0
-          -9.44171e-05 0.00393826 0 -7.08721e-05 0.00310277 0 -4.76949e-05 0.0024336 0 -3.53138e-05 0.00190554 0
-          -3.42047e-05 0.00145911 0 -3.75248e-05 0.000698084 0 0.000940006 0.00149094 0 -0.00135775 0.00577181 0
-          -0.000450255 0.00519066 0 -0.000201507 0.00420054 0 -0.000120356 0.00316703 0 -8.71703e-05 0.00268699 0
-          -6.16721e-05 0.0022453 0 -4.70774e-05 0.00187374 0 -5.00344e-05 0.00153401 0 -5.82297e-05 0.000789949 0
-          0.00104671 -0.00252497 0 -0.00126099 0.00236342 0 -0.000459379 0.0030095 0 -0.000229331 0.00292225 0
-          -0.000143704 0.00247348 0 -0.000100887 0.00220666 0 -7.41772e-05 0.00195908 0 -5.84764e-05 0.00173734 0
-          -6.94973e-05 0.00150667 0 -8.59837e-05 0.000824658 0 0.00108367 -0.00456845 0 -0.00110544 -0.00021664 0
-          -0.000424778 0.000870729 0 -0.000225944 0.00135094 0 -0.000152979 0.00148746 0 -0.000110622 0.00148277 0
-          -8.30683e-05 0.0014447 0 -6.77024e-05 0.00138521 0 -9.16429e-05 0.00128099 0 -0.000120415 0.000750001 0
-          0.00102828 -0.00528902 0 -0.000913835 -0.00176917 0 -0.000359328 -0.000731789 0 -0.000189967 -0.000162799 0
-          -0.00013529 0.000213262 0 -0.000103617 0.00043843 0 -8.04039e-05 0.000585165 0 -6.89255e-05 0.00068048 0
-          -0.00011004 0.000716695 0 -0.000153764 0.000475982 0 0.000872889 -0.00527951 0 -0.000698226 -0.00249586 0
-          -0.00028124 -0.00159828 0 -0.000141499 -0.00114273 0 -9.9256e-05 -0.000810235 0 -7.739e-05 -0.000550367 0
-          -6.14398e-05 -0.000352431 0 -5.59495e-05 -0.000196069 0 -0.000109916 -7.57368e-05 0 -0.000163433 2.70244e-05 0
-          0.000611977 -0.00499957 0 -0.000453324 -0.00276591 0 -0.000190055 -0.00193171 0 -9.13848e-05 -0.00155892 0
-          -6.11869e-05 -0.00131183 0 -4.63465e-05 -0.00111438 0 -3.60821e-05 -0.000959961 0 -3.43117e-05 -0.000831698 0
-          -8.21314e-05 -0.000706412 0 -0.000128054 -0.000379281 0 0.000227006 -0.00486413 0 -0.000160931 -0.00282615 0
-          -6.98527e-05 -0.00200211 0 -3.2935e-05 -0.00164958 0 -2.13998e-05 -0.00142999 0 -1.57646e-05 -0.00126013 0
-          -1.19322e-05 -0.00113064 0 -1.15439e-05 -0.00102375 0 -3.06813e-05 -0.000907784 0 -4.88477e-05 -0.000520137 0
+          1.03466e-07 0.180413 0 -1.81739e-05 0.00152645 0 -6.99037e-08 0.000311863 0 -1.04107e-08 0.000153518 0
+          -4.52234e-09 0.000104094 0 -3.20913e-09 6.32896e-05 0 -1.93009e-09 4.00693e-05 0 -1.3321e-09 2.47967e-05 0
+          -1.10394e-09 1.35054e-05 0 -1.07524e-09 2.80718e-06 0 6.90046e-07 0.176149 0 -6.10623e-05 0.00311365 0
+          -4.65485e-07 0.000648082 0 -7.04429e-08 0.000318894 0 -3.05914e-08 0.000216221 0 -2.17073e-08 0.000131418 0
+          -1.30508e-08 8.31981e-05 0 -9.00635e-09 5.14826e-05 0 -7.45542e-09 2.80435e-05 0 -7.25431e-09 5.89254e-06 0
+          2.48803e-06 0.169034 0 -0.000118979 0.00572425 0 -1.67516e-06 0.00122344 0 -2.58464e-07 0.000601729 0
+          -1.12205e-07 0.000407983 0 -7.9615e-08 0.000247854 0 -4.78437e-08 0.000156902 0 -3.30119e-08 9.70808e-05 0
+          -2.729e-08 5.28945e-05 0 -2.65214e-08 1.12866e-05 0 6.82746e-06 0.159449 0 -0.000196005 0.0091457 0
+          -4.58468e-06 0.00203052 0 -7.26177e-07 0.000998565 0 -3.15154e-07 0.000677085 0 -2.2361e-07 0.000411089 0
+          -1.34292e-07 0.000260227 0 -9.2642e-08 0.000160999 0 -7.64454e-08 8.7758e-05 0 -7.4171e-08 1.91335e-05 0
+          1.62162e-05 0.14677 0 -0.000296198 0.0134589 0 -1.08471e-05 0.00315604 0 -1.78214e-06 0.0015542 0
+          -7.73576e-07 0.00105426 0 -5.48907e-07 0.000639695 0 -3.29392e-07 0.00040498 0 -2.27175e-07 0.000250566 0
+          -1.87e-07 0.000136696 0 -1.81034e-07 3.07028e-05 0 3.51108e-05 0.130539 0 -0.000422354 0.0184903 0
+          -2.33476e-05 0.00469407 0 -4.03878e-06 0.00232504 0 -1.75651e-06 0.00157951 0 -1.24695e-06 0.000958248 0
+          -7.476e-07 0.000607021 0 -5.15484e-07 0.000375775 0 -4.22971e-07 0.000205405 0 -4.08283e-07 4.80618e-05 0
+          7.06157e-05 0.110946 0 -0.00057388 0.0234448 0 -4.65165e-05 0.00667885 0 -8.65454e-06 0.00336179 0
+          -3.78945e-06 0.00229413 0 -2.69475e-06 0.00139436 0 -1.61464e-06 0.000885255 0 -1.11336e-06 0.000549223 0
+          -9.10113e-07 0.000301711 0 -8.75404e-07 7.47014e-05 0 0.000131677 0.0893167 0 -0.000744451 0.0266986 0
+          -8.53873e-05 0.00890974 0 -1.75839e-05 0.00464052 0 -7.8342e-06 0.00320126 0 -5.59919e-06 0.0019607 0
+          -3.35836e-06 0.00125303 0 -2.31815e-06 0.00078273 0 -1.88884e-06 0.000435527 0 -1.81082e-06 0.000116646 0
+          0.000224571 0.0678387 0 -0.000921625 0.0266299 0 -0.000141914 0.0107715 0 -3.33427e-05 0.00593137 0
+          -1.53792e-05 0.00417159 0 -1.11205e-05 0.00260562 0 -6.70914e-06 0.00169154 0 -4.64893e-06 0.00107486 0
+          -3.79081e-06 0.000615945 0 -3.63361e-06 0.000183458 0 0.000346661 0.0482884 0 -0.00108998 0.0233327 0
+          -0.000210712 0.0114848 0 -5.75449e-05 0.00679242 0 -2.79708e-05 0.00489306 0 -2.06153e-05 0.00316793 0
+          -1.26267e-05 0.00211761 0 -8.83058e-06 0.0013909 0 -7.28607e-06 0.000841086 0 -7.04802e-06 0.000284993 0
+          0.000488281 0.0315189 0 -0.0012336 0.0185855 0 -0.000282119 0.0107896 0 -8.92188e-05 0.00689396 0
+          -4.61028e-05 0.00506874 0 -3.4647e-05 0.00345423 0 -2.17724e-05 0.00241175 0 -1.54696e-05 0.00166499 0
+          -1.31652e-05 0.00108508 0 -1.30612e-05 0.000419663 0 0.000640741 0.0180552 0 -0.00133598 0.0138893 0
+          -0.000349459 0.00914322 0 -0.000125436 0.0063035 0 -6.87911e-05 0.00468766 0 -5.21466e-05 0.00340432 0
+          -3.38602e-05 0.00250987 0 -2.45746e-05 0.00184156 0 -2.20647e-05 0.0013035 0 -2.28414e-05 0.000566697 0
+          0.000795962 0.00814342 0 -0.00138166 0.00964578 0 -0.000408152 0.00720147 0 -0.000163244 0.00531438 0
+          -9.42705e-05 0.00393779 0 -7.08294e-05 0.00310321 0 -4.77364e-05 0.00243423 0 -3.55124e-05 0.00190553 0
+          -3.4346e-05 0.00145801 0 -3.75442e-05 0.000697023 0 0.000939888 0.00148848 0 -0.00135789 0.00577328 0
+          -0.000450207 0.00519223 0 -0.000201349 0.00420165 0 -0.000120223 0.00316621 0 -8.71192e-05 0.00268623 0
+          -6.17182e-05 0.00224417 0 -4.72814e-05 0.00187267 0 -5.01745e-05 0.00153362 0 -5.82426e-05 0.000789973 0
+          0.00104663 -0.00252657 0 -0.00126105 0.00236418 0 -0.00045933 0.0030109 0 -0.00022922 0.00292362 0
+          -0.000143618 0.00247325 0 -0.000100855 0.00220582 0 -7.42289e-05 0.00195755 0 -5.86507e-05 0.00173605 0
+          -6.9603e-05 0.00150668 0 -8.59761e-05 0.0008252 0 0.0010836 -0.00456915 0 -0.00110544 -0.000216459 0
+          -0.000424703 0.000871451 0 -0.000225861 0.00135191 0 -0.000152947 0.00148774 0 -0.00011063 0.0014825 0
+          -8.31348e-05 0.00144381 0 -6.78362e-05 0.00138438 0 -9.16996e-05 0.00128108 0 -0.000120379 0.000750489 0
+          0.00102821 -0.00528916 0 -0.000913806 -0.00176911 0 -0.000359228 -0.000731582 0 -0.000189885 -0.000162491 0
+          -0.000135284 0.00021345 0 -0.000103658 0.000438471 0 -8.04913e-05 0.000584937 0 -6.90365e-05 0.00068026 0
+          -0.000110061 0.000716871 0 -0.000153707 0.000476272 0 0.000872825 -0.0052794 0 -0.000698195 -0.00249572 0
+          -0.000281143 -0.00159824 0 -0.000141417 -0.00114283 0 -9.92477e-05 -0.000810362 0 -7.74356e-05 -0.000550435 0
+          -6.15297e-05 -0.000352464 0 -5.60472e-05 -0.000195954 0 -0.000109927 -7.54426e-05 0 -0.000163377 2.72343e-05 0
+          0.000611931 -0.0049994 0 -0.000453303 -0.00276571 0 -0.000189986 -0.00193167 0 -9.13237e-05 -0.00155913 0
+          -6.11763e-05 -0.00131213 0 -4.63765e-05 -0.00111461 0 -3.61467e-05 -0.000960057 0 -3.43819e-05 -0.000831548 0
+          -8.2141e-05 -0.000706097 0 -0.000128018 -0.000379091 0 0.000226989 -0.00486395 0 -0.000160924 -0.00282594 0
+          -6.98274e-05 -0.00200206 0 -3.29122e-05 -0.00164979 0 -2.13952e-05 -0.00143031 0 -1.57751e-05 -0.00126041 0
+          -1.19557e-05 -0.00113078 0 -1.15696e-05 -0.00102362 0 -3.06853e-05 -0.000907484 0 -4.88353e-05 -0.000519954 0
         </DataArray>
         <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii">
-          0.0505184 2.18275e-05 0 0.000803563 9.31471e-08 0 0.000523297 1.8769e-08 0 0.000453119 9.23837e-09 0
-          0.000414299 6.25271e-09 0 0.000389106 3.80075e-09 0 0.000373555 2.4047e-09 0 0.000363786 1.49319e-09 0
-          0.000357978 8.24819e-10 0 0.000355468 1.77007e-10 0 0.0517452 7.34014e-05 0 0.00271443 6.21228e-07 0
-          0.00177869 1.26976e-07 0 0.00154013 6.24807e-08 0 0.00140817 4.22868e-08 0 0.00132254 2.56979e-08 0
-          0.0012697 1.62581e-08 0 0.00123651 1.00947e-08 0 0.00121678 5.57657e-09 0 0.00120824 1.2059e-09 0
-          0.05343 0.000143239 0 0.00535685 2.23991e-06 0 0.00353578 4.65794e-07 0 0.00306144 2.29114e-07 0
-          0.00279908 1.55058e-07 0 0.00262887 9.41999e-08 0 0.00252385 5.95941e-08 0 0.0024579 3.69992e-08 0
-          0.0024187 2.0442e-08 0 0.0024017 4.46283e-09 0 0.0557253 0.000236511 0 0.00899191 6.14665e-06 0
-          0.0059943 1.30841e-06 0 0.00519009 6.43325e-07 0 0.00474521 4.35375e-07 0 0.00445666 2.64387e-07 0
-          0.00427868 1.67251e-07 0 0.00416692 1.0383e-07 0 0.0041005 5.73784e-08 0 0.00407163 1.26893e-08 0
-          0.0588127 0.000358641 0 0.0139516 1.45993e-05 0 0.00943101 3.21093e-06 0 0.00816677 1.57858e-06 0
-          0.00746681 1.06837e-06 0 0.00701289 6.48444e-07 0 0.006733 4.10192e-07 0 0.00655727 2.54632e-07 0
-          0.00645284 1.40765e-07 0 0.00640729 3.16865e-08 0 0.0628749 0.00051409 0 0.0206206 3.16105e-05 0
-          0.0142213 7.28188e-06 0 0.0123224 3.58384e-06 0 0.0112678 2.42629e-06 0 0.0105837 1.47183e-06 0
-          0.010162 9.3112e-07 0 0.00989715 5.7802e-07 0 0.00973976 3.19764e-07 0 0.00967075 7.37533e-08 0
-          0.0679967 0.000704269 0 0.0293331 6.35765e-05 0 0.0208425 1.56492e-05 0 0.0180951 7.73708e-06 0
-          0.0165557 5.24432e-06 0 0.0155555 3.18069e-06 0 0.0149384 2.01314e-06 0 0.0145505 1.25024e-06 0
-          0.0143197 6.92704e-07 0 0.0142177 1.65216e-07 0 0.0739616 0.000925333 0 0.0401044 0.000118552 0
-          0.0297859 3.20583e-05 0 0.0259981 1.60504e-05 0 0.0238296 1.09179e-05 0 0.0224124 6.6306e-06 0
-          0.0215343 4.20396e-06 0 0.0209805 2.61521e-06 0 0.0206496 1.4545e-06 0 0.0205011 3.63362e-07 0
-          0.0801472 0.00116776 0 0.052316 0.000202185 0 0.0412178 6.19219e-05 0 0.036402 3.18295e-05 0
-          0.0335275 2.18344e-05 0 0.0316201 1.33373e-05 0 0.030423 8.49926e-06 0 0.0296598 5.31473e-06 0
-          0.0291979 2.98432e-06 0 0.028985 7.95077e-07 0 0.0858428 0.00141817 0 0.0647251 0.000312103 0
-          0.0543652 0.000110374 0 0.0489691 5.91631e-05 0 0.045547 4.11886e-05 0 0.0432112 2.55303e-05 0
-          0.0417013 1.64647e-05 0 0.0407142 1.04284e-05 0 0.040098 5.98447e-06 0 0.0397992 1.73952e-06 0
-          0.0907736 0.00165888 0 0.0760855 0.000439603 0 0.0674344 0.000178813 0 0.0622069 0.000100948 0
-          0.0586752 7.15549e-05 0 0.056176 4.55162e-05 0 0.0544795 2.99954e-05 0 0.0533201 1.9467e-05 0
-          0.0525551 1.16209e-05 0 0.052155 3.75927e-06 0 0.094765 0.00186697 0 0.0854807 0.000576839 0
-          0.0787676 0.000264091 0 0.0742648 0.000157368 0 0.0710581 0.000113319 0 0.068708 7.467e-05 0
-          0.0670108 5.07571e-05 0 0.0657801 3.41424e-05 0 0.0649078 2.1533e-05 0 0.0644116 7.79526e-06 0
-          0.0977004 0.00201886 0 0.0926063 0.000716528 0 0.0877534 0.000361136 0 0.0841708 0.000226642 0
-          0.0815057 0.000164985 0 0.0794822 0.000113346 0 0.077916 7.99906e-05 0 0.0767049 5.61886e-05 0
-          0.0757815 3.76984e-05 0 0.0752154 1.5132e-05 0 0.0996687 0.00209436 0 0.0976609 0.000846026 0
-          0.094482 0.000465079 0 0.0918126 0.000305696 0 0.0897865 0.000223244 0 0.0881835 0.000161276 0
-          0.0868214 0.000118693 0 0.0856933 8.73497e-05 0 0.0847728 6.22866e-05 0 0.0841727 2.72939e-05 0
-          0.100858 0.00207714 0 0.101053 0.000942059 0 0.0995031 0.000563963 0 0.0977689 0.000390783 0
-          0.0962261 0.000288748 0 0.0949225 0.000218348 0 0.0937777 0.000167731 0 0.0927694 0.000129406 0
-          0.0918933 9.76313e-05 0 0.0912927 4.59916e-05 0 0.101453 0.00195624 0 0.103025 0.000975315 0
-          0.102914 0.000629712 0 0.102281 0.000465561 0 0.101422 0.000358569 0 0.100526 0.000282 0
-          0.0996685 0.000225863 0 0.098857 0.000182373 0 0.0981069 0.000144667 0 0.0975689 7.23796e-05 0
-          0.101646 0.00172726 0 0.103867 0.000925464 0 0.104703 0.000630647 0 0.105048 0.000494249 0
-          0.105082 0.000402678 0 0.104902 0.000331916 0 0.104589 0.000278372 0 0.104196 0.000235469 0
-          0.103765 0.000195682 0 0.103426 0.000103397 0 0.101619 0.00138912 0 0.104009 0.000785613 0
-          0.105289 0.000551244 0 0.106178 0.000448105 0 0.106835 0.000381439 0 0.107308 0.000329011 0
-          0.107632 0.000288598 0 0.107834 0.000255309 0 0.10794 0.000221462 0 0.107982 0.000123385 0
-          0.101515 0.000934712 0 0.103867 0.000550788 0 0.105295 0.000390718 0 0.106371 0.000322709 0
-          0.10727 0.000281051 0 0.108043 0.000249294 0 0.108717 0.000225454 0 0.109309 0.000206012 0
-          0.109826 0.000184278 0 0.110201 0.000107435 0 0.10142 0.000338387 0 0.103696 0.000204309 0
-          0.105163 0.000145268 0 0.106279 0.000120481 0 0.10723 0.000105744 0 0.108073 9.48045e-05 0
-          0.108838 8.68331e-05 0 0.109545 8.04916e-05 0 0.110194 7.29793e-05 0 0.11069 4.3667e-05 0
+          0.0505184 2.18275e-05 0 0.000803534 9.31331e-08 0 0.000523318 1.87628e-08 0 0.00045316 9.2367e-09 0
+          0.000414338 6.25545e-09 0 0.000389133 3.8023e-09 0 0.000373574 2.40656e-09 0 0.000363801 1.49302e-09 0
+          0.000358003 8.20704e-10 0 0.000355512 1.73788e-10 0 0.051745 7.34015e-05 0 0.00271433 6.21132e-07 0
+          0.00177876 1.26935e-07 0 0.00154027 6.24694e-08 0 0.0014083 4.23054e-08 0 0.00132264 2.57083e-08 0
+          0.00126977 1.62707e-08 0 0.00123656 1.00936e-08 0 0.00121687 5.5488e-09 0 0.00120839 1.18418e-09 0
+          0.0534298 0.000143239 0 0.00535665 2.23956e-06 0 0.00353592 4.65641e-07 0 0.00306172 2.29072e-07 0
+          0.00279934 1.55126e-07 0 0.00262906 9.42381e-08 0 0.00252398 5.96402e-08 0 0.002458 3.69954e-08 0
+          0.00241887 2.03404e-08 0 0.002402 4.38333e-09 0 0.0557249 0.000236512 0 0.00899157 6.14566e-06 0
+          0.00599455 1.30799e-06 0 0.00519056 6.43208e-07 0 0.00474565 4.35567e-07 0 0.00445698 2.64494e-07 0
+          0.0042789 1.67381e-07 0 0.00416709 1.0382e-07 0 0.00410079 5.70935e-08 0 0.00407213 1.24665e-08 0
+          0.0588121 0.000358643 0 0.0139511 1.45969e-05 0 0.00943139 3.20988e-06 0 0.00816751 1.5783e-06 0
+          0.00746751 1.06884e-06 0 0.00701339 6.48706e-07 0 0.00673335 4.10511e-07 0 0.00655754 2.54606e-07 0
+          0.0064533 1.40067e-07 0 0.00640809 3.11411e-08 0 0.062874 0.000514095 0 0.0206198 3.1605e-05 0
+          0.0142219 7.27951e-06 0 0.0123235 3.58319e-06 0 0.0112688 2.42735e-06 0 0.0105845 1.47243e-06 0
+          0.0101625 9.31844e-07 0 0.00989756 5.77963e-07 0 0.00974045 3.18183e-07 0 0.00967195 7.25185e-08 0
+          0.0679956 0.000704281 0 0.0293321 6.35651e-05 0 0.0208433 1.56441e-05 0 0.0180967 7.73566e-06 0
+          0.0165572 5.24662e-06 0 0.0155566 3.18195e-06 0 0.0149391 2.0147e-06 0 0.0145511 1.25012e-06 0
+          0.0143207 6.89302e-07 0 0.0142194 1.6256e-07 0 0.0739604 0.000925353 0 0.0401034 0.00011853 0
+          0.0297871 3.2048e-05 0 0.0260003 1.60474e-05 0 0.0238318 1.09226e-05 0 0.022414 6.63316e-06 0
+          0.0215354 4.20719e-06 0 0.0209813 2.61496e-06 0 0.020651 1.44745e-06 0 0.0205036 3.57871e-07 0
+          0.0801461 0.00116779 0 0.0523151 0.000202149 0 0.0412192 6.19021e-05 0 0.0364048 3.18234e-05 0
+          0.0335302 2.18433e-05 0 0.0316222 1.33421e-05 0 0.0304244 8.50551e-06 0 0.029661 5.31417e-06 0
+          0.0292 2.97037e-06 0 0.0289884 7.84228e-07 0 0.0858418 0.00141822 0 0.0647244 0.000312048 0
+          0.0543667 0.00011034 0 0.048972 5.91511e-05 0 0.0455499 4.12034e-05 0 0.0432136 2.55381e-05 0
+          0.0417031 1.64756e-05 0 0.0407158 1.04271e-05 0 0.0401006 5.95867e-06 0 0.0398034 1.71955e-06 0
+          0.090773 0.00165894 0 0.0760852 0.000439527 0 0.0674356 0.000178762 0 0.0622092 0.000100928 0
+          0.0586776 7.15753e-05 0 0.0561782 4.55265e-05 0 0.0544814 3.00116e-05 0 0.0533219 1.94637e-05 0
+          0.052558 1.15779e-05 0 0.0521594 3.72635e-06 0 0.094765 0.00186705 0 0.0854809 0.000576752 0
+          0.0787683 0.000264026 0 0.074266 0.000157339 0 0.0710596 0.000113342 0 0.0687094 7.46809e-05 0
+          0.0670122 5.07771e-05 0 0.0657816 3.41356e-05 0 0.06491 2.1471e-05 0 0.0644149 7.7484e-06 0
+          0.0977008 0.00201892 0 0.0926069 0.000716446 0 0.0877535 0.000361069 0 0.0841708 0.000226608 0
+          0.081506 0.000165003 0 0.0794826 0.000113356 0 0.0779165 8.00123e-05 0 0.0767054 5.61786e-05 0
+          0.0757822 3.76231e-05 0 0.0752164 1.5076e-05 0 0.0996692 0.00209439 0 0.0976614 0.000845963 0
+          0.094482 0.000465023 0 0.0918122 0.000305668 0 0.0897859 0.000223256 0 0.088183 0.000161286 0
+          0.0868209 0.000118715 0 0.0856928 8.73401e-05 0 0.084772 6.22145e-05 0 0.0841716 2.72415e-05 0
+          0.100858 0.00207715 0 0.101053 0.000942012 0 0.0995031 0.000563928 0 0.0977684 0.000390772 0
+          0.0962254 0.00028876 0 0.0949218 0.000218358 0 0.0937771 0.000167749 0 0.0927688 0.000129399 0
+          0.0918924 9.75773e-05 0 0.0912914 4.59549e-05 0 0.101453 0.00195622 0 0.103025 0.000975277 0
+          0.102914 0.000629696 0 0.102281 0.000465571 0 0.101422 0.000358589 0 0.100526 0.000282014 0
+          0.099668 0.000225876 0 0.0988566 0.000182363 0 0.0981064 0.00014463 0 0.0975681 7.23584e-05 0
+          0.101646 0.00172723 0 0.103867 0.000925427 0 0.104703 0.000630639 0 0.105048 0.000494272 0
+          0.105082 0.000402708 0 0.104902 0.000331937 0 0.104589 0.000278384 0 0.104195 0.000235457 0
+          0.103765 0.000195653 0 0.103426 0.000103383 0 0.101619 0.00138909 0 0.104009 0.000785578 0
+          0.105289 0.000551238 0 0.106178 0.000448129 0 0.106835 0.000381472 0 0.107308 0.000329037 0
+          0.107632 0.000288613 0 0.107834 0.000255301 0 0.10794 0.000221441 0 0.107982 0.000123374 0
+          0.101515 0.000934692 0 0.103867 0.000550764 0 0.105295 0.000390713 0 0.106371 0.000322726 0
+          0.10727 0.000281076 0 0.108043 0.000249315 0 0.108717 0.000225468 0 0.109309 0.000206009 0
+          0.109826 0.000184267 0 0.110201 0.000107428 0 0.10142 0.00033838 0 0.103696 0.0002043 0
+          0.105163 0.000145266 0 0.106279 0.000120487 0 0.10723 0.000105753 0 0.108073 9.48125e-05 0
+          0.108838 8.68388e-05 0 0.109545 8.04914e-05 0 0.110194 7.29759e-05 0 0.11069 4.36644e-05 0
         </DataArray>
         <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii">
           0 0 0 0 0 0 0 0 0 0 0 0
diff --git a/test/references/test_flatplate_lowrekepsilon2cni.vtu b/test/references/test_flatplate_lowrekepsilon2cni.vtu
index f368f17b19..fda6e32a5e 100644
--- a/test/references/test_flatplate_lowrekepsilon2cni.vtu
+++ b/test/references/test_flatplate_lowrekepsilon2cni.vtu
@@ -403,108 +403,108 @@
           0.000157222 0.000148441 0.000141669 0.00013613 0.000131456 0.000127434 0.000123933 0.000120911
         </DataArray>
         <DataArray type="Float32" Name="dv_x/dx_" NumberOfComponents="3" format="ascii">
-          -0.110335 126.778 0 -0.041719 5.79435 0 -0.000304121 3.40004 0 -9.13398e-05 2.7872 0
-          -4.83911e-05 2.48454 0 -3.01604e-05 2.30225 0 -2.01588e-05 2.18232 0 -1.37463e-05 2.10028 0
-          -8.72661e-06 2.04461 0 -6.33954e-06 2.01288 0 -0.108492 3.81798 0 -0.0418307 5.72734 0
-          -0.00101956 3.39784 0 -0.000310397 2.78528 0 -0.000164419 2.48284 0 -0.000102464 2.30072 0
-          -6.84784e-05 2.18093 0 -4.66891e-05 2.09899 0 -2.96316e-05 2.04342 0 -2.15196e-05 2.01176 0
-          -0.105949 3.71796 0 -0.0419604 5.62554 0 -0.00199399 3.39456 0 -0.000616902 2.78247 0
-          -0.00032671 2.48034 0 -0.00020357 2.29848 0 -0.00013603 2.17888 0 -9.27307e-05 2.0971 0
-          -5.88328e-05 2.04166 0 -4.27108e-05 2.01011 0 -0.10246 3.58078 0 -0.0420907 5.48531 0
-          -0.00330577 3.38933 0 -0.00104555 2.77841 0 -0.00055361 2.47679 0 -0.000344879 2.29529 0
-          -0.000230412 2.17598 0 -0.000157034 2.09443 0 -9.95851e-05 2.03917 0 -7.22591e-05 2.00778 0
-          -0.0977149 3.39341 0 -0.0421759 5.29205 0 -0.00504138 3.38014 0 -0.00164423 2.77235 0
-          -0.000870597 2.47162 0 -0.000542216 2.2907 0 -0.000362162 2.17181 0 -0.000246752 2.09059 0
-          -0.000156383 2.03559 0 -0.000113392 2.00442 0 -0.0913391 3.1381 0 -0.0421117 5.02408 0
-          -0.00727707 3.36203 0 -0.00247746 2.76269 0 -0.00131274 2.4638 0 -0.000817413 2.28386 0
-          -0.000545816 2.16563 0 -0.000371735 2.0849 0 -0.000235396 2.03028 0 -0.00017052 1.99941 0
-          -0.0829338 2.79151 0 -0.0416818 4.64864 0 -0.0100312 3.3231 0 -0.00362623 2.74559 0
-          -0.00192716 2.45097 0 -0.00120013 2.27294 0 -0.000801178 2.15586 0 -0.000545416 2.07591 0
-          -0.00034501 2.02184 0 -0.000249608 1.99139 0 -0.0721919 2.33269 0 -0.0404695 4.1241 0
-          -0.0131559 3.23609 0 -0.00517163 2.71098 0 -0.00277284 2.42714 0 -0.00172903 2.25335 0
-          -0.00115449 2.13851 0 -0.00078576 2.05989 0 -0.00049649 2.00663 0 -0.000358662 1.97669 0
-          -0.0591524 1.776 0 -0.0377747 3.42717 0 -0.0161427 3.04617 0 -0.0071248 2.63198 0
-          -0.0039063 2.37558 0 -0.00244839 2.21208 0 -0.00163788 2.10213 0 -0.00111579 2.02602 0
-          -0.000704818 1.97393 0 -0.000508555 1.94446 0 -0.0445244 1.2018 0 -0.0327789 2.59557 0
-          -0.0179705 2.67354 0 -0.00923191 2.44667 0 -0.00531527 2.25248 0 -0.0033847 2.11371 0
-          -0.00228098 2.01513 0 -0.00156198 1.94434 0 -0.000990335 1.89409 0 -0.000715507 1.86476 0
-          -0.0298168 0.717176 0 -0.0252993 1.74274 0 -0.0174049 2.08268 0 -0.010694 2.07296 0
-          -0.00672869 1.98336 0 -0.0044603 1.89358 0 -0.0030736 1.81893 0 -0.00214182 1.75961 0
-          -0.00137936 1.71353 0 -0.00100576 1.68455 0 -0.0169488 0.37951 0 -0.0165741 1.01682 0
-          -0.0140518 1.38233 0 -0.0104106 1.51698 0 -0.00744407 1.53809 0 -0.00533597 1.51534 0
-          -0.00387082 1.47901 0 -0.00281287 1.44082 0 -0.00188109 1.40517 0 -0.00140326 1.37991 0
-          -0.00729181 0.179134 0 -0.00863822 0.511844 0 -0.00909512 0.768443 0 -0.00810613 0.928967 0
-          -0.00675595 1.01324 0 -0.00544193 1.04848 0 -0.00431169 1.05528 0 -0.0033686 1.0466 0
-          -0.00239142 1.03017 0 -0.00184518 1.01519 0 -0.00107487 0.0750973 0 -0.00286678 0.222144 0
-          -0.00434951 0.357265 0 -0.00471669 0.470015 0 -0.00466417 0.555105 0 -0.00435814 0.613905 0
-          -0.00391451 0.650823 0 -0.00339681 0.670867 0 -0.00261178 0.678656 0 -0.00210025 0.679387 0
-          0.00235335 0.0271282 0 0.000550248 0.0824068 0 -0.00102347 0.139043 0 -0.00166367 0.194928 0
-          -0.00207032 0.247239 0 -0.00232497 0.293652 0 -0.00245679 0.332798 0 -0.00246228 0.364164 0
-          -0.00211399 0.387847 0 -0.00179756 0.401949 0 0.00393431 0.00748794 0 0.00223536 0.0247149 0
-          0.000780265 0.0447153 0 0.000215923 0.0658733 0 -0.000163401 0.0880856 0 -0.000457591 0.110849 0
-          -0.000699882 0.133566 0 -0.000887125 0.155595 0 -0.000889223 0.176097 0 -0.000814513 0.190763 0
-          0.0044566 0.000626921 0 0.00292629 0.00433105 0 0.00160347 0.0105804 0 0.00110445 0.0172148 0
-          0.000800257 0.0244644 0 0.000577823 0.0323569 0 0.000399134 0.0408673 0 0.000252265 0.0499353 0
-          0.000130626 0.0592654 0 7.46004e-05 0.0665904 0 0.00445031 -0.00104603 0 0.00312476 -0.00118413 0
-          0.0019315 0.000584856 0 0.00145653 0.00236515 0 0.00118963 0.00430711 0 0.00100809 0.00646723 0
-          0.000870843 0.00886035 0 0.00075685 0.0114838 0 0.000599001 0.0142298 0 0.000494543 0.0164994 0
-          0.00425909 -0.000950027 0 0.00313031 -0.00163262 0 0.00204748 -0.00115348 0 0.00157009 -0.000744243 0
-          0.00131342 -0.000330832 0 0.00114742 0.000129104 0 0.0010267 0.000648256 0 0.00092397 0.00122544 0
-          0.000758057 0.0018171 0 0.000642436 0.00235197 0 0.00406907 -0.000764901 0 0.00308913 -0.00139497 0
-          0.00208708 -0.00116802 0 0.00160061 -0.00100731 0 0.00134258 -0.000869306 0 0.00117956 -0.000721843 0
-          0.00106285 -0.000554678 0 0.000961557 -0.000367964 0 0.000796297 -0.000186764 0 0.000681892 6.33799e-06 0
+          -0.110335 126.778 0 -0.041719 5.79435 0 -0.000304118 3.40006 0 -9.13377e-05 2.78723 0
+          -4.83932e-05 2.48457 0 -3.01713e-05 2.30226 0 -2.01825e-05 2.18225 0 -1.3785e-05 2.10005 0
+          -8.77205e-06 2.04415 0 -6.38384e-06 2.01219 0 -0.108492 3.81798 0 -0.0418307 5.72735 0
+          -0.00101955 3.39786 0 -0.00031039 2.78531 0 -0.000164427 2.48287 0 -0.000102502 2.30073 0
+          -6.85588e-05 2.18086 0 -4.68206e-05 2.09876 0 -2.97861e-05 2.04295 0 -2.16702e-05 2.01107 0
+          -0.105949 3.71796 0 -0.0419603 5.62555 0 -0.00199397 3.39457 0 -0.000616888 2.7825 0
+          -0.000326724 2.48038 0 -0.000203644 2.29849 0 -0.00013619 2.17881 0 -9.29924e-05 2.09687 0
+          -5.91401e-05 2.04119 0 -4.30103e-05 2.00942 0 -0.10246 3.58079 0 -0.0420907 5.48532 0
+          -0.00330574 3.38935 0 -0.00104553 2.77844 0 -0.000553634 2.47682 0 -0.000345004 2.2953 0
+          -0.000230683 2.17591 0 -0.000157479 2.0942 0 -0.000100106 2.0387 0 -7.2767e-05 2.00709 0
+          -0.0977149 3.39341 0 -0.0421759 5.29206 0 -0.00504134 3.38015 0 -0.00164419 2.77238 0
+          -0.000870634 2.47166 0 -0.000542414 2.29071 0 -0.00036259 2.17174 0 -0.000247452 2.09036 0
+          -0.000157204 2.03513 0 -0.000114192 2.00373 0 -0.0913391 3.1381 0 -0.0421116 5.02409 0
+          -0.007277 3.36205 0 -0.0024774 2.76272 0 -0.00131279 2.46383 0 -0.000817712 2.28387 0
+          -0.000546461 2.16556 0 -0.000372791 2.08467 0 -0.000236634 2.02982 0 -0.000171726 1.99874 0
+          -0.0829337 2.79151 0 -0.0416817 4.64864 0 -0.0100311 3.32312 0 -0.00362614 2.74562 0
+          -0.00192724 2.45101 0 -0.00120056 2.27296 0 -0.000802124 2.1558 0 -0.000546965 2.07569 0
+          -0.000346827 2.0214 0 -0.000251375 1.99074 0 -0.0721919 2.33269 0 -0.0404694 4.1241 0
+          -0.0131557 3.23611 0 -0.00517149 2.71101 0 -0.00277294 2.42718 0 -0.00172965 2.25338 0
+          -0.00115583 2.13847 0 -0.000787969 2.05972 0 -0.00049908 2.00626 0 -0.000361179 1.97613 0
+          -0.0591524 1.776 0 -0.0377746 3.42717 0 -0.0161425 3.04618 0 -0.00712459 2.63201 0
+          -0.00390641 2.37563 0 -0.0024492 2.21213 0 -0.00163968 2.10216 0 -0.00111877 2.02598 0
+          -0.00070832 1.97376 0 -0.000511958 1.94418 0 -0.0445243 1.2018 0 -0.0327787 2.59557 0
+          -0.0179702 2.67354 0 -0.00923152 2.4467 0 -0.00531521 2.25255 0 -0.00338547 2.11383 0
+          -0.00228295 2.01532 0 -0.00156537 1.94458 0 -0.000994373 1.8944 0 -0.000719448 1.86512 0
+          -0.0298167 0.717176 0 -0.0252992 1.74274 0 -0.0174045 2.08267 0 -0.0106932 2.07296 0
+          -0.00672798 1.98339 0 -0.00446013 1.8937 0 -0.00307436 1.81919 0 -0.00214374 1.76007 0
+          -0.00138194 1.71423 0 -0.00100838 1.68547 0 -0.0169488 0.379509 0 -0.016574 1.01682 0
+          -0.0140514 1.38232 0 -0.0104097 1.51695 0 -0.00744258 1.53805 0 -0.00533407 1.51531 0
+          -0.0038688 1.47904 0 -0.00281096 1.44097 0 -0.00187964 1.40548 0 -0.00140217 1.38036 0
+          -0.00729179 0.179133 0 -0.00863822 0.511842 0 -0.00909513 0.768438 0 -0.00810595 0.928945 0
+          -0.00675527 1.01318 0 -0.00544052 1.04837 0 -0.00430953 1.0551 0 -0.0033659 1.04635 0
+          -0.00238889 1.02984 0 -0.00184302 1.0148 0 -0.00107487 0.0750971 0 -0.00286679 0.222143 0
+          -0.00434964 0.357264 0 -0.00471706 0.470013 0 -0.00466483 0.555093 0 -0.00435905 0.613868 0
+          -0.00391569 0.65074 0 -0.00339842 0.670716 0 -0.00261359 0.678415 0 -0.00210201 0.67907 0
+          0.00235334 0.0271282 0 0.000550241 0.0824067 0 -0.00102351 0.139043 0 -0.00166386 0.19493 0
+          -0.0020708 0.247247 0 -0.00232589 0.293668 0 -0.00245835 0.332824 0 -0.00246469 0.364207 0
+          -0.00211683 0.387914 0 -0.00180036 0.402042 0 0.0039343 0.007488 0 0.00223536 0.024715 0
+          0.000780254 0.0447154 0 0.0002159 0.0658739 0 -0.000163444 0.0880885 0 -0.000457639 0.110857 0
+          -0.00069987 0.133585 0 -0.000886885 0.155632 0 -0.000888719 0.176162 0 -0.000813917 0.190858 0
+          0.00445659 0.000626933 0 0.00292629 0.00433106 0 0.00160346 0.0105804 0 0.00110444 0.0172148 0
+          0.000800276 0.0244645 0 0.000577918 0.0323574 0 0.000399392 0.0408684 0 0.000252838 0.0499371 0
+          0.000131473 0.0592667 0 7.55188e-05 0.0665902 0 0.00445031 -0.00104603 0 0.00312475 -0.00118412 0
+          0.00193148 0.000584861 0 0.00145652 0.00236513 0 0.00118963 0.00430705 0 0.00100814 0.00646702 0
+          0.000870977 0.00885975 0 0.000757103 0.0114822 0 0.000599321 0.0142257 0 0.000494864 0.0164921 0
+          0.00425909 -0.000950023 0 0.00313031 -0.00163261 0 0.00204746 -0.00115347 0 0.00157007 -0.00074423 0
+          0.00131341 -0.000330827 0 0.00114745 0.000129073 0 0.00102678 0.000648124 0 0.000924107 0.00122506 0
+          0.000758203 0.00181618 0 0.000642567 0.00235039 0 0.00406907 -0.000764902 0 0.00308912 -0.00139497 0
+          0.00208707 -0.00116802 0 0.00160059 -0.0010073 0 0.00134258 -0.000869301 0 0.00117959 -0.000721842 0
+          0.00106292 -0.000554701 0 0.000961671 -0.000368059 0 0.000796409 -0.000187016 0 0.000681987 5.91091e-06 0
         </DataArray>
         <DataArray type="Float32" Name="dv_y/dx_" NumberOfComponents="3" format="ascii">
-          1.07005e-07 0.180771 0 -1.81903e-05 0.00157917 0 -7.26177e-08 0.000334345 0 -1.23476e-08 0.00015226 0
-          -4.79203e-09 8.80068e-05 0 -2.4825e-09 5.66888e-05 0 -1.50817e-09 3.85056e-05 0 -1.05043e-09 2.66189e-05 0
-          -9.52421e-10 1.75635e-05 0 -9.96403e-10 7.63077e-06 0 7.13879e-07 0.176902 0 -6.11759e-05 0.00322252 0
-          -4.83786e-07 0.00069446 0 -8.35194e-08 0.000316115 0 -3.24027e-08 0.000182671 0 -1.67831e-08 0.000117648 0
-          -1.0195e-08 7.99014e-05 0 -7.10029e-09 5.52287e-05 0 -6.43781e-09 3.64343e-05 0 -6.73526e-09 1.58178e-05 0
-          2.57495e-06 0.170459 0 -0.0001194 0.00592861 0 -1.742e-06 0.00131023 0 -3.06309e-07 0.000596073 0
-          -1.18788e-07 0.000344329 0 -6.15116e-08 0.000221711 0 -3.73604e-08 0.000150549 0 -2.60171e-08 0.000104043 0
-          -2.35893e-08 6.86203e-05 0 -2.46798e-08 2.97608e-05 0 7.0704e-06 0.161805 0 -0.000197194 0.00948732 0
-          -4.77186e-06 0.00217388 0 -8.60232e-07 0.000988474 0 -3.3344e-07 0.000570741 0 -1.72607e-07 0.000367384 0
-          -1.04816e-07 0.000249403 0 -7.29822e-08 0.000172316 0 -6.61704e-08 0.000113611 0 -6.92317e-08 4.92028e-05 0
-          1.68159e-05 0.150373 0 -0.000299111 0.0140226 0 -1.13099e-05 0.00338282 0 -2.11111e-06 0.00153839 0
-          -8.18003e-07 0.000887801 0 -4.2327e-07 0.000571254 0 -2.56965e-07 0.000387673 0 -1.78889e-07 0.00026776 0
-          -1.62188e-07 0.00017646 0 -1.697e-07 7.62705e-05 0 3.65385e-05 0.135637 0 -0.000428866 0.0195082 0
-          -2.44483e-05 0.00506249 0 -4.79264e-06 0.00230783 0 -1.85774e-06 0.00133142 0 -9.6086e-07 0.000856358 0
-          -5.83153e-07 0.000580933 0 -4.05876e-07 0.00040108 0 -3.67977e-07 0.000264174 0 -3.85049e-07 0.00011388 0
-          7.42102e-05 0.117344 0 -0.000587229 0.0255425 0 -4.92633e-05 0.00734538 0 -1.03439e-05 0.00337787 0
-          -4.02074e-06 0.00195014 0 -2.07925e-06 0.00125417 0 -1.26156e-06 0.000850558 0 -8.77831e-07 0.00058702 0
-          -7.95907e-07 0.000386441 0 -8.32957e-07 0.00016603 0 0.000141745 0.0959327 0 -0.000768669 0.0310031 0
-          -9.29183e-05 0.010274 0 -2.14594e-05 0.00483657 0 -8.41818e-06 0.00280422 0 -4.35764e-06 0.00180553 0
-          -2.6441e-06 0.00122495 0 -1.83961e-06 0.000845539 0 -1.66848e-06 0.000556707 0 -1.74682e-06 0.000238335 0
-          0.000252987 0.0729198 0 -0.000957688 0.0339167 0 -0.000162429 0.0135328 0 -4.26493e-05 0.00671018 0
-          -1.71294e-05 0.0039462 0 -8.90931e-06 0.00255449 0 -5.41335e-06 0.00173811 0 -3.76785e-06 0.00120254 0
-          -3.42196e-06 0.000794226 0 -3.58676e-06 0.000339496 0 0.000415555 0.0506944 0 -0.00112824 0.0323482 0
-          -0.000257647 0.0160772 0 -7.95036e-05 0.0087532 0 -3.35798e-05 0.00533797 0 -1.77271e-05 0.00351417 0
-          -1.08298e-05 0.00241613 0 -7.55457e-06 0.00168668 0 -6.89398e-06 0.00112765 0 -7.25338e-06 0.000485164 0
-          0.000618592 0.0315632 0 -0.00125113 0.0261774 0 -0.000362435 0.0163751 0 -0.000133682 0.0101936 0
-          -6.15389e-05 0.0066703 0 -3.36767e-05 0.00457015 0 -2.09043e-05 0.00322864 0 -1.46899e-05 0.00230794 0
-          -1.36068e-05 0.00159084 0 -1.4479e-05 0.000700678 0 0.000829761 0.0168351 0 -0.00130848 0.0176376 0
-          -0.000447331 0.013732 0 -0.000194674 0.0100242 0 -0.000100315 0.0072919 0 -5.85704e-05 0.00536735 0
-          -3.76762e-05 0.0039988 0 -2.69908e-05 0.00299251 0 -2.59678e-05 0.00217344 0 -2.83811e-05 0.000999212 0
-          0.00100931 0.00663348 0 -0.00130268 0.00962533 0 -0.000488926 0.00918121 0 -0.00024068 0.00792859 0
-          -0.000138909 0.00657795 0 -8.8389e-05 0.00536636 0 -6.03605e-05 0.00434434 0 -4.50168e-05 0.00349132 0
-          -4.6724e-05 0.00272015 0 -5.34969e-05 0.00132493 0 0.00112827 0.00027385 0 -0.00124922 0.0038246 0
-          -0.000486797 0.00462034 0 -0.000255225 0.00476244 0 -0.000159913 0.00457388 0 -0.000110524 0.00422505 0
-          -8.12896e-05 0.00380964 0 -6.47692e-05 0.00336941 0 -7.63578e-05 0.00286409 0 -9.32866e-05 0.00150173 0
-          0.00117536 -0.00323894 0 -0.00116114 0.000363855 0 -0.000458386 0.00133082 0 -0.000242193 0.00186485 0
-          -0.000156408 0.00217308 0 -0.000113276 0.00233516 0 -8.82233e-05 0.00239599 0 -7.58074e-05 0.00237702 0
-          -0.000107543 0.00223045 0 -0.000142224 0.00128349 0 0.00115039 -0.0048559 0 -0.00104089 -0.00143143 0
-          -0.000418367 -0.000530618 0 -0.000216827 -2.03161e-05 0 -0.000138472 0.000334027 0 -0.000100361 0.000600701 0
-          -7.93814e-05 0.000808928 0 -7.23163e-05 0.000968755 0 -0.000126211 0.00103894 0 -0.000179629 0.000690965 0
-          0.00105355 -0.00533576 0 -0.000885081 -0.00227553 0 -0.000368321 -0.00141471 0 -0.000187006 -0.000972966 0
-          -0.000116772 -0.000680241 0 -8.29651e-05 -0.000459939 0 -6.47322e-05 -0.000280664 0 -6.11265e-05 -0.000128534 0
-          -0.000125273 -1.26964e-05 0 -0.000186644 8.51802e-05 0 0.000879283 -0.00523661 0 -0.000690525 -0.00264248 0
-          -0.000301976 -0.00178264 0 -0.000151199 -0.00137209 0 -9.26299e-05 -0.00112004 0 -6.46569e-05 -0.000941658 0
-          -4.97687e-05 -0.000803751 0 -4.8372e-05 -0.00068927 0 -0.000107115 -0.000578917 0 -0.000162138 -0.000282736 0
-          0.000612793 -0.00494005 0 -0.000452997 -0.00279345 0 -0.000209399 -0.00191867 0 -0.000104117 -0.00151198 0
-          -6.29256e-05 -0.00127504 0 -4.33986e-05 -0.00111494 0 -3.31591e-05 -0.000996263 0 -3.30004e-05 -0.000899639 0
-          -7.44166e-05 -0.000789523 0 -0.000112541 -0.000443984 0 0.00022697 -0.00480473 0 -0.000161372 -0.00283241 0
-          -7.75438e-05 -0.00195022 0 -3.84755e-05 -0.00154177 0 -2.30934e-05 -0.0013077 0 -1.58335e-05 -0.00115188 0
-          -1.2062e-05 -0.00103789 0 -1.21642e-05 -0.000945379 0 -2.73131e-05 -0.000833936 0 -4.11051e-05 -0.000484316 0
+          1.07005e-07 0.180771 0 -1.81903e-05 0.00157917 0 -7.2618e-08 0.000334339 0 -1.23473e-08 0.000152253 0
+          -4.79074e-09 8.80083e-05 0 -2.48031e-09 5.6708e-05 0 -1.50539e-09 3.85506e-05 0 -1.04735e-09 2.66936e-05 0
+          -9.52977e-10 1.76699e-05 0 -1.0007e-09 7.69436e-06 0 7.13878e-07 0.176902 0 -6.11759e-05 0.00322252 0
+          -4.83788e-07 0.000694448 0 -8.3517e-08 0.000316102 0 -3.2394e-08 0.000182674 0 -1.67683e-08 0.000117688 0
+          -1.01762e-08 7.99949e-05 0 -7.07949e-09 5.53839e-05 0 -6.44157e-09 3.66553e-05 0 -6.76431e-09 1.59499e-05 0
+          2.57494e-06 0.170459 0 -0.0001194 0.00592861 0 -1.74201e-06 0.00131021 0 -3.063e-07 0.000596048 0
+          -1.18756e-07 0.000344334 0 -6.14575e-08 0.000221787 0 -3.72915e-08 0.000150726 0 -2.59408e-08 0.000104335 0
+          -2.36031e-08 6.90371e-05 0 -2.47863e-08 3.00097e-05 0 7.0704e-06 0.161805 0 -0.000197194 0.00948731 0
+          -4.77187e-06 0.00217385 0 -8.60207e-07 0.000988432 0 -3.3335e-07 0.000570751 0 -1.72455e-07 0.000367509 0
+          -1.04623e-07 0.000249695 0 -7.27681e-08 0.000172801 0 -6.62092e-08 0.000114302 0 -6.95308e-08 4.96155e-05 0
+          1.68159e-05 0.150373 0 -0.000299111 0.0140226 0 -1.13099e-05 0.00338276 0 -2.11104e-06 0.00153832 0
+          -8.17783e-07 0.000887815 0 -4.22897e-07 0.000571448 0 -2.56491e-07 0.000388129 0 -1.78364e-07 0.000268515 0
+          -1.62284e-07 0.000177536 0 -1.70434e-07 7.69122e-05 0 3.65385e-05 0.135637 0 -0.000428866 0.0195082 0
+          -2.44484e-05 0.0050624 0 -4.7925e-06 0.00230773 0 -1.85724e-06 0.00133144 0 -9.60012e-07 0.000856649 0
+          -5.82075e-07 0.000581614 0 -4.04684e-07 0.000402211 0 -3.68195e-07 0.000265785 0 -3.86716e-07 0.000114841 0
+          7.42101e-05 0.117344 0 -0.000587229 0.0255425 0 -4.92635e-05 0.00734525 0 -1.03436e-05 0.00337772 0
+          -4.01966e-06 0.00195016 0 -2.07741e-06 0.00125459 0 -1.25923e-06 0.000851548 0 -8.75255e-07 0.000588665 0
+          -7.96379e-07 0.000388786 0 -8.36565e-07 0.000167426 0 0.000141745 0.0959326 0 -0.00076867 0.031003 0
+          -9.29188e-05 0.0102738 0 -2.14588e-05 0.00483634 0 -8.41593e-06 0.00280423 0 -4.35381e-06 0.0018061 0
+          -2.63923e-06 0.00122632 0 -1.83423e-06 0.000847839 0 -1.66947e-06 0.000559989 0 -1.75435e-06 0.000240288 0
+          0.000252987 0.0729197 0 -0.000957688 0.0339167 0 -0.00016243 0.0135325 0 -4.26482e-05 0.00670982 0
+          -1.71249e-05 0.00394613 0 -8.90158e-06 0.00255514 0 -5.40353e-06 0.00173981 0 -3.75702e-06 0.00120545 0
+          -3.42393e-06 0.000798415 0 -3.60186e-06 0.000341994 0 0.000415554 0.0506943 0 -0.00112824 0.0323481 0
+          -0.000257649 0.0160768 0 -7.95017e-05 0.0087526 0 -3.35715e-05 0.00533757 0 -1.77125e-05 0.00351448 0
+          -1.08112e-05 0.00241757 0 -7.53416e-06 0.00168941 0 -6.89749e-06 0.00113173 0 -7.28137e-06 0.000487638 0
+          0.000618592 0.0315631 0 -0.00125113 0.0261773 0 -0.000362441 0.0163748 0 -0.000133681 0.0101928 0
+          -6.15267e-05 0.00666927 0 -3.36534e-05 0.00456938 0 -2.0874e-05 0.00322851 0 -1.46566e-05 0.00230864 0
+          -1.36109e-05 0.00159248 0 -1.45213e-05 0.000701825 0 0.00082976 0.0168351 0 -0.00130849 0.0176376 0
+          -0.000447342 0.0137319 0 -0.00019468 0.0100236 0 -0.000100307 0.00729074 0 -5.8545e-05 0.00536577 0
+          -3.76401e-05 0.00399702 0 -2.69495e-05 0.00299073 0 -2.5966e-05 0.0021719 0 -2.84207e-05 0.000998594 0
+          0.0010093 0.00663347 0 -0.00130269 0.0096253 0 -0.000488941 0.00918123 0 -0.000240695 0.00792855 0
+          -0.000138913 0.00657762 0 -8.8376e-05 0.00536561 0 -6.03335e-05 0.00434321 0 -4.49795e-05 0.00349004 0
+          -4.67087e-05 0.00271899 0 -5.35086e-05 0.00132452 0 0.00112827 0.000273867 0 -0.00124923 0.00382458 0
+          -0.000486809 0.0046204 0 -0.00025524 0.00476267 0 -0.00015992 0.0045743 0 -0.000110517 0.0042256 0
+          -8.12659e-05 0.00381037 0 -6.47289e-05 0.00337059 0 -7.63359e-05 0.00286589 0 -9.32911e-05 0.0015031 0
+          0.00117536 -0.00323892 0 -0.00116115 0.00036385 0 -0.000458393 0.00133084 0 -0.000242196 0.00186501 0
+          -0.000156402 0.00217346 0 -0.000113253 0.00233583 0 -8.8176e-05 0.00239701 0 -7.57354e-05 0.00237853 0
+          -0.000107521 0.00223243 0 -0.000142264 0.00128487 0 0.00115039 -0.00485589 0 -0.0010409 -0.00143143 0
+          -0.000418372 -0.000530608 0 -0.000216825 -2.02745e-05 0 -0.000138456 0.000334129 0 -0.000100326 0.000600874 0
+          -7.93193e-05 0.000809145 0 -7.22318e-05 0.000968943 0 -0.000126195 0.00103888 0 -0.000179689 0.000690822 0
+          0.00105355 -0.00533575 0 -0.000885084 -0.00227553 0 -0.000368326 -0.00141469 0 -0.000187004 -0.000972949 0
+          -0.000116757 -0.000680237 0 -8.29345e-05 -0.000459982 0 -6.46838e-05 -0.000280819 0 -6.10726e-05 -0.000128928 0
+          -0.000125273 -1.35138e-05 0 -0.000186694 8.44878e-05 0 0.000879281 -0.00523661 0 -0.000690528 -0.00264247 0
+          -0.000301979 -0.00178262 0 -0.000151198 -0.00137207 0 -9.26195e-05 -0.00112003 0 -6.46355e-05 -0.0009417 0
+          -4.97378e-05 -0.000803882 0 -4.83466e-05 -0.000689552 0 -0.000107126 -0.000579384 0 -0.000162175 -0.000283103 0
+          0.000612792 -0.00494005 0 -0.000452999 -0.00279344 0 -0.000209402 -0.00191865 0 -0.000104116 -0.00151196 0
+          -6.29189e-05 -0.00127503 0 -4.33852e-05 -0.00111496 0 -3.31407e-05 -0.000996348 0 -3.29884e-05 -0.000899803 0
+          -7.44269e-05 -0.000789731 0 -0.000112566 -0.000444111 0 0.000226969 -0.00480473 0 -0.000161372 -0.0028324 0
+          -7.75447e-05 -0.0019502 0 -3.84753e-05 -0.00154175 0 -2.3091e-05 -0.00130769 0 -1.58287e-05 -0.0011519 0
+          -1.20555e-05 -0.00103796 0 -1.21604e-05 -0.000945517 0 -2.73172e-05 -0.00083409 0 -4.11139e-05 -0.000484394 0
         </DataArray>
         <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii">
           0.0504699 2.18484e-05 0 0.000698642 9.63042e-08 0 0.000407064 2.01145e-08 0 0.000333695 9.16341e-09 0
diff --git a/test/references/test_flatplate_zeroeq2cni.vtu b/test/references/test_flatplate_zeroeq2cni.vtu
index 17e254b067..be2532eb39 100644
--- a/test/references/test_flatplate_zeroeq2cni.vtu
+++ b/test/references/test_flatplate_zeroeq2cni.vtu
@@ -365,108 +365,108 @@
           4.42885e-05 3.71469e-05 0.000202194 0.000426957 0.000661171 0.000865854 0.00102486 0.00112227
         </DataArray>
         <DataArray type="Float32" Name="dv_x/dx_" NumberOfComponents="3" format="ascii">
-          -0.109753 128.622 0 -0.0414057 10.1437 0 -0.000253248 8.35409 0 -0.000109218 7.6416 0
-          -6.07982e-05 7.26831 0 -3.8813e-05 7.03662 0 -2.62756e-05 6.88195 0 -1.80802e-05 6.77501 0
-          -1.02728e-05 6.7019 0 -5.86525e-06 6.67255 0 -0.106526 5.60315 0 -0.040776 9.94512 0
-          -0.000848334 8.22104 0 -0.000368127 7.53163 0 -0.000205116 7.16893 0 -0.000130995 6.94339 0
-          -8.86977e-05 6.79268 0 -6.10442e-05 6.68842 0 -3.47364e-05 6.61707 0 -1.98996e-05 6.58824 0
-          -0.102137 5.30614 0 -0.0399021 9.45203 0 -0.00163951 7.86943 0 -0.000713531 7.23777 0
-          -0.000398674 6.90192 0 -0.000254921 6.69214 0 -0.00017272 6.55165 0 -0.000118949 6.45431 0
-          -6.7819e-05 6.38751 0 -3.89894e-05 6.36029 0 -0.0963913 4.80166 0 -0.0387148 8.59145 0
-          -0.00262889 7.22397 0 -0.00114614 6.68787 0 -0.000643881 6.39736 0 -0.000412656 6.21472 0
-          -0.000279938 6.09197 0 -0.000193031 6.00674 0 -0.000110346 5.94797 0 -6.3686e-05 5.92379 0
-          -0.0892408 4.11366 0 -0.037175 7.39742 0 -0.00378254 6.29374 0 -0.00164412 5.87579 0
-          -0.000931337 5.64311 0 -0.000598727 5.49582 0 -0.000406866 5.39643 0 -0.000281063 5.32725 0
-          -0.000161199 5.27928 0 -9.34359e-05 5.2593 0 -0.0808459 3.32692 0 -0.0352787 6.02486 0
-          -0.00502712 5.20002 0 -0.00217159 4.89644 0 -0.00124275 4.72221 0 -0.000801446 4.61138 0
-          -0.000545631 4.53631 0 -0.000377677 4.48397 0 -0.000217446 4.44748 0 -0.000126674 4.43201 0
-          -0.0715153 2.5518 0 -0.033042 4.67202 0 -0.00627244 4.10585 0 -0.00269842 3.8945 0
-          -0.00156033 3.77021 0 -0.00100894 3.69085 0 -0.000688004 3.63695 0 -0.000477059 3.59936 0
-          -0.000275853 3.57307 0 -0.000161736 3.5616 0 -0.0616024 1.86997 0 -0.030478 3.48115 0
-          -0.00742901 3.13102 0 -0.00320846 2.98687 0 -0.00187188 2.90112 0 -0.00121309 2.84608 0
-          -0.000828246 2.80864 0 -0.000575003 2.78254 0 -0.000334084 2.7643 0 -0.000197557 2.756 0
-          -0.0514415 1.3167 0 -0.0275881 2.51031 0 -0.00841014 2.32611 0 -0.00369271 2.22988 0
-          -0.00216919 2.17251 0 -0.00140889 2.13529 0 -0.000962796 2.10993 0 -0.000668825 2.09227 0
-          -0.000390672 2.07998 0 -0.000233592 2.07405 0 -0.0413366 0.892759 0 -0.0243663 1.75804 0
-          -0.00912694 1.69208 0 -0.00413846 1.6313 0 -0.00244461 1.59448 0 -0.001592 1.57013 0
-          -0.00108873 1.55347 0 -0.000756349 1.54188 0 -0.000444405 1.53388 0 -0.000269363 1.52973 0
-          -0.0315718 0.581694 0 -0.0208125 1.19514 0 -0.00948446 1.20671 0 -0.00452002 1.17356 0
-          -0.0026877 1.15171 0 -0.00175651 1.13674 0 -0.00120226 1.12637 0 -0.000834901 1.11915 0
-          -0.000493681 1.11424 0 -0.000303958 1.11145 0 -0.0224259 0.361783 0 -0.0169491 0.785062 0
-          -0.00938309 0.841565 0 -0.0047911 0.830578 0 -0.00288156 0.81993 0 -0.00189279 0.811917 0
-          -0.00129737 0.806186 0 -0.000900338 0.802182 0 -0.000535841 0.799509 0 -0.000335491 0.79781 0
-          -0.0141809 0.212001 0 -0.0128413 0.493553 0 -0.00872825 0.570126 0 -0.00487948 0.576597 0
-          -0.00299774 0.574628 0 -0.00198485 0.571942 0 -0.00136399 0.569729 0 -0.000945838 0.568148 0
-          -0.000566326 0.567156 0 -0.000360423 0.566357 0 -0.00711918 0.114341 0 -0.00861913 0.291985 0
-          -0.00745151 0.370593 0 -0.0046864 0.389701 0 -0.00298983 0.394643 0 -0.00200673 0.396158 0
-          -0.0013856 0.39671 0 -0.000960191 0.397028 0 -0.000577507 0.397345 0 -0.000372649 0.397318 0
-          -0.00150331 0.0543069 0 -0.00449679 0.157707 0 -0.00554623 0.22619 0 -0.00409631 0.252728 0
-          -0.00278749 0.263061 0 -0.00191753 0.267958 0 -0.00133565 0.270748 0 -0.000925162 0.272606 0
-          -0.000556894 0.273985 0 -0.000362172 0.274632 0 0.00246718 0.0206279 0 -0.000783053 0.0732985 0
-          -0.00311955 0.124551 0 -0.00300549 0.153012 0 -0.00229551 0.167038 0 -0.00165629 0.174617 0
-          -0.00117367 0.179271 0 -0.000812617 0.182439 0 -0.000485141 0.184729 0 -0.000313611 0.185979 0
-          0.00473441 0.00461483 0 0.0021361 0.025399 0 -0.000458474 0.0567062 0 -0.00138457 0.0816376 0
-          -0.00140858 0.0972421 0 -0.00113675 0.106669 0 -0.0008364 0.112726 0 -0.000576785 0.116919 0
-          -0.000330938 0.119945 0 -0.000202588 0.1217 0 0.00549323 -0.000607049 0 0.00387158 0.00398047 0
-          0.00190567 0.0172948 0 0.000616608 0.0332387 0 -5.88069e-05 0.0471197 0 -0.000272725 0.0574962 0
-          -0.000257773 0.0648696 0 -0.000167529 0.0701186 0 -5.80032e-05 0.0738859 0 -1.10619e-07 0.0761185 0
-          0.00539834 -0.00106 0 0.00437557 -0.00132392 0 0.00320165 0.00172443 0 0.00234645 0.00748496 0
-          0.00162598 0.0148626 0 0.00108372 0.0222622 0 0.000742628 0.0286802 0 0.000551131 0.0337811 0
-          0.000419625 0.0375953 0 0.000355996 0.0399008 0 0.00518407 -0.000844646 0 0.00435924 -0.001573 0
-          0.00344843 -0.0010045 0 0.00291758 0.00084252 0 0.00252922 0.00458592 0 0.00214723 0.0096837 0
-          0.00175961 0.0149959 0 0.00139384 0.0196382 0 0.00101378 0.0232445 0 0.000807445 0.025454 0
+          -0.109753 128.622 0 -0.0414057 10.1437 0 -0.000253249 8.35409 0 -0.000109219 7.6416 0
+          -6.07993e-05 7.2683 0 -3.8814e-05 7.0366 0 -2.62764e-05 6.88193 0 -1.80808e-05 6.77498 0
+          -1.02731e-05 6.70187 0 -5.86551e-06 6.67252 0 -0.106526 5.60315 0 -0.040776 9.94513 0
+          -0.000848338 8.22104 0 -0.000368131 7.53162 0 -0.00020512 7.16892 0 -0.000130999 6.94337 0
+          -8.87004e-05 6.79266 0 -6.10463e-05 6.6884 0 -3.47377e-05 6.61704 0 -1.99005e-05 6.58821 0
+          -0.102137 5.30615 0 -0.0399021 9.45204 0 -0.00163952 7.86943 0 -0.00071354 7.23777 0
+          -0.000398682 6.9019 0 -0.000254928 6.69212 0 -0.000172726 6.55163 0 -0.000118953 6.45429 0
+          -6.78216e-05 6.38749 0 -3.89912e-05 6.36026 0 -0.0963913 4.80167 0 -0.0387148 8.59146 0
+          -0.0026289 7.22398 0 -0.00114615 6.68786 0 -0.000643894 6.39735 0 -0.000412667 6.2147 0
+          -0.000279947 6.09195 0 -0.000193038 6.00671 0 -0.00011035 5.94794 0 -6.3689e-05 5.92376 0
+          -0.0892408 4.11366 0 -0.0371751 7.39743 0 -0.00378256 6.29374 0 -0.00164414 5.87579 0
+          -0.000931359 5.6431 0 -0.000598746 5.49581 0 -0.000406882 5.39641 0 -0.000281075 5.32722 0
+          -0.000161206 5.27925 0 -9.34407e-05 5.25926 0 -0.0808458 3.32692 0 -0.0352788 6.02487 0
+          -0.00502716 5.20002 0 -0.00217163 4.89643 0 -0.00124279 4.7222 0 -0.000801476 4.61135 0
+          -0.000545656 4.53628 0 -0.000377696 4.48393 0 -0.000217457 4.44744 0 -0.000126681 4.43196 0
+          -0.0715153 2.5518 0 -0.033042 4.67202 0 -0.0062725 4.10584 0 -0.00269848 3.89448 0
+          -0.00156039 3.77018 0 -0.00100899 3.69081 0 -0.000688046 3.63691 0 -0.000477091 3.59931 0
+          -0.000275873 3.57302 0 -0.000161749 3.56154 0 -0.0616023 1.86996 0 -0.0304781 3.48114 0
+          -0.00742911 3.131 0 -0.00320856 2.98683 0 -0.00187197 2.90108 0 -0.00121317 2.84603 0
+          -0.000828315 2.80858 0 -0.000575057 2.78248 0 -0.000334119 2.76423 0 -0.000197581 2.75592 0
+          -0.0514416 1.3167 0 -0.0275882 2.51029 0 -0.00841029 2.32608 0 -0.00369285 2.22984 0
+          -0.00216933 2.17246 0 -0.00140901 2.13524 0 -0.000962898 2.10987 0 -0.000668907 2.09221 0
+          -0.000390725 2.07992 0 -0.000233629 2.07398 0 -0.0413368 0.892753 0 -0.0243665 1.75802 0
+          -0.00912714 1.69206 0 -0.00413865 1.63128 0 -0.00244477 1.59446 0 -0.00159214 1.57011 0
+          -0.00108885 1.55345 0 -0.000756446 1.54186 0 -0.000444468 1.53386 0 -0.000269407 1.52971 0
+          -0.031572 0.581693 0 -0.0208127 1.19514 0 -0.00948467 1.20671 0 -0.00452021 1.17356 0
+          -0.00268785 1.15172 0 -0.00175663 1.13674 0 -0.00120236 1.12638 0 -0.000834981 1.11917 0
+          -0.000493732 1.11425 0 -0.000303992 1.11147 0 -0.022426 0.361785 0 -0.0169493 0.785068 0
+          -0.00938326 0.841576 0 -0.00479124 0.830592 0 -0.00288166 0.819948 0 -0.00189286 0.811939 0
+          -0.00129742 0.806213 0 -0.000900365 0.802213 0 -0.000535853 0.799543 0 -0.000335496 0.797846 0
+          -0.0141809 0.212003 0 -0.0128414 0.493559 0 -0.00872832 0.570137 0 -0.00487953 0.576611 0
+          -0.00299776 0.574645 0 -0.00198484 0.571962 0 -0.00136396 0.569752 0 -0.000945799 0.568174 0
+          -0.000566288 0.567184 0 -0.000360389 0.566386 0 -0.00711916 0.114342 0 -0.00861911 0.291987 0
+          -0.00745148 0.370597 0 -0.00468637 0.389708 0 -0.00298979 0.39465 0 -0.00200667 0.396167 0
+          -0.00138553 0.39672 0 -0.000960107 0.397039 0 -0.000577434 0.397356 0 -0.000372587 0.397329 0
+          -0.00150328 0.0543069 0 -0.00449674 0.157707 0 -0.00554617 0.226191 0 -0.00409625 0.252728 0
+          -0.00278742 0.263062 0 -0.00191746 0.267958 0 -0.00133557 0.270748 0 -0.00092508 0.272606 0
+          -0.000556823 0.273984 0 -0.000362112 0.274631 0 0.00246719 0.0206279 0 -0.000783026 0.0732982 0
+          -0.00311951 0.12455 0 -0.00300545 0.153011 0 -0.00229547 0.167036 0 -0.00165625 0.174615 0
+          -0.00117363 0.179268 0 -0.000812576 0.182436 0 -0.000485106 0.184725 0 -0.000313582 0.185975 0
+          0.00473442 0.00461482 0 0.00213611 0.0253989 0 -0.000458465 0.0567059 0 -0.00138456 0.0816372 0
+          -0.00140857 0.0972413 0 -0.00113674 0.106668 0 -0.0008364 0.112725 0 -0.000576788 0.116918 0
+          -0.000330942 0.119943 0 -0.000202592 0.121697 0 0.00549323 -0.000607049 0 0.00387159 0.00398047 0
+          0.00190568 0.0172948 0 0.000616606 0.0332387 0 -5.88144e-05 0.0471196 0 -0.000272737 0.0574962 0
+          -0.000257789 0.0648694 0 -0.000167549 0.0701184 0 -5.8023e-05 0.0738856 0 -1.2845e-07 0.0761182 0
+          0.00539835 -0.00105999 0 0.00437558 -0.00132392 0 0.00320166 0.00172445 0 0.00234645 0.00748499 0
+          0.00162598 0.0148627 0 0.00108371 0.0222623 0 0.000742615 0.0286803 0 0.000551114 0.0337812 0
+          0.000419609 0.0375955 0 0.00035598 0.039901 0 0.00518408 -0.000844647 0 0.00435925 -0.001573 0
+          0.00344844 -0.0010045 0 0.00291759 0.000842525 0 0.00252922 0.00458593 0 0.00214723 0.00968373 0
+          0.0017596 0.0149959 0 0.00139383 0.0196383 0 0.00101377 0.0232446 0 0.000807436 0.0254541 0
         </DataArray>
         <DataArray type="Float32" Name="dv_y/dx_" NumberOfComponents="3" format="ascii">
-          7.0994e-08 0.179216 0 -1.81109e-05 0.00104886 0 -4.38795e-08 0.000382131 0 -1.36478e-08 0.00018595 0
-          -5.68696e-09 0.000111535 0 -3.09095e-09 7.30941e-05 0 -1.9145e-09 5.01659e-05 0 -1.35726e-09 3.50748e-05 0
-          -1.75887e-09 2.32191e-05 0 -2.32296e-09 2.30243e-07 0 4.74147e-07 0.1737 0 -6.06326e-05 0.00213639 0
-          -2.92565e-07 0.00078081 0 -9.17439e-08 0.000380852 0 -3.82631e-08 0.000228714 0 -2.08069e-08 0.000149987 0
-          -1.28902e-08 0.000102992 0 -9.13616e-09 7.20491e-05 0 -1.18139e-08 4.77752e-05 0 -1.55885e-08 7.67119e-07 0
-          1.70713e-06 0.1647 0 -0.000117432 0.00388756 0 -1.05223e-06 0.00141835 0 -3.30761e-07 0.000695477 0
-          -1.38292e-07 0.00041867 0 -7.53031e-08 0.000274924 0 -4.66806e-08 0.00018897 0 -3.3073e-08 0.000132323 0
-          -4.27018e-08 8.80159e-05 0 -5.6324e-08 2.07197e-06 0 4.6423e-06 0.153218 0 -0.000191932 0.0060779 0
-          -2.85943e-06 0.00219321 0 -8.95622e-07 0.00108567 0 -3.76444e-07 0.00065597 0 -2.05516e-07 0.000431656 0
-          -1.2756e-07 0.000297155 0 -9.03167e-08 0.000208377 0 -1.16553e-07 0.00013929 0 -1.53809e-07 4.50529e-06 0
-          1.08304e-05 0.139325 0 -0.000287454 0.00867047 0 -6.67241e-06 0.00306062 0 -2.06136e-06 0.00153666 0
-          -8.74569e-07 0.000932463 0 -4.79252e-07 0.000615266 0 -2.98045e-07 0.000424383 0 -2.10795e-07 0.000298125 0
-          -2.72218e-07 0.000200614 0 -3.59802e-07 8.60851e-06 0 2.2863e-05 0.123453 0 -0.0004067 0.0115372 0
-          -1.4103e-05 0.00396301 0 -4.24981e-06 0.00202529 0 -1.82865e-06 0.00123402 0 -1.0063e-06 0.000816693 0
-          -6.27406e-07 0.000564534 0 -4.42999e-07 0.000397343 0 -5.72861e-07 0.000269447 0 -7.59049e-07 1.51943e-05 0
-          4.47735e-05 0.106283 0 -0.000551113 0.0144485 0 -2.76609e-05 0.00485935 0 -8.08299e-06 0.00252954 0
-          -3.54139e-06 0.00154686 0 -1.9565e-06 0.00102685 0 -1.22336e-06 0.000711338 0 -8.61917e-07 0.000501625 0
-          -1.11545e-06 0.00034281 0 -1.48184e-06 2.54394e-05 0 8.23748e-05 0.0885769 0 -0.000720013 0.0170959 0
-          -5.09227e-05 0.00573436 0 -1.44826e-05 0.00303241 0 -6.4707e-06 0.00186117 0 -3.58735e-06 0.00123913 0
-          -2.2499e-06 0.000860202 0 -1.58144e-06 0.000607722 0 -2.04387e-06 0.000418194 0 -2.71986e-06 4.07666e-05 0
-          0.000143356 0.0710504 0 -0.000909392 0.0191327 0 -8.84831e-05 0.00658147 0 -2.48338e-05 0.00351977 0
-          -1.1297e-05 0.00217011 0 -6.2855e-06 0.001449 0 -3.95407e-06 0.00100801 0 -2.77352e-06 0.000713447 0
-          -3.56743e-06 0.000493669 0 -4.74645e-06 6.25271e-05 0 0.000236833 0.0543329 0 -0.00111036 0.0202209 0
-          -0.000145455 0.00737415 0 -4.11922e-05 0.00397632 0 -1.90087e-05 0.00246651 0 -1.06236e-05 0.00165209 0
-          -6.7035e-06 0.00115184 0 -4.69563e-06 0.000816784 0 -5.98503e-06 0.000567456 0 -7.94078e-06 9.16023e-05 0
-          0.000371896 0.0389699 0 -0.00130744 0.0200812 0 -0.000226183 0.00803998 0 -6.64341e-05 0.00438063 0
-          -3.09987e-05 0.00273925 0 -1.74296e-05 0.00184201 0 -1.10347e-05 0.00128753 0 -7.72711e-06 0.000914853 0
-          -9.71454e-06 0.000637335 0 -1.28137e-05 0.000127972 0 0.000554579 0.025433 0 -0.00147741 0.0185482 0
-          -0.000331778 0.00844581 0 -0.000104098 0.00469716 0 -4.91352e-05 0.00296952 0 -2.78515e-05 0.00200803 0
-          -1.77064e-05 0.00140813 0 -1.24117e-05 0.0010028 0 -1.53232e-05 0.000699911 0 -2.00303e-05 0.000170225 0
-          0.000782782 0.0141154 0 -0.00158967 0.0156295 0 -0.000456307 0.00840183 0 -0.000157418 0.00486457 0
-          -7.56766e-05 0.00312619 0 -4.33708e-05 0.00213194 0 -2.77358e-05 0.00150182 0 -1.94937e-05 0.00107235 0
-          -2.35471e-05 0.000749564 0 -3.04144e-05 0.000214974 0 0.0010393 0.00530577 0 -0.00161031 0.0115601 0
-          -0.00058217 0.00769414 0 -0.000226809 0.00478341 0 -0.000112696 0.00315914 0 -6.56342e-05 0.00218376 0
-          -4.23523e-05 0.00154892 0 -2.99091e-05 0.0011097 0 -3.52657e-05 0.000776849 0 -4.48993e-05 0.000256129 0
-          0.00128471 -0.000865082 0 -0.0015119 0.00683905 0 -0.000676984 0.00615574 0 -0.000305096 0.00431316 0
-          -0.000160331 0.00299101 0 -9.58057e-05 0.00211607 0 -6.27112e-05 0.00151788 0 -4.46354e-05 0.00109263 0
-          -5.13428e-05 0.000766256 0 -6.43277e-05 0.000283984 0 0.00145502 -0.00450391 0 -0.00129023 0.00222084 0
-          -0.000697324 0.00378394 0 -0.000371087 0.00329707 0 -0.00021286 0.00251238 0 -0.000132793 0.00185629 0
-          -8.90106e-05 0.00135832 0 -6.41753e-05 0.000985224 0 -7.21313e-05 0.00069248 0 -8.88723e-05 0.00028378 0
-          0.0014737 -0.00604213 0 -0.000982926 -0.00139606 0 -0.000608294 0.000912092 0 -0.000386254 0.00163296 0
-          -0.00025229 0.00159119 0 -0.000169464 0.00130918 0 -0.000118307 0.00100212 0 -8.71328e-05 0.000737506 0
-          -9.61126e-05 0.000519352 0 -0.000116498 0.000235246 0 0.00128869 -0.00625482 0 -0.000668838 -0.00340561 0
-          -0.000426665 -0.0015929 0 -0.000310406 -0.000449328 0 -0.000241792 0.000118966 0 -0.00018543 0.000314554 0
-          -0.000140093 0.000322692 0 -0.000107313 0.00026143 0 -0.000117011 0.000187582 0 -0.000139645 0.00010891 0
-          0.000905657 -0.00596603 0 -0.000399732 -0.00408534 0 -0.00023847 -0.00293931 0 -0.000172103 -0.00209783 0
-          -0.00015673 -0.00144854 0 -0.000143978 -0.000989469 0 -0.000124953 -0.000684925 0 -0.000104035 -0.000482947 0
-          -0.000115193 -0.000336412 0 -0.000136182 -0.000114303 0 0.000334703 -0.00581363 0 -0.000138749 -0.0041915 0
-          -7.85792e-05 -0.00325905 0 -4.93165e-05 -0.00262644 0 -4.76778e-05 -0.00205718 0 -5.16941e-05 -0.001559 0
-          -5.1382e-05 -0.00115388 0 -4.62756e-05 -0.000838874 0 -5.2448e-05 -0.00058852 0 -6.18466e-05 -0.000224712 0
+          7.09941e-08 0.179216 0 -1.81109e-05 0.00104886 0 -4.38795e-08 0.000382133 0 -1.36478e-08 0.000185953 0
+          -5.68699e-09 0.000111538 0 -3.09099e-09 7.30962e-05 0 -1.91454e-09 5.01676e-05 0 -1.35731e-09 3.50762e-05 0
+          -1.75891e-09 2.322e-05 0 -2.32301e-09 2.30628e-07 0 4.74148e-07 0.1737 0 -6.06326e-05 0.00213639 0
+          -2.92565e-07 0.000780815 0 -9.17439e-08 0.000380858 0 -3.82633e-08 0.000228719 0 -2.08071e-08 0.000149991 0
+          -1.28905e-08 0.000102996 0 -9.13643e-09 7.20518e-05 0 -1.18142e-08 4.7777e-05 0 -1.55888e-08 7.67943e-07 0
+          1.70713e-06 0.1647 0 -0.000117432 0.00388757 0 -1.05223e-06 0.00141836 0 -3.30761e-07 0.000695488 0
+          -1.38292e-07 0.00041868 0 -7.5304e-08 0.000274932 0 -4.66815e-08 0.000188977 0 -3.3074e-08 0.000132329 0
+          -4.2703e-08 8.80194e-05 0 -5.63252e-08 2.07353e-06 0 4.64231e-06 0.153218 0 -0.000191932 0.00607791 0
+          -2.85942e-06 0.00219323 0 -8.95622e-07 0.00108569 0 -3.76446e-07 0.000655986 0 -2.05519e-07 0.00043167 0
+          -1.27562e-07 0.000297167 0 -9.03196e-08 0.000208386 0 -1.16557e-07 0.000139296 0 -1.53813e-07 4.50788e-06 0
+          1.08304e-05 0.139325 0 -0.000287454 0.0086705 0 -6.67241e-06 0.00306065 0 -2.06136e-06 0.00153669 0
+          -8.74573e-07 0.00093249 0 -4.79258e-07 0.000615289 0 -2.98052e-07 0.000424402 0 -2.10802e-07 0.00029814 0
+          -2.72227e-07 0.000200624 0 -3.59811e-07 8.61258e-06 0 2.28631e-05 0.123453 0 -0.000406699 0.0115373 0
+          -1.4103e-05 0.00396305 0 -4.24981e-06 0.00202534 0 -1.82866e-06 0.00123406 0 -1.00632e-06 0.000816731 0
+          -6.27422e-07 0.000564565 0 -4.43016e-07 0.000397368 0 -5.72881e-07 0.000269463 0 -7.59071e-07 1.52009e-05 0
+          4.47737e-05 0.106283 0 -0.000551113 0.0144486 0 -2.76609e-05 0.00485942 0 -8.083e-06 0.00252961 0
+          -3.54141e-06 0.00154693 0 -1.95653e-06 0.00102691 0 -1.22339e-06 0.00071139 0 -8.61957e-07 0.000501667 0
+          -1.11549e-06 0.000342838 0 -1.48189e-06 2.54507e-05 0 8.23751e-05 0.0885768 0 -0.000720013 0.017096 0
+          -5.09227e-05 0.00573448 0 -1.44826e-05 0.00303253 0 -6.47075e-06 0.00186128 0 -3.58743e-06 0.00123922 0
+          -2.24997e-06 0.000860285 0 -1.58153e-06 0.00060779 0 -2.04399e-06 0.00041824 0 -2.71999e-06 4.07854e-05 0
+          0.000143357 0.0710504 0 -0.000909391 0.0191329 0 -8.8483e-05 0.00658164 0 -2.48339e-05 0.00351994 0
+          -1.12971e-05 0.00217026 0 -6.28565e-06 0.00144913 0 -3.95423e-06 0.00100812 0 -2.77372e-06 0.000713542 0
+          -3.56769e-06 0.000493735 0 -4.74674e-06 6.2554e-05 0 0.000236835 0.054333 0 -0.00111035 0.0202211 0
+          -0.000145455 0.00737437 0 -4.11924e-05 0.00397652 0 -1.90089e-05 0.00246668 0 -1.06239e-05 0.00165223 0
+          -6.7038e-06 0.00115196 0 -4.69602e-06 0.000816889 0 -5.98556e-06 0.000567528 0 -7.94137e-06 9.16314e-05 0
+          0.0003719 0.0389701 0 -0.00130744 0.0200814 0 -0.000226183 0.00804021 0 -6.64347e-05 0.00438082 0
+          -3.09993e-05 0.0027394 0 -1.74301e-05 0.00184213 0 -1.10352e-05 0.00128763 0 -7.72776e-06 0.00091493 0
+          -9.71544e-06 0.000637385 0 -1.28148e-05 0.000127991 0 0.000554584 0.0254331 0 -0.00147741 0.0185484 0
+          -0.000331779 0.00844597 0 -0.000104099 0.00469729 0 -4.91363e-05 0.00296961 0 -2.78525e-05 0.00200808 0
+          -1.77072e-05 0.00140816 0 -1.24127e-05 0.00100281 0 -1.53244e-05 0.00069991 0 -2.00317e-05 0.000170219 0
+          0.000782789 0.0141155 0 -0.00158967 0.0156296 0 -0.000456308 0.0084019 0 -0.00015742 0.0048646 0
+          -7.56785e-05 0.00312619 0 -4.33723e-05 0.00213191 0 -2.77369e-05 0.00150178 0 -1.94948e-05 0.00107229 0
+          -2.35483e-05 0.000749505 0 -3.04156e-05 0.00021494 0 0.00103931 0.00530576 0 -0.00161031 0.0115601 0
+          -0.000582172 0.00769411 0 -0.000226811 0.00478337 0 -0.000112699 0.00315908 0 -6.56363e-05 0.00218369 0
+          -4.23538e-05 0.00154883 0 -2.99104e-05 0.00110961 0 -3.52664e-05 0.000776756 0 -4.48996e-05 0.000256077 0
+          0.00128471 -0.0008651 0 -0.0015119 0.006839 0 -0.000676986 0.00615568 0 -0.000305099 0.0043131 0
+          -0.000160334 0.00299094 0 -9.58082e-05 0.002116 0 -6.27131e-05 0.0015178 0 -4.46367e-05 0.00109254 0
+          -5.13426e-05 0.000766173 0 -6.43262e-05 0.000283937 0 0.00145502 -0.00450392 0 -0.00129023 0.00222081 0
+          -0.000697326 0.0037839 0 -0.00037109 0.00329702 0 -0.000212863 0.00251233 0 -0.000132796 0.00185624 0
+          -8.90127e-05 0.00135828 0 -6.41766e-05 0.000985182 0 -7.21302e-05 0.000692441 0 -8.88693e-05 0.000283756 0
+          0.00147371 -0.00604214 0 -0.000982926 -0.00139608 0 -0.000608296 0.000912078 0 -0.000386257 0.00163295 0
+          -0.000252292 0.00159118 0 -0.000169466 0.00130917 0 -0.000118309 0.00100212 0 -8.7134e-05 0.000737507 0
+          -9.61113e-05 0.000519356 0 -0.000116495 0.000235246 0 0.00128869 -0.00625483 0 -0.000668838 -0.00340562 0
+          -0.000426667 -0.00159291 0 -0.000310408 -0.000449327 0 -0.000241794 0.000118972 0 -0.000185432 0.000314565 0
+          -0.000140094 0.000322707 0 -0.000107314 0.000261449 0 -0.00011701 0.000187603 0 -0.000139643 0.000108922 0
+          0.000905659 -0.00596604 0 -0.000399731 -0.00408535 0 -0.000238472 -0.00293932 0 -0.000172105 -0.00209783 0
+          -0.000156732 -0.00144853 0 -0.000143979 -0.00098946 0 -0.000124953 -0.000684912 0 -0.000104035 -0.00048293 0
+          -0.000115192 -0.000336394 0 -0.000136181 -0.000114291 0 0.000334704 -0.00581364 0 -0.000138749 -0.00419151 0
+          -7.85797e-05 -0.00325906 0 -4.93171e-05 -0.00262644 0 -4.76783e-05 -0.00205718 0 -5.16945e-05 -0.001559 0
+          -5.13823e-05 -0.00115387 0 -4.62758e-05 -0.000838861 0 -5.24478e-05 -0.000588506 0 -6.18462e-05 -0.000224702 0
         </DataArray>
         <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii">
           0.050691 2.17562e-05 0 0.00122197 6.38945e-08 0 0.00100411 2.31158e-08 0 0.000918076 1.12391e-08 0
-- 
GitLab