diff --git a/doc/doxygen/modules.txt b/doc/doxygen/modules.txt
index d951836a865386f31f83389845fceaf3c6e049e6..475280dc7e6e65ccac1e1523a08f27c5e3f3f5aa 100644
--- a/doc/doxygen/modules.txt
+++ b/doc/doxygen/modules.txt
@@ -206,35 +206,14 @@
      * \ingroup FreeflowModels
      * \defgroup FreeflowNCModel Compositional
      * \brief Single-phase multi-component free-flow flow models
+     * \copydetails ./freeflow/compositional/navierstokesncmodel.hh
      */
-      /*!
-       * \ingroup FreeflowNCModel
-       * \defgroup NavierStokesNCModel Compositional Navier-Stokes
-       * \brief Single-phase multi-component Navier-Stokes flow
-       * \copydetails ./freeflow/compositional/navierstokesncmodel.hh
-       */
-      /*!
-       * \ingroup FreeflowNCModel
-       * \defgroup RANSNCModel Compositional Reynolds-Averaged Navier-Stokes
-       * \brief Single-phase multi-component Reynolds-Averaged Navier-Stokes flow
-       * \copydetails ./freeflow/ransnc/model.hh
-       */
     /*!
      * \ingroup FreeflowModels
      * \defgroup FreeflowNIModel Nonisothermal
      * \brief An energy equation adaptor for isothermal free-flow models
      * \copydetails ./freeflow/nonisothermal/model.hh
      */
-      /*!
-       * \ingroup FreeflowNIModel
-       * \defgroup NavierStokesNIModel Nonisothermal Navier-Stokes
-       * \brief An energy equation adaptor for isothermal Navier-Stokes models
-       */
-      /*!
-       * \ingroup FreeflowNIModel
-       * \defgroup RANSNIModel Nonisothermal Reynolds-Averaged Navier-Stokes
-       * \brief An energy equation adaptor for isothermal Reynolds-Averaged Navier-Stokes models
-       */
 
 /* ***************** Benchmarks and Tests ******************/
 /*!
diff --git a/dumux/freeflow/compositional/CMakeLists.txt b/dumux/freeflow/compositional/CMakeLists.txt
index ca470a2136cc6a0a6fc1582bc4860fee6e671b4a..4be489a57036df61daf21c27e23f3ae3148166d4 100644
--- a/dumux/freeflow/compositional/CMakeLists.txt
+++ b/dumux/freeflow/compositional/CMakeLists.txt
@@ -6,6 +6,8 @@ fluxvariables.hh
 indices.hh
 localresidual.hh
 navierstokesncmodel.hh
+lowrekepsilonncmodel.hh
 volumevariables.hh
 vtkoutputfields.hh
+zeroeqncmodel.hh
 DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/compositional)
diff --git a/dumux/freeflow/compositional/fluxvariables.hh b/dumux/freeflow/compositional/fluxvariables.hh
index 89ea6aa83005e180ef63bf294c101e5c0b6b4e56..beed3d387bc23b5d3f6f966bce739229f67a526c 100644
--- a/dumux/freeflow/compositional/fluxvariables.hh
+++ b/dumux/freeflow/compositional/fluxvariables.hh
@@ -32,7 +32,7 @@ namespace Dumux
 
 
 // forward declaration
-template<class TypeTag, DiscretizationMethod discMethod>
+template<class TypeTag, class BaseFluxVariables, DiscretizationMethod discMethod>
 class FreeflowNCFluxVariablesImpl;
 
 /*!
@@ -42,8 +42,8 @@ class FreeflowNCFluxVariablesImpl;
           discretization-specific flux variables.
  * \note  Not all specializations are currently implemented
  */
-template<class TypeTag>
-using FreeflowNCFluxVariables = FreeflowNCFluxVariablesImpl<TypeTag, GET_PROP_TYPE(TypeTag, FVGridGeometry)::discMethod>;
+template<class TypeTag, class BaseFluxVariables>
+using FreeflowNCFluxVariables = FreeflowNCFluxVariablesImpl<TypeTag, BaseFluxVariables, GET_PROP_TYPE(TypeTag, FVGridGeometry)::discMethod>;
 
 
 } // end namespace
diff --git a/dumux/freeflow/compositional/indices.hh b/dumux/freeflow/compositional/indices.hh
index 1e1feda47ecf4d81ab671d732ade0e288405d3e1..80a27a302feb94e77994bbd7cdc67b3064828a94 100644
--- a/dumux/freeflow/compositional/indices.hh
+++ b/dumux/freeflow/compositional/indices.hh
@@ -33,8 +33,9 @@ namespace Dumux {
  * \brief The common indices for the isothermal multi-component free-flow model.
  */
 template <int dimension, int numEquations,
-          int phaseIdx, int theReplaceCompEqIdx>
-struct FreeflowNCIndices : public NavierStokesIndices<dimension>
+          int phaseIdx, int theReplaceCompEqIdx,
+          class FreeflowIndices>
+struct FreeflowNCIndices : public FreeflowIndices
 {
 public:
     //! The index of the fluid phase in the fluid system
diff --git a/dumux/freeflow/compositional/localresidual.hh b/dumux/freeflow/compositional/localresidual.hh
index 2ec40d73e4d988671b737851b1aa5555c7ff616f..edae25e919af21f2a08e06cbed443186c0d4bd13 100644
--- a/dumux/freeflow/compositional/localresidual.hh
+++ b/dumux/freeflow/compositional/localresidual.hh
@@ -33,7 +33,7 @@ namespace Dumux
 {
 
 // forward declaration
-template<class TypeTag, DiscretizationMethod discMethod>
+template<class TypeTag, class BaseLocalResidual, DiscretizationMethod discMethod>
 class FreeflowNCResidualImpl;
 
 /*!
@@ -43,8 +43,8 @@ class FreeflowNCResidualImpl;
           discretization-specific local residual.
  * \note  Not all specializations are currently implemented
  */
-template<class TypeTag>
-using FreeflowNCResidual = FreeflowNCResidualImpl<TypeTag, GET_PROP_TYPE(TypeTag, FVGridGeometry)::discMethod>;
+template<class TypeTag, class BaseLocalResidual>
+using FreeflowNCResidual = FreeflowNCResidualImpl<TypeTag, BaseLocalResidual, GET_PROP_TYPE(TypeTag, FVGridGeometry)::discMethod>;
 
 }
 
diff --git a/dumux/freeflow/compositional/lowrekepsilonncmodel.hh b/dumux/freeflow/compositional/lowrekepsilonncmodel.hh
new file mode 100644
index 0000000000000000000000000000000000000000..25e7c6a2149cae9c5e97d395ca3253bd9284bc0c
--- /dev/null
+++ b/dumux/freeflow/compositional/lowrekepsilonncmodel.hh
@@ -0,0 +1,213 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ * \ingroup FreeflowNCModel
+ *
+ * \brief A single-phase, multi-component Reynolds-Averaged Navier-Stokes 0-Eq. model
+ *
+ * \copydoc Dumux::FreeflowNCModel
+ */
+
+#ifndef DUMUX_LOWREKEPSILON_NC_MODEL_HH
+#define DUMUX_LOWREKEPSILON_NC_MODEL_HH
+
+#include <dumux/common/properties.hh>
+#include <dumux/freeflow/compositional/navierstokesncmodel.hh>
+#include <dumux/freeflow/nonisothermal/vtkoutputfields.hh>
+#include <dumux/freeflow/rans/twoeq/lowrekepsilon/model.hh>
+
+#include "vtkoutputfields.hh"
+
+#include <dumux/freeflow/ransnc/volumevariables.hh>
+
+namespace Dumux {
+
+///////////////////////////////////////////////////////////////////////////
+// properties for the single-phase, multi-component low-Re k-epsilon model
+///////////////////////////////////////////////////////////////////////////
+namespace Properties {
+
+//////////////////////////////////////////////////////////////////
+// Type tags
+//////////////////////////////////////////////////////////////////
+
+//! The type tags for the single-phase, multi-component isothermal low-Re k-epsilon model
+NEW_TYPE_TAG(LowReKEpsilonNC, INHERITS_FROM(NavierStokesNC));
+
+///////////////////////////////////////////////////////////////////////////
+// default property values
+///////////////////////////////////////////////////////////////////////////
+
+/*!
+ * \ingroup FreeflowNCModel
+ * \brief Traits for the low-Reynolds k-epsilon multi-component model
+ */
+template<int dimension, int nComp, int phaseIdx, int replaceCompEqIdx, bool useMoles>
+struct LowReKEpsilonNCModelTraits : NavierStokesNCModelTraits<dimension, nComp, phaseIdx, replaceCompEqIdx, useMoles>
+{
+    //! There are as many momentum balance equations as dimensions
+    //! and as many balance equations as components.
+    static constexpr int numEq() { return dimension+nComp+2; }
+
+    //! The model does include a turbulence model
+    static constexpr bool usesTurbulenceModel() { return true; }
+
+    //! the indices
+    using Indices = FreeflowNCIndices<dimension, numEq(), phaseIdx, replaceCompEqIdx, LowReKEpsilonIndices<dimension, nComp>>;
+};
+
+//!< states some specifics of the isothermal multi-component low-Reynolds k-epsilon model
+SET_PROP(LowReKEpsilonNC, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dimension = GridView::dimension;
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    static constexpr int numComponents = FluidSystem::numComponents;
+    static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    static constexpr int replaceCompEqIdx = GET_PROP_VALUE(TypeTag, ReplaceCompEqIdx);
+    static constexpr bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles);
+public:
+    using type = LowReKEpsilonNCModelTraits<dimension, numComponents, phaseIdx, replaceCompEqIdx, useMoles>;
+};
+
+//! Set the volume variables property
+SET_PROP(LowReKEpsilonNC, VolumeVariables)
+{
+private:
+    using PV = typename GET_PROP_TYPE(TypeTag, PrimaryVariables);
+    using FSY = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    using FST = typename GET_PROP_TYPE(TypeTag, FluidState);
+    using MT = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+
+    using Traits = NavierStokesVolumeVariablesTraits<PV, FSY, FST, MT>;
+    using NCVolVars = FreeflowNCVolumeVariables<Traits>;
+    using RANSVolVars = LowReKEpsilonVolumeVariables<Traits, NCVolVars>;
+public:
+    using type = RANSNCVolumeVariables<Traits, RANSVolVars>;
+};
+
+//! The local residual
+SET_PROP(LowReKEpsilonNC, LocalResidual)
+{
+private:
+    using BaseLocalResidual = LowReKEpsilonResidual<TypeTag>;
+public:
+    using type = FreeflowNCResidual<TypeTag, BaseLocalResidual>;
+};
+
+//! The flux variables
+SET_PROP(LowReKEpsilonNC, FluxVariables)
+{
+private:
+    using BaseFluxVariables = LowReKEpsilonFluxVariables<TypeTag>;
+public:
+    using type = FreeflowNCFluxVariables<TypeTag, BaseFluxVariables>;
+};
+
+//! The specific vtk output fields
+SET_PROP(LowReKEpsilonNC, VtkOutputFields)
+{
+private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    using SinglePhaseVtkOutputFields = LowReKEpsilonVtkOutputFields<FVGridGeometry>;
+public:
+    using type = FreeflowNCVtkOutputFields<SinglePhaseVtkOutputFields, ModelTraits, FVGridGeometry, FluidSystem, phaseIdx>;
+};
+
+//////////////////////////////////////////////////////////////////////////
+// Property values for non-isothermal multi-component low-Re k-epsilon model
+//////////////////////////////////////////////////////////////////////////
+
+//! The type tags for the single-phase, multi-component non-isothermal low-Re k-epsilon models
+NEW_TYPE_TAG(LowReKEpsilonNCNI, INHERITS_FROM(NavierStokesNCNI));
+
+//! The model traits of the non-isothermal model
+SET_PROP(LowReKEpsilonNCNI, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    static constexpr int numComponents = FluidSystem::numComponents;
+    static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    static constexpr int replaceCompEqIdx = GET_PROP_VALUE(TypeTag, ReplaceCompEqIdx);
+    static constexpr bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles);
+    using IsothermalModelTraits = LowReKEpsilonNCModelTraits<dim, numComponents, phaseIdx, replaceCompEqIdx, useMoles>;
+public:
+    using type = FreeflowNIModelTraits<IsothermalModelTraits>;
+};
+
+//! Set the volume variables property
+SET_PROP(LowReKEpsilonNCNI, VolumeVariables)
+{
+private:
+    using PV = typename GET_PROP_TYPE(TypeTag, PrimaryVariables);
+    using FSY = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    using FST = typename GET_PROP_TYPE(TypeTag, FluidState);
+    using MT = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+
+    using Traits = NavierStokesVolumeVariablesTraits<PV, FSY, FST, MT>;
+    using NCVolVars = FreeflowNCVolumeVariables<Traits>;
+    using RANSVolVars = LowReKEpsilonVolumeVariables<Traits, NCVolVars>;
+public:
+    using type = RANSNCVolumeVariables<Traits, RANSVolVars>;
+};
+
+//! The local residual
+SET_PROP(LowReKEpsilonNCNI, LocalResidual)
+{
+private:
+    using BaseLocalResidual = LowReKEpsilonResidual<TypeTag>;
+public:
+    using type = FreeflowNCResidual<TypeTag, BaseLocalResidual>;
+};
+
+//! The flux variables
+SET_PROP(LowReKEpsilonNCNI, FluxVariables)
+{
+private:
+    using BaseFluxVariables = LowReKEpsilonFluxVariables<TypeTag>;
+public:
+    using type = FreeflowNCFluxVariables<TypeTag, BaseFluxVariables>;
+};
+
+//! The specific vtk output fields
+SET_PROP(LowReKEpsilonNCNI, VtkOutputFields)
+{
+private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    using BaseVtkOutputFields = LowReKEpsilonVtkOutputFields<FVGridGeometry>;
+    using NonIsothermalFields = FreeflowNonIsothermalVtkOutputFields<BaseVtkOutputFields, ModelTraits>;
+public:
+    using type = FreeflowNCVtkOutputFields<NonIsothermalFields, ModelTraits, FVGridGeometry, FluidSystem, phaseIdx>;
+};
+
+// \}
+} // end namespace Properties
+} // end namespace Dumux
+
+#endif
diff --git a/dumux/freeflow/compositional/navierstokesncmodel.hh b/dumux/freeflow/compositional/navierstokesncmodel.hh
index cc5a30b6f40b628071f39291439ff8a667a01f7c..3603c0cd7a3cc8f5c70e3fbe01864ccc1231110d 100644
--- a/dumux/freeflow/compositional/navierstokesncmodel.hh
+++ b/dumux/freeflow/compositional/navierstokesncmodel.hh
@@ -26,21 +26,24 @@
  * \f[
  *    \frac{\partial \left(\varrho X^\kappa\right)}{\partial t}
  *    + \nabla \cdot \left( \varrho {\boldsymbol{v}} X^\kappa
- *    - D^\kappa \varrho \frac{M^\kappa}{M} \textbf{grad}\, x^\kappa \right)
+ *    - (D^\kappa + D_\text{t}) \varrho \frac{M^\kappa}{M} \textbf{grad}\, x^\kappa \right)
  *    - q^\kappa = 0
  * \f]
  *
  * Alternatively, one component balance equation can be replace by a <B> total mass/mole balance equation </B>:
- *
  * \f[
  *    \frac{\partial \varrho_g}{\partial t}
  *    + \nabla \cdot \left(
  *        \varrho {\boldsymbol{v}}
- *        - \sum_\kappa D^\kappa \varrho \frac{M^\kappa}{M} \textbf{grad}\, x^\kappa
+ *        - \sum_\kappa (D^\kappa + D_\text{t}) \varrho \frac{M^\kappa}{M} \textbf{grad}\, x^\kappa
  *      \right)
  *    - q = 0
  * \f]
  *
+ * The eddy diffusivity \f$ D_\text{t} \f$ is related to the eddy viscosity \f$ \nu_\text{t} \f$
+ * by the turbulent Schmidt number, for Navier-Stokes models \f$ D_\text{t} = 0 \f$.
+ * \f[ D_\text{t} = \frac{\nu_\text{t}}{\mathrm{Sc}_\text{t}} \f]
+ *
  * So far, only the staggered grid spatial discretization (for structured grids) is available.
  */
 
@@ -52,7 +55,7 @@
 #include <dumux/freeflow/navierstokes/model.hh>
 #include <dumux/freeflow/nonisothermal/model.hh>
 #include <dumux/freeflow/nonisothermal/indices.hh>
-#include <dumux/freeflow/nonisothermal/navierstokesnivtkoutputfields.hh>
+#include <dumux/freeflow/nonisothermal/vtkoutputfields.hh>
 #include <dumux/discretization/fickslaw.hh>
 #include <dumux/discretization/fourierslaw.hh>
 
@@ -75,35 +78,23 @@ namespace Dumux {
  * \brief Traits for the multi-component free-flow model
  */
 template<int dimension, int nComp, int phaseIdx, int replaceCompEqIdx, bool useM>
-struct NavierStokesNCModelTraits
+struct NavierStokesNCModelTraits : NavierStokesModelTraits<dimension>
 {
-    //! The dimension of the model
-    static constexpr int dim() { return dimension; }
-
     //! There are as many momentum balance equations as dimensions
     //! and as many balance equations as components.
     static constexpr int numEq() { return dimension+nComp; }
 
-    //! The number of phases is always 1
-    static constexpr int numPhases() { return 1; }
-
     //! The number of components
     static constexpr int numComponents() { return nComp; }
 
     //! Use moles or not
     static constexpr bool useMoles() { return useM; }
 
-    //! Enable advection
-    static constexpr bool enableAdvection() { return true; }
-
     //! The one-phase model has no molecular diffusion
     static constexpr bool enableMolecularDiffusion() { return true; }
 
-    //! The model is isothermal
-    static constexpr bool enableEnergyBalance() { return false; }
-
     //! the indices
-    using Indices = FreeflowNCIndices<dim(), numEq(), phaseIdx, replaceCompEqIdx>;
+    using Indices = FreeflowNCIndices<dimension, numEq(), phaseIdx, replaceCompEqIdx, NavierStokesIndices<dimension>>;
 };
 
 ///////////////////////////////////////////////////////////////////////////
@@ -146,9 +137,14 @@ SET_INT_PROP(NavierStokesNC, ReplaceCompEqIdx, 0); //<! Set the ReplaceCompEqIdx
 SET_BOOL_PROP(NavierStokesNC, EnableInertiaTerms, true); //!< Consider inertia terms by default
 SET_BOOL_PROP(NavierStokesNC, NormalizePressure, true); //!< Normalize the pressure term in the momentum balance by default
 
-
 //! The local residual
-SET_TYPE_PROP(NavierStokesNC, LocalResidual, FreeflowNCResidual<TypeTag>);
+SET_PROP(NavierStokesNC, LocalResidual)
+{
+private:
+    using BaseLocalResidual = NavierStokesResidual<TypeTag>;
+public:
+    using type = FreeflowNCResidual<TypeTag, BaseLocalResidual>;
+};
 
 //! Set the volume variables property
 SET_PROP(NavierStokesNC, VolumeVariables)
@@ -164,9 +160,14 @@ public:
     using type = FreeflowNCVolumeVariables<Traits>;
 };
 
-
 //! The flux variables
-SET_TYPE_PROP(NavierStokesNC, FluxVariables, FreeflowNCFluxVariables<TypeTag>);
+SET_PROP(NavierStokesNC, FluxVariables)
+{
+private:
+    using BaseFluxVariables = NavierStokesFluxVariables<TypeTag>;
+public:
+    using type = FreeflowNCFluxVariables<TypeTag, BaseFluxVariables>;
+};
 
 //! The flux variables cache class, by default the one for free flow
 SET_TYPE_PROP(NavierStokesNC, FluxVariablesCache, FreeFlowFluxVariablesCache<TypeTag>);
@@ -175,11 +176,13 @@ SET_TYPE_PROP(NavierStokesNC, FluxVariablesCache, FreeFlowFluxVariablesCache<Typ
 SET_PROP(NavierStokesNC, VtkOutputFields)
 {
 private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
     using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
     static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    using BaseVtkOutputFields = NavierStokesVtkOutputFields<FVGridGeometry>;
 public:
-     using type = FreeflowNCVtkOutputFields<FVGridGeometry, FluidSystem, phaseIdx>;
+    using type = FreeflowNCVtkOutputFields<BaseVtkOutputFields, ModelTraits, FVGridGeometry, FluidSystem, phaseIdx>;
 };
 
 /*!
@@ -224,12 +227,14 @@ public:
 SET_PROP(NavierStokesNCNI, VtkOutputFields)
 {
 private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
     using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
     static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
-    using IsothermalFields = FreeflowNCVtkOutputFields<FVGridGeometry, FluidSystem, phaseIdx>;
+    using BaseVtkOutputFields = NavierStokesVtkOutputFields<FVGridGeometry>;
+    using NonIsothermalFields = FreeflowNonIsothermalVtkOutputFields<BaseVtkOutputFields, ModelTraits>;
 public:
-     using type = NavierStokesNonIsothermalVtkOutputFields<IsothermalFields>;
+    using type = FreeflowNCVtkOutputFields<NonIsothermalFields, ModelTraits, FVGridGeometry, FluidSystem, phaseIdx>;
 };
 
 //! Use Fourier's Law as default heat conduction type
diff --git a/dumux/freeflow/compositional/staggered/fluxvariables.hh b/dumux/freeflow/compositional/staggered/fluxvariables.hh
index a84067d31c18b6d893c0e12871d429e6843041d2..fde62e47ce9ff83c8fdd873e70922bf94d1e8556 100644
--- a/dumux/freeflow/compositional/staggered/fluxvariables.hh
+++ b/dumux/freeflow/compositional/staggered/fluxvariables.hh
@@ -34,18 +34,18 @@ namespace Dumux
 {
 
 // forward declaration
-template<class TypeTag, DiscretizationMethod discMethod>
+template<class TypeTag, class BaseFluxVariables, DiscretizationMethod discMethod>
 class FreeflowNCFluxVariablesImpl;
 
 /*!
  * \ingroup FreeflowNCModel
  * \brief The flux variables class for the multi-component free-flow model using the staggered grid discretization.
  */
-template<class TypeTag>
-class FreeflowNCFluxVariablesImpl<TypeTag, DiscretizationMethod::staggered>
-: public NavierStokesFluxVariables<TypeTag>
+template<class TypeTag, class BaseFluxVariables>
+class FreeflowNCFluxVariablesImpl<TypeTag, BaseFluxVariables, DiscretizationMethod::staggered>
+: public BaseFluxVariables
 {
-    using ParentType = NavierStokesFluxVariables<TypeTag>;
+    using ParentType = BaseFluxVariables;
     using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
     using FVElementGeometry = typename FVGridGeometry::LocalView;
@@ -75,7 +75,7 @@ public:
                                                         const SubControlVolumeFace &scvf,
                                                         const FluxVariablesCache& fluxVarsCache)
     {
-        CellCenterPrimaryVariables flux(0.0);
+        CellCenterPrimaryVariables flux = ParentType::computeFluxForCellCenter(problem, element, fvGeometry, elemVolVars, elemFaceVars, scvf, fluxVarsCache);
 
         for (int compIdx = 0; compIdx < numComponents; ++compIdx)
         {
diff --git a/dumux/freeflow/compositional/staggered/localresidual.hh b/dumux/freeflow/compositional/staggered/localresidual.hh
index de823729154a9704533ef504cdf69f59f63e8771..099589dcfcc8bce850d80eb8ed6a3d117d65910b 100644
--- a/dumux/freeflow/compositional/staggered/localresidual.hh
+++ b/dumux/freeflow/compositional/staggered/localresidual.hh
@@ -31,20 +31,18 @@
 namespace Dumux {
 
 // forward declaration
-template<class TypeTag,  DiscretizationMethod discMethod>
+template<class TypeTag, class BaseLocalResidual, DiscretizationMethod discMethod>
 class FreeflowNCResidualImpl;
 
 /*!
  * \ingroup FreeflowNCModel
  * \brief Element-wise calculation of the multi-component free-flow residual for models using the staggered discretization
  */
-template<class TypeTag>
-class FreeflowNCResidualImpl<TypeTag, DiscretizationMethod::staggered>
-: public NavierStokesResidual<TypeTag>
+template<class TypeTag, class BaseLocalResidual>
+class FreeflowNCResidualImpl<TypeTag, BaseLocalResidual, DiscretizationMethod::staggered>
+: public BaseLocalResidual
 {
-    using ParentType = NavierStokesResidual<TypeTag>;
-    friend class StaggeredLocalResidual<TypeTag>;
-    friend ParentType;
+    using ParentType = BaseLocalResidual;
 
     using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
     using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
@@ -70,7 +68,7 @@ public:
                                                            const SubControlVolume& scv,
                                                            const VolumeVariables& volVars) const
     {
-        CellCenterPrimaryVariables storage(0.0);
+        CellCenterPrimaryVariables storage = ParentType::computeStorageForCellCenter(problem, scv, volVars);
 
         const Scalar density = useMoles ? volVars.molarDensity() : volVars.density();
 
@@ -96,20 +94,19 @@ public:
         return storage;
     }
 
-protected:
 
     /*!
      * \brief Sets a fixed Dirichlet value for a cell (such as pressure) at the boundary.
      *        This is a provisional alternative to setting the Dirichlet value on the boundary directly.
      */
     template<class ElementVolumeVariables, class BoundaryTypes>
-    void setFixedCell_(CellCenterResidual& residual,
-                       const Problem& problem,
-                       const SubControlVolume& insideScv,
-                       const ElementVolumeVariables& elemVolVars,
-                       const BoundaryTypes& bcTypes) const
+    void setFixedCell(CellCenterResidual& residual,
+                      const Problem& problem,
+                      const SubControlVolume& insideScv,
+                      const ElementVolumeVariables& elemVolVars,
+                      const BoundaryTypes& bcTypes) const
     {
-        ParentType::setFixedCell_(residual, problem, insideScv, elemVolVars, bcTypes);
+        ParentType::setFixedCell(residual, problem, insideScv, elemVolVars, bcTypes);
 
         for (int compIdx = 0; compIdx < numComponents; ++compIdx)
         {
diff --git a/dumux/freeflow/compositional/volumevariables.hh b/dumux/freeflow/compositional/volumevariables.hh
index fc09bef71b01584ebf90aa13219fe56daad4aa71..92576fc064a3e61533865a2c481949ee360139e2 100644
--- a/dumux/freeflow/compositional/volumevariables.hh
+++ b/dumux/freeflow/compositional/volumevariables.hh
@@ -188,25 +188,25 @@ public:
     Scalar viscosity() const
     { return fluidState_.viscosity(fluidSystemPhaseIdx); }
 
-     /*!
-      * \brief Returns the mass fraction of a component in the phase \f$\mathrm{[-]}\f$
-      *
-      * \param compIdx the index of the component
-      */
-     Scalar massFraction(int compIdx) const
-     {
-         return fluidState_.massFraction(fluidSystemPhaseIdx, compIdx);
-     }
+    /*!
+     * \brief Returns the mass fraction of a component in the phase \f$\mathrm{[-]}\f$
+     *
+     * \param compIdx the index of the component
+     */
+    Scalar massFraction(int compIdx) const
+    {
+        return fluidState_.massFraction(fluidSystemPhaseIdx, compIdx);
+    }
 
-     /*!
-      * \brief Returns the mole fraction of a component in the phase \f$\mathrm{[-]}\f$
-      *
-      * \param compIdx the index of the component
-      */
-     Scalar moleFraction(int compIdx) const
-     {
-         return fluidState_.moleFraction(fluidSystemPhaseIdx, compIdx);
-     }
+    /*!
+     * \brief Returns the mole fraction of a component in the phase \f$\mathrm{[-]}\f$
+     *
+     * \param compIdx the index of the component
+     */
+    Scalar moleFraction(int compIdx) const
+    {
+        return fluidState_.moleFraction(fluidSystemPhaseIdx, compIdx);
+    }
 
     /*!
      * \brief Returns the mass density of a given phase \f$\mathrm{[kg/m^3]}\f$
diff --git a/dumux/freeflow/compositional/vtkoutputfields.hh b/dumux/freeflow/compositional/vtkoutputfields.hh
index 4d1678aea75ad539f9213747d9dbcd4cc5da0a76..bfd5f54dffc328839d1e2ced521708c1f829b374 100644
--- a/dumux/freeflow/compositional/vtkoutputfields.hh
+++ b/dumux/freeflow/compositional/vtkoutputfields.hh
@@ -34,7 +34,7 @@ namespace Dumux
  * \ingroup FreeflowNCModel
  * \brief Adds vtk output fields specific to the FreeflowNC model
  */
-template<class FVGridGeometry, class FluidSystem, int phaseIdx>
+template<class BaseVtkOutputFields, class ModelTraits, class FVGridGeometry, class FluidSystem, int phaseIdx>
 class FreeflowNCVtkOutputFields
 {
 
@@ -43,8 +43,14 @@ public:
     template <class VtkOutputModule>
     static void init(VtkOutputModule& vtk)
     {
-        NavierStokesVtkOutputFields<FVGridGeometry>::init(vtk);
+        BaseVtkOutputFields::init(vtk);
+        add(vtk);
+    }
 
+    //! Add the FreeflowNC specific vtk output fields.
+    template <class VtkOutputModule>
+    static void add(VtkOutputModule& vtk)
+    {
         for (int j = 0; j < FluidSystem::numComponents; ++j)
         {
             vtk.addVolumeVariable([j](const auto& v){ return v.massFraction(j); }, "X^" + FluidSystem::componentName(j) + "_" + FluidSystem::phaseName(phaseIdx));
@@ -54,6 +60,9 @@ public:
                 vtk.addVolumeVariable([j](const auto& v){ return v.diffusionCoefficient(j); }, "D^" + FluidSystem::componentName(j) + "_" + FluidSystem::phaseName(phaseIdx));
             }
         }
+        if (ModelTraits::usesTurbulenceModel())
+            // the eddy diffusivity is recalculated for an arbitrary component which is not the phase component
+            vtk.addVolumeVariable([](const auto& v){ return v.effectiveDiffusivity(1-phaseIdx) - v.diffusionCoefficient(1-phaseIdx); }, "D_t");
     }
 };
 
diff --git a/dumux/freeflow/ransnc/model.hh b/dumux/freeflow/compositional/zeroeqncmodel.hh
similarity index 55%
rename from dumux/freeflow/ransnc/model.hh
rename to dumux/freeflow/compositional/zeroeqncmodel.hh
index 372747753b12ba250f1da5dcde0b90428cf713c6..8baff41f33768276f7155550997dd23bec7ed1f0 100644
--- a/dumux/freeflow/ransnc/model.hh
+++ b/dumux/freeflow/compositional/zeroeqncmodel.hh
@@ -18,53 +18,29 @@
  *****************************************************************************/
 /*!
  * \file
- * \ingroup RANSModel
+ * \ingroup FreeflowNCModel
  *
- * \brief A single-phase, multi-component isothermal Navier-Stokes model
+ * \brief A single-phase, multi-component Reynolds-Averaged Navier-Stokes 0-Eq. model
  *
- * \copydoc Dumux::RANSModel
- *
- * The system is closed by a <B> component mass/mole balance equation </B> for each component \f$\kappa\f$:
- * \f[
- *    \frac{\partial \left(\varrho X^\kappa\right)}{\partial t}
- *    + \nabla \cdot \left( \varrho {\boldsymbol{v}} X^\kappa
- *    - (D^\kappa + D_\text{t}) \varrho \frac{M^\kappa}{M} \textbf{grad}\, x^\kappa \right)
- *    - q^\kappa = 0
- * \f]
- *
- * Alternatively, one component balance equation can be replace by a <B> total mass/mole balance equation </B>:
- * \f[
- *    \frac{\partial \varrho_g}{\partial t}
- *    + \nabla \cdot \left(
- *        \varrho {\boldsymbol{v}}
- *        - \sum_\kappa (D^\kappa + D_\text{t}) \varrho \frac{M^\kappa}{M} \textbf{grad}\, x^\kappa
- *      \right)
- *    - q = 0
- * \f]
- *
- * The eddy diffusivity \f$ D_\text{t} \f$ is related to the eddy viscosity \f$ \nu_\text{t} \f$
- * by the turbulent Schmidt number:
- * \f[ D_\text{t} = \frac{\nu_\text{t}}{\mathrm{Sc}_\text{t}} \f]
- *
- * So far, only the staggered grid spatial discretization (for structured grids) is available.
+ * \copydoc Dumux::FreeflowNCModel
  */
 
-#ifndef DUMUX_RANS_NC_MODEL_HH
-#define DUMUX_RANS_NC_MODEL_HH
+#ifndef DUMUX_ZEROEQ_NC_MODEL_HH
+#define DUMUX_ZEROEQ_NC_MODEL_HH
 
 #include <dumux/common/properties.hh>
 #include <dumux/freeflow/compositional/navierstokesncmodel.hh>
-#include <dumux/freeflow/nonisothermal/ransnivtkoutputfields.hh>
-#include <dumux/freeflow/rans/zeroeq/volumevariables.hh>
+#include <dumux/freeflow/nonisothermal/vtkoutputfields.hh>
+#include <dumux/freeflow/rans/zeroeq/model.hh>
 
-#include "indices.hh"
-#include "volumevariables.hh"
 #include "vtkoutputfields.hh"
 
+#include <dumux/freeflow/ransnc/volumevariables.hh>
+
 namespace Dumux {
 
 ///////////////////////////////////////////////////////////////////////////
-// properties for the single-phase, multi-component RANS model
+// properties for the single-phase, multi-component ZeroEq model
 ///////////////////////////////////////////////////////////////////////////
 namespace Properties {
 
@@ -72,14 +48,39 @@ namespace Properties {
 // Type tags
 //////////////////////////////////////////////////////////////////
 
-//! The type tags for the single-phase, multi-component isothermal RANS model
-NEW_TYPE_TAG(RANSNC, INHERITS_FROM(NavierStokesNC));
-NEW_TYPE_TAG(ZeroEqNC, INHERITS_FROM(RANSNC));
+//! The type tags for the single-phase, multi-component isothermal ZeroEq model
+NEW_TYPE_TAG(ZeroEqNC, INHERITS_FROM(NavierStokesNC));
 
 ///////////////////////////////////////////////////////////////////////////
 // default property values
 ///////////////////////////////////////////////////////////////////////////
 
+/*!
+ * \ingroup ZeroEqModel
+ * \brief Traits for the Reynolds-averaged Navier-Stokes 0-Eq. model
+ */
+template<int dimension, int nComp, int phaseIdx, int replaceCompEqIdx, bool useM>
+struct ZeroEqNCModelTraits : NavierStokesNCModelTraits<dimension, nComp, phaseIdx, replaceCompEqIdx, useM>
+{
+    //! The model does include a turbulence model
+    static constexpr bool usesTurbulenceModel() { return true; }
+};
+
+//! The model traits of the isothermal model
+SET_PROP(ZeroEqNC, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    static constexpr int numComponents = FluidSystem::numComponents;
+    static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    static constexpr int replaceCompEqIdx = GET_PROP_VALUE(TypeTag, ReplaceCompEqIdx);
+    static constexpr bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles);
+public:
+    using type = ZeroEqNCModelTraits<dim, numComponents, phaseIdx, replaceCompEqIdx, useMoles>;
+};
+
 //! Set the volume variables property
 SET_PROP(ZeroEqNC, VolumeVariables)
 {
@@ -100,21 +101,37 @@ public:
 SET_PROP(ZeroEqNC, VtkOutputFields)
 {
 private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
     using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
     static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
-    using SinglePhaseVtkOutputFields = RANSVtkOutputFields<FVGridGeometry>;
+    using BaseVtkOutputFields = RANSVtkOutputFields<FVGridGeometry>;
 public:
-    using type = RANSNCVtkOutputFields<FVGridGeometry, FluidSystem, phaseIdx, SinglePhaseVtkOutputFields>;
+     using type = FreeflowNCVtkOutputFields<BaseVtkOutputFields, ModelTraits, FVGridGeometry, FluidSystem, phaseIdx>;
 };
 
 //////////////////////////////////////////////////////////////////////////
-// Property values for non-isothermal multi-component RANS model
+// Property values for non-isothermal multi-component ZeroEq model
 //////////////////////////////////////////////////////////////////////////
 
-//! The type tags for the single-phase, multi-component non-isothermal RANS models
-NEW_TYPE_TAG(RANSNCNI, INHERITS_FROM(NavierStokesNCNI));
-NEW_TYPE_TAG(ZeroEqNCNI, INHERITS_FROM(RANSNCNI));
+//! The type tags for the single-phase, multi-component non-isothermal ZeroEq models
+NEW_TYPE_TAG(ZeroEqNCNI, INHERITS_FROM(NavierStokesNCNI));
+
+//! The model traits of the non-isothermal model
+SET_PROP(ZeroEqNCNI, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+    using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    static constexpr int numComponents = FluidSystem::numComponents;
+    static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    static constexpr int replaceCompEqIdx = GET_PROP_VALUE(TypeTag, ReplaceCompEqIdx);
+    static constexpr bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles);
+    using IsothermalModelTraits = ZeroEqNCModelTraits<dim, numComponents, phaseIdx, replaceCompEqIdx, useMoles>;
+public:
+    using type = FreeflowNIModelTraits<IsothermalModelTraits>;
+};
 
 //! Set the volume variables property
 SET_PROP(ZeroEqNCNI, VolumeVariables)
@@ -126,8 +143,8 @@ private:
     using MT = typename GET_PROP_TYPE(TypeTag, ModelTraits);
 
     using Traits = NavierStokesVolumeVariablesTraits<PV, FSY, FST, MT>;
-    using NSVolVars = FreeflowNCVolumeVariables<Traits>;
-    using RANSVolVars = ZeroEqVolumeVariables<Traits, NSVolVars>;
+    using NCVolVars = FreeflowNCVolumeVariables<Traits>;
+    using RANSVolVars = ZeroEqVolumeVariables<Traits, NCVolVars>;
 public:
     using type = RANSNCVolumeVariables<Traits, RANSVolVars>;
 };
@@ -136,14 +153,14 @@ public:
 SET_PROP(ZeroEqNCNI, VtkOutputFields)
 {
 private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
     using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
     static constexpr int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
-    using NavierStokesFields = NavierStokesVtkOutputFields<FVGridGeometry>;
-    using RANSFields = RANSVtkOutputFields<FVGridGeometry>;
-    using SinglePhaseVtkOutputFields = RANSNonIsothermalVtkOutputFields<NavierStokesFields, RANSFields>;
+    using BaseVtkOutputFields = RANSVtkOutputFields<FVGridGeometry>;
+    using NonIsothermalFields = FreeflowNonIsothermalVtkOutputFields<BaseVtkOutputFields, ModelTraits>;
 public:
-    using type = RANSNCVtkOutputFields<FVGridGeometry, FluidSystem, phaseIdx, SinglePhaseVtkOutputFields>;
+    using type = FreeflowNCVtkOutputFields<NonIsothermalFields, ModelTraits, FVGridGeometry, FluidSystem, phaseIdx>;
 };
 
 // \}
diff --git a/dumux/freeflow/navierstokes/model.hh b/dumux/freeflow/navierstokes/model.hh
index e26d38e51c301921c2b1920ec50695c4cc75147c..ad0c3983ae4f78dc3f5f97ac28388ce7c10b0105 100644
--- a/dumux/freeflow/navierstokes/model.hh
+++ b/dumux/freeflow/navierstokes/model.hh
@@ -52,7 +52,7 @@
 #include <dumux/freeflow/properties.hh>
 #include <dumux/freeflow/nonisothermal/model.hh>
 #include <dumux/freeflow/nonisothermal/indices.hh>
-#include <dumux/freeflow/nonisothermal/navierstokesnivtkoutputfields.hh>
+#include <dumux/freeflow/nonisothermal/vtkoutputfields.hh>
 
 #include "localresidual.hh"
 #include "volumevariables.hh"
@@ -96,6 +96,9 @@ struct NavierStokesModelTraits
     //! The model is isothermal
     static constexpr bool enableEnergyBalance() { return false; }
 
+    //! The model does not include a turbulence model
+    static constexpr bool usesTurbulenceModel() { return false; }
+
     //! the indices
     using Indices = NavierStokesIndices<dim()>;
 };
@@ -222,10 +225,11 @@ public:
 SET_PROP(NavierStokesNI, VtkOutputFields)
 {
 private:
+     using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
      using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
      using IsothermalFields = NavierStokesVtkOutputFields<FVGridGeometry>;
 public:
-     using type = NavierStokesNonIsothermalVtkOutputFields<IsothermalFields>;
+     using type = FreeflowNonIsothermalVtkOutputFields<IsothermalFields, ModelTraits>;
 };
 
 //! Use Fourier's Law as default heat conduction type
diff --git a/dumux/freeflow/navierstokes/staggered/localresidual.hh b/dumux/freeflow/navierstokes/staggered/localresidual.hh
index eb68642847c3d4ebecd106cc29324e6c0ed2174d..d96aa7a3bf4b35e539f28ab4fae4b85434e23b3e 100644
--- a/dumux/freeflow/navierstokes/staggered/localresidual.hh
+++ b/dumux/freeflow/navierstokes/staggered/localresidual.hh
@@ -183,6 +183,25 @@ public:
         return fluxVars.computeMomentumFlux(problem, element, scvf, fvGeometry, elemVolVars, elementFaceVars);
     }
 
+    /*!
+     * \brief Sets a fixed Dirichlet value for a cell (such as pressure) at the boundary.
+     *        This is a provisional alternative to setting the Dirichlet value on the boundary directly.
+     */
+    template<class BoundaryTypes>
+    void setFixedCell(CellCenterResidual& residual,
+                      const Problem& problem,
+                      const SubControlVolume& insideScv,
+                      const ElementVolumeVariables& elemVolVars,
+                      const BoundaryTypes& bcTypes) const
+    {
+        // set a fixed pressure for cells adjacent to a wall
+        if(bcTypes.isDirichletCell(Indices::conti0EqIdx))
+        {
+            const auto& insideVolVars = elemVolVars[insideScv];
+            residual[Indices::conti0EqIdx - cellCenterOffset] = insideVolVars.pressure() - problem.dirichletAtPos(insideScv.center())[Indices::pressureIdx];
+        }
+    }
+
 protected:
 
     //  /*!
@@ -243,30 +262,11 @@ protected:
 
                 residual += boundaryFlux;
 
-                asImp_().setFixedCell_(residual, problem, scv, elemVolVars, bcTypes);
+                asImp_().setFixedCell(residual, problem, scv, elemVolVars, bcTypes);
             }
         }
     }
 
-    /*!
-     * \brief Sets a fixed Dirichlet value for a cell (such as pressure) at the boundary.
-     *        This is a provisional alternative to setting the Dirichlet value on the boundary directly.
-     */
-    template<class BoundaryTypes>
-    void setFixedCell_(CellCenterResidual& residual,
-                       const Problem& problem,
-                       const SubControlVolume& insideScv,
-                       const ElementVolumeVariables& elemVolVars,
-                       const BoundaryTypes& bcTypes) const
-    {
-        // set a fixed pressure for cells adjacent to a wall
-        if(bcTypes.isDirichletCell(Indices::conti0EqIdx))
-        {
-            const auto& insideVolVars = elemVolVars[insideScv];
-            residual[Indices::conti0EqIdx - cellCenterOffset] = insideVolVars.pressure() - problem.dirichletAtPos(insideScv.center())[Indices::pressureIdx];
-        }
-    }
-
      /*!
      * \brief Evaluate boundary conditions for a face dof
      */
diff --git a/dumux/freeflow/nonisothermal/CMakeLists.txt b/dumux/freeflow/nonisothermal/CMakeLists.txt
index 343041b7e53de72b37f34f61457551a8386b12b7..1f1856fa57efc0aa6e98aec8bbe11e7b832f9165 100644
--- a/dumux/freeflow/nonisothermal/CMakeLists.txt
+++ b/dumux/freeflow/nonisothermal/CMakeLists.txt
@@ -3,6 +3,5 @@
 install(FILES
 indices.hh
 model.hh
-navierstokesnivtkoutputfields.hh
-ransnivtkoutputfields.hh
+vtkoutputfields.hh
 DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/freeflow/nonisothermal)
diff --git a/dumux/freeflow/nonisothermal/ransnivtkoutputfields.hh b/dumux/freeflow/nonisothermal/ransnivtkoutputfields.hh
deleted file mode 100644
index c40137409536817a2e7168f1d3ec6c99f58ef45e..0000000000000000000000000000000000000000
--- a/dumux/freeflow/nonisothermal/ransnivtkoutputfields.hh
+++ /dev/null
@@ -1,61 +0,0 @@
-// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
-// vi: set et ts=4 sw=4 sts=4:
-/*****************************************************************************
- *   See the file COPYING for full copying permissions.                      *
- *                                                                           *
- *   This program is free software: you can redistribute it and/or modify    *
- *   it under the terms of the GNU General Public License as published by    *
- *   the Free Software Foundation, either version 2 of the License, or       *
- *   (at your option) any later version.                                     *
- *                                                                           *
- *   This program is distributed in the hope that it will be useful,         *
- *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
- *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
- *   GNU General Public License for more details.                            *
- *                                                                           *
- *   You should have received a copy of the GNU General Public License       *
- *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
- *****************************************************************************/
-/*!
- * \file
- * \ingroup RANSNIModel
- * \copydoc Dumux::RANSNonIsothermalVtkOutputFields
- */
-#ifndef DUMUX_RANS_NI_OUTPUT_FIELDS_HH
-#define DUMUX_RANS_NI_OUTPUT_FIELDS_HH
-
-#include <dumux/common/properties.hh>
-
-namespace Dumux
-{
-
-/*!
- * \ingroup RANSNIModel
- * \brief Adds vtk output fields specific to non-isothermal RANS models
- */
-template<class NavierStokesVtkOutputFields, class RANSVtkOutputFields>
-class RANSNonIsothermalVtkOutputFields
-{
-
-public:
-    //! Initialize the non-isothermal specific vtk output fields.
-    template <class VtkOutputModule>
-    static void init(VtkOutputModule& vtk)
-    {
-        NavierStokesVtkOutputFields::init(vtk);
-        add(vtk);
-    }
-
-    //! Add the RANS specific vtk output fields.
-    template <class VtkOutputModule>
-    static void add(VtkOutputModule& vtk)
-    {
-        RANSVtkOutputFields::add(vtk);
-        vtk.addVolumeVariable( [](const auto& v){ return v.temperature(); }, "temperature");
-        vtk.addVolumeVariable( [](const auto& v){ return v.eddyThermalConductivity(); }, "lambda_t");
-    }
-};
-
-} // end namespace Dumux
-
-#endif
diff --git a/dumux/freeflow/nonisothermal/navierstokesnivtkoutputfields.hh b/dumux/freeflow/nonisothermal/vtkoutputfields.hh
similarity index 67%
rename from dumux/freeflow/nonisothermal/navierstokesnivtkoutputfields.hh
rename to dumux/freeflow/nonisothermal/vtkoutputfields.hh
index 8cdf0c8f0c6eb5229ee62ac0c3dce6f896c7430b..4d0978ae5990734af5e762fc47d7e3b651f74d36 100644
--- a/dumux/freeflow/nonisothermal/navierstokesnivtkoutputfields.hh
+++ b/dumux/freeflow/nonisothermal/vtkoutputfields.hh
@@ -18,11 +18,11 @@
  *****************************************************************************/
 /*!
  * \file
- * \ingroup NavierStokesNIModel
- * \copydoc Dumux::NavierStokesNonIsothermalVtkOutputFields
+ * \ingroup FreeflowNIModel
+ * \copydoc Dumux::FreeflowNonIsothermalVtkOutputFields
  */
-#ifndef DUMUX_NAVIERSTOKES_NI_OUTPUT_FIELDS_HH
-#define DUMUX_NAVIERSTOKES_NI_OUTPUT_FIELDS_HH
+#ifndef DUMUX_FREEFLOW_NI_OUTPUT_FIELDS_HH
+#define DUMUX_FREEFLOW_NI_OUTPUT_FIELDS_HH
 
 #include <dumux/common/properties.hh>
 
@@ -30,21 +30,30 @@ namespace Dumux
 {
 
 /*!
- * \ingroup NavierStokesNIModel
+ * \ingroup FreeflowNIModel
  * \brief Adds vtk output fields specific to non-isothermal free-flow models
  */
-template<class IsothermalVtkOutputFields>
-class NavierStokesNonIsothermalVtkOutputFields
+template<class IsothermalVtkOutputFields, class ModelTraits>
+class FreeflowNonIsothermalVtkOutputFields
 {
 
 public:
-
     //! Initialize the non-isothermal specific vtk output fields.
     template <class VtkOutputModule>
     static void init(VtkOutputModule& vtk)
     {
         IsothermalVtkOutputFields::init(vtk);
-        vtk.addVolumeVariable( [](const auto& v){ return v.temperature(); }, "temperature");
+        add(vtk);
+    }
+
+    //! Add the non-isothermal specific vtk output fields.
+    template <class VtkOutputModule>
+    static void add(VtkOutputModule& vtk)
+    {
+        vtk.addVolumeVariable([](const auto& v){ return v.temperature(); }, "temperature");
+//         vtk.addVolumeVariable([](const auto& v){ return v.thermalConductivity(); }, "lambda");
+        if (ModelTraits::usesTurbulenceModel())
+            vtk.addVolumeVariable([](const auto& v){ return v.effectiveThermalConductivity() - v.thermalConductivity(); }, "lambda_t");
     }
 };
 
diff --git a/dumux/freeflow/rans/model.hh b/dumux/freeflow/rans/model.hh
index fc511bbebe87b58c1ff0f47b85c8e8cc3acbafee..4723967012f991043db9b46937d0f2687f41c24f 100644
--- a/dumux/freeflow/rans/model.hh
+++ b/dumux/freeflow/rans/model.hh
@@ -39,7 +39,6 @@
 
 #include <dumux/common/properties.hh>
 #include <dumux/freeflow/navierstokes/model.hh>
-#include <dumux/freeflow/nonisothermal/ransnivtkoutputfields.hh>
 
 #include "vtkoutputfields.hh"
 
@@ -63,6 +62,27 @@ NEW_TYPE_TAG(RANS, INHERITS_FROM(NavierStokes));
 ///////////////////////////////////////////////////////////////////////////
 SET_BOOL_PROP(RANS, EnableInertiaTerms, true); //!< Explicitly force the consideration of inertia terms by default
 
+/*!
+ * \ingroup RANSModel
+ * \brief Traits for the Reynolds-averaged Navier-Stokes model
+ */
+template<int dimension>
+struct RANSModelTraits : NavierStokesModelTraits<dimension>
+{
+    //! The model does include a turbulence model
+    static constexpr bool usesTurbulenceModel() { return true; }
+};
+
+//! The model traits of the isothermal model
+SET_PROP(RANS, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+public:
+    using type = RANSModelTraits<dim>;
+};
+
 //! The specific vtk output fields
 SET_PROP(RANS, VtkOutputFields)
 {
@@ -85,11 +105,7 @@ SET_PROP(RANSNI, ModelTraits)
 private:
     using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
     static constexpr int dim = GridView::dimension;
-    static constexpr bool enableInertiaTerms = GET_PROP_VALUE(TypeTag, EnableInertiaTerms);
-
-    static_assert(enableInertiaTerms, "The RANS model only works with intertia terms enabled!");
-
-    using IsothermalTraits = NavierStokesModelTraits<dim>;
+    using IsothermalTraits = RANSModelTraits<dim>;
 public:
     using type = FreeflowNIModelTraits<IsothermalTraits>;
 };
@@ -98,11 +114,11 @@ public:
 SET_PROP(RANSNI, VtkOutputFields)
 {
 private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
-    using NavierStokesFields = NavierStokesVtkOutputFields<FVGridGeometry>;
-    using RANSFields = RANSVtkOutputFields<FVGridGeometry>;
+    using IsothermalFields = RANSVtkOutputFields<FVGridGeometry>;
 public:
-    using type = RANSNonIsothermalVtkOutputFields<NavierStokesFields, RANSFields>;
+    using type = FreeflowNonIsothermalVtkOutputFields<IsothermalFields, ModelTraits>;
 };
 
 //! Use Fourier's Law as default heat conduction type
diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/indices.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/indices.hh
index 8f4b585dccf9acb80a9c8d28ff13e8dfd6c4207e..0fb86e5fd230613bc0ce7afd7110549201891fd4 100644
--- a/dumux/freeflow/rans/twoeq/lowrekepsilon/indices.hh
+++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/indices.hh
@@ -34,15 +34,13 @@ namespace Dumux {
  * \brief The common indices for the isothermal low-Reynolds k-epsilon model.
  *
  * \tparam dimension The dimension of the problem
+ * \tparam numComponents The number of considered transported components
  */
-template <int dimension>
+template<int dimension, int numComponents>
 struct LowReKEpsilonIndices : public NavierStokesIndices<dimension>
 {
-private:
-    using ParentType = NavierStokesIndices<dimension>;
-
 public:
-    static constexpr auto turbulentKineticEnergyEqIdx = ParentType::conti0EqIdx + 1;
+    static constexpr auto turbulentKineticEnergyEqIdx = dimension + numComponents;
     static constexpr auto turbulentKineticEnergyIdx = turbulentKineticEnergyEqIdx;
     static constexpr auto dissipationEqIdx = turbulentKineticEnergyEqIdx + 1;
     static constexpr auto dissipationIdx = dissipationEqIdx;
diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/model.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/model.hh
index 6c9add5af4532a5b82f26482b73d92fd9b681630..9e36203aaa97c4bc6cbb49c0654bb6ec5bb11163 100644
--- a/dumux/freeflow/rans/twoeq/lowrekepsilon/model.hh
+++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/model.hh
@@ -99,7 +99,7 @@ namespace Properties {
  * \brief Traits for the low-Reynolds k-epsilon model
  */
 template<int dimension>
-struct LowReKEpsilonModelTraits
+struct LowReKEpsilonModelTraits : RANSModelTraits<dimension>
 {
     //! The dimension of the model
     static constexpr int dim() { return dimension; }
@@ -108,23 +108,11 @@ struct LowReKEpsilonModelTraits
     //! one mass balance equation and two turbulent transport equations
     static constexpr int numEq() { return dim()+1+2; }
 
-    //! The number of phases is always 1
-    static constexpr int numPhases() { return 1; }
-
     //! The number of components
     static constexpr int numComponents() { return 1; }
 
-    //! Enable advection
-    static constexpr bool enableAdvection() { return true; }
-
-    //! The one-phase model has no molecular diffusion
-    static constexpr bool enableMolecularDiffusion() { return true; }
-
-    //! The model is isothermal
-    static constexpr bool enableEnergyBalance() { return false; }
-
     //! the indices
-    using Indices = LowReKEpsilonIndices<dim()>;
+    using Indices = LowReKEpsilonIndices<dim(), numComponents()>;
 };
 
 ///////////////////////////////////////////////////////////////////////////
@@ -181,6 +169,17 @@ public:
 //! The type tag for the single-phase, isothermal low-Reynolds k-epsilon model
 NEW_TYPE_TAG(LowReKEpsilonNI, INHERITS_FROM(RANSNI));
 
+//! The model traits of the non-isothermal model
+SET_PROP(LowReKEpsilonNI, ModelTraits)
+{
+private:
+    using GridView = typename GET_PROP_TYPE(TypeTag, FVGridGeometry)::GridView;
+    static constexpr int dim = GridView::dimension;
+    using IsothermalTraits = LowReKEpsilonModelTraits<dim>;
+public:
+    using type = FreeflowNIModelTraits<IsothermalTraits>;
+};
+
 //! Set the volume variables property
 SET_PROP(LowReKEpsilonNI, VolumeVariables)
 {
@@ -196,6 +195,17 @@ public:
     using type = LowReKEpsilonVolumeVariables<Traits, NSVolVars>;
 };
 
+//! The specific non-isothermal vtk output fields
+SET_PROP(LowReKEpsilonNI, VtkOutputFields)
+{
+private:
+    using ModelTraits = typename GET_PROP_TYPE(TypeTag, ModelTraits);
+    using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using IsothermalFields = LowReKEpsilonVtkOutputFields<FVGridGeometry>;
+public:
+    using type = FreeflowNonIsothermalVtkOutputFields<IsothermalFields, ModelTraits>;
+};
+
 // \}
 }
 
diff --git a/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/localresidual.hh b/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/localresidual.hh
index f4a3ebafbc17f9d0c3830b9415b148ddde961d71..1e807eef6d5f8be9f9061c94b2fb60d463029a12 100644
--- a/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/localresidual.hh
+++ b/dumux/freeflow/rans/twoeq/lowrekepsilon/staggered/localresidual.hh
@@ -44,8 +44,6 @@ class LowReKEpsilonResidualImpl<TypeTag, DiscretizationMethod::staggered>
 : public NavierStokesResidual<TypeTag>
 {
     using ParentType = NavierStokesResidual<TypeTag>;
-    friend class StaggeredLocalResidual<TypeTag>;
-    friend ParentType;
 
     using GridVariables = typename GET_PROP_TYPE(TypeTag, GridVariables);
 
diff --git a/dumux/freeflow/ransnc/indices.hh b/dumux/freeflow/ransnc/indices.hh
deleted file mode 100644
index 06b40e75b6ff55925b7ed21432f034d4f3933df1..0000000000000000000000000000000000000000
--- a/dumux/freeflow/ransnc/indices.hh
+++ /dev/null
@@ -1,56 +0,0 @@
-// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
-// vi: set et ts=4 sw=4 sts=4:
-/*****************************************************************************
- *   See the file COPYING for full copying permissions.                      *
- *                                                                           *
- *   This program is free software: you can redistribute it and/or modify    *
- *   it under the terms of the GNU General Public License as published by    *
- *   the Free Software Foundation, either version 2 of the License, or       *
- *   (at your option) any later version.                                     *
- *                                                                           *
- *   This program is distributed in the hope that it will be useful,         *
- *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
- *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
- *   GNU General Public License for more details.                            *
- *                                                                           *
- *   You should have received a copy of the GNU General Public License       *
- *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
- *****************************************************************************/
-/*!
- * \file
- * \ingroup RANSNCModel
- * \copydoc Dumux::RANSNCIndices
- */
-#ifndef DUMUX_RANS_NC_INDICES_HH
-#define DUMUX_RANS_NC_INDICES_HH
-
-#include <dumux/freeflow/compositional/indices.hh>
-
-namespace Dumux {
-
-/*!
- * \ingroup RANSNCModel
- * \brief Dummy indices for the ZeroEqNC model
- */
-class DummyIndices
-{ };
-
-// \{
-/*!
- * \ingroup RANSNCModel
- * \brief The common indices for the isothermal multi-component Reynolds-averaged Navier-Stokes model.
- *
- * \tparam PVOffset The first index in a primary variable vector.
- */
-template <int dimension, int numEquations,
-          int thePhaseIdx, int theReplaceCompEqIdx,
-          class MomentumIndices = DummyIndices>
-struct RANSNCIndices
-    : public FreeflowNCIndices<dimension, numEquations, thePhaseIdx, theReplaceCompEqIdx>,
-      public MomentumIndices
-{ };
-
-// \}
-} // end namespace Dumux
-
-#endif
diff --git a/dumux/freeflow/ransnc/vtkoutputfields.hh b/dumux/freeflow/ransnc/vtkoutputfields.hh
deleted file mode 100644
index 4e46d6ad81b3ee3b0a3d5ebba82fba1ef2dcca90..0000000000000000000000000000000000000000
--- a/dumux/freeflow/ransnc/vtkoutputfields.hh
+++ /dev/null
@@ -1,55 +0,0 @@
-// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
-// vi: set et ts=4 sw=4 sts=4:
-/*****************************************************************************
- *   See the file COPYING for full copying permissions.                      *
- *                                                                           *
- *   This program is free software: you can redistribute it and/or modify    *
- *   it under the terms of the GNU General Public License as published by    *
- *   the Free Software Foundation, either version 2 of the License, or       *
- *   (at your option) any later version.                                     *
- *                                                                           *
- *   This program is distributed in the hope that it will be useful,         *
- *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
- *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
- *   GNU General Public License for more details.                            *
- *                                                                           *
- *   You should have received a copy of the GNU General Public License       *
- *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
- *****************************************************************************/
-/*!
- * \file
- * \ingroup RANSNCModel
- * \copydoc Dumux::RANSNCVtkOutputFields
- */
-#ifndef DUMUX_RANS_NC_VTK_OUTPUT_FIELDS_HH
-#define DUMUX_RANS_NC_VTK_OUTPUT_FIELDS_HH
-
-#include <dumux/freeflow/rans/vtkoutputfields.hh>
-#include <dumux/freeflow/compositional/vtkoutputfields.hh>
-
-namespace Dumux
-{
-
-/*!
- * \ingroup RANSNCModel
- * \brief Adds vtk output fields specific to the RANSNC model
- */
-template<class FVGridGeometry, class FluidSystem, int phaseIdx, class MomentumVtkOutputFields>
-class RANSNCVtkOutputFields
-{
-    enum { dim = FVGridGeometry::GridView::dimension };
-
-public:
-    //! Initialize the RANSNC specific vtk output fields.
-    template <class VtkOutputModule>
-    static void init(VtkOutputModule& vtk)
-    {
-        FreeflowNCVtkOutputFields<FVGridGeometry, FluidSystem, phaseIdx>::init(vtk);
-        MomentumVtkOutputFields::add(vtk);
-        vtk.addVolumeVariable([](const auto& v){ return v.eddyDiffusivity(); }, "D_t");
-    }
-};
-
-} // end namespace Dumux
-
-#endif
diff --git a/test/freeflow/rans/test_pipe_laufer.cc b/test/freeflow/rans/test_pipe_laufer.cc
index 8ab152fd04648809ac57d4e56a18d6f6d95807eb..d5f9d1452045a1f04e0565e97f6535d5b31d315f 100644
--- a/test/freeflow/rans/test_pipe_laufer.cc
+++ b/test/freeflow/rans/test_pipe_laufer.cc
@@ -26,6 +26,8 @@
  */
 #include <config.h>
 
+#define IS_TURBULENT 1
+
 #include <ctime>
 #include <iostream>
 
diff --git a/test/freeflow/ransnc/CMakeLists.txt b/test/freeflow/ransnc/CMakeLists.txt
index d81756d601bbe77c011d5a8992230dbcd103be13..ec8a488f25128b9a9d75d3910b5517eb2c8a9f24 100644
--- a/test/freeflow/ransnc/CMakeLists.txt
+++ b/test/freeflow/ransnc/CMakeLists.txt
@@ -6,7 +6,7 @@ dune_add_test(NAME test_channel_zeroeq2c
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_channel_zeroeq2c.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_channel2c-00016.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_channel2c-00031.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_channel_zeroeq2c test_channel2c.input")
 
 dune_add_test(NAME test_channel_zeroeq2cni
@@ -15,6 +15,19 @@ dune_add_test(NAME test_channel_zeroeq2cni
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS       --script fuzzy
                              --files ${CMAKE_SOURCE_DIR}/test/references/test_channel_zeroeq2cni.vtu
-                                     ${CMAKE_CURRENT_BINARY_DIR}/test_channel2cni-00019.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_channel2cni-00035.vtu
                              --command "${CMAKE_CURRENT_BINARY_DIR}/test_channel_zeroeq2cni test_channel2cni.input")
 target_compile_definitions(test_channel_zeroeq2cni PUBLIC "NONISOTHERMAL=1")
+
+add_executable(test_channel_lowrekepsilon2c EXCLUDE_FROM_ALL test_channel.cc)
+target_compile_definitions(test_channel_lowrekepsilon2c PUBLIC "LOWREKEPSILON=1")
+
+dune_add_test(NAME test_channel_lowrekepsilon2cni
+              SOURCES test_channel.cc
+              CMAKE_GUARD HAVE_UMFPACK
+              COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
+              CMD_ARGS       --script fuzzy
+                             --files ${CMAKE_SOURCE_DIR}/test/references/test_channel_lowrekepsilon2cni.vtu
+                                     ${CMAKE_CURRENT_BINARY_DIR}/test_channel2cni-00033.vtu
+                             --command "${CMAKE_CURRENT_BINARY_DIR}/test_channel_lowrekepsilon2cni test_channel2cni.input")
+target_compile_definitions(test_channel_lowrekepsilon2cni PUBLIC "LOWREKEPSILON=1" "NONISOTHERMAL=1")
diff --git a/test/freeflow/ransnc/channeltestproblem.hh b/test/freeflow/ransnc/channeltestproblem.hh
index 822056dc2170e1ceeec156599328236f4eb1d0b2..d8ecfbb26520c37fbf2029dd9e33b02c0e963dc1 100644
--- a/test/freeflow/ransnc/channeltestproblem.hh
+++ b/test/freeflow/ransnc/channeltestproblem.hh
@@ -26,9 +26,15 @@
 
 #include <dumux/discretization/staggered/freeflow/properties.hh>
 #include <dumux/material/fluidsystems/h2oair.hh>
+#include <dumux/freeflow/turbulenceproperties.hh>
 
+#if LOWREKEPSILON
+#include <dumux/freeflow/compositional/lowrekepsilonncmodel.hh>
+#include <dumux/freeflow/rans/twoeq/lowrekepsilon/problem.hh>
+#else
+#include <dumux/freeflow/compositional/zeroeqncmodel.hh>
 #include <dumux/freeflow/rans/zeroeq/problem.hh>
-#include <dumux/freeflow/ransnc/model.hh>
+#endif
 
 namespace Dumux
 {
@@ -39,9 +45,17 @@ namespace Properties
 {
 
 #if NONISOTHERMAL
-NEW_TYPE_TAG(ChannelNCTestTypeTag, INHERITS_FROM(StaggeredFreeFlowModel, ZeroEqNCNI));
+  #if LOWREKEPSILON
+  NEW_TYPE_TAG(ChannelNCTestTypeTag, INHERITS_FROM(StaggeredFreeFlowModel, LowReKEpsilonNCNI));
+  #else
+  NEW_TYPE_TAG(ChannelNCTestTypeTag, INHERITS_FROM(StaggeredFreeFlowModel, ZeroEqNCNI));
+  #endif
 #else
-NEW_TYPE_TAG(ChannelNCTestTypeTag, INHERITS_FROM(StaggeredFreeFlowModel, ZeroEqNC));
+  #if LOWREKEPSILON
+  NEW_TYPE_TAG(ChannelNCTestTypeTag, INHERITS_FROM(StaggeredFreeFlowModel, LowReKEpsilonNC));
+  #else
+  NEW_TYPE_TAG(ChannelNCTestTypeTag, INHERITS_FROM(StaggeredFreeFlowModel, ZeroEqNC));
+  #endif
 #endif
 
 NEW_PROP_TAG(FluidSystem);
@@ -81,12 +95,19 @@ SET_BOOL_PROP(ChannelNCTestTypeTag, UseMoles, true);
  * which is \f$ \unit[30]{K} \f$ higher than the initial and inlet temperature.
  */
 template <class TypeTag>
+#if LOWREKEPSILON
+class ChannelNCTestProblem : public LowReKEpsilonProblem<TypeTag>
+{
+    using ParentType = LowReKEpsilonProblem<TypeTag>;
+#else
 class ChannelNCTestProblem : public ZeroEqProblem<TypeTag>
 {
     using ParentType = ZeroEqProblem<TypeTag>;
+#endif
 
     using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes);
     using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem);
+    using FluidState = typename GET_PROP_TYPE(TypeTag, FluidState);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
     using Indices = typename GET_PROP_TYPE(TypeTag, ModelTraits)::Indices;
     using NumEqVector = typename GET_PROP_TYPE(TypeTag, NumEqVector);
@@ -98,12 +119,34 @@ class ChannelNCTestProblem : public ZeroEqProblem<TypeTag>
 
     using TimeLoopPtr = std::shared_ptr<CheckPointTimeLoop<Scalar>>;
 
+    static const unsigned int phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+
 public:
     ChannelNCTestProblem(std::shared_ptr<const FVGridGeometry> fvGridGeometry)
     : ParentType(fvGridGeometry), eps_(1e-6)
     {
         inletVelocity_ = getParam<Scalar>("Problem.InletVelocity");
+
         FluidSystem::init();
+        Dumux::TurbulenceProperties<Scalar, dimWorld, true> turbulenceProperties;
+        FluidState fluidState;
+        fluidState.setPressure(phaseIdx, 1e5);
+        fluidState.setTemperature(temperature());
+        fluidState.setMassFraction(phaseIdx, phaseIdx, 1.0);
+        Scalar density = FluidSystem::density(fluidState, phaseIdx);
+        Scalar kinematicViscosity = FluidSystem::viscosity(fluidState, phaseIdx) / density;
+        Scalar diameter = this->fvGridGeometry().bBoxMax()[1] - this->fvGridGeometry().bBoxMin()[1];
+        turbulentKineticEnergy_ = turbulenceProperties.turbulentKineticEnergy(inletVelocity_, diameter, kinematicViscosity);
+        dissipation_ = turbulenceProperties.dissipation(inletVelocity_, diameter, kinematicViscosity);
+#if LOWREKEPSILON
+        std::cout << Indices::momentumXBalanceIdx
+                  << Indices::momentumYBalanceIdx
+                  << Indices::conti0EqIdx
+                  << Indices::conti0EqIdx + 1
+                  << Indices::turbulentKineticEnergyEqIdx
+                  << Indices::dissipationEqIdx
+                  << std::endl;
+#endif
     }
 
    /*!
@@ -158,6 +201,10 @@ public:
 #if NONISOTHERMAL
         values.setOutflow(Indices::energyBalanceIdx);
 #endif
+#if LOWREKEPSILON
+        values.setDirichlet(Indices::turbulentKineticEnergyIdx);
+        values.setDirichlet(Indices::dissipationIdx);
+#endif
 
         if(isInlet_(globalPos))
         {
@@ -175,6 +222,10 @@ public:
             values.setOutflow(transportEqIdx);
 #if NONISOTHERMAL
             values.setOutflow(Indices::energyBalanceIdx);
+#endif
+#if LOWREKEPSILON
+            values.setOutflow(Indices::turbulentKineticEnergyEqIdx);
+            values.setOutflow(Indices::dissipationEqIdx);
 #endif
         }
         else if (isOnWall(globalPos))
@@ -244,6 +295,16 @@ public:
             values[Indices::velocityXIdx] =  inletVelocity_;
         values[Indices::velocityYIdx] = 0.0;
 
+#if LOWREKEPSILON
+        values[Indices::turbulentKineticEnergyEqIdx] = turbulentKineticEnergy_;
+        values[Indices::dissipationEqIdx] = dissipation_;
+        if (isOnWall(globalPos))
+        {
+            values[Indices::turbulentKineticEnergyEqIdx] = 0.0;
+            values[Indices::dissipationEqIdx] = 0.0;
+        }
+#endif
+
         return values;
     }
 
@@ -279,6 +340,8 @@ private:
 
     const Scalar eps_;
     Scalar inletVelocity_;
+    Scalar turbulentKineticEnergy_;
+    Scalar dissipation_;
     TimeLoopPtr timeLoop_;
 };
 } //end namespace
diff --git a/test/freeflow/ransnc/test_channel.cc b/test/freeflow/ransnc/test_channel.cc
index da76773a4e2b33670a271084d507e40d90259393..2d38f3d3cf885de6f6c4812a1cb3a9e27374f6cc 100644
--- a/test/freeflow/ransnc/test_channel.cc
+++ b/test/freeflow/ransnc/test_channel.cc
@@ -21,16 +21,18 @@
  *
  * \brief Test for the staggered grid multi-component (Navier-)Stokes model
  */
- #include <config.h>
+#include <config.h>
 
- #include <ctime>
- #include <iostream>
+#define IS_TURBULENT 1
 
- #include <dune/common/parallel/mpihelper.hh>
- #include <dune/common/timer.hh>
- #include <dune/grid/io/file/dgfparser/dgfexception.hh>
- #include <dune/grid/io/file/vtk.hh>
- #include <dune/istl/io.hh>
+#include <ctime>
+#include <iostream>
+
+#include <dune/common/parallel/mpihelper.hh>
+#include <dune/common/timer.hh>
+#include <dune/grid/io/file/dgfparser/dgfexception.hh>
+#include <dune/grid/io/file/vtk.hh>
+#include <dune/istl/io.hh>
 
 #include "channeltestproblem.hh"
 
diff --git a/test/freeflow/ransnc/test_channel2c.input b/test/freeflow/ransnc/test_channel2c.input
index d8216571731ca69c673512063629a74ed6246369..c1f9cf4758d5669095dd6bb89758db548423b310 100644
--- a/test/freeflow/ransnc/test_channel2c.input
+++ b/test/freeflow/ransnc/test_channel2c.input
@@ -1,5 +1,5 @@
 [TimeLoop]
-DtInitial = 1 # [s]
+DtInitial = 1e-3 # [s]
 TEnd = 1000 # [s]
 
 [Grid]
diff --git a/test/freeflow/ransnc/test_channel2cni.input b/test/freeflow/ransnc/test_channel2cni.input
index 69087375b65be3034fbfd68b70d61783d22b3ffa..20ee8f10e08e7a88b9e15bc6f0b52b340f079b06 100644
--- a/test/freeflow/ransnc/test_channel2cni.input
+++ b/test/freeflow/ransnc/test_channel2cni.input
@@ -1,5 +1,5 @@
 [TimeLoop]
-DtInitial = 1 # [s]
+DtInitial = 1e-3 # [s]
 TEnd = 1000 # [s]
 
 [Grid]
diff --git a/test/references/test_channel_lowrekepsilon2cni.vtu b/test/references/test_channel_lowrekepsilon2cni.vtu
new file mode 100644
index 0000000000000000000000000000000000000000..4c271d9ddb5ebae814b09f13c1d1c636628f5399
--- /dev/null
+++ b/test/references/test_channel_lowrekepsilon2cni.vtu
@@ -0,0 +1,735 @@
+<?xml version="1.0"?>
+<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
+  <UnstructuredGrid>
+    <Piece NumberOfCells="200" NumberOfPoints="231">
+      <CellData Scalars="p" Vectors="dv_x/dx_">
+        <DataArray type="Float32" Name="p" NumberOfComponents="1" format="ascii">
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000 100000
+          100000 100000 100000 100000 100000 100000 100000 100000
+        </DataArray>
+        <DataArray type="Float32" Name="rhoMolar" NumberOfComponents="1" format="ascii">
+          38.4438 38.4221 38.4181 38.4164 38.4154 38.4148 38.4144 38.4141 38.4139 38.4138 38.5298 38.4577
+          38.4442 38.4384 38.4352 38.4331 38.4317 38.4307 38.43 38.4296 38.6469 38.5078 38.4809 38.4693
+          38.4629 38.4588 38.456 38.454 38.4526 38.4517 38.8049 38.5781 38.5323 38.5127 38.5017 38.4947
+          38.49 38.4867 38.4843 38.4827 39.0149 38.6768 38.6045 38.5735 38.5562 38.5452 38.5377 38.5324
+          38.5287 38.5262 39.2884 38.8155 38.706 38.659 38.6327 38.616 38.6047 38.5967 38.591 38.5873
+          39.6338 39.0098 38.8487 38.7792 38.7403 38.7156 38.6988 38.687 38.6786 38.6731 40.0492 39.2794
+          39.0495 38.9484 38.8917 38.8557 38.8312 38.814 38.8017 38.7937 40.512 39.6442 39.3302 39.1861
+          39.1046 39.0527 39.0174 38.9925 38.9748 38.9631 40.9777 40.1105 39.7147 39.5169 39.4021 39.3283
+          39.2779 39.2422 39.2166 39.1996 41.4004 40.6488 40.2115 39.9609 39.8067 39.7049 39.6341 39.5834
+          39.5466 39.5215 41.7516 41.1897 40.7837 40.508 40.3203 40.1888 40.0939 40.0237 39.9712 39.9338
+          42.022 41.658 41.3463 41.0954 40.9 40.7492 40.6326 40.5416 40.4702 40.4163 42.2157 42.0098
+          41.8127 41.6294 41.4649 41.3212 41.1979 41.0934 41.0056 40.9349 42.3455 42.2429 42.139 42.0326
+          41.9258 41.8208 41.7197 41.624 41.5352 41.4577 42.4267 42.3827 42.3351 42.2833 42.2278 42.1694
+          42.1086 42.0461 41.9829 41.9231 42.4721 42.4529 42.4296 42.4043 42.3777 42.3499 42.321 42.2909
+          42.2596 42.2293 42.4386 42.4242 42.4166 42.4108 42.4052 42.399 42.392 42.384 42.3751 42.366
+          42.4833 42.4824 42.4792 42.4752 42.471 42.4667 42.4623 42.458 42.4538 42.4497 42.4785 42.4805
+          42.4822 42.4836 42.4846 42.4853 42.4858 42.4859 42.4858 42.4854
+        </DataArray>
+        <DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii">
+          1.11333 1.1127 1.11259 1.11253 1.1125 1.11248 1.11247 1.11246 1.11245 1.11244 1.11582 1.11374
+          1.11334 1.11317 1.11308 1.11301 1.11297 1.11294 1.11291 1.1129 1.11921 1.11518 1.1144 1.11407
+          1.11388 1.11376 1.11367 1.11361 1.11357 1.11354 1.12379 1.11722 1.11589 1.11532 1.115 1.1148
+          1.11466 1.11456 1.11449 1.11444 1.12987 1.12008 1.11798 1.11708 1.11658 1.11626 1.11604 1.11588
+          1.11577 1.1157 1.13779 1.1241 1.12092 1.11956 1.1188 1.11831 1.11798 1.11774 1.11758 1.11746
+          1.14779 1.12972 1.12506 1.12304 1.12191 1.12119 1.1207 1.12036 1.12011 1.11995 1.15983 1.13753
+          1.13087 1.12794 1.1263 1.12525 1.12454 1.12404 1.12368 1.12344 1.17323 1.14809 1.139 1.13483
+          1.13246 1.13096 1.12993 1.12921 1.12869 1.12835 1.18671 1.1616 1.15014 1.1444 1.14108 1.13894
+          1.13747 1.13644 1.13569 1.1352 1.19895 1.17719 1.16452 1.15726 1.1528 1.14984 1.14779 1.14632
+          1.14525 1.14452 1.20913 1.19285 1.18109 1.17311 1.16767 1.16386 1.1611 1.15907 1.15755 1.15646
+          1.21695 1.20641 1.19738 1.19012 1.18445 1.18008 1.1767 1.17406 1.17199 1.17043 1.22256 1.2166
+          1.21089 1.20557 1.20081 1.19664 1.19307 1.19004 1.18749 1.18544 1.22632 1.22334 1.22033 1.21724
+          1.21414 1.2111 1.20817 1.20539 1.20282 1.20057 1.22866 1.22737 1.22599 1.22448 1.22287 1.22117
+          1.21941 1.2176 1.21576 1.21403 1.22993 1.22935 1.22867 1.22793 1.22716 1.22636 1.22552 1.22465
+          1.22375 1.22287 1.22871 1.22836 1.22818 1.22804 1.2279 1.22773 1.22754 1.22732 1.22707 1.22681
+          1.23027 1.23022 1.23012 1.23 1.22987 1.22975 1.22962 1.2295 1.22937 1.22926 1.23017 1.23023
+          1.23027 1.23031 1.23033 1.23035 1.23036 1.23036 1.23035 1.23034
+        </DataArray>
+        <DataArray type="Float32" Name="v_x/v_x,max" NumberOfComponents="1" format="ascii">
+          0.496333 0.00672405 0.00388315 0.00316563 0.00281142 0.00259848 0.00245873 0.00236337 0.00229818 0.00226187 0.50726 0.022689
+          0.0131954 0.0107569 0.00955332 0.00882981 0.00835505 0.0080311 0.00780968 0.00768634 0.522233 0.0447171 0.0262218 0.0213749
+          0.018983 0.0175455 0.0166022 0.0159587 0.0155189 0.0152739 0.54257 0.0749331 0.044436 0.0362205 0.032167 0.0297311
+          0.0281331 0.0270431 0.0262983 0.0258834 0.569843 0.116034 0.0698849 0.0569648 0.0505893 0.0467589 0.0442465 0.042533
+          0.0413627 0.0407105 0.605735 0.171257 0.105386 0.0859239 0.0763086 0.0705326 0.0667448 0.0641621 0.0623989 0.061416
+          0.651622 0.244057 0.154735 0.12628 0.112163 0.10368 0.0981173 0.0943253 0.0917378 0.0902945 0.707592 0.337099
+          0.222757 0.182313 0.162006 0.149781 0.141761 0.136293 0.132564 0.130481 0.770808 0.450049 0.314676 0.259423
+          0.230863 0.213554 0.202171 0.1944 0.189094 0.186123 0.834649 0.576745 0.433408 0.363096 0.324441 0.300552
+          0.284705 0.273825 0.266357 0.262142 0.891155 0.704063 0.573295 0.494359 0.446068 0.414768 0.393479 0.378603
+          0.368208 0.362219 0.935133 0.815342 0.715093 0.64118 0.588959 0.551992 0.525411 0.506043 0.491944 0.483489
+          0.965536 0.898738 0.834569 0.778475 0.732163 0.695111 0.665903 0.643025 0.625253 0.614003 0.984243 0.952345
+          0.917997 0.884021 0.851757 0.822201 0.795926 0.773125 0.753787 0.740737 0.994342 0.98187 0.966338 0.949951
+          0.93294 0.915587 0.898253 0.881329 0.865271 0.853492 0.998817 0.995489 0.989644 0.983253 0.976409 0.969085
+          0.961301 0.9531 0.944584 0.937811 1 1 0.998519 0.996693 0.994747 0.99265 0.990395 0.987982
+          0.98534 0.983089 0.99937 0.999681 1 1 1 1 1 1 0.999857 0.999636
+          0.998387 0.998046 0.998818 0.999077 0.999275 0.999473 0.999688 0.999923 1 1 0.996521 0.993313
+          0.991816 0.989564 0.987161 0.98475 0.982385 0.980085 0.977682 0.975899
+        </DataArray>
+        <DataArray type="Float32" Name="p_rel" NumberOfComponents="1" format="ascii">
+          0.00156383 0.00103285 0.000837012 0.000684173 0.000553568 0.000437054 0.0003302 0.000230317 0.00013561 4.50275e-05 0.00156372 0.00103289
+          0.00083702 0.000684176 0.000553569 0.000437055 0.000330201 0.000230318 0.00013561 4.50276e-05 0.00156355 0.00103294 0.000837031 0.000684181
+          0.000553572 0.000437057 0.000330202 0.000230318 0.000135611 4.50278e-05 0.00156333 0.001033 0.000837046 0.000684188 0.000553576 0.000437059
+          0.000330204 0.000230319 0.000135611 4.5028e-05 0.001563 0.00103309 0.000837067 0.000684197 0.000553582 0.000437063 0.000330206 0.000230321
+          0.000135612 4.50284e-05 0.00156255 0.00103322 0.000837097 0.000684211 0.000553589 0.000437067 0.000330209 0.000230323 0.000135614 4.50289e-05
+          0.00156194 0.00103338 0.00083714 0.000684229 0.0005536 0.000437074 0.000330214 0.000230326 0.000135616 4.50296e-05 0.00156115 0.00103361
+          0.000837201 0.000684256 0.000553615 0.000437084 0.00033022 0.00023033 0.000135618 4.50307e-05 0.00156013 0.00103394 0.000837291 0.000684296
+          0.000553637 0.000437098 0.000330229 0.000230337 0.000135622 4.50324e-05 0.00155865 0.00103444 0.000837428 0.000684356 0.000553671 0.000437119
+          0.000330244 0.000230347 0.000135629 4.50357e-05 0.00155628 0.00103525 0.000837661 0.000684457 0.000553729 0.000437157 0.000330271 0.000230367
+          0.000135644 4.50441e-05 0.00155254 0.00103659 0.000838075 0.000684646 0.000553841 0.000437235 0.000330329 0.000230412 0.000135682 4.50678e-05
+          0.00154694 0.00103875 0.000838766 0.000684974 0.000554047 0.000437386 0.000330449 0.000230512 0.000135768 4.51305e-05 0.00153901 0.00104204
+          0.00083984 0.000685474 0.000554359 0.00043762 0.000330643 0.000230682 0.000135925 4.5276e-05 0.00152837 0.00104675 0.000841429 0.0006862
+          0.000554786 0.000437922 0.000330888 0.000230901 0.00013614 4.55782e-05 0.00151477 0.00105307 0.000843665 0.000687221 0.000555371 0.000438312
+          0.000331178 0.00023114 0.000136381 4.61488e-05 0.0014981 0.00106098 0.000846665 0.000688595 0.000556152 0.000438824 0.000331545 0.000231428
+          0.000136681 4.70824e-05 0.00147891 0.00107005 0.000850406 0.000690324 0.00055714 0.000439473 0.00033201 0.000231791 0.000137074 4.82831e-05
+          0.0014586 0.00107939 0.000854638 0.000692312 0.000558286 0.000440233 0.00033256 0.000232226 0.00013755 4.94376e-05 0.0014432 0.0010867
+          0.000858255 0.000694046 0.000559297 0.000440913 0.000333059 0.000232626 0.000137976 4.99823e-05
+        </DataArray>
+        <DataArray type="Float32" Name="nu" NumberOfComponents="1" format="ascii">
+          1.71781e-05 1.71954e-05 1.71985e-05 1.71999e-05 1.72006e-05 1.72011e-05 1.72014e-05 1.72016e-05 1.72018e-05 1.72019e-05 1.71101e-05 1.71671e-05
+          1.71778e-05 1.71824e-05 1.71849e-05 1.71866e-05 1.71877e-05 1.71884e-05 1.7189e-05 1.71893e-05 1.7018e-05 1.71274e-05 1.71487e-05 1.71578e-05
+          1.7163e-05 1.71662e-05 1.71684e-05 1.71699e-05 1.7171e-05 1.71717e-05 1.68949e-05 1.7072e-05 1.71081e-05 1.71235e-05 1.71322e-05 1.71377e-05
+          1.71414e-05 1.71441e-05 1.71459e-05 1.71471e-05 1.67334e-05 1.69946e-05 1.70512e-05 1.70756e-05 1.70892e-05 1.70979e-05 1.71037e-05 1.71079e-05
+          1.71108e-05 1.71127e-05 1.65265e-05 1.68867e-05 1.69718e-05 1.70085e-05 1.70291e-05 1.70421e-05 1.7051e-05 1.70573e-05 1.70617e-05 1.70646e-05
+          1.62707e-05 1.67373e-05 1.6861e-05 1.69148e-05 1.69451e-05 1.69643e-05 1.69773e-05 1.69865e-05 1.69931e-05 1.69974e-05 1.59707e-05 1.65333e-05
+          1.6707e-05 1.67843e-05 1.68279e-05 1.68556e-05 1.68745e-05 1.68878e-05 1.68973e-05 1.69035e-05 1.56463e-05 1.62631e-05 1.64952e-05 1.66034e-05
+          1.66651e-05 1.67045e-05 1.67314e-05 1.67504e-05 1.6764e-05 1.67729e-05 1.53296e-05 1.59272e-05 1.62116e-05 1.63566e-05 1.64416e-05 1.64966e-05
+          1.65344e-05 1.65612e-05 1.65804e-05 1.65932e-05 1.50504e-05 1.55522e-05 1.58558e-05 1.60338e-05 1.61448e-05 1.62187e-05 1.62704e-05 1.63076e-05
+          1.63346e-05 1.63531e-05 1.48241e-05 1.51885e-05 1.54603e-05 1.5649e-05 1.57794e-05 1.58718e-05 1.59389e-05 1.59888e-05 1.60263e-05 1.60531e-05
+          1.46533e-05 1.48839e-05 1.50856e-05 1.5251e-05 1.53817e-05 1.54836e-05 1.55632e-05 1.56258e-05 1.5675e-05 1.57124e-05 1.45328e-05 1.46609e-05
+          1.47852e-05 1.49022e-05 1.50083e-05 1.5102e-05 1.5183e-05 1.52522e-05 1.53108e-05 1.53581e-05 1.44528e-05 1.45159e-05 1.45802e-05 1.46466e-05
+          1.47136e-05 1.47799e-05 1.48443e-05 1.49056e-05 1.49627e-05 1.50129e-05 1.44031e-05 1.443e-05 1.44591e-05 1.44909e-05 1.45251e-05 1.45613e-05
+          1.4599e-05 1.4638e-05 1.46776e-05 1.47152e-05 1.43752e-05 1.43869e-05 1.4401e-05 1.44165e-05 1.44327e-05 1.44497e-05 1.44675e-05 1.4486e-05
+          1.45053e-05 1.4524e-05 1.43946e-05 1.44036e-05 1.44085e-05 1.44121e-05 1.44156e-05 1.44195e-05 1.44238e-05 1.44287e-05 1.44342e-05 1.44398e-05
+          1.43685e-05 1.43689e-05 1.43708e-05 1.43732e-05 1.43758e-05 1.43785e-05 1.43811e-05 1.43837e-05 1.43863e-05 1.43888e-05 1.43716e-05 1.43704e-05
+          1.43693e-05 1.43685e-05 1.43678e-05 1.43674e-05 1.43671e-05 1.4367e-05 1.43671e-05 1.43672e-05
+        </DataArray>
+        <DataArray type="Float32" Name="nu_t" NumberOfComponents="1" format="ascii">
+          9.90596e-12 1.97815e-13 1.00238e-13 8.22561e-14 7.97086e-14 8.29902e-14 8.94253e-14 9.79957e-14 1.08309e-13 1.21154e-13 3.13268e-10 8.98356e-12
+          4.5234e-12 3.70442e-12 3.58582e-12 3.73093e-12 4.01841e-12 4.40217e-12 4.86445e-12 5.44071e-12 2.23556e-09 7.36652e-11 3.66669e-11 2.99167e-11
+          2.89012e-11 3.00334e-11 3.23205e-11 3.53868e-11 3.90875e-11 4.37084e-11 1.07092e-08 3.82568e-10 1.87479e-10 1.52173e-10 1.46596e-10 1.5207e-10
+          1.63456e-10 1.78816e-10 1.97406e-10 2.20673e-10 4.28976e-08 1.63292e-09 7.84701e-10 6.32546e-10 6.07064e-10 6.28218e-10 6.74156e-10 7.3667e-10
+          8.1262e-10 9.07994e-10 1.54605e-07 6.35174e-09 2.98528e-09 2.38556e-09 2.27826e-09 2.35021e-09 2.51661e-09 2.7458e-09 3.02568e-09 3.3787e-09
+          5.12978e-07 2.36587e-08 1.08956e-08 8.61936e-09 8.1825e-09 8.40759e-09 8.97811e-09 9.77652e-09 1.07581e-08 1.20032e-08 1.55833e-06 8.6037e-08
+          3.93001e-08 3.07887e-08 2.90368e-08 2.96995e-08 3.16107e-08 3.43387e-08 3.77196e-08 4.2037e-08 4.18665e-06 3.03042e-07 1.41539e-07 1.1036e-07
+          1.03492e-07 1.0537e-07 1.11747e-07 1.21046e-07 1.32664e-07 1.47599e-07 9.55022e-06 9.91771e-07 5.00312e-07 3.94178e-07 3.69191e-07 3.7464e-07
+          3.95858e-07 4.27249e-07 4.66617e-07 5.17358e-07 1.86516e-05 2.77162e-06 1.60981e-06 1.32397e-06 1.25321e-06 1.27171e-06 1.33798e-06 1.43489e-06
+          1.55528e-06 1.70923e-06 3.25042e-05 6.36711e-06 4.14726e-06 3.61874e-06 3.51733e-06 3.60431e-06 3.79804e-06 4.06258e-06 4.38155e-06 4.77864e-06
+          5.20885e-05 1.27179e-05 8.57717e-06 7.62097e-06 7.52805e-06 7.81044e-06 8.29713e-06 8.91352e-06 9.62462e-06 1.04637e-05 7.63532e-05 2.36271e-05
+          1.58879e-05 1.35021e-05 1.28628e-05 1.31099e-05 1.38692e-05 1.49452e-05 1.62311e-05 1.77051e-05 9.99666e-05 4.06581e-05 2.84383e-05 2.3345e-05
+          2.07381e-05 1.96534e-05 1.96486e-05 2.04528e-05 2.18767e-05 2.37401e-05 0.000116559 6.18804e-05 4.66575e-05 3.94514e-05 3.46853e-05 3.13598e-05
+          2.91608e-05 2.79635e-05 2.76958e-05 2.82464e-05 0.000124782 8.27415e-05 6.67286e-05 5.89069e-05 5.34834e-05 4.9298e-05 4.59068e-05 4.31118e-05
+          4.08497e-05 3.92216e-05 0.000127693 9.98406e-05 8.49721e-05 7.73822e-05 7.20723e-05 6.79742e-05 6.46616e-05 6.191e-05 5.95888e-05 5.77028e-05
+          0.000128751 0.000112465 0.000100336 9.36844e-05 8.90498e-05 8.55789e-05 8.29061e-05 8.08306e-05 7.92323e-05 7.8068e-05 0.000129995 0.000122289
+          0.000115173 0.000111458 0.000109263 0.000107991 0.000107365 0.00010724 0.000107529 0.000108138
+        </DataArray>
+        <DataArray type="Float32" Name="l_w" NumberOfComponents="1" format="ascii">
+          0.000119663 0.000119663 0.000119663 0.000119663 0.000119663 0.000119663 0.000119663 0.000119663 0.000119663 0.000119663 0.000406853 0.000406853
+          0.000406853 0.000406853 0.000406853 0.000406853 0.000406853 0.000406853 0.000406853 0.000406853 0.00080892 0.00080892 0.00080892 0.00080892
+          0.00080892 0.00080892 0.00080892 0.00080892 0.00080892 0.00080892 0.00137181 0.00137181 0.00137181 0.00137181 0.00137181 0.00137181
+          0.00137181 0.00137181 0.00137181 0.00137181 0.00215986 0.00215986 0.00215986 0.00215986 0.00215986 0.00215986 0.00215986 0.00215986
+          0.00215986 0.00215986 0.00326313 0.00326313 0.00326313 0.00326313 0.00326313 0.00326313 0.00326313 0.00326313 0.00326313 0.00326313
+          0.00480771 0.00480771 0.00480771 0.00480771 0.00480771 0.00480771 0.00480771 0.00480771 0.00480771 0.00480771 0.00697012 0.00697012
+          0.00697012 0.00697012 0.00697012 0.00697012 0.00697012 0.00697012 0.00697012 0.00697012 0.0099975 0.0099975 0.0099975 0.0099975
+          0.0099975 0.0099975 0.0099975 0.0099975 0.0099975 0.0099975 0.0142358 0.0142358 0.0142358 0.0142358 0.0142358 0.0142358
+          0.0142358 0.0142358 0.0142358 0.0142358 0.0201695 0.0201695 0.0201695 0.0201695 0.0201695 0.0201695 0.0201695 0.0201695
+          0.0201695 0.0201695 0.0284766 0.0284766 0.0284766 0.0284766 0.0284766 0.0284766 0.0284766 0.0284766 0.0284766 0.0284766
+          0.0401066 0.0401066 0.0401066 0.0401066 0.0401066 0.0401066 0.0401066 0.0401066 0.0401066 0.0401066 0.0563885 0.0563885
+          0.0563885 0.0563885 0.0563885 0.0563885 0.0563885 0.0563885 0.0563885 0.0563885 0.0791832 0.0791832 0.0791832 0.0791832
+          0.0791832 0.0791832 0.0791832 0.0791832 0.0791832 0.0791832 0.111096 0.111096 0.111096 0.111096 0.111096 0.111096
+          0.111096 0.111096 0.111096 0.111096 0.155774 0.155774 0.155774 0.155774 0.155774 0.155774 0.155774 0.155774
+          0.155774 0.155774 0.218322 0.218322 0.218322 0.218322 0.218322 0.218322 0.218322 0.218322 0.218322 0.218322
+          0.30589 0.30589 0.30589 0.30589 0.30589 0.30589 0.30589 0.30589 0.30589 0.30589 0.428486 0.428486
+          0.428486 0.428486 0.428486 0.428486 0.428486 0.428486 0.428486 0.428486
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          0.325086 0.0695351 0.0533783 0.0484353 0.0458318 0.0442162 0.0431431 0.0424141 0.0419304 0.0416754 1.10969 0.236809
+          0.181706 0.164848 0.15597 0.150462 0.146804 0.144319 0.14267 0.1418 2.21827 0.471923 0.361886 0.328225
+          0.310503 0.299509 0.292208 0.287249 0.283957 0.28222 3.78927 0.802912 0.615165 0.557738 0.527514 0.50877
+          0.496323 0.487868 0.482257 0.479292 6.02363 1.26991 0.971781 0.880603 0.83264 0.802904 0.783163 0.769753
+          0.760852 0.756142 9.21445 1.93084 1.47504 1.33567 1.2624 1.217 1.18687 1.1664 1.15281 1.14561
+          13.7895 2.87019 2.18752 1.97879 1.86917 1.80129 1.75625 1.72566 1.70534 1.69455 20.3672 4.21249
+          3.20066 2.89112 2.72875 2.6283 2.56169 2.51646 2.48639 2.47037 29.8192 6.14252 4.64977 4.19202
+          3.95218 3.80397 3.70575 3.63905 3.59468 3.57093 43.338 8.93101 6.73681 6.05925 5.70416 5.48489
+          5.33966 5.24101 5.1753 5.13989 62.5408 12.9587 9.75897 8.75764 8.2303 7.90422 7.68805 7.54102
+          7.44278 7.38921 89.6471 18.734 14.1308 12.6687 11.8891 11.4036 11.0802 10.8592 10.7104 10.6276
+          127.731 26.9251 20.3962 18.3082 17.1777 16.4635 15.9821 15.6494 15.4225 15.2924 181.074 38.4314
+          29.2591 26.3433 24.752 23.7321 23.0329 22.5412 22.1991 21.9961 255.679 54.5063 41.6645 37.638
+          35.4541 34.0517 33.0819 32.3895 31.898 31.5979 359.962 76.929 58.9461 53.3742 50.3885 48.4929
+          47.1945 46.2741 45.6232 45.23 505.702 108.189 82.9846 75.2253 71.1045 68.5193 66.7756 65.5642
+          64.7309 64.2545 707.806 151.455 116.246 105.463 99.7739 96.2339 93.8718 92.2554 91.1695 90.5802
+          993.506 212.715 163.298 148.163 140.18 135.218 131.914 129.663 128.162 127.361 1391.38 297.938
+          228.77 207.614 196.471 189.557 184.963 181.841 179.768 178.673
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          1.08148 0.0700645 0.0534077 0.0484634 0.0458583 0.0442414 0.0431671 0.0424372 0.0419527 0.0416972 1.10529 0.236419
+          0.181486 0.16468 0.155828 0.150335 0.146687 0.144208 0.142564 0.141696 1.13792 0.465952 0.360647 0.327233
+          0.30964 0.298726 0.291479 0.286557 0.283293 0.281572 1.18223 0.780802 0.61116 0.554508 0.524689 0.506198
+          0.493923 0.485591 0.480068 0.477155 1.24166 1.20908 0.961177 0.872089 0.825182 0.79611 0.776819 0.76373
+          0.755064 0.750491 1.31987 1.7845 1.44945 1.31543 1.2447 1.20088 1.17181 1.15211 1.13908 1.13219
+          1.41985 2.54307 2.12818 1.93325 1.82954 1.76524 1.72261 1.69372 1.67465 1.66456 1.54181 3.51256
+          3.06374 2.79107 2.64255 2.55015 2.48885 2.44731 2.41991 2.40539 1.67955 4.6895 4.32797 3.97158
+          3.7657 3.63594 3.54944 3.49068 3.45186 3.43114 1.81866 6.00967 5.96096 5.55872 5.2921 5.11715
+          4.99845 4.91685 4.86228 4.83254 1.94178 7.33632 7.88493 7.56827 7.276 7.06178 6.90817 6.79827
+          6.72154 6.67744 2.03761 8.49585 9.83518 9.81599 9.60675 9.39814 9.22444 9.0866 8.9803 8.91303
+          2.10385 9.36483 11.4784 11.9179 11.9426 11.8349 11.691 11.5463 11.4138 11.319 2.14462 9.92342
+          12.6259 13.5337 13.8934 13.9987 13.9738 13.8824 13.7602 13.6554 2.16662 10.2311 13.2907 14.543
+          15.2176 15.5886 15.7703 15.8253 15.7953 15.734 2.17637 10.373 13.6113 15.0529 15.9266 16.4995
+          16.8772 17.1141 17.2431 17.2884 2.17895 10.42 13.7333 15.2586 16.2257 16.9007 17.388 17.7404
+          17.9871 18.1231 2.17758 10.4167 13.7537 15.3092 16.3114 17.0259 17.5566 17.9562 18.2521 18.4281
+          2.17543 10.3996 13.7374 15.2951 16.2996 17.0169 17.5511 17.9548 18.2547 18.4348 2.17137 10.3503
+          13.6411 15.1495 16.102 16.7662 17.2474 17.5986 17.8473 17.9905
+        </DataArray>
+        <DataArray type="Float32" Name="k" NumberOfComponents="1" format="ascii">
+          1.22859e-08 1.45722e-09 8.2727e-10 6.6987e-10 6.29009e-10 6.33421e-10 6.61343e-10 7.04103e-10 7.58117e-10 8.29137e-10 1.25971e-07 1.89613e-08
+          1.0762e-08 8.71349e-09 8.1815e-09 8.23857e-09 8.60151e-09 9.15747e-09 9.85983e-09 1.07834e-08 4.26342e-07 7.44842e-08 4.22599e-08 3.42084e-08
+          3.21154e-08 3.23364e-08 3.37585e-08 3.59387e-08 3.86936e-08 4.23169e-08 1.06942e-06 2.13115e-07 1.20863e-07 9.77973e-08 9.17888e-08 9.24025e-08
+          9.64527e-08 1.02671e-07 1.10532e-07 1.20875e-07 2.32995e-06 5.27626e-07 2.99214e-07 2.41952e-07 2.26975e-07 2.28408e-07 2.38353e-07 2.53664e-07
+          2.73041e-07 2.98554e-07 4.68019e-06 1.2083e-06 6.86392e-07 5.54524e-07 5.19763e-07 5.22702e-07 5.4518e-07 5.79965e-07 6.24065e-07 6.82213e-07
+          8.86831e-06 2.64086e-06 1.51133e-06 1.22003e-06 1.14214e-06 1.14735e-06 1.19563e-06 1.27099e-06 1.36683e-06 1.4935e-06 1.5751e-05 5.56696e-06
+          3.25887e-06 2.6339e-06 2.46251e-06 2.46997e-06 2.5703e-06 2.729e-06 2.93172e-06 3.20069e-06 2.51991e-05 1.11681e-05 6.92144e-06 5.64493e-06
+          5.27933e-06 5.28749e-06 5.49207e-06 5.82037e-06 6.24176e-06 6.80368e-06 3.45208e-05 2.03169e-05 1.41511e-05 1.19071e-05 1.12207e-05 1.12472e-05
+          1.16648e-05 1.23322e-05 1.31876e-05 1.43318e-05 4.02606e-05 3.09305e-05 2.57019e-05 2.32893e-05 2.25608e-05 2.28306e-05 2.37216e-05 2.50312e-05
+          2.66612e-05 2.88175e-05 4.19506e-05 3.74977e-05 3.64265e-05 3.6743e-05 3.77522e-05 3.93376e-05 4.14088e-05 4.38686e-05 4.66522e-05 5.01303e-05
+          4.15891e-05 3.80821e-05 3.88293e-05 4.1862e-05 4.57573e-05 4.99275e-05 5.41818e-05 5.84637e-05 6.27682e-05 6.7532e-05 4.1053e-05 3.61992e-05
+          3.50877e-05 3.67609e-05 4.0268e-05 4.49364e-05 5.02751e-05 5.59178e-05 6.16189e-05 6.73951e-05 4.1063e-05 3.50524e-05 3.16227e-05 3.0343e-05
+          3.07729e-05 3.25917e-05 3.55754e-05 3.95364e-05 4.42707e-05 4.93399e-05 4.15035e-05 3.51967e-05 3.06256e-05 2.74852e-05 2.55308e-05 2.45771e-05
+          2.44969e-05 2.52117e-05 2.66641e-05 2.85522e-05 4.19969e-05 3.58641e-05 3.10863e-05 2.73521e-05 2.445e-05 2.22302e-05 2.0585e-05 1.94385e-05
+          1.8731e-05 1.83204e-05 4.22814e-05 3.63817e-05 3.17287e-05 2.79901e-05 2.49478e-05 2.24514e-05 2.03935e-05 1.86958e-05 1.72986e-05 1.61427e-05
+          4.24642e-05 3.6734e-05 3.22536e-05 2.8686e-05 2.58071e-05 2.34611e-05 2.15364e-05 1.9951e-05 1.86441e-05 1.75676e-05 4.29718e-05 3.80774e-05
+          3.4586e-05 3.20762e-05 3.028e-05 2.90174e-05 2.81634e-05 2.76285e-05 2.73463e-05 2.72411e-05
+        </DataArray>
+        <DataArray type="Float32" Name="epsilon" NumberOfComponents="1" format="ascii">
+          5.11729e-09 7.72253e-10 3.77083e-10 2.73417e-10 2.35448e-10 2.21292e-10 2.18517e-10 2.22328e-10 2.30742e-10 2.45464e-10 5.78089e-08 9.79565e-09
+          4.81038e-09 3.49389e-09 3.01138e-09 2.83188e-09 2.79738e-09 2.84687e-09 2.9551e-09 3.1439e-09 1.84313e-07 3.66858e-08 1.82052e-08 1.32641e-08
+          1.14508e-08 1.07789e-08 1.06546e-08 1.08478e-08 1.12634e-08 1.19847e-08 4.09834e-07 9.82027e-08 4.94353e-08 3.61682e-08 3.12902e-08 2.94923e-08
+          2.91766e-08 2.97223e-08 3.08719e-08 3.28544e-08 7.62258e-07 2.22451e-07 1.14117e-07 8.3931e-08 7.28005e-08 6.87236e-08 6.80547e-08 6.93715e-08
+          7.20826e-08 7.67235e-08 1.28205e-06 4.54285e-07 2.38908e-07 1.76844e-07 1.53847e-07 1.45475e-07 1.44205e-07 1.47085e-07 1.52884e-07 1.6274e-07
+          2.02344e-06 8.61392e-07 4.68717e-07 3.49706e-07 3.05191e-07 2.89031e-07 2.86739e-07 2.92578e-07 3.04144e-07 3.237e-07 2.99198e-06 1.53304e-06
+          8.78932e-07 6.63201e-07 5.80775e-07 5.50667e-07 5.46442e-07 5.57465e-07 5.79238e-07 6.16074e-07 3.96278e-06 2.52636e-06 1.58611e-06 1.22314e-06
+          1.07719e-06 1.02254e-06 1.01427e-06 1.0336e-06 1.07243e-06 1.13881e-06 4.40777e-06 3.65622e-06 2.68548e-06 2.17904e-06 1.94914e-06 1.85843e-06
+          1.84386e-06 1.87616e-06 1.94206e-06 2.05673e-06 4.01136e-06 4.30112e-06 3.92066e-06 3.53265e-06 3.3017e-06 3.20658e-06 3.20532e-06 3.26882e-06
+          3.38144e-06 3.57326e-06 3.13481e-06 3.85207e-06 4.31887e-06 4.55221e-06 4.6609e-06 4.75079e-06 4.86471e-06 5.01169e-06 5.1923e-06 5.46281e-06
+          2.30064e-06 2.73287e-06 3.3077e-06 3.92915e-06 4.4872e-06 4.95554e-06 5.34897e-06 5.68986e-06 5.99808e-06 6.34264e-06 1.73897e-06 1.78308e-06
+          1.99262e-06 2.35426e-06 2.81057e-06 3.31123e-06 3.81767e-06 4.30215e-06 4.74868e-06 5.16922e-06 1.43783e-06 1.26663e-06 1.20477e-06 1.24706e-06
+          1.37608e-06 1.57614e-06 1.83454e-06 2.13942e-06 2.47704e-06 2.81421e-06 1.30885e-06 1.0579e-06 8.9069e-07 7.9053e-07 7.43846e-07 7.41007e-07
+          7.75726e-07 8.44172e-07 9.4314e-07 1.05334e-06 1.26832e-06 9.95889e-07 8.01477e-07 6.61797e-07 5.61886e-07 4.91905e-07 4.45294e-07 4.17672e-07
+          4.05776e-07 4.02243e-07 1.25964e-06 9.84105e-07 7.86192e-07 6.40243e-07 5.30476e-07 4.46721e-07 3.82194e-07 3.32247e-07 2.93553e-07 2.63015e-07
+          1.26048e-06 9.86306e-07 7.90452e-07 6.46666e-07 5.38843e-07 4.5661e-07 3.9305e-07 3.43424e-07 3.04409e-07 2.73548e-07 1.27845e-06 1.03237e-06
+          8.67426e-07 7.54488e-07 6.76378e-07 6.22403e-07 5.85645e-07 5.61486e-07 5.46734e-07 5.38495e-07
+        </DataArray>
+        <DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
+          312.852 313.029 313.061 313.075 313.083 313.088 313.091 313.094 313.095 313.096 312.154 312.739
+          312.849 312.896 312.922 312.939 312.95 312.958 312.964 312.968 311.208 312.332 312.551 312.644
+          312.697 312.73 312.753 312.769 312.78 312.788 309.941 311.763 312.134 312.293 312.382 312.438
+          312.477 312.504 312.523 312.536 308.272 310.967 311.55 311.8 311.94 312.029 312.09 312.132
+          312.163 312.183 306.127 309.856 310.733 311.111 311.322 311.457 311.548 311.613 311.659 311.689
+          303.459 308.313 309.591 310.146 310.458 310.656 310.791 310.885 310.953 310.997 300.311 306.197
+          307.999 308.799 309.249 309.536 309.731 309.868 309.966 310.031 296.881 303.379 305.801 306.925
+          307.565 307.974 308.253 308.449 308.59 308.682 293.507 299.852 302.84 304.357 305.243 305.816
+          306.209 306.487 306.687 306.82 290.51 295.881 299.099 300.975 302.141 302.915 303.456 303.845
+          304.128 304.321 288.066 291.996 294.903 296.91 298.292 299.268 299.977 300.503 300.897 301.179
+          286.213 288.713 290.89 292.666 294.064 295.152 295.999 296.664 297.187 297.584 284.9 286.295
+          287.645 288.912 290.058 291.066 291.937 292.68 293.307 293.814 284.026 284.715 285.418 286.14
+          286.869 287.589 288.287 288.949 289.567 290.108 283.483 283.777 284.096 284.444 284.818 285.212
+          285.624 286.048 286.479 286.888 283.179 283.308 283.463 283.632 283.81 283.996 284.19 284.393
+          284.603 284.808 283.403 283.499 283.55 283.589 283.626 283.667 283.714 283.768 283.827 283.889
+          283.105 283.111 283.132 283.158 283.187 283.216 283.245 283.273 283.302 283.329 283.137 283.123
+          283.112 283.103 283.096 283.091 283.088 283.087 283.088 283.09
+        </DataArray>
+        <DataArray type="Float32" Name="lambda_t" NumberOfComponents="1" format="ascii">
+          1.30475e-08 2.60406e-10 1.31941e-10 1.08268e-10 1.04912e-10 1.0923e-10 1.17699e-10 1.28979e-10 1.42553e-10 1.59459e-10 4.13524e-07 1.18368e-08
+          5.95804e-09 4.8786e-09 4.72202e-09 4.91288e-09 5.29127e-09 5.79646e-09 6.40507e-09 7.16379e-09 2.95982e-06 9.71861e-08 4.83413e-08 3.94303e-08
+          3.80858e-08 3.95737e-08 4.25846e-08 4.66225e-08 5.14966e-08 5.75834e-08 1.42357e-05 5.05625e-07 2.47495e-07 2.00787e-07 1.93375e-07 2.0056e-07
+          2.15552e-07 2.35788e-07 2.60286e-07 2.90955e-07 5.73269e-05 2.16358e-06 1.03781e-06 8.35917e-07 8.0189e-07 8.29603e-07 8.90102e-07 9.72514e-07
+          1.07268e-06 1.19851e-06 0.000208033 8.4456e-06 3.95839e-06 3.15941e-06 3.01529e-06 3.1092e-06 3.3284e-06 3.6308e-06 4.00034e-06 4.46667e-06
+          0.000696224 3.16126e-05 1.44996e-05 1.14503e-05 1.08592e-05 1.1151e-05 1.19027e-05 1.29573e-05 1.42553e-05 1.5903e-05 0.00213684 0.000115744
+          5.25652e-05 4.10762e-05 3.86836e-05 3.95306e-05 4.20485e-05 4.56576e-05 5.01376e-05 5.58652e-05 0.00580627 0.000411402 0.000190652 0.000148118
+          0.000138617 0.000140948 0.000149346 0.000161673 0.000177113 0.000196995 0.013395 0.001362 0.000680401 0.000533436 0.000498195 0.000504618
+          0.000532527 0.000574243 0.000626757 0.000694618 0.0264269 0.00385665 0.00221624 0.00181154 0.0017082 0.00172906 0.00181598 0.00194506
+          0.00210634 0.0023134 0.0464402 0.00897603 0.00578971 0.00501821 0.0048553 0.0049594 0.00521382 0.00556737 0.00599676 0.00653423
+          0.0748977 0.0181304 0.0121371 0.0107194 0.0105391 0.0108947 0.0115409 0.0123709 0.0133347 0.0144783 0.110288 0.0339638
+          0.0227328 0.0192355 0.0182532 0.0185403 0.0195565 0.021021 0.0227816 0.0248081 0.144837 0.0587668 0.0410046 0.0335768
+          0.0297525 0.0281267 0.0280527 0.0291347 0.0310976 0.0336843 0.169199 0.0897356 0.0675858 0.0570786 0.0501181 0.0452511
+          0.0420183 0.0402339 0.0397896 0.0405235 0.181337 0.120191 0.0968788 0.0854728 0.0775553 0.0714397 0.0664805 0.0623889
+          0.0590719 0.0566771 0.185473 0.144958 0.123343 0.112307 0.104585 0.0986225 0.0937999 0.0897908 0.0864057 0.0836525
+          0.18715 0.163478 0.145837 0.136158 0.12941 0.124353 0.120457 0.11743 0.115096 0.113394 0.188928 0.177738
+          0.167402 0.16201 0.158823 0.156977 0.15607 0.155888 0.156308 0.157193
+        </DataArray>
+        <DataArray type="Float32" Name="X^H2O_gas" NumberOfComponents="1" format="ascii">
+          4.26966e-07 1.6043e-06 3.56479e-06 6.35872e-06 9.92419e-06 1.41336e-05 1.88333e-05 2.38694e-05 2.91024e-05 3.44218e-05 4.27165e-07 1.6043e-06
+          3.56479e-06 6.35872e-06 9.92419e-06 1.41336e-05 1.88333e-05 2.38694e-05 2.91024e-05 3.44218e-05 4.27835e-07 1.60434e-06 3.56482e-06 6.35876e-06
+          9.92423e-06 1.41336e-05 1.88334e-05 2.38694e-05 2.91024e-05 3.44218e-05 4.29547e-07 1.60451e-06 3.56496e-06 6.35891e-06 9.9244e-06 1.41338e-05
+          1.88336e-05 2.38696e-05 2.91027e-05 3.4422e-05 4.33477e-07 1.60514e-06 3.56549e-06 6.3595e-06 9.92506e-06 1.41345e-05 1.88343e-05 2.38704e-05
+          2.91034e-05 3.44228e-05 4.42038e-07 1.6072e-06 3.56724e-06 6.36145e-06 9.92723e-06 1.41369e-05 1.88368e-05 2.38729e-05 2.9106e-05 3.44254e-05
+          4.60112e-07 1.61349e-06 3.57272e-06 6.36755e-06 9.93404e-06 1.41443e-05 1.88446e-05 2.38809e-05 2.9114e-05 3.44335e-05 4.97237e-07 1.63168e-06
+          3.58919e-06 6.38587e-06 9.95444e-06 1.41663e-05 1.88678e-05 2.39048e-05 2.91382e-05 3.44577e-05 5.7065e-07 1.68183e-06 3.63718e-06 6.43936e-06
+          1.0014e-05 1.42308e-05 1.89356e-05 2.39744e-05 2.92084e-05 3.4528e-05 7.09409e-07 1.81253e-06 3.7729e-06 6.59188e-06 1.01838e-05 1.44143e-05
+          1.91284e-05 2.41722e-05 2.94076e-05 3.47269e-05 9.6463e-07 2.13048e-06 4.13901e-06 7.01139e-06 1.06517e-05 1.49191e-05 1.96572e-05 2.4713e-05
+          2.99503e-05 3.52659e-05 1.43839e-06 2.85634e-06 5.06047e-06 8.09644e-06 1.18656e-05 1.62234e-05 2.10145e-05 2.60905e-05 3.13212e-05 3.66141e-05
+          2.35964e-06 4.47112e-06 7.24298e-06 1.07154e-05 1.47887e-05 1.93312e-05 2.42056e-05 2.9283e-05 3.44525e-05 3.96463e-05 4.31662e-06 8.13583e-06
+          1.22993e-05 1.67877e-05 2.14906e-05 2.633e-05 3.12429e-05 3.61717e-05 4.10662e-05 4.5921e-05 9.13589e-06 1.69712e-05 2.41162e-05 3.06075e-05
+          3.64185e-05 4.16218e-05 4.63251e-05 5.06366e-05 5.46555e-05 5.85391e-05 2.38702e-05 4.05942e-05 5.26074e-05 6.14582e-05 6.79732e-05 7.27761e-05
+          7.63355e-05 7.90025e-05 8.10549e-05 8.28696e-05 8.33991e-05 0.00011206 0.000123445 0.000127747 0.000128683 0.000127942 0.000126354 0.000124348
+          0.00012218 0.000120209 0.000421506 0.000327452 0.000272946 0.000237016 0.000211698 0.000193012 0.000178713 0.000167441 0.000158342 0.00015096
+          6.66995e-05 9.46179e-05 0.000107826 0.000114396 0.000117428 0.000118439 0.00011826 0.000117376 0.00011607 0.000114481 5.92282e-06 1.23795e-05
+          1.8417e-05 2.40205e-05 2.91897e-05 3.39415e-05 3.83027e-05 4.23029e-05 4.59635e-05 4.92896e-05
+        </DataArray>
+        <DataArray type="Float32" Name="x^H2O_gas" NumberOfComponents="1" format="ascii">
+          6.86363e-07 2.57896e-06 5.7305e-06 1.02218e-05 1.59534e-05 2.272e-05 3.02749e-05 3.83702e-05 4.67822e-05 5.5333e-05 6.86682e-07 2.57896e-06
+          5.73051e-06 1.02218e-05 1.59534e-05 2.272e-05 3.02749e-05 3.83702e-05 4.67823e-05 5.5333e-05 6.87759e-07 2.57902e-06 5.73056e-06 1.02219e-05
+          1.59534e-05 2.27201e-05 3.02749e-05 3.83703e-05 4.67823e-05 5.53331e-05 6.90511e-07 2.5793e-06 5.73078e-06 1.02221e-05 1.59537e-05 2.27204e-05
+          3.02753e-05 3.83706e-05 4.67827e-05 5.53334e-05 6.96829e-07 2.58031e-06 5.73163e-06 1.02231e-05 1.59548e-05 2.27215e-05 3.02765e-05 3.83719e-05
+          4.67839e-05 5.53347e-05 7.10591e-07 2.58362e-06 5.73444e-06 1.02262e-05 1.59583e-05 2.27253e-05 3.02805e-05 3.8376e-05 4.6788e-05 5.53388e-05
+          7.39644e-07 2.59373e-06 5.74326e-06 1.0236e-05 1.59692e-05 2.27372e-05 3.02929e-05 3.83888e-05 4.6801e-05 5.53519e-05 7.99325e-07 2.62298e-06
+          5.76973e-06 1.02655e-05 1.6002e-05 2.27727e-05 3.03303e-05 3.84272e-05 4.68397e-05 5.53908e-05 9.17338e-07 2.70359e-06 5.84688e-06 1.03514e-05
+          1.60977e-05 2.28763e-05 3.04393e-05 3.85391e-05 4.69526e-05 5.55038e-05 1.1404e-06 2.9137e-06 6.06506e-06 1.05966e-05 1.63707e-05 2.31712e-05
+          3.07491e-05 3.88571e-05 4.72729e-05 5.58235e-05 1.55067e-06 3.42481e-06 6.65358e-06 1.1271e-05 1.71228e-05 2.39827e-05 3.15991e-05 3.97263e-05
+          4.81452e-05 5.66899e-05 2.31226e-06 4.59166e-06 8.13485e-06 1.30152e-05 1.90742e-05 2.60794e-05 3.37811e-05 4.19407e-05 5.0349e-05 5.88571e-05
+          3.79319e-06 7.18745e-06 1.16433e-05 1.72253e-05 2.37731e-05 3.10752e-05 3.89108e-05 4.70725e-05 5.53823e-05 6.37313e-05 6.93909e-06 1.30785e-05
+          1.97713e-05 2.69866e-05 3.45464e-05 4.23256e-05 5.0223e-05 5.8146e-05 6.60137e-05 7.38175e-05 1.46862e-05 2.72814e-05 3.8767e-05 4.92017e-05
+          5.85426e-05 6.69067e-05 7.44671e-05 8.13975e-05 8.78576e-05 9.41002e-05 3.83716e-05 6.52549e-05 8.45655e-05 9.87923e-05 0.000109265 0.000116985
+          0.000122706 0.000126993 0.000130292 0.000133209 0.00013406 0.000180128 0.000198427 0.000205342 0.000206846 0.000205655 0.000203102 0.000199879
+          0.000196394 0.000193226 0.000677411 0.000526285 0.000438696 0.000380957 0.000340268 0.000310237 0.000287256 0.00026914 0.000254515 0.000242651
+          0.000107217 0.000152093 0.000173323 0.000183882 0.000188756 0.00019038 0.000190093 0.000188672 0.000186573 0.000184019 9.52109e-06 1.99003e-05
+          2.96056e-05 3.86131e-05 4.69226e-05 5.4561e-05 6.15715e-05 6.80015e-05 7.38858e-05 7.92322e-05
+        </DataArray>
+        <DataArray type="Float32" Name="D^H2O_gas" NumberOfComponents="1" format="ascii">
+          2.71937e-05 2.72214e-05 2.72264e-05 2.72286e-05 2.72298e-05 2.72306e-05 2.72311e-05 2.72315e-05 2.72317e-05 2.72319e-05 2.70846e-05 2.71759e-05
+          2.71931e-05 2.72005e-05 2.72046e-05 2.72072e-05 2.7209e-05 2.72103e-05 2.72112e-05 2.72118e-05 2.69369e-05 2.71124e-05 2.71465e-05 2.71612e-05
+          2.71694e-05 2.71746e-05 2.71782e-05 2.71807e-05 2.71824e-05 2.71836e-05 2.67399e-05 2.70235e-05 2.70814e-05 2.71062e-05 2.71201e-05 2.71289e-05
+          2.7135e-05 2.71392e-05 2.71422e-05 2.71442e-05 2.64813e-05 2.68995e-05 2.69903e-05 2.70293e-05 2.70512e-05 2.70651e-05 2.70745e-05 2.70812e-05
+          2.70859e-05 2.7089e-05 2.61505e-05 2.67268e-05 2.6863e-05 2.69218e-05 2.69548e-05 2.69758e-05 2.699e-05 2.70001e-05 2.70072e-05 2.70119e-05
+          2.57417e-05 2.64876e-05 2.66856e-05 2.67718e-05 2.68202e-05 2.6851e-05 2.6872e-05 2.68867e-05 2.68973e-05 2.69042e-05 2.5263e-05 2.61612e-05
+          2.64391e-05 2.65628e-05 2.66326e-05 2.6677e-05 2.67073e-05 2.67286e-05 2.67438e-05 2.67538e-05 2.4746e-05 2.57295e-05 2.61004e-05 2.62734e-05
+          2.63721e-05 2.64352e-05 2.64783e-05 2.65087e-05 2.65304e-05 2.65448e-05 2.42421e-05 2.51936e-05 2.56474e-05 2.58789e-05 2.60148e-05 2.61027e-05
+          2.61631e-05 2.6206e-05 2.62367e-05 2.62572e-05 2.37984e-05 2.45962e-05 2.50798e-05 2.53637e-05 2.55407e-05 2.56588e-05 2.57413e-05 2.58007e-05
+          2.5844e-05 2.58735e-05 2.34392e-05 2.40179e-05 2.445e-05 2.47503e-05 2.49581e-05 2.51053e-05 2.52124e-05 2.5292e-05 2.53518e-05 2.53946e-05
+          2.31685e-05 2.35341e-05 2.38544e-05 2.41172e-05 2.4325e-05 2.44872e-05 2.46139e-05 2.47135e-05 2.4792e-05 2.48516e-05 2.29775e-05 2.31805e-05
+          2.33776e-05 2.35632e-05 2.37317e-05 2.38805e-05 2.40093e-05 2.41193e-05 2.42124e-05 2.42877e-05 2.28509e-05 2.29508e-05 2.30528e-05 2.31579e-05
+          2.32642e-05 2.33694e-05 2.34715e-05 2.35688e-05 2.36595e-05 2.37392e-05 2.27722e-05 2.28148e-05 2.28609e-05 2.29114e-05 2.29656e-05 2.30229e-05
+          2.30827e-05 2.31445e-05 2.32073e-05 2.32669e-05 2.27284e-05 2.27469e-05 2.27694e-05 2.27938e-05 2.28196e-05 2.28466e-05 2.28746e-05 2.2904e-05
+          2.29345e-05 2.29642e-05 2.27607e-05 2.27746e-05 2.27819e-05 2.27875e-05 2.2793e-05 2.27989e-05 2.28057e-05 2.28134e-05 2.28221e-05 2.28309e-05
+          2.27176e-05 2.27185e-05 2.27215e-05 2.27253e-05 2.27295e-05 2.27336e-05 2.27378e-05 2.27419e-05 2.2746e-05 2.275e-05 2.27222e-05 2.27203e-05
+          2.27186e-05 2.27173e-05 2.27163e-05 2.27156e-05 2.27152e-05 2.27151e-05 2.27152e-05 2.27155e-05
+        </DataArray>
+        <DataArray type="Float32" Name="X^Air_gas" NumberOfComponents="1" format="ascii">
+          1 0.999998 0.999996 0.999994 0.99999 0.999986 0.999981 0.999976 0.999971 0.999966 1 0.999998
+          0.999996 0.999994 0.99999 0.999986 0.999981 0.999976 0.999971 0.999966 1 0.999998 0.999996 0.999994
+          0.99999 0.999986 0.999981 0.999976 0.999971 0.999966 1 0.999998 0.999996 0.999994 0.99999 0.999986
+          0.999981 0.999976 0.999971 0.999966 1 0.999998 0.999996 0.999994 0.99999 0.999986 0.999981 0.999976
+          0.999971 0.999966 1 0.999998 0.999996 0.999994 0.99999 0.999986 0.999981 0.999976 0.999971 0.999966
+          1 0.999998 0.999996 0.999994 0.99999 0.999986 0.999981 0.999976 0.999971 0.999966 1 0.999998
+          0.999996 0.999994 0.99999 0.999986 0.999981 0.999976 0.999971 0.999966 0.999999 0.999998 0.999996 0.999994
+          0.99999 0.999986 0.999981 0.999976 0.999971 0.999965 0.999999 0.999998 0.999996 0.999993 0.99999 0.999986
+          0.999981 0.999976 0.999971 0.999965 0.999999 0.999998 0.999996 0.999993 0.999989 0.999985 0.99998 0.999975
+          0.99997 0.999965 0.999999 0.999997 0.999995 0.999992 0.999988 0.999984 0.999979 0.999974 0.999969 0.999963
+          0.999998 0.999996 0.999993 0.999989 0.999985 0.999981 0.999976 0.999971 0.999966 0.99996 0.999996 0.999992
+          0.999988 0.999983 0.999978 0.999974 0.999969 0.999964 0.999959 0.999954 0.999991 0.999983 0.999976 0.999969
+          0.999964 0.999958 0.999954 0.999949 0.999945 0.999941 0.999976 0.999959 0.999947 0.999939 0.999932 0.999927
+          0.999924 0.999921 0.999919 0.999917 0.999917 0.999888 0.999877 0.999872 0.999871 0.999872 0.999874 0.999876
+          0.999878 0.99988 0.999578 0.999673 0.999727 0.999763 0.999788 0.999807 0.999821 0.999833 0.999842 0.999849
+          0.999933 0.999905 0.999892 0.999886 0.999883 0.999882 0.999882 0.999883 0.999884 0.999885 0.999994 0.999988
+          0.999982 0.999976 0.999971 0.999966 0.999962 0.999958 0.999954 0.999951
+        </DataArray>
+        <DataArray type="Float32" Name="x^Air_gas" NumberOfComponents="1" format="ascii">
+          0.999999 0.999997 0.999994 0.99999 0.999984 0.999977 0.99997 0.999962 0.999953 0.999945 0.999999 0.999997
+          0.999994 0.99999 0.999984 0.999977 0.99997 0.999962 0.999953 0.999945 0.999999 0.999997 0.999994 0.99999
+          0.999984 0.999977 0.99997 0.999962 0.999953 0.999945 0.999999 0.999997 0.999994 0.99999 0.999984 0.999977
+          0.99997 0.999962 0.999953 0.999945 0.999999 0.999997 0.999994 0.99999 0.999984 0.999977 0.99997 0.999962
+          0.999953 0.999945 0.999999 0.999997 0.999994 0.99999 0.999984 0.999977 0.99997 0.999962 0.999953 0.999945
+          0.999999 0.999997 0.999994 0.99999 0.999984 0.999977 0.99997 0.999962 0.999953 0.999945 0.999999 0.999997
+          0.999994 0.99999 0.999984 0.999977 0.99997 0.999962 0.999953 0.999945 0.999999 0.999997 0.999994 0.99999
+          0.999984 0.999977 0.99997 0.999961 0.999953 0.999945 0.999999 0.999997 0.999994 0.999989 0.999984 0.999977
+          0.999969 0.999961 0.999953 0.999944 0.999998 0.999997 0.999993 0.999989 0.999983 0.999976 0.999968 0.99996
+          0.999952 0.999943 0.999998 0.999995 0.999992 0.999987 0.999981 0.999974 0.999966 0.999958 0.99995 0.999941
+          0.999996 0.999993 0.999988 0.999983 0.999976 0.999969 0.999961 0.999953 0.999945 0.999936 0.999993 0.999987
+          0.99998 0.999973 0.999965 0.999958 0.99995 0.999942 0.999934 0.999926 0.999985 0.999973 0.999961 0.999951
+          0.999941 0.999933 0.999926 0.999919 0.999912 0.999906 0.999962 0.999935 0.999915 0.999901 0.999891 0.999883
+          0.999877 0.999873 0.99987 0.999867 0.999866 0.99982 0.999802 0.999795 0.999793 0.999794 0.999797 0.9998
+          0.999804 0.999807 0.999323 0.999474 0.999561 0.999619 0.99966 0.99969 0.999713 0.999731 0.999745 0.999757
+          0.999893 0.999848 0.999827 0.999816 0.999811 0.99981 0.99981 0.999811 0.999813 0.999816 0.99999 0.99998
+          0.99997 0.999961 0.999953 0.999945 0.999938 0.999932 0.999926 0.999921
+        </DataArray>
+        <DataArray type="Float32" Name="D_t" NumberOfComponents="1" format="ascii">
+          1.41514e-11 2.82593e-13 1.43197e-13 1.17509e-13 1.13869e-13 1.18557e-13 1.2775e-13 1.39994e-13 1.54727e-13 1.73077e-13 4.47526e-10 1.28337e-11
+          6.46201e-12 5.29203e-12 5.1226e-12 5.3299e-12 5.74059e-12 6.28882e-12 6.94922e-12 7.77245e-12 3.19365e-09 1.05236e-10 5.23813e-11 4.27381e-11
+          4.12875e-11 4.29048e-11 4.61722e-11 5.05525e-11 5.58393e-11 6.24406e-11 1.52989e-08 5.46526e-10 2.67828e-10 2.1739e-10 2.09423e-10 2.17243e-10
+          2.33509e-10 2.55452e-10 2.82008e-10 3.15247e-10 6.12823e-08 2.33274e-09 1.121e-09 9.03637e-10 8.67234e-10 8.97454e-10 9.6308e-10 1.05239e-09
+          1.16089e-09 1.29713e-09 2.20864e-07 9.07391e-09 4.26469e-09 3.40795e-09 3.25465e-09 3.35744e-09 3.59515e-09 3.92256e-09 4.32241e-09 4.82672e-09
+          7.32826e-07 3.37981e-08 1.55652e-08 1.23134e-08 1.16893e-08 1.20108e-08 1.28259e-08 1.39665e-08 1.53687e-08 1.71474e-08 2.22619e-06 1.2291e-07
+          5.6143e-08 4.39839e-08 4.14811e-08 4.24279e-08 4.51581e-08 4.90552e-08 5.38852e-08 6.00528e-08 5.98093e-06 4.32918e-07 2.02198e-07 1.57656e-07
+          1.47845e-07 1.50528e-07 1.59638e-07 1.72922e-07 1.8952e-07 2.10856e-07 1.36432e-05 1.41682e-06 7.14732e-07 5.63111e-07 5.27416e-07 5.352e-07
+          5.65512e-07 6.10356e-07 6.66596e-07 7.39083e-07 2.66452e-05 3.95946e-06 2.29972e-06 1.89139e-06 1.7903e-06 1.81673e-06 1.9114e-06 2.04984e-06
+          2.22183e-06 2.44175e-06 4.64345e-05 9.09586e-06 5.92465e-06 5.16964e-06 5.02476e-06 5.14902e-06 5.42578e-06 5.80368e-06 6.25936e-06 6.82663e-06
+          7.44121e-05 1.81684e-05 1.22531e-05 1.08871e-05 1.07544e-05 1.11578e-05 1.1853e-05 1.27336e-05 1.37495e-05 1.49481e-05 0.000109076 3.37531e-05
+          2.2697e-05 1.92887e-05 1.83754e-05 1.87284e-05 1.98132e-05 2.13503e-05 2.31873e-05 2.52929e-05 0.000142809 5.8083e-05 4.06261e-05 3.335e-05
+          2.96258e-05 2.80763e-05 2.80694e-05 2.92183e-05 3.12525e-05 3.39145e-05 0.000166513 8.84005e-05 6.66536e-05 5.63592e-05 4.95504e-05 4.47997e-05
+          4.16584e-05 3.99478e-05 3.95654e-05 4.0352e-05 0.000178261 0.000118202 9.53266e-05 8.41527e-05 7.64048e-05 7.04257e-05 6.55811e-05 6.15883e-05
+          5.83567e-05 5.60308e-05 0.000182419 0.000142629 0.000121389 0.000110546 0.00010296 9.7106e-05 9.23737e-05 8.84428e-05 8.51269e-05 8.24326e-05
+          0.00018393 0.000160665 0.000143336 0.000133835 0.000127214 0.000122256 0.000118437 0.000115472 0.000113189 0.000111526 0.000185707 0.000174699
+          0.000164532 0.000159226 0.00015609 0.000154272 0.000153379 0.0001532 0.000153612 0.000154483
+        </DataArray>
+        <DataArray type="Float32" Name="dv_x/dx_" NumberOfComponents="3" format="ascii">
+          -0.110333 126.781 0 -0.0417171 5.80634 0 -0.000302245 3.42218 0 -8.96832e-05 2.81795 0
+          -4.68361e-05 2.52325 0 -2.86671e-05 2.34856 0 -1.87106e-05 2.23599 0 -1.23662e-05 2.16109 0
+          -7.4467e-06 2.1121 0 -5.11229e-06 2.08649 0 -0.108486 3.82108 0 -0.0418243 5.73915 0
+          -0.0010132 3.41974 0 -0.000304777 2.81575 0 -0.000159142 2.52125 0 -9.73954e-05 2.34672 0
+          -6.35617e-05 2.23426 0 -4.2003e-05 2.15945 0 -2.5291e-05 2.11054 0 -1.73636e-05 2.08497 0
+          -0.105938 3.72095 0 -0.0419477 5.63706 0 -0.00198139 3.41607 0 -0.000605757 2.81251 0
+          -0.000316239 2.51829 0 -0.000193511 2.34397 0 -0.000126271 2.23169 0 -8.34278e-05 2.15702 0
+          -5.02283e-05 2.10821 0 -3.44864e-05 2.0827 0 -0.102442 3.58363 0 -0.0420694 5.49644 0
+          -0.00328451 3.41032 0 -0.00102671 2.80785 0 -0.000535904 2.51408 0 -0.000327862 2.34009 0
+          -0.000213901 2.22805 0 -0.000141291 2.15357 0 -8.50525e-05 2.10493 0 -5.84016e-05 2.07949 0
+          -0.0976875 3.39608 0 -0.0421428 5.30266 0 -0.00500817 3.40037 0 -0.00161472 2.80094 0
+          -0.000842829 2.508 0 -0.000515518 2.33453 0 -0.000336251 2.22286 0 -0.000222037 2.14866 0
+          -0.000133632 2.10024 0 -9.17711e-05 2.0749 0 -0.091299 3.14062 0 -0.0420626 5.03407 0
+          -0.00722747 3.38123 0 -0.00243319 2.7901 0 -0.00127102 2.49888 0 -0.000777278 2.32631 0
+          -0.00050685 2.21523 0 -0.000334551 2.14145 0 -0.000201299 2.09335 0 -0.00013827 2.06816 0
+          -0.082877 2.79403 0 -0.0416119 4.65797 0 -0.00995959 3.34085 0 -0.00356165 2.77133 0
+          -0.0018662 2.48423 0 -0.00114142 2.31344 0 -0.000744152 2.2034 0 -0.000490964 2.13029 0
+          -0.00029535 2.08265 0 -0.000202948 2.05765 0 -0.0721134 2.33527 0 -0.0403734 4.13261 0
+          -0.0130556 3.25184 0 -0.00507942 2.73434 0 -0.0026855 2.4578 0 -0.00164482 2.29105 0
+          -0.00107264 2.18305 0 -0.00070755 2.1111 0 -0.000425697 2.06411 0 -0.00029276 2.03929 0
+          -0.0590466 1.77821 0 -0.0376479 3.43414 0 -0.0160068 3.05916 0 -0.00699575 2.65194 0
+          -0.00378336 2.40241 0 -0.00232964 2.24557 0 -0.0015224 2.14212 0 -0.00100537 2.07233 0
+          -0.000605895 2.02617 0 -0.000417628 2.00131 0 -0.0443896 1.20307 0 -0.0326176 2.60002 0
+          -0.0177916 2.68269 0 -0.00905589 2.46165 0 -0.00514594 2.27348 0 -0.00322077 2.14062 0
+          -0.00212158 2.0478 0 -0.0014096 1.98257 0 -0.000855692 1.93751 0 -0.00059379 1.91196 0
+          -0.0296607 0.717512 0 -0.0251056 1.74444 0 -0.0171797 2.08712 0 -0.0104645 2.08126 0
+          -0.00650462 1.99602 0 -0.00424263 1.91069 0 -0.00286222 1.8404 0 -0.00194028 1.78524 0
+          -0.00120438 1.74301 0 -0.000850714 1.71662 0 -0.0167872 0.379373 0 -0.016364 1.01665 0
+          -0.0137945 1.38278 0 -0.010137 1.51885 0 -0.00717016 1.54203 0 -0.00506758 1.52166 0
+          -0.00361026 1.48779 0 -0.00256536 1.45202 0 -0.00167004 1.41862 0 -0.00122001 1.39477 0
+          -0.00713948 0.178913 0 -0.00843486 0.511053 0 -0.00883606 0.76704 0 -0.00781868 0.927287 0
+          -0.00645801 1.01176 0 -0.00514379 1.04761 0 -0.00401922 1.05526 0 -0.00308943 1.04759 0
+          -0.00215549 1.03222 0 -0.00164319 1.01788 0 -0.000937827 0.0749579 0 -0.00268425 0.221501 0
+          -0.00411289 0.355804 0 -0.00444487 0.467702 0 -0.00437154 0.552131 0 -0.00405573 0.610564 0
+          -0.0036106 0.647415 0 -0.00310141 0.667652 0 -0.00236103 0.675841 0 -0.0018867 0.676866 0
+          0.00247778 0.0270882 0 0.000710581 0.082111 0 -0.000818818 0.138187 0 -0.00142552 0.193326 0
+          -0.00180587 0.244848 0 -0.00204097 0.290548 0 -0.00216021 0.329141 0 -0.00216377 0.360165 0
+          -0.00185545 0.383748 0 -0.00157646 0.397851 0 0.00405337 0.00751248 0 0.00238068 0.0246462 0
+          0.000957341 0.0443345 0 0.000417772 0.0650465 0 6.07501e-05 0.0867173 0 -0.000212897 0.108884 0
+          -0.00043681 0.130992 0 -0.000611899 0.152452 0 -0.000642945 0.172496 0 -0.000600809 0.186877 0
+          0.00457518 0.00052446 0 0.00306075 0.00406979 0 0.00175974 0.0101908 0 0.00127957 0.0166464 0
+          0.000992039 0.0236422 0 0.000784888 0.0312 0 0.000620543 0.0392971 0 0.000485217 0.0478858 0
+          0.000341773 0.0567188 0 0.000259363 0.0636788 0 0.00453825 -0.00109274 0 0.00324442 -0.00135529 0
+          0.00208113 0.000210577 0 0.00161973 0.00169238 0 0.00136119 0.00324181 0 0.00118595 0.00491835 0
+          0.00105416 0.00673984 0 0.000944821 0.00870854 0 0.000768242 0.0107453 0 0.000643028 0.0124416 0
+          0.00434912 -0.00137816 0 0.00322379 -0.00315472 0 0.002141 -0.00410915 0 0.00165877 -0.00529224 0
+          0.0013956 -0.00656452 0 0.00122248 -0.00785241 0 0.00109469 -0.00912593 0 0.000986287 -0.0103743 0
+          0.000808774 -0.01161 0 0.000683784 -0.012474 0 0.00380157 -0.00784304 0 0.00276612 -0.020165 0
+          0.00170677 -0.0277728 0 0.0011897 -0.0334008 0 0.000912809 -0.0380274 0 0.00073735 -0.0420285 0
+          0.000612483 -0.0455849 0 0.000509772 -0.0487959 0 0.000400513 -0.0516822 0 0.000340391 -0.0537958 0
+        </DataArray>
+        <DataArray type="Float32" Name="dv_y/dx_" NumberOfComponents="3" format="ascii">
+          1.06723e-07 0.180769 0 -1.81904e-05 0.00157484 0 -7.25639e-08 0.000330844 0 -1.23241e-08 0.000149069 0
+          -4.77769e-09 8.49918e-05 0 -2.47265e-09 5.37875e-05 0 -1.49953e-09 3.56851e-05 0 -1.03077e-09 2.38852e-05 0
+          -9.3049e-10 1.51274e-05 0 -9.82875e-10 5.33478e-06 0 7.1192e-07 0.176897 0 -6.11765e-05 0.00321342 0
+          -4.83399e-07 0.000687133 0 -8.33547e-08 0.000309443 0 -3.23046e-08 0.000176366 0 -1.67171e-08 0.000111577 0
+          -1.01382e-08 7.39959e-05 0 -6.96998e-09 4.94996e-05 0 -6.28941e-09 3.13158e-05 0 -6.64027e-09 1.1012e-05 0
+          2.56769e-06 0.17045 0 -0.000119402 0.00591141 0 -1.74055e-06 0.0012964 0 -3.05699e-07 0.000583478 0
+          -1.18428e-07 0.000332421 0 -6.12719e-08 0.000210243 0 -3.71556e-08 0.000139388 0 -2.55454e-08 9.32101e-05 0
+          -2.3037e-08 5.89267e-05 0 -2.4307e-08 2.07256e-05 0 7.05e-06 0.161791 0 -0.000197199 0.00945897 0
+          -4.76777e-06 0.00215104 0 -8.58523e-07 0.000967643 0 -3.32435e-07 0.000551034 0 -1.71941e-07 0.000348395 0
+          -1.04248e-07 0.000230917 0 -7.16718e-08 0.000154369 0 -6.45766e-08 9.75311e-05 0 -6.80778e-08 3.43835e-05 0
+          1.67661e-05 0.150351 0 -0.000299122 0.0139791 0 -1.13e-05 0.00334753 0 -2.10696e-06 0.00150614 0
+          -8.15569e-07 0.000857264 0 -4.21655e-07 0.000541812 0 -2.55587e-07 0.000359002 0 -1.75709e-07 0.000239919 0
+          -1.58116e-07 0.00015148 0 -1.66488e-07 5.36242e-05 0 3.64265e-05 0.135604 0 -0.000428891 0.0194445 0
+          -2.44263e-05 0.00501011 0 -4.78343e-06 0.00225983 0 -1.85232e-06 0.00128589 0 -9.57252e-07 0.000812433 0
+          -5.80062e-07 0.000538138 0 -3.98747e-07 0.000359518 0 -3.58197e-07 0.000226819 0 -3.7654e-07 8.07997e-05 0
+          7.39729e-05 0.117297 0 -0.000587283 0.0254538 0 -4.92187e-05 0.00726982 0 -1.03246e-05 0.00330826 0
+          -4.00931e-06 0.00188399 0 -2.07161e-06 0.00119028 0 -1.25496e-06 0.000788276 0 -8.62648e-07 0.000526523 0
+          -7.73119e-07 0.000331952 0 -8.10885e-07 0.000119346 0 0.000141268 0.095863 0 -0.000768781 0.0308863 0
+          -9.28374e-05 0.0101676 0 -2.14211e-05 0.00473765 0 -8.3951e-06 0.00270994 0 -4.34207e-06 0.00171435 0
+          -2.63051e-06 0.00113602 0 -1.8084e-06 0.000759167 0 -1.61603e-06 0.000478718 0 -1.69008e-06 0.000174514 0
+          0.000252076 0.0728221 0 -0.0009579 0.0337699 0 -0.000162307 0.0133871 0 -4.25779e-05 0.00657246 0
+          -1.70845e-05 0.00381435 0 -8.8785e-06 0.0024268 0 -5.38595e-06 0.00161356 0 -3.70537e-06 0.00108166 0
+          -3.30164e-06 0.000684838 0 -3.44213e-06 0.000255291 0 0.000413892 0.0505716 0 -0.00112864 0.0321692 0
+          -0.000257511 0.0158855 0 -7.93819e-05 0.00856714 0 -3.3496e-05 0.00515858 0 -1.76673e-05 0.00334019 0
+          -1.0775e-05 0.00224663 0 -7.43161e-06 0.00152257 0 -6.61946e-06 0.000979107 0 -6.89168e-06 0.000379153 0
+          0.000615659 0.0314272 0 -0.00125192 0.02597 0 -0.000362373 0.0161392 0 -0.000133506 0.00995612 0
+          -6.13916e-05 0.00643822 0 -3.3562e-05 0.0043445 0 -2.07933e-05 0.00300929 0 -1.44497e-05 0.00209653 0
+          -1.2994e-05 0.00140001 0 -1.36133e-05 0.000575429 0 0.000824818 0.0166988 0 -0.00131007 0.0174175 0
+          -0.000447553 0.0134691 0 -0.000194506 0.00974788 0 -0.000100091 0.00701573 0 -5.83595e-05 0.0050965 0
+          -3.74524e-05 0.00373527 0 -2.65294e-05 0.00273924 0 -2.46708e-05 0.00194527 0 -2.64628e-05 0.000861175 0
+          0.0010015 0.00650307 0 -0.00130558 0.00941139 0 -0.000489798 0.00891744 0 -0.000240723 0.00763999 0
+          -0.000138671 0.00628057 0 -8.80643e-05 0.0050692 0 -5.99573e-05 0.00405236 0 -4.41892e-05 0.00320932 0
+          -4.41966e-05 0.00246484 0 -4.96363e-05 0.00118087 0 0.0011167 0.000147132 0 -0.00125391 0.00362675 0
+          -0.000488756 0.00437656 0 -0.00025584 0.00448883 0 -0.000159887 0.00428302 0 -0.000110187 0.00392599 0
+          -8.07132e-05 0.00350888 0 -6.34549e-05 0.00307345 0 -7.18525e-05 0.00259134 0 -8.61933e-05 0.00135547 0
+          0.00115896 -0.003372 0 -0.00116786 0.000181216 0 -0.000461725 0.00111623 0 -0.00024377 0.00162488 0
+          -0.000156999 0.00191318 0 -0.000113273 0.00206016 0 -8.77194e-05 0.0021104 0 -7.4068e-05 0.00208652 0
+          -0.000100141 0.00195322 0 -0.000130126 0.00113832 0 0.00112771 -0.00500877 0 -0.0010493 -0.00159302 0
+          -0.00042294 -0.000708708 0 -0.000219507 -0.000217083 0 -0.000140043 0.000118739 0 -0.000101196 0.000367936 0
+          -7.95112e-05 0.000560317 0 -7.06204e-05 0.000707332 0 -0.000115081 0.000778852 0 -0.000160495 0.000554508 0
+          0.0010234 -0.00541682 0 -0.000893402 -0.00239746 0 -0.000373905 -0.0015626 0 -0.000190958 -0.00114052 0
+          -0.00011966 -0.000864271 0 -8.50893e-05 -0.000658499 0 -6.60574e-05 -0.00049246 0 -6.012e-05 -0.00035222 0
+          -0.000109895 -0.000240303 0 -0.000158763 -3.76841e-05 0 0.000842077 -0.0052677 0 -0.000704903 -0.0027392 0
+          -0.000310626 -0.00190444 0 -0.000157108 -0.0015063 0 -9.69718e-05 -0.00126153 0 -6.79731e-05 -0.00108801 0
+          -5.21435e-05 -0.000953794 0 -4.80888e-05 -0.000842709 0 -8.69753e-05 -0.000734294 0 -0.000124285 -0.000365672 0
+          0.000566508 -0.00490979 0 -0.000472667 -0.00274591 0 -0.000219672 -0.00185815 0 -0.000110532 -0.00144169 0
+          -6.73331e-05 -0.00119705 0 -4.65919e-05 -0.00103067 0 -3.53712e-05 -0.000906826 0 -3.26611e-05 -0.000806669 0
+          -5.02185e-05 -0.000699893 0 -6.65361e-05 -0.000392604 0 0.000200865 -0.00462423 0 -0.00017045 -0.00262665 0
+          -8.22101e-05 -0.00170217 0 -4.13256e-05 -0.00126862 0 -2.49859e-05 -0.00101885 0 -1.71444e-05 -0.00085236 0
+          -1.29136e-05 -0.000730817 0 -1.18474e-05 -0.000633692 0 -1.44574e-05 -0.000528903 0 -1.665e-05 -0.000323238 0
+        </DataArray>
+        <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii">
+          0.0504703 2.18484e-05 0 0.000700092 9.60506e-08 0 0.000409732 1.99076e-08 0 0.000337395 8.97443e-09 0
+          0.000302107 5.11929e-09 0 0.000281184 3.24174e-09 0 0.000267696 2.15272e-09 0 0.000258717 1.4434e-09 0
+          0.000252836 9.17332e-10 0 0.000249757 3.2659e-10 0 0.0515814 7.35464e-05 0 0.00236233 6.40729e-07 0
+          0.00139232 1.34606e-07 0 0.00114648 6.06527e-08 0 0.00102657 3.45846e-08 0 0.000955483 2.18908e-08 0
+          0.000909661 1.45282e-08 0 0.000879159 9.73231e-09 0 0.000859186 6.17458e-09 0 0.000848729 2.18353e-09 0
+          0.053104 0.000143776 0 0.00465584 2.31092e-06 0 0.0027668 4.93524e-07 0 0.00227815 2.22272e-07 0
+          0.00203986 1.267e-07 0 0.00189861 8.01722e-08 0 0.00180758 5.31888e-08 0 0.00174699 3.56126e-08 0
+          0.00170732 2.25721e-08 0 0.00168655 7.9626e-09 0 0.055172 0.000238024 0 0.00780186 6.34501e-06 0
+          0.00468869 1.3856e-06 0 0.00386041 6.23718e-07 0 0.00345657 3.55408e-07 0 0.00321723 2.24833e-07 0
+          0.00306301 1.49122e-07 0 0.00296038 9.9812e-08 0 0.00289322 6.32219e-08 0 0.00285805 2.23039e-08 0
+          0.0579453 0.000362346 0 0.0120812 1.50895e-05 0 0.00737394 3.39949e-06 0 0.00607136 1.52958e-06 0
+          0.00543617 8.71233e-07 0 0.00505982 5.5099e-07 0 0.00481736 3.65354e-07 0 0.00465605 2.44473e-07 0
+          0.00455053 1.54762e-07 0 0.00449526 5.4693e-08 0 0.0615951 0.000522386 0 0.0178309 3.27839e-05 0
+          0.0111199 7.71692e-06 0 0.00915784 3.47248e-06 0 0.0081999 1.97703e-06 0 0.0076324 1.24992e-06 0
+          0.00726687 8.28569e-07 0 0.00702377 5.5427e-07 0 0.00686483 3.50662e-07 0 0.00678156 1.24334e-07 0
+          0.0662612 0.000721406 0 0.0254107 6.65756e-05 0 0.0163269 1.66657e-05 0 0.013459 7.51363e-06 0
+          0.0120527 4.27663e-06 0 0.0112193 2.70292e-06 0 0.0106826 1.79124e-06 0 0.0103257 1.1979e-06 0
+          0.0100925 7.57338e-07 0 0.0099703 2.69917e-07 0 0.0719525 0.000957203 0 0.0350979 0.000127141 0
+          0.0235043 3.46664e-05 0 0.019431 1.57369e-05 0 0.0174087 8.96208e-06 0 0.0162079 5.66378e-06 0
+          0.0154343 3.75275e-06 0 0.0149199 2.50918e-06 0 0.0145839 1.58536e-06 0 0.0144076 5.6939e-07 0
+          0.0783807 0.00121891 0 0.046858 0.000226869 0 0.0332032 6.94342e-05 0 0.0276496 3.21025e-05 0
+          0.0248079 1.8343e-05 0 0.0231088 1.16032e-05 0 0.0220113 7.6913e-06 0 0.0212805 5.14437e-06 0
+          0.0208029 3.25053e-06 0 0.0205513 1.18108e-06 0 0.0848725 0.00148631 0 0.0600493 0.000372503 0
+          0.0457312 0.000131935 0 0.0386991 6.34935e-05 0 0.0348635 3.6681e-05 0 0.0325228 2.3303e-05 0
+          0.030997 1.54861e-05 0 0.0299746 1.03827e-05 0 0.0293022 6.58044e-06 0 0.0289442 2.43607e-06 0
+          0.0906184 0.00173333 0 0.0733053 0.000554094 0 0.0604915 0.000231023 0 0.0526893 0.000119253 0
+          0.0479332 7.08262e-05 0 0.0448821 4.55949e-05 0 0.0428394 3.05666e-05 0 0.0414435 2.0666e-05 0
+          0.0405054 1.32549e-05 0 0.0399921 5.06467e-06 0 0.0950904 0.00193385 0 0.0848915 0.000742337 0
+          0.0754535 0.000361772 0 0.0683379 0.000205285 0 0.0632883 0.000128385 0 0.0597319 8.5203e-05 0
+          0.0572039 5.8389e-05 0 0.0553944 4.03121e-05 0 0.0541179 2.6613e-05 0 0.0533821 1.06864e-05 0
+          0.098182 0.00206625 0 0.0935745 0.000901348 0 0.0880601 0.000499559 0 0.0829712 0.000313606 0
+          0.0786775 0.00021072 0 0.0752209 0.000147245 0 0.0725034 0.000105107 0 0.0703949 7.53871e-05 0
+          0.0687916 5.21773e-05 0 0.0678035 2.23142e-05 0 0.100084 0.00211537 0 0.099156 0.00100503 0
+          0.0968631 0.000610676 0 0.0942205 0.000418534 0 0.0915295 0.000303695 0 0.0889752 0.000226716 0
+          0.0866634 0.000171542 0 0.0846437 0.000129962 0 0.0829436 9.54964e-05 0 0.0818128 4.3692e-05 0
+          0.101111 0.002072 0 0.10223 0.00104307 0 0.101964 0.000670581 0 0.101247 0.000489011 0
+          0.100253 0.000378077 0 0.0990808 0.000300644 0 0.097805 0.000242198 0 0.0964904 0.000195444 0
+          0.095212 0.000153355 0 0.0942684 7.52168e-05 0 0.101566 0.00193089 0 0.103648 0.00101494 0
+          0.104423 0.000671741 0 0.104797 0.000507423 0 0.104924 0.000408348 0 0.10487 0.000339392 0
+          0.104669 0.000286938 0 0.104346 0.000244001 0 0.103936 0.000202169 0 0.103576 0.000105832 0
+          0.101686 0.00168838 0 0.104118 0.000921059 0 0.105359 0.0006163 0 0.106229 0.000472382 0
+          0.106895 0.000387164 0 0.10742 0.000328807 0 0.107837 0.000285077 0 0.108165 0.00024955 0
+          0.108419 0.000212899 0 0.108575 0.000117609 0 0.101622 0.00135007 0 0.104084 0.00075787 0
+          0.105516 0.000504188 0 0.106582 0.000385126 0 0.107459 0.00031567 0 0.108215 0.000268775 0
+          0.108883 0.000234119 0 0.10948 0.000206214 0 0.110017 0.00017639 0 0.110402 0.000101793 0
+          0.101522 0.000897607 0 0.103914 0.000509858 0 0.105391 0.000330409 0 0.106483 0.000246257 0
+          0.107382 0.000197779 0 0.108158 0.000165467 0 0.108849 0.00014188 0 0.109472 0.000123029 0
+          0.110032 0.000102672 0 0.110443 6.27342e-05 0 0.101333 0.000318209 0 0.103421 0.000180779 0
+          0.104652 0.00011367 0 0.10547 8.21286e-05 0 0.10608 6.40821e-05 0 0.106565 5.2149e-05 0
+          0.106965 4.35128e-05 0 0.1073 3.6655e-05 0 0.107577 2.92898e-05 0 0.107781 1.92946e-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
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0
+        </DataArray>
+      </CellData>
+      <Points>
+        <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
+          0 0 0 0.6 0 0 0 0.000239325 0 0.6 0.000239325 0
+          1.2 0 0 1.2 0.000239325 0 1.8 0 0 1.8 0.000239325 0
+          2.4 0 0 2.4 0.000239325 0 3 0 0 3 0.000239325 0
+          3.6 0 0 3.6 0.000239325 0 4.2 0 0 4.2 0.000239325 0
+          4.8 0 0 4.8 0.000239325 0 5.4 0 0 5.4 0.000239325 0
+          6 0 0 6 0.000239325 0 0 0.000574381 0 0.6 0.000574381 0
+          1.2 0.000574381 0 1.8 0.000574381 0 2.4 0.000574381 0 3 0.000574381 0
+          3.6 0.000574381 0 4.2 0.000574381 0 4.8 0.000574381 0 5.4 0.000574381 0
+          6 0.000574381 0 0 0.00104346 0 0.6 0.00104346 0 1.2 0.00104346 0
+          1.8 0.00104346 0 2.4 0.00104346 0 3 0.00104346 0 3.6 0.00104346 0
+          4.2 0.00104346 0 4.8 0.00104346 0 5.4 0.00104346 0 6 0.00104346 0
+          0 0.00170017 0 0.6 0.00170017 0 1.2 0.00170017 0 1.8 0.00170017 0
+          2.4 0.00170017 0 3 0.00170017 0 3.6 0.00170017 0 4.2 0.00170017 0
+          4.8 0.00170017 0 5.4 0.00170017 0 6 0.00170017 0 0 0.00261956 0
+          0.6 0.00261956 0 1.2 0.00261956 0 1.8 0.00261956 0 2.4 0.00261956 0
+          3 0.00261956 0 3.6 0.00261956 0 4.2 0.00261956 0 4.8 0.00261956 0
+          5.4 0.00261956 0 6 0.00261956 0 0 0.00390671 0 0.6 0.00390671 0
+          1.2 0.00390671 0 1.8 0.00390671 0 2.4 0.00390671 0 3 0.00390671 0
+          3.6 0.00390671 0 4.2 0.00390671 0 4.8 0.00390671 0 5.4 0.00390671 0
+          6 0.00390671 0 0 0.00570872 0 0.6 0.00570872 0 1.2 0.00570872 0
+          1.8 0.00570872 0 2.4 0.00570872 0 3 0.00570872 0 3.6 0.00570872 0
+          4.2 0.00570872 0 4.8 0.00570872 0 5.4 0.00570872 0 6 0.00570872 0
+          0 0.00823153 0 0.6 0.00823153 0 1.2 0.00823153 0 1.8 0.00823153 0
+          2.4 0.00823153 0 3 0.00823153 0 3.6 0.00823153 0 4.2 0.00823153 0
+          4.8 0.00823153 0 5.4 0.00823153 0 6 0.00823153 0 0 0.0117635 0
+          0.6 0.0117635 0 1.2 0.0117635 0 1.8 0.0117635 0 2.4 0.0117635 0
+          3 0.0117635 0 3.6 0.0117635 0 4.2 0.0117635 0 4.8 0.0117635 0
+          5.4 0.0117635 0 6 0.0117635 0 0 0.0167082 0 0.6 0.0167082 0
+          1.2 0.0167082 0 1.8 0.0167082 0 2.4 0.0167082 0 3 0.0167082 0
+          3.6 0.0167082 0 4.2 0.0167082 0 4.8 0.0167082 0 5.4 0.0167082 0
+          6 0.0167082 0 0 0.0236308 0 0.6 0.0236308 0 1.2 0.0236308 0
+          1.8 0.0236308 0 2.4 0.0236308 0 3 0.0236308 0 3.6 0.0236308 0
+          4.2 0.0236308 0 4.8 0.0236308 0 5.4 0.0236308 0 6 0.0236308 0
+          0 0.0333224 0 0.6 0.0333224 0 1.2 0.0333224 0 1.8 0.0333224 0
+          2.4 0.0333224 0 3 0.0333224 0 3.6 0.0333224 0 4.2 0.0333224 0
+          4.8 0.0333224 0 5.4 0.0333224 0 6 0.0333224 0 0 0.0468907 0
+          0.6 0.0468907 0 1.2 0.0468907 0 1.8 0.0468907 0 2.4 0.0468907 0
+          3 0.0468907 0 3.6 0.0468907 0 4.2 0.0468907 0 4.8 0.0468907 0
+          5.4 0.0468907 0 6 0.0468907 0 0 0.0658863 0 0.6 0.0658863 0
+          1.2 0.0658863 0 1.8 0.0658863 0 2.4 0.0658863 0 3 0.0658863 0
+          3.6 0.0658863 0 4.2 0.0658863 0 4.8 0.0658863 0 5.4 0.0658863 0
+          6 0.0658863 0 0 0.0924802 0 0.6 0.0924802 0 1.2 0.0924802 0
+          1.8 0.0924802 0 2.4 0.0924802 0 3 0.0924802 0 3.6 0.0924802 0
+          4.2 0.0924802 0 4.8 0.0924802 0 5.4 0.0924802 0 6 0.0924802 0
+          0 0.129712 0 0.6 0.129712 0 1.2 0.129712 0 1.8 0.129712 0
+          2.4 0.129712 0 3 0.129712 0 3.6 0.129712 0 4.2 0.129712 0
+          4.8 0.129712 0 5.4 0.129712 0 6 0.129712 0 0 0.181835 0
+          0.6 0.181835 0 1.2 0.181835 0 1.8 0.181835 0 2.4 0.181835 0
+          3 0.181835 0 3.6 0.181835 0 4.2 0.181835 0 4.8 0.181835 0
+          5.4 0.181835 0 6 0.181835 0 0 0.254809 0 0.6 0.254809 0
+          1.2 0.254809 0 1.8 0.254809 0 2.4 0.254809 0 3 0.254809 0
+          3.6 0.254809 0 4.2 0.254809 0 4.8 0.254809 0 5.4 0.254809 0
+          6 0.254809 0 0 0.356972 0 0.6 0.356972 0 1.2 0.356972 0
+          1.8 0.356972 0 2.4 0.356972 0 3 0.356972 0 3.6 0.356972 0
+          4.2 0.356972 0 4.8 0.356972 0 5.4 0.356972 0 6 0.356972 0
+          0 0.5 0 0.6 0.5 0 1.2 0.5 0 1.8 0.5 0
+          2.4 0.5 0 3 0.5 0 3.6 0.5 0 4.2 0.5 0
+          4.8 0.5 0 5.4 0.5 0 6 0.5 0
+        </DataArray>
+      </Points>
+      <Cells>
+        <DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii">
+          0 1 3 2 1 4 5 3 4 6 7 5
+          6 8 9 7 8 10 11 9 10 12 13 11
+          12 14 15 13 14 16 17 15 16 18 19 17
+          18 20 21 19 2 3 23 22 3 5 24 23
+          5 7 25 24 7 9 26 25 9 11 27 26
+          11 13 28 27 13 15 29 28 15 17 30 29
+          17 19 31 30 19 21 32 31 22 23 34 33
+          23 24 35 34 24 25 36 35 25 26 37 36
+          26 27 38 37 27 28 39 38 28 29 40 39
+          29 30 41 40 30 31 42 41 31 32 43 42
+          33 34 45 44 34 35 46 45 35 36 47 46
+          36 37 48 47 37 38 49 48 38 39 50 49
+          39 40 51 50 40 41 52 51 41 42 53 52
+          42 43 54 53 44 45 56 55 45 46 57 56
+          46 47 58 57 47 48 59 58 48 49 60 59
+          49 50 61 60 50 51 62 61 51 52 63 62
+          52 53 64 63 53 54 65 64 55 56 67 66
+          56 57 68 67 57 58 69 68 58 59 70 69
+          59 60 71 70 60 61 72 71 61 62 73 72
+          62 63 74 73 63 64 75 74 64 65 76 75
+          66 67 78 77 67 68 79 78 68 69 80 79
+          69 70 81 80 70 71 82 81 71 72 83 82
+          72 73 84 83 73 74 85 84 74 75 86 85
+          75 76 87 86 77 78 89 88 78 79 90 89
+          79 80 91 90 80 81 92 91 81 82 93 92
+          82 83 94 93 83 84 95 94 84 85 96 95
+          85 86 97 96 86 87 98 97 88 89 100 99
+          89 90 101 100 90 91 102 101 91 92 103 102
+          92 93 104 103 93 94 105 104 94 95 106 105
+          95 96 107 106 96 97 108 107 97 98 109 108
+          99 100 111 110 100 101 112 111 101 102 113 112
+          102 103 114 113 103 104 115 114 104 105 116 115
+          105 106 117 116 106 107 118 117 107 108 119 118
+          108 109 120 119 110 111 122 121 111 112 123 122
+          112 113 124 123 113 114 125 124 114 115 126 125
+          115 116 127 126 116 117 128 127 117 118 129 128
+          118 119 130 129 119 120 131 130 121 122 133 132
+          122 123 134 133 123 124 135 134 124 125 136 135
+          125 126 137 136 126 127 138 137 127 128 139 138
+          128 129 140 139 129 130 141 140 130 131 142 141
+          132 133 144 143 133 134 145 144 134 135 146 145
+          135 136 147 146 136 137 148 147 137 138 149 148
+          138 139 150 149 139 140 151 150 140 141 152 151
+          141 142 153 152 143 144 155 154 144 145 156 155
+          145 146 157 156 146 147 158 157 147 148 159 158
+          148 149 160 159 149 150 161 160 150 151 162 161
+          151 152 163 162 152 153 164 163 154 155 166 165
+          155 156 167 166 156 157 168 167 157 158 169 168
+          158 159 170 169 159 160 171 170 160 161 172 171
+          161 162 173 172 162 163 174 173 163 164 175 174
+          165 166 177 176 166 167 178 177 167 168 179 178
+          168 169 180 179 169 170 181 180 170 171 182 181
+          171 172 183 182 172 173 184 183 173 174 185 184
+          174 175 186 185 176 177 188 187 177 178 189 188
+          178 179 190 189 179 180 191 190 180 181 192 191
+          181 182 193 192 182 183 194 193 183 184 195 194
+          184 185 196 195 185 186 197 196 187 188 199 198
+          188 189 200 199 189 190 201 200 190 191 202 201
+          191 192 203 202 192 193 204 203 193 194 205 204
+          194 195 206 205 195 196 207 206 196 197 208 207
+          198 199 210 209 199 200 211 210 200 201 212 211
+          201 202 213 212 202 203 214 213 203 204 215 214
+          204 205 216 215 205 206 217 216 206 207 218 217
+          207 208 219 218 209 210 221 220 210 211 222 221
+          211 212 223 222 212 213 224 223 213 214 225 224
+          214 215 226 225 215 216 227 226 216 217 228 227
+          217 218 229 228 218 219 230 229
+        </DataArray>
+        <DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii">
+          4 8 12 16 20 24 28 32 36 40 44 48
+          52 56 60 64 68 72 76 80 84 88 92 96
+          100 104 108 112 116 120 124 128 132 136 140 144
+          148 152 156 160 164 168 172 176 180 184 188 192
+          196 200 204 208 212 216 220 224 228 232 236 240
+          244 248 252 256 260 264 268 272 276 280 284 288
+          292 296 300 304 308 312 316 320 324 328 332 336
+          340 344 348 352 356 360 364 368 372 376 380 384
+          388 392 396 400 404 408 412 416 420 424 428 432
+          436 440 444 448 452 456 460 464 468 472 476 480
+          484 488 492 496 500 504 508 512 516 520 524 528
+          532 536 540 544 548 552 556 560 564 568 572 576
+          580 584 588 592 596 600 604 608 612 616 620 624
+          628 632 636 640 644 648 652 656 660 664 668 672
+          676 680 684 688 692 696 700 704 708 712 716 720
+          724 728 732 736 740 744 748 752 756 760 764 768
+          772 776 780 784 788 792 796 800
+        </DataArray>
+        <DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii">
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9
+        </DataArray>
+      </Cells>
+    </Piece>
+  </UnstructuredGrid>
+</VTKFile>
diff --git a/test/references/test_channel_zeroeq2cni.vtu b/test/references/test_channel_zeroeq2cni.vtu
index 50136c932c62cea0d3af8151ca32536bcbc1b587..dfcf56e816171169ea2ad8a0192396b819836258 100644
--- a/test/references/test_channel_zeroeq2cni.vtu
+++ b/test/references/test_channel_zeroeq2cni.vtu
@@ -60,101 +60,6 @@
           1.23014 1.23015 1.23016 1.23016 1.23015 1.23013 1.23011 1.22966 1.229 1.22826 1.23012 1.23013
           1.23013 1.23014 1.23015 1.23016 1.23016 1.23023 1.23021 1.23012
         </DataArray>
-        <DataArray type="Float32" Name="X^H2O_gas" NumberOfComponents="1" format="ascii">
-          2.83501e-10 1.5709e-08 8.63056e-08 3.8179e-07 1.0074e-06 2.50971e-06 4.96982e-06 1.52856e-05 2.9833e-05 4.48942e-05 2.8363e-10 1.57091e-08
-          8.63057e-08 3.8179e-07 1.0074e-06 2.50971e-06 4.96982e-06 1.52857e-05 2.9833e-05 4.48942e-05 2.84066e-10 1.57095e-08 8.63068e-08 3.81794e-07
-          1.0074e-06 2.50973e-06 4.96984e-06 1.52858e-05 2.98332e-05 4.48944e-05 2.85178e-10 1.57118e-08 8.63121e-08 3.81813e-07 1.00744e-06 2.50981e-06
-          4.96997e-06 1.52863e-05 2.9834e-05 4.48953e-05 2.87726e-10 1.572e-08 8.63323e-08 3.81885e-07 1.00758e-06 2.51013e-06 4.97045e-06 1.52885e-05
-          2.98371e-05 4.48987e-05 2.93219e-10 1.57475e-08 8.64007e-08 3.82126e-07 1.00804e-06 2.51119e-06 4.97208e-06 1.52956e-05 2.98476e-05 4.49099e-05
-          3.04426e-10 1.58313e-08 8.66161e-08 3.8288e-07 1.0095e-06 2.5145e-06 4.97724e-06 1.53178e-05 2.98801e-05 4.49448e-05 3.25607e-10 1.60716e-08
-          8.72598e-08 3.85133e-07 1.01384e-06 2.52441e-06 4.99277e-06 1.53842e-05 2.99771e-05 4.50487e-05 3.66295e-10 1.67036e-08 8.90746e-08 3.91533e-07
-          1.02623e-06 2.55267e-06 5.03723e-06 1.55736e-05 3.02528e-05 4.53428e-05 4.5387e-10 1.81839e-08 9.37367e-08 4.08275e-07 1.05884e-06 2.62746e-06
-          5.15508e-06 1.60745e-05 3.09754e-05 4.61085e-05 6.63032e-10 2.12607e-08 1.04176e-07 4.46878e-07 1.13459e-06 2.80259e-06 5.42987e-06 1.72431e-05
-          3.26289e-05 4.78416e-05 1.23212e-09 2.84986e-08 1.2704e-07 5.22938e-07 1.285e-06 3.15615e-06 5.97765e-06 1.95948e-05 3.58415e-05 5.11495e-05
-          3.16952e-09 4.92606e-08 1.86089e-07 6.89487e-07 1.59664e-06 3.79749e-06 6.95509e-06 2.37806e-05 4.12902e-05 5.66117e-05 1.26994e-08 1.19134e-07
-          3.65325e-07 1.15474e-06 2.39811e-06 5.21646e-06 9.04105e-06 3.07072e-05 4.98496e-05 6.48689e-05 8.47188e-08 4.34547e-07 1.04621e-06 2.6764e-06
-          4.77726e-06 9.20765e-06 1.45187e-05 4.21195e-05 6.30106e-05 7.68877e-05 9.31609e-07 2.74678e-06 5.05196e-06 9.205e-06 1.34958e-05 2.20582e-05
-          3.04849e-05 6.35909e-05 8.35416e-05 9.39954e-05 1.69764e-05 3.05851e-05 4.16903e-05 5.25247e-05 6.12575e-05 7.47313e-05 8.56206e-05 0.000114813
-          0.000121333 0.000120435 0.00052942 0.000476101 0.00043777 0.000404446 0.000376605 0.000344711 0.000320329 0.000233012 0.00018365 0.000154636
-          4.12487e-05 6.29599e-05 7.71827e-05 8.79764e-05 9.64213e-05 0.000103828 0.000108584 0.000118472 0.000118891 0.000115482 1.43685e-06 2.87433e-06
-          4.22897e-06 5.56831e-06 6.89258e-06 8.21293e-06 9.12802e-06 2.03564e-05 3.08438e-05 4.00497e-05
-        </DataArray>
-        <DataArray type="Float32" Name="x^H2O_gas" NumberOfComponents="1" format="ascii">
-          4.55737e-10 2.52528e-08 1.38739e-07 6.13739e-07 1.61942e-06 4.03443e-06 7.98912e-06 2.45719e-05 4.79567e-05 7.21669e-05 4.55945e-10 2.52529e-08
-          1.38739e-07 6.1374e-07 1.61942e-06 4.03443e-06 7.98913e-06 2.4572e-05 4.79567e-05 7.21669e-05 4.56646e-10 2.52536e-08 1.38741e-07 6.13747e-07
-          1.61943e-06 4.03446e-06 7.98917e-06 2.45722e-05 4.7957e-05 7.21673e-05 4.58433e-10 2.52572e-08 1.38749e-07 6.13777e-07 1.61949e-06 4.0346e-06
-          7.98937e-06 2.45731e-05 4.79583e-05 7.21687e-05 4.62529e-10 2.52705e-08 1.38782e-07 6.13893e-07 1.61971e-06 4.03511e-06 7.99014e-06 2.45765e-05
-          4.79633e-05 7.21742e-05 4.7136e-10 2.53146e-08 1.38892e-07 6.1428e-07 1.62046e-06 4.03681e-06 7.99276e-06 2.45879e-05 4.79801e-05 7.21922e-05
-          4.89375e-10 2.54494e-08 1.39238e-07 6.15493e-07 1.6228e-06 4.04214e-06 8.00106e-06 2.46236e-05 4.80324e-05 7.22484e-05 5.23424e-10 2.58356e-08
-          1.40273e-07 6.19114e-07 1.62978e-06 4.05807e-06 8.02602e-06 2.47304e-05 4.81883e-05 7.24153e-05 5.88832e-10 2.68515e-08 1.4319e-07 6.29402e-07
-          1.64969e-06 4.1035e-06 8.09749e-06 2.50349e-05 4.86315e-05 7.2888e-05 7.29611e-10 2.92312e-08 1.50685e-07 6.56315e-07 1.70212e-06 4.22373e-06
-          8.28693e-06 2.584e-05 4.9793e-05 7.41189e-05 1.06585e-09 3.41772e-08 1.67467e-07 7.18371e-07 1.82389e-06 4.50524e-06 8.72867e-06 2.77185e-05
-          5.2451e-05 7.69047e-05 1.98067e-09 4.58124e-08 2.0422e-07 8.4064e-07 2.06567e-06 5.0736e-06 9.60924e-06 3.1499e-05 5.76151e-05 8.2222e-05
-          5.0951e-09 7.9188e-08 2.99144e-07 1.10837e-06 2.56664e-06 6.10458e-06 1.11805e-05 3.82276e-05 6.63737e-05 9.1002e-05 2.04148e-08 1.91512e-07
-          5.87271e-07 1.85629e-06 3.85504e-06 8.38561e-06 1.45337e-05 4.93619e-05 8.01325e-05 0.000104275 1.36188e-07 6.98549e-07 1.68182e-06 4.3024e-06
-          7.67958e-06 1.48015e-05 2.33391e-05 6.77067e-05 0.000101288 0.000123594 1.49759e-06 4.41553e-06 8.12117e-06 1.47973e-05 2.16947e-05 3.54588e-05
-          4.90046e-05 0.00010222 0.000134289 0.000151092 2.72898e-05 4.91656e-05 6.70168e-05 8.44325e-05 9.84698e-05 0.000120128 0.000137631 0.000184552
-          0.000195032 0.000193588 0.000850787 0.000765127 0.000703542 0.000650001 0.000605266 0.000554019 0.00051484 0.000374522 0.00029519 0.000248558
-          6.6307e-05 0.000101206 0.000124068 0.000141417 0.000154991 0.000166896 0.000174541 0.000190434 0.000191107 0.000185628 2.30978e-06 4.62057e-06
-          6.7982e-06 8.95121e-06 1.108e-05 1.32025e-05 1.46735e-05 3.27232e-05 4.95814e-05 6.43796e-05
-        </DataArray>
-        <DataArray type="Float32" Name="D^H2O_gas" NumberOfComponents="1" format="ascii">
-          2.71937e-05 2.722e-05 2.72245e-05 2.72262e-05 2.72273e-05 2.72278e-05 2.72281e-05 2.72275e-05 2.72271e-05 2.72269e-05 2.70846e-05 2.71713e-05
-          2.71867e-05 2.71923e-05 2.7196e-05 2.71977e-05 2.71989e-05 2.71968e-05 2.71953e-05 2.71948e-05 2.69371e-05 2.71031e-05 2.71339e-05 2.71449e-05
-          2.71523e-05 2.71557e-05 2.7158e-05 2.71539e-05 2.71509e-05 2.71498e-05 2.67402e-05 2.70079e-05 2.70599e-05 2.70786e-05 2.70912e-05 2.70969e-05
-          2.71007e-05 2.70939e-05 2.70887e-05 2.7087e-05 2.64824e-05 2.68749e-05 2.69566e-05 2.69859e-05 2.70058e-05 2.70147e-05 2.70207e-05 2.70099e-05
-          2.70018e-05 2.69991e-05 2.61554e-05 2.669e-05 2.68124e-05 2.68565e-05 2.68864e-05 2.68999e-05 2.69089e-05 2.68926e-05 2.68804e-05 2.68763e-05
-          2.57634e-05 2.6435e-05 2.66117e-05 2.66762e-05 2.672e-05 2.67398e-05 2.6753e-05 2.6729e-05 2.67112e-05 2.67051e-05 2.53376e-05 2.60918e-05
-          2.63359e-05 2.64271e-05 2.64896e-05 2.65179e-05 2.6537e-05 2.65024e-05 2.64768e-05 2.64682e-05 2.48999e-05 2.56557e-05 2.59691e-05 2.60914e-05
-          2.61778e-05 2.62166e-05 2.62434e-05 2.61944e-05 2.6159e-05 2.61473e-05 2.44433e-05 2.51573e-05 2.55185e-05 2.56675e-05 2.57801e-05 2.58294e-05
-          2.58656e-05 2.5798e-05 2.57518e-05 2.57375e-05 2.39864e-05 2.46645e-05 2.50349e-05 2.51902e-05 2.53256e-05 2.53807e-05 2.54279e-05 2.53372e-05
-          2.52827e-05 2.52678e-05 2.35692e-05 2.41772e-05 2.45503e-05 2.4729e-05 2.48783e-05 2.49264e-05 2.49859e-05 2.48639e-05 2.48076e-05 2.47958e-05
-          2.32257e-05 2.36832e-05 2.40358e-05 2.42711e-05 2.44403e-05 2.45113e-05 2.45847e-05 2.44214e-05 2.43719e-05 2.43674e-05 2.29742e-05 2.32591e-05
-          2.35267e-05 2.37628e-05 2.39484e-05 2.40811e-05 2.41729e-05 2.40202e-05 2.39891e-05 2.39968e-05 2.28226e-05 2.29615e-05 2.31162e-05 2.32869e-05
-          2.34435e-05 2.35876e-05 2.36911e-05 2.36536e-05 2.36545e-05 2.36788e-05 2.27527e-05 2.27982e-05 2.28565e-05 2.29423e-05 2.30344e-05 2.31374e-05
-          2.32193e-05 2.33132e-05 2.33638e-05 2.34076e-05 2.27248e-05 2.2731e-05 2.2742e-05 2.27643e-05 2.27937e-05 2.2841e-05 2.2885e-05 2.30089e-05
-          2.30982e-05 2.31617e-05 2.27318e-05 2.27384e-05 2.27444e-05 2.27515e-05 2.27592e-05 2.27723e-05 2.27853e-05 2.28462e-05 2.28998e-05 2.29471e-05
-          2.27225e-05 2.27215e-05 2.27209e-05 2.27206e-05 2.27207e-05 2.27211e-05 2.27217e-05 2.27365e-05 2.27583e-05 2.27832e-05 2.2724e-05 2.27238e-05
-          2.27235e-05 2.27233e-05 2.2723e-05 2.27227e-05 2.27224e-05 2.27201e-05 2.27202e-05 2.27231e-05
-        </DataArray>
-        <DataArray type="Float32" Name="X^Air_gas" NumberOfComponents="1" format="ascii">
-          1 1 1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1
-          1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1 1 1
-          0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1 1 1 0.999999 0.999997
-          0.999995 0.999985 0.99997 0.999955 1 1 1 1 0.999999 0.999997 0.999995 0.999985
-          0.99997 0.999955 1 1 1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955
-          1 1 1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1
-          1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1 1 1
-          0.999999 0.999997 0.999995 0.999984 0.99997 0.999955 1 1 1 1 0.999999 0.999997
-          0.999995 0.999984 0.999969 0.999954 1 1 1 1 0.999999 0.999997 0.999995 0.999983
-          0.999967 0.999952 1 1 1 0.999999 0.999999 0.999997 0.999994 0.99998 0.999964 0.999949
-          1 1 1 0.999999 0.999998 0.999996 0.999993 0.999976 0.999959 0.999943 1 1
-          1 0.999999 0.999998 0.999995 0.999991 0.999969 0.99995 0.999935 1 1 0.999999 0.999997
-          0.999995 0.999991 0.999985 0.999958 0.999937 0.999923 0.999999 0.999997 0.999995 0.999991 0.999987 0.999978
-          0.99997 0.999936 0.999916 0.999906 0.999983 0.999969 0.999958 0.999947 0.999939 0.999925 0.999914 0.999885
-          0.999879 0.99988 0.999471 0.999524 0.999562 0.999596 0.999623 0.999655 0.99968 0.999767 0.999816 0.999845
-          0.999959 0.999937 0.999923 0.999912 0.999904 0.999896 0.999891 0.999882 0.999881 0.999885 0.999999 0.999997
-          0.999996 0.999994 0.999993 0.999992 0.999991 0.99998 0.999969 0.99996
-        </DataArray>
-        <DataArray type="Float32" Name="x^Air_gas" NumberOfComponents="1" format="ascii">
-          1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1
-          1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999
-          0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999 0.999998 0.999996
-          0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975
-          0.999952 0.999928 1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928
-          1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1
-          1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999
-          0.999998 0.999996 0.999992 0.999975 0.999951 0.999927 1 1 1 0.999999 0.999998 0.999996
-          0.999992 0.999974 0.99995 0.999926 1 1 1 0.999999 0.999998 0.999995 0.999991 0.999972
-          0.999948 0.999923 1 1 1 0.999999 0.999998 0.999995 0.99999 0.999969 0.999942 0.999918
-          1 1 1 0.999999 0.999997 0.999994 0.999989 0.999962 0.999934 0.999909 1 1
-          0.999999 0.999998 0.999996 0.999992 0.999985 0.999951 0.99992 0.999896 1 0.999999 0.999998 0.999996
-          0.999992 0.999985 0.999977 0.999932 0.999899 0.999876 0.999999 0.999996 0.999992 0.999985 0.999978 0.999965
-          0.999951 0.999898 0.999866 0.999849 0.999973 0.999951 0.999933 0.999916 0.999902 0.99988 0.999862 0.999815
-          0.999805 0.999806 0.999149 0.999235 0.999296 0.99935 0.999395 0.999446 0.999485 0.999626 0.999705 0.999751
-          0.999934 0.999899 0.999876 0.999859 0.999845 0.999833 0.999825 0.99981 0.999809 0.999814 0.999998 0.999995
-          0.999993 0.999991 0.999989 0.999987 0.999985 0.999967 0.99995 0.999936
-        </DataArray>
         <DataArray type="Float32" Name="v_x/v_x,max" NumberOfComponents="1" format="ascii">
           0.496131 0.00706041 0.00441226 0.00379091 0.00349277 0.00332499 0.00326468 0.00331109 0.00340564 0.00347307 0.50732 0.0238338
           0.0149958 0.012884 0.0118709 0.0113009 0.0110965 0.0112547 0.0115756 0.0118037 0.52266 0.0469966 0.0298056 0.0256078
@@ -326,6 +231,101 @@
           2.10338e-07 2.96869e-05 3.36706e-05 0.000408596 0.00042355 0.00452434 0.0043639 0.343918 0.360194 0.370977 2.78402e-08 3.93344e-06
           4.46119e-06 5.45357e-05 5.65318e-05 0.000637402 0.00061481 0.342835 0.359251 0.370206
         </DataArray>
+        <DataArray type="Float32" Name="X^H2O_gas" NumberOfComponents="1" format="ascii">
+          2.83491e-10 1.57089e-08 8.63061e-08 3.81799e-07 1.00748e-06 2.51023e-06 4.97391e-06 1.5304e-05 2.98717e-05 4.4951e-05 2.83621e-10 1.5709e-08
+          8.63062e-08 3.818e-07 1.00748e-06 2.51023e-06 4.97391e-06 1.5304e-05 2.98718e-05 4.49511e-05 2.84056e-10 1.57094e-08 8.63072e-08 3.81804e-07
+          1.00749e-06 2.51025e-06 4.97393e-06 1.53041e-05 2.98719e-05 4.49513e-05 2.85168e-10 1.57116e-08 8.63125e-08 3.81823e-07 1.00753e-06 2.51033e-06
+          4.97406e-06 1.53047e-05 2.98728e-05 4.49522e-05 2.87716e-10 1.57199e-08 8.63327e-08 3.81895e-07 1.00766e-06 2.51065e-06 4.97454e-06 1.53068e-05
+          2.98759e-05 4.49556e-05 2.93209e-10 1.57473e-08 8.64012e-08 3.82136e-07 1.00813e-06 2.51171e-06 4.97618e-06 1.5314e-05 2.98864e-05 4.49669e-05
+          3.04415e-10 1.58312e-08 8.66166e-08 3.8289e-07 1.00958e-06 2.51503e-06 4.98137e-06 1.53363e-05 2.99191e-05 4.5002e-05 3.25596e-10 1.60715e-08
+          8.72603e-08 3.85143e-07 1.01393e-06 2.52495e-06 4.99695e-06 1.54029e-05 3.00164e-05 4.51063e-05 3.66285e-10 1.67034e-08 8.90751e-08 3.91543e-07
+          1.02632e-06 2.55323e-06 5.04155e-06 1.55928e-05 3.0293e-05 4.54013e-05 4.5386e-10 1.81837e-08 9.37373e-08 4.08287e-07 1.05894e-06 2.62809e-06
+          5.15971e-06 1.60948e-05 3.10173e-05 4.6169e-05 6.63023e-10 2.12606e-08 1.04177e-07 4.46895e-07 1.13472e-06 2.80336e-06 5.4352e-06 1.7266e-05
+          3.26748e-05 4.79062e-05 1.23211e-09 2.84985e-08 1.27041e-07 5.22961e-07 1.28517e-06 3.15718e-06 5.98425e-06 1.96234e-05 3.58955e-05 5.12214e-05
+          3.16951e-09 4.92605e-08 1.8609e-07 6.89513e-07 1.59683e-06 3.79871e-06 6.96269e-06 2.38161e-05 4.13537e-05 5.66909e-05 1.26994e-08 1.19134e-07
+          3.65325e-07 1.15476e-06 2.39828e-06 5.21768e-06 9.04856e-06 3.07409e-05 4.99089e-05 6.49418e-05 8.47188e-08 4.34547e-07 1.04621e-06 2.67642e-06
+          4.77741e-06 9.20894e-06 1.45262e-05 4.21353e-05 6.30387e-05 7.69257e-05 9.31609e-07 2.74678e-06 5.05196e-06 9.20502e-06 1.3496e-05 2.20599e-05
+          3.04922e-05 6.35924e-05 8.35381e-05 9.39914e-05 1.69764e-05 3.05851e-05 4.16903e-05 5.25247e-05 6.12578e-05 7.47335e-05 8.56282e-05 0.000114815
+          0.000121325 0.000120418 0.00052942 0.000476101 0.00043777 0.000404446 0.000376605 0.000344712 0.000320325 0.000233002 0.000183634 0.000154616
+          4.12487e-05 6.29599e-05 7.71827e-05 8.79764e-05 9.64208e-05 0.000103826 0.000108582 0.00011847 0.000118887 0.000115475 1.43685e-06 2.87433e-06
+          4.22897e-06 5.5683e-06 6.89251e-06 8.21267e-06 9.12747e-06 2.03576e-05 3.08466e-05 4.00536e-05
+        </DataArray>
+        <DataArray type="Float32" Name="x^H2O_gas" NumberOfComponents="1" format="ascii">
+          4.55722e-10 2.52526e-08 1.3874e-07 6.13755e-07 1.61956e-06 4.03527e-06 7.99569e-06 2.46014e-05 4.80189e-05 7.22583e-05 4.5593e-10 2.52527e-08
+          1.3874e-07 6.13756e-07 1.61956e-06 4.03527e-06 7.9957e-06 2.46015e-05 4.8019e-05 7.22584e-05 4.5663e-10 2.52534e-08 1.38742e-07 6.13762e-07
+          1.61957e-06 4.0353e-06 7.99574e-06 2.46017e-05 4.80193e-05 7.22587e-05 4.58417e-10 2.5257e-08 1.3875e-07 6.13793e-07 1.61963e-06 4.03544e-06
+          7.99594e-06 2.46026e-05 4.80206e-05 7.22602e-05 4.62513e-10 2.52703e-08 1.38783e-07 6.13908e-07 1.61985e-06 4.03595e-06 7.99672e-06 2.4606e-05
+          4.80257e-05 7.22657e-05 4.71344e-10 2.53144e-08 1.38893e-07 6.14296e-07 1.6206e-06 4.03766e-06 7.99936e-06 2.46175e-05 4.80425e-05 7.22839e-05
+          4.89358e-10 2.54492e-08 1.39239e-07 6.15508e-07 1.62294e-06 4.04299e-06 8.0077e-06 2.46534e-05 4.80951e-05 7.23403e-05 5.23407e-10 2.58354e-08
+          1.40274e-07 6.19131e-07 1.62993e-06 4.05893e-06 8.03274e-06 2.47605e-05 4.82516e-05 7.25079e-05 5.88815e-10 2.68513e-08 1.43191e-07 6.29419e-07
+          1.64984e-06 4.1044e-06 8.10443e-06 2.50657e-05 4.86961e-05 7.29821e-05 7.29594e-10 2.9231e-08 1.50686e-07 6.56335e-07 1.70229e-06 4.22473e-06
+          8.29437e-06 2.58727e-05 4.98604e-05 7.42162e-05 1.06583e-09 3.4177e-08 1.67468e-07 7.18399e-07 1.8241e-06 4.50649e-06 8.73724e-06 2.77554e-05
+          5.25248e-05 7.70086e-05 1.98066e-09 4.58122e-08 2.04222e-07 8.40677e-07 2.06595e-06 5.07526e-06 9.61985e-06 3.15449e-05 5.77019e-05 8.23375e-05
+          5.0951e-09 7.91879e-08 2.99146e-07 1.10841e-06 2.56696e-06 6.10654e-06 1.11927e-05 3.82847e-05 6.64758e-05 9.11293e-05 2.04148e-08 1.91512e-07
+          5.87272e-07 1.85632e-06 3.85531e-06 8.38756e-06 1.45458e-05 4.9416e-05 8.02279e-05 0.000104392 1.36188e-07 6.98549e-07 1.68182e-06 4.30243e-06
+          7.67983e-06 1.48036e-05 2.33511e-05 6.77322e-05 0.000101333 0.000123655 1.49759e-06 4.41553e-06 8.12117e-06 1.47973e-05 2.1695e-05 3.54615e-05
+          4.90162e-05 0.000102223 0.000134283 0.000151086 2.72898e-05 4.91656e-05 6.70168e-05 8.44326e-05 9.84703e-05 0.000120131 0.000137643 0.000184557
+          0.000195019 0.000193561 0.000850787 0.000765127 0.000703542 0.000650001 0.000605267 0.00055402 0.000514832 0.000374505 0.000295165 0.000248528
+          6.6307e-05 0.000101206 0.000124068 0.000141417 0.000154991 0.000166894 0.000174538 0.00019043 0.0001911 0.000185617 2.30978e-06 4.62057e-06
+          6.79819e-06 8.95119e-06 1.10799e-05 1.32021e-05 1.46726e-05 3.27251e-05 4.9586e-05 6.43859e-05
+        </DataArray>
+        <DataArray type="Float32" Name="D^H2O_gas" NumberOfComponents="1" format="ascii">
+          2.71937e-05 2.722e-05 2.72245e-05 2.72262e-05 2.72273e-05 2.72278e-05 2.72281e-05 2.72275e-05 2.72271e-05 2.72269e-05 2.70846e-05 2.71713e-05
+          2.71867e-05 2.71923e-05 2.7196e-05 2.71977e-05 2.71989e-05 2.71968e-05 2.71953e-05 2.71948e-05 2.69371e-05 2.71031e-05 2.71339e-05 2.71449e-05
+          2.71523e-05 2.71557e-05 2.7158e-05 2.71539e-05 2.71509e-05 2.71498e-05 2.67402e-05 2.70079e-05 2.70599e-05 2.70786e-05 2.70912e-05 2.70969e-05
+          2.71007e-05 2.70939e-05 2.70887e-05 2.70869e-05 2.64824e-05 2.68749e-05 2.69566e-05 2.69859e-05 2.70058e-05 2.70147e-05 2.70207e-05 2.70099e-05
+          2.70018e-05 2.6999e-05 2.61554e-05 2.669e-05 2.68124e-05 2.68565e-05 2.68864e-05 2.68999e-05 2.69089e-05 2.68926e-05 2.68804e-05 2.68762e-05
+          2.57634e-05 2.6435e-05 2.66117e-05 2.66762e-05 2.672e-05 2.67398e-05 2.6753e-05 2.6729e-05 2.67111e-05 2.6705e-05 2.53376e-05 2.60918e-05
+          2.63359e-05 2.64271e-05 2.64896e-05 2.65179e-05 2.65369e-05 2.65023e-05 2.64767e-05 2.64681e-05 2.48999e-05 2.56557e-05 2.59691e-05 2.60914e-05
+          2.61778e-05 2.62166e-05 2.62434e-05 2.61943e-05 2.61588e-05 2.61471e-05 2.44433e-05 2.51573e-05 2.55185e-05 2.56675e-05 2.57801e-05 2.58294e-05
+          2.58656e-05 2.57979e-05 2.57516e-05 2.57372e-05 2.39864e-05 2.46645e-05 2.50349e-05 2.51902e-05 2.53256e-05 2.53807e-05 2.54278e-05 2.53369e-05
+          2.52823e-05 2.52673e-05 2.35692e-05 2.41772e-05 2.45503e-05 2.4729e-05 2.48783e-05 2.49263e-05 2.49856e-05 2.48633e-05 2.48068e-05 2.47948e-05
+          2.32257e-05 2.36832e-05 2.40358e-05 2.42711e-05 2.44403e-05 2.45112e-05 2.45843e-05 2.44205e-05 2.43707e-05 2.43661e-05 2.29742e-05 2.32591e-05
+          2.35267e-05 2.37628e-05 2.39484e-05 2.40811e-05 2.41727e-05 2.40196e-05 2.39882e-05 2.39957e-05 2.28226e-05 2.29615e-05 2.31162e-05 2.32869e-05
+          2.34435e-05 2.35876e-05 2.3691e-05 2.36535e-05 2.36543e-05 2.36785e-05 2.27527e-05 2.27982e-05 2.28565e-05 2.29423e-05 2.30344e-05 2.31374e-05
+          2.32193e-05 2.33134e-05 2.33641e-05 2.34079e-05 2.27248e-05 2.2731e-05 2.2742e-05 2.27643e-05 2.27937e-05 2.2841e-05 2.2885e-05 2.3009e-05
+          2.30984e-05 2.3162e-05 2.27318e-05 2.27384e-05 2.27444e-05 2.27515e-05 2.27592e-05 2.27723e-05 2.27853e-05 2.28462e-05 2.28998e-05 2.29472e-05
+          2.27225e-05 2.27215e-05 2.27209e-05 2.27206e-05 2.27207e-05 2.27211e-05 2.27217e-05 2.27365e-05 2.27583e-05 2.27833e-05 2.2724e-05 2.27238e-05
+          2.27235e-05 2.27233e-05 2.2723e-05 2.27227e-05 2.27224e-05 2.27201e-05 2.27202e-05 2.27231e-05
+        </DataArray>
+        <DataArray type="Float32" Name="X^Air_gas" NumberOfComponents="1" format="ascii">
+          1 1 1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1
+          1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1 1 1
+          0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1 1 1 0.999999 0.999997
+          0.999995 0.999985 0.99997 0.999955 1 1 1 1 0.999999 0.999997 0.999995 0.999985
+          0.99997 0.999955 1 1 1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955
+          1 1 1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1
+          1 1 0.999999 0.999997 0.999995 0.999985 0.99997 0.999955 1 1 1 1
+          0.999999 0.999997 0.999995 0.999984 0.99997 0.999955 1 1 1 1 0.999999 0.999997
+          0.999995 0.999984 0.999969 0.999954 1 1 1 1 0.999999 0.999997 0.999995 0.999983
+          0.999967 0.999952 1 1 1 0.999999 0.999999 0.999997 0.999994 0.99998 0.999964 0.999949
+          1 1 1 0.999999 0.999998 0.999996 0.999993 0.999976 0.999959 0.999943 1 1
+          1 0.999999 0.999998 0.999995 0.999991 0.999969 0.99995 0.999935 1 1 0.999999 0.999997
+          0.999995 0.999991 0.999985 0.999958 0.999937 0.999923 0.999999 0.999997 0.999995 0.999991 0.999987 0.999978
+          0.999969 0.999936 0.999916 0.999906 0.999983 0.999969 0.999958 0.999947 0.999939 0.999925 0.999914 0.999885
+          0.999879 0.99988 0.999471 0.999524 0.999562 0.999596 0.999623 0.999655 0.99968 0.999767 0.999816 0.999845
+          0.999959 0.999937 0.999923 0.999912 0.999904 0.999896 0.999891 0.999882 0.999881 0.999885 0.999999 0.999997
+          0.999996 0.999994 0.999993 0.999992 0.999991 0.99998 0.999969 0.99996
+        </DataArray>
+        <DataArray type="Float32" Name="x^Air_gas" NumberOfComponents="1" format="ascii">
+          1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1
+          1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999
+          0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999 0.999998 0.999996
+          0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975
+          0.999952 0.999928 1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928
+          1 1 1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1
+          1 0.999999 0.999998 0.999996 0.999992 0.999975 0.999952 0.999928 1 1 1 0.999999
+          0.999998 0.999996 0.999992 0.999975 0.999951 0.999927 1 1 1 0.999999 0.999998 0.999996
+          0.999992 0.999974 0.99995 0.999926 1 1 1 0.999999 0.999998 0.999995 0.999991 0.999972
+          0.999947 0.999923 1 1 1 0.999999 0.999998 0.999995 0.99999 0.999968 0.999942 0.999918
+          1 1 1 0.999999 0.999997 0.999994 0.999989 0.999962 0.999934 0.999909 1 1
+          0.999999 0.999998 0.999996 0.999992 0.999985 0.999951 0.99992 0.999896 1 0.999999 0.999998 0.999996
+          0.999992 0.999985 0.999977 0.999932 0.999899 0.999876 0.999999 0.999996 0.999992 0.999985 0.999978 0.999965
+          0.999951 0.999898 0.999866 0.999849 0.999973 0.999951 0.999933 0.999916 0.999902 0.99988 0.999862 0.999815
+          0.999805 0.999806 0.999149 0.999235 0.999296 0.99935 0.999395 0.999446 0.999485 0.999626 0.999705 0.999751
+          0.999934 0.999899 0.999876 0.999859 0.999845 0.999833 0.999825 0.99981 0.999809 0.999814 0.999998 0.999995
+          0.999993 0.999991 0.999989 0.999987 0.999985 0.999967 0.99995 0.999936
+        </DataArray>
         <DataArray type="Float32" Name="D_t" NumberOfComponents="1" format="ascii">
           6.74089e-11 1.5758e-13 6.39191e-14 4.81353e-14 4.15364e-14 3.81463e-14 3.71972e-14 3.86559e-14 4.12195e-14 4.30916e-14 2.7197e-10 2.07645e-11
           8.51649e-12 6.41383e-12 5.53457e-12 5.08305e-12 4.95681e-12 5.15186e-12 5.49317e-12 5.74168e-12 4.01316e-09 3.1766e-10 1.3253e-10 9.98201e-11
@@ -347,159 +347,159 @@
         </DataArray>
         <DataArray type="Float32" Name="dv_x/dx_" NumberOfComponents="3" format="ascii">
           -0.110293 126.877 0 -0.0416801 6.10747 0 -0.000276757 3.88905 0 -7.52383e-05 3.37474 0
-          -3.69638e-05 3.13489 0 -1.67823e-05 3.00432 0 1.98608e-06 2.96686 0 1.55755e-05 3.0245 0
-          1.68389e-05 3.123 0 1.40014e-05 3.19288 0 -0.10835 3.91626 0 -0.0416982 6.04077 0
-          -0.000926516 3.88731 0 -0.000255692 3.37317 0 -0.000125589 3.13348 0 -5.69687e-05 3.00305 0
-          6.84228e-06 2.96583 0 5.29366e-05 3.02366 0 5.70863e-05 3.12192 0 4.73851e-05 3.19131 0
+          -3.69639e-05 3.13489 0 -1.67823e-05 3.00432 0 1.98671e-06 2.96686 0 1.55767e-05 3.02451 0
+          1.68404e-05 3.12301 0 1.40029e-05 3.1929 0 -0.10835 3.91626 0 -0.0416982 6.04077 0
+          -0.000926516 3.88731 0 -0.000255692 3.37317 0 -0.000125589 3.13348 0 -5.69684e-05 3.00305 0
+          6.84444e-06 2.96583 0 5.29407e-05 3.02366 0 5.70914e-05 3.12193 0 4.73903e-05 3.19133 0
           -0.105667 3.816 0 -0.0416967 5.93915 0 -0.00180897 3.8848 0 -0.000508225 3.37097 0
-          -0.000249555 3.13151 0 -0.000113078 3.00128 0 1.38225e-05 2.96443 0 0.00010523 3.02256 0
-          0.000113133 3.12047 0 9.3711e-05 3.1891 0 -0.101982 3.67632 0 -0.0416429 5.79684 0
-          -0.00299167 3.88037 0 -0.000861434 3.36762 0 -0.000422872 3.12857 0 -0.000191326 2.99865 0
-          2.39542e-05 2.96233 0 0.000178418 3.02089 0 0.00019101 3.11832 0 0.000157759 3.18588 0
+          -0.000249555 3.13151 0 -0.000113077 3.00128 0 1.38268e-05 2.96443 0 0.000105238 3.02256 0
+          0.000113143 3.12049 0 9.37214e-05 3.18912 0 -0.101982 3.67632 0 -0.0416429 5.79684 0
+          -0.00299167 3.88037 0 -0.000861435 3.36762 0 -0.000422873 3.12857 0 -0.000191325 2.99865 0
+          2.39616e-05 2.96233 0 0.000178432 3.0209 0 0.000191027 3.11833 0 0.000157777 3.1859 0
           -0.0969656 3.47659 0 -0.041467 5.59087 0 -0.00454375 3.87089 0 -0.00135458 3.36176 0
-          -0.000664935 3.12366 0 -0.000300228 2.99431 0 3.88585e-05 2.95879 0 0.000280832 3.01794 0
-          0.000298872 3.11464 0 0.000245829 3.18068 0 -0.0902333 3.17874 0 -0.0410214 5.27601 0
-          -0.00650496 3.84649 0 -0.00203915 3.34883 0 -0.00100201 3.11339 0 -0.000451176 2.98537 0
-          6.11984e-05 2.95115 0 0.000424058 3.01108 0 0.000447496 3.10659 0 0.000365907 3.17034 0
-          -0.0814433 2.72893 0 -0.0399936 4.77808 0 -0.00879617 3.77748 0 -0.00297219 3.31293 0
-          -0.00146691 3.08582 0 -0.000658218 2.96154 0 9.5588e-05 2.92975 0 0.000623813 2.99045 0
-          0.000650272 3.08351 0 0.000527144 3.14347 0 -0.070553 2.1808 0 -0.0377823 4.10361 0
-          -0.011031 3.58886 0 -0.00417577 3.20534 0 -0.00208751 3.00247 0 -0.000933317 2.88899 0
-          0.000150486 2.86227 0 0.000899048 2.92272 0 0.000920217 3.00973 0 0.000736379 3.06258 0
-          -0.0577801 1.64082 0 -0.033904 3.29389 0 -0.012681 3.15951 0 -0.00550822 2.92301 0
-          -0.00283508 2.77412 0 -0.00126457 2.68605 0 0.00024147 2.66938 0 0.00126159 2.72619 0
-          0.00125517 2.79921 0 0.000984276 2.83875 0 -0.0439614 1.13065 0 -0.028587 2.3642 0
-          -0.0132766 2.44033 0 -0.0065092 2.37764 0 -0.00352224 2.30922 0 -0.0015675 2.26045 0
-          0.000393511 2.2579 0 0.00168515 2.30633 0 0.00160176 2.35665 0 0.00121517 2.37716 0
-          -0.0310595 0.71154 0 -0.0228023 1.55023 0 -0.0125671 1.68564 0 -0.00661962 1.67565 0
-          -0.00382848 1.65379 0 -0.0016996 1.64898 0 0.000630445 1.664 0 0.00209866 1.70543 0
-          0.00185556 1.73352 0 0.0013321 1.7363 0 -0.019432 0.418168 0 -0.017027 0.984136 0
-          -0.0117882 1.14176 0 -0.0068872 1.12897 0 -0.00383868 1.09673 0 -0.00144634 1.07677 0
-          0.00106336 1.08412 0 0.00251015 1.1186 0 0.00196811 1.13058 0 0.00128111 1.12308 0
-          -0.00925857 0.21751 0 -0.0107804 0.571111 0 -0.0101609 0.750255 0 -0.00736768 0.792694 0
-          -0.00469564 0.773235 0 -0.00190911 0.732829 0 0.00132535 0.710748 0 0.00287047 0.704077 0
-          0.00193003 0.689545 0 0.00108295 0.67765 0 -0.00172006 0.0923388 0 -0.00463541 0.273758 0
-          -0.00663422 0.421567 0 -0.0063527 0.508524 0 -0.00523116 0.54053 0 -0.00289978 0.537226 0
-          0.000394592 0.504052 0 0.00201698 0.450339 0 0.00135343 0.413524 0 0.000727761 0.400955 0
-          0.00262761 0.0294359 0 -5.94455e-05 0.100597 0 -0.00251602 0.182972 0 -0.00349379 0.256045 0
-          -0.00376097 0.310342 0 -0.00309696 0.343588 0 -0.00150404 0.333208 0 -7.74712e-05 0.284825 0
-          0.000321895 0.24906 0 0.000264303 0.237073 0 0.00439485 0.00551161 0 0.0023642 0.0247078 0
-          0.000452543 0.0555676 0 -0.000545969 0.0914711 0 -0.00124011 0.128236 0 -0.00185734 0.160656 0
-          -0.00228441 0.17606 0 -0.00181925 0.167742 0 -0.000823551 0.152692 0 -0.000365235 0.14501 0
+          -0.000664937 3.12366 0 -0.000300226 2.99431 0 3.88704e-05 2.95879 0 0.000280854 3.01795 0
+          0.000298899 3.11466 0 0.000245857 3.1807 0 -0.0902333 3.17874 0 -0.0410214 5.27601 0
+          -0.00650496 3.84649 0 -0.00203915 3.34883 0 -0.00100202 3.11339 0 -0.000451173 2.98537 0
+          6.12167e-05 2.95116 0 0.000424092 3.01109 0 0.000447537 3.10661 0 0.000365948 3.17036 0
+          -0.0814433 2.72893 0 -0.0399936 4.77808 0 -0.00879617 3.77748 0 -0.0029722 3.31293 0
+          -0.00146691 3.08582 0 -0.000658213 2.96154 0 9.56158e-05 2.92975 0 0.000623863 2.99045 0
+          0.000650331 3.08352 0 0.000527203 3.14349 0 -0.070553 2.1808 0 -0.0377823 4.10361 0
+          -0.011031 3.58886 0 -0.00417578 3.20534 0 -0.00208752 3.00247 0 -0.000933309 2.88899 0
+          0.000150528 2.86227 0 0.000899121 2.92272 0 0.000920303 3.00975 0 0.000736465 3.06261 0
+          -0.0577801 1.64082 0 -0.033904 3.29389 0 -0.012681 3.15951 0 -0.00550823 2.92301 0
+          -0.00283509 2.77412 0 -0.00126456 2.68605 0 0.000241533 2.66939 0 0.0012617 2.7262 0
+          0.0012553 2.79924 0 0.0009844 2.83879 0 -0.0439614 1.13065 0 -0.028587 2.3642 0
+          -0.0132767 2.44033 0 -0.00650921 2.37764 0 -0.00352224 2.30922 0 -0.00156746 2.26045 0
+          0.000393633 2.25792 0 0.00168534 2.30638 0 0.00160197 2.35671 0 0.00121537 2.37724 0
+          -0.0310595 0.71154 0 -0.0228023 1.55023 0 -0.0125671 1.68564 0 -0.00661961 1.67565 0
+          -0.00382843 1.65379 0 -0.00169942 1.64899 0 0.000630795 1.66404 0 0.00209912 1.7055 0
+          0.001856 1.73362 0 0.00133249 1.73642 0 -0.019432 0.418168 0 -0.017027 0.984136 0
+          -0.0117882 1.14176 0 -0.00688718 1.12897 0 -0.00383855 1.09673 0 -0.00144591 1.07678 0
+          0.00106416 1.08414 0 0.00251112 1.11864 0 0.00196896 1.13065 0 0.00128183 1.12316 0
+          -0.00925857 0.21751 0 -0.0107804 0.571111 0 -0.0101609 0.750255 0 -0.00736766 0.792694 0
+          -0.00469552 0.773234 0 -0.00190864 0.732825 0 0.00132634 0.710739 0 0.00287175 0.704062 0
+          0.00193114 0.689526 0 0.00108388 0.677629 0 -0.00172006 0.0923388 0 -0.00463541 0.273758 0
+          -0.00663422 0.421567 0 -0.00635269 0.508523 0 -0.0052311 0.540529 0 -0.00289954 0.537222 0
+          0.000395125 0.504036 0 0.00201771 0.450301 0 0.00135414 0.413468 0 0.000728402 0.400885 0
+          0.00262761 0.0294359 0 -5.94454e-05 0.100597 0 -0.00251602 0.182972 0 -0.00349378 0.256045 0
+          -0.00376096 0.310341 0 -0.003097 0.343587 0 -0.00150414 0.3332 0 -7.75191e-05 0.284806 0
+          0.000321944 0.24903 0 0.000264383 0.237033 0 0.00439485 0.00551161 0 0.0023642 0.0247078 0
+          0.000452543 0.0555676 0 -0.000545969 0.0914711 0 -0.00124012 0.128236 0 -0.00185744 0.160656 0
+          -0.00228465 0.17606 0 -0.00181956 0.167741 0 -0.000823811 0.152689 0 -0.000365448 0.145005 0
           0.00473026 -0.000758552 0 0.00313539 0.00149118 0 0.00174517 0.0088349 0 0.00114432 0.0192991 0
-          0.000654798 0.0329084 0 -4.46176e-05 0.0479798 0 -0.00105181 0.0648671 0 -0.00156891 0.0791497 0
-          -0.00112896 0.085333 0 -0.0007163 0.0866803 0 0.00457251 -0.00149839 0 0.00322142 -0.00241308 0
-          0.00204378 -0.0011909 0 0.00160513 0.00044788 0 0.00132266 0.00295709 0 0.000998344 0.00645056 0
-          0.000500788 0.0129016 0 9.48979e-06 0.0229728 0 -0.000150649 0.0320569 0 -0.000124457 0.0369039 0
+          0.000654787 0.0329084 0 -4.46681e-05 0.0479799 0 -0.00105194 0.0648679 0 -0.00156914 0.0791517 0
+          -0.0011292 0.0853361 0 -0.000716519 0.086684 0 0.00457251 -0.00149839 0 0.00322142 -0.00241308 0
+          0.00204378 -0.0011909 0 0.00160512 0.000447878 0 0.00132265 0.00295708 0 0.000998313 0.00645056 0
+          0.000500724 0.0129018 0 9.38648e-06 0.0229735 0 -0.000150766 0.0320584 0 -0.000124568 0.0369061 0
           0.00432776 -0.00110522 0 0.00317385 -0.00210223 0 0.00210307 -0.00199346 0 0.00166322 -0.00202284 0
-          0.00140572 -0.00207269 0 0.00119942 -0.00208175 0 0.00101508 -0.00254494 0 0.000827361 -0.00316804 0
-          0.000613793 -0.00328453 0 0.00049641 -0.00311472 0 0.00408161 -0.00786002 0 0.00306586 -0.0200659 0
-          0.00205768 -0.027481 0 0.00159125 -0.0330672 0 0.00131235 -0.0377632 0 0.000915637 -0.0417575 0
-          0.000310539 -0.0451781 0 -0.000120039 -0.0480328 0 -0.000141312 -0.0502929 0 -6.49801e-05 -0.0518273 0
+          0.00140571 -0.0020727 0 0.00119939 -0.00208176 0 0.00101503 -0.00254493 0 0.000827303 -0.00316793 0
+          0.000613736 -0.00328421 0 0.000496359 -0.00311418 0 0.00408161 -0.00786002 0 0.00306586 -0.0200659 0
+          0.00205768 -0.027481 0 0.00159125 -0.0330672 0 0.00131234 -0.0377632 0 0.000915609 -0.0417574 0
+          0.000310494 -0.0451779 0 -0.000120089 -0.0480324 0 -0.000141352 -0.0502923 0 -6.50127e-05 -0.0518266 0
         </DataArray>
         <DataArray type="Float32" Name="dv_y/dx_" NumberOfComponents="3" format="ascii">
-          1.00826e-07 0.180693 0 -1.81887e-05 0.0014866 0 -6.95462e-08 0.000287318 0 -1.09249e-08 0.000121104 0
-          -4.35005e-09 6.93313e-05 0 -3.70245e-09 3.43433e-05 0 -3.78479e-09 -4.54286e-06 0 -1.63567e-09 -4.112e-05 0
-          1.13165e-09 -3.70257e-05 0 1.86203e-09 -1.84574e-05 0 6.72033e-07 0.176741 0 -6.11655e-05 0.0030299 0
-          -4.62965e-07 0.000596933 0 -7.3907e-08 0.000251456 0 -2.94158e-08 0.000143949 0 -2.50466e-08 7.12683e-05 0
-          -2.55854e-08 -9.55052e-06 0 -1.10131e-08 -8.53869e-05 0 7.68365e-09 -7.66296e-05 0 1.2591e-08 -3.80698e-05 0
-          2.42124e-06 0.170157 0 -0.000119362 0.00556385 0 -1.66543e-06 0.00112661 0 -2.7111e-07 0.000474216 0
-          -1.07846e-07 0.000271456 0 -9.18696e-08 0.000134296 0 -9.37645e-08 -1.83205e-05 0 -4.01646e-08 -0.000161048 0
-          2.83097e-08 -0.000143846 0 4.6158e-08 -7.11132e-05 0 6.63747e-06 0.161311 0 -0.000197088 0.0088754 0
-          -4.55571e-06 0.00186987 0 -7.61567e-07 0.000786501 0 -3.02757e-07 0.000450212 0 -2.58065e-07 0.000222497 0
-          -2.63082e-07 -3.11154e-05 0 -1.11952e-07 -0.000267182 0 8.00033e-08 -0.000237027 0 1.29564e-07 -0.000116356 0
+          1.00826e-07 0.180693 0 -1.81887e-05 0.0014866 0 -6.95462e-08 0.000287318 0 -1.09248e-08 0.000121104 0
+          -4.35005e-09 6.93316e-05 0 -3.70253e-09 3.43435e-05 0 -3.78492e-09 -4.54421e-06 0 -1.63576e-09 -4.11226e-05 0
+          1.13163e-09 -3.7029e-05 0 1.86208e-09 -1.84601e-05 0 6.72033e-07 0.176741 0 -6.11655e-05 0.0030299 0
+          -4.62965e-07 0.000596933 0 -7.39069e-08 0.000251456 0 -2.94158e-08 0.00014395 0 -2.50472e-08 7.12687e-05 0
+          -2.55863e-08 -9.55335e-06 0 -1.10138e-08 -8.53921e-05 0 7.68358e-09 -7.66363e-05 0 1.25913e-08 -3.80754e-05 0
+          2.42124e-06 0.170157 0 -0.000119362 0.00556385 0 -1.66543e-06 0.00112661 0 -2.7111e-07 0.000474217 0
+          -1.07846e-07 0.000271457 0 -9.18717e-08 0.000134297 0 -9.37679e-08 -1.83259e-05 0 -4.01669e-08 -0.000161058 0
+          2.83094e-08 -0.000143859 0 4.61594e-08 -7.11238e-05 0 6.63747e-06 0.161311 0 -0.000197088 0.0088754 0
+          -4.55571e-06 0.00186987 0 -7.61566e-07 0.000786502 0 -3.02756e-07 0.000450214 0 -2.58071e-07 0.000222498 0
+          -2.63091e-07 -3.11245e-05 0 -1.11959e-07 -0.000267198 0 8.00026e-08 -0.000237049 0 1.29568e-07 -0.000116373 0
           1.57436e-05 0.14965 0 -0.000298859 0.0130332 0 -1.07718e-05 0.00290938 0 -1.86934e-06 0.00122389 0
-          -7.42794e-07 0.00070074 0 -6.33742e-07 0.000345804 0 -6.45038e-07 -5.00597e-05 0 -2.71977e-07 -0.00041615 0
-          1.98107e-07 -0.000365625 0 3.17858e-07 -0.000177688 0 3.40263e-05 0.134786 0 -0.000428367 0.0178511 0
-          -2.31683e-05 0.00434403 0 -4.24261e-06 0.00183334 0 -1.68671e-06 0.00105081 0 -1.4414e-06 0.00051755 0
-          -1.464e-06 -7.86648e-05 0 -6.09316e-07 -0.000625235 0 4.55845e-07 -0.000541697 0 7.21982e-07 -0.000259511 0
-          6.82625e-05 0.116942 0 -0.000586684 0.0225039 0 -4.61156e-05 0.00624343 0 -9.13596e-06 0.00266528 0
-          -3.64615e-06 0.00153354 0 -3.12599e-06 0.000753531 0 -3.16664e-06 -0.000122938 0 -1.29368e-06 -0.000917518 0
-          1.00509e-06 -0.000778582 0 1.56317e-06 -0.000365515 0 0.000126717 0.0969499 0 -0.000770331 0.0256449 0
-          -8.4453e-05 0.00849557 0 -1.87922e-05 0.00372773 0 -7.59241e-06 0.0021689 0 -6.55851e-06 0.00106336 0
-          -6.62613e-06 -0.00019314 0 -2.6347e-06 -0.00131822 0 2.16107e-06 -0.00108295 0 3.27404e-06 -0.000494355 0
+          -7.42794e-07 0.000700743 0 -6.33756e-07 0.000345805 0 -6.45061e-07 -5.00743e-05 0 -2.71993e-07 -0.000416176 0
+          1.98106e-07 -0.000365658 0 3.17868e-07 -0.000177714 0 3.40263e-05 0.134786 0 -0.000428367 0.0178511 0
+          -2.31683e-05 0.00434403 0 -4.2426e-06 0.00183335 0 -1.68671e-06 0.00105082 0 -1.44143e-06 0.000517552 0
+          -1.46405e-06 -7.86875e-05 0 -6.09351e-07 -0.000625273 0 4.55842e-07 -0.000541747 0 7.22006e-07 -0.00025955 0
+          6.82625e-05 0.116942 0 -0.000586684 0.0225039 0 -4.61156e-05 0.00624343 0 -9.13594e-06 0.00266528 0
+          -3.64615e-06 0.00153354 0 -3.12606e-06 0.000753533 0 -3.16675e-06 -0.000122973 0 -1.29375e-06 -0.000917573 0
+          1.00509e-06 -0.000778655 0 1.56322e-06 -0.000365572 0 0.000126717 0.0969499 0 -0.000770331 0.0256449 0
+          -8.4453e-05 0.00849557 0 -1.87922e-05 0.00372774 0 -7.59241e-06 0.00216891 0 -6.55867e-06 0.00106336 0
+          -6.62636e-06 -0.000193194 0 -2.63486e-06 -0.0013183 0 2.16106e-06 -0.00108306 0 3.27416e-06 -0.000494435 0
           0.000216142 0.0757438 0 -0.000969233 0.0264825 0 -0.000140903 0.0105719 0 -3.64976e-05 0.00487246 0
-          -1.51691e-05 0.00290718 0 -1.33414e-05 0.0014222 0 -1.34665e-05 -0.00030537 0 -5.14194e-06 -0.00183654 0
-          4.56814e-06 -0.00143072 0 6.6543e-06 -0.000629449 0 0.000340511 0.0547655 0 -0.00116493 0.0254305 0
-          -0.000215297 0.0116284 0 -6.51999e-05 0.00570099 0 -2.84828e-05 0.00357531 0 -2.60097e-05 0.00174537 0
-          -2.6357e-05 -0.000480226 0 -9.44845e-06 -0.00244245 0 9.46972e-06 -0.00174097 0 1.29771e-05 -0.000732252 0
-          0.000503563 0.0357448 0 -0.00133489 0.0229451 0 -0.000308144 0.0118196 0 -0.000104761 0.00628179 0
-          -4.86994e-05 0.00389219 0 -4.77187e-05 0.00187182 0 -4.89653e-05 -0.000771338 0 -1.58288e-05 -0.00310436 0
-          1.90649e-05 -0.00190113 0 2.37554e-05 -0.000760762 0 0.000703572 0.0198167 0 -0.00144886 0.0185752 0
-          -0.000413045 0.011653 0 -0.000159277 0.00707737 0 -8.08173e-05 0.00424062 0 -8.13532e-05 0.00215345 0
-          -8.54108e-05 -0.00123215 0 -2.2856e-05 -0.00378749 0 3.72819e-05 -0.00184042 0 4.00433e-05 -0.000696303 0
-          0.000915046 0.00774123 0 -0.00147052 0.0124015 0 -0.000499171 0.0101882 0 -0.000227913 0.00750047 0
-          -0.000130507 0.00503582 0 -0.000138645 0.00305035 0 -0.000147669 -0.0013223 0 -2.59348e-05 -0.00387876 0
-          7.04226e-05 -0.00152595 0 6.17727e-05 -0.000539184 0 0.00108818 -6.6606e-05 0 -0.00139194 0.0060304 0
-          -0.000527043 0.0067898 0 -0.000279121 0.00630229 0 -0.000184327 0.00520713 0 -0.000229243 0.00383225 0
-          -0.000246581 -9.85266e-05 0 -2.75927e-05 -0.00251783 0 0.00011496 -0.000950709 0 8.59473e-05 -0.000299051 0
-          0.00117688 -0.00407834 0 -0.00124725 0.00123243 0 -0.000490317 0.00277477 0 -0.000279451 0.00357041 0
-          -0.000210941 0.00372796 0 -0.000311418 0.00333041 0 -0.000354453 0.00179553 0 -5.36852e-05 5.21218e-06 0
-          0.000142675 -8.03567e-05 0 0.000104214 9.08983e-06 0 0.0011631 -0.00553915 0 -0.00107951 -0.00140426 0
-          -0.000420456 -0.000148229 0 -0.000235665 0.000775487 0 -0.000195268 0.00136254 0 -0.000317341 0.00166028 0
-          -0.000398175 0.00229102 0 -0.000113113 0.00192687 0 0.000115137 0.000839788 0 9.41029e-05 0.000342184 0
-          0.00105737 -0.00570304 0 -0.000903176 -0.00241916 0 -0.000351194 -0.00150059 0 -0.000183025 -0.000900534 0
-          -0.000154469 -0.000443514 0 -0.000252157 -1.03461e-06 0 -0.000337437 0.00102978 0 -0.00014631 0.0017888 0
-          4.15315e-05 0.00099775 0 4.06943e-05 0.000442492 0 0.000874879 -0.00540497 0 -0.000704002 -0.0027089 0
-          -0.000284759 -0.00189374 0 -0.00014121 -0.00149448 0 -0.000114893 -0.00121552 0 -0.000185695 -0.000889617 0
-          -0.000238244 -0.000364107 0 -0.000115975 0.000400298 0 -5.16303e-06 0.000268136 0 -5.1277e-06 0.000161938 0
-          0.000605539 -0.00503133 0 -0.00046393 -0.00279256 0 -0.000199274 -0.00195887 0 -9.81821e-05 -0.00159138 0
-          -7.88013e-05 -0.00136257 0 -0.000145648 -0.00110486 0 -0.000176072 -0.000672613 0 -6.72182e-05 -0.00019461 0
-          1.17133e-05 -0.000143875 0 1.41241e-05 -6.91047e-05 0 0.000222772 -0.00481977 0 -0.000165903 -0.00280761 0
-          -7.4387e-05 -0.00195172 0 -3.67749e-05 -0.00157569 0 -2.96866e-05 -0.00134475 0 -6.48586e-05 -0.00108853 0
-          -7.88261e-05 -0.000444342 0 -2.33738e-05 -3.98771e-08 0 1.68176e-05 -2.87943e-05 0 2.10624e-05 -7.24523e-05 0
+          -1.51691e-05 0.00290719 0 -1.33417e-05 0.00142219 0 -1.3467e-05 -0.000305463 0 -5.14225e-06 -0.00183667 0
+          4.56814e-06 -0.0014309 0 6.65459e-06 -0.000629568 0 0.000340511 0.0547655 0 -0.00116493 0.0254305 0
+          -0.000215297 0.0116284 0 -6.51998e-05 0.00570099 0 -2.84829e-05 0.0035753 0 -2.60105e-05 0.00174531 0
+          -2.6358e-05 -0.000480446 0 -9.44907e-06 -0.00244272 0 9.46976e-06 -0.00174129 0 1.29778e-05 -0.000732448 0
+          0.000503563 0.0357448 0 -0.00133489 0.0229451 0 -0.000308144 0.0118196 0 -0.000104761 0.00628178 0
+          -4.86999e-05 0.00389215 0 -4.77209e-05 0.00187161 0 -4.89675e-05 -0.000771873 0 -1.583e-05 -0.00310497 0
+          1.90655e-05 -0.00190176 0 2.37577e-05 -0.000761101 0 0.000703572 0.0198167 0 -0.00144886 0.0185752 0
+          -0.000413045 0.011653 0 -0.000159277 0.00707736 0 -8.08197e-05 0.00424055 0 -8.13599e-05 0.00215313 0
+          -8.54166e-05 -0.00123306 0 -2.28578e-05 -0.00378857 0 3.72852e-05 -0.00184145 0 4.00511e-05 -0.000696815 0
+          0.000915046 0.00774123 0 -0.00147052 0.0124015 0 -0.000499171 0.0101882 0 -0.000227914 0.00750046 0
+          -0.000130512 0.00503576 0 -0.000138661 0.00305007 0 -0.000147684 -0.00132324 0 -2.59379e-05 -0.00387991 0
+          7.04326e-05 -0.00152708 0 6.17923e-05 -0.000539756 0 0.00108818 -6.6606e-05 0 -0.00139194 0.0060304 0
+          -0.000527043 0.0067898 0 -0.000279122 0.00630228 0 -0.000184336 0.0052071 0 -0.00022927 0.00383212 0
+          -0.000246607 -9.89703e-05 0 -2.7599e-05 -0.00251845 0 0.000114977 -0.000951418 0 8.59811e-05 -0.000299449 0
+          0.00117688 -0.00407834 0 -0.00124725 0.00123243 0 -0.000490318 0.00277477 0 -0.000279453 0.00357041 0
+          -0.000210951 0.00372795 0 -0.000311447 0.0033304 0 -0.000354483 0.00179562 0 -5.36969e-05 5.21854e-06 0
+          0.000142692 -8.04483e-05 0 0.000104254 8.99582e-06 0 0.0011631 -0.00553915 0 -0.00107951 -0.00140426 0
+          -0.000420456 -0.00014823 0 -0.000235667 0.000775487 0 -0.000195278 0.00136254 0 -0.000317364 0.00166032 0
+          -0.0003982 0.00229125 0 -0.000113128 0.00192714 0 0.000115149 0.000840042 0 9.41366e-05 0.000342297 0
+          0.00105737 -0.00570304 0 -0.000903177 -0.00241916 0 -0.000351195 -0.00150059 0 -0.000183027 -0.000900533 0
+          -0.000154476 -0.00044351 0 -0.000252172 -9.99175e-07 0 -0.000337453 0.00102992 0 -0.00014632 0.00178903 0
+          4.15388e-05 0.000998015 0 4.07163e-05 0.000442639 0 0.000874879 -0.00540497 0 -0.000704002 -0.0027089 0
+          -0.000284759 -0.00189374 0 -0.000141211 -0.00149448 0 -0.000114899 -0.00121551 0 -0.000185705 -0.000889589 0
+          -0.000238252 -0.000364035 0 -0.000115979 0.000400417 0 -5.15776e-06 0.000268289 0 -5.11511e-06 0.000162032 0
+          0.000605539 -0.00503133 0 -0.00046393 -0.00279256 0 -0.000199274 -0.00195887 0 -9.81833e-05 -0.00159137 0
+          -7.88054e-05 -0.00136256 0 -0.000145655 -0.00110483 0 -0.000176077 -0.000672561 0 -6.72182e-05 -0.000194544 0
+          1.17174e-05 -0.0001438 0 1.41312e-05 -6.90586e-05 0 0.000222772 -0.00481977 0 -0.000165903 -0.00280761 0
+          -7.4387e-05 -0.00195172 0 -3.67753e-05 -0.00157569 0 -2.96881e-05 -0.00134474 0 -6.48611e-05 -0.00108851 0
+          -7.88275e-05 -0.000444292 0 -2.33734e-05 1.39094e-08 0 1.68192e-05 -2.87439e-05 0 2.10649e-05 -7.2424e-05 0
         </DataArray>
         <DataArray type="Float32" Name="velocity_gas (m/s)" NumberOfComponents="3" format="ascii">
           0.0504817 2.18438e-05 0 0.000736099 9.0743e-08 0 0.000465557 1.72821e-08 0 0.00040399 7.28756e-09 0
-          0.000375272 4.17209e-09 0 0.000359636 2.06706e-09 0 0.000355136 -2.70809e-10 0 0.00036202 -2.47365e-09 0
-          0.000373822 -2.23226e-09 0 0.000382217 -1.1152e-09 0 0.0516201 7.35155e-05 0 0.00248484 6.0483e-07 0
-          0.00158227 1.16896e-07 0 0.00137302 4.92714e-08 0 0.00127544 2.82063e-08 0 0.00122233 1.39694e-08 0
-          0.00120709 -1.84936e-09 0 0.00123054 -1.67261e-08 0 0.0012706 -1.5056e-08 0 0.00129901 -7.50249e-09 0
+          0.000375272 4.17208e-09 0 0.000359636 2.06699e-09 0 0.000355137 -2.71038e-10 0 0.000362023 -2.474e-09 0
+          0.000373826 -2.23263e-09 0 0.000382223 -1.1154e-09 0 0.0516201 7.35155e-05 0 0.00248484 6.0483e-07 0
+          0.00158227 1.16896e-07 0 0.00137302 4.92713e-08 0 0.00127544 2.82062e-08 0 0.00122233 1.39689e-08 0
+          0.00120709 -1.85091e-09 0 0.00123055 -1.67285e-08 0 0.00127061 -1.50585e-08 0 0.00129903 -7.50384e-09 0
           0.053181 0.000143663 0 0.00489974 2.17912e-06 0 0.00314491 4.28722e-07 0 0.00272897 1.80604e-07 0
-          0.00253505 1.03385e-07 0 0.00242952 5.11779e-08 0 0.00239938 -6.85722e-09 0 0.00244611 -6.13142e-08 0
-          0.00252562 -5.50215e-08 0 0.00258181 -2.73307e-08 0 0.0553024 0.00023771 0 0.00821588 5.97372e-06 0
-          0.00533094 1.20403e-06 0 0.00462588 5.06868e-07 0 0.00429723 2.90137e-07 0 0.00411846 1.4353e-07 0
-          0.00406768 -1.95369e-08 0 0.00414721 -1.72097e-07 0 0.00428172 -1.53787e-07 0 0.00437631 -7.60599e-08 0
+          0.00253505 1.03385e-07 0 0.00242952 5.1176e-08 0 0.00239938 -6.86291e-09 0 0.00244613 -6.13227e-08 0
+          0.00252565 -5.50307e-08 0 0.00258185 -2.73357e-08 0 0.0553024 0.00023771 0 0.00821588 5.97372e-06 0
+          0.00533094 1.20403e-06 0 0.00462588 5.06868e-07 0 0.00429723 2.90136e-07 0 0.00411846 1.43525e-07 0
+          0.00406769 -1.95528e-08 0 0.00414724 -1.72121e-07 0 0.00428177 -1.53813e-07 0 0.00437638 -7.60738e-08 0
           0.0581475 0.000361585 0 0.0127309 1.41693e-05 0 0.00838707 2.95481e-06 0 0.00727844 1.24312e-06 0
-          0.00676158 7.11567e-07 0 0.00648056 3.51691e-07 0 0.00640137 -4.89111e-08 0 0.0065272 -4.22182e-07 0
-          0.00673827 -3.75059e-07 0 0.00688567 -1.84374e-07 0 0.0618777 0.000520747 0 0.01879 3.06236e-05 0
-          0.012652 6.7066e-06 0 0.0109841 2.82163e-06 0 0.0102051 1.6154e-06 0 0.0097817 7.97409e-07 0
-          0.00966376 -1.1425e-07 0 0.00985514 -9.58997e-07 0 0.0101725 -8.44925e-07 0 0.0103919 -4.11806e-07 0
+          0.00676159 7.11564e-07 0 0.00648057 3.51678e-07 0 0.00640139 -4.89503e-08 0 0.00652724 -4.22241e-07 0
+          0.00673835 -3.75123e-07 0 0.00688578 -1.84408e-07 0 0.0618777 0.000520747 0 0.01879 3.06236e-05 0
+          0.012652 6.7066e-06 0 0.0109841 2.82163e-06 0 0.0102051 1.61539e-06 0 0.00978171 7.9738e-07 0
+          0.00966378 -1.14339e-07 0 0.00985521 -9.59131e-07 0 0.0101726 -8.45069e-07 0 0.010392 -4.11883e-07 0
           0.0665643 0.000718478 0 0.026701 6.14362e-05 0 0.018572 1.44571e-05 0 0.0161456 6.0975e-06 0
-          0.0150054 3.49383e-06 0 0.0143854 1.72178e-06 0 0.0142157 -2.57256e-07 0 0.0145001 -2.07734e-06 0
-          0.014964 -1.8086e-06 0 0.0152801 -8.70857e-07 0 0.0719939 0.000954248 0 0.0365023 0.000114045 0
-          0.0266551 2.98509e-05 0 0.0232651 1.27017e-05 0 0.0216442 7.29992e-06 0 0.0207602 3.59013e-06 0
-          0.0205244 -5.70027e-07 0 0.0209408 -4.35946e-06 0 0.0216029 -3.72947e-06 0 0.0220444 -1.76542e-06 0
+          0.0150054 3.49382e-06 0 0.0143854 1.72172e-06 0 0.0142157 -2.57449e-07 0 0.0145002 -2.07763e-06 0
+          0.0149642 -1.80891e-06 0 0.0152803 -8.71024e-07 0 0.0719939 0.000954248 0 0.0365023 0.000114045 0
+          0.0266551 2.98509e-05 0 0.0232651 1.27017e-05 0 0.0216442 7.29989e-06 0 0.0207602 3.58999e-06 0
+          0.0205245 -5.70434e-07 0 0.0209409 -4.36007e-06 0 0.0216032 -3.73012e-06 0 0.0220448 -1.76577e-06 0
           0.0778822 0.00122163 0 0.0479979 0.000194528 0 0.0371974 5.85473e-05 0 0.0327807 2.54435e-05 0
-          0.0305876 1.47494e-05 0 0.0293788 7.23919e-06 0 0.0290703 -1.25953e-06 0 0.0296685 -8.91696e-06 0
-          0.0305837 -7.4254e-06 0 0.0311738 -3.43372e-06 0 0.0839155 0.00150458 0 0.0604347 0.000306459 0
-          0.0496112 0.000106663 0 0.0445028 4.81032e-05 0 0.0418002 2.84215e-05 0 0.0402763 1.39214e-05 0
-          0.0399193 -2.78757e-06 0 0.0407481 -1.7699e-05 0 0.0419404 -1.41167e-05 0 0.0426687 -6.33295e-06 0
+          0.0305876 1.47493e-05 0 0.0293788 7.2389e-06 0 0.0290704 -1.26036e-06 0 0.0296687 -8.91821e-06 0
+          0.0305841 -7.42674e-06 0 0.0311743 -3.43442e-06 0 0.0839155 0.00150458 0 0.0604347 0.000306459 0
+          0.0496112 0.000106663 0 0.0445028 4.81032e-05 0 0.0418002 2.84214e-05 0 0.0402764 1.39208e-05 0
+          0.0399195 -2.78922e-06 0 0.0407484 -1.77014e-05 0 0.0419408 -1.41193e-05 0 0.0426693 -6.3343e-06 0
           0.0893832 0.0017787 0 0.0720465 0.000453206 0 0.0620204 0.000176831 0 0.0569659 8.34335e-05 0
-          0.0540768 5.11163e-05 0 0.0523716 2.49931e-05 0 0.0520362 -6.13366e-06 0 0.0531254 -3.37439e-05 0
-          0.0545507 -2.51108e-05 0 0.0553482 -1.08676e-05 0 0.0940484 0.00201361 0 0.0825112 0.000633215 0
-          0.073616 0.000274983 0 0.0683652 0.000137561 0 0.0653511 8.38516e-05 0 0.0637577 4.05931e-05 0
-          0.0636117 -1.37179e-05 0 0.065026 -6.18356e-05 0 0.066614 -4.11163e-05 0 0.0673791 -1.71281e-05 0
+          0.0540768 5.11161e-05 0 0.0523716 2.49921e-05 0 0.0520363 -6.13646e-06 0 0.0531257 -3.3748e-05 0
+          0.0545511 -2.51152e-05 0 0.0553487 -1.08698e-05 0 0.0940484 0.00201361 0 0.0825112 0.000633215 0
+          0.073616 0.000274983 0 0.0683652 0.000137561 0 0.0653511 8.38514e-05 0 0.0637577 4.05919e-05 0
+          0.0636117 -1.37214e-05 0 0.0650261 -6.18407e-05 0 0.0666141 -4.11219e-05 0 0.0673793 -1.71307e-05 0
           0.0977202 0.00217379 0 0.0916673 0.000823542 0 0.0847837 0.000409159 0 0.0794742 0.000224537 0
-          0.0759423 0.00013567 0 0.0738384 6.79691e-05 0 0.0736471 -3.05554e-05 0 0.0754195 -0.000109073 0
-          0.0770797 -6.16356e-05 0 0.0777254 -2.46678e-05 0 0.10012 0.00222969 0 0.0984519 0.000979365 0
-          0.0945571 0.000559355 0 0.0904909 0.000346916 0 0.0869337 0.000224422 0 0.0842131 0.000125787 0
-          0.0834522 -5.04247e-05 0 0.0846827 -0.000169852 0 0.0858679 -8.3483e-05 0 0.0863028 -3.20658e-05 0
+          0.0759423 0.00013567 0 0.0738384 6.79678e-05 0 0.0736471 -3.05584e-05 0 0.0754194 -0.000109077 0
+          0.0770796 -6.16403e-05 0 0.0777253 -2.46693e-05 0 0.10012 0.00222969 0 0.0984519 0.000979365 0
+          0.0945571 0.000559355 0 0.0904909 0.000346916 0 0.0869337 0.000224421 0 0.0842131 0.000125786 0
+          0.0834522 -5.0427e-05 0 0.0846828 -0.000169853 0 0.0858679 -8.3486e-05 0 0.0863028 -3.20656e-05 0
           0.101328 0.00217119 0 0.102365 0.00105919 0 0.101257 0.000674482 0 0.0993456 0.000470811 0
-          0.0970646 0.000339155 0 0.0948324 0.000217756 0 0.0933488 -3.42915e-05 0 0.0930294 -0.000207327 0
-          0.0932584 -9.86601e-05 0 0.0934178 -3.62807e-05 0 0.10173 0.00200657 0 0.103955 0.00104679 0
-          0.104567 0.000711155 0 0.104498 0.000542244 0 0.103912 0.000428371 0 0.10301 0.000307989 0
-          0.101684 4.77471e-05 0 0.100271 -0.000169638 0 0.0995036 -8.79475e-05 0 0.0992855 -3.15887e-05 0
-          0.101751 0.00174694 0 0.104257 0.000951637 0 0.105513 0.000663129 0 0.106351 0.000530206 0
-          0.106886 0.000443512 0 0.107137 0.000344898 0 0.106833 0.000141042 0 0.105876 -5.99189e-05 0
-          0.104952 -3.45053e-05 0 0.104523 -1.01547e-05 0 0.101649 0.00139505 0 0.104115 0.000787391 0
-          0.105514 0.000550252 0 0.106568 0.000445682 0 0.10744 0.000380812 0 0.108155 0.000307854 0
-          0.108639 0.00015806 0 0.108756 2.20213e-05 0 0.108651 1.88947e-05 0 0.108576 1.57744e-05 0
-          0.101526 0.000935563 0 0.103895 0.000544985 0 0.105334 0.000378847 0 0.106419 0.000305858 0
-          0.10733 0.000261037 0 0.108106 0.000211326 0 0.10877 8.63134e-05 0 0.109324 7.12027e-08 0
-          0.109763 5.64272e-06 0 0.110061 1.40911e-05 0 0.101416 0.000337651 0 0.103673 0.000200495 0
-          0.105095 0.000138568 0 0.106143 0.000111231 0 0.107005 9.44412e-05 0 0.107718 7.56186e-05 0
-          0.108104 1.66313e-05 0 0.108091 -1.89618e-05 0 0.10796 -1.14232e-05 0 0.107921 1.20507e-06 0
+          0.0970646 0.000339154 0 0.0948325 0.000217753 0 0.0933489 -3.42954e-05 0 0.0930295 -0.00020733 0
+          0.0932586 -9.86641e-05 0 0.0934181 -3.62807e-05 0 0.10173 0.00200657 0 0.103955 0.00104679 0
+          0.104567 0.000711155 0 0.104498 0.000542244 0 0.103912 0.00042837 0 0.10301 0.000307985 0
+          0.101684 4.77401e-05 0 0.100271 -0.000169646 0 0.0995037 -8.79556e-05 0 0.0992856 -3.15917e-05 0
+          0.101751 0.00174694 0 0.104257 0.000951637 0 0.105513 0.000663129 0 0.106351 0.000530205 0
+          0.106886 0.00044351 0 0.107137 0.000344894 0 0.106833 0.000141034 0 0.105876 -5.99289e-05 0
+          0.104952 -3.45162e-05 0 0.104523 -1.01603e-05 0 0.101649 0.00139505 0 0.104115 0.000787391 0
+          0.105514 0.000550252 0 0.106568 0.000445682 0 0.10744 0.000380811 0 0.108155 0.00030785 0
+          0.108639 0.000158053 0 0.108756 2.20121e-05 0 0.108651 1.88847e-05 0 0.108576 1.57687e-05 0
+          0.101526 0.000935563 0 0.103895 0.000544985 0 0.105334 0.000378847 0 0.106419 0.000305857 0
+          0.10733 0.000261036 0 0.108106 0.000211323 0 0.10877 8.63086e-05 0 0.109324 6.51994e-08 0
+          0.109763 5.6364e-06 0 0.110061 1.40874e-05 0 0.101416 0.000337651 0 0.103673 0.000200495 0
+          0.105095 0.000138568 0 0.106143 0.000111231 0 0.107005 9.44409e-05 0 0.107718 7.56176e-05 0
+          0.108104 1.66296e-05 0 0.108091 -1.89638e-05 0 0.10796 -1.14253e-05 0 0.107921 1.20382e-06 0
         </DataArray>
         <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii">
           0 0 0 0 0 0 0 0 0 0 0 0