diff --git a/dumux/freeflow/stokes/stokesvolumevariables.hh b/dumux/freeflow/stokes/stokesvolumevariables.hh
index 4ffffb350e66349cfe37322fee17af424585e8f4..0b0fdd64a2e213c3ab5cccba41edda6b0a8e8ae2 100644
--- a/dumux/freeflow/stokes/stokesvolumevariables.hh
+++ b/dumux/freeflow/stokes/stokesvolumevariables.hh
@@ -52,7 +52,7 @@ class StokesVolumeVariables : public ImplicitVolumeVariables<TypeTag>
 
     enum {
         dim = GridView::dimension,
-
+        dimWorld = GridView::dimensionworld,
         momentumXIdx = Indices::momentumXIdx,
         lastMomentumIdx = Indices::lastMomentumIdx,
         pressureIdx = Indices::pressureIdx
@@ -67,6 +67,7 @@ class StokesVolumeVariables : public ImplicitVolumeVariables<TypeTag>
     typedef typename GET_PROP_TYPE(TypeTag, FluidState) FluidState;
 
     typedef Dune::FieldVector<Scalar, dim> DimVector;
+    typedef Dune::FieldVector<Scalar, dimWorld> GlobalPosition;
 
 public:
     /*!
@@ -88,6 +89,7 @@ public:
 
         completeFluidState(priVars, problem, element, fvGeometry, scvIdx, fluidState_, isOldSol);
 
+        globalPos_ = fvGeometry.subContVol[scvIdx].global;
         for (int dimIdx=momentumXIdx; dimIdx<=lastMomentumIdx; ++dimIdx)
             velocity_[dimIdx] = priVars[dimIdx];
     }
@@ -137,6 +139,12 @@ public:
     FluidState &fluidState()
     { return fluidState_; }
 
+    /*!
+     * \brief Returns the global position for the control-volume.
+     */
+    const GlobalPosition globalPos() const
+    { return globalPos_; }
+
     /*!
      * \brief Returns the mass density \f$\mathrm{[kg/m^3]}\f$ of the fluid within the
      *        sub-control volume.
@@ -144,7 +152,6 @@ public:
     Scalar density() const
     { return fluidState_.density(phaseIdx); }
 
-
     /*!
      * \brief Returns the molar density \f$\mathrm{[mol/m^3]}\f$ of the fluid within the
      *        sub-control volume.
@@ -204,6 +211,7 @@ protected:
     }
 
     DimVector velocity_;
+    GlobalPosition globalPos_;
     FluidState fluidState_;
 
 private:
diff --git a/dumux/freeflow/zeroeq/zeroeqfluxvariables.hh b/dumux/freeflow/zeroeq/zeroeqfluxvariables.hh
index e72aa1c50666d93c7c0c21ffe347de1fc484b947..98029292e1a945fa683c25f9f73a3aed756d6aae 100644
--- a/dumux/freeflow/zeroeq/zeroeqfluxvariables.hh
+++ b/dumux/freeflow/zeroeq/zeroeqfluxvariables.hh
@@ -74,16 +74,15 @@ public:
         , eddyViscosityModel_(GET_PARAM_FROM_GROUP(TypeTag, int, ZeroEq, EddyViscosityModel))
         , karmanConstant_(GET_PROP_VALUE(TypeTag, KarmanConstant))
     {
-        DimVector globalPos = this->face().ipGlobal;
         dynamicEddyViscosity_ = 0.0;
         mixingLength_ = 0.0;
         dynamicEddyViscosityInner_ = 0.0;
         dynamicEddyViscosityOuter_ = 0.0;
         fz_ = 0.0;
-        posIdx_ = problem.model().getPosIdx(globalPos);
-        wallIdx_ = problem.model().getWallIdx(globalPos, posIdx_);
-        distanceToWallRough_ = std::abs(problem.model().distanceToWallRough(globalPos, wallIdx_, posIdx_));
-        distanceToWallReal_ = std::abs(problem.model().distanceToWallReal(globalPos, wallIdx_, posIdx_));
+        posIdx_ = problem.model().getPosIdx(globalPos());
+        wallIdx_ = problem.model().getWallIdx(globalPos(), posIdx_);
+        distanceToWallRough_ = std::abs(problem.model().distanceToWallRough(globalPos(), wallIdx_, posIdx_));
+        distanceToWallReal_ = std::abs(problem.model().distanceToWallReal(globalPos(), wallIdx_, posIdx_));
         for (int dimIdx = 0; dimIdx < dim; ++dimIdx)
             maxVelocity_[dimIdx] = problem.model().wall[wallIdx_].maxVelocity[posIdx_][dimIdx];
         for (int dimIdx = 0; dimIdx < dim; ++dimIdx)
@@ -209,7 +208,13 @@ protected:
 
 public:
     /*!
-     * \brief Returns the mixing length \f$\mathrm{[m]}\f$ for the element center.
+     * \brief Returns the global coordinates of the integration point.
+     */
+    DimVector globalPos() const
+    { return this->face().ipGlobal; }
+
+    /*!
+     * \brief Returns the mixing length \f$\mathrm{[m]}\f$.
      */
     Scalar mixingLength() const
     { return mixingLength_; }
@@ -275,6 +280,12 @@ public:
     Scalar yPlusRough() const
     { return yPlusRough_; }
 
+    /*!
+     * \brief Returns a dimensionless velocity \f$\mathrm{[-]}\f$.
+     */
+    Scalar uPlus() const
+    { return this->velocity()[flowNormal_] / frictionVelocityWall(); }
+
     /*!
      * \brief Returns the Karman constant \f$\mathrm{[-]}\f$.
      */
diff --git a/dumux/freeflow/zeroeq/zeroeqmodel.hh b/dumux/freeflow/zeroeq/zeroeqmodel.hh
index 4c15939fa29c2255b8f87682ec995a3b60225203..dcccae55209f3f0ac470b9ad995e532d7518aab4 100644
--- a/dumux/freeflow/zeroeq/zeroeqmodel.hh
+++ b/dumux/freeflow/zeroeq/zeroeqmodel.hh
@@ -77,25 +77,18 @@ class ZeroEqModel : public GET_PROP_TYPE(TypeTag, BaseStokesModel)
         intervals = GET_PROP_VALUE(TypeTag, NumberOfIntervals),
         bboxMinIsWall = GET_PROP_VALUE(TypeTag, BBoxMinIsWall),
         bboxMaxIsWall = GET_PROP_VALUE(TypeTag, BBoxMaxIsWall),
-        walls = (bboxMinIsWall ? 1 : 0) + (bboxMaxIsWall ? 1 : 0),
-        prec = Indices::scvDataPrecision, // precision of scv data
-        width = Indices::scvDataWidth // width of column
+        walls = (bboxMinIsWall ? 1 : 0) + (bboxMaxIsWall ? 1 : 0)
     };
-    enum { numEq = GET_PROP_VALUE(TypeTag, NumEq) };
 
     typedef typename GridView::template Codim<0>::Iterator ElementIterator;
-    typedef typename GridView::template Codim<dim>::Iterator VertexIterator;
     typedef typename GridView::IntersectionIterator IntersectionIterator;
     typedef Dune::ReferenceElements<Scalar, dim> ReferenceElements;
     typedef Dune::ReferenceElement<Scalar, dim> ReferenceElement;
 
     typedef Dune::FieldVector<Scalar, dimWorld> GlobalPosition;
-    typedef Dune::FieldVector<Scalar, dimWorld> DimVector;
 
     typedef typename GridView::template Codim<0>::Entity Element;
     typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry;
-    typedef typename GET_PROP_TYPE(TypeTag, ElementBoundaryTypes) ElementBoundaryTypes;
-    typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
     typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector;
 
     typedef typename GET_PROP_TYPE(TypeTag, VolumeVariables) VolumeVariables;
@@ -107,7 +100,6 @@ public:
     ZeroEqModel()
         : flowNormal_(GET_PARAM_FROM_GROUP(TypeTag, int, ZeroEq, FlowNormal))
         , wallNormal_(GET_PARAM_FROM_GROUP(TypeTag, int, ZeroEq, WallNormal))
-        , writeAllSCVData_(GET_PARAM_FROM_GROUP(TypeTag, Scalar, ZeroEq, WriteAllSCVData))
     {
         eps_ = 1e-6;
 
@@ -122,58 +114,6 @@ public:
         }
     }
 
-    /*!
-     * \brief Calculate the fluxes across a certain layer in the domain.
-     *        The layer is situated perpendicular to the coordinate axis "coord" and cuts
-     *        the axis at the value "coordVal".
-     *
-     * \param globalSol The global solution vector.
-     * \param flux A vector to store the flux.
-     * \param axis The dimension, perpendicular to which the layer is situated.
-     * \param coordVal The (Scalar) coordinate on the axis, at which the layer is situated.
-     */
-    void calculateFluxAcrossLayer(const SolutionVector &globalSol, Dune::FieldVector<Scalar, numEq> &flux, int axis, Scalar coordVal)
-    {
-        GlobalPosition globalI, globalJ;
-        PrimaryVariables tmpFlux(0.0);
-
-        FVElementGeometry fvGeometry;
-        ElementVolumeVariables elemVolVars;
-
-        // Loop over elements
-        ElementIterator eIt = this->problem_.gridView().template begin<0>();
-        ElementIterator eEndIt = this->problem_.gridView().template end<0>();
-        for (; eIt != eEndIt; ++eIt)
-        {
-            if (eIt->partitionType() != Dune::InteriorEntity)
-                continue;
-
-            fvGeometry.update(this->gridView_(), *eIt);
-            elemVolVars.update(this->problem_(), *eIt, fvGeometry);
-            this->localResidual().evalFluxes(*eIt, elemVolVars);
-
-            bool hasLeft = false;
-            bool hasRight = false;
-            for (int i = 0; i < fvGeometry.numVertices; i++) {
-                const GlobalPosition &globalPos = fvGeometry.subContVol[i].global;
-                if (globalI[axis] < coordVal)
-                    hasLeft = true;
-                else if (globalI[axis] >= coordVal)
-                    hasRight = true;
-            }
-            if (!hasLeft || !hasRight)
-                continue;
-
-            for (int i = 0; i < fvGeometry.numVertices; i++) {
-                const GlobalPosition &globalPos = fvGeometry.subContVol[i].global;
-                if (globalI[axis] < coordVal)
-                    flux += this->localResidual().residual(i);
-            }
-        }
-
-        flux = this->problem_.gridView().comm().sum(flux);
-    }
-
     /*!
      * \brief Write vtk and additional plain text scv-data.
      *
@@ -189,41 +129,38 @@ public:
                             MultiWriter &writer)
     {
         typedef Dune::BlockVector<Dune::FieldVector<Scalar, 1> > ScalarField;
-        typedef Dune::BlockVector<Dune::FieldVector<Scalar, dim> > VelocityField;
+        typedef Dune::BlockVector<Dune::FieldVector<Scalar, dim> > VectorField;
 
         // create the required scalar fields
         unsigned numVertices = this->gridView_().size(dim);
+        unsigned numElements = this->gridView_().size(0);
         ScalarField &pN = *writer.allocateManagedBuffer(numVertices);
         ScalarField &delP = *writer.allocateManagedBuffer(numVertices);
         ScalarField &rho = *writer.allocateManagedBuffer(numVertices);
         ScalarField &mu = *writer.allocateManagedBuffer(numVertices);
-        VelocityField &velocity = *writer.template allocateManagedBuffer<Scalar, dim> (numVertices);
-
-        unsigned numElements = this->gridView_().size(0);
+        VectorField &velocity = *writer.template allocateManagedBuffer<Scalar, dim> (numVertices);
+        ScalarField &mut = *writer.allocateManagedBuffer(numElements);
+        ScalarField &lmix = *writer.allocateManagedBuffer(numElements);
+        ScalarField &uPlus = *writer.allocateManagedBuffer(numElements);
+        ScalarField &yPlus = *writer.allocateManagedBuffer(numElements);
         ScalarField &rank = *writer.allocateManagedBuffer(numElements);
 
+        // write volume values to .vtu and .csv
+        std::ofstream volVarsFile("volVarsData.csv", std::ios_base::out);
+        asImp_().writeVolVarsHeader(volVarsFile);
+        volVarsFile << std::endl;
+
         FVElementGeometry fvGeometry;
         VolumeVariables volVars;
 
-        ElementBoundaryTypes elemBcTypes;
-
-        VertexIterator vIt = this->gridView_().template begin<dim>();
-        VertexIterator vEndIt = this->gridView_().template end<dim>();
-        for (; vIt != vEndIt; ++vIt)
-        {}
-
-
         ElementIterator eIt = this->gridView_().template begin<0>();
         ElementIterator eEndIt = this->gridView_().template end<0>();
-
         for (; eIt != eEndIt; ++eIt)
         {
             int idx = this->elementMapper().map(*eIt);
             rank[idx] = this->gridView_().comm().rank();
 
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
-
 
             int numLocalVerts = eIt->template count<dim>();
             for (int i = 0; i < numLocalVerts; ++i)
@@ -241,8 +178,12 @@ public:
                 rho[vIdxGlobal] = volVars.density();
                 mu[vIdxGlobal] = volVars.dynamicViscosity();
                 velocity[vIdxGlobal] = volVars.velocity();
-            };
+
+                asImp_().writeVolVarsData(volVarsFile, volVars);
+                volVarsFile << std::endl;
+            }
         }
+        volVarsFile.close();
 
         writer.attachVertexData(pN, "P");
         writer.attachVertexData(delP, "delP");
@@ -250,17 +191,19 @@ public:
         writer.attachVertexData(mu, "mu");
         writer.attachVertexData(velocity, "v", dim);
 
-
         // ensure that the actual values are given out
         asImp_().updateWallProperties();
 
+        // write flux values to .vtu and .csv
+        std::ofstream fluxVarsFile("fluxVarsData.csv", std::ios_base::out);
+        asImp_().writeFluxVarsHeader(fluxVarsFile);
+        fluxVarsFile << std::endl;
+
         eIt = this->gridView_().template begin<0>();
         eEndIt = this->gridView_().template end<0>();
-
         for (; eIt != eEndIt; ++eIt)
         {
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
 
             ElementVolumeVariables elemVolVars;
             elemVolVars.update(this->problem_(),
@@ -268,236 +211,116 @@ public:
                                fvGeometry,
                                false);
 
-            IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
-            const IntersectionIterator &endIt = this->gridView_().iend(*eIt);
+            unsigned int numFluxVars = 0;
+            Scalar sumDynamicEddyViscosity = 0.0;
+            Scalar sumMixingLength = 0.0;
+            Scalar sumUPlus = 0.0;
+            Scalar sumYPlus = 0.0;
 
-            for (; isIt != endIt; ++isIt)
+            IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
+            IntersectionIterator isEndIt = this->gridView_().iend(*eIt);
+            for (; isIt != isEndIt; ++isIt)
             {
                 int fIdx = isIt->indexInInside();
 
-                FluxVariables fluxVars(this->problem_(),
-                                                    *eIt,
-                                                    fvGeometry,
-                                                    fIdx,
-                                                    elemVolVars,
-                                                    false);
+                FluxVariables fluxVars(this->problem_(), *eIt, fvGeometry,
+                                       fIdx, elemVolVars, false);
 
-                GlobalPosition globalPos = fvGeometry.subContVolFace[fIdx].ipGlobal;
+                asImp_().writeFluxVarsData(fluxVarsFile, fluxVars);
+                fluxVarsFile << std::endl;
 
-                if (asImp_().shouldWriteSCVData(globalPos))
-                    asImp_().writeSCVData(volVars, fluxVars, globalPos);
+                sumDynamicEddyViscosity += fluxVars.dynamicEddyViscosity();
+                sumMixingLength += fluxVars.mixingLength();
+                sumUPlus += fluxVars.uPlus();
+                sumYPlus += fluxVars.yPlusRough();
+                numFluxVars += 1;
             }
-        }
-    }
-
 
-    /**********************************
-     * SCVDATA
-     * -------
-     * This section contains functions to zeroeq output related functions.
-     */
-
-    /*!
-     * \brief Returns true if a scv-data file for gnuplot evaluation
-     *        should be given out.
-     *
-     * \param globalPos Global Position.
-     */
-    const bool shouldWriteSCVData(const GlobalPosition &globalPos) const
-    {
-        if (writeAllSCVData_ > 1.0)
-            return true;
-        else if (writeAllSCVData_ < 0.0)
-            return false;
-        else
-        {
-            Scalar relGlobalPosMin = (globalPos[flowNormal_] - 1e-3 - this->problem_().bBoxMin()[flowNormal_])
-                                     / (this->problem_().bBoxMax()[flowNormal_] - this->problem_().bBoxMin()[flowNormal_]);
-            Scalar relGlobalPosMax = (globalPos[flowNormal_] + 1e-3 - this->problem_().bBoxMin()[flowNormal_])
-                                     / (this->problem_().bBoxMax()[flowNormal_] - this->problem_().bBoxMin()[flowNormal_]);
-            return (relGlobalPosMax > writeAllSCVData_ && relGlobalPosMin < writeAllSCVData_);
-        }
-    }
-
-    /*!
-     * \brief Writes scv-data file for gnuplot evaluation.
-     *
-     * \param volVars Volume Variables of current scv.
-     * \param fluxVars Flux Variables of current element.
-     * \param globalPos Global Position.
-     */
-    void writeSCVData(const VolumeVariables &volVars, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
-    {
-        std::ofstream fileAct ("");
-        std::stringstream stream ("");
-
-        char flowNormalChar = 'x';
-        if (flowNormal_ == 1) flowNormalChar = 'y';
-        stream << "scvData" << "-" << flowNormalChar << std::setprecision(4)
-               << (globalPos[flowNormal_] - this->problem_().bBoxMin()[flowNormal_])
-                  / (this->problem_().bBoxMax()[flowNormal_] - this->problem_().bBoxMin()[flowNormal_])
-               << ".dat";
-        std::string fileString2(stream.str());
-        stream.str(""); stream.clear();
-        const char* fileNameAct = fileString2.c_str();
-
-        int posIdx = getPosIdx(globalPos);
-        int wallIdx = getWallIdx(globalPos, posIdx);
-        if (!wall[wallIdx].headerWritten[posIdx])
-        {
-            fileAct.open(fileNameAct, std::ios::out);
-
-            asImp_().writeSCVHeader(stream, fluxVars, globalPos);
-            stream << std::endl;
-            if (bboxMinIsWall)
-            {
-                asImp_().writeWallHeader(stream, posIdx, 0);
-                stream << std::endl;
-            }
-            if (bboxMaxIsWall)
-            {
-                asImp_().writeWallHeader(stream, posIdx, 1);
-                stream << std::endl;
-            }
-            asImp_().writeDataHeader(stream, posIdx);
-            stream << std::endl;
-
-            fileAct << stream.str();
-            stream.str(""); stream.clear();
-            fileAct.close();
-            for (int wIdx = 0; wIdx < walls; ++wIdx)
-                wall[wIdx].headerWritten[posIdx] = true;
+            int eIdxGlobal = this->elementMapper().map(*eIt);
+            mut[eIdxGlobal] = sumDynamicEddyViscosity / numFluxVars;
+            lmix[eIdxGlobal] = sumMixingLength / numFluxVars;
+            uPlus[eIdxGlobal] = sumUPlus / numFluxVars;
+            yPlus[eIdxGlobal] = sumYPlus / numFluxVars;
         }
-        fileAct.open(fileNameAct, std::ios::app);
+        fluxVarsFile.close();
 
-        asImp_().writeSCVDataValues(stream, volVars, fluxVars, globalPos);
-        stream << std::endl;
-        fileAct << stream.str();
-        fileAct.close();
+        writer.attachCellData(mut, "mu_t");
+        writer.attachCellData(lmix, "l_mix");
+        writer.attachCellData(uPlus, "u^+");
+        writer.attachCellData(yPlus, "y^+");
     }
 
+
     /*!
-     * \brief Writes scv-data header, containing basic properties, which are constant
-     *        at this point.
+     * \brief Writes the header for the volVarsData.csv file
      *
-     * \param stream Output Filestream.
-     * \param fluxVars Flux Variables of current element.
-     * \param globalPos Global Position.
+     * \param stream The output file stream
      */
-    void writeSCVHeader(std::stringstream &stream, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
+    void writeVolVarsHeader(std::ofstream &stream)
     {
-        int posIdx = getPosIdx(globalPos);
-        stream << std::setprecision(prec) << "# "
-               << std::setw(width-2) << "over x[m]:"
-               << std::setw(width) << globalPos[flowNormal_]
-               << std::setw(width) << "at t[s]:"
-               << std::setw(width) << this->problem_().timeManager().time()
-               << std::setw(width) << "Re_d[-]:"
-               << std::setw(width) << wall[0].maxVelocityAbs[posIdx][flowNormal_]
-                                      * (this->problem_().bBoxMax()[wallNormal_] - this->problem_().bBoxMin()[wallNormal_])
-                                      / fluxVars.kinematicViscosity()
-               << std::setw(width) << "Re_x[-]:"
-               << std::setw(width) << wall[0].maxVelocityAbs[posIdx][flowNormal_]
-                                      * (this->problem_().bBoxMax()[flowNormal_] - this->problem_().bBoxMin()[flowNormal_])
-                                      / fluxVars.kinematicViscosity()
-               << std::endl;
-        stream << std::setprecision(prec) << "# "
-               << std::setw(width-2)<< "eddyVMod"
-               << std::setw(width) << GET_PARAM_FROM_GROUP(TypeTag, int, ZeroEq, EddyViscosityModel)
-               << " - " << std::setw(width*2-3) << std::left  << eddyViscosityModelName() << std::right;
+//         stream << "# time end" << std::endl;
+        stream << "#globalPos[0]"
+               << "," << "globalPos[1]"
+               << "," << "velocity[0]"
+               << "," << "velocity[1]"
+               << "," << "pressure"
+               << "," << "density"
+               << "," << "temperature";
     }
 
     /*!
-     * \brief Writes property names to wall-data header.
+     * \brief Writes the data into the volVarsData.csv file
      *
-     * \param stream Output Filestream.
-     * \param posIdx Position Index of current Global Position.
-     * \param wallIdx Wall Index of current Global Position.
+     * \param stream The output file stream
      */
-    void writeWallHeader(std::stringstream &stream, int posIdx, int wallIdx)
+    void writeVolVarsData(std::ofstream &stream, const VolumeVariables &volVars)
     {
-        stream << std::setprecision(prec) << "# "
-               << std::setw(width-4) << "wall[" << wallIdx << "]"
-               << std::setw(width) << "u_*[m/s]:"
-               << std::setw(width) << std::sqrt(wall[wallIdx].wallShearStress[posIdx] / wall[wallIdx].wallDensity[posIdx])
-               << std::setw(width) << "vs_5[m]:"
-               << std::setw(width) << 5.0 * wall[wallIdx].wallKinematicViscosity[posIdx]
-                                      / std::sqrt(wall[wallIdx].wallShearStress[posIdx] / wall[wallIdx].wallDensity[posIdx])
-               << std::setw(width) << "bl_tot[m]:"
-               << std::setw(width) << std::abs(wall[wallIdx].boundaryLayerThickness[posIdx])
-               << std::setw(width) << "ks_+[-]:"
-               << std::setw(width) << wall[wallIdx].sandGrainRoughness[posIdx]
-                                      * std::sqrt(std::abs(wall[wallIdx].wallVelGrad[posIdx]) * wall[wallIdx].wallKinematicViscosity[posIdx])
-                                      / wall[wallIdx].wallKinematicViscosity[posIdx]
-               << std::setw(width) << "velGrad[1/s]:"
-               << std::setw(width) << wall[wallIdx].wallVelGrad[posIdx]
-               << std::setw(width) << "nu[m^2/s]:"
-               << std::setw(width) << wall[wallIdx].wallKinematicViscosity[posIdx]
-               << std::setw(width) << "rho[kg/m^3]:"
-               << std::setw(width) << wall[wallIdx].wallDensity[posIdx]
-               << std::setw(width) << "tau[Pa]:"
-               << std::setw(width) << wall[wallIdx].wallShearStress[posIdx];
+        stream << volVars.globalPos()[0]
+               << "," << volVars.globalPos()[1]
+               << "," << volVars.velocity()[0]
+               << "," << volVars.velocity()[1]
+               << "," << volVars.pressure()
+               << "," << volVars.density()
+               << "," << volVars.temperature();
     }
 
     /*!
-     * \brief Writes property names to scv-data header.
+     * \brief Writes the header for the fluxVarsData.csv file
      *
-     * \param stream Output Filestream.
-     * \param posIdx Position Index of current Global Position.
+     * \param stream The output file stream
      */
-    void writeDataHeader(std::stringstream &stream, int posIdx)
+    void writeFluxVarsHeader(std::ofstream &stream)
     {
-        stream << std::setw(1) << "#" << std::setw(width-1);
-        for (int numIdx = 1; numIdx < 30; ++numIdx)
-            stream << numIdx << std::setw(width);
-        stream << std::endl;
-        stream << std::setw(1) << "#" << std::setw(width-1) << "x [m]"
-               << std::setw(width) << "y [m]"
-               << std::setw(width) << "u [m/s]"
-               << std::setw(width) << "v [m/s]"
-               << std::setw(width) << "u/u_max [-]"
-               << std::setw(width) << "v/v_max [-]"
-               << std::setw(width) << "y^+ [-]"
-               << std::setw(width) << "u^+ [-]"
-               << std::setw(width) << "velGrad [1/s]"
-               << std::setw(width) << "rho [kg/m^3]"
-               << std::setw(width) << "nu [m^2/s]"
-               << std::setw(width) << "nu_t [m^2/s]";
+//         stream << "# time end" << std::endl;
+        stream << "#globalPos[0]"
+               << "," << "globalPos[1]"
+               << "," << "uPlus"
+               << "," << "yPlus"
+               << "," << "uStar"
+               << "," << "eddyViscosity"
+               << "," << "mixingLength";
     }
 
     /*!
-     * \brief Writes values to scv-data.
+     * \brief Writes the data into the fluxVarsData.csv file
      *
-     * \param stream Output Filestream.
-     * \param volVars Volume Variables of current scv.
-     * \param fluxVars Flux Variables of current element.
-     * \param globalPos Global Position.
+     * \param stream The output file stream
      */
-    void writeSCVDataValues(std::stringstream &stream, const VolumeVariables &volVars, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
+    void writeFluxVarsData(std::ofstream &stream, const FluxVariables &fluxVars)
     {
-        int posIdx = getPosIdx(globalPos);
-        int wallIdx = getWallIdx(globalPos, posIdx);
-        stream << std::setw(width) << std::setprecision(prec+1) << globalPos[0]
-               << std::setw(width) << globalPos[1]
-               << std::setw(width) << std::setprecision(prec) << fluxVars.velocity()[0]
-               << std::setw(width) << fluxVars.velocity()[1]
-               << std::setw(width) << fluxVars.velocity()[0] / wall[wallIdx].maxVelocityAbs[posIdx][0]
-               << std::setw(width) << fluxVars.velocity()[1] / wall[wallIdx].maxVelocityAbs[posIdx][1]
-               << std::setw(width) << fluxVars.frictionVelocityWall() * std::abs(wall[wallIdx].wallPos[posIdx] - globalPos[wallNormal_]) / fluxVars.kinematicViscosity()
-               << std::setw(width) << fluxVars.velocity()[flowNormal_] / fluxVars.frictionVelocityWall()
-               << std::setw(width) << fluxVars.velocityGrad()[flowNormal_][wallNormal_]
-               << std::setw(width) << fluxVars.density()
-               << std::setw(width) << fluxVars.dynamicViscosity() / fluxVars.density()
-               << std::setw(width) << fluxVars.dynamicEddyViscosity() / fluxVars.density();
+        stream << fluxVars.globalPos()[0]
+               << "," << fluxVars.globalPos()[1]
+               << "," << fluxVars.uPlus()
+               << "," << fluxVars.yPlusRough()
+               << "," << fluxVars.frictionVelocityWall()
+               << "," << fluxVars.dynamicEddyViscosity()
+               << "," << fluxVars.mixingLength();
     }
 
-
-
-    /**********************************
-     * WALL PROPERTIES
-     * ---------------
-     * This section contains functions which treat the wall handling.
+    /*!
+     * \name Wall properties
      */
+    // \{
 
      /*!
      * \brief Container for all necessary information, needed to calculate the
@@ -758,7 +581,6 @@ public:
     void updateMaxFluxVars()
     {
         FVElementGeometry fvGeometry;
-        ElementBoundaryTypes elemBcTypes;
 
         ElementIterator eIt = this->gridView_().template begin<0>();
         ElementIterator eEndIt = this->gridView_().template end<0>();
@@ -766,7 +588,6 @@ public:
         for (; eIt != eEndIt; ++eIt)
         {
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
 
             ElementVolumeVariables elemVolVars;
             elemVolVars.update(this->problem_(),
@@ -825,7 +646,7 @@ public:
         if (wall[wallIdx].fMax[posIdx] < fluxVars.fz())
         {
             wall[wallIdx].fMax[posIdx] = fluxVars.fz();
-            wall[wallIdx].yMax[posIdx] = distanceToWallReal(globalPos, wallIdx, posIdx);
+            wall[wallIdx].yMax[posIdx] = distanceToWallRough(globalPos, wallIdx, posIdx);
 //            // if the values in the middle should be set on both wall
 //            for (int wIdx = 0; wIdx < walls; ++wIdx)
 //                if (std::abs(distanceToWall(globalPos, wIdx, posIdx)) < std::abs(wall[wIdx].boundaryLayerThickness[posIdx] + 1e-4))
@@ -842,14 +663,12 @@ public:
     void updateCrossLength()
     {
         FVElementGeometry fvGeometry;
-        ElementBoundaryTypes elemBcTypes;
         ElementIterator eIt = this->gridView_().template begin<0>();
         ElementIterator eEndIt = this->gridView_().template end<0>();
 
         for (; eIt != eEndIt; ++eIt)
         {
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
 
             ElementVolumeVariables elemVolVars;
             elemVolVars.update(this->problem_(),
@@ -858,9 +677,9 @@ public:
                                false);
 
             IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
-            const IntersectionIterator &endIt = this->gridView_().iend(*eIt);
+            const IntersectionIterator &isEndIt = this->gridView_().iend(*eIt);
 
-            for (; isIt != endIt; ++isIt)
+            for (; isIt != isEndIt; ++isIt)
             {
                 int fIdx = isIt->indexInInside();
                 FluxVariables fluxVars(this->problem_(),
@@ -875,19 +694,28 @@ public:
                 int wallIdx = getWallIdx(globalPos, posIdx);
 
                 // muCross
-                if (fluxVars.dynamicEddyViscosityOuter() < fluxVars.dynamicEddyViscosityInner() && useViscosityInner(globalPos, posIdx))
-                    wall[wallIdx].crossLength[posIdx] = distanceToWallReal(globalPos, wallIdx, posIdx) - eps_ * std::abs(distanceToWallReal(globalPos, wallIdx, posIdx) / distanceToWallReal(globalPos, wallIdx, posIdx));
+                if (fluxVars.dynamicEddyViscosityOuter() < fluxVars.dynamicEddyViscosityInner()
+                    && useViscosityInner(globalPos, posIdx))
+                {
+                    wall[wallIdx].crossLength[posIdx] = distanceToWallReal(globalPos, wallIdx, posIdx);
+                }
 
                 if (std::abs(fluxVars.velocity()[flowNormal_]) >= 0.99 * std::abs(wall[wallIdx].maxVelocity[posIdx][flowNormal_])
                     && std::abs(wall[wallIdx].boundaryLayerThicknessCalculated[posIdx]) > std::abs(distanceToWallReal(globalPos, wallIdx, posIdx)))
+                {
                     wall[wallIdx].boundaryLayerThicknessCalculated[posIdx] = distanceToWallReal(globalPos, wallIdx, posIdx);
+                }
 
                 if (wall[wallIdx].maxVelocity[posIdx][flowNormal_] * globalPos[flowNormal_] / fluxVars.kinematicViscosity() < 2300)
+                {
                     wall[wallIdx].viscousSublayerThicknessCalculated[posIdx] = wall[wallIdx].boundaryLayerThicknessCalculated[posIdx];
+                }
                 else if ((fluxVars.velocity()[flowNormal_] / fluxVars.frictionVelocityWall() <= 5.0)
                          && (std::abs(wall[wallIdx].viscousSublayerThicknessCalculated[posIdx])
                              < std::abs(distanceToWallReal(globalPos, wallIdx, posIdx))))
+                {
                     wall[wallIdx].viscousSublayerThicknessCalculated[posIdx] = distanceToWallReal(globalPos, wallIdx, posIdx);
+                }
             }
         }
     }
@@ -898,7 +726,6 @@ public:
     void updateWallFluidProperties()
     {
         FVElementGeometry fvGeometry;
-        ElementBoundaryTypes elemBcTypes;
 
         ElementIterator eIt = this->gridView_().template begin<0>();
         ElementIterator eEndIt = this->gridView_().template end<0>();
@@ -915,8 +742,8 @@ public:
 
             const ReferenceElement &refElement = ReferenceElements::general(eIt->geometry().type());
             IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
-            const IntersectionIterator &endIt = this->gridView_().iend(*eIt);
-            for (; isIt != endIt; ++isIt)
+            const IntersectionIterator &isEndIt = this->gridView_().iend(*eIt);
+            for (; isIt != isEndIt; ++isIt)
             {
                 // handle only faces on the boundary
                 if (!isIt->boundary())
@@ -1123,6 +950,8 @@ public:
         return (prevValue + (nextValue - prevValue) / (next - prev) * (position - prev));
     }
 
+    // \} // wall properties
+
     /*!
      * \brief Returns whether the actual eddy viscosity model includes surface roughness approach.
      *
@@ -1176,8 +1005,6 @@ protected:
 private:
     const int flowNormal_;
     const int wallNormal_;
-    Scalar writeAllSCVData_;
-    Scalar scvDataCoordinateDelta_;
     Scalar eps_;
 };
 
diff --git a/dumux/freeflow/zeroeq/zeroeqproperties.hh b/dumux/freeflow/zeroeq/zeroeqproperties.hh
index a271ad3ce80a55ef014c5138113b8a23ce0faca9..532406163cddf2e4fc998eb1512259b6a90a77de 100644
--- a/dumux/freeflow/zeroeq/zeroeqproperties.hh
+++ b/dumux/freeflow/zeroeq/zeroeqproperties.hh
@@ -58,7 +58,6 @@ NEW_PROP_TAG(ZeroEqBBoxMinSandGrainRoughness); //!< Sets a sand grain roughness
 NEW_PROP_TAG(ZeroEqBBoxMaxSandGrainRoughness); //!< Sets a sand grain roughness at BBoxMax
 NEW_PROP_TAG(ZeroEqEddyViscosityModel); //!< Returns used eddy viscosity model
 NEW_PROP_TAG(NumberOfIntervals); //!< Returns number of wall intervals
-NEW_PROP_TAG(ZeroEqWriteAllSCVData); //!< Returns which scv data are written
 NEW_PROP_TAG(BaseStokesModel); //!< Returns the base implementation of the Stokes model
 NEW_PROP_TAG(BaseStokesVolumeVariables); //!< Returns the base implementation of the Stokes volume variables
 NEW_PROP_TAG(BaseStokesFluxVariables); //!< Returns the base implementation of the Stokes flux variables
diff --git a/dumux/freeflow/zeroeq/zeroeqpropertydefaults.hh b/dumux/freeflow/zeroeq/zeroeqpropertydefaults.hh
index b0572d0ee0375d97c65f9213a0ccd0d9aceb9efa..088e7c34d791eadd1859c13238629b3b910f6f0c 100644
--- a/dumux/freeflow/zeroeq/zeroeqpropertydefaults.hh
+++ b/dumux/freeflow/zeroeq/zeroeqpropertydefaults.hh
@@ -82,9 +82,6 @@ SET_INT_PROP(BoxZeroEq, ZeroEqEddyViscosityModel, 1);
 //! Set the number of wall intervals in which more complex turbulence models are evaluated
 SET_INT_PROP(BoxZeroEq, NumberOfIntervals, 1000);
 
-//! Set which scv data files should be written (<0 - no, 1> all)
-SET_SCALAR_PROP(BoxZeroEq, ZeroEqWriteAllSCVData, -1);
-
 //! Set the BaseStokesFluxVariables to StokesFluxVariables
 SET_TYPE_PROP(BoxZeroEq, BaseStokesFluxVariables, StokesFluxVariables<TypeTag>);
 
diff --git a/dumux/freeflow/zeroeqnc/zeroeqncmodel.hh b/dumux/freeflow/zeroeqnc/zeroeqncmodel.hh
index ba532fe70c825e84efc29453eb887e5f75ba4689..199ca9f169b3bd80b2e7807b6aedf1af1d68064e 100644
--- a/dumux/freeflow/zeroeqnc/zeroeqncmodel.hh
+++ b/dumux/freeflow/zeroeqnc/zeroeqncmodel.hh
@@ -85,33 +85,24 @@ class ZeroEqncModel : public ZeroEqModel<TypeTag>
         dimWorld = GridView::dimensionworld,
         intervals = GET_PROP_VALUE(TypeTag, NumberOfIntervals),
         walls = (GET_PROP_VALUE(TypeTag, BBoxMinIsWall) ? 1 : 0)
-                + (GET_PROP_VALUE(TypeTag, BBoxMaxIsWall) ? 1 : 0),
-        prec = Indices::scvDataPrecision, // precision of scv data
-        width = Indices::scvDataWidth // width of column
+                + (GET_PROP_VALUE(TypeTag, BBoxMaxIsWall) ? 1 : 0)
     };
-    enum { numEq = GET_PROP_VALUE(TypeTag, NumEq) };
     enum { transportCompIdx = Indices::transportCompIdx,
            numComponents = Indices::numComponents };
     enum { phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx) };
 
     typedef typename GridView::template Codim<0>::Iterator ElementIterator;
-    typedef typename GridView::template Codim<dim>::Iterator VertexIterator;
     typedef typename GridView::IntersectionIterator IntersectionIterator;
-    typedef Dune::ReferenceElements<Scalar, dim> ReferenceElements;
-    typedef Dune::ReferenceElement<Scalar, dim> ReferenceElement;
 
     typedef Dune::FieldVector<Scalar, dimWorld> GlobalPosition;
-    typedef Dune::FieldVector<Scalar, dimWorld> DimVector;
 
     typedef typename GridView::template Codim<0>::Entity Element;
     typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry;
     typedef typename GET_PROP_TYPE(TypeTag, ElementBoundaryTypes) ElementBoundaryTypes;
-    typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
     typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector;
 
     typedef typename GET_PROP_TYPE(TypeTag, FluidSystem) FluidSystem;
     typedef typename GET_PROP_TYPE(TypeTag, VolumeVariables) VolumeVariables;
-
     typedef typename GET_PROP_TYPE(TypeTag, FluxVariables) FluxVariables;
     typedef typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables) ElementVolumeVariables;
 
@@ -137,36 +128,41 @@ public:
                             MultiWriter &writer)
     {
         typedef Dune::BlockVector<Dune::FieldVector<Scalar, 1> > ScalarField;
-        typedef Dune::BlockVector<Dune::FieldVector<Scalar, dim> > VelocityField;
-
-        const Scalar scale_ = GET_PROP_VALUE(TypeTag, Scaling);
+        typedef Dune::BlockVector<Dune::FieldVector<Scalar, dim> > VectorField;
 
         // create the required scalar fields
         unsigned numVertices = this->gridView_().size(dim);
+        unsigned numElements = this->gridView_().size(0);
         ScalarField &pN = *writer.allocateManagedBuffer(numVertices);
         ScalarField &delP = *writer.allocateManagedBuffer(numVertices);
-
         ScalarField *moleFraction[numComponents];
+        ScalarField *massFraction[numComponents];
+        ScalarField &rho = *writer.allocateManagedBuffer(numVertices);
+        VectorField &velocity = *writer.template allocateManagedBuffer<Scalar, dim> (numVertices);
+        ScalarField &mu = *writer.allocateManagedBuffer(numVertices);
+        ScalarField &D = *writer.allocateManagedBuffer(numVertices);
+        ScalarField &mut = *writer.allocateManagedBuffer(numElements);
+        ScalarField &lmix = *writer.allocateManagedBuffer(numElements);
+        ScalarField &uPlus = *writer.allocateManagedBuffer(numElements);
+        ScalarField &yPlus = *writer.allocateManagedBuffer(numElements);
+        ScalarField &Dt = *writer.allocateManagedBuffer(numElements);
+        ScalarField &rank = *writer.allocateManagedBuffer(numElements);
         for (int i = 0; i < numComponents; ++i)
             moleFraction[i] = writer.template allocateManagedBuffer<Scalar, 1>(numVertices);
-        ScalarField *massFraction[numComponents];
         for (int i = 0; i < numComponents; ++i)
             massFraction[i] = writer.template allocateManagedBuffer<Scalar, 1>(numVertices);
 
-        ScalarField &rho = *writer.allocateManagedBuffer(numVertices);
-        ScalarField &mu = *writer.allocateManagedBuffer(numVertices);
-        VelocityField &velocity = *writer.template allocateManagedBuffer<Scalar, dim> (numVertices);
-
-        unsigned numElements = this->gridView_().size(0);
-        ScalarField &rank = *writer.allocateManagedBuffer(numElements);
+        // write volume values to .vtu and .csv
+        std::ofstream volVarsFile("volVarsData.csv", std::ios_base::out);
+        asImp_().writeVolVarsHeader(volVarsFile);
+        volVarsFile << std::endl;
 
         FVElementGeometry fvGeometry;
-        VolumeVariables volVars;
         ElementBoundaryTypes elemBcTypes;
+        VolumeVariables volVars;
 
         ElementIterator eIt = this->gridView_().template begin<0>();
         ElementIterator eEndIt = this->gridView_().template end<0>();
-
         for (; eIt != eEndIt; ++eIt)
         {
             int idx = this->elementMapper().map(*eIt);
@@ -186,8 +182,8 @@ public:
                                i,
                                false);
 
-                pN[vIdxGlobal] = volVars.pressure()*scale_;
-                delP[vIdxGlobal] = volVars.pressure()*scale_ - 1e5;
+                pN[vIdxGlobal] = volVars.pressure();
+                delP[vIdxGlobal] = volVars.pressure() - 1e5;
                 for (int compIdx = 0; compIdx < numComponents; ++compIdx)
                 {
                     (*moleFraction[compIdx])[vIdxGlobal]= volVars.moleFraction(compIdx);
@@ -195,10 +191,13 @@ public:
                     Valgrind::CheckDefined((*moleFraction[compIdx])[vIdxGlobal]);
                     Valgrind::CheckDefined((*massFraction[compIdx])[vIdxGlobal]);
                 }
-                rho[vIdxGlobal] = volVars.density()*scale_*scale_*scale_;
-                mu[vIdxGlobal] = volVars.dynamicViscosity()*scale_;
+                rho[vIdxGlobal] = volVars.density();
+                mu[vIdxGlobal] = volVars.dynamicViscosity();
+                D[vIdxGlobal] = volVars.diffusionCoeff(transportCompIdx);
                 velocity[vIdxGlobal] = volVars.velocity();
-                velocity[vIdxGlobal] *= 1/scale_;
+
+                asImp_().writeVolVarsData(volVarsFile, volVars);
+                volVarsFile << std::endl;
             }
         }
         writer.attachVertexData(pN, "P");
@@ -215,22 +214,26 @@ public:
                      << "^" << FluidSystem::componentName(j);
             writer.attachVertexData(*massFraction[j], massFrac.str().c_str());
         }
+        volVarsFile.close();
 
         writer.attachVertexData(rho, "rho");
         writer.attachVertexData(mu, "mu");
+        writer.attachVertexData(D, "D");
         writer.attachVertexData(velocity, "v", dim);
 
-
-        // just to have the actual values plotted
+        // ensure that the actual values are given out
         asImp_().updateWallProperties();
 
+        // write flux values to .vtu and .csv
+        std::ofstream fluxFile("fluxVarsData.csv", std::ios_base::out);
+        asImp_().writeFluxVarsHeader(fluxFile);
+        fluxFile << std::endl;
+
         eIt = this->gridView_().template begin<0>();
         eEndIt = this->gridView_().template end<0>();
-
         for (; eIt != eEndIt; ++eIt)
         {
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
 
             ElementVolumeVariables elemVolVars;
             elemVolVars.update(this->problem_(),
@@ -238,73 +241,68 @@ public:
                                fvGeometry,
                                false);
 
-            IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
-            const IntersectionIterator &endIt = this->gridView_().iend(*eIt);
+            unsigned int numFluxVars = 0;
+            Scalar sumDynamicEddyViscosity = 0.0;
+            Scalar sumMixingLength = 0.0;
+            Scalar sumUPlus = 0.0;
+            Scalar sumYPlus = 0.0;
+            Scalar sumEddyDiffusivity = 0.0;
 
-            for (; isIt != endIt; ++isIt)
+            IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
+            IntersectionIterator isEndIt = this->gridView_().iend(*eIt);
+            for (; isIt != isEndIt; ++isIt)
             {
                 int fIdx = isIt->indexInInside();
 
-                FluxVariables fluxVars(this->problem_(),
-                                                    *eIt,
-                                                    fvGeometry,
-                                                    fIdx,
-                                                    elemVolVars,
-                                                    false);
+                FluxVariables fluxVars(this->problem_(), *eIt, fvGeometry,
+                                       fIdx, elemVolVars, false);
 
-                GlobalPosition globalPos = fvGeometry.subContVolFace[fIdx].ipGlobal;
+                asImp_().writeFluxVarsData(fluxFile, fluxVars);
+                fluxFile << std::endl;
 
-                if (asImp_().shouldWriteSCVData(globalPos))
-                asImp_().writeSCVData(volVars, fluxVars, globalPos);
+                sumDynamicEddyViscosity += fluxVars.dynamicEddyViscosity();
+                sumMixingLength += fluxVars.mixingLength();
+                sumUPlus += fluxVars.uPlus();
+                sumYPlus += fluxVars.yPlusRough();
+                sumEddyDiffusivity += fluxVars.eddyDiffusivity();
+                numFluxVars += 1;
             }
-        }
-    }
 
-    //! \copydoc ZeroEqModel::writeSCVHeader
-    void writeSCVHeader(std::stringstream &stream, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
-    {
-        ParentType::writeSCVHeader(stream, fluxVars, globalPos);
+            int eIdxGlobal = this->elementMapper().map(*eIt);
+            mut[eIdxGlobal] = sumDynamicEddyViscosity / numFluxVars;
+            lmix[eIdxGlobal] = sumMixingLength / numFluxVars;
+            uPlus[eIdxGlobal] = sumUPlus / numFluxVars;
+            yPlus[eIdxGlobal] = sumYPlus / numFluxVars;
+            Dt[eIdxGlobal] = sumEddyDiffusivity / numFluxVars;
+        }
+        fluxFile.close();
 
-        stream << std::setw(width) << "eddyDMod"
-               << std::setw(width) << GET_PARAM_FROM_GROUP(TypeTag, int, ZeroEq, EddyDiffusivityModel)
-               << " - " << std::setw(width*2-3) << std::left  << eddyDiffusivityModelName() << std::right;
+        writer.attachCellData(mut, "mu_t");
+        writer.attachCellData(lmix, "l_mix");
+        writer.attachCellData(uPlus, "u^+");
+        writer.attachCellData(yPlus, "y^+");
+        writer.attachCellData(Dt, "D_t");
     }
 
-    //! \copydoc ZeroEqModel::writeDataHeader
-    void writeDataHeader(std::stringstream &stream, int posIdx)
+    //! \copydoc ZeroEqModel::writeFluxVarsHeader
+    void writeFluxVarsHeader(std::ofstream &stream)
     {
-        ParentType::writeDataHeader(stream, posIdx);
-
-        stream << std::setw(width) << "X [kg/kg]"
-               << std::setw(width) << "X/X_max [-]"
-               << std::setw(width) << "N [mol/mol]"
-               << std::setw(width) << "N/N_max [-]"
-               << std::setw(width) << "NGrad [mol/m]"
-               << std::setw(width) << "D [m^2/s]"
-               << std::setw(width) << "D_t [m^2/s]"
-               << std::setw(width) << "Sc [-]"
-               << std::setw(width) << "Sc_t [-]";
+        ParentType::writeFluxVarsHeader(stream);
+        stream << "," << "eddyDiffusivity";
     }
 
-    //! \copydoc ZeroEqModel::writeSCVDataValues
-    void writeSCVDataValues(std::stringstream &stream, const VolumeVariables &volVars, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
+    //! \copydoc ZeroEqModel::writeFluxVarsData
+    void writeFluxVarsData(std::ofstream &stream, const FluxVariables &fluxVars)
     {
-        ParentType::writeSCVDataValues(stream, volVars, fluxVars, globalPos);
-
-        int posIdx = this->getPosIdx(globalPos);
-        int wallIdx = this->getWallIdx(globalPos, posIdx);
-        stream << std::setprecision(prec)
-               << std::setw(width) << fluxVars.massFraction(transportCompIdx)
-               << std::setw(width) << fluxVars.massFraction(transportCompIdx) / this->wall[wallIdx].maxMassFraction[posIdx]
-               << std::setw(width) << fluxVars.moleFraction(transportCompIdx)
-               << std::setw(width) << fluxVars.moleFraction(transportCompIdx) / this->wall[wallIdx].maxMoleFraction[posIdx]
-               << std::setw(width) << fluxVars.moleFractionGrad(transportCompIdx)[wallNormal_]
-               << std::setw(width) << fluxVars.diffusionCoeff(transportCompIdx)
-               << std::setw(width) << fluxVars.eddyDiffusivity()
-               << std::setw(width) << fluxVars.schmidtNumber()
-               << std::setw(width) << fluxVars.turbulentSchmidtNumber();
+        ParentType::writeFluxVarsData(stream, fluxVars);
+        stream << "," << fluxVars.eddyDiffusivity();
     }
 
+    /*!
+     * \name Wall properties
+     */
+    // \{
+
     //! \copydoc ZeroEqModel::resetWallProperties
     void resetWallProperties()
     {
@@ -344,6 +342,8 @@ public:
         this->wall[wallIdx].maxMoleFraction[posIdx] = this->interpolation(posIdx, prevIdx, this->wall[wallIdx].maxMoleFraction[prevIdx], nextIdx, this->wall[wallIdx].maxMoleFraction[nextIdx]);
     }
 
+    // \} // wall properties
+
     /*!
      * \brief Returns the name of used the eddy diffusivity model.
      */
diff --git a/dumux/freeflow/zeroeqncni/zeroeqncnimodel.hh b/dumux/freeflow/zeroeqncni/zeroeqncnimodel.hh
index 6d5ad17d2df5ce2393ad6a20bf802373640e87b1..5ae50be080218a1df1479286f29ea15cedabc0fe 100644
--- a/dumux/freeflow/zeroeqncni/zeroeqncnimodel.hh
+++ b/dumux/freeflow/zeroeqncni/zeroeqncnimodel.hh
@@ -96,33 +96,23 @@ class ZeroEqncniModel : public ZeroEqncModel<TypeTag>
         dimWorld = GridView::dimensionworld,
         intervals = GET_PROP_VALUE(TypeTag, NumberOfIntervals),
         walls = (GET_PROP_VALUE(TypeTag, BBoxMinIsWall) ? 1 : 0)
-                + (GET_PROP_VALUE(TypeTag, BBoxMaxIsWall) ? 1 : 0),
-        prec = Indices::scvDataPrecision, // precision of scv data
-        width = Indices::scvDataWidth // width of column
+                + (GET_PROP_VALUE(TypeTag, BBoxMaxIsWall) ? 1 : 0)
     };
-    enum { numEq = GET_PROP_VALUE(TypeTag, NumEq) };
     enum { transportCompIdx = Indices::transportCompIdx,
            numComponents = Indices::numComponents };
     enum { phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx) };
 
     typedef typename GridView::template Codim<0>::Iterator ElementIterator;
-    typedef typename GridView::template Codim<dim>::Iterator VertexIterator;
     typedef typename GridView::IntersectionIterator IntersectionIterator;
-    typedef Dune::ReferenceElements<Scalar, dim> ReferenceElements;
-    typedef Dune::ReferenceElement<Scalar, dim> ReferenceElement;
 
     typedef Dune::FieldVector<Scalar, dimWorld> GlobalPosition;
-    typedef Dune::FieldVector<Scalar, dimWorld> DimVector;
 
     typedef typename GridView::template Codim<0>::Entity Element;
     typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry;
-    typedef typename GET_PROP_TYPE(TypeTag, ElementBoundaryTypes) ElementBoundaryTypes;
-    typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
     typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector;
 
     typedef typename GET_PROP_TYPE(TypeTag, FluidSystem) FluidSystem;
     typedef typename GET_PROP_TYPE(TypeTag, VolumeVariables) VolumeVariables;
-
     typedef typename GET_PROP_TYPE(TypeTag, FluxVariables) FluxVariables;
     typedef typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables) ElementVolumeVariables;
 
@@ -148,44 +138,49 @@ public:
                             MultiWriter &writer)
     {
         typedef Dune::BlockVector<Dune::FieldVector<Scalar, 1> > ScalarField;
-        typedef Dune::BlockVector<Dune::FieldVector<Scalar, dim> > VelocityField;
-
-        const Scalar scale_ = GET_PROP_VALUE(TypeTag, Scaling);
+        typedef Dune::BlockVector<Dune::FieldVector<Scalar, dim> > VectorField;
 
         // create the required scalar fields
         unsigned numVertices = this->gridView_().size(dim);
+        unsigned numElements = this->gridView_().size(0);
         ScalarField &pN = *writer.allocateManagedBuffer(numVertices);
         ScalarField &delP = *writer.allocateManagedBuffer(numVertices);
-
         ScalarField *moleFraction[numComponents];
-        for (int i = 0; i < numComponents; ++i)
-            moleFraction[i] = writer.template allocateManagedBuffer<Scalar, 1>(numVertices);
         ScalarField *massFraction[numComponents];
-        for (int i = 0; i < numComponents; ++i)
-            massFraction[i] = writer.template allocateManagedBuffer<Scalar, 1>(numVertices);
-
         ScalarField &rho = *writer.allocateManagedBuffer(numVertices);
+        VectorField &velocity = *writer.template allocateManagedBuffer<Scalar, dim> (numVertices);
         ScalarField &mu = *writer.allocateManagedBuffer(numVertices);
-        VelocityField &velocity = *writer.template allocateManagedBuffer<Scalar, dim> (numVertices);
+        ScalarField &D = *writer.allocateManagedBuffer(numVertices);
         ScalarField &T = *writer.allocateManagedBuffer(numVertices);
-
-        unsigned numElements = this->gridView_().size(0);
+        ScalarField &lambda = *writer.allocateManagedBuffer(numVertices);
+        ScalarField &mut = *writer.allocateManagedBuffer(numElements);
+        ScalarField &lmix = *writer.allocateManagedBuffer(numElements);
+        ScalarField &uPlus = *writer.allocateManagedBuffer(numElements);
+        ScalarField &yPlus = *writer.allocateManagedBuffer(numElements);
+        ScalarField &Dt = *writer.allocateManagedBuffer(numElements);
+        ScalarField &lambdat = *writer.allocateManagedBuffer(numElements);
         ScalarField &rank = *writer.allocateManagedBuffer(numElements);
+        for (int i = 0; i < numComponents; ++i)
+            moleFraction[i] = writer.template allocateManagedBuffer<Scalar, 1>(numVertices);
+        for (int i = 0; i < numComponents; ++i)
+            massFraction[i] = writer.template allocateManagedBuffer<Scalar, 1>(numVertices);
+
+        // write volume values to .vtu and .csv
+        std::ofstream volVarsFile("volVarsData.csv", std::ios_base::out);
+        asImp_().writeVolVarsHeader(volVarsFile);
+        volVarsFile << std::endl;
 
         FVElementGeometry fvGeometry;
         VolumeVariables volVars;
-        ElementBoundaryTypes elemBcTypes;
 
         ElementIterator eIt = this->gridView_().template begin<0>();
         ElementIterator eEndIt = this->gridView_().template end<0>();
-
         for (; eIt != eEndIt; ++eIt)
         {
             int idx = this->elementMapper().map(*eIt);
             rank[idx] = this->gridView_().comm().rank();
 
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
 
             int numLocalVerts = eIt->template count<dim>();
             for (int i = 0; i < numLocalVerts; ++i)
@@ -198,8 +193,8 @@ public:
                                i,
                                false);
 
-                pN[vIdxGlobal] = volVars.pressure()*scale_;
-                delP[vIdxGlobal] = volVars.pressure()*scale_ - 1e5;
+                pN[vIdxGlobal] = volVars.pressure();
+                delP[vIdxGlobal] = volVars.pressure() - 1e5;
                 for (int compIdx = 0; compIdx < numComponents; ++compIdx)
                 {
                     (*moleFraction[compIdx])[vIdxGlobal]= volVars.moleFraction(compIdx);
@@ -207,13 +202,18 @@ public:
                     Valgrind::CheckDefined((*moleFraction[compIdx])[vIdxGlobal]);
                     Valgrind::CheckDefined((*massFraction[compIdx])[vIdxGlobal]);
                 }
-                rho[vIdxGlobal] = volVars.density()*scale_*scale_*scale_;
-                mu[vIdxGlobal] = volVars.dynamicViscosity()*scale_;
-                velocity[vIdxGlobal] = volVars.velocity();
-                velocity[vIdxGlobal] *= 1/scale_;
+                rho[vIdxGlobal] = volVars.density();
+                mu[vIdxGlobal] = volVars.dynamicViscosity();
+                D[vIdxGlobal] = volVars.diffusionCoeff(transportCompIdx);
                 T[vIdxGlobal] = volVars.temperature();
+                velocity[vIdxGlobal] = volVars.velocity();
+
+                asImp_().writeVolVarsData(volVarsFile, volVars);
+                volVarsFile << std::endl;
             }
         }
+        volVarsFile.close();
+
         writer.attachVertexData(pN, "P");
         writer.attachVertexData(delP, "delP");
 
@@ -231,20 +231,24 @@ public:
 
         writer.attachVertexData(rho, "rho");
         writer.attachVertexData(mu, "mu");
-        writer.attachVertexData(velocity, "v", dim);
+        writer.attachVertexData(D, "D");
+        writer.attachVertexData(lambda, "lambda");
         writer.attachVertexData(T, "temperature");
+        writer.attachVertexData(velocity, "v", dim);
 
-
-        // just to have the actual values plotted
+        // ensure that the actual values are given out
         asImp_().updateWallProperties();
 
+        // write flux values to .vtu and .csv
+        std::ofstream fluxFile("fluxVarsData.csv", std::ios_base::out);
+        asImp_().writeFluxVarsHeader(fluxFile);
+        fluxFile << std::endl;
+
         eIt = this->gridView_().template begin<0>();
         eEndIt = this->gridView_().template end<0>();
-
         for (; eIt != eEndIt; ++eIt)
         {
             fvGeometry.update(this->gridView_(), *eIt);
-            elemBcTypes.update(this->problem_(), *eIt, fvGeometry);
 
             ElementVolumeVariables elemVolVars;
             elemVolVars.update(this->problem_(),
@@ -252,10 +256,17 @@ public:
                                fvGeometry,
                                false);
 
-            IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
-            const IntersectionIterator &endIt = this->gridView_().iend(*eIt);
+            unsigned int numFluxVars = 0;
+            Scalar sumDynamicEddyViscosity = 0.0;
+            Scalar sumMixingLength = 0.0;
+            Scalar sumUPlus = 0.0;
+            Scalar sumYPlus = 0.0;
+            Scalar sumEddyDiffusivity = 0.0;
+            Scalar sumEddyConducitivity = 0.0;
 
-            for (; isIt != endIt; ++isIt)
+            IntersectionIterator isIt = this->gridView_().ibegin(*eIt);
+            IntersectionIterator isEndIt = this->gridView_().iend(*eIt);
+            for (; isIt != isEndIt; ++isIt)
             {
                 int fIdx = isIt->indexInInside();
 
@@ -266,54 +277,54 @@ public:
                                                     elemVolVars,
                                                     false);
 
-                GlobalPosition globalPos = fvGeometry.subContVolFace[fIdx].ipGlobal;
+                asImp_().writeFluxVarsData(fluxFile, fluxVars);
+                fluxFile << std::endl;
 
-                if (asImp_().shouldWriteSCVData(globalPos))
-                asImp_().writeSCVData(volVars, fluxVars, globalPos);
+                sumDynamicEddyViscosity += fluxVars.dynamicEddyViscosity();
+                sumMixingLength += fluxVars.mixingLength();
+                sumUPlus += fluxVars.uPlus();
+                sumYPlus += fluxVars.yPlusRough();
+                sumEddyDiffusivity += fluxVars.eddyDiffusivity();
+                sumEddyConducitivity += fluxVars.thermalEddyConductivity();
+                numFluxVars += 1;
             }
+
+            int eIdxGlobal = this->elementMapper().map(*eIt);
+            mut[eIdxGlobal] = sumDynamicEddyViscosity / numFluxVars;
+            lmix[eIdxGlobal] = sumMixingLength / numFluxVars;
+            uPlus[eIdxGlobal] = sumUPlus / numFluxVars;
+            yPlus[eIdxGlobal] = sumYPlus / numFluxVars;
+            Dt[eIdxGlobal] = sumEddyDiffusivity / numFluxVars;
+            lambdat[eIdxGlobal] = sumEddyConducitivity / numFluxVars;
         }
+        fluxFile.close();
+
+        writer.attachCellData(mut, "mu_t");
+        writer.attachCellData(lmix, "l_mix");
+        writer.attachCellData(uPlus, "u^+");
+        writer.attachCellData(yPlus, "y^+");
+        writer.attachCellData(Dt, "D_t");
+        writer.attachCellData(lambdat, "lambda_t");
     }
 
-    //! \copydoc ZeroEqModel::writeSCVHeader
-    void writeSCVHeader(std::stringstream &stream, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
+    //! \copydoc ZeroEqModel::writeFluxVarsHeader
+    void writeFluxVarsHeader(std::ofstream &stream)
     {
-        ParentType::writeSCVHeader(stream, fluxVars, globalPos);
-
-        stream << std::setw(width) << "eddyCMod"
-               << std::setw(width) << GET_PARAM_FROM_GROUP(TypeTag, int, ZeroEq, EddyConductivityModel)
-               << " - " << std::setw(width*2-3) << std::left  << eddyConductivityModelName() << std::right;
+        ParentType::writeFluxVarsHeader(stream);
+        stream << "," << "EddyConductivity";
     }
 
-    //! \copydoc ZeroEqModel::writeDataHeader
-    void writeDataHeader(std::stringstream &stream, int posIdx)
+    //! \copydoc ZeroEqModel::writeFluxVarsData
+    void writeFluxVarsData(std::ofstream &stream, const FluxVariables &fluxVars)
     {
-        ParentType::writeDataHeader(stream, posIdx);
-
-        stream << std::setw(width) << "T [K]"
-               << std::setw(width) << "T/T_max [-]"
-               << std::setw(width) << "TGrad [K/m]"
-               << std::setw(width) << "lambda [W/(m*K)]"
-               << std::setw(width) << "lambda_t [W/(m*K)]"
-               << std::setw(width) << "Pr [-]"
-               << std::setw(width) << "Pr_t [-]";
+        ParentType::writeFluxVarsData(stream, fluxVars);
+        stream << "," << fluxVars.thermalEddyConductivity();
     }
 
-    //! \copydoc ZeroEqModel::writeSCVDataValues
-    void writeSCVDataValues(std::stringstream &stream, const VolumeVariables &volVars, const FluxVariables &fluxVars, const GlobalPosition &globalPos)
-    {
-        ParentType::writeSCVDataValues(stream, volVars, fluxVars, globalPos);
-
-        int posIdx = this->getPosIdx(globalPos);
-        int wallIdx = this->getWallIdx(globalPos, posIdx);
-        stream << std::setprecision(prec)
-               << std::setw(width) << fluxVars.temperature()
-               << std::setw(width) << fluxVars.temperature() / this->wall[wallIdx].maxTemperature[posIdx]
-               << std::setw(width) << fluxVars.temperatureGrad()[wallNormal_]
-               << std::setw(width) << fluxVars.thermalConductivity()
-               << std::setw(width) << fluxVars.thermalEddyConductivity()
-               << std::setw(width) << fluxVars.prandtlNumber()
-               << std::setw(width) << fluxVars.turbulentPrandtlNumber();
-    }
+    /*!
+     * \name Wall properties
+     */
+    // \{
 
 
     //! \copydoc ZeroEqModel::resetWallProperties
@@ -347,6 +358,8 @@ public:
         this->wall[wallIdx].maxTemperature[posIdx] = this->interpolation(posIdx, prevIdx, this->wall[wallIdx].maxTemperature[prevIdx], nextIdx, this->wall[wallIdx].maxTemperature[nextIdx]);
     }
 
+    // \} // wall properties
+
     /*!
      * \brief Returns the name of used the eddy conductivity model.
      */
diff --git a/test/freeflow/zeroeq/zeroeqchanneltestproblem.hh b/test/freeflow/zeroeq/zeroeqchanneltestproblem.hh
index 84278a81251ff5220a564202f4adc326c8c1018a..6db74779bc61f6e008a304298bf37c3f095dd7f1 100644
--- a/test/freeflow/zeroeq/zeroeqchanneltestproblem.hh
+++ b/test/freeflow/zeroeq/zeroeqchanneltestproblem.hh
@@ -66,9 +66,6 @@ SET_BOOL_PROP(ZeroEqChannelTestProblem, ProblemEnableGravity, false);
 // Set only bottom as wall
 SET_BOOL_PROP(ZeroEqChannelTestProblem, BBoxMaxIsWall, false);
 
-// Do not write sub-control volume data
-SET_SCALAR_PROP(ZeroEqChannelTestProblem, ZeroEqWriteAllSCVData, -1);
-
 #if HAVE_UMFPACK
 // Use UMFPack as linear solver
 SET_TYPE_PROP(ZeroEqChannelTestProblem, LinearSolver, UMFPackBackend<TypeTag>);
diff --git a/test/freeflow/zeroeq/zeroeqtestproblem.hh b/test/freeflow/zeroeq/zeroeqtestproblem.hh
index e13159c30c3d769637202151a7a99dd440294916..2f4797933d0a9a300b2d5558556615e13abf946c 100644
--- a/test/freeflow/zeroeq/zeroeqtestproblem.hh
+++ b/test/freeflow/zeroeq/zeroeqtestproblem.hh
@@ -65,9 +65,6 @@ SET_TYPE_PROP(ZeroEqTestProblem, Fluid,
 
 // Disable gravity
 SET_BOOL_PROP(ZeroEqTestProblem, ProblemEnableGravity, false);
-
-// Write sub-control volume data only at x=0.8875 in dimensionless coordinates
-SET_SCALAR_PROP(ZeroEqTestProblem, ZeroEqWriteAllSCVData, .8875);
 }
 
 /*!
diff --git a/test/references/2cnizeroeq2p2cni-ff-reference.vtu b/test/references/2cnizeroeq2p2cni-ff-reference.vtu
index b655726128e22c1b45f40a498f0684deb06c242e..08575e73d8b7b496d35d2f7ee6c896608bae988f 100644
--- a/test/references/2cnizeroeq2p2cni-ff-reference.vtu
+++ b/test/references/2cnizeroeq2p2cni-ff-reference.vtu
@@ -139,6 +139,57 @@
           1.81252e-05 1.81252e-05 1.81252e-05 1.80701e-05 1.81222e-05 1.81478e-05 1.81511e-05 1.81534e-05 1.8151e-05 1.81479e-05 1.81444e-05 1.81407e-05
           1.81377e-05 1.8135e-05 1.81331e-05 1.81316e-05 1.813e-05 1.81262e-05 1.81481e-05 1.78881e-05
         </DataArray>
+        <DataArray type="Float32" Name="D" NumberOfComponents="1" format="ascii">
+          2.4933e-05 2.49396e-05 2.4933e-05 2.49396e-05 2.49334e-05 2.49334e-05 2.49394e-05 2.49395e-05 2.49338e-05 2.49339e-05 2.49389e-05 2.4939e-05
+          2.45071e-05 2.49333e-05 2.38383e-05 2.49302e-05 2.34513e-05 2.49231e-05 2.34989e-05 2.49171e-05 2.49352e-05 2.49139e-05 2.49376e-05 2.49164e-05
+          2.49357e-05 2.49145e-05 2.49372e-05 2.49162e-05 2.49362e-05 2.49157e-05 2.40576e-05 2.47245e-05 2.49324e-05 2.49398e-05 2.49332e-05 2.49394e-05
+          2.49338e-05 2.4939e-05 2.49343e-05 2.49384e-05 2.49347e-05 2.49378e-05 2.49348e-05 2.49371e-05 2.4935e-05 2.49365e-05 2.49354e-05 2.48134e-05
+          2.49325e-05 2.49399e-05 2.49332e-05 2.49394e-05 2.49337e-05 2.4939e-05 2.49342e-05 2.49385e-05 2.49347e-05 2.49381e-05 2.49352e-05 2.49376e-05
+          2.49356e-05 2.49372e-05 2.49361e-05 2.48317e-05 2.49326e-05 2.494e-05 2.49331e-05 2.49395e-05 2.49337e-05 2.4939e-05 2.49342e-05 2.49385e-05
+          2.49347e-05 2.49381e-05 2.49352e-05 2.49376e-05 2.49356e-05 2.49372e-05 2.4936e-05 2.48306e-05 2.49326e-05 2.494e-05 2.49331e-05 2.49395e-05
+          2.49336e-05 2.4939e-05 2.49341e-05 2.49386e-05 2.49346e-05 2.49381e-05 2.49351e-05 2.49377e-05 2.49356e-05 2.49372e-05 2.49359e-05 2.48292e-05
+          2.49326e-05 2.494e-05 2.49331e-05 2.49395e-05 2.49337e-05 2.4939e-05 2.49342e-05 2.49385e-05 2.49347e-05 2.49381e-05 2.49351e-05 2.49376e-05
+          2.49356e-05 2.49372e-05 2.4936e-05 2.483e-05 2.49325e-05 2.49399e-05 2.49332e-05 2.49394e-05 2.49337e-05 2.4939e-05 2.49342e-05 2.49385e-05
+          2.49347e-05 2.49381e-05 2.49352e-05 2.49377e-05 2.49357e-05 2.49372e-05 2.49361e-05 2.4831e-05 2.49324e-05 2.49398e-05 2.49332e-05 2.49394e-05
+          2.49338e-05 2.4939e-05 2.49343e-05 2.49386e-05 2.49348e-05 2.49381e-05 2.49352e-05 2.49377e-05 2.49357e-05 2.49373e-05 2.49362e-05 2.48135e-05
+          2.4933e-05 2.49396e-05 2.49334e-05 2.49395e-05 2.49339e-05 2.49391e-05 2.49344e-05 2.49387e-05 2.49349e-05 2.49383e-05 2.49354e-05 2.49378e-05
+          2.49358e-05 2.49374e-05 2.49361e-05 2.47426e-05 2.4933e-05 2.49396e-05 2.49333e-05 2.49394e-05 2.49338e-05 2.4939e-05 2.49342e-05 2.49385e-05
+          2.49347e-05 2.49381e-05 2.49352e-05 2.49376e-05 2.49357e-05 2.49372e-05 2.49362e-05 2.40621e-05
+        </DataArray>
+        <DataArray type="Float32" Name="lambda" 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
+        </DataArray>
+        <DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
+          298.15 298.15 298.15 298.15 298.15 298.151 298.15 298.151 298.15 298.151 298.15 298.15
+          295.301 298.144 290.77 298.095 288.161 298.073 288.465 298.011 298.15 298.009 298.15 298.009
+          298.15 298.01 298.15 298.01 298.15 298.014 292.264 296.737 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 298.15 298.15 298.148 298.147 298.146 298.146 298.145 298.145 297.33
+          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 297.451 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 298.15 298.15 298.15 298.149 297.444 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.149 297.435
+          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
+          298.15 298.15 298.149 297.44 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 298.15 298.15 298.15 298.15 297.447 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.151 298.151 298.15 297.33
+          298.15 298.15 298.151 298.151 298.151 298.151 298.151 298.151 298.151 298.151 298.151 298.151
+          298.151 298.151 298.15 296.858 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
+          298.15 298.15 298.15 298.15 298.15 298.15 298.15 292.294
+        </DataArray>
         <DataArray type="Float32" Name="v" NumberOfComponents="3" format="ascii">
           0 0 0 0 0 0 3.5 0 0 3.42882 0.102826 0
           0 0 0 3.12032 0.00889225 0 0 0 0 3.23492 0.0250081 0
@@ -185,24 +236,99 @@
           0 0 0 0 0 0 0 0 0 0 0 0
           0 0 0 0 0 0 0 0 0 1.01295 0.00752135 0
         </DataArray>
-        <DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
-          298.15 298.15 298.15 298.15 298.15 298.151 298.15 298.151 298.15 298.151 298.15 298.15
-          295.301 298.144 290.77 298.095 288.161 298.073 288.465 298.011 298.15 298.009 298.15 298.009
-          298.15 298.01 298.15 298.01 298.15 298.014 292.264 296.737 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 298.15 298.15 298.148 298.147 298.146 298.146 298.145 298.145 297.33
-          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 297.451 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 298.15 298.15 298.15 298.149 297.444 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.149 297.435
-          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
-          298.15 298.15 298.149 297.44 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 298.15 298.15 298.15 298.15 297.447 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.151 298.151 298.15 297.33
-          298.15 298.15 298.151 298.151 298.151 298.151 298.151 298.151 298.151 298.151 298.151 298.151
-          298.151 298.151 298.15 296.858 298.15 298.15 298.15 298.15 298.15 298.15 298.15 298.15
-          298.15 298.15 298.15 298.15 298.15 298.15 298.15 292.294
-        </DataArray>
       </PointData>
+      <CellData Scalars="mu_t">
+        <DataArray type="Float32" Name="mu_t" NumberOfComponents="1" format="ascii">
+          0.00113159 0.00104003 0.000994585 0.000946153 0.000918956 0.000891534 0.000825134 0.000826161 0.000817793 0.000788671 0.000819218 0.000807311
+          0.000801877 0.000802407 0.000592772 0.000957068 0.00209102 0.00247875 0.002849 0.0030101 0.00311446 0.00309562 0.00312415 0.00314063
+          0.00315469 0.0031766 0.003191 0.00317897 0.00310787 0.00297999 0.00029722 0.000493796 0.000112746 0.000534618 0.000980159 0.00158017
+          0.00228887 0.00274029 0.00314916 0.00356794 0.00384152 0.00417363 0.00438773 0.00453972 0.00471252 0.000773058 0.00172632 0.0019766
+          0.002156 0.00207599 0.00197914 0.00189706 0.00169951 0.00147182 0.00125439 0.00107262 0.000864541 0.000692967 0.00051321 0.000210249
+          0.000365036 0.000682166 0.000872764 0.00107367 0.00116764 0.00118295 0.00098146 0.0010111 0.00105023 0.00114153 0.00129587 0.00137807
+          0.00145231 0.00143824 0.00126426 0.00028109 0.000593999 0.000771226 0.000961311 0.00104528 0.00110322 0.00109239 0.00111875 0.00116632
+          0.00119642 0.00126418 0.00130753 0.00134769 0.00132309 0.00112829 0.000754456 0.0017034 0.00195615 0.00212335 0.00207551 0.0019782
+          0.00184724 0.00166068 0.00146923 0.0012424 0.00103336 0.000827976 0.000669233 0.000501449 0.000208812 0.000281812 0.000479384 0.000106655
+          0.000550506 0.00109626 0.00169419 0.00220646 0.0027186 0.00315032 0.0035611 0.00389769 0.00419895 0.00439584 0.00453065 0.00469281
+          0.000957558 0.00208942 0.00247432 0.00284071 0.00298117 0.00309322 0.00312965 0.00316063 0.00316581 0.00317419 0.00317047 0.00317347
+          0.0031566 0.00308956 0.00296338 0.00113009 0.00103872 0.000993146 0.000945172 0.000917185 0.000889965 0.000871513 0.000853585 0.000840515
+          0.000827013 0.000817364 0.000807301 0.000802808 0.000803525 0.000592546
+        </DataArray>
+        <DataArray type="Float32" Name="l_mix" NumberOfComponents="1" format="ascii">
+          0.00163983 0.00161525 0.0016027 0.00158822 0.0015802 0.00157336 0.00155683 0.00156233 0.00156112 0.00154393 0.00154818 0.00154371
+          0.00154198 0.00154175 0.00145989 0.00911232 0.00908745 0.00907421 0.00905814 0.0090491 0.00904109 0.00902139 0.00902808 0.00902662
+          0.00900526 0.00901061 0.00900491 0.00900275 0.00900245 0.0088855 0.0213472 0.0213457 0.0213448 0.0213437 0.021343 0.0213424
+          0.0213408 0.0213413 0.0213412 0.0213394 0.0213399 0.0213394 0.0213392 0.0213391 0.0213264 0.042356 0.042356 0.042356
+          0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.0423559
+          0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107
+          0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107
+          0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.0791107 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356
+          0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.042356 0.0423559 0.0213471 0.0213456 0.0213448
+          0.0213436 0.021343 0.0213421 0.0213416 0.021341 0.0213406 0.0213401 0.0213398 0.0213393 0.0213392 0.0213392 0.0213263
+          0.00911195 0.00908708 0.00907376 0.00905783 0.00904848 0.00903814 0.00903123 0.00902389 0.00901901 0.00901304 0.00900932 0.00900451
+          0.00900283 0.00900271 0.00888511 0.00163945 0.00161489 0.00160228 0.00158794 0.00157966 0.00157086 0.00156501 0.00155898 0.00155494
+          0.00155017 0.00154715 0.00154339 0.00154203 0.00154196 0.00145964
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          25.9974 25.2795 24.8924 24.4908 24.2424 24.2905 26.0523 26.1294 26.0409 25.4357 23.354 23.2578
+          23.193 23.212 30.7123 53.5297 54.0252 53.9632 53.8836 53.7206 53.8818 55.3969 55.7662 55.7248
+          54.6433 52.4942 52.3651 52.2274 52.1347 58.0966 54.9101 57.2277 58.1084 59.0808 59.502 60.2965
+          62.4883 63.2884 63.5911 62.7302 60.5027 60.6422 60.6255 60.4909 67.4387 54.5764 56.5523 57.597
+          58.8458 59.5319 60.6923 63.3403 64.4775 65.0991 64.5312 62.4483 62.8458 63.0021 63.0032 70.4531
+          54.3547 56.059 57.0129 58.1827 58.8708 60.0426 62.7113 63.8872 64.5598 64.0434 62.0036 62.4421
+          62.6324 62.6822 70.2087 54.3693 56.0716 57.0282 58.1884 58.8936 59.6857 60.2259 60.8131 61.2183
+          61.7053 62.026 62.4159 62.58 62.6267 70.1846 54.577 56.5492 57.5953 58.8298 59.5397 60.3214
+          60.8316 61.3789 61.7439 62.1793 62.4567 62.8008 62.9296 62.9294 70.4089 54.8986 57.2117 58.0883
+          59.0482 59.4451 59.8638 60.0483 60.2492 60.3132 60.4443 60.4676 60.5737 60.5436 60.421 67.4071
+          53.5085 54.0026 53.9346 53.8546 53.6451 53.4567 53.2358 53.0307 52.799 52.6276 52.4318 52.315
+          52.1865 52.1087 58.1123 25.986 25.2687 24.8806 24.4825 24.2277 24.0019 23.8368 23.6823 23.5457
+          23.4327 23.326 23.249 23.1946 23.2175 30.7679
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          25.9953 25.262 24.8958 24.4811 24.2542 24.0623 23.6043 23.7555 23.7222 23.2536 23.3694 23.2482
+          23.2018 23.1951 21.0925 97.4825 94.7324 93.3593 91.8043 90.9534 90.2336 88.5162 89.083 88.9582
+          87.2012 87.6352 87.1806 87.0067 86.9817 79.0968 222.585 216.306 213.17 209.62 207.677 206.033
+          202.112 203.406 203.121 199.109 200.1 199.062 198.665 198.608 180.604 441.515 429.059 422.84
+          415.797 411.943 408.683 400.904 403.472 402.906 394.949 396.914 394.855 394.068 393.955 358.243
+          824.641 801.377 789.762 776.607 769.409 763.32 748.792 753.586 752.531 737.668 741.339 737.493
+          736.022 735.811 669.11 824.273 801.046 789.381 776.352 768.921 761.106 755.944 750.683 747.173
+          743.047 740.459 737.219 736.072 735.987 668.923 441.318 428.882 422.636 415.66 411.682 407.498
+          404.734 401.917 400.038 397.829 396.443 394.709 394.095 394.049 358.143 222.486 216.216 213.068
+          209.551 207.545 205.436 204.043 202.622 201.675 200.561 199.863 198.988 198.679 198.656 180.554
+          97.439 94.6933 93.3144 91.7742 90.8958 89.9719 89.3617 88.7397 88.3248 87.837 87.5312 87.1482
+          87.0126 87.0025 79.0748 25.9837 25.2515 24.8838 24.4731 24.2389 23.9925 23.8298 23.6639 23.5533
+          23.4232 23.3417 23.2395 23.2034 23.2007 21.0866
+        </DataArray>
+        <DataArray type="Float32" Name="D_t" NumberOfComponents="1" format="ascii">
+          0.000181498 0.000171441 0.000166304 0.000160841 0.000157678 0.000155221 0.000158329 0.000156366 0.000154514 0.000152488 0.000146058 0.000144701
+          0.000144004 0.000144121 0.000164695 0.00125296 0.00123174 0.00121344 0.00119246 0.00117821 0.00116256 0.00114642 0.00113598 0.00112554
+          0.00111546 0.00110902 0.00110079 0.00109575 0.00109366 0.00108748 0.0029294 0.0029674 0.00297005 0.00297021 0.00296412 0.00295472
+          0.00293785 0.00292907 0.00291849 0.0029099 0.00290465 0.00289697 0.0028908 0.00288458 0.00287049 0.00577537 0.00581614 0.00583774
+          0.00586478 0.00587813 0.00589347 0.00589936 0.00591067 0.00591698 0.00592751 0.0059361 0.00594361 0.00594702 0.00594724 0.00593603
+          0.0107443 0.0107709 0.0107957 0.0108335 0.0108597 0.0108923 0.0109117 0.0109408 0.0109617 0.0109887 0.0110091 0.0110303
+          0.0110424 0.0110511 0.0110477 0.0107424 0.0107689 0.0107934 0.010831 0.010857 0.0108905 0.0109141 0.0109432 0.0109642
+          0.0109899 0.0110084 0.0110287 0.0110401 0.0110485 0.0110447 0.00577287 0.00581342 0.00583476 0.00586124 0.00587511 0.00589148
+          0.00590092 0.00591241 0.00591978 0.00592858 0.00593439 0.00594102 0.00594388 0.00594413 0.00593265 0.00292749 0.00296536 0.00296762
+          0.00296759 0.00295951 0.00295068 0.00294019 0.00293002 0.00291984 0.00291047 0.0029018 0.00289451 0.0028887 0.0028831 0.00286929
+          0.00125191 0.00123071 0.00121221 0.0011914 0.00117574 0.00116004 0.00114749 0.00113525 0.00112501 0.00111526 0.00110724 0.0011
+          0.00109552 0.00109378 0.0010878 0.000181335 0.000171295 0.000166143 0.00016073 0.000157477 0.000154385 0.000152238 0.00015017 0.000148572
+          0.000147021 0.000145816 0.000144683 0.000144103 0.000144249 0.000164976
+        </DataArray>
+        <DataArray type="Float32" Name="lambda_t" NumberOfComponents="1" format="ascii">
+          0.0051381 0.00459677 0.00439989 0.0042354 0.00418486 0.00429451 0.00475194 0.00506318 0.00519527 0.00520361 0.0049703 0.00483844
+          0.0047665 0.00450784 0.00458698 0.0369964 0.0362385 0.0356075 0.0349147 0.0344484 0.0339764 0.0335402 0.0333042 0.0330947
+          0.0329199 0.0328385 0.0326668 0.0325713 0.0325186 0.0317069 0.0866885 0.087788 0.0878392 0.0878128 0.0876049 0.0873028
+          0.0867868 0.0865125 0.0861956 0.0859448 0.0858021 0.0855897 0.0854252 0.0852337 0.0836485 0.170931 0.172133 0.17277
+          0.173563 0.173954 0.174399 0.174568 0.174894 0.175075 0.175378 0.175628 0.175845 0.175941 0.175859 0.173219
+          0.317993 0.318778 0.319515 0.32063 0.321409 0.322368 0.322944 0.323802 0.324421 0.325217 0.32582 0.326443
+          0.32679 0.326788 0.322258 0.317938 0.31872 0.319448 0.320556 0.321328 0.322315 0.323017 0.323872 0.324497
+          0.325252 0.325799 0.326396 0.32672 0.32671 0.322154 0.170856 0.172053 0.172682 0.173458 0.173864 0.17434
+          0.174613 0.174943 0.175153 0.175403 0.175567 0.175751 0.175825 0.175737 0.173071 0.086632 0.0877276 0.0877676
+          0.0877363 0.0874696 0.0871802 0.0868447 0.0865187 0.0861954 0.0858965 0.0856212 0.0853876 0.0852009 0.0849982 0.0833986
+          0.0369654 0.036209 0.0355729 0.0348898 0.0343835 0.0338902 0.033501 0.0331282 0.0328203 0.0325301 0.0322944 0.032084
+          0.0319571 0.0318943 0.0311047 0.00513358 0.00459432 0.00439789 0.00424499 0.00419353 0.00415476 0.00414693 0.00413628 0.00413205
+          0.00412105 0.0041117 0.00410144 0.0041231 0.00400505 0.00418437
+        </DataArray>
+      </CellData>
       <Points>
         <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
           0 0.25 0 0.05 0.25 0 0 0.262165 0 0.05 0.262165 0
diff --git a/test/references/2czeroeq2p2c-ff-reference.vtu b/test/references/2czeroeq2p2c-ff-reference.vtu
index 9d1d53e1da427cb472a524f0b8b3d279df1d7ee9..2115eab7690f156c99965936b0c9222eab15f8cd 100644
--- a/test/references/2czeroeq2p2c-ff-reference.vtu
+++ b/test/references/2czeroeq2p2c-ff-reference.vtu
@@ -4,116 +4,116 @@
     <Piece NumberOfCells="140" NumberOfPoints="165">
       <PointData Scalars="P" Vectors="v">
         <DataArray type="Float32" Name="P" NumberOfComponents="1" format="ascii">
-          100013 99987.5 100013 99987.5 100012 100012 99989.5 99989.5 100009 100009 99991.8 99991.4
-          100004 100006 99995.2 99993.9 100002 100003 99997.4 99996.6 100000 100000 100017 99986.2
-          100012 99989.1 100009 99991.6 100004 99994.8 100002 99997.1 100000 100016 99986.1 100012
-          99988.9 100009 99991.3 100006 99993.7 100003 99996.4 100000 100016 99985.8 100012 99988.7
-          100009 99991.4 100005 99994.3 100003 99996.8 100000 100016 99985.9 100013 99988.6 100009
-          99991.2 100006 99993.6 100003 99996.2 100000 100016 99985.6 100012 99988.5 100009 99991.2
-          100006 99994 100003 99996.5 100000 100016 99985.8 100013 99988.5 100010 99991.1 100007
-          99993.6 100003 99996.1 100000 100015 99985.6 100013 99988.4 100009 99991.1 100006 99993.8
-          100003 99996.3 100000 100016 99985.9 100013 99988.6 100010 99991.2 100006 99993.7 100003
-          99996.2 100000 100016 99985.6 100013 99988.5 100009 99991.1 100006 99993.7 100003 99996.3
-          100000 100016 99986.2 100013 99988.9 100009 99991.5 100006 99993.9 100003 99996.4 100000
-          100017 99985.9 100013 99988.9 100009 99991.5 100006 99994 100003 99996.4 100000 100014
-          99988.8 100011 99990.3 100008 99992.3 100005 99994.4 100003 99996.8 100000 100014 99988.8
-          100011 99990.2 100008 99992.2 100005 99994.4 100003 99996.7 100000
+          100012 99986.8 100012 99986.8 100011 100011 99988.9 99988.9 100008 100008 99991.6 99991.3
+          100004 100006 99995.1 99993.8 100002 100003 99997.2 99996.5 100000 100000 100016 99985.5
+          100012 99988.6 100008 99991.4 100004 99994.7 100002 99997 100000 100016 99985.5 100012
+          99988.4 100009 99991.1 100006 99993.5 100003 99996.3 100000 100015 99985.2 100012 99988.3
+          100009 99991.1 100005 99994.2 100003 99996.7 100000 100015 99985.2 100012 99988.1 100009
+          99990.9 100006 99993.4 100003 99996.1 100000 100015 99985.1 100012 99988.1 100009 99990.9
+          100006 99993.8 100003 99996.4 100000 100015 99985.1 100012 99988 100009 99990.7 100006
+          99993.4 100003 99996 100000 100015 99985 100012 99987.9 100009 99990.8 100006 99993.6
+          100003 99996.2 100000 100015 99985.1 100012 99988 100009 99990.7 100006 99993.4 100003
+          99996 100000 100015 99985 100012 99987.9 100009 99990.7 100006 99993.5 100003 99996.1
+          100000 100015 99985.3 100012 99988.2 100009 99990.9 100006 99993.5 100003 99996.1 100000
+          100016 99985.1 100012 99988.2 100009 99991 100006 99993.6 100003 99996.2 100000 100012
+          99987.2 100010 99989.2 100008 99991.5 100005 99993.9 100003 99996.3 100000 100012 99987.2
+          100010 99989.2 100008 99991.5 100005 99993.9 100003 99996.3 100000
         </DataArray>
         <DataArray type="Float32" Name="delP" NumberOfComponents="1" format="ascii">
-          12.7076 -12.4944 12.7147 -12.4873 11.5107 11.5158 -10.5337 -10.5425 8.73664 8.82837 -8.1863 -8.55834
-          3.71338 6.01529 -4.74736 -6.10369 2.06491 3.03845 -2.64569 -3.44184 0 0 17.0911 -13.8382
-          12.1097 -10.8541 8.76434 -8.37622 4.47049 -5.18672 2.29653 -2.85172 0 16.3375 -13.869 12.3292
-          -11.0759 9.14513 -8.69817 6.3276 -6.28461 3.16632 -3.6495 0 15.9682 -14.1798 12.4226 -11.2616
-          8.97968 -8.61862 5.23923 -5.70377 2.62091 -3.25261 0 15.8914 -14.1375 12.5677 -11.3627 9.39899
-          -8.82092 6.47911 -6.38516 3.25645 -3.81505 0 15.6063 -14.3605 12.4864 -11.4896 9.17214 -8.80718
-          5.73398 -6.04669 2.86099 -3.53875 0 15.7284 -14.2093 12.6345 -11.4624 9.52614 -8.87621 6.51491
-          -6.40333 3.28669 -3.87779 0 15.4858 -14.4277 12.5174 -11.5889 9.30708 -8.90985 6.02325 -6.23515
-          3.01125 -3.7002 0 15.8087 -14.1284 12.6719 -11.3985 9.53786 -8.81662 6.44795 -6.32764 3.24642
-          -3.82551 0 15.5736 -14.3811 12.6134 -11.5458 9.36209 -8.87883 6.12034 -6.26007 3.04598 -3.72436
-          0 16.2371 -13.7486 12.6556 -11.0583 9.35488 -8.53976 6.20463 -6.09136 3.08709 -3.63626 0
-          16.825 -14.0623 12.6586 -11.126 9.10154 -8.52945 5.87794 -6.01488 2.89389 -3.61815 0 14.0212
-          -11.1778 11.2851 -9.69385 8.39841 -7.73741 5.49221 -5.58784 2.66227 -3.24051 0 13.9477 -11.2514
-          11.2436 -9.77021 8.35553 -7.79898 5.45532 -5.63381 2.63356 -3.28067 0
+          12.0349 -13.1681 12.0412 -13.1617 10.9073 10.9098 -11.1111 -11.1165 8.28912 8.3453 -8.37977 -8.68324
+          3.89873 5.71854 -4.88425 -6.24955 1.97537 2.86707 -2.74958 -3.52368 0 0 16.4663 -14.4651
+          11.5312 -11.3914 8.36027 -8.55825 4.48056 -5.32232 2.29061 -2.96146 0 15.6992 -14.5038 11.7152
+          -11.5945 8.64018 -8.92717 5.94847 -6.44936 3.00684 -3.74248 0 15.4005 -14.7474 11.8725 -11.7293
+          8.58489 -8.85202 5.11774 -5.84245 2.57262 -3.34293 0 15.2731 -14.7625 11.9469 -11.8694 8.86964
+          -9.13729 6.07481 -6.58385 3.06027 -3.90954 0 15.0739 -14.8986 11.9555 -11.9355 8.76475 -9.08419
+          5.52912 -6.20645 2.76298 -3.6218 0 15.0816 -14.863 11.9873 -12.0007 8.97326 -9.25714 6.09758
+          -6.64531 3.06916 -3.99105 0 14.9449 -14.9737 11.9737 -12.0532 8.87368 -9.2298 5.7634 -6.43041
+          2.87999 -3.79982 0 15.0637 -14.8718 11.9554 -12.0124 8.95409 -9.2689 6.03155 -6.62854 3.03115
+          -3.99143 0 14.9506 -14.9993 12.0021 -12.0781 8.89728 -9.2606 5.84146 -6.51069 2.91639 -3.8726
+          0 15.2253 -14.7092 11.8011 -11.8275 8.75309 -9.10746 5.83836 -6.49066 2.92188 -3.89976 0
+          15.9598 -14.9404 11.9088 -11.8385 8.66529 -9.03779 5.687 -6.38452 2.83167 -3.82189 0 12.2525
+          -12.8222 10.3092 -10.784 7.92823 -8.50987 5.35183 -6.1316 2.67814 -3.6911 0 12.2467 -12.828
+          10.3084 -10.7882 7.92661 -8.51342 5.34936 -6.13493 2.67548 -3.69443 0
         </DataArray>
         <DataArray type="Float32" Name="x_gas^H2O" NumberOfComponents="1" format="ascii">
-          0.0127981 0.0102663 0.0141522 0.0138445 0.00913757 0.0135929 0.00766004 0.0132375 0.00626842 0.0128278 0.00570891 0.0124788
-          0.00901065 0.0124365 0.011238 0.0124141 0.0130469 0.01242 0.0149163 0.0125371 0.031697 0.0143012 0.0121553 0.0123204
-          0.0123984 0.0124568 0.0124696 0.0124521 0.0124336 0.0124164 0.0124033 0.0124128 0.0131154 0.0120484 0.0120811 0.0121118
-          0.0121489 0.0121786 0.0122018 0.0122135 0.0122245 0.0122328 0.0122538 0.0127947 0.0120979 0.0120998 0.0121043 0.0121121
-          0.0121212 0.0121311 0.0121389 0.0121472 0.0121551 0.0121765 0.0126232 0.0121389 0.0121375 0.0121366 0.0121364 0.0121371
-          0.0121387 0.0121406 0.0121431 0.0121462 0.0121646 0.0126356 0.0121649 0.0121635 0.0121623 0.012161 0.01216 0.0121593
-          0.012159 0.0121588 0.0121597 0.0121798 0.0126548 0.0121784 0.0121775 0.0121766 0.0121756 0.0121746 0.0121737 0.0121729
-          0.0121722 0.0121728 0.0121968 0.0126888 0.0121854 0.0121839 0.0121826 0.0121813 0.0121802 0.0121792 0.0121784 0.0121778
-          0.0121792 0.0122084 0.0126996 0.0121789 0.0121782 0.0121775 0.0121767 0.0121763 0.0121763 0.0121767 0.0121778 0.0121813
-          0.0122165 0.0127097 0.0121691 0.0121669 0.012166 0.0121667 0.012169 0.012173 0.0121781 0.0121847 0.0121936 0.0122313
-          0.0127204 0.0121149 0.012127 0.0121423 0.0121631 0.0121842 0.0122079 0.01223 0.0122526 0.0122742 0.0123179 0.0128053
-          0.0121618 0.0122622 0.012339 0.0124181 0.0124759 0.0125272 0.0125629 0.0125915 0.0126111 0.0126442 0.0131372 0.0142436
-          0.014145 0.0140488 0.0139228 0.0138049 0.0136694 0.0135471 0.0134186 0.013303 0.0132063 0.0139505 0.0127981 0.011735
-          0.010997 0.0100829 0.00942506 0.00874768 0.00825228 0.00779673 0.00744966 0.00714776 0.0127981
+          0.0127981 0.0105814 0.0141423 0.0138691 0.0100028 0.0136808 0.00905438 0.0134445 0.00801763 0.0131864 0.00761935 0.0129488
+          0.0105508 0.0128917 0.0126255 0.0128592 0.0143585 0.0128543 0.016196 0.0129884 0.031697 0.0147984 0.012153 0.0123115
+          0.0123839 0.0124483 0.0124827 0.0124984 0.0124944 0.0124974 0.0125006 0.0125367 0.0132921 0.012049 0.0120794 0.0121066
+          0.0121399 0.0121687 0.0121968 0.0122146 0.0122341 0.0122514 0.0122848 0.0128599 0.0120976 0.0120993 0.0121032 0.0121099
+          0.0121178 0.0121276 0.0121363 0.0121466 0.0121572 0.0121831 0.0126613 0.0121367 0.0121354 0.0121348 0.0121345 0.0121351
+          0.0121364 0.0121383 0.0121409 0.0121446 0.0121647 0.0126624 0.0121625 0.0121612 0.0121599 0.0121586 0.0121577 0.0121568
+          0.0121564 0.0121561 0.012157 0.0121781 0.0126796 0.0121758 0.012175 0.0121742 0.0121732 0.0121723 0.0121713 0.0121705
+          0.0121697 0.0121702 0.0121952 0.012714 0.0121837 0.0121824 0.0121813 0.0121802 0.0121792 0.0121782 0.0121773 0.0121766
+          0.0121777 0.012208 0.0127274 0.0121795 0.0121791 0.0121785 0.0121779 0.0121774 0.012177 0.0121767 0.0121768 0.0121791
+          0.0122145 0.0127381 0.0121736 0.0121716 0.0121705 0.0121702 0.0121706 0.0121717 0.0121734 0.0121758 0.0121804 0.0122154
+          0.0127343 0.0121289 0.0121367 0.0121452 0.012156 0.0121667 0.0121789 0.0121907 0.0122035 0.0122171 0.012255 0.0127662
+          0.0121616 0.012235 0.0122809 0.0123325 0.0123701 0.0124094 0.0124401 0.0124705 0.0124961 0.0125392 0.0130704 0.0141558
+          0.0140831 0.014025 0.0139574 0.0138987 0.0138329 0.0137723 0.0137067 0.0136449 0.0135969 0.01429 0.0127981 0.0121524
+          0.0119493 0.0115476 0.0113193 0.0109876 0.0107244 0.010426 0.0101621 0.00990616 0.0127981
         </DataArray>
         <DataArray type="Float32" Name="X_gas^H2O" NumberOfComponents="1" format="ascii">
-          0.008 0.00641127 0.008851 0.00865753 0.00570391 0.00849942 0.00477892 0.00827608 0.00390867 0.0080187 0.00355903 0.00779951
-          0.00562442 0.00777293 0.00702063 0.00775889 0.00815631 0.00776257 0.00933162 0.00783609 0.0199569 0.00894472 0.00759637 0.00770003
-          0.00774898 0.00778565 0.00779373 0.00778274 0.00777112 0.00776032 0.0077521 0.00775804 0.00819937 0.00752922 0.00754977 0.00756903
-          0.00759235 0.00761099 0.00762557 0.0076329 0.00763982 0.00764504 0.00765818 0.00799789 0.0075603 0.00756152 0.00756436 0.00756926
-          0.00757493 0.00758115 0.00758607 0.0075913 0.00759622 0.00760968 0.00789016 0.00758607 0.00758517 0.00758465 0.0075845 0.00758495
-          0.00758591 0.00758715 0.00758868 0.00759066 0.00760221 0.00789796 0.00760242 0.00760154 0.00760073 0.00759991 0.00759931 0.00759884
-          0.00759865 0.00759857 0.00759915 0.00761175 0.00790999 0.00761084 0.00761031 0.00760974 0.00760909 0.0076085 0.0076079 0.00760739
-          0.00760696 0.00760737 0.0076224 0.00793134 0.00761526 0.00761433 0.0076135 0.0076127 0.007612 0.00761135 0.00761084 0.0076105
-          0.00761135 0.00762972 0.00793818 0.00761116 0.00761075 0.00761028 0.00760982 0.00760955 0.00760951 0.00760978 0.00761047 0.00761271
-          0.00763478 0.0079445 0.00760503 0.00760362 0.00760306 0.00760349 0.00760494 0.00760745 0.00761067 0.00761481 0.0076204 0.00764408
-          0.00795124 0.00757101 0.00757858 0.00758822 0.00760123 0.00761452 0.00762938 0.00764325 0.00765744 0.00767101 0.00769845 0.00800455
-          0.00760041 0.00766349 0.00771167 0.00776135 0.00779765 0.0078299 0.0078523 0.00787025 0.00788257 0.00790337 0.00821305 0.00890851
-          0.0088465 0.00878598 0.00870676 0.00863267 0.00854747 0.00847062 0.0083899 0.00831723 0.00825644 0.0087242 0.008 0.00733255
-          0.00686945 0.00629628 0.00588402 0.00545973 0.00514956 0.00486445 0.0046473 0.00445846 0.008
+          0.008 0.00660883 0.00884482 0.00867302 0.00624607 0.00855466 0.00565181 0.00840613 0.0050027 0.00824396 0.00475347 0.00809469
+          0.0065896 0.00805881 0.00789164 0.00803839 0.00898076 0.00803532 0.0101371 0.00811957 0.0199569 0.00925742 0.0075949 0.00769442
+          0.00773986 0.00778035 0.00780193 0.00781181 0.00780929 0.00781114 0.00781319 0.00783587 0.00831037 0.00752961 0.00754871 0.00756581
+          0.00758666 0.00760475 0.00762241 0.00763362 0.00764585 0.00765668 0.00767767 0.00803884 0.00756015 0.0075612 0.00756367 0.00756783
+          0.00757282 0.00757896 0.00758444 0.00759089 0.00759752 0.0076138 0.00791413 0.00758467 0.00758389 0.00758346 0.00758331 0.00758367
+          0.0075845 0.0075857 0.00758734 0.00758965 0.00760229 0.00791481 0.00760089 0.00760003 0.00759925 0.00759846 0.00759784 0.00759732
+          0.00759703 0.00759687 0.00759743 0.00761067 0.00792561 0.0076092 0.00760874 0.00760823 0.00760762 0.00760704 0.00760643 0.00760588
+          0.00760538 0.00760573 0.00762138 0.00794719 0.00761419 0.00761338 0.00761266 0.00761196 0.00761133 0.00761072 0.00761018 0.00760972
+          0.00761042 0.00762942 0.0079556 0.00761155 0.00761128 0.00761094 0.00761057 0.00761025 0.00760998 0.00760982 0.00760983 0.00761127
+          0.00763352 0.00796235 0.00760783 0.0076066 0.00760592 0.0076057 0.00760596 0.00760666 0.0076077 0.00760923 0.00761212 0.00763406
+          0.00795993 0.0075798 0.00758466 0.00759002 0.0075968 0.0076035 0.00761118 0.00761858 0.00762665 0.00763514 0.00765897 0.00797998
+          0.00760033 0.00764641 0.00767519 0.00770762 0.00773125 0.00775589 0.0077752 0.00779425 0.00781034 0.0078374 0.00817106 0.00885327
+          0.00880755 0.00877101 0.00872856 0.00869166 0.00865028 0.00861219 0.00857095 0.00853208 0.0085019 0.00893768 0.008 0.00759457
+          0.00746704 0.00721489 0.00707165 0.00686359 0.00669851 0.00651136 0.00634593 0.00618549 0.008
         </DataArray>
         <DataArray type="Float32" Name="x_gas^Air" NumberOfComponents="1" format="ascii">
-          0.987202 0.989734 0.985848 0.986156 0.990862 0.986407 0.99234 0.986762 0.993732 0.987172 0.994291 0.987521
-          0.990989 0.987563 0.988762 0.987586 0.986953 0.98758 0.985084 0.987463 0.968303 0.985699 0.987845 0.98768
-          0.987602 0.987543 0.98753 0.987548 0.987566 0.987584 0.987597 0.987587 0.986885 0.987952 0.987919 0.987888
-          0.987851 0.987821 0.987798 0.987787 0.987776 0.987767 0.987746 0.987205 0.987902 0.9879 0.987896 0.987888
-          0.987879 0.987869 0.987861 0.987853 0.987845 0.987823 0.987377 0.987861 0.987863 0.987863 0.987864 0.987863
-          0.987861 0.987859 0.987857 0.987854 0.987835 0.987364 0.987835 0.987836 0.987838 0.987839 0.98784 0.987841
-          0.987841 0.987841 0.98784 0.98782 0.987345 0.987822 0.987822 0.987823 0.987824 0.987825 0.987826 0.987827
-          0.987828 0.987827 0.987803 0.987311 0.987815 0.987816 0.987817 0.987819 0.98782 0.987821 0.987822 0.987822
-          0.987821 0.987792 0.9873 0.987821 0.987822 0.987823 0.987823 0.987824 0.987824 0.987823 0.987822 0.987819
-          0.987783 0.98729 0.987831 0.987833 0.987834 0.987833 0.987831 0.987827 0.987822 0.987815 0.987806 0.987769
-          0.98728 0.987885 0.987873 0.987858 0.987837 0.987816 0.987792 0.98777 0.987747 0.987726 0.987682 0.987195
-          0.987838 0.987738 0.987661 0.987582 0.987524 0.987473 0.987437 0.987409 0.987389 0.987356 0.986863 0.985756
-          0.985855 0.985951 0.986077 0.986195 0.986331 0.986453 0.986581 0.986697 0.986794 0.986049 0.987202 0.988265
-          0.989003 0.989917 0.990575 0.991252 0.991748 0.992203 0.99255 0.992852 0.987202
+          0.987202 0.989419 0.985858 0.986131 0.989997 0.986319 0.990946 0.986556 0.991982 0.986814 0.992381 0.987051
+          0.989449 0.987108 0.987374 0.987141 0.985641 0.987146 0.983804 0.987012 0.968303 0.985202 0.987847 0.987689
+          0.987616 0.987552 0.987517 0.987502 0.987506 0.987503 0.987499 0.987463 0.986708 0.987951 0.987921 0.987893
+          0.98786 0.987831 0.987803 0.987785 0.987766 0.987749 0.987715 0.98714 0.987902 0.987901 0.987897 0.98789
+          0.987882 0.987872 0.987864 0.987853 0.987843 0.987817 0.987339 0.987863 0.987865 0.987865 0.987866 0.987865
+          0.987864 0.987862 0.987859 0.987855 0.987835 0.987338 0.987837 0.987839 0.98784 0.987841 0.987842 0.987843
+          0.987844 0.987844 0.987843 0.987822 0.98732 0.987824 0.987825 0.987826 0.987827 0.987828 0.987829 0.98783
+          0.98783 0.98783 0.987805 0.987286 0.987816 0.987818 0.987819 0.98782 0.987821 0.987822 0.987823 0.987823
+          0.987822 0.987792 0.987273 0.987821 0.987821 0.987821 0.987822 0.987823 0.987823 0.987823 0.987823 0.987821
+          0.987786 0.987262 0.987826 0.987828 0.987829 0.98783 0.987829 0.987828 0.987827 0.987824 0.98782 0.987785
+          0.987266 0.987871 0.987863 0.987855 0.987844 0.987833 0.987821 0.987809 0.987796 0.987783 0.987745 0.987234
+          0.987838 0.987765 0.987719 0.987668 0.98763 0.987591 0.98756 0.98753 0.987504 0.987461 0.98693 0.985844
+          0.985917 0.985975 0.986043 0.986101 0.986167 0.986228 0.986293 0.986355 0.986403 0.98571 0.987202 0.987848
+          0.988051 0.988452 0.988681 0.989012 0.989276 0.989574 0.989838 0.990094 0.987202
         </DataArray>
         <DataArray type="Float32" Name="X_gas^Air" NumberOfComponents="1" format="ascii">
-          0.992 0.993589 0.991149 0.991342 0.994296 0.991501 0.995221 0.991724 0.996091 0.991981 0.996441 0.9922
-          0.994376 0.992227 0.992979 0.992241 0.991844 0.992237 0.990668 0.992164 0.980043 0.991055 0.992404 0.9923
-          0.992251 0.992214 0.992206 0.992217 0.992229 0.99224 0.992248 0.992242 0.991801 0.992471 0.99245 0.992431
-          0.992408 0.992389 0.992374 0.992367 0.99236 0.992355 0.992342 0.992002 0.99244 0.992438 0.992436 0.992431
-          0.992425 0.992419 0.992414 0.992409 0.992404 0.99239 0.99211 0.992414 0.992415 0.992415 0.992415 0.992415
-          0.992414 0.992413 0.992411 0.992409 0.992398 0.992102 0.992398 0.992398 0.992399 0.9924 0.992401 0.992401
-          0.992401 0.992401 0.992401 0.992388 0.99209 0.992389 0.99239 0.99239 0.992391 0.992392 0.992392 0.992393
-          0.992393 0.992393 0.992378 0.992069 0.992385 0.992386 0.992387 0.992387 0.992388 0.992389 0.992389 0.99239
-          0.992389 0.99237 0.992062 0.992389 0.992389 0.99239 0.99239 0.99239 0.992391 0.99239 0.99239 0.992387
-          0.992365 0.992055 0.992395 0.992396 0.992397 0.992397 0.992395 0.992393 0.992389 0.992385 0.99238 0.992356
-          0.992049 0.992429 0.992421 0.992412 0.992399 0.992386 0.992371 0.992357 0.992343 0.992329 0.992302 0.991995
-          0.9924 0.992337 0.992288 0.992239 0.992202 0.99217 0.992148 0.99213 0.992117 0.992097 0.991787 0.991091
-          0.991153 0.991214 0.991293 0.991367 0.991453 0.991529 0.99161 0.991683 0.991744 0.991276 0.992 0.992667
-          0.993131 0.993704 0.994116 0.99454 0.99485 0.995136 0.995353 0.995542 0.992
+          0.992 0.993391 0.991155 0.991327 0.993754 0.991445 0.994348 0.991594 0.994997 0.991756 0.995247 0.991905
+          0.99341 0.991941 0.992108 0.991962 0.991019 0.991965 0.989863 0.99188 0.980043 0.990743 0.992405 0.992306
+          0.99226 0.99222 0.992198 0.992188 0.992191 0.992189 0.992187 0.992164 0.99169 0.99247 0.992451 0.992434
+          0.992413 0.992395 0.992378 0.992366 0.992354 0.992343 0.992322 0.991961 0.99244 0.992439 0.992436 0.992432
+          0.992427 0.992421 0.992416 0.992409 0.992402 0.992386 0.992086 0.992415 0.992416 0.992417 0.992417 0.992416
+          0.992415 0.992414 0.992413 0.99241 0.992398 0.992085 0.992399 0.9924 0.992401 0.992402 0.992402 0.992403
+          0.992403 0.992403 0.992403 0.992389 0.992074 0.992391 0.992391 0.992392 0.992392 0.992393 0.992394 0.992394
+          0.992395 0.992394 0.992379 0.992053 0.992386 0.992387 0.992387 0.992388 0.992389 0.992389 0.99239 0.99239
+          0.99239 0.992371 0.992044 0.992388 0.992389 0.992389 0.992389 0.99239 0.99239 0.99239 0.99239 0.992389
+          0.992366 0.992038 0.992392 0.992393 0.992394 0.992394 0.992394 0.992393 0.992392 0.992391 0.992388 0.992366
+          0.99204 0.99242 0.992415 0.99241 0.992403 0.992396 0.992389 0.992381 0.992373 0.992365 0.992341 0.99202
+          0.9924 0.992354 0.992325 0.992292 0.992269 0.992244 0.992225 0.992206 0.99219 0.992163 0.991829 0.991147
+          0.991192 0.991229 0.991271 0.991308 0.99135 0.991388 0.991429 0.991468 0.991498 0.991062 0.992 0.992405
+          0.992533 0.992785 0.992928 0.993136 0.993302 0.993489 0.993654 0.993815 0.992
         </DataArray>
         <DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii">
-          1.16273 1.16355 1.16213 1.16197 1.16433 1.16236 1.16473 1.16226 1.16557 1.16267 1.16562 1.16262
-          1.1643 1.16281 1.16322 1.16268 1.1625 1.16278 1.16162 1.16266 1.15424 1.16192 1.16306 1.16263
-          1.1629 1.16261 1.16283 1.16264 1.16279 1.16269 1.16278 1.16272 1.16244 1.1631 1.16274 1.16303
-          1.16274 1.16296 1.16274 1.16291 1.16276 1.16287 1.16278 1.16258 1.16308 1.16272 1.16303 1.16275
-          1.16298 1.16278 1.16293 1.1628 1.1629 1.16282 1.16266 1.16306 1.16271 1.16302 1.16274 1.16298
-          1.16277 1.16295 1.1628 1.16291 1.16282 1.16265 1.16304 1.16269 1.16301 1.16273 1.16297 1.16276
-          1.16293 1.16279 1.1629 1.16281 1.16264 1.16304 1.16269 1.163 1.16272 1.16297 1.16275 1.16293
-          1.16278 1.1629 1.1628 1.16263 1.16303 1.16268 1.163 1.16272 1.16296 1.16275 1.16293 1.16278
-          1.16289 1.1628 1.16262 1.16304 1.16269 1.163 1.16272 1.16297 1.16275 1.16293 1.16278 1.16289
-          1.16279 1.16262 1.16304 1.16269 1.16301 1.16273 1.16297 1.16275 1.16293 1.16278 1.16288 1.16279
-          1.16262 1.16307 1.16272 1.16302 1.16273 1.16296 1.16274 1.1629 1.16275 1.16285 1.16275 1.16258
-          1.16306 1.16265 1.16293 1.16262 1.16283 1.1626 1.16275 1.1626 1.1627 1.16261 1.16243 1.16211
-          1.16186 1.16216 1.16197 1.16223 1.16211 1.16231 1.16224 1.16239 1.16236 1.16207 1.16274 1.16292
-          1.16351 1.16367 1.16417 1.16428 1.16465 1.16472 1.16497 1.16504 1.16258
+          1.16272 1.16341 1.16213 1.16196 1.16394 1.16232 1.1641 1.16217 1.16479 1.16251 1.16477 1.16241
+          1.16362 1.16261 1.1626 1.16248 1.16192 1.16259 1.16105 1.16246 1.15424 1.1617 1.16306 1.16263
+          1.1629 1.1626 1.16282 1.16261 1.16277 1.16265 1.16274 1.16266 1.16236 1.16309 1.16273 1.16302
+          1.16274 1.16296 1.16274 1.16291 1.16276 1.16286 1.16276 1.16255 1.16307 1.16272 1.16303 1.16275
+          1.16298 1.16277 1.16293 1.1628 1.16289 1.16281 1.16264 1.16305 1.1627 1.16301 1.16274 1.16298
+          1.16277 1.16294 1.1628 1.16291 1.16282 1.16264 1.16304 1.16269 1.163 1.16272 1.16297 1.16276
+          1.16293 1.16279 1.1629 1.16281 1.16263 1.16303 1.16268 1.163 1.16272 1.16296 1.16275 1.16293
+          1.16278 1.16289 1.1628 1.16262 1.16303 1.16268 1.16299 1.16271 1.16296 1.16275 1.16292 1.16278
+          1.16289 1.1628 1.16261 1.16303 1.16268 1.16299 1.16272 1.16296 1.16275 1.16293 1.16278 1.16289
+          1.16279 1.16261 1.16303 1.16268 1.163 1.16272 1.16296 1.16275 1.16293 1.16278 1.16289 1.16279
+          1.16261 1.16305 1.1627 1.16301 1.16273 1.16296 1.16275 1.16292 1.16277 1.16287 1.16278 1.1626
+          1.16305 1.16266 1.16295 1.16265 1.16287 1.16265 1.16281 1.16265 1.16275 1.16265 1.16246 1.16212
+          1.16187 1.16216 1.16194 1.16219 1.16203 1.16221 1.16211 1.16224 1.16219 1.16192 1.16272 1.16272
+          1.16308 1.16301 1.16333 1.16328 1.16356 1.16356 1.16378 1.16382 1.16258
         </DataArray>
         <DataArray type="Float32" Name="mu" NumberOfComponents="1" format="ascii">
           1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05
@@ -131,51 +131,139 @@
           1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05
           1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05 1.82387e-05
         </DataArray>
+        <DataArray type="Float32" Name="D" NumberOfComponents="1" format="ascii">
+          2.49338e-05 2.494e-05 2.49338e-05 2.494e-05 2.4934e-05 2.4934e-05 2.49395e-05 2.49395e-05 2.49347e-05 2.49347e-05 2.49389e-05 2.49389e-05
+          2.49358e-05 2.49353e-05 2.4938e-05 2.49383e-05 2.49363e-05 2.4936e-05 2.49374e-05 2.49376e-05 2.49368e-05 2.49368e-05 2.49327e-05 2.49404e-05
+          2.49339e-05 2.49396e-05 2.49347e-05 2.49389e-05 2.49356e-05 2.49381e-05 2.49362e-05 2.49375e-05 2.49368e-05 2.49328e-05 2.49404e-05 2.49338e-05
+          2.49397e-05 2.49346e-05 2.4939e-05 2.49353e-05 2.49384e-05 2.4936e-05 2.49377e-05 2.49368e-05 2.49329e-05 2.49404e-05 2.49338e-05 2.49397e-05
+          2.49346e-05 2.4939e-05 2.49355e-05 2.49382e-05 2.49361e-05 2.49376e-05 2.49368e-05 2.4933e-05 2.49404e-05 2.49338e-05 2.49397e-05 2.49346e-05
+          2.4939e-05 2.49352e-05 2.49384e-05 2.4936e-05 2.49377e-05 2.49368e-05 2.4933e-05 2.49405e-05 2.49338e-05 2.49397e-05 2.49346e-05 2.4939e-05
+          2.49354e-05 2.49383e-05 2.49361e-05 2.49377e-05 2.49368e-05 2.4933e-05 2.49405e-05 2.49338e-05 2.49398e-05 2.49345e-05 2.49391e-05 2.49352e-05
+          2.49384e-05 2.4936e-05 2.49378e-05 2.49368e-05 2.4933e-05 2.49405e-05 2.49338e-05 2.49398e-05 2.49346e-05 2.49391e-05 2.49353e-05 2.49384e-05
+          2.4936e-05 2.49377e-05 2.49368e-05 2.4933e-05 2.49405e-05 2.49338e-05 2.49398e-05 2.49345e-05 2.49391e-05 2.49353e-05 2.49384e-05 2.4936e-05
+          2.49378e-05 2.49368e-05 2.4933e-05 2.49405e-05 2.49338e-05 2.49398e-05 2.49345e-05 2.49391e-05 2.49353e-05 2.49384e-05 2.4936e-05 2.49377e-05
+          2.49368e-05 2.4933e-05 2.49404e-05 2.49338e-05 2.49397e-05 2.49346e-05 2.4939e-05 2.49353e-05 2.49384e-05 2.4936e-05 2.49377e-05 2.49368e-05
+          2.49328e-05 2.49405e-05 2.49338e-05 2.49397e-05 2.49346e-05 2.4939e-05 2.49353e-05 2.49384e-05 2.49361e-05 2.49377e-05 2.49368e-05 2.49337e-05
+          2.494e-05 2.49342e-05 2.49395e-05 2.49348e-05 2.49389e-05 2.49354e-05 2.49383e-05 2.49361e-05 2.49377e-05 2.49368e-05 2.49337e-05 2.494e-05
+          2.49342e-05 2.49395e-05 2.49348e-05 2.49389e-05 2.49354e-05 2.49383e-05 2.49361e-05 2.49377e-05 2.49368e-05
+        </DataArray>
         <DataArray type="Float32" Name="v" NumberOfComponents="3" format="ascii">
-          0 0 0 0 0 0 3.5 0 0 3.5226 0.133438 0
-          0 0 0 3.10316 0.039719 0 0 0 0 3.32715 0.096961 0
-          0 0 0 2.78188 0.0977591 0 0 0 0 3.06058 0.102405 0
-          -0.11585 -0.00175433 0 2.5538 -0.0717313 0 0.329198 0.00309016 0 2.90737 0.0240212 0
-          -0.112085 -0.00199565 0 2.42867 -0.0148857 0 0.383762 0.00166675 0 2.78052 0.0462393 0
-          -0.416815 -0.00102905 0 2.21882 0.147859 0 3.5 0 0 3.97609 0.135405 0
-          3.63169 0.0331424 0 3.96463 0.105193 0 3.62015 0.0667963 0 3.99835 0.0771965 0
-          3.62134 0.0251744 0 3.85316 0.0462399 0 3.5309 0.0299398 0 3.75456 0.0705104 0
-          3.46603 0.162229 0 3.5 0 0 3.96827 0.0929367 0 3.64746 0.0569294 0
-          4.0091 0.115684 0 3.73122 0.092696 0 4.07029 0.103997 0 3.78527 -0.00884432 0
-          4.09312 0.0518353 0 3.80517 0.0221447 0 4.10274 0.0843089 0 3.86435 0.101275 0
-          3.5 0 0 3.91554 0.0540102 0 3.58705 0.029717 0 3.97234 0.0668106 0
-          3.68264 0.0384963 0 4.07347 0.0504208 0 3.76907 0.0303745 0 4.06878 0.0404587 0
-          3.80093 0.0328165 0 4.09857 0.0586474 0 3.8703 0.0664373 0 3.5 0 0
-          3.8872 0.0369149 0 3.56405 0.0374383 0 3.93426 0.0664146 0 3.64351 0.0470763 0
-          3.99244 0.0581828 0 3.71146 -0.0031627 0 4.05399 0.0303095 0 3.7758 0.0104711 0
-          4.11531 0.047378 0 3.85956 0.056677 0 3.5 0 0 3.86659 0.0129529 0
-          3.53694 0.00779553 0 3.9143 0.0182653 0 3.61177 0.00450547 0 3.98751 0.00912037 0
-          3.68696 0.0057465 0 4.01701 0.00688683 0 3.73891 0.00458341 0 4.06505 0.0128956 0
-          3.81561 0.0152176 0 3.5 0 0 3.85981 0.0108028 0 3.53731 0.0102978 0
-          3.90102 0.0195089 0 3.60194 0.00621133 0 3.95428 0.00999994 0 3.66873 -0.0207275 0
-          4.0215 -0.00651749 0 3.74163 -0.018216 0 4.09276 -0.00166805 0 3.82757 0.00149796 0
-          3.5 0 0 3.85133 -0.0120283 0 3.52373 -0.0193824 0 3.89305 -0.0279481 0
-          3.58844 -0.0318127 0 3.95589 -0.037786 0 3.65992 -0.0330068 0 4.0035 -0.0399367 0
-          3.72311 -0.0381835 0 4.06269 -0.0436588 0 3.8033 -0.0466215 0 3.5 0 0
-          3.86121 -0.00871048 0 3.54081 -0.0211809 0 3.90559 -0.0295653 0 3.60758 -0.0375599 0
-          3.96354 -0.0447584 0 3.6795 -0.0557033 0 4.03222 -0.056942 0 3.75518 -0.0612835 0
-          4.1044 -0.0617452 0 3.83627 -0.065316 0 3.5 0 0 3.85781 -0.0444216 0
-          3.53417 -0.0548395 0 3.90938 -0.0852568 0 3.61127 -0.0779024 0 3.97607 -0.0981896 0
-          3.69005 -0.0838742 0 4.03606 -0.100415 0 3.7624 -0.0928283 0 4.10026 -0.10796 0
-          3.83349 -0.11476 0 3.5 0 0 3.9148 -0.0504801 0 3.60302 -0.0663425 0
-          3.97994 -0.102641 0 3.69544 -0.0925474 0 4.04625 -0.117329 0 3.77283 -0.106087 0
-          4.10657 -0.122526 0 3.83405 -0.115244 0 4.15444 -0.123514 0 3.88892 -0.132939 0
-          3.5 0 0 3.93781 -0.16003 0 3.62329 -0.102892 0 3.99176 -0.179883 0
-          3.69481 -0.132121 0 4.02412 -0.172305 0 3.72759 -0.132419 0 4.02716 -0.15478 0
-          3.72264 -0.129944 0 4.00363 -0.151494 0 3.69497 -0.169719 0 3.5 0 0
-          3.66154 -0.162265 0 3.33194 -0.083821 0 3.51553 -0.151729 0 3.13616 -0.0987868 0
-          3.34683 -0.129778 0 2.94836 -0.0922458 0 3.18654 -0.10351 0 2.78133 -0.0786423 0
-          3.03593 -0.0965944 0 2.61509 -0.0181258 0 0 0 0 0 0 0
+          0 0 0 0 0 0 3.5 0 0 3.53404 0.118701 0
+          0 0 0 3.13506 0.0153384 0 0 0 0 3.38605 0.0611465 0
+          0 0 0 2.89037 0.0591554 0 0 0 0 3.18578 0.0763042 0
+          -0.104984 -0.00188946 0 2.66297 -0.0690366 0 0.349991 0.00320055 0 2.98558 0.0276965 0
+          -0.111047 -0.00199827 0 2.47899 -0.00755949 0 0.378099 0.00171254 0 2.78912 0.051971 0
+          -0.436006 -0.00106813 0 2.19748 0.153669 0 3.5 0 0 3.97495 0.125727 0
+          3.62701 0.0212362 0 3.95623 0.0822526 0 3.60913 0.0463749 0 3.97676 0.078399 0
+          3.59647 0.0381856 0 3.8332 0.0638654 0 3.49383 0.0524918 0 3.7098 0.0935697 0
+          3.39904 0.181822 0 3.5 0 0 3.96545 0.0789225 0 3.6318 0.0340509 0
+          3.98283 0.0796555 0 3.67503 0.0570794 0 4.00278 0.0847379 0 3.70337 -0.00491033 0
+          4.00751 0.0635862 0 3.70266 0.0421746 0 3.99504 0.104159 0 3.73681 0.122861 0
+          3.5 0 0 3.91357 0.051447 0 3.57192 0.0270119 0 3.94299 0.0616169 0
+          3.62266 0.0368509 0 3.99418 0.0631446 0 3.67086 0.0496282 0 3.97066 0.0668539 0
+          3.68737 0.0651708 0 3.98517 0.0924067 0 3.73898 0.101579 0 3.5 0 0
+          3.88708 0.0308135 0 3.55019 0.027124 0 3.91012 0.0528859 0 3.59397 0.0361944 0
+          3.93042 0.0571927 0 3.63022 0.00971725 0 3.96183 0.0509991 0 3.6652 0.0390349 0
+          3.99621 0.0775438 0 3.71943 0.088436 0 3.5 0 0 3.8665 0.0183132 0
+          3.52484 0.0181535 0 3.89061 0.0339215 0 3.56567 0.02526 0 3.92564 0.039664 0
+          3.60579 0.0402606 0 3.9291 0.0482474 0 3.63424 0.0500919 0 3.9561 0.0617898 0
+          3.6871 0.0667082 0 3.5 0 0 3.85988 0.0123552 0 3.52424 0.0142093 0
+          3.87817 0.0269278 0 3.55835 0.0185111 0 3.89856 0.0301295 0 3.59265 0.0081541 0
+          3.9329 0.029761 0 3.63247 0.0237716 0 3.97235 0.0443679 0 3.6831 0.0503896 0
+          3.5 0 0 3.85115 0.00208237 0 3.51216 0.00634822 0 3.87025 0.00887014 0
+          3.5455 0.0116542 0 3.89847 0.0148423 0 3.58186 0.0224232 0 3.91605 0.0225491 0
+          3.61587 0.0266401 0 3.94786 0.0276332 0 3.66455 0.028982 0 3.5 0 0
+          3.85871 0.00212868 0 3.52376 -4.45735e-05 0 3.87544 0.00166666 0 3.55573 0.000136967 0
+          3.89739 0.00163286 0 3.59041 -0.00464952 0 3.93067 0.00195001 0 3.6307 0.00091801 0
+          3.9699 0.00806727 0 3.67743 0.00980241 0 3.5 0 0 3.85371 -0.0162271 0
+          3.51555 -0.0067587 0 3.87375 -0.0192136 0 3.55119 -0.00524931 0 3.89915 -0.0147103 0
+          3.58797 -0.000905234 0 3.92296 -0.00950821 0 3.62437 -0.00279676 0 3.95602 -0.00997117 0
+          3.66856 -0.0119962 0 3.5 0 0 3.89969 -0.0197906 0 3.56512 -0.01595 0
+          3.91811 -0.0327039 0 3.60589 -0.019104 0 3.93994 -0.0331866 0 3.64188 -0.0247927 0
+          3.96964 -0.0324221 0 3.67897 -0.0276926 0 4.00368 -0.0310201 0 3.71822 -0.0331585 0
+          3.5 0 0 3.91983 -0.0927506 0 3.58556 -0.0123058 0 3.93381 -0.0651015 0
+          3.62443 -0.0212124 0 3.94915 -0.0515872 0 3.65233 -0.0257876 0 3.96614 -0.0448527 0
+          3.67646 -0.0332858 0 3.98604 -0.046804 0 3.70008 -0.049991 0 3.5 0 0
+          3.72819 -0.102769 0 3.40788 -0.0103883 0 3.6911 -0.0664855 0 3.34329 -0.0249399 0
+          3.65246 -0.0543633 0 3.28962 -0.0357251 0 3.61296 -0.0498694 0 3.24015 -0.0412582 0
+          3.56774 -0.049634 0 3.18533 -0.0331022 0 0 0 0 0 0 0
           0 0 0 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>
       </PointData>
+      <CellData Scalars="mu_t">
+        <DataArray type="Float32" Name="mu_t" NumberOfComponents="1" format="ascii">
+          0.00037694 0.00037829 0.000378361 0.000378659 0.000368235 0.000753508 0.000696578 0.000669272 0.000860983 0.000895254 0.00028062 0.000298737
+          0.000308102 0.000320384 0.000315304 0.000809906 0.000751639 0.000787207 0.00133437 0.00144065 4.24e-05 4.5681e-05 4.74037e-05 4.96459e-05
+          4.89585e-05 0.0005242 0.000498406 0.000535232 0.00124494 0.00134425 4.4278e-06 4.77156e-06 4.95209e-06 5.187e-06 5.11538e-06 0.000252992
+          0.000242116 0.000261712 0.000803164 0.000867209 7.03135e-07 7.57605e-07 7.86208e-07 8.23428e-07 8.12041e-07 6.75428e-05 6.46868e-05 6.99732e-05
+          0.000294766 0.000318254 1.51912e-07 1.63662e-07 1.69831e-07 1.77859e-07 1.75397e-07 1.65216e-05 1.5825e-05 1.71204e-05 8.17726e-05 8.82865e-05
+          4.02712e-08 4.33828e-08 4.50165e-08 4.71425e-08 4.64892e-08 4.54319e-06 4.35179e-06 4.70819e-06 2.30696e-05 2.49071e-05 1.23236e-08 1.32752e-08
+          1.37747e-08 1.44249e-08 1.42248e-08 1.41151e-06 1.35206e-06 1.46281e-06 7.18084e-06 7.75279e-06 4.19179e-09 4.5153e-09 4.68513e-09 4.90616e-09
+          4.83809e-09 4.8407e-07 4.63687e-07 5.01672e-07 2.4562e-06 2.65183e-06 1.50295e-05 1.48368e-05 1.54849e-05 1.54135e-05 1.58197e-05 1.58703e-05
+          1.61605e-05 1.63036e-05 1.65964e-05 1.67661e-05 5.17892e-05 5.11256e-05 5.33576e-05 5.31114e-05 5.45104e-05 5.46843e-05 5.56839e-05 5.61764e-05
+          5.71851e-05 5.77694e-05 0.000250306 0.000247189 0.000257755 0.000256596 0.000263223 0.000264051 0.000268789 0.000271129 0.000275916 0.000278693
+          0.000997929 0.000990654 0.00102084 0.00101806 0.00103723 0.00103998 0.00105389 0.00106109 0.00107546 0.00108399 0.00156473 0.00157122
+          0.00156427 0.00156484 0.00156129 0.0015604 0.00155861 0.00155779 0.00155749 0.00155629
+        </DataArray>
+        <DataArray type="Float32" Name="l_mix" NumberOfComponents="1" format="ascii">
+          0.00265146 0.00261872 0.00260577 0.00258152 0.00256249 0.00254872 0.00248784 0.00246637 0.00243793 0.00244175 0.011084 0.0110563
+          0.0110451 0.0110228 0.0110051 0.0109915 0.0109287 0.010905 0.0108721 0.0108766 0.0197922 0.0197867 0.0197843 0.0197794
+          0.0197754 0.0197722 0.0197562 0.0197497 0.0197402 0.0197415 0.0291303 0.0291297 0.0291294 0.0291289 0.0291284 0.029128
+          0.0291257 0.0291248 0.0291232 0.0291235 0.0393735 0.0393734 0.0393734 0.0393734 0.0393733 0.0393733 0.0393731 0.039373
+          0.0393729 0.0393729 0.0506389 0.0506389 0.0506389 0.0506389 0.0506389 0.0506389 0.0506389 0.0506389 0.0506389 0.0506389
+          0.0630308 0.0630308 0.0630308 0.0630308 0.0630308 0.0630308 0.0630308 0.0630308 0.0630308 0.0630308 0.0766618 0.0766618
+          0.0766618 0.0766618 0.0766618 0.0766618 0.0766618 0.0766618 0.0766618 0.0766618 0.091656 0.091656 0.091656 0.091656
+          0.091656 0.091656 0.091656 0.091656 0.091656 0.091656 0.0968504 0.0968504 0.0968504 0.0968504 0.0968504 0.0968504
+          0.0968504 0.0968504 0.0968504 0.0968504 0.0787074 0.0787074 0.0787074 0.0787074 0.0787074 0.0787074 0.0787074 0.0787074
+          0.0787074 0.0787074 0.0587486 0.0587485 0.0587485 0.0587484 0.0587483 0.0587482 0.0587482 0.0587481 0.058748 0.0587479
+          0.0367414 0.0367389 0.0367382 0.0367363 0.0367355 0.0367338 0.0367329 0.0367313 0.0367302 0.0367281 0.0113561 0.0113388
+          0.0113332 0.0113203 0.0113144 0.0113032 0.0112971 0.0112864 0.0112791 0.0112662
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          31.6558 30.84 30.4865 29.9298 29.4356 28.1137 30.2732 29.769 29.5397 26.15 65.2952 65.9957
+          65.938 66.012 66.1851 65.7078 67.1692 66.7683 66.5433 64.1347 67.2362 70.2898 71.0496 72.6066
+          73.945 74.8083 77.7604 78.4906 79.505 78.6826 66.9601 69.7512 70.7297 72.6087 74.0949 75.2591
+          78.8489 80.2186 82.0077 81.9435 66.6075 69.0112 70.008 71.8749 73.3515 74.5465 78.2389 79.7846
+          81.8145 81.8578 66.3957 68.5757 69.5431 71.3531 72.7434 73.8923 77.6914 79.2902 81.3762 81.4291
+          66.2733 68.3299 69.2724 71.0306 72.4164 73.5522 77.35 78.9684 81.0745 81.1102 66.2042 68.2003
+          69.118 70.8372 72.1871 73.3021 77.1602 78.8044 80.9326 80.9472 66.199 68.1927 69.103 70.8117
+          72.1688 73.2853 77.1372 78.7835 80.9101 80.9042 121.319 122.484 123.063 124.258 124.944 126.098
+          126.883 128.065 129.041 130.38 121.656 123.168 123.763 125.034 125.722 126.891 127.647 128.804
+          129.739 131.017 122.2 124.298 124.845 126.15 126.755 127.854 128.555 129.612 130.438 131.542
+          120.789 121.568 121.649 122.053 122.144 122.465 122.57 122.866 123.001 123.267 59.6058 59.2509
+          59.0758 58.8351 58.6497 58.4547 58.2632 58.0855 57.8677 57.6487
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          31.6573 30.8215 30.4982 29.9062 29.4499 29.1259 27.7428 27.2746 26.6691 26.7504 98.1376 95.5467
+          94.5444 92.7091 91.2947 90.2903 86.0027 84.5514 82.6743 82.9261 171.266 166.744 164.995 161.792
+          159.324 157.571 150.089 147.556 144.28 144.719 251.707 245.062 242.491 237.784 234.156 231.58
+          220.583 216.861 212.046 212.692 340.193 331.211 327.737 321.375 316.472 312.99 298.127 293.096
+          286.589 287.462 437.526 425.975 421.507 413.324 407.019 402.541 383.425 376.955 368.586 369.709
+          544.594 530.216 524.654 514.469 506.62 501.047 477.253 469.2 458.783 460.181 662.368 644.881
+          638.115 625.728 616.182 609.403 580.464 570.669 558 559.699 791.919 771.012 762.923 748.114
+          736.7 728.595 693.996 682.285 667.138 669.17 456.528 453.464 452.507 450.261 449.263 447.337
+          446.314 444.502 443.29 441.15 371.007 368.517 367.739 365.914 365.103 363.538 362.706 361.234
+          360.248 358.509 276.934 275.075 274.494 273.132 272.526 271.359 270.738 269.639 268.903 267.605
+          173.453 172.289 171.925 171.072 170.693 169.961 169.572 168.884 168.423 167.61 59.6246 59.2243
+          59.0993 58.806 58.6756 58.4242 58.2905 58.0539 57.8955 57.616
+        </DataArray>
+        <DataArray type="Float32" Name="D_t" NumberOfComponents="1" format="ascii">
+          0.000271517 0.000257364 0.000251623 0.000242127 0.000234353 0.000222303 0.000225243 0.000217916 0.000211147 0.000190221 0.00154717 0.00152415
+          0.00150701 0.00148012 0.00146202 0.00143747 0.00140113 0.00137099 0.00133728 0.00129809 0.00277655 0.00282467 0.00282461 0.00282964
+          0.00283716 0.00284029 0.00281525 0.00279658 0.0027719 0.0027613 0.00406367 0.00411897 0.00413182 0.00415753 0.00417714 0.00419816
+          0.00419286 0.00419728 0.00419799 0.00422151 0.00546351 0.00550845 0.00552778 0.00556263 0.00558883 0.00561992 0.00562318 0.00564231
+          0.00566048 0.00569957 0.00700443 0.00703987 0.00706226 0.00710242 0.00712879 0.00716507 0.00718143 0.0072115 0.00724059 0.00729143
+          0.00870253 0.00873153 0.00875655 0.00880078 0.00883342 0.00887736 0.00889992 0.00894035 0.00897972 0.00904086 0.0105735 0.0105996
+          0.0106264 0.0106749 0.0107099 0.0107607 0.0107979 0.0108509 0.0109021 0.0109734 0.0126407 0.0126717 0.0127024 0.0127586
+          0.0128016 0.0128626 0.0129065 0.0129704 0.0130315 0.0131135 0.0133594 0.0133952 0.0134285 0.0134899 0.0135328 0.0135977
+          0.0136497 0.0137193 0.013785 0.0138676 0.0108865 0.0109455 0.0109739 0.0110302 0.0110651 0.0111188 0.0111582 0.0112124
+          0.0112619 0.0113236 0.00816263 0.00824538 0.00826329 0.00830718 0.00832773 0.00836302 0.0083889 0.00842278 0.00845266 0.00848748
+          0.00505611 0.00505624 0.00504896 0.00504148 0.00503417 0.00502638 0.00501938 0.00501163 0.00500377 0.00499406 0.000964362 0.000952072
+          0.000947124 0.000938507 0.000933352 0.000926192 0.000920922 0.000914322 0.000908289 0.000900974
+        </DataArray>
+      </CellData>
       <Points>
         <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
           0 0.25 0 0.05 0.25 0 0 0.267873 0 0.05 0.267873 0
diff --git a/test/references/2czeroeq2p2c-pm-reference.vtu b/test/references/2czeroeq2p2c-pm-reference.vtu
index 8893537bc3f79266e72552c1af839e4e7edf1ebf..6f679e680ddbe4b795986b7aae0ab2ad062c1383 100644
--- a/test/references/2czeroeq2p2c-pm-reference.vtu
+++ b/test/references/2czeroeq2p2c-pm-reference.vtu
@@ -4,44 +4,44 @@
     <Piece NumberOfCells="55" NumberOfPoints="72">
       <PointData Scalars="Sn" Vectors="velocityW">
         <DataArray type="Float32" Name="Sn" NumberOfComponents="1" format="ascii">
-          0.0140735 0.0140721 0.0242515 0.0242369 0.0140694 0.0242084 0.0140672 0.0241845 0.0140657 0.0241691 0.0140652 0.0241637
-          0.11515 0.115079 0.114939 0.114822 0.114746 0.114719 0.342753 0.342619 0.342345 0.342115 0.341967 0.341914
-          0.597452 0.597327 0.597059 0.596848 0.596706 0.596651 0.76742 0.767349 0.76716 0.76703 0.766917 0.766854
-          0.860726 0.860762 0.860661 0.8606 0.860471 0.860343 0.911199 0.91151 0.911529 0.911519 0.911296 0.910933
-          0.940039 0.941086 0.94128 0.941318 0.940895 0.939862 0.957833 0.960786 0.96117 0.961275 0.960555 0.957769
-          0.969085 0.97719 0.97749 0.977746 0.976793 0.969303 0.965428 1 1 1 1 0.966488
+          0.014036 0.0140344 0.0238613 0.023845 0.0140313 0.0238128 0.0140287 0.0237855 0.014027 0.0237677 0.0140264 0.0237616
+          0.113233 0.113152 0.112993 0.112858 0.112769 0.112738 0.339188 0.339035 0.338719 0.338449 0.338275 0.338214
+          0.594283 0.594139 0.593828 0.593577 0.59341 0.593347 0.765419 0.765334 0.765113 0.764954 0.764825 0.764758
+          0.859555 0.859583 0.859459 0.859378 0.859241 0.85911 0.9105 0.910807 0.910807 0.910784 0.910556 0.910191
+          0.939602 0.940652 0.940832 0.94086 0.940435 0.939396 0.957554 0.960521 0.960897 0.960989 0.960273 0.957467
+          0.968907 0.977057 0.977356 0.977587 0.976654 0.969105 0.965202 1 1 1 1 0.966209
         </DataArray>
         <DataArray type="Float32" Name="Sw" NumberOfComponents="1" format="ascii">
-          0.985927 0.985928 0.975748 0.975763 0.985931 0.975792 0.985933 0.975815 0.985934 0.975831 0.985935 0.975836
-          0.88485 0.884921 0.885061 0.885178 0.885254 0.885281 0.657247 0.657381 0.657655 0.657885 0.658033 0.658086
-          0.402548 0.402673 0.402941 0.403152 0.403294 0.403349 0.23258 0.232651 0.23284 0.23297 0.233083 0.233146
-          0.139274 0.139238 0.139339 0.1394 0.139529 0.139657 0.0888011 0.0884896 0.0884714 0.0884813 0.0887042 0.0890673
-          0.0599615 0.0589138 0.0587203 0.0586822 0.0591051 0.0601381 0.0421667 0.0392145 0.0388302 0.0387255 0.0394446 0.0422315
-          0.0309154 0.0228101 0.02251 0.0222541 0.0232072 0.0306968 0.0345725 0 0 0 0 0.0335122
+          0.985964 0.985966 0.976139 0.976155 0.985969 0.976187 0.985971 0.976215 0.985973 0.976232 0.985974 0.976238
+          0.886767 0.886848 0.887007 0.887142 0.887231 0.887262 0.660812 0.660965 0.661282 0.661551 0.661725 0.661786
+          0.405717 0.405861 0.406172 0.406423 0.40659 0.406653 0.234581 0.234666 0.234887 0.235046 0.235175 0.235242
+          0.140444 0.140417 0.140541 0.140622 0.140759 0.14089 0.0895005 0.0891933 0.0891929 0.0892158 0.0894437 0.0898091
+          0.0603975 0.0593479 0.059168 0.0591404 0.0595651 0.0606041 0.0424458 0.039479 0.0391034 0.0390112 0.0397269 0.0425327
+          0.0310931 0.022943 0.0226439 0.0224126 0.0233463 0.0308953 0.0347981 0 0 0 0 0.0337906
         </DataArray>
         <DataArray type="Float32" Name="pn" NumberOfComponents="1" format="ascii">
-          100003 100003 100003 100002 100003 100002 100002 100002 100002 100002 100002 100002
+          100003 100003 100003 100003 100003 100002 100002 100002 100002 100002 100002 100002
           100002 100002 100002 100002 100002 100001 100002 100002 100002 100001 100001 100001
-          100002 100002 100001 100001 100001 100001 100001 100001 100001 100001 100001 100000
-          100001 100001 100001 100000 100000 100000 100001 100001 100000 100000 100000 99999.9
-          100001 100001 99999.7 100000 99999.7 99999.7 100001 100001 99999 100000 99999.3 99999.6
-          100001 100002 99997.7 100001 99998.7 99999.6 100001 100003 99995.6 100002 99997.6 100000
+          100002 100002 100001 100001 100001 100001 100002 100001 100001 100001 100001 100000
+          100002 100001 100001 100000 100000 100000 100001 100001 100000 100000 99999.9 99999.9
+          100002 100001 99999.8 100000 99999.6 99999.7 100002 100001 99999 100000 99999.2 99999.5
+          100001 100002 99997.7 100001 99998.6 99999.6 100001 100003 99995.5 100002 99997.5 100000
         </DataArray>
         <DataArray type="Float32" Name="pw" NumberOfComponents="1" format="ascii">
-          99473.8 99473.8 99131.6 99131.6 99473.8 99131.6 99473.8 99131.6 99473.8 99131.6 99473.8 99131.6
-          98820.4 98820.4 98820.4 98820.4 98820.4 98820.4 98537.6 98537.6 98537.6 98537.6 98537.6 98537.6
-          98280.4 98280.4 98280.4 98280.4 98280.4 98280.4 98046.6 98046.5 98046.4 98046.4 98046.5 98046.6
-          97833.5 97833.1 97832.9 97832.9 97833.1 97833.5 97637.8 97636 97635.1 97635.1 97636 97637.8
-          97454.3 97445.3 97442.4 97442.5 97445.6 97454.1 97274.6 97235.1 97227.4 97227.2 97236.4 97273.6
-          97099.5 96907.2 96894.1 96889.3 96915.8 97093.6 97164.2 95700.5 95693.1 95699.4 95695.1 97145.5
+          99477.5 99477.5 99135.3 99135.3 99477.5 99135.2 99477.5 99135.2 99477.5 99135.3 99477.5 99135.3
+          98824.1 98824.1 98824.1 98824.1 98824.1 98824.1 98541.3 98541.3 98541.2 98541.2 98541.3 98541.3
+          98284.1 98284.1 98284.1 98284.1 98284.1 98284.1 98050.2 98050.2 98050.1 98050.1 98050.2 98050.2
+          97837.1 97836.8 97836.6 97836.6 97836.8 97837.1 97641.5 97639.7 97638.8 97638.8 97639.7 97641.5
+          97458 97449.1 97446.2 97446.3 97449.3 97457.8 97278.3 97239 97231.3 97231.2 97240.2 97277.4
+          97103.1 96911.4 96898.1 96894.1 96919.7 97097.4 97168.1 95700.8 95693 95699.3 95695 97150.3
         </DataArray>
         <DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii">
-          529.171 529.043 871.038 870.907 528.789 870.65 528.574 870.434 528.435 870.294 528.387 870.246
-          1181.82 1181.69 1181.43 1181.22 1181.08 1181.03 1464.36 1464.23 1463.96 1463.73 1463.58 1463.53
-          1721.26 1721.11 1720.81 1720.58 1720.42 1720.36 1954.93 1954.8 1954.47 1954.24 1954.04 1953.93
-          2167.9 2168.01 2167.7 2167.51 2167.13 2166.74 2363.47 2365.05 2365.15 2365.1 2363.96 2362.13
-          2547.05 2555.67 2557.28 2557.6 2554.08 2545.62 2726.77 2766.11 2771.52 2773 2762.91 2725.95
-          2901.8 3094.55 3103.56 3111.38 3082.9 2906.03 2836.61 4302.49 4302.49 4302.49 4302.49 2854.51
+          525.617 525.471 867.485 867.336 525.177 867.038 524.925 866.786 524.762 866.621 524.706 866.565
+          1178.27 1178.12 1177.82 1177.57 1177.4 1177.34 1460.81 1460.66 1460.34 1460.07 1459.9 1459.84
+          1717.71 1717.55 1717.2 1716.92 1716.73 1716.66 1951.39 1951.24 1950.85 1950.57 1950.35 1950.23
+          2164.37 2164.45 2164.08 2163.83 2163.42 2163.03 2359.95 2361.49 2361.49 2361.38 2360.23 2358.4
+          2543.52 2552.08 2553.56 2553.79 2550.29 2541.86 2723.24 2762.43 2767.67 2768.96 2759.01 2722.15
+          2898.4 3090.62 3099.52 3106.52 3078.89 2902.19 2832.9 4302.49 4302.49 4302.49 4302.49 2849.74
         </DataArray>
         <DataArray type="Float32" Name="rhoW" NumberOfComponents="1" format="ascii">
           997.047 997.047 997.047 997.047 997.047 997.047 997.047 997.047 997.047 997.047 997.047 997.047
@@ -53,27 +53,27 @@
         </DataArray>
         <DataArray type="Float32" Name="rhoN" NumberOfComponents="1" format="ascii">
           1.15427 1.15427 1.15427 1.15427 1.15427 1.15426 1.15427 1.15426 1.15426 1.15426 1.15426 1.15426
-          1.15426 1.15426 1.15426 1.15426 1.15426 1.15425 1.15426 1.15426 1.15426 1.15425 1.15425 1.15425
-          1.15426 1.15426 1.15425 1.15425 1.15425 1.15425 1.15425 1.15425 1.15425 1.15425 1.15424 1.15424
-          1.15425 1.15425 1.15424 1.15424 1.15424 1.15424 1.15425 1.15425 1.15424 1.15424 1.15424 1.15424
-          1.15425 1.15425 1.15423 1.15424 1.15423 1.15423 1.15425 1.15425 1.15423 1.15424 1.15423 1.15423
-          1.15425 1.15426 1.15421 1.15424 1.15422 1.15423 1.15425 1.16429 1.16322 1.16249 1.16162 1.15424
+          1.15427 1.15426 1.15426 1.15426 1.15426 1.15425 1.15426 1.15426 1.15426 1.15425 1.15425 1.15425
+          1.15426 1.15426 1.15425 1.15425 1.15425 1.15425 1.15426 1.15425 1.15425 1.15425 1.15424 1.15424
+          1.15426 1.15425 1.15425 1.15424 1.15424 1.15424 1.15425 1.15425 1.15424 1.15424 1.15424 1.15424
+          1.15426 1.15425 1.15423 1.15424 1.15423 1.15423 1.15426 1.15425 1.15423 1.15424 1.15423 1.15423
+          1.15425 1.15426 1.15421 1.15424 1.15422 1.15423 1.15425 1.16361 1.1626 1.16191 1.16105 1.15424
         </DataArray>
         <DataArray type="Float32" Name="mobW" NumberOfComponents="1" format="ascii">
-          1122.19 1122.19 1107.71 1107.74 1122.19 1107.8 1122.2 1107.85 1122.2 1107.89 1122.2 1107.9
-          736.07 736.271 736.662 736.99 737.204 737.279 287.063 287.242 287.608 287.915 288.114 288.185
-          66.2057 66.2667 66.3971 66.4997 66.5688 66.596 13.191 13.2029 13.2344 13.2561 13.275 13.2855
-          2.91047 2.90824 2.91446 2.91828 2.92626 2.93425 0.758508 0.750502 0.750037 0.75029 0.756012 0.765394
-          0.228279 0.216116 0.213917 0.213486 0.218304 0.230372 0.0750418 0.0593104 0.0574365 0.0569328 0.0604514 0.0754142
-          0.0269312 0.00927879 0.00884154 0.00847939 0.00987847 0.0262906 0.039189 0 0 0 0 0.0353266
+          1122.22 1122.22 1108.53 1108.57 1122.22 1108.63 1122.22 1108.69 1122.22 1108.73 1122.22 1108.74
+          741.462 741.689 742.14 742.522 742.772 742.859 291.851 292.057 292.485 292.85 293.086 293.168
+          67.7573 67.8283 67.9822 68.1065 68.1889 68.2203 13.5272 13.5415 13.5791 13.6061 13.628 13.6394
+          2.98352 2.98179 2.98959 2.99467 3.00336 3.01165 0.776682 0.768664 0.768655 0.769252 0.775196 0.784792
+          0.233469 0.221103 0.219027 0.21871 0.223626 0.235954 0.0766549 0.060623 0.0587646 0.0583145 0.0618703 0.0771619
+          0.0274593 0.00947678 0.00903488 0.00870247 0.0100944 0.0268718 0.0400448 0 0 0 0 0.0363157
         </DataArray>
         <DataArray type="Float32" Name="mobN" NumberOfComponents="1" format="ascii">
-          0.964857 0.964199 12.4522 12.4261 0.962901 12.3754 0.961799 12.333 0.961088 12.3056 0.960844 12.2961
-          729.183 728.176 726.218 724.577 723.507 723.135 7381.64 7375.74 7363.72 7353.65 7347.14 7344.82
-          22321.1 22312.1 22292.8 22277.6 22267.4 22263.4 35757.4 35751.4 35735.4 35724.4 35714.8 35709.4
-          43833.8 43836.9 43828.1 43822.8 43811.5 43800.3 48381.3 48413.4 48415.3 48414.3 48391.3 48354
-          51422.6 51529.1 51548.7 51552.5 51509.7 51404.6 53092.5 53332.3 53362.5 53370.7 53314.1 53087.1
-          53929.7 54385.4 54399.5 54411.4 54366.3 53943.7 53681.3 54828.6 54828.6 54828.6 54828.6 53755.8
+          0.946785 0.946047 11.766 11.7379 0.944568 11.6821 0.9433 11.635 0.942478 11.6045 0.942195 11.594
+          702.483 701.372 699.173 697.314 696.098 695.676 7225.8 7219.15 7205.4 7193.72 7186.17 7183.52
+          22093.1 22082.8 22060.5 22042.4 22030.5 22026 35587.8 35580.6 35561.8 35548.4 35537.5 35531.8
+          43731.4 43733.8 43722.9 43715.9 43703.9 43692.4 48309.5 48341 48341.1 48338.7 48315.4 48277.9
+          51378.1 51485.1 51503.3 51506.1 51463 51356.9 53069.2 53311.3 53341.1 53348.3 53291.6 53061.9
+          53918.2 54379 54393.2 54404.1 54359.6 53931 53665.2 54828.6 54828.6 54828.6 54828.6 53736.4
         </DataArray>
         <DataArray type="Float32" Name="X_liquid^H2O" NumberOfComponents="1" format="ascii">
           0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978
@@ -81,31 +81,31 @@
           0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978
           0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978
           0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978
-          0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.28427 0.354514 0.411606 0.470565 0.999978
+          0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.999978 0.332861 0.398288 0.452986 0.510935 0.999978
         </DataArray>
         <DataArray type="Float32" Name="X_liquid^Air" NumberOfComponents="1" format="ascii">
-          2.15475e-05 2.15475e-05 2.15474e-05 2.15474e-05 2.15474e-05 2.15473e-05 2.15474e-05 2.15473e-05 2.15474e-05 2.15473e-05 2.15473e-05 2.15473e-05
+          2.15475e-05 2.15475e-05 2.15475e-05 2.15474e-05 2.15474e-05 2.15474e-05 2.15474e-05 2.15473e-05 2.15474e-05 2.15473e-05 2.15473e-05 2.15473e-05
           2.15474e-05 2.15473e-05 2.15473e-05 2.15472e-05 2.15472e-05 2.15472e-05 2.15473e-05 2.15473e-05 2.15472e-05 2.15471e-05 2.15471e-05 2.15471e-05
-          2.15472e-05 2.15472e-05 2.15471e-05 2.15471e-05 2.1547e-05 2.1547e-05 2.15472e-05 2.15471e-05 2.15471e-05 2.1547e-05 2.1547e-05 2.1547e-05
-          2.15472e-05 2.15471e-05 2.1547e-05 2.15469e-05 2.15469e-05 2.15469e-05 2.15471e-05 2.15471e-05 2.15469e-05 2.15469e-05 2.15468e-05 2.15468e-05
-          2.15471e-05 2.15471e-05 2.15468e-05 2.15469e-05 2.15468e-05 2.15468e-05 2.15472e-05 2.15471e-05 2.15466e-05 2.15469e-05 2.15467e-05 2.15468e-05
-          2.15471e-05 2.15472e-05 2.15463e-05 2.1547e-05 2.15466e-05 2.15468e-05 2.1547e-05 2.20519e-05 2.20008e-05 2.1962e-05 2.19195e-05 2.15469e-05
+          2.15473e-05 2.15472e-05 2.15471e-05 2.15471e-05 2.1547e-05 2.1547e-05 2.15472e-05 2.15472e-05 2.15471e-05 2.1547e-05 2.1547e-05 2.1547e-05
+          2.15472e-05 2.15471e-05 2.1547e-05 2.15469e-05 2.15469e-05 2.15469e-05 2.15472e-05 2.15471e-05 2.15469e-05 2.15469e-05 2.15468e-05 2.15468e-05
+          2.15472e-05 2.15471e-05 2.15468e-05 2.15469e-05 2.15468e-05 2.15468e-05 2.15472e-05 2.15472e-05 2.15466e-05 2.15469e-05 2.15467e-05 2.15467e-05
+          2.15472e-05 2.15473e-05 2.15463e-05 2.1547e-05 2.15465e-05 2.15468e-05 2.15471e-05 2.20178e-05 2.197e-05 2.19328e-05 2.18911e-05 2.15469e-05
         </DataArray>
         <DataArray type="Float32" Name="X_gas^H2O" NumberOfComponents="1" format="ascii">
-          0.0199563 0.0199563 0.0199564 0.0199564 0.0199564 0.0199564 0.0199564 0.0199565 0.0199564 0.0199565 0.0199564 0.0199565
-          0.0199564 0.0199565 0.0199565 0.0199565 0.0199566 0.0199566 0.0199565 0.0199565 0.0199566 0.0199566 0.0199566 0.0199567
+          0.0199563 0.0199563 0.0199563 0.0199564 0.0199563 0.0199564 0.0199564 0.0199565 0.0199564 0.0199565 0.0199564 0.0199565
+          0.0199564 0.0199564 0.0199565 0.0199565 0.0199566 0.0199566 0.0199565 0.0199565 0.0199566 0.0199566 0.0199567 0.0199567
           0.0199565 0.0199566 0.0199566 0.0199567 0.0199567 0.0199567 0.0199566 0.0199566 0.0199567 0.0199567 0.0199568 0.0199568
-          0.0199566 0.0199567 0.0199568 0.0199568 0.0199568 0.0199568 0.0199566 0.0199567 0.0199568 0.0199568 0.0199569 0.0199569
-          0.0199566 0.0199567 0.0199569 0.0199569 0.019957 0.0199569 0.0199566 0.0199566 0.0199571 0.0199569 0.019957 0.019957
-          0.0199566 0.0199565 0.0199574 0.0199568 0.0199572 0.019957 0.0199567 0.00562442 0.00702063 0.00815631 0.00933162 0.0199569
+          0.0199566 0.0199566 0.0199568 0.0199568 0.0199568 0.0199568 0.0199566 0.0199567 0.0199568 0.0199568 0.0199569 0.0199569
+          0.0199566 0.0199566 0.0199569 0.0199569 0.019957 0.019957 0.0199566 0.0199566 0.0199571 0.0199569 0.019957 0.019957
+          0.0199566 0.0199565 0.0199574 0.0199568 0.0199572 0.019957 0.0199567 0.0065896 0.00789164 0.00898076 0.0101371 0.0199569
         </DataArray>
         <DataArray type="Float32" Name="X_gas^Air" NumberOfComponents="1" format="ascii">
           0.980044 0.980044 0.980044 0.980044 0.980044 0.980044 0.980044 0.980044 0.980044 0.980043 0.980044 0.980043
-          0.980044 0.980044 0.980043 0.980043 0.980043 0.980043 0.980044 0.980043 0.980043 0.980043 0.980043 0.980043
+          0.980044 0.980044 0.980044 0.980043 0.980043 0.980043 0.980044 0.980044 0.980043 0.980043 0.980043 0.980043
           0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043
           0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043
           0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043
-          0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.980043 0.994376 0.992979 0.991844 0.990668 0.980043
+          0.980043 0.980044 0.980043 0.980043 0.980043 0.980043 0.980043 0.99341 0.992108 0.991019 0.989863 0.980043
         </DataArray>
         <DataArray type="Float32" Name="x_liquid^H2O" NumberOfComponents="1" format="ascii">
           0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987
@@ -113,31 +113,31 @@
           0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987
           0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987
           0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987
-          0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.284279 0.354523 0.411614 0.470573 0.999987
+          0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.999987 0.332869 0.398296 0.452995 0.510943 0.999987
         </DataArray>
         <DataArray type="Float32" Name="x_liquid^Air" NumberOfComponents="1" format="ascii">
-          1.34042e-05 1.34042e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.3404e-05 1.34041e-05 1.3404e-05
-          1.34041e-05 1.34041e-05 1.3404e-05 1.3404e-05 1.3404e-05 1.3404e-05 1.34041e-05 1.3404e-05 1.3404e-05 1.3404e-05 1.34039e-05 1.34039e-05
+          1.34042e-05 1.34042e-05 1.34042e-05 1.34041e-05 1.34042e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.34041e-05 1.3404e-05 1.34041e-05 1.3404e-05
+          1.34041e-05 1.34041e-05 1.34041e-05 1.3404e-05 1.3404e-05 1.3404e-05 1.34041e-05 1.3404e-05 1.3404e-05 1.3404e-05 1.34039e-05 1.34039e-05
           1.3404e-05 1.3404e-05 1.3404e-05 1.34039e-05 1.34039e-05 1.34039e-05 1.3404e-05 1.3404e-05 1.34039e-05 1.34039e-05 1.34039e-05 1.34038e-05
-          1.3404e-05 1.34039e-05 1.34039e-05 1.34038e-05 1.34038e-05 1.34038e-05 1.3404e-05 1.34039e-05 1.34038e-05 1.34038e-05 1.34038e-05 1.34038e-05
+          1.3404e-05 1.3404e-05 1.34039e-05 1.34038e-05 1.34038e-05 1.34038e-05 1.3404e-05 1.34039e-05 1.34038e-05 1.34038e-05 1.34038e-05 1.34038e-05
           1.3404e-05 1.34039e-05 1.34037e-05 1.34038e-05 1.34037e-05 1.34037e-05 1.3404e-05 1.3404e-05 1.34036e-05 1.34038e-05 1.34037e-05 1.34037e-05
-          1.3404e-05 1.3404e-05 1.34035e-05 1.34039e-05 1.34036e-05 1.34037e-05 1.34039e-05 1.37182e-05 1.36864e-05 1.36622e-05 1.36357e-05 1.34038e-05
+          1.3404e-05 1.34041e-05 1.34035e-05 1.34039e-05 1.34036e-05 1.34037e-05 1.34039e-05 1.3697e-05 1.36672e-05 1.3644e-05 1.3618e-05 1.34038e-05
         </DataArray>
         <DataArray type="Float32" Name="x_gas^H2O" NumberOfComponents="1" format="ascii">
-          0.0316961 0.0316961 0.0316962 0.0316963 0.0316962 0.0316963 0.0316963 0.0316964 0.0316963 0.0316964 0.0316963 0.0316965
-          0.0316963 0.0316964 0.0316964 0.0316965 0.0316966 0.0316966 0.0316964 0.0316965 0.0316966 0.0316966 0.0316967 0.0316967
-          0.0316965 0.0316966 0.0316967 0.0316967 0.0316968 0.0316968 0.0316966 0.0316966 0.0316968 0.0316968 0.0316969 0.0316969
-          0.0316966 0.0316967 0.0316969 0.0316969 0.031697 0.031697 0.0316966 0.0316967 0.031697 0.031697 0.0316971 0.0316971
-          0.0316966 0.0316967 0.0316971 0.031697 0.0316972 0.0316971 0.0316966 0.0316967 0.0316974 0.031697 0.0316973 0.0316972
-          0.0316966 0.0316965 0.0316978 0.0316968 0.0316975 0.0316972 0.0316968 0.00901065 0.011238 0.0130469 0.0149163 0.031697
+          0.0316961 0.0316961 0.0316962 0.0316962 0.0316962 0.0316963 0.0316963 0.0316964 0.0316963 0.0316964 0.0316963 0.0316965
+          0.0316963 0.0316963 0.0316964 0.0316965 0.0316966 0.0316966 0.0316964 0.0316964 0.0316965 0.0316966 0.0316967 0.0316967
+          0.0316965 0.0316965 0.0316966 0.0316967 0.0316968 0.0316968 0.0316965 0.0316966 0.0316967 0.0316968 0.0316969 0.0316969
+          0.0316966 0.0316967 0.0316968 0.0316969 0.031697 0.031697 0.0316966 0.0316967 0.031697 0.031697 0.0316971 0.0316971
+          0.0316966 0.0316967 0.0316971 0.031697 0.0316972 0.0316971 0.0316965 0.0316966 0.0316974 0.031697 0.0316973 0.0316972
+          0.0316966 0.0316964 0.0316978 0.0316969 0.0316975 0.0316972 0.0316967 0.0105508 0.0126255 0.0143585 0.016196 0.031697
         </DataArray>
         <DataArray type="Float32" Name="x_gas^Air" NumberOfComponents="1" format="ascii">
           0.968304 0.968304 0.968304 0.968304 0.968304 0.968304 0.968304 0.968304 0.968304 0.968304 0.968304 0.968304
           0.968304 0.968304 0.968304 0.968304 0.968303 0.968303 0.968304 0.968304 0.968303 0.968303 0.968303 0.968303
-          0.968304 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303
+          0.968304 0.968304 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303
           0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303
           0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303 0.968303
-          0.968303 0.968304 0.968302 0.968303 0.968303 0.968303 0.968303 0.990989 0.988762 0.986953 0.985084 0.968303
+          0.968303 0.968304 0.968302 0.968303 0.968302 0.968303 0.968303 0.989449 0.987374 0.985641 0.983804 0.968303
         </DataArray>
         <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii">
           0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41 0.41
@@ -164,44 +164,44 @@
           3 3 3 3 3 3 3 2 2 2 2 3
         </DataArray>
         <DataArray type="Float32" Name="velocityW" NumberOfComponents="3" format="ascii">
-          3.17116e-09 -1.90556e-09 0 4.20044e-09 -4.06614e-10 0 4.59625e-09 -1.83623e-09 0 5.95555e-09 1.80081e-09 0
-          2.69636e-09 2.08659e-09 0 3.73864e-09 7.56507e-09 0 -2.3885e-09 2.09924e-09 0 -3.41443e-09 7.57478e-09 0
-          -3.99835e-09 -3.45424e-10 0 -5.72103e-09 1.91141e-09 0 -3.05671e-09 -1.82563e-09 0 -4.45076e-09 -1.67295e-09 0
-          7.03927e-09 7.91498e-09 0 8.42102e-09 1.70802e-08 0 4.94726e-09 2.9862e-08 0 -4.71836e-09 2.9834e-08 0
-          -8.17423e-09 1.72359e-08 0 -6.82e-09 8.26658e-09 0 7.40526e-09 3.70943e-08 0 8.18823e-09 5.32508e-08 0
-          4.47828e-09 7.26655e-08 0 -4.42284e-09 7.25581e-08 0 -8.01649e-09 5.33903e-08 0 -7.20196e-09 3.76694e-08 0
-          6.38921e-09 7.24846e-08 0 6.25701e-09 9.54546e-08 0 3.02587e-09 1.19241e-07 0 -3.08424e-09 1.19056e-07 0
-          -6.15248e-09 9.55764e-08 0 -6.20956e-09 7.33073e-08 0 6.48048e-09 9.64426e-08 0 5.60999e-09 1.25907e-07 0
-          2.32268e-09 1.51889e-07 0 -2.43066e-09 1.51642e-07 0 -5.5257e-09 1.25999e-07 0 -6.28421e-09 9.75162e-08 0
-          7.84102e-09 1.0717e-07 0 6.0978e-09 1.43805e-07 0 2.12699e-09 1.70707e-07 0 -2.27031e-09 1.70413e-07 0
-          -6.01315e-09 1.43821e-07 0 -7.58626e-09 1.0849e-07 0 1.03527e-08 1.09196e-07 0 7.2689e-09 1.54676e-07 0
-          2.05216e-09 1.81447e-07 0 -2.23036e-09 1.81139e-07 0 -7.18194e-09 1.54544e-07 0 -9.98393e-09 1.10791e-07 0
-          1.43626e-08 1.05544e-07 0 9.04097e-09 1.62573e-07 0 1.8631e-09 1.8784e-07 0 -2.07324e-09 1.87614e-07 0
-          -8.95424e-09 1.62176e-07 0 -1.37551e-08 1.07502e-07 0 2.17807e-08 9.69318e-08 0 1.2108e-08 1.70091e-07 0
-          1.34145e-09 1.91567e-07 0 -1.57473e-09 1.91642e-07 0 -1.19369e-08 1.69177e-07 0 -2.04768e-08 9.95083e-08 0
-          4.74022e-08 7.77149e-08 0 2.39888e-08 1.70415e-07 0 3.55643e-10 1.89219e-07 0 -4.68503e-10 1.85133e-07 0
-          -2.27832e-08 1.76206e-07 0 -4.44935e-08 8.18253e-08 0 2.38004e-07 6.40943e-08 0 1.19002e-07 1.66798e-07 0
-          0 1.85558e-07 0 0 1.77086e-07 0 -1.05996e-07 1.79641e-07 0 -2.11993e-07 6.93326e-08 0
+          3.2273e-09 -1.94016e-09 0 4.28843e-09 -4.24216e-10 0 4.67443e-09 -1.92945e-09 0 6.07395e-09 1.74923e-09 0
+          2.78912e-09 2.11022e-09 0 3.85299e-09 7.61017e-09 0 -2.36187e-09 2.13123e-09 0 -3.39948e-09 7.63484e-09 0
+          -4.01378e-09 -3.38662e-10 0 -5.7594e-09 1.90805e-09 0 -3.07513e-09 -1.83386e-09 0 -4.48734e-09 -1.71442e-09 0
+          7.20256e-09 7.7781e-09 0 8.62578e-09 1.70822e-08 0 5.09806e-09 3.00969e-08 0 -4.76242e-09 3.00913e-08 0
+          -8.30396e-09 1.73224e-08 0 -6.93598e-09 8.23001e-09 0 7.60517e-09 3.7309e-08 0 8.42242e-09 5.37674e-08 0
+          4.62396e-09 7.35821e-08 0 -4.51532e-09 7.3494e-08 0 -8.20821e-09 5.40137e-08 0 -7.37755e-09 3.80211e-08 0
+          6.55714e-09 7.3463e-08 0 6.43188e-09 9.69059e-08 0 3.11601e-09 1.2123e-07 0 -3.16169e-09 1.21054e-07 0
+          -6.30993e-09 9.71558e-08 0 -6.37108e-09 7.44467e-08 0 6.62875e-09 9.81129e-08 0 5.74539e-09 1.28204e-07 0
+          2.3775e-09 1.54801e-07 0 -2.48831e-09 1.54551e-07 0 -5.65204e-09 1.28445e-07 0 -6.43449e-09 9.93634e-08 0
+          8.00236e-09 1.09222e-07 0 6.22937e-09 1.46634e-07 0 2.1672e-09 1.74194e-07 0 -2.32048e-09 1.73875e-07 0
+          -6.13764e-09 1.46819e-07 0 -7.75631e-09 1.10725e-07 0 1.0553e-08 1.1139e-07 0 7.4164e-09 1.57819e-07 0
+          2.08387e-09 1.85267e-07 0 -2.27776e-09 1.84905e-07 0 -7.32256e-09 1.57876e-07 0 -1.02017e-08 1.13164e-07 0
+          1.463e-08 1.0773e-07 0 9.21775e-09 1.65921e-07 0 1.88449e-09 1.91861e-07 0 -2.11606e-09 1.91543e-07 0
+          -9.12421e-09 1.65737e-07 0 -1.40528e-08 1.09853e-07 0 2.21737e-08 9.89955e-08 0 1.23369e-08 1.73604e-07 0
+          1.34513e-09 1.95714e-07 0 -1.60486e-09 1.95647e-07 0 -1.2161e-08 1.72935e-07 0 -2.09222e-08 1.01714e-07 0
+          4.83308e-08 7.95314e-08 0 2.44641e-08 1.74303e-07 0 3.53416e-10 1.93716e-07 0 -4.75314e-10 1.89875e-07 0
+          -2.33049e-08 1.80446e-07 0 -4.55498e-08 8.37206e-08 0 2.43735e-07 6.57516e-08 0 1.21867e-07 1.70981e-07 0
+          0 1.90356e-07 0 0 1.82543e-07 0 -1.09313e-07 1.84266e-07 0 -2.18626e-07 7.10208e-08 0
         </DataArray>
         <DataArray type="Float32" Name="velocityN" NumberOfComponents="3" format="ascii">
-          6.62752e-10 -7.77521e-10 0 9.83393e-10 -5.38088e-10 0 8.70193e-09 -9.7025e-09 0 1.28333e-08 -6.40904e-09 0
-          1.20214e-09 -2.42347e-10 0 1.55591e-08 -2.41116e-09 0 9.02974e-10 -1.75542e-10 0 1.16076e-08 -1.57812e-09 0
-          4.73599e-10 -1.51135e-10 0 6.07803e-09 -1.25907e-09 0 2.41503e-10 -1.44537e-10 0 3.09451e-09 -1.17746e-09 0
-          5.17248e-07 -3.4658e-07 0 7.63048e-07 -1.75362e-07 0 9.22927e-07 3.36527e-08 0 6.85888e-07 7.48428e-08 0
-          3.58673e-07 9.06703e-08 0 1.82576e-07 9.47676e-08 0 5.44794e-06 -3.70316e-06 0 8.19497e-06 -1.87634e-06 0
-          9.9172e-06 6.11888e-07 0 7.22442e-06 1.04912e-06 0 3.7252e-06 1.17091e-06 0 1.89398e-06 1.21354e-06 0
-          1.84889e-05 -1.60123e-05 0 2.81019e-05 -8.24774e-06 0 3.27035e-05 3.62894e-06 0 2.2427e-05 4.57002e-06 0
-          1.15226e-05 4.96865e-06 0 5.88332e-06 5.1682e-06 0 3.6254e-05 -4.17991e-05 0 5.55577e-05 -2.18687e-05 0
-          5.8666e-05 1.34161e-05 0 3.55155e-05 1.03764e-05 0 1.90826e-05 1.20871e-05 0 9.60496e-06 1.24727e-05 0
-          5.68201e-05 -8.18129e-05 0 9.12687e-05 -4.48688e-05 0 8.24344e-05 3.85012e-05 0 3.95343e-05 1.34738e-05 0
-          2.5443e-05 2.23642e-05 0 1.09688e-05 2.14002e-05 0 7.66994e-05 -0.000134202 0 0.000143475 -8.40649e-05 0
-          0.000105253 9.5491e-05 0 3.14301e-05 1.85578e-06 0 3.42337e-05 3.89287e-05 0 5.86199e-06 2.822e-05 0
-          8.06e-05 -0.000190803 0 0.000224786 -0.000158024 0 0.000128237 0.000216476 0 5.35643e-06 -4.95504e-05 0
-          5.20093e-05 7.36542e-05 0 -1.9192e-05 2.40859e-05 0 2.52703e-05 -0.000226821 0 0.000346918 -0.000306295 0
-          0.000147857 0.000459107 0 -4.94219e-05 -0.000189121 0 8.8101e-05 0.000155074 0 -9.78044e-05 -1.23261e-05 0
-          -0.000177035 -0.000185075 0 0.000526502 -0.000590653 0 0.000160468 0.000924088 0 -0.00014746 -0.000492595 0
-          0.000157321 0.000343042 0 -0.000299542 -0.000125448 0 -0.000494106 -0.000135029 0 0.000707104 -0.000775716 0
-          0.000162602 0.00122821 0 -0.000257618 -0.000696372 0 0.000241665 0.000473721 0 -0.000584544 -0.000208555 0
+          7.41006e-10 -8.36974e-10 0 1.11141e-09 -5.77603e-10 0 9.36707e-09 -1.01993e-08 0 1.39667e-08 -6.75418e-09 0
+          1.37235e-09 -2.41717e-10 0 1.71011e-08 -2.36283e-09 0 1.03868e-09 -1.61369e-10 0 1.28489e-08 -1.39442e-09 0
+          5.46634e-10 -1.30776e-10 0 6.74847e-09 -1.00946e-09 0 2.78788e-10 -1.23101e-10 0 3.43516e-09 -9.19343e-10 0
+          5.67229e-07 -3.77979e-07 0 8.46375e-07 -1.96365e-07 0 1.03461e-06 3.66752e-08 0 7.74856e-07 8.5841e-08 0
+          4.06346e-07 1.05346e-07 0 2.06681e-07 1.09793e-07 0 6.05449e-06 -4.10021e-06 0 9.21446e-06 -2.14588e-06 0
+          1.13056e-05 6.41817e-07 0 8.32642e-06 1.20382e-06 0 4.29363e-06 1.35995e-06 0 2.17124e-06 1.39578e-06 0
+          2.06466e-05 -1.7827e-05 0 3.17689e-05 -9.50226e-06 0 3.77272e-05 3.75868e-06 0 2.63109e-05 5.35139e-06 0
+          1.34031e-05 5.82697e-06 0 6.74777e-06 5.93697e-06 0 4.02978e-05 -4.6539e-05 0 6.25964e-05 -2.52433e-05 0
+          6.81829e-05 1.38551e-05 0 4.24169e-05 1.26055e-05 0 2.2104e-05 1.42665e-05 0 1.08447e-05 1.42423e-05 0
+          6.25422e-05 -9.07664e-05 0 0.000101912 -5.16397e-05 0 9.64723e-05 3.98001e-05 0 4.86456e-05 1.80627e-05 0
+          2.88103e-05 2.63268e-05 0 1.19927e-05 2.41649e-05 0 8.34316e-05 -0.000148066 0 0.000158309 -9.59071e-05 0
+          0.000124383 9.88378e-05 0 4.19384e-05 9.66252e-06 0 3.70832e-05 4.49322e-05 0 5.87006e-06 3.14229e-05 0
+          8.64448e-05 -0.000209223 0 0.000244982 -0.000177792 0 0.000153991 0.000224231 0 1.64699e-05 -3.79285e-05 0
+          5.35065e-05 8.20148e-05 0 -2.1465e-05 2.65322e-05 0 2.51891e-05 -0.000247271 0 0.000373582 -0.000339222 0
+          0.000182279 0.000475718 0 -3.91417e-05 -0.000173881 0 8.72911e-05 0.00016656 0 -0.000104551 -1.27268e-05 0
+          -0.000193898 -0.000200914 0 0.00056059 -0.000646259 0 0.000206613 0.000957252 0 -0.00014027 -0.000476531 0
+          0.000153331 0.000359297 0 -0.000314649 -0.000132227 0 -0.000535197 -0.000146244 0 0.000747095 -0.000845729 0
+          0.000219979 0.00127206 0 -0.000254782 -0.000681098 0 0.000235201 0.000492906 0 -0.000609466 -0.000219634 0
         </DataArray>
       </PointData>
       <CellData Scalars="process rank">
diff --git a/test/references/zeroeq-reference.vtu b/test/references/zeroeq-reference.vtu
index 5b6912274648dc3b4b5eee75388721e123b1f198..6ab1fcf3d0e4b7454e94333e457968af8d76c379 100644
--- a/test/references/zeroeq-reference.vtu
+++ b/test/references/zeroeq-reference.vtu
@@ -4,226 +4,226 @@
     <Piece NumberOfCells="800" NumberOfPoints="861">
       <PointData Scalars="P" Vectors="v">
         <DataArray type="Float32" Name="P" NumberOfComponents="1" format="ascii">
-          100009 99994.6 100009 99994.6 100009 100009 99994.8 99994.8 100008 100008 99995.3 99995.3
-          100007 100007 99995.8 99995.8 100006 100006 99996.4 99996.4 100005 100005 99996.9 99996.9
-          100004 100004 99997.4 99997.4 100003 100003 99998 99998 100002 100002 99998.5 99998.5
-          100001 100001 99999 99999 100000 100000 100009 99994.5 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.4 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.4 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100010 99994.3 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.4 100009
-          99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003
-          99998 100002 99998.5 100001 99999 100000 100009 99994.6 100009 99994.8 100008 99995.3
-          100007 99995.8 100006 99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5
-          100001 99999 100000 100013 99993.9 100009 99994.8 100008 99995.3 100007 99995.8 100006
-          99996.4 100005 99996.9 100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
-          100013 99993.9 100009 99994.8 100008 99995.3 100007 99995.8 100006 99996.4 100005 99996.9
-          100004 99997.4 100003 99998 100002 99998.5 100001 99999 100000
+          100009 99994.5 100009 99994.5 100009 100009 99994.8 99994.8 100008 100008 99995.4 99995.4
+          100007 100007 99995.9 99995.9 100006 100006 99996.4 99996.4 100005 100005 99996.9 99996.9
+          100004 100004 99997.5 99997.5 100003 100003 99998 99998 100002 100002 99998.5 99998.5
+          100001 100001 99999.1 99999.1 100000 100000 100009 99994.5 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999.1 100000 100010 99994.4 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999.1 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999.1 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999.1 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100010 99994.3 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000 100010 99994.4 100009
+          99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003
+          99998 100002 99998.5 100001 99999 100000 100009 99994.5 100009 99994.8 100008 99995.4
+          100007 99995.9 100006 99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5
+          100001 99999 100000 100009 99994.5 100009 99994.8 100008 99995.4 100007 99995.9 100006
+          99996.4 100005 99996.9 100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
+          100009 99994.5 100009 99994.8 100008 99995.4 100007 99995.9 100006 99996.4 100005 99996.9
+          100004 99997.5 100003 99998 100002 99998.5 100001 99999 100000
         </DataArray>
         <DataArray type="Float32" Name="delP" NumberOfComponents="1" format="ascii">
-          8.79366 -5.42546 8.79412 -5.425 8.76578 8.76566 -5.19932 -5.19932 7.75585 7.75586 -4.69013 -4.69012
-          6.74012 6.74012 -4.15901 -4.15901 5.74924 5.74924 -3.62386 -3.62387 4.77931 4.77931 -3.0901 -3.09011
-          3.81499 3.81499 -2.55637 -2.55637 2.85328 2.85328 -2.02727 -2.02727 1.90328 1.90327 -1.4935 -1.4935
-          0.953005 0.953003 -0.969063 -0.969062 0 0 9.21033 -5.49628 8.77868 -5.20161 7.7562 -4.6902
-          6.74013 -4.15903 5.74923 -3.62387 4.77931 -3.09011 3.81498 -2.55638 2.85328 -2.02728 1.90326 -1.49353
-          0.953013 -0.969145 0 9.80258 -5.59942 8.79688 -5.20447 7.75709 -4.69015 6.74019 -4.15896 5.74924
-          -3.62389 4.77929 -3.09015 3.81495 -2.55638 2.85325 -2.02732 1.90322 -1.49352 0.953008 -0.969114 0
-          10.0436 -5.64131 8.80515 -5.20617 7.75724 -4.6902 6.74018 -4.15887 5.74924 -3.6237 4.77928 -3.08997
-          3.81497 -2.55639 2.85329 -2.02726 1.90325 -1.49356 0.952995 -0.969039 0 10.184 -5.667 8.81023
-          -5.20688 7.75777 -4.69014 6.74022 -4.1588 5.74922 -3.62376 4.77929 -3.09001 3.81495 -2.55638 2.85328
-          -2.02726 1.90325 -1.49354 0.953012 -0.969057 0 10.256 -5.68004 8.81357 -5.20784 7.75772 -4.69017
-          6.74023 -4.15875 5.74926 -3.62355 4.77927 -3.08985 3.81496 -2.55639 2.8533 -2.0272 1.90327 -1.49357
-          0.953 -0.968997 0 10.2924 -5.68774 8.81556 -5.20805 7.7582 -4.69015 6.74026 -4.15869 5.7492
-          -3.62366 4.7793 -3.08989 3.81495 -2.55638 2.8533 -2.0272 1.90327 -1.49355 0.953013 -0.969003 0
-          10.3104 -5.69148 8.81726 -5.20879 7.75805 -4.69017 6.7403 -4.15867 5.74929 -3.62343 4.77925 -3.08975
-          3.81496 -2.55639 2.85331 -2.02715 1.90329 -1.49358 0.953004 -0.968959 0 10.3179 -5.69405 8.81828
-          -5.20885 7.75854 -4.69019 6.74031 -4.15861 5.74919 -3.62358 4.77932 -3.08979 3.81495 -2.55639 2.85331
-          -2.02714 1.90329 -1.49356 0.953012 -0.968954 0 10.3209 -5.69514 8.81944 -5.20953 7.75832 -4.69019
-          6.74037 -4.15861 5.74932 -3.62334 4.77925 -3.08967 3.81496 -2.55639 2.85332 -2.02711 1.9033 -1.49359
-          0.953005 -0.968926 0 10.3211 -5.69625 8.82009 -5.20952 7.75882 -4.69023 6.74037 -4.15856 5.74919
-          -3.62352 4.77934 -3.08971 3.81495 -2.55639 2.85333 -2.02709 1.9033 -1.49357 0.95301 -0.968908 0
-          10.3206 -5.69665 8.82105 -5.21018 7.75855 -4.69021 6.74045 -4.15858 5.74935 -3.62327 4.77926 -3.08962
-          3.81496 -2.5564 2.85333 -2.02707 1.90331 -1.4936 0.953005 -0.968895 0 10.3195 -5.69734 8.82152
-          -5.21012 7.75904 -4.69028 6.74044 -4.15851 5.74919 -3.62348 4.77938 -3.08965 3.81496 -2.5564 2.85334
-          -2.02705 1.90331 -1.49358 0.953006 -0.968863 0 10.3186 -5.69757 8.82237 -5.21076 7.75873 -4.69025
-          6.74053 -4.15855 5.74939 -3.6232 4.77927 -3.08957 3.81496 -2.55641 2.85334 -2.02703 1.90331 -1.49361
-          0.953003 -0.968864 0 10.3176 -5.69809 8.8227 -5.21067 7.75922 -4.69033 6.7405 -4.15848 5.7492
-          -3.62345 4.77941 -3.0896 3.81497 -2.55641 2.85336 -2.02701 1.90332 -1.49359 0.952999 -0.968818 0
-          10.3169 -5.69824 8.82345 -5.21127 7.75887 -4.69029 6.7406 -4.15853 5.74943 -3.62315 4.77929 -3.08953
-          3.81496 -2.55642 2.85334 -2.02701 1.90332 -1.49362 0.952998 -0.968831 0 10.3161 -5.69862 8.82364
-          -5.21114 7.75934 -4.69039 6.74056 -4.15846 5.74921 -3.62342 4.77945 -3.08956 3.81498 -2.55642 2.85337
-          -2.02698 1.90333 -1.49361 0.952991 -0.968774 0 10.3156 -5.69869 8.82431 -5.21172 7.75897 -4.69033
-          6.74064 -4.15852 5.74945 -3.62311 4.77931 -3.08951 3.81497 -2.55642 2.85335 -2.02699 1.90333 -1.49364
-          0.952993 -0.968801 0 10.3151 -5.69895 8.82436 -5.21155 7.75943 -4.69043 6.74059 -4.15845 5.74921
-          -3.62339 4.77949 -3.08953 3.81499 -2.55642 2.85337 -2.02696 1.90333 -1.49362 0.952984 -0.968735 0
-          10.3148 -5.69893 8.82493 -5.21209 7.75903 -4.69037 6.74067 -4.15851 5.74946 -3.62308 4.77933 -3.0895
-          3.81498 -2.55642 2.85335 -2.02698 1.90333 -1.49364 0.952991 -0.968781 0 10.3145 -5.69906 8.82486
-          -5.21189 7.75948 -4.69048 6.74061 -4.15847 5.7492 -3.62343 4.77952 -3.08956 3.81499 -2.55643 2.85337
-          -2.02695 1.90334 -1.49362 0.952984 -0.968714 0 10.3145 -5.69897 8.82534 -5.21241 7.75905 -4.6904
-          6.74067 -4.15852 5.74944 -3.62308 4.77933 -3.08953 3.81498 -2.55643 2.85333 -2.02699 1.90333 -1.49365
-          0.952996 -0.968784 0 10.3145 -5.69896 8.82513 -5.21216 7.75948 -4.69051 6.74059 -4.15847 5.74915
-          -3.62345 4.77953 -3.08959 3.81499 -2.55644 2.85336 -2.02696 1.90334 -1.49362 0.952973 -0.968671 0
-          10.3146 -5.6988 8.82552 -5.21265 7.75903 -4.69043 6.74064 -4.15853 5.7494 -3.62309 4.77932 -3.08959
-          3.81498 -2.55644 2.85331 -2.02701 1.90333 -1.49364 0.952994 -0.968771 0 10.3149 -5.69866 8.82518
-          -5.21236 7.75945 -4.69055 6.74055 -4.15848 5.74908 -3.62348 4.77954 -3.08964 3.815 -2.55644 2.85334
-          -2.02697 1.90334 -1.49361 0.952951 -0.968599 0 10.3152 -5.69842 8.82547 -5.21283 7.75897 -4.69045
-          6.7406 -4.15854 5.74935 -3.6231 4.77931 -3.08965 3.81499 -2.55644 2.85328 -2.02703 1.90334 -1.49364
-          0.952981 -0.968731 0 10.3158 -5.69814 8.825 -5.2125 7.75937 -4.69058 6.74049 -4.15848 5.74901
-          -3.62353 4.77956 -3.0897 3.81501 -2.55644 2.85332 -2.02699 1.90335 -1.4936 0.952916 -0.9685 0
-          10.3162 -5.69781 8.8252 -5.21294 7.75886 -4.69047 6.74054 -4.15856 5.74932 -3.62311 4.77931 -3.08973
-          3.815 -2.55644 2.85325 -2.02706 1.90334 -1.49363 0.952957 -0.968667 0 10.3168 -5.69735 8.82458
-          -5.21258 7.75925 -4.69062 6.74042 -4.1585 5.74895 -3.62358 4.77959 -3.08977 3.81502 -2.55644 2.85329
-          -2.02701 1.90335 -1.49359 0.952873 -0.968385 0 10.3168 -5.69683 8.82467 -5.213 7.75869 -4.69049
-          6.74049 -4.15859 5.74929 -3.62314 4.77932 -3.08982 3.81502 -2.55644 2.85322 -2.0271 1.90334 -1.49362
-          0.952927 -0.968598 0 10.3159 -5.69594 8.82387 -5.21259 7.75907 -4.69067 6.74035 -4.15853 5.74889
-          -3.62366 4.77963 -3.08986 3.81504 -2.55644 2.85327 -2.02704 1.90336 -1.49358 0.952827 -0.968274 0
-          10.3122 -5.6947 8.82375 -5.21298 7.75846 -4.69053 6.74044 -4.15864 5.74927 -3.6232 4.77933 -3.08994
-          3.81504 -2.55644 2.85318 -2.02715 1.90335 -1.49362 0.952897 -0.968538 0 10.3038 -5.69231 8.82257
-          -5.2125 7.75885 -4.69074 6.74028 -4.15858 5.74884 -3.62376 4.77967 -3.08998 3.81507 -2.55645 2.85324
-          -2.02709 1.90336 -1.49358 0.952781 -0.968172 0 10.2832 -5.68808 8.82185 -5.21283 7.75817 -4.69059
-          6.74039 -4.15873 5.74927 -3.62328 4.77936 -3.09008 3.81506 -2.55644 2.85314 -2.02721 1.90335 -1.49361
-          0.952864 -0.968484 0 10.2453 -5.68044 8.81966 -5.21217 7.75856 -4.69084 6.74022 -4.15868 5.7488
-          -3.6239 4.77973 -3.09012 3.81509 -2.55645 2.85321 -2.02713 1.90336 -1.49357 0.95273 -0.968068 0
-          10.1342 -5.66062 8.81615 -5.21208 7.75774 -4.69068 6.74036 -4.15885 5.74928 -3.6234 4.77939 -3.09025
-          3.81509 -2.55645 2.8531 -2.02727 1.90335 -1.4936 0.952823 -0.968421 0 10.0804 -5.65004 8.81333
-          -5.21133 7.75814 -4.69099 6.74018 -4.15881 5.74877 -3.62402 4.77976 -3.09029 3.81512 -2.55645 2.85316
-          -2.02719 1.90336 -1.49355 0.952663 -0.967938 0 8.86831 -5.44141 8.77725 -5.20578 7.75644 -4.69077
-          6.74028 -4.15887 5.74904 -3.62373 4.77961 -3.09029 3.81512 -2.55645 2.85314 -2.02722 1.90337 -1.49357
-          0.95275 -0.968197 0 12.7674 -6.10859 8.89087 -5.22508 7.75995 -4.69137 6.74032 -4.15887 5.74895
-          -3.6238 4.77968 -3.09029 3.81512 -2.55645 2.85315 -2.02719 1.90338 -1.49354 0.9527 -0.968008 0
-          12.767 -6.109 8.89083 -5.22515 7.75993 -4.69137 6.74032 -4.15887 5.74897 -3.62378 4.77967 -3.09028
-          3.81512 -2.55645 2.85315 -2.02719 1.90338 -1.49354 0.952702 -0.968012 0
+          8.80602 -5.45084 8.80648 -5.45038 8.6807 8.68059 -5.1598 -5.1598 7.69549 7.6955 -4.64111 -4.6411
+          6.68763 6.68763 -4.11387 -4.11386 5.70411 5.70411 -3.58103 -3.58104 4.73953 4.73953 -3.05268 -3.05269
+          3.78117 3.78117 -2.52226 -2.52226 2.82744 2.82743 -1.99698 -1.99698 1.88237 1.88237 -1.47311 -1.47312
+          0.945099 0.945093 -0.948187 -0.948167 0 0 9.23458 -5.52363 8.69395 -5.16212 7.69586 -4.64119
+          6.68763 -4.11389 5.70408 -3.58105 4.73954 -3.05269 3.78117 -2.52228 2.82743 -1.997 1.88236 -1.47313
+          0.945079 -0.948184 0 9.82485 -5.62655 8.71204 -5.16498 7.69673 -4.64112 6.6877 -4.11382 5.70412
+          -3.58107 4.7395 -3.05273 3.78113 -2.52227 2.8274 -1.99699 1.88233 -1.47317 0.945068 -0.948109 0
+          10.0652 -5.66811 8.72026 -5.16659 7.69692 -4.6412 6.68768 -4.11373 5.7041 -3.58089 4.73949 -3.05253
+          3.78116 -2.52228 2.82747 -1.99701 1.88238 -1.47315 0.945183 -0.948758 0 10.204 -5.69375 8.72521
+          -5.16732 7.69739 -4.64109 6.68775 -4.11368 5.70415 -3.58092 4.73946 -3.05257 3.78113 -2.52227 2.82744
+          -1.99699 1.88237 -1.47315 0.945208 -0.948748 0 10.2751 -5.70631 8.72846 -5.16814 7.69742 -4.64118
+          6.68773 -4.11361 5.70413 -3.58076 4.73945 -3.05238 3.78115 -2.52229 2.8275 -1.99701 1.88242 -1.47312
+          0.945271 -0.949233 0 10.3104 -5.71412 8.73031 -5.16837 7.69778 -4.64108 6.6878 -4.11358 5.70418
+          -3.58081 4.73942 -3.05244 3.78113 -2.52227 2.82747 -1.99699 1.8824 -1.47313 0.945306 -0.94926 0
+          10.3281 -5.7174 8.7319 -5.16894 7.69776 -4.64118 6.68778 -4.11353 5.70416 -3.58066 4.73942 -3.05226
+          3.78115 -2.52229 2.82754 -1.99701 1.88245 -1.4731 0.945337 -0.949645 0 10.3348 -5.72019 8.73279
+          -5.16903 7.69809 -4.64109 6.68786 -4.11351 5.70421 -3.58072 4.73939 -3.05233 3.78113 -2.52228 2.82751
+          -1.99699 1.88243 -1.4731 0.94539 -0.94974 0 10.3381 -5.72085 8.7338 -5.1695 7.69804 -4.64119
+          6.68784 -4.11347 5.7042 -3.58059 4.7394 -3.05216 3.78115 -2.52229 2.82757 -1.99701 1.88248 -1.47307
+          0.945395 -0.950046 0 10.3378 -5.72228 8.73433 -5.16952 7.69833 -4.6411 6.68792 -4.11347 5.70425
+          -3.58066 4.73938 -3.05224 3.78113 -2.52228 2.82753 -1.99699 1.88246 -1.47309 0.945473 -0.950227 0
+          10.3379 -5.72223 8.73511 -5.16994 7.69825 -4.64121 6.68791 -4.11343 5.70424 -3.58054 4.73939 -3.05209
+          3.78115 -2.5223 2.8276 -1.99702 1.8825 -1.47305 0.945453 -0.950461 0 10.3364 -5.7233 8.73546
+          -5.16991 7.69852 -4.64112 6.68798 -4.11343 5.7043 -3.58062 4.73937 -3.05218 3.78113 -2.52229 2.82756
+          -1.997 1.88248 -1.47308 0.945553 -0.950716 0 10.3362 -5.72305 8.73608 -5.17028 7.69842 -4.64123
+          6.68797 -4.11341 5.70428 -3.58051 4.73939 -3.05203 3.78116 -2.5223 2.82762 -1.99702 1.88253 -1.47304
+          0.945503 -0.95085 0 10.3349 -5.72398 8.73629 -5.17021 7.69865 -4.64114 6.68805 -4.11341 5.70434
+          -3.58059 4.73937 -3.05212 3.78113 -2.52229 2.82758 -1.997 1.8825 -1.47307 0.945617 -0.951148 0
+          10.3349 -5.72361 8.73677 -5.17053 7.69853 -4.64125 6.68803 -4.11339 5.70433 -3.58048 4.73939 -3.05197
+          3.78116 -2.52231 2.82764 -1.99703 1.88254 -1.47303 0.945532 -0.951155 0 10.3338 -5.72442 8.73684
+          -5.17041 7.69874 -4.64116 6.6881 -4.1134 5.70438 -3.58056 4.73938 -3.05207 3.78114 -2.52229 2.8276
+          -1.99701 1.88252 -1.47306 0.945658 -0.951475 0 10.3341 -5.72394 8.73718 -5.17068 7.6986 -4.64126
+          6.68807 -4.11338 5.70436 -3.58045 4.7394 -3.05193 3.78117 -2.52231 2.82766 -1.99703 1.88256 -1.47301
+          0.945535 -0.951343 0 10.3332 -5.72464 8.73712 -5.17051 7.69879 -4.64117 6.68812 -4.11339 5.70441
+          -3.58054 4.73939 -3.05204 3.78115 -2.52229 2.82762 -1.99701 1.88253 -1.47305 0.945673 -0.951676 0
+          10.3339 -5.72405 8.73732 -5.17073 7.69862 -4.64126 6.68808 -4.11337 5.70438 -3.58044 4.73941 -3.05191
+          3.78118 -2.52231 2.82767 -1.99703 1.88256 -1.473 0.945515 -0.951395 0 10.3332 -5.72464 8.73712
+          -5.17051 7.69879 -4.64117 6.68812 -4.11339 5.70441 -3.58054 4.73939 -3.05204 3.78115 -2.52229 2.82762
+          -1.99701 1.88253 -1.47305 0.945652 -0.951713 0 10.3341 -5.72394 8.73718 -5.17068 7.6986 -4.64126
+          6.68807 -4.11338 5.70436 -3.58045 4.7394 -3.05193 3.78117 -2.52231 2.82766 -1.99703 1.88256 -1.473
+          0.945512 -0.951466 0 10.3338 -5.72442 8.73684 -5.17041 7.69874 -4.64116 6.6881 -4.1134 5.70438
+          -3.58056 4.73938 -3.05207 3.78114 -2.52229 2.8276 -1.99701 1.88252 -1.47304 0.945645 -0.951777 0
+          10.3349 -5.72361 8.73677 -5.17053 7.69853 -4.64125 6.68803 -4.11339 5.70433 -3.58048 4.73939 -3.05197
+          3.78116 -2.52231 2.82764 -1.99703 1.88255 -1.473 0.945519 -0.951554 0 10.3349 -5.72398 8.73629
+          -5.17021 7.69865 -4.64114 6.68805 -4.11341 5.70434 -3.58059 4.73937 -3.05212 3.78113 -2.52229 2.82758
+          -1.997 1.88251 -1.47304 0.945643 -0.951847 0 10.3362 -5.72305 8.73608 -5.17028 7.69842 -4.64123
+          6.68797 -4.11341 5.70428 -3.58051 4.73939 -3.05203 3.78116 -2.5223 2.82762 -1.99702 1.88253 -1.47301
+          0.945529 -0.951645 0 10.3364 -5.7233 8.73546 -5.16991 7.69852 -4.64112 6.68798 -4.11343 5.7043
+          -3.58062 4.73937 -3.05218 3.78113 -2.52229 2.82756 -1.997 1.88248 -1.47304 0.945642 -0.951915 0
+          10.3379 -5.72223 8.73511 -5.16994 7.69825 -4.64121 6.68791 -4.11343 5.70424 -3.58054 4.73939 -3.05209
+          3.78115 -2.5223 2.8276 -1.99702 1.8825 -1.47301 0.945541 -0.951733 0 10.3378 -5.72228 8.73433
+          -5.16952 7.69833 -4.6411 6.68792 -4.11347 5.70425 -3.58066 4.73938 -3.05224 3.78113 -2.52228 2.82753
+          -1.99699 1.88246 -1.47304 0.945642 -0.951981 0 10.3381 -5.72085 8.7338 -5.1695 7.69804 -4.64119
+          6.68784 -4.11347 5.7042 -3.58059 4.7394 -3.05216 3.78115 -2.52229 2.82757 -1.99701 1.88248 -1.47302
+          0.945554 -0.951821 0 10.3348 -5.72019 8.73279 -5.16903 7.69809 -4.64109 6.68786 -4.11351 5.70421
+          -3.58072 4.73939 -3.05233 3.78113 -2.52228 2.8275 -1.99699 1.88243 -1.47305 0.945644 -0.952047 0
+          10.3281 -5.7174 8.7319 -5.16894 7.69776 -4.64118 6.68778 -4.11353 5.70416 -3.58066 4.73942 -3.05226
+          3.78115 -2.52229 2.82754 -1.99701 1.88245 -1.47304 0.945569 -0.95191 0 10.3104 -5.71412 8.73031
+          -5.16837 7.69778 -4.64108 6.6878 -4.11358 5.70418 -3.58081 4.73942 -3.05244 3.78113 -2.52227 2.82747
+          -1.99699 1.8824 -1.47306 0.945648 -0.952116 0 10.2751 -5.70631 8.72846 -5.16814 7.69742 -4.64118
+          6.68773 -4.11361 5.70413 -3.58076 4.73945 -3.05238 3.78115 -2.52229 2.8275 -1.99701 1.88241 -1.47306
+          0.945587 -0.952002 0 10.204 -5.69375 8.72521 -5.16732 7.69739 -4.64109 6.68775 -4.11368 5.70415
+          -3.58092 4.73946 -3.05257 3.78113 -2.52227 2.82744 -1.99699 1.88236 -1.47308 0.945655 -0.952189 0
+          10.0652 -5.66811 8.72026 -5.16659 7.69692 -4.6412 6.68768 -4.11373 5.7041 -3.58089 4.73949 -3.05253
+          3.78116 -2.52228 2.82746 -1.99701 1.88238 -1.47308 0.945605 -0.952098 0 9.82485 -5.62655 8.71204
+          -5.16498 7.69673 -4.64112 6.6877 -4.11382 5.70412 -3.58107 4.7395 -3.05273 3.78113 -2.52227 2.82739
+          -1.99699 1.88232 -1.4731 0.945658 -0.952254 0 9.23458 -5.52363 8.69395 -5.16212 7.69586 -4.64119
+          6.68763 -4.11389 5.70408 -3.58105 4.73954 -3.05269 3.78117 -2.52228 2.82743 -1.99699 1.88235 -1.47308
+          0.945647 -0.952245 0 8.80648 -5.45038 8.68059 -5.1598 7.6955 -4.6411 6.68763 -4.11386 5.70411
+          -3.58104 4.73953 -3.05269 3.78117 -2.52226 2.82743 -1.99697 1.88236 -1.47306 0.945646 -0.952169 0
+          8.80602 -5.45084 8.6807 -5.1598 7.69549 -4.64111 6.68763 -4.11387 5.70411 -3.58103 4.73953 -3.05268
+          3.78117 -2.52226 2.82743 -1.99697 1.88236 -1.47305 0.945647 -0.952167 0
         </DataArray>
         <DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii">
           1.23023 1.23005 1.23023 1.23005 1.23023 1.23023 1.23006 1.23006 1.23021 1.23021 1.23006 1.23006
           1.2302 1.2302 1.23007 1.23007 1.23019 1.23019 1.23008 1.23008 1.23018 1.23018 1.23008 1.23008
-          1.23017 1.23017 1.23009 1.23009 1.23015 1.23015 1.23009 1.23009 1.23014 1.23014 1.2301 1.2301
+          1.23017 1.23017 1.23009 1.23009 1.23015 1.23015 1.2301 1.2301 1.23014 1.23014 1.2301 1.2301
           1.23013 1.23013 1.23011 1.23011 1.23012 1.23012 1.23023 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23024 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23024 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23024 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
           1.23013 1.23011 1.23012 1.23025 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
           1.23024 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23024 1.23005 1.23023
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23024 1.23005 1.23023
           1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015
-          1.23009 1.23014 1.2301 1.23013 1.23011 1.23012 1.23023 1.23005 1.23023 1.23006 1.23021 1.23006
-          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301
-          1.23013 1.23011 1.23012 1.23028 1.23004 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
-          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
-          1.23028 1.23004 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
-          1.23017 1.23009 1.23015 1.23009 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.2301 1.23014 1.2301 1.23013 1.23011 1.23012 1.23023 1.23005 1.23023 1.23006 1.23021 1.23006
+          1.2302 1.23007 1.23019 1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301
+          1.23013 1.23011 1.23012 1.23023 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019
+          1.23008 1.23018 1.23008 1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
+          1.23023 1.23005 1.23023 1.23006 1.23021 1.23006 1.2302 1.23007 1.23019 1.23008 1.23018 1.23008
+          1.23017 1.23009 1.23015 1.2301 1.23014 1.2301 1.23013 1.23011 1.23012
         </DataArray>
         <DataArray type="Float32" Name="mu" NumberOfComponents="1" format="ascii">
           1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05
@@ -300,224 +300,502 @@
           1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05
         </DataArray>
         <DataArray type="Float32" Name="v" NumberOfComponents="3" format="ascii">
-          0 0 0 0 0 0 2.5 0 0 1.71681 0.00740167 0
-          0 0 0 1.52883 -0.00176772 0 0 -6.34956e-37 0 1.68763 3.63718e-05 0
-          0 0 0 1.53458 0.000167235 0 0 0 0 1.67439 0.00016323 0
-          0 -3.11697e-37 0 1.51358 7.8725e-05 0 0 0 0 1.66439 4.52105e-05 0
-          0 6.95309e-38 0 1.51351 1.03204e-05 0 0 0 0 1.66924 -4.56647e-05 0
-          0 0 0 1.52215 -3.71703e-05 0 0 -2.29221e-37 0 1.67755 -7.72989e-05 0
-          0 0 0 1.53354 -4.88357e-05 0 0 -2.11681e-37 0 1.68608 -1.96307e-05 0
-          0 0 0 1.53892 -3.20131e-05 0 0 0 0 1.6927 -9.41847e-05 0
-          0 0 0 1.55487 -8.91494e-05 0 0 0 0 1.70884 -2.76103e-05 0
-          0 2.76241e-37 0 1.56486 -7.12366e-05 0 0 0 0 1.71465 0.000255542 0
-          0 0 0 1.5594 -0.00121806 0 2.5 0 0 2.21514 0.0134203 0
-          1.92872 -0.00148212 0 1.98899 0.000384692 0 1.8214 0.00011315 0 1.95678 0.000277231 0
-          1.79878 9.36305e-05 0 1.9463 -9.9563e-07 0 1.79965 -6.25359e-05 0 1.95336 -9.80373e-05 0
-          1.8099 -8.90004e-05 0 1.9636 -0.000133581 0 1.82353 -9.93126e-05 0 1.97378 -4.75767e-05 0
-          1.8288 -6.08508e-05 0 1.98184 -0.000192748 0 1.84845 -0.000192306 0 2.00078 -9.37471e-05 0
-          1.85847 -9.91933e-05 0 2.00557 0.000192051 0 1.85928 -0.000653059 0 2.5 0 0
-          2.45649 0.0168078 0 2.21286 -0.000287813 0 2.24492 0.00141611 0 2.03891 0.000487704 0
-          2.14953 0.000538867 0 1.97834 0.000233718 0 2.11099 7.28587e-05 0 1.95542 -5.11446e-05 0
-          2.09721 -0.000153675 0 1.95502 -0.000154041 0 2.10492 -0.000254916 0 1.97074 -0.000181514 0
-          2.1158 -6.48125e-05 0 1.97513 -0.000116227 0 2.12505 -0.000357289 0 1.99767 -0.000338263 0
-          2.14548 -0.000138633 0 2.0063 -0.000115683 0 2.1489 0.000155079 0 2.01148 -0.000620159 0
-          2.5 0 0 2.58474 0.0179994 0 2.39282 0.000762788 0 2.43637 0.00256442 0
-          2.22708 0.00110632 0 2.31747 0.00101465 0 2.14275 0.000533863 0 2.25965 0.000271615 0
-          2.1018 9.85188e-05 0 2.23093 -8.87637e-05 0 2.08594 -0.000169253 0 2.22519 -0.000320981 0
-          2.08867 -0.000229676 0 2.22818 -7.47021e-05 0 2.09019 -0.000151331 0 2.23201 -0.000476004 0
-          2.10282 -0.000450603 0 2.24525 -0.000187585 0 2.11095 -0.000127397 0 2.249 8.67049e-05 0
-          2.11504 -0.000428876 0 2.5 0 0 2.65551 0.0184262 0 2.50414 0.00151282 0
-          2.57122 0.00356527 0 2.37764 0.00184424 0 2.45888 0.00156273 0 2.28703 0.000902686 0
-          2.39181 0.000571574 0 2.23535 0.000289052 0 2.35313 3.86008e-05 0 2.20847 -9.6437e-05 0
-          2.33712 -0.000301335 0 2.20082 -0.000228999 0 2.33311 -6.94278e-05 0 2.19879 -0.000155788 0
-          2.33266 -0.000530282 0 2.20391 -0.000516717 0 2.33973 -0.0002322 0 2.21016 -0.000147229 0
-          2.34303 6.68217e-05 0 2.21428 -0.000467961 0 2.5 0 0 2.69433 0.0178379 0
-          2.57458 0.00190838 0 2.66349 0.00423463 0 2.4918 0.00244774 0 2.57349 0.00213259 0
-          2.40918 0.00131667 0 2.50677 0.000908892 0 2.35414 0.000555172 0 2.46328 0.000245253 0
-          2.32084 1.03802e-05 0 2.44041 -0.000231386 0 2.30568 -0.00019174 0 2.43081 -4.45145e-05 0
-          2.30023 -0.000143228 0 2.42697 -0.000545701 0 2.29977 -0.000547644 0 2.42898 -0.000264886 0
-          2.30356 -0.000161501 0 2.43142 3.65445e-05 0 2.30734 -0.000487233 0 2.5 0 0
-          2.71527 0.0171761 0 2.61857 0.00205629 0 2.72579 0.00467426 0 2.57533 0.00294634 0
-          2.66327 0.00260043 0 2.50942 0.00168888 0 2.60444 0.00125621 0 2.45747 0.000803447 0
-          2.56096 0.000455965 0 2.42204 0.000165469 0 2.53464 -0.000112991 0 2.40231 -0.00012271 0
-          2.52118 -1.50648e-06 0 2.39414 -0.000110728 0 2.51476 -0.00052441 0 2.38967 -0.000547717 0
-          2.51283 -0.000282586 0 2.39095 -0.000171669 0 2.51415 1.46591e-05 0 2.39415 -0.000492253 0
-          2.5 0 0 2.72585 0.0159312 0 2.64291 0.00196347 0 2.76696 0.00482867 0
-          2.63483 0.00322686 0 2.73168 0.00297364 0 2.58953 0.00201655 0 2.68555 0.00156047 0
-          2.54552 0.00107116 0 2.64615 0.000691865 0 2.51168 0.000314444 0 2.61949 1.76955e-05 0
-          2.49019 -3.76846e-05 0 2.604 5.52461e-05 0 2.4803 -7.02651e-05 0 2.59587 -0.00048644 0
-          2.47316 -0.000527714 0 2.59105 -0.000285154 0 2.47221 -0.000173451 0 2.59116 -1.22556e-05 0
-          2.4747 -0.000487839 0 2.5 0 0 2.73059 0.0149175 0 2.65393 0.00174119 0
-          2.79257 0.00480663 0 2.67618 0.00339935 0 2.78268 0.0031878 0 2.65218 0.00224274 0
-          2.75156 0.00181318 0 2.6192 0.00127282 0 2.71924 0.000885252 0 2.58989 0.000474733 0
-          2.69483 0.000160692 0 2.56911 5.70497e-05 0 2.67911 0.000119106 0 2.55865 -1.90853e-05 0
-          2.67016 -0.000429832 0 2.54995 -0.000490794 0 2.66342 -0.000274818 0 2.54721 -0.000169799 0
-          2.66238 -2.78561e-05 0 2.549 -0.000476126 0 2.5 0 0 2.73241 0.0135203 0
-          2.65807 0.00139468 0 2.8068 0.00455915 0 2.70391 0.00337448 0 2.81984 0.0032944 0
-          2.70025 0.00239344 0 2.80436 0.00198261 0 2.67984 0.00145767 0 2.78101 0.00106648 0
-          2.6572 0.000597841 0 2.76086 0.000284561 0 2.6391 0.000146124 0 2.74648 0.000183315 0
-          2.62922 3.00285e-05 0 2.7376 -0.000371436 0 2.61994 -0.000446195 0 2.72977 -0.000254197 0
-          2.61589 -0.000158077 0 2.72775 -4.74144e-05 0 2.61705 -0.000460176 0 2.5 0 0
-          2.73292 0.0124549 0 2.65927 0.00102483 0 2.81345 0.00422121 0 2.72151 0.00326629 0
-          2.84614 0.00325333 0 2.73648 0.00243259 0 2.84594 0.00207979 0 2.72907 0.00155296 0
-          2.83251 0.00117812 0 2.7144 0.000707982 0 2.81803 0.000395608 0 2.70045 0.000225576 0
-          2.80627 0.000240775 0 2.69216 7.99755e-05 0 2.79823 -0.000306902 0 2.6831 -0.00039526 0
-          2.78999 -0.000226616 0 2.67823 -0.000142598 0 2.78724 -5.59527e-05 0 2.67889 -0.000440876 0
-          2.5 0 0 2.73291 0.0110452 0 2.65948 0.00061017 0 2.81604 0.00375433 0
-          2.73175 0.00299607 0 2.8639 0.00312597 0 2.76318 0.00239859 0 2.87814 0.00208749 0
-          2.76849 0.00161917 0 2.87492 0.00126063 0 2.76244 0.000763671 0 2.86696 0.000468718 0
-          2.75362 0.000283797 0 2.85872 0.000286082 0 2.74774 0.000118779 0 2.85219 -0.000250683 0
-          2.73949 -0.000345247 0 2.84407 -0.00019477 0 2.73424 -0.000121701 0 2.84085 -6.96004e-05 0
-          2.73455 -0.000420343 0 2.5 0 0 2.73272 0.00997927 0 2.65929 0.00021608 0
-          2.81674 0.00328358 0 2.73705 0.00269525 0 2.87513 0.00287672 0 2.78219 0.00226187 0
-          2.90256 0.00202582 0 2.79962 0.00159158 0 2.90943 0.00126496 0 2.80235 0.000795864 0
-          2.90837 0.000516438 0 2.79918 0.000321106 0 2.90423 0.000314524 0 2.79628 0.000150796 0
-          2.89966 -0.000195924 0 2.78925 -0.000295373 0 2.89202 -0.00016143 0 2.78397 -0.000100294 0
-          2.88862 -7.38618e-05 0 2.7841 -0.000398414 0 2.5 0 0 2.73249 0.00857297 0
-          2.65907 -0.000204407 0 2.81686 0.0027463 0 2.73938 0.0022917 0 2.88161 0.00257372 0
-          2.79505 0.00206627 0 2.92049 0.00188189 0 2.82375 0.0015356 0 2.93712 0.0012379 0
-          2.83512 0.000768516 0 2.943 0.00051941 0 2.83775 0.00033026 0 2.94319 0.000323562 0
-          2.83814 0.00016601 0 2.94087 -0.000154472 0 2.83252 -0.000250637 0 2.93389 -0.000128449 0
-          2.8275 -7.70227e-05 0 2.93058 -8.50052e-05 0 2.82757 -0.000376108 0 2.5 0 0
-          2.73227 0.00751099 0 2.65879 -0.00060035 0 2.81672 0.00224408 0 2.74019 0.00191145 0
-          2.88498 0.00218819 0 2.8031 0.00178854 0 2.93304 0.00167854 0 2.84197 0.00138912 0
-          2.95893 0.00113427 0 2.86165 0.000716793 0 2.97158 0.000495155 0 2.8699 0.000315629 0
-          2.97603 0.0003114 0 2.87369 0.000171017 0 2.97603 -0.00011667 0 2.86945 -0.000208024 0
-          2.96972 -9.76364e-05 0 2.86487 -5.68868e-05 0 2.96676 -8.84395e-05 0 2.865 -0.000351971 0
-          2.5 0 0 2.73205 0.00610904 0 2.65859 -0.00102148 0 2.81663 0.00169454 0
-          2.74035 0.00146593 0 2.88649 0.00179098 0 2.80766 0.00147929 0 2.94127 0.00140603 0
-          2.85516 0.00122001 0 2.97564 0.00100329 0 2.88268 0.000607416 0 2.99467 0.000428402 0
-          2.89612 0.000273585 0 3.0031 0.000278278 0 2.90319 0.000158168 0 3.00529 -9.1592e-05 0
-          2.9001 -0.000170472 0 2.99952 -6.99354e-05 0 2.89611 -3.84308e-05 0 2.99715 -0.000100188 0
-          2.89636 -0.000325714 0 2.5 0 0 2.73188 0.00505082 0 2.65838 -0.00141914 0
-          2.81646 0.00118862 0 2.74028 0.00106738 0 2.88706 0.0013483 0 2.80994 0.00111855 0
-          2.94623 0.00109251 0 2.86418 0.000969501 0 2.98788 0.000801558 0 2.89879 0.000478065 0
-          3.01269 0.000340116 0 2.91674 0.000211497 0 3.02457 0.00022503 0 2.92677 0.000136463 0
-          3.02864 -6.70538e-05 0 2.92445 -0.000133345 0 3.02322 -4.63491e-05 0 2.92112 -2.63139e-05 0
-          3.02161 -0.000105386 0 2.92154 -0.000294721 0 2.5 0 0 2.73172 0.00365232 0
-          2.65825 -0.00184113 0 2.81641 0.000637919 0 2.74018 0.00061413 0 2.8872 0.000921199 0
-          2.8109 0.000755653 0 2.9489 0.000733196 0 2.86982 0.000710688 0 2.9962 0.000581615 0
-          2.91032 0.000298308 0 3.02579 0.000218218 0 2.93183 0.000128328 0 3.04044 0.0001543 0
-          2.94432 0.000100693 0 3.04588 -5.01116e-05 0 2.9423 -9.87846e-05 0 3.04062 -2.71376e-05 0
-          2.93965 -1.82977e-05 0 3.03985 -0.000120003 0 2.94032 -0.000258184 0 2.5 0 0
-          2.73161 0.0025968 0 2.65811 -0.0022406 0 2.81629 0.000131825 0 2.74007 0.000213793 0
-          2.8872 0.000465114 0 2.81121 0.000364436 0 2.95011 0.000359194 0 2.87283 0.000390623 0
-          3.00096 0.000305463 0 2.91736 0.000110853 0 3.03377 8.72952e-05 0 2.94112 3.34411e-05 0
-          3.05034 6.92605e-05 0 2.95537 6.24848e-05 0 3.05643 -2.75322e-05 0 2.9532 -6.27905e-05 0
-          3.0513 -1.25735e-05 0 2.95119 -1.74208e-05 0 3.05128 -0.000129843 0 2.95235 -0.000214577 0
-          2.5 0 0 2.7315 0.00120051 0 2.65804 -0.00266329 0 2.8163 -0.00041903 0
-          2.74001 -0.000240388 0 2.88714 3.29461e-05 0 2.81123 -1.23711e-05 0 2.95031 -3.5359e-05 0
-          2.87369 8.89664e-05 0 3.00204 3.44642e-05 0 2.91957 -0.000107466 0 3.03573 -6.04944e-05 0
-          2.9439 -7.32162e-05 0 3.05341 -2.48924e-05 0 2.95897 1.97534e-05 0 3.0592 -7.17528e-06 0
-          2.95649 -3.05278e-05 0 3.05461 -1.61048e-06 0 2.95489 -1.80308e-05 0 3.05488 -0.000153846 0
-          2.95735 -0.000168239 0 2.5 0 0 2.73145 0.000146543 0 2.65798 -0.00306442 0
-          2.81623 -0.000925166 0 2.73996 -0.000639919 0 2.8871 -0.000424641 0 2.81109 -0.000405955 0
-          2.94967 -0.000420759 0 2.87237 -0.00024064 0 2.99952 -0.000259105 0 2.9162 -0.000305342 0
-          3.03161 -0.000196777 0 2.93943 -0.00018202 0 3.0488 -0.000121108 0 2.95398 -1.38784e-05 0
-          3.05406 2.00021e-05 0 2.95153 -1.9609e-06 0 3.04991 6.21436e-06 0 2.94989 -6.82609e-06 0
-          3.04953 -0.000241831 0 2.95536 0.00019438 0 2.5 0 0 2.73139 -0.00124876 0
-          2.65798 -0.00348759 0 2.81629 -0.00147615 0 2.73996 -0.00109398 0 2.887 -0.000856229 0
-          2.81069 -0.000775288 0 2.94806 -0.000801325 0 2.86891 -0.000519058 0 2.9939 -0.0005053 0
-          2.90822 -0.00050487 0 3.02245 -0.000330553 0 2.9288 -0.000284187 0 3.03764 -0.000209103 0
-          2.94166 -4.87064e-05 0 3.04209 4.04032e-05 0 2.93919 2.39066e-05 0 3.03802 1.46747e-05 0
-          2.93716 1.6008e-05 0 3.0371 -0.000352845 0 2.94238 0.000503339 0 2.5 0 0
-          2.7314 -0.00230236 0 2.65799 -0.00389017 0 2.81629 -0.00198238 0 2.73997 -0.00149183 0
-          2.8868 -0.00130995 0 2.80968 -0.00115009 0 2.94494 -0.00114757 0 2.86287 -0.000799467 0
-          2.98497 -0.000741239 0 2.89596 -0.000660606 0 3.0086 -0.000434806 0 2.91267 -0.000369867 0
-          3.02072 -0.000283795 0 2.92301 -7.21412e-05 0 3.02388 6.71357e-05 0 2.92018 5.04898e-05 0
-          3.01958 2.7268e-05 0 2.91762 3.64427e-05 0 3.01794 -0.000444541 0 2.92246 0.000864635 0
-          2.5 0 0 2.73139 -0.00369793 0 2.65806 -0.00431359 0 2.81639 -0.00253346 0
-          2.73996 -0.00194358 0 2.88621 -0.00173012 0 2.80746 -0.00148332 0 2.93957 -0.00146276 0
-          2.8535 -0.00100695 0 2.97231 -0.000908108 0 2.8793 -0.000801002 0 2.99003 -0.000521469 0
-          2.89121 -0.000435339 0 2.99835 -0.000339583 0 2.89848 -9.16687e-05 0 2.99976 9.06403e-05 0
-          2.89489 7.83568e-05 0 2.995 4.24029e-05 0 2.89177 6.82597e-05 0 2.99271 -0.000547947 0
-          2.8957 0.00116144 0 2.5 0 0 2.73146 -0.00475235 0 2.65814 -0.00471734 0
-          2.81643 -0.00303937 0 2.73982 -0.00233405 0 2.88482 -0.00215683 0 2.80306 -0.00179838 0
-          2.93105 -0.00171643 0 2.84003 -0.00119886 0 2.95532 -0.0010514 0 2.85779 -0.000885288 0
-          2.96646 -0.000566952 0 2.86426 -0.000475149 0 2.97051 -0.000375454 0 2.86817 -9.43649e-05 0
-          2.96984 0.000125508 0 2.86347 0.000109748 0 2.96448 6.20016e-05 0 2.85983 9.6503e-05 0
-          2.9617 -0.00062948 0 2.86232 0.0015434 0 2.5 0 0 2.73151 -0.00614934 0
-          2.65826 -0.00514076 0 2.81651 -0.00358869 0 2.73923 -0.00276966 0 2.88176 -0.00252273 0
-          2.79529 -0.0020425 0 2.91839 -0.00191491 0 2.82159 -0.00130376 0 2.93328 -0.00111692 0
-          2.83081 -0.000945768 0 2.93737 -0.000586442 0 2.83142 -0.000489118 0 2.93697 -0.000389204 0
-          2.83192 -8.9143e-05 0 2.93408 0.000161653 0 2.82592 0.000144094 0 2.92809 8.35078e-05 0
-          2.82191 0.000132953 0 2.92505 -0.000719553 0 2.82263 0.00189572 0 2.5 0 0
-          2.73162 -0.0072056 0 2.65838 -0.00554511 0 2.81633 -0.00408752 0 2.73748 -0.00312345 0
-          2.87583 -0.00285591 0 2.78277 -0.00223776 0 2.90047 -0.00203283 0 2.79724 -0.00138219 0
-          2.90529 -0.0011531 0 2.79754 -0.000944507 0 2.90214 -0.000559442 0 2.79219 -0.000475272 0
-          2.89738 -0.000382824 0 2.78946 -6.52899e-05 0 2.89234 0.000211895 0 2.78217 0.000182275 0
-          2.88583 0.000107956 0 2.77799 0.000161074 0 2.88282 -0.000780001 0 2.7765 0.00232764 0
-          2.5 0 0 2.73168 -0.00860475 0 2.65844 -0.00596654 0 2.81558 -0.00461555 0
-          2.73321 -0.00348857 0 2.8653 -0.00308063 0 2.76402 -0.00233383 0 2.87602 -0.00208235 0
-          2.76581 -0.00136522 0 2.87035 -0.00110738 0 2.75707 -0.000917199 0 2.86006 -0.000504847 0
-          2.74597 -0.000436909 0 2.85132 -0.000356962 0 2.74043 -3.429e-05 0 2.84443 0.000263613 0
-          2.73207 0.00022207 0 2.83764 0.000131939 0 2.728 0.000192581 0 2.83493 -0.00084564 0
-          2.72441 0.00274876 0 2.5 0 0 2.73171 -0.00966269 0 2.6582 -0.00636364 0
-          2.81304 -0.00506074 0 2.72427 -0.00372012 0 2.84819 -0.00322533 0 2.73738 -0.00235875 0
-          2.84354 -0.00204178 0 2.72595 -0.00131686 0 2.82732 -0.00103088 0 2.70834 -0.000829661 0
-          2.81038 -0.000406695 0 2.69219 -0.000375896 0 2.7984 -0.000316409 0 2.68447 1.19337e-05 0
-          2.79016 0.000326742 0 2.67551 0.000262569 0 2.78349 0.000155559 0 2.67189 0.000211196 0
-          2.78131 -0.00087695 0 2.66666 0.00321859 0 2.5 0 0 2.73144 -0.0110612 0
-          2.65706 -0.00675813 0 2.80672 -0.00547598 0 2.70782 -0.00390155 0 2.82223 -0.00322221 0
-          2.70084 -0.00226809 0 2.80126 -0.00192696 0 2.67609 -0.00117304 0 2.775 -0.000874863 0
-          2.65033 -0.000722806 0 2.75244 -0.00028965 0 2.63032 -0.000299479 0 2.73828 -0.000264437 0
-          2.62127 5.93714e-05 0 2.72938 0.000385579 0 2.61239 0.000299766 0 2.72338 0.000174301 0
-          2.6096 0.000231583 0 2.72186 -0.000921406 0 2.60384 0.00367727 0 2.5 0 0
-          2.73048 -0.0121087 0 2.65342 -0.00708542 0 2.79342 -0.00571861 0 2.68071 -0.00388742 0
-          2.78488 -0.00311152 0 2.65192 -0.00209553 0 2.74726 -0.00172196 0 2.61466 -0.00100531 0
-          2.71226 -0.000696701 0 2.58208 -0.000568463 0 2.68569 -0.000144464 0 2.55997 -0.000213612 0
-          2.67073 -0.000207968 0 2.55058 0.000113886 0 2.66201 0.000446915 0 2.54269 0.000331136 0
-          2.65735 0.000187399 0 2.54112 0.000240101 0 2.65652 -0.000945193 0 2.53609 0.00416248 0
-          2.5 0 0 2.72771 -0.0134651 0 2.64385 -0.00733075 0 2.76953 -0.00582171 0
-          2.63939 -0.00377148 0 2.73296 -0.00283401 0 2.58773 -0.00180431 0 2.67958 -0.0014547 0
-          2.54016 -0.000759033 0 2.63809 -0.000454934 0 2.5028 -0.000415112 0 2.60979 -3.43173e-06 0
-          2.48096 -0.000129009 0 2.59563 -0.000151545 0 2.47224 0.000159582 0 2.58809 0.00049188 0
-          2.46648 0.000351351 0 2.58549 0.000190128 0 2.46644 0.000254217 0 2.58533 -0.00100377 0
-          2.46323 0.00464145 0 2.5 0 0 2.72125 -0.0143875 0 2.62281 -0.00739584 0
-          2.73062 -0.00564514 0 2.57949 -0.00341435 0 2.66254 -0.0024378 0 2.50512 -0.00144468 0
-          2.59656 -0.00112825 0 2.4515 -0.000516462 0 2.55168 -0.00021493 0 2.41197 -0.000242972 0
-          2.52473 0.000134884 0 2.39331 -5.39206e-05 0 2.51303 -0.000102076 0 2.38618 0.000200693 0
-          2.50776 0.000524134 0 2.38391 0.00035711 0 2.50796 0.000182715 0 2.38561 0.000260525 0
-          2.50832 -0.0010576 0 2.38483 0.00513542 0 2.5 0 0 2.70782 -0.0154521 0
-          2.5839 -0.00723426 0 2.67055 -0.00524084 0 2.49465 -0.0029137 0 2.56904 -0.00188221 0
-          2.40132 -0.00101001 0 2.49714 -0.000796734 0 2.34815 -0.000231181 0 2.45247 5.86503e-05 0
-          2.30946 -0.000111397 0 2.43091 0.000230835 0 2.29734 1.3158e-06 0 2.42304 -6.20264e-05 0
-          2.29244 0.000219471 0 2.42132 0.000521188 0 2.29527 0.000343386 0 2.42493 0.000162655 0
-          2.29868 0.000276195 0 2.42558 -0.00115326 0 2.30043 0.00560149 0 2.5 0 0
-          2.68188 -0.015815 0 2.51906 -0.0067145 0 2.57949 -0.00447234 0 2.37637 -0.00215286 0
-          2.44811 -0.0012649 0 2.27467 -0.000594819 0 2.38132 -0.000491474 0 2.23038 1.29589e-05 0
-          2.34007 0.000296471 0 2.19571 -1.48891e-05 0 2.32907 0.000280876 0 2.1936 3.29604e-05 0
-          2.32583 -3.39629e-05 0 2.1911 0.00021714 0 2.32924 0.000482582 0 2.20095 0.000309013 0
-          2.33659 0.000133732 0 2.20572 0.000285971 0 2.33721 -0.00123327 0 2.20929 0.00600887 0
-          2.5 0 0 2.63134 -0.0159107 0 2.41108 -0.00575092 0 2.4437 -0.00339597 0
-          2.21522 -0.00130695 0 2.29704 -0.000636408 0 2.12571 -0.000242083 0 2.25024 -0.000290457 0
-          2.09951 0.000273912 0 2.21388 0.00053215 0 2.07214 -3.19899e-05 0 2.22023 0.00024613 0
-          2.08285 3.92552e-05 0 2.22143 -1.34849e-05 0 2.08239 0.000169935 0 2.23221 0.000381319 0
-          2.10145 0.000253816 0 2.24305 9.92609e-05 0 2.10677 0.000300083 0 2.24371 -0.00130648 0
-          2.10837 0.00619998 0 2.5 0 0 2.52894 -0.014591 0 2.22559 -0.00423911 0
-          2.24876 -0.00199911 0 2.00398 -0.000396715 0 2.11697 -0.000223027 0 1.95783 -9.08825e-05 0
-          2.10758 -0.000199847 0 1.94897 0.000402746 0 2.12517 0.000608908 0 1.97529 -0.000108736 0
-          2.12574 0.000154291 0 1.98513 3.08382e-05 0 2.12779 2.03218e-06 0 1.98554 9.00583e-05 0
-          2.13654 0.000237511 0 2.00249 0.000184819 0 2.14785 7.35541e-05 0 2.00811 0.000263329 0
-          2.15356 -0.0011748 0 1.98294 0.0058371 0 2.5 0 0 2.30911 -0.0116831 0
-          1.91243 -0.00236121 0 1.97784 -0.00087008 0 1.82682 9.82685e-05 0 1.97987 -0.000101334 0
-          1.81452 -0.000131123 0 1.96628 -9.65279e-05 0 1.80705 0.000114581 0 1.97912 0.000242635 0
-          1.82979 1.01619e-05 0 1.98245 8.66882e-05 0 1.83782 2.48657e-05 0 1.98506 5.5756e-06 0
-          1.83896 5.72747e-05 0 1.99211 0.000148115 0 1.85377 0.000112022 0 2.00319 5.91924e-05 0
-          1.86061 0.000129581 0 2.00624 -0.000722549 0 1.85539 0.00478392 0 2.5 0 0
-          2.00383 -0.00555198 0 1.62067 -0.000641966 0 1.69764 -0.000904239 0 1.53446 -0.000368591 0
-          1.69165 1.5962e-05 0 1.52834 4.9886e-05 0 1.68018 -6.21912e-05 0 1.52196 0.000217541 0
-          1.68892 0.000270437 0 1.53987 -8.77891e-05 0 1.6933 2.72412e-05 0 1.54633 5.27458e-06 0
-          1.69586 6.4692e-06 0 1.54795 3.63552e-06 0 1.70119 3.55203e-05 0 1.55996 4.66473e-05 0
-          1.71107 8.00562e-06 0 1.56701 0.000144566 0 1.712 -0.000713833 0 1.57576 0.00378707 0
-          0 0 0 0 5.08736e-38 0 0 0 0 0 0 0
-          0 -1.58875e-38 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 2.5 0 0 1.73155 0.00721306 0
+          0 0 0 1.5281 -0.00162926 0 0 1.1566e-36 0 1.67885 1.2415e-05 0
+          0 0 0 1.52971 9.92656e-05 0 0 0 0 1.67024 0.000172584 0
+          0 -6.68448e-38 0 1.5115 7.79486e-05 0 0 0 0 1.66234 3.86999e-05 0
+          0 1.34401e-37 0 1.51269 -4.63011e-06 0 0 0 0 1.67542 -6.09517e-05 0
+          0 0 0 1.52582 -2.41727e-05 0 0 -3.80566e-37 0 1.67799 -6.50556e-05 0
+          0 0 0 1.53423 -4.84295e-05 0 0 -1.99834e-37 0 1.68553 -1.76783e-05 0
+          0 0 0 1.53975 -5.24306e-05 0 0 0 0 1.69259 -2.90405e-05 0
+          0 0 0 1.54734 -5.77728e-05 0 0 0 0 1.70296 -8.32004e-05 0
+          0 0 0 1.56227 -8.02069e-05 0 0 3.05996e-37 0 1.71332 0.000244992 0
+          0 0 0 1.50243 0.000616231 0 2.5 0 0 2.23226 0.0133704 0
+          1.92983 -0.00114174 0 1.98442 0.000402107 0 1.81569 5.78895e-05 0 1.95221 0.000249585 0
+          1.79641 6.63302e-05 0 1.94408 5.42996e-06 0 1.79819 -0.00017803 0 1.9624 -0.000159883 0
+          1.81319 5.6467e-06 0 1.9641 -0.000109007 0 1.82423 -8.9156e-05 0 1.97323 -4.66427e-05 0
+          1.82958 -8.77981e-05 0 1.98209 -7.39379e-05 0 1.83762 -0.000115673 0 1.99456 -0.000165343 0
+          1.85526 -0.000206579 0 2.00653 0.000482689 0 1.7866 0.00259579 0 2.5 0 0
+          2.47369 0.0165405 0 2.216 0.000211845 0 2.24271 0.00144057 0 2.03478 0.000413618 0
+          2.14535 0.000503982 0 1.97586 0.000201279 0 2.10829 8.29061e-05 0 1.95391 -0.000229161 0
+          2.10261 -0.000242175 0 1.95818 -4.35587e-06 0 2.10529 -0.000224417 0 1.97142 -0.000167991 0
+          2.11529 -5.87994e-05 0 1.97579 -0.000181331 0 2.12588 -0.000108976 0 1.98337 -0.000213662 0
+          2.13987 -0.000306524 0 2.00348 -0.00031109 0 2.14751 0.000735559 0 1.95779 0.00429912 0
+          2.5 0 0 2.60161 0.017846 0 2.39666 0.00143136 0 2.43559 0.0026402 0
+          2.22432 0.00107618 0 2.31393 0.000958116 0 2.14041 0.000485741 0 2.25676 0.000285786 0
+          2.10038 -0.000137804 0 2.23189 -0.000219798 0 2.08785 1.51438e-05 0 2.22498 -0.000273245 0
+          2.08873 -0.000209455 0 2.22696 -6.57328e-05 0 2.09011 -0.000234625 0 2.23091 -0.00013836 0
+          2.09477 -0.000280628 0 2.23896 -0.000416519 0 2.10783 -0.000389838 0 2.24122 0.00108246 0
+          2.10002 0.00351636 0 2.5 0 0 2.67191 0.0180458 0 2.5085 0.00231405 0
+          2.57126 0.00364228 0 2.37586 0.00180765 0 2.45601 0.00151479 0 2.28497 0.000862069 0
+          2.38895 0.000577747 0 2.23396 5.3227e-05 0 2.35153 -9.9383e-05 0 2.20893 8.107e-05 0
+          2.33622 -0.000247415 0 2.20027 -0.000203847 0 2.33129 -5.88622e-05 0 2.19799 -0.000246388 0
+          2.33041 -0.00015427 0 2.19947 -0.000313673 0 2.33394 -0.000490126 0 2.20652 -0.000397335 0
+          2.33382 0.00116591 0 2.21108 0.00289743 0 2.5 0 0 2.71032 0.0175661 0
+          2.5793 0.00285873 0 2.66404 0.00435799 0 2.4907 0.00245784 0 2.57118 0.00207289 0
+          2.40745 0.00126983 0 2.50407 0.000914713 0 2.35275 0.000301885 0 2.46035 8.72579e-05 0
+          2.32005 0.000187586 0 2.43882 -0.00016738 0 2.30455 -0.000159612 0 2.42849 -3.31591e-05 0
+          2.29881 -0.000229544 0 2.424 -0.000153401 0 2.29738 -0.000323143 0 2.42402 -0.000524897 0
+          2.29968 -0.000393688 0 2.42237 0.00120417 0 2.30674 0.00246979 0 2.5 0 0
+          2.73094 0.0166738 0 2.62351 0.00312506 0 2.72667 0.00479596 0 2.57467 0.00294904 0
+          2.66139 0.00255445 0 2.50802 0.00165539 0 2.60195 0.00125476 0 2.45607 0.000572788 0
+          2.5574 0.000310017 0 2.42032 0.000322231 0 2.53245 -5.13804e-05 0 2.40066 -8.69228e-05 0
+          2.51842 1.06801e-05 0 2.39218 -0.000193196 0 2.51134 -0.000136872 0 2.38841 -0.000314534 0
+          2.50867 -0.000532602 0 2.38712 -0.000367618 0 2.50578 0.00117771 0 2.39308 0.00215269 0
+          2.5 0 0 2.74131 0.0155353 0 2.64807 0.00317117 0 2.76806 0.00499518 0
+          2.63449 0.00327448 0 2.73014 0.00291803 0 2.58841 0.00197979 0 2.68329 0.00156159 0
+          2.54413 0.000834728 0 2.64238 0.000539433 0 2.50938 0.000468573 0 2.6168 8.33011e-05 0
+          2.48812 3.32495e-06 0 2.60088 6.79577e-05 0 2.47791 -0.000143547 0 2.59215 -0.000108146 0
+          2.47247 -0.000293023 0 2.58755 -0.000515757 0 2.4686 -0.000347711 0 2.58363 0.00119008 0
+          2.47238 0.00194252 0 2.5 0 0 2.74591 0.0142886 0 2.65928 0.00306047 0
+          2.79383 0.00497133 0 2.67604 0.00343781 0 2.78137 0.00314659 0 2.65129 0.0022204 0
+          2.74951 0.00181035 0 2.61783 0.00106459 0 2.7155 0.000753116 0 2.58729 0.000611773 0
+          2.69179 0.000221156 0 2.56668 0.000100024 0 2.6757 0.000132667 0 2.55592 -8.71416e-05 0
+          2.66627 -7.12199e-05 0 2.54954 -0.000262174 0 2.66042 -0.000485811 0 2.54393 -0.000312097 0
+          2.6557 0.00117001 0 2.54574 0.00177694 0 2.5 0 0 2.74767 0.0129955 0
+          2.66357 0.00284809 0 2.80819 0.00476904 0 2.70394 0.00345664 0 2.81871 0.00324353 0
+          2.69955 0.00236779 0 2.8025 0.00198541 0 2.67853 0.00124552 0 2.77743 0.000932242 0
+          2.65448 0.000737761 0 2.7576 0.000348985 0 2.63641 0.000193189 0 2.74287 0.000197327 0
+          2.62626 -2.92225e-05 0 2.73363 -3.05397e-05 0 2.61963 -0.000226269 0 2.72715 -0.000443685 0
+          2.613 -0.000284805 0 2.72185 0.00119163 0 2.61386 0.00168919 0 2.5 0 0
+          2.74816 0.0116953 0 2.66483 0.00258697 0 2.81496 0.00442965 0 2.72166 0.0033385 0
+          2.84513 0.00321667 0 2.73593 0.00242082 0 2.84424 0.00208105 0 2.72781 0.00136899 0
+          2.82911 0.00106619 0 2.71167 0.000836312 0 2.81466 0.000456073 0 2.6976 0.000274276 0
+          2.80252 0.000255603 0 2.68906 2.46058e-05 0 2.79426 9.89527e-06 0 2.68282 -0.000188129 0
+          2.78771 -0.000399081 0 2.67577 -0.000241876 0 2.78204 0.00117002 0 2.67703 0.00161547 0
+          2.5 0 0 2.74819 0.0103888 0 2.66512 0.00230454 0 2.81762 0.00400749 0
+          2.73201 0.00311165 0 2.86301 0.00307937 0 2.76276 0.00238277 0 2.87659 0.00209615 0
+          2.76731 0.00143069 0 2.87166 0.00114732 0 2.75974 0.000899227 0 2.86356 0.000534632 0
+          2.75071 0.000336686 0 2.85492 0.000301513 0 2.74456 7.04806e-05 0 2.84827 4.61325e-05 0
+          2.73928 -0.00015113 0 2.84211 -0.000351104 0 2.73225 -0.000206009 0 2.83627 0.00117029 0
+          2.73529 0.00160687 0 2.5 0 0 2.74802 0.00908695 0 2.66495 0.00201858 0
+          2.81837 0.00353478 0 2.7374 0.00280047 0 2.87432 0.00284422 0 2.78188 0.00225928 0
+          2.90113 0.00203393 0 2.79852 0.00143118 0 2.90624 0.00117428 0 2.79971 0.000922292 0
+          2.905 0.000579573 0 2.79628 0.000375803 0 2.90044 0.000331082 0 2.79311 0.000104671 0
+          2.89587 7.52689e-05 0 2.7892 -0.000117124 0 2.89043 -0.000307165 0 2.7825 -0.000155018 0
+          2.88467 0.00111693 0 2.78799 0.00154868 0 2.5 0 0 2.74786 0.00778334 0
+          2.6648 0.00173009 0 2.81854 0.00304144 0 2.73981 0.00243991 0 2.88089 0.00253106 0
+          2.79483 0.00205902 0 2.91917 0.00189783 0 2.82275 0.00137148 0 2.93393 0.00114615 0
+          2.83254 0.000902678 0 2.93971 0.000588564 0 2.83493 0.000389138 0 2.93951 0.000340957 0
+          2.83507 0.00012554 0 2.93726 9.48876e-05 0 2.8328 -8.82564e-05 0 2.93276 -0.000264 0
+          2.82661 -0.000113023 0 2.92728 0.00107806 0 2.83491 0.00153102 0 2.5 0 0
+          2.74767 0.00648435 0 2.66454 0.00144289 0 2.81842 0.002537 0 2.74067 0.00204868 0
+          2.88431 0.00215951 0 2.80297 0.00179408 0 2.93182 0.00169378 0 2.84105 0.00125475 0
+          2.95573 0.00106559 0 2.85914 0.00084063 0 2.96841 0.000561326 0 2.86724 0.000376017 0
+          2.97252 0.000329993 0 2.8708 0.000131762 0 2.97268 0.000103823 0 2.87029 -6.49502e-05 0
+          2.96918 -0.000226631 0 2.86465 -6.04204e-05 0 2.96423 0.000993128 0 2.87528 0.001394 0
+          2.5 0 0 2.74755 0.0051845 0 2.66443 0.0011542 0 2.81836 0.00203098 0
+          2.74089 0.00164569 0 2.88589 0.00175182 0 2.8076 0.00147969 0 2.94013 0.00142883 0
+          2.85434 0.00108361 0 2.97247 0.000933788 0 2.88029 0.000736946 0 2.99169 0.000499649 0
+          2.89372 0.000337512 0 2.99984 0.000297602 0 2.90056 0.000124205 0 3.00227 0.000101398 0
+          2.9018 -4.77262e-05 0 2.99972 -0.000189927 0 2.89666 -2.10608e-05 0 2.99544 0.00092533 0
+          2.90936 0.00131943 0 2.5 0 0 2.74741 0.00388796 0 2.66423 0.000866318 0
+          2.81821 0.00152296 0 2.74086 0.00123558 0 2.8865 0.00132304 0 2.80994 0.00113138 0
+          2.94517 0.00111421 0 2.86345 0.000863762 0 2.98485 0.000754889 0 2.89658 0.000595091 0
+          3.00999 0.000406698 0 2.91469 0.000276099 0 3.02168 0.000245369 0 2.92451 0.000103986 0
+          3.02606 8.81936e-05 0 2.92733 -3.54078e-05 0 3.0243 -0.000157536 0 2.92255 2.45893e-05 0
+          3.0208 0.000821727 0 2.93657 0.00110321 0 2.5 0 0 2.74735 0.0025909 0
+          2.6642 0.000577393 0 2.81819 0.00101559 0 2.74082 0.000824571 0 2.8867 0.000885178 0
+          2.81096 0.000762793 0 2.94792 0.00076237 0 2.86918 0.000602088 0 2.99344 0.000532763 0
+          2.90842 0.000419295 0 3.02353 0.000287555 0 2.93029 0.000195693 0 3.03802 0.000175323 0
+          2.94252 7.42955e-05 0 3.04387 6.52039e-05 0 2.94663 -2.70439e-05 0 3.04264 -0.000123767 0
+          2.9421 5.43527e-05 0 3.03989 0.000738315 0 2.95713 0.000996404 0 2.5 0 0
+          2.74728 0.00129554 0 2.66407 0.000288879 0 2.81808 0.000507659 0 2.74074 0.000412181 0
+          2.88673 0.000443082 0 2.81133 0.00038358 0 2.94922 0.000387149 0 2.87232 0.000309878 0
+          2.99865 0.000276898 0 2.9159 0.000217469 0 3.0322 0.000148916 0 2.94026 0.000101487 0
+          3.04852 9.18187e-05 0 2.95416 3.81604e-05 0 3.05524 3.46801e-05 0 2.95913 -2.02562e-05 0
+          3.05425 -9.2991e-05 0 2.95487 8.88816e-05 0 3.0522 0.000629208 0 2.96965 0.000736526 0
+          2.5 0 0 2.74729 3.59686e-13 0 2.66412 -2.88557e-13 0 2.81814 -2.10121e-13 0
+          2.74076 1.13223e-12 0 2.88675 -8.63786e-13 0 2.81142 4.11622e-12 0 2.94962 -1.63386e-11 0
+          2.87337 5.90101e-11 0 3.00051 -2.06267e-10 0 2.91867 6.64847e-10 0 3.0354 -2.27444e-09 0
+          2.9439 4.8408e-09 0 3.05236 -2.38652e-08 0 2.95843 -1.22284e-07 0 3.05933 -6.51005e-07 0
+          2.96374 -1.35582e-05 0 3.05833 -6.08981e-05 0 2.95994 0.000101931 0 3.05823 0.000562259 0
+          2.96481 0.000676074 0 2.5 0 0 2.74728 -0.00129554 0 2.66407 -0.000288879 0
+          2.81808 -0.000507659 0 2.74074 -0.000412181 0 2.88673 -0.000443082 0 2.81133 -0.00038358 0
+          2.94922 -0.000387149 0 2.87232 -0.000309878 0 2.99865 -0.000276898 0 2.9159 -0.000217468 0
+          3.0322 -0.000148921 0 2.94026 -0.000101477 0 3.04852 -9.18721e-05 0 2.95416 -3.83712e-05 0
+          3.05524 -3.61332e-05 0 2.95913 -5.92368e-06 0 3.05413 -3.13725e-05 0 2.95611 9.60585e-05 0
+          3.05426 0.000541278 0 2.95792 0.000702484 0 2.5 0 0 2.74735 -0.0025909 0
+          2.6642 -0.000577393 0 2.81819 -0.00101559 0 2.74082 -0.000824571 0 2.8867 -0.000885178 0
+          2.81096 -0.000762793 0 2.94792 -0.00076237 0 2.86918 -0.000602088 0 2.99344 -0.000532763 0
+          2.90842 -0.000419293 0 3.02353 -0.000287561 0 2.93029 -0.000195679 0 3.03802 -0.000175394 0
+          2.94252 -7.44049e-05 0 3.04387 -6.71059e-05 0 2.94662 3.51392e-06 0 3.0425 -8.4574e-06 0
+          2.94374 9.68455e-05 0 3.04226 0.000520475 0 2.94478 0.000736125 0 2.5 0 0
+          2.74741 -0.00388796 0 2.66423 -0.000866318 0 2.81821 -0.00152296 0 2.74086 -0.00123558 0
+          2.8865 -0.00132304 0 2.80994 -0.00113138 0 2.94517 -0.00111421 0 2.86345 -0.000863762 0
+          2.98485 -0.000754889 0 2.89658 -0.00059509 0 3.00999 -0.000406704 0 2.91469 -0.000276083 0
+          3.02168 -0.000245449 0 2.92451 -0.000104036 0 3.02605 -9.03504e-05 0 2.9273 1.4305e-05 0
+          3.02416 1.70384e-05 0 2.92419 9.45639e-05 0 3.02334 0.000513899 0 2.92518 0.000767853 0
+          2.5 0 0 2.74755 -0.0051845 0 2.66443 -0.0011542 0 2.81836 -0.00203098 0
+          2.74089 -0.00164569 0 2.88589 -0.00175182 0 2.8076 -0.00147969 0 2.94013 -0.00142883 0
+          2.85434 -0.00108361 0 2.97247 -0.000933788 0 2.88029 -0.000736944 0 2.99169 -0.000499655 0
+          2.89372 -0.000337493 0 2.99984 -0.000297693 0 2.90056 -0.000124182 0 3.00226 -0.000103826 0
+          2.90177 2.93118e-05 0 2.99958 4.11735e-05 0 2.89817 0.000103939 0 2.99817 0.000494878 0
+          2.89931 0.000793189 0 2.5 0 0 2.74767 -0.00648435 0 2.66454 -0.00144289 0
+          2.81842 -0.002537 0 2.74067 -0.00204868 0 2.88431 -0.00215951 0 2.80297 -0.00179408 0
+          2.93182 -0.00169378 0 2.84105 -0.00125475 0 2.95573 -0.00106559 0 2.85914 -0.000840628 0
+          2.96841 -0.000561332 0 2.86724 -0.000375998 0 2.97252 -0.000330085 0 2.8708 -0.000131711 0
+          2.97268 -0.000106298 0 2.87025 4.86686e-05 0 2.96903 7.12987e-05 0 2.86606 0.000110774 0
+          2.9671 0.000486681 0 2.86732 0.000813967 0 2.5 0 0 2.74786 -0.00778334 0
+          2.6648 -0.00173009 0 2.81854 -0.00304144 0 2.73981 -0.00243991 0 2.88089 -0.00253106 0
+          2.79483 -0.00205902 0 2.91917 -0.00189783 0 2.82275 -0.00137148 0 2.93393 -0.00114615 0
+          2.83254 -0.000902676 0 2.93971 -0.000588571 0 2.83493 -0.000389118 0 2.93951 -0.000341056 0
+          2.83507 -0.000125437 0 2.93726 -9.74998e-05 0 2.83275 7.46343e-05 0 2.93257 0.000101962 0
+          2.82794 0.000127699 0 2.93028 0.000465774 0 2.82933 0.000829805 0 2.5 0 0
+          2.74802 -0.00908695 0 2.66495 -0.00201858 0 2.81837 -0.00353478 0 2.7374 -0.00280047 0
+          2.87432 -0.00284422 0 2.78188 -0.00225928 0 2.90113 -0.00203393 0 2.79852 -0.00143118 0
+          2.90624 -0.00117428 0 2.79971 -0.00092229 0 2.905 -0.000579579 0 2.79628 -0.000375782 0
+          2.90044 -0.000331182 0 2.79311 -0.000104544 0 2.89587 -7.78953e-05 0 2.78915 0.000106025 0
+          2.8902 0.000139123 0 2.78381 0.000139645 0 2.88773 0.000455868 0 2.78535 0.000843094 0
+          2.5 0 0 2.74819 -0.0103888 0 2.66512 -0.00230454 0 2.81762 -0.00400749 0
+          2.73201 -0.00311165 0 2.86301 -0.00307937 0 2.76276 -0.00238277 0 2.87659 -0.00209615 0
+          2.76731 -0.00143069 0 2.87166 -0.00114733 0 2.75974 -0.000899226 0 2.86356 -0.000534639 0
+          2.75071 -0.000336663 0 2.85492 -0.00030162 0 2.74456 -7.0289e-05 0 2.84827 -4.89687e-05 0
+          2.73923 0.000143507 0 2.84182 0.000175906 0 2.73356 0.000158698 0 2.83941 0.000433138 0
+          2.73535 0.000852214 0 2.5 0 0 2.74816 -0.0116953 0 2.66483 -0.00258697 0
+          2.81496 -0.00442965 0 2.72166 -0.0033385 0 2.84513 -0.00321667 0 2.73593 -0.00242082 0
+          2.84424 -0.00208105 0 2.72781 -0.00136899 0 2.82911 -0.00106619 0 2.71167 -0.00083631 0
+          2.81466 -0.00045608 0 2.6976 -0.000274253 0 2.80252 -0.000255713 0 2.68906 -2.43693e-05 0
+          2.79425 -1.28896e-05 0 2.68277 0.00018413 0 2.78736 0.000216871 0 2.67707 0.000169608 0
+          2.78525 0.000420476 0 2.67929 0.000857198 0 2.5 0 0 2.74767 -0.0129955 0
+          2.66357 -0.00284809 0 2.80819 -0.00476904 0 2.70394 -0.00345664 0 2.81871 -0.00324353 0
+          2.69955 -0.00236779 0 2.8025 -0.00198541 0 2.67853 -0.00124552 0 2.77743 -0.000932243 0
+          2.65448 -0.00073776 0 2.7576 -0.000348992 0 2.63641 -0.000193163 0 2.74287 -0.00019745 0
+          2.62626 2.95585e-05 0 2.73362 2.71487e-05 0 2.61958 0.000226925 0 2.72673 0.000253759 0
+          2.61424 0.000184284 0 2.72521 0.000393461 0 2.61712 0.000853372 0 2.5 0 0
+          2.74591 -0.0142886 0 2.65928 -0.00306047 0 2.79383 -0.00497133 0 2.67604 -0.00343781 0
+          2.78137 -0.00314659 0 2.65129 -0.0022204 0 2.74951 -0.00181035 0 2.61783 -0.00106459 0
+          2.7155 -0.000753117 0 2.58729 -0.000611772 0 2.69179 -0.000221163 0 2.56668 -9.99966e-05 0
+          2.6757 -0.000132798 0 2.55592 8.75611e-05 0 2.66627 6.74806e-05 0 2.54949 0.000267456 0
+          2.65993 0.000289835 0 2.54499 0.000187553 0 2.65926 0.000374454 0 2.54884 0.000836774 0
+          2.5 0 0 2.74131 -0.0155353 0 2.64807 -0.00317117 0 2.76806 -0.00499518 0
+          2.63449 -0.00327448 0 2.73014 -0.00291803 0 2.58841 -0.00197979 0 2.68329 -0.00156159 0
+          2.54413 -0.000834728 0 2.64238 -0.000539433 0 2.50938 -0.000468571 0 2.6168 -8.33087e-05 0
+          2.48812 -3.29425e-06 0 2.60088 -6.81072e-05 0 2.47791 0.0001441 0 2.59215 0.000103847 0
+          2.47243 0.000303556 0 2.58699 0.000315636 0 2.46931 0.000191492 0 2.58742 0.000339122 0
+          2.47445 0.000797722 0 2.5 0 0 2.73094 -0.0166738 0 2.62351 -0.00312506 0
+          2.72667 -0.00479596 0 2.57467 -0.00294904 0 2.66139 -0.00255445 0 2.50802 -0.00165539 0
+          2.60195 -0.00125476 0 2.45607 -0.000572788 0 2.5574 -0.000310017 0 2.42032 -0.000322229 0
+          2.53245 5.13727e-05 0 2.40066 8.69553e-05 0 2.51842 -1.08414e-05 0 2.39218 0.000193857 0
+          2.51133 0.000132135 0 2.38837 0.000329614 0 2.50806 0.000333423 0 2.38723 0.000181509 0
+          2.50977 0.000310477 0 2.39394 0.000725443 0 2.5 0 0 2.71032 -0.0175661 0
+          2.5793 -0.00285873 0 2.66404 -0.00435799 0 2.4907 -0.00245784 0 2.57118 -0.00207289 0
+          2.40745 -0.00126983 0 2.50407 -0.000914713 0 2.35275 -0.000301885 0 2.46035 -8.72583e-05 0
+          2.32005 -0.000187584 0 2.43882 0.000167372 0 2.30455 0.000159648 0 2.42849 3.29781e-05 0
+          2.29881 0.000230342 0 2.42399 0.000148156 0 2.29735 0.000342351 0 2.4234 0.000332933 0
+          2.2988 0.000170569 0 2.42645 0.000266103 0 2.30726 0.000601412 0 2.5 0 0
+          2.67191 -0.0180458 0 2.5085 -0.00231405 0 2.57126 -0.00364228 0 2.37586 -0.00180765 0
+          2.45601 -0.00151479 0 2.28497 -0.000862069 0 2.38895 -0.000577747 0 2.23396 -5.32269e-05 0
+          2.35153 9.93826e-05 0 2.20893 -8.10682e-05 0 2.33622 0.000247407 0 2.20027 0.000203883 0
+          2.33129 5.86758e-05 0 2.19799 0.000247247 0 2.3304 0.000148943 0 2.19945 0.000334605 0
+          2.33339 0.000316094 0 2.20409 0.000145484 0 2.33768 0.000232661 0 2.21419 0.000403331 0
+          2.5 0 0 2.60161 -0.017846 0 2.39666 -0.00143136 0 2.43559 -0.0026402 0
+          2.22432 -0.00107618 0 2.31393 -0.000958116 0 2.14041 -0.000485741 0 2.25676 -0.000285786 0
+          2.10038 0.000137805 0 2.23189 0.000219798 0 2.08785 -1.51421e-05 0 2.22498 0.000273237 0
+          2.08873 0.000209491 0 2.22696 6.55534e-05 0 2.09011 0.000235461 0 2.23091 0.000133447 0
+          2.09473 0.0003003 0 2.23863 0.000273281 0 2.10306 0.000120696 0 2.24383 0.00019468 0
+          2.1141 9.95773e-05 0 2.5 0 0 2.47369 -0.0165405 0 2.216 -0.000211845 0
+          2.24271 -0.00144057 0 2.03478 -0.000413618 0 2.14535 -0.000503982 0 1.97586 -0.000201279 0
+          2.10829 -8.29061e-05 0 1.95391 0.000229161 0 2.10261 0.000242175 0 1.95818 4.35703e-06 0
+          2.10529 0.000224411 0 1.97142 0.000168015 0 2.11529 5.86798e-05 0 1.97579 0.000181885 0
+          2.12589 0.000105659 0 1.98327 0.000227239 0 2.13996 0.000204509 0 1.9956 0.000110292 0
+          2.14477 4.73315e-05 0 2.01003 0.000438382 0 2.5 0 0 2.23226 -0.0133704 0
+          1.92983 0.00114174 0 1.98442 -0.000402107 0 1.81569 -5.78895e-05 0 1.95221 -0.000249585 0
+          1.79641 -6.63302e-05 0 1.94408 -5.42996e-06 0 1.79819 0.00017803 0 1.9624 0.000159883 0
+          1.81319 -5.64636e-06 0 1.9641 0.000109005 0 1.82423 8.91601e-05 0 1.97323 4.66227e-05 0
+          1.82958 8.78797e-05 0 1.98209 7.306e-05 0 1.83759 0.000119598 0 1.9943 0.000113692 0
+          1.84949 0.000109789 0 2.00107 -9.39984e-05 0 1.85758 0.0005452 0 2.5 0 0
+          1.73155 -0.00721306 0 1.5281 0.00162926 0 1.67885 -1.2415e-05 0 1.52971 -9.92656e-05 0
+          1.67024 -0.000172584 0 1.5115 -7.79486e-05 0 1.66234 -3.86999e-05 0 1.51269 4.63014e-06 0
+          1.67542 6.09516e-05 0 1.52582 2.41732e-05 0 1.67799 6.50532e-05 0 1.53423 4.84409e-05 0
+          1.68553 1.7623e-05 0 1.53975 5.26883e-05 0 1.69259 2.76771e-05 0 1.54732 6.3623e-05 0
+          1.70261 4.76269e-05 0 1.55778 6.51787e-05 0 1.71055 -0.0001929 0 1.55773 0.00115497 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
           0 0 0 0 0 0 0 0 0 0 0 0
           0 0 0 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>
       </PointData>
+      <CellData Scalars="mu_t">
+        <DataArray type="Float32" Name="mu_t" NumberOfComponents="1" format="ascii">
+          7.90911e-05 0.00012713 0.000123757 0.000123758 0.000123292 0.000121999 0.00012159 0.000121561 0.000122528 0.000123276 0.000123551 0.000123998
+          0.000124599 0.000124857 0.000125429 0.000125823 0.000126617 0.0001275 0.000128294 0.000124219 9.22047e-05 0.000346934 0.000386998 0.000453289
+          0.000489433 0.000510709 0.000510177 0.000510594 0.0005164 0.000518755 0.000518348 0.000521073 0.000523212 0.000523234 0.000525545 0.000526264
+          0.000529058 0.000532314 0.000534657 0.000522387 4.46835e-05 0.000345874 0.000393774 0.000535667 0.000635348 0.00076512 0.000764922 0.000874496
+          0.000888761 0.000934081 0.00093565 0.000975348 0.000977509 0.000982457 0.000988994 0.000987728 0.000993809 0.00100304 0.000988955 0.0010627
+          2.3082e-05 0.000338995 0.000388268 0.000534493 0.000634919 0.000764961 0.000764762 0.000900328 0.000930273 0.00103238 0.00106246 0.00116571
+          0.00119743 0.00130009 0.00130185 0.00129954 0.00132458 0.00137579 0.00136413 0.00146131 9.31419e-06 0.000314162 0.000368187 0.000529861
+          0.000633204 0.000764322 0.000764124 0.000900046 0.00093003 0.00103224 0.00106234 0.00116563 0.00119736 0.00130004 0.00130181 0.0012995
+          0.00132683 0.00142074 0.00141618 0.00145632 3.37255e-06 0.000258813 0.000321703 0.000516645 0.000628153 0.000762425 0.000762227 0.000899209
+          0.000929307 0.00103183 0.00106198 0.00116541 0.00119716 0.00129992 0.00130168 0.00129937 0.00132672 0.00142066 0.00141611 0.00145624
+          1.31208e-06 0.000182162 0.000251836 0.000487351 0.000616095 0.000757809 0.000757612 0.000897158 0.000927537 0.00103081 0.00106109 0.00116486
+          0.00119668 0.0012996 0.00130136 0.00129905 0.00132644 0.00142047 0.00141592 0.00145607 5.67349e-07 0.000112283 0.000178877 0.000436118
+          0.000591788 0.000748102 0.000747908 0.000892794 0.000923768 0.00102865 0.00105919 0.00116369 0.00119564 0.00129892 0.00130068 0.00129838
+          0.00132583 0.00142006 0.00141551 0.0014557 2.6986e-07 6.45849e-05 0.000118986 0.000365306 0.00054985 0.000729984 0.000729794 0.000884452
+          0.000916554 0.00102447 0.00105553 0.00116143 0.00119362 0.00129761 0.00129937 0.00129707 0.00132466 0.00141927 0.00141472 0.00145499
+          1.3893e-07 3.66482e-05 7.6105e-05 0.000286566 0.000488037 0.000699605 0.000699423 0.000869867 0.000903906 0.00101706 0.00104902 0.00115739
+          0.00119003 0.00129527 0.00129702 0.00129472 0.00132256 0.00141785 0.0014133 0.0014537 7.63305e-08 2.11649e-05 4.78251e-05 0.000213126
+          0.0004105 0.000653746 0.000653576 0.00084631 0.000883381 0.00100479 0.00103823 0.00115063 0.00118402 0.00129133 0.00129308 0.00129078
+          0.00131904 0.00141546 0.00141092 0.00145154 4.42583e-08 1.25978e-05 3.00643e-05 0.000152735 0.000327322 0.000591579 0.000591426 0.000811042
+          0.000852414 0.000985676 0.00102137 0.00113992 0.00117448 0.00128504 0.00128678 0.0012845 0.00131341 0.00141163 0.00140711 0.00144807
+          2.68476e-08 7.75148e-06 1.91397e-05 0.000107087 0.000249586 0.000516089 0.000515955 0.000762113 0.000808953 0.000957591 0.000996471 0.0011238
+          0.00116008 0.00127546 0.00127719 0.00127493 0.00130482 0.00140577 0.00140126 0.00144276 1.69224e-08 4.92502e-06 1.24207e-05 7.4392e-05
+          0.000184441 0.000433817 0.000433704 0.000699335 0.000752277 0.000918611 0.00096166 0.00110061 0.0011393 0.00126145 0.00126316 0.00126092
+          0.00129225 0.00139712 0.00139264 0.00143492 1.10233e-08 3.223e-06 8.23696e-06 5.16981e-05 0.000133909 0.00035265 0.000352558 0.000624968
+          0.000683674 0.000867553 0.000915595 0.0010687 0.00111057 0.00124172 0.0012434 0.0012412 0.00127449 0.00138479 0.00138035 0.00142373
+          7.38861e-09 2.16617e-06 5.58334e-06 3.61746e-05 9.65853e-05 0.000279097 0.000279025 0.000543561 0.000606525 0.000804531 0.00085796 0.00102673
+          0.00107252 0.00121491 0.00121655 0.0012144 0.00125028 0.00136777 0.00136338 0.00140825 5.07771e-09 1.4911e-06 3.86483e-06 2.5586e-05
+          6.97538e-05 0.000216767 0.000216711 0.000460849 0.000525619 0.000731306 0.000789832 0.000973983 0.00102427 0.00117977 0.00118137 0.00117928
+          0.00121839 0.00134495 0.00134064 0.00138744 3.56742e-09 1.04864e-06 2.72816e-06 1.83287e-05 5.06913e-05 0.000166476 0.000166433 0.000382229
+          0.000445974 0.000651187 0.000713719 0.000910709 0.000965733 0.00113535 0.00113689 0.00113487 0.00117784 0.00131527 0.00131105 0.00136028
+          2.55598e-09 7.51783e-07 1.96086e-06 1.33081e-05 3.7174e-05 0.00012722 0.000127187 0.000311579 0.000371737 0.000568434 0.000633188 0.000838322
+          0.000897817 0.00108122 0.00108269 0.00108077 0.00112804 0.00127776 0.00127367 0.0013258 1.86373e-09 5.48373e-07 1.43288e-06 9.7939e-06
+          2.75488e-05 9.71968e-05 9.71717e-05 0.000250871 0.000305594 0.000487375 0.000552185 0.000759326 0.00082246 0.0010177 0.00101908 0.00101727
+          0.00106902 0.00123177 0.00122782 0.00128328 1.86373e-09 5.48373e-07 1.43288e-06 9.7939e-06 2.75488e-05 9.71968e-05 9.71717e-05 0.000250871
+          0.000305594 0.000487375 0.000552185 0.000759326 0.00082246 0.0010177 0.00101908 0.00101725 0.00106955 0.0012332 0.00122748 0.00122078
+          2.55598e-09 7.51783e-07 1.96086e-06 1.33081e-05 3.7174e-05 0.00012722 0.000127187 0.000311579 0.000371737 0.000568434 0.000633188 0.000838322
+          0.000897817 0.00108122 0.00108269 0.00108074 0.0011286 0.00127925 0.00127332 0.00126637 3.56742e-09 1.04864e-06 2.72816e-06 1.83287e-05
+          5.06913e-05 0.000166476 0.000166433 0.000382229 0.000445974 0.000651187 0.000713719 0.000910709 0.000965733 0.00113535 0.00113689 0.00113485
+          0.00117842 0.0013168 0.00131069 0.00130354 5.07771e-09 1.4911e-06 3.86483e-06 2.5586e-05 6.97538e-05 0.000216767 0.000216711 0.000460849
+          0.000525619 0.000731306 0.000789832 0.000973983 0.00102427 0.00117977 0.00118137 0.00117925 0.00121899 0.00134652 0.00134027 0.00133296
+          7.38861e-09 2.16617e-06 5.58334e-06 3.61746e-05 9.65853e-05 0.000279097 0.000279025 0.000543561 0.000606525 0.000804531 0.00085796 0.00102673
+          0.00107252 0.00121491 0.00121656 0.00121437 0.00125089 0.00136936 0.00136301 0.00135557 1.10233e-08 3.223e-06 8.23696e-06 5.16981e-05
+          0.000133909 0.00035265 0.000352558 0.000624968 0.000683674 0.000867553 0.000915595 0.0010687 0.00111057 0.00124172 0.0012434 0.00124117
+          0.00127511 0.00138641 0.00137997 0.00137244 1.69224e-08 4.92502e-06 1.24207e-05 7.4392e-05 0.000184441 0.000433817 0.000433704 0.000699335
+          0.000752277 0.000918611 0.000961659 0.00110061 0.0011393 0.00126145 0.00126316 0.0012609 0.00129288 0.00139875 0.00139226 0.00138466
+          2.68476e-08 7.75148e-06 1.91397e-05 0.000107087 0.000249586 0.000516089 0.000515955 0.000762113 0.000808953 0.000957591 0.000996471 0.0011238
+          0.00116008 0.00127546 0.00127719 0.0012749 0.00130546 0.00140741 0.00140088 0.00139323 4.42583e-08 1.25978e-05 3.00643e-05 0.000152735
+          0.000327322 0.000591579 0.000591426 0.000811042 0.000852414 0.000985676 0.00102137 0.00113992 0.00117448 0.00128504 0.00128678 0.00128447
+          0.00131405 0.00141328 0.00140672 0.00139904 7.63305e-08 2.11649e-05 4.78251e-05 0.000213126 0.0004105 0.000653746 0.000653576 0.00084631
+          0.000883381 0.00100479 0.00103823 0.00115063 0.00118401 0.00129133 0.00129308 0.00129076 0.00131968 0.00141711 0.00141053 0.00140283
+          1.3893e-07 3.66482e-05 7.6105e-05 0.000286566 0.000488037 0.000699605 0.000699423 0.000869867 0.000903906 0.00101706 0.00104902 0.00115739
+          0.00119003 0.00129527 0.00129703 0.0012947 0.00132321 0.0014195 0.00141292 0.0014052 2.6986e-07 6.45849e-05 0.000118986 0.000365306
+          0.00054985 0.000729984 0.000729794 0.000884452 0.000916554 0.00102447 0.00105553 0.00116143 0.00119362 0.00129761 0.00129937 0.00129704
+          0.00132531 0.00142092 0.00141433 0.00140661 5.67349e-07 0.000112283 0.000178877 0.000436118 0.000591788 0.000748102 0.000747908 0.000892794
+          0.000923768 0.00102865 0.00105919 0.00116369 0.00119564 0.00129892 0.00130069 0.00129835 0.00132648 0.00142172 0.00141512 0.0014074
+          1.31208e-06 0.000182162 0.000251836 0.000487351 0.000616095 0.000757809 0.000757612 0.000897158 0.000927537 0.00103081 0.00106109 0.00116486
+          0.00119668 0.0012996 0.00130136 0.00129903 0.00132709 0.00142213 0.00141553 0.0014078 3.37255e-06 0.000258813 0.000321703 0.000516645
+          0.000628153 0.000762425 0.000762227 0.000899209 0.000929307 0.00103183 0.00106198 0.00116541 0.00119716 0.00129992 0.00130168 0.00129934
+          0.00132737 0.00142232 0.00141572 0.00140799 9.31419e-06 0.000314162 0.000368187 0.000529861 0.000633204 0.000764322 0.000764124 0.000900046
+          0.00093003 0.00103224 0.00106234 0.00116563 0.00119736 0.00130004 0.00130181 0.00129947 0.00132748 0.0014224 0.00141579 0.00140807
+          2.3082e-05 0.000338995 0.000388268 0.000534493 0.000634919 0.000764961 0.000764762 0.000900328 0.000930273 0.00103238 0.00106246 0.00116571
+          0.00119743 0.00130009 0.00130185 0.00129951 0.00132449 0.00138118 0.00137707 0.00136593 4.46835e-05 0.000345874 0.000393774 0.000535667
+          0.000635348 0.00076512 0.000764922 0.000874496 0.000888761 0.000934081 0.00093565 0.000975348 0.000977509 0.000982452 0.000989019 0.000987552
+          0.000994744 0.000996688 0.000990668 0.00101215 9.22047e-05 0.000346934 0.000386998 0.000453289 0.000489433 0.000510709 0.000510177 0.000510594
+          0.0005164 0.000518755 0.000518348 0.000521073 0.000523212 0.000523233 0.000525546 0.000526245 0.000529103 0.000530912 0.000530564 0.000537779
+          7.90911e-05 0.00012713 0.000123757 0.000123758 0.000123292 0.000121999 0.00012159 0.000121561 0.000122528 0.000123276 0.000123551 0.000123998
+          0.000124599 0.000124857 0.000125428 0.000125822 0.000126593 0.000127178 0.000127811 0.000127701
+        </DataArray>
+        <DataArray type="Float32" Name="l_mix" NumberOfComponents="1" format="ascii">
+          0.00059494 0.000542775 0.000539801 0.000539713 0.000539368 0.000538055 0.000537765 0.000537648 0.000538648 0.000539263 0.000539608 0.000539941
+          0.000540584 0.000540737 0.00054135 0.000541629 0.000542442 0.000543166 0.000543968 0.000540092 0.00313399 0.00298049 0.00297111 0.00297085
+          0.00296974 0.00296557 0.00296463 0.00296428 0.00296744 0.00296942 0.00297049 0.00297157 0.00297359 0.00297409 0.00297601 0.00297691
+          0.00297945 0.00298176 0.00298425 0.00297201 0.00597758 0.0058332 0.00582375 0.00582348 0.00582237 0.00581811 0.00581716 0.00581679
+          0.00582001 0.00582203 0.00582313 0.00582422 0.00582627 0.00582678 0.00582872 0.00582963 0.00583219 0.00583452 0.00583703 0.00582462
+          0.00870346 0.0086078 0.0086011 0.00860091 0.00860012 0.00859705 0.00859638 0.00859612 0.00859842 0.00859987 0.00860066 0.00860144
+          0.0086029 0.00860326 0.00860464 0.00860529 0.00860711 0.00860877 0.00861054 0.00860169 0.0113259 0.0112724 0.0112684 0.0112683
+          0.0112678 0.011266 0.0112656 0.0112654 0.0112668 0.0112677 0.0112681 0.0112686 0.0112695 0.0112697 0.0112705 0.0112709
+          0.011272 0.011273 0.0112741 0.0112687 0.013895 0.0138679 0.0138658 0.0138657 0.0138654 0.0138644 0.0138642 0.0138641
+          0.0138649 0.0138654 0.0138656 0.0138659 0.0138664 0.0138665 0.0138669 0.0138671 0.0138677 0.0138683 0.0138688 0.0138659
+          0.0164408 0.016428 0.0164269 0.0164268 0.0164267 0.0164262 0.0164261 0.016426 0.0164264 0.0164267 0.0164268 0.0164269
+          0.0164272 0.0164272 0.0164275 0.0164276 0.0164279 0.0164281 0.0164284 0.016427 0.0189772 0.0189714 0.0189709 0.0189709
+          0.0189708 0.0189705 0.0189705 0.0189705 0.0189706 0.0189708 0.0189708 0.0189709 0.018971 0.018971 0.0189711 0.0189712
+          0.0189713 0.0189715 0.0189716 0.0189709 0.02151 0.0215075 0.0215072 0.0215072 0.0215072 0.0215071 0.021507 0.021507
+          0.0215071 0.0215072 0.0215072 0.0215072 0.0215073 0.0215073 0.0215074 0.0215074 0.0215074 0.0215075 0.0215076 0.0215072
+          0.0240415 0.0240404 0.0240403 0.0240403 0.0240403 0.0240402 0.0240402 0.0240402 0.0240402 0.0240403 0.0240403 0.0240403
+          0.0240403 0.0240403 0.0240403 0.0240404 0.0240404 0.0240404 0.0240404 0.0240403 0.0265725 0.026572 0.026572 0.026572
+          0.026572 0.0265719 0.0265719 0.0265719 0.0265719 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572
+          0.026572 0.026572 0.026572 0.026572 0.0291033 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031
+          0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031
+          0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634
+          0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.0341648 0.0341648 0.0341647 0.0341647
+          0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647
+          0.0341648 0.0341648 0.0341648 0.0341647 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955
+          0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955
+          0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262
+          0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.041757 0.041757 0.041757 0.041757
+          0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757
+          0.041757 0.041757 0.041757 0.041757 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877
+          0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877
+          0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184
+          0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0493491 0.0493491 0.0493491 0.0493491
+          0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491
+          0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491
+          0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491 0.0493491
+          0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184
+          0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0468184 0.0442877 0.0442877 0.0442877 0.0442877
+          0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877 0.0442877
+          0.0442877 0.0442877 0.0442877 0.0442877 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757
+          0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757 0.041757
+          0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262
+          0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0392262 0.0366955 0.0366955 0.0366955 0.0366955
+          0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955 0.0366955
+          0.0366955 0.0366955 0.0366955 0.0366955 0.0341648 0.0341648 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647
+          0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341647 0.0341648 0.0341648 0.0341648 0.0341648
+          0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634
+          0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.031634 0.0291033 0.0291031 0.0291031 0.0291031
+          0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031 0.0291031
+          0.0291031 0.0291031 0.0291031 0.0291031 0.0265725 0.026572 0.026572 0.026572 0.026572 0.0265719 0.0265719 0.0265719
+          0.0265719 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572 0.026572
+          0.0240415 0.0240404 0.0240403 0.0240403 0.0240403 0.0240402 0.0240402 0.0240402 0.0240402 0.0240403 0.0240403 0.0240403
+          0.0240403 0.0240403 0.0240403 0.0240404 0.0240404 0.0240404 0.0240404 0.0240404 0.02151 0.0215075 0.0215072 0.0215072
+          0.0215072 0.0215071 0.021507 0.021507 0.0215071 0.0215072 0.0215072 0.0215072 0.0215073 0.0215073 0.0215074 0.0215074
+          0.0215074 0.0215075 0.0215075 0.0215075 0.0189772 0.0189714 0.0189709 0.0189709 0.0189708 0.0189705 0.0189705 0.0189705
+          0.0189706 0.0189708 0.0189708 0.0189709 0.018971 0.018971 0.0189711 0.0189712 0.0189713 0.0189714 0.0189715 0.0189715
+          0.0164408 0.016428 0.0164269 0.0164268 0.0164267 0.0164262 0.0164261 0.016426 0.0164264 0.0164267 0.0164268 0.0164269
+          0.0164272 0.0164272 0.0164275 0.0164276 0.0164278 0.016428 0.0164283 0.0164282 0.013895 0.0138679 0.0138658 0.0138657
+          0.0138654 0.0138644 0.0138642 0.0138641 0.0138649 0.0138654 0.0138656 0.0138659 0.0138664 0.0138665 0.0138669 0.0138671
+          0.0138677 0.013868 0.0138685 0.0138684 0.0113259 0.0112724 0.0112684 0.0112683 0.0112678 0.011266 0.0112656 0.0112654
+          0.0112668 0.0112677 0.0112681 0.0112686 0.0112695 0.0112697 0.0112705 0.0112709 0.011272 0.0112726 0.0112735 0.0112732
+          0.00870346 0.0086078 0.0086011 0.00860091 0.00860012 0.00859705 0.00859638 0.00859612 0.00859842 0.00859987 0.00860066 0.00860144
+          0.0086029 0.00860326 0.00860464 0.00860529 0.00860706 0.0086081 0.00860956 0.00860914 0.00597758 0.0058332 0.00582375 0.00582348
+          0.00582237 0.00581811 0.00581716 0.00581679 0.00582001 0.00582203 0.00582313 0.00582422 0.00582627 0.00582678 0.00582872 0.00582963
+          0.00583212 0.00583358 0.00583565 0.00583506 0.00313399 0.00298049 0.00297111 0.00297085 0.00296974 0.00296557 0.00296463 0.00296428
+          0.00296744 0.00296942 0.00297049 0.00297157 0.00297359 0.00297409 0.00297601 0.00297691 0.00297938 0.00298082 0.00298288 0.00298229
+          0.00059494 0.000542775 0.000539801 0.000539713 0.000539368 0.000538055 0.000537765 0.000537648 0.000538648 0.000539263 0.000539608 0.000539941
+          0.000540584 0.000540737 0.00054135 0.000541628 0.000542419 0.00054287 0.00054353 0.000543339
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          15.1474 13.2927 13.1779 13.1874 13.1638 13.1323 13.1096 13.1183 13.1387 13.1723 13.1714 13.1948
+          13.2041 13.2216 13.2299 13.2515 13.2665 13.3031 13.3182 13.2028 32.1113 30.2647 29.2638 28.8061
+          28.6643 28.6047 28.5602 28.5806 28.6371 28.7082 28.7007 28.7563 28.7777 28.8109 28.8313 28.8747
+          28.9083 28.9881 29.02 28.7767 34.8037 36.0969 34.4097 33.1994 32.6973 32.4827 32.321 32.2466
+          32.2168 32.2456 32.2355 32.3078 32.3336 32.3606 32.3899 32.4307 32.4718 32.5661 32.5798 32.4302
+          36.1436 39.5092 38.1826 36.7331 35.8672 35.3957 35.0342 34.7873 34.5736 34.485 34.4376 34.4662
+          34.4592 34.4691 34.4751 34.5005 34.5195 34.5912 34.5614 34.6825 36.8627 41.5123 40.7346 39.4859
+          38.549 37.9541 37.4709 37.1043 36.7543 36.5412 36.4184 36.355 36.2839 36.2657 36.2221 36.2213
+          36.1941 36.2093 36.1449 36.489 37.2571 42.7019 42.4235 41.5205 40.7034 40.1185 39.596 39.1692
+          38.7366 38.437 38.2526 38.1202 37.9959 37.9477 37.867 37.84 37.7768 37.7452 37.6618 38.0823
+          37.4713 43.4127 43.5344 42.977 42.3663 41.8874 41.3975 40.9673 40.5008 40.1542 39.9288 39.7496
+          39.5855 39.5111 39.4027 39.353 39.2616 39.1931 39.0956 39.5361 37.5837 43.8202 44.2441 43.9961
+          43.6117 43.2908 42.8855 42.4988 42.0401 41.6826 41.4392 41.235 41.0457 40.9523 40.8244 40.7572
+          40.6441 40.5478 40.4383 40.8787 37.638 44.0275 44.6667 44.6893 44.5221 44.3778 44.0868 43.7772
+          43.3586 43.0205 42.781 42.5717 42.3718 42.2685 42.129 42.0502 41.9214 41.8051 41.6857 42.1213
+          37.6611 44.1168 44.895 45.1401 45.172 45.2025 45.0383 44.8253 44.4692 44.1735 43.9566 43.7594
+          43.5624 43.4589 43.3155 43.2309 43.0921 42.9624 42.835 43.2701 37.6692 44.1487 45.0045 45.4147
+          45.6219 45.8154 45.7792 45.6714 45.3907 45.153 44.9733 44.8022 44.6196 44.5248 44.3845 44.2997
+          44.1559 44.0182 43.885 44.3282 37.6711 44.1571 45.0495 45.5691 45.9195 46.2594 46.3463 46.3446
+          46.145 45.9741 45.8418 45.7071 45.548 45.4693 45.3381 45.2582 45.1137 44.9726 44.8352 45.2969
+          37.6706 44.157 45.064 45.648 46.1042 46.5698 46.771 46.8721 46.7543 46.654 46.5752 46.4837
+          46.3544 46.2974 46.18 46.109 45.9673 45.826 45.6865 46.1742 37.6694 44.1544 45.0665 45.6839
+          46.2097 46.7762 47.0792 47.2773 47.2394 47.2099 47.1876 47.1427 47.0468 47.0154 46.9149 46.8556
+          46.7192 46.5799 46.4404 46.9572 37.6681 44.1513 45.065 45.6975 46.2642 46.9046 47.293 47.58
+          47.6186 47.6583 47.6926 47.6948 47.6334 47.6294 47.5473 47.5016 47.3717 47.2356 47.098 47.6426
+          37.667 44.1485 45.0627 45.7013 46.2892 46.9781 47.4323 47.7973 47.9075 48.0135 48.1026 48.1499
+          48.122 48.1454 48.0815 48.0498 47.9268 47.7939 47.66 48.2283 37.6661 44.1462 45.0606 45.7012
+          46.2989 47.016 47.5162 47.9451 48.1198 48.2875 48.4275 48.5157 48.5182 48.5671 48.5198 48.5015
+          48.3846 48.2544 48.1255 48.7124 37.6654 44.1445 45.0589 45.7003 46.302 47.0333 47.5622 48.0387
+          48.2673 48.4897 48.674 48.7968 48.8248 48.8957 48.8619 48.8551 48.7429 48.6145 48.4911 49.0912
+          37.6649 44.1433 45.0578 45.6993 46.3024 47.04 47.5846 48.0922 48.3607 48.6261 48.8447 48.9932
+          49.0397 49.1274 49.1028 49.1046 48.995 48.8683 48.7503 49.3561 37.6646 44.1427 45.0572 45.6988
+          46.3023 47.0421 47.5935 48.1165 48.4071 48.6974 48.9357 49.0979 49.1544 49.2514 49.2312 49.2378
+          49.1289 49.0049 48.8973 49.4627 37.6646 44.1427 45.0572 45.6988 46.3023 47.0421 47.5935 48.1165
+          48.4071 48.6974 48.9357 49.0979 49.1544 49.2514 49.2312 49.2379 49.1312 49.0464 48.965 49.0154
+          37.6649 44.1433 45.0578 45.6993 46.3024 47.04 47.5846 48.0922 48.3607 48.6261 48.8447 48.9932
+          49.0397 49.1274 49.1028 49.1047 48.9966 48.9158 48.834 48.8688 37.6654 44.1445 45.0589 45.7003
+          46.302 47.0333 47.5622 48.0387 48.2673 48.4897 48.674 48.7968 48.8248 48.8957 48.8619 48.8551
+          48.7443 48.6634 48.5782 48.6095 37.6661 44.1462 45.0606 45.7012 46.2989 47.016 47.5162 47.9451
+          48.1198 48.2875 48.4275 48.5157 48.5182 48.5671 48.5199 48.5014 48.386 48.3025 48.2133 48.2447
+          37.667 44.1485 45.0627 45.7013 46.2892 46.9781 47.4323 47.7973 47.9075 48.0135 48.1026 48.1499
+          48.122 48.1454 48.0815 48.0496 47.928 47.8407 47.7476 47.78 37.6681 44.1513 45.065 45.6975
+          46.2642 46.9046 47.293 47.58 47.6186 47.6583 47.6926 47.6948 47.6334 47.6294 47.5473 47.5014
+          47.3726 47.281 47.1853 47.2185 37.6694 44.1544 45.0665 45.6839 46.2097 46.7762 47.0792 47.2773
+          47.2394 47.2099 47.1876 47.1427 47.0468 47.0154 46.9149 46.8554 46.7197 46.6242 46.5274 46.5613
+          37.6706 44.157 45.064 45.648 46.1042 46.5698 46.771 46.8721 46.7543 46.654 46.5752 46.4837
+          46.3544 46.2974 46.1801 46.1087 45.9674 45.8692 45.7732 45.8084 37.6711 44.1571 45.0495 45.5691
+          45.9195 46.2594 46.3463 46.3446 46.145 45.9741 45.8418 45.7071 45.548 45.4693 45.3381 45.2579
+          45.1132 45.0146 44.9214 44.959 37.6692 44.1487 45.0045 45.4147 45.6219 45.8154 45.7792 45.6714
+          45.3907 45.153 44.9733 44.8022 44.6196 44.5248 44.3845 44.2994 44.1549 44.0587 43.9707 44.0123
+          37.6611 44.1168 44.895 45.1401 45.172 45.2025 45.0383 44.8253 44.4692 44.1735 43.9566 43.7594
+          43.5624 43.4589 43.3155 43.2306 43.0905 43.0004 42.92 42.9678 37.638 44.0275 44.6667 44.6893
+          44.5221 44.3778 44.0868 43.7772 43.3586 43.0205 42.781 42.5717 42.3718 42.2685 42.129 42.0499
+          41.9192 41.8395 41.769 41.8254 37.5837 43.8202 44.2441 43.9961 43.6117 43.2908 42.8855 42.4988
+          42.0401 41.6826 41.4392 41.235 41.0457 40.9523 40.8244 40.757 40.6413 40.5769 40.5181 40.5856
+          37.4713 43.4127 43.5344 42.977 42.3663 41.8874 41.3975 40.9673 40.5008 40.1542 39.9288 39.7496
+          39.5855 39.5111 39.4027 39.3529 39.2586 39.2145 39.1686 39.249 37.2571 42.7019 42.4235 41.5205
+          40.7034 40.1185 39.596 39.1692 38.7366 38.437 38.2526 38.1202 37.9959 37.9477 37.867 37.8398
+          37.774 37.7553 37.7223 37.816 36.8627 41.5123 40.7346 39.4859 38.549 37.9541 37.4709 37.1043
+          36.7543 36.5412 36.4184 36.355 36.2839 36.2657 36.2221 36.2211 36.1923 36.2036 36.1819 36.2853
+          36.1436 39.5092 38.1826 36.7331 35.8672 35.3957 35.0342 34.7873 34.5736 34.485 34.4376 34.4662
+          34.4592 34.469 34.4751 34.5001 34.5199 34.5645 34.5476 34.668 34.8037 36.0969 34.4097 33.1994
+          32.6973 32.4827 32.321 32.2466 32.2168 32.2456 32.2355 32.3078 32.3336 32.3606 32.39 32.4303
+          32.4725 32.5341 32.527 32.6343 32.1113 30.2647 29.2638 28.8061 28.6643 28.6047 28.5602 28.5806
+          28.6371 28.7082 28.7007 28.7563 28.7777 28.8109 28.8312 28.8745 28.9073 28.9654 28.9769 29.0234
+          15.1474 13.2927 13.1779 13.1874 13.1638 13.1323 13.1096 13.1183 13.1387 13.1723 13.1714 13.1948
+          13.2041 13.2216 13.2299 13.2515 13.2658 13.2932 13.3033 13.3094
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          15.1199 13.2844 13.1841 13.1812 13.1695 13.1257 13.1159 13.1121 13.1455 13.1661 13.1776 13.1889
+          13.2104 13.2156 13.2361 13.2456 13.2728 13.2973 13.3243 13.1942 45.3596 39.8531 39.5523 39.5437
+          39.5086 39.3772 39.3476 39.3363 39.4364 39.4984 39.5328 39.5666 39.6311 39.6467 39.7084 39.7367
+          39.8185 39.892 39.9729 39.5825 75.5993 66.4218 65.9204 65.9062 65.8477 65.6286 65.5794 65.5604
+          65.7273 65.8306 65.8881 65.9443 66.0518 66.0779 66.1806 66.2278 66.3642 66.4866 66.6215 65.9709
+          105.839 92.9905 92.2886 92.2686 92.1868 91.88 91.8111 91.7846 92.0182 92.1629 92.2433 92.322
+          92.4725 92.509 92.6528 92.7189 92.9099 93.0812 93.2701 92.3593 136.079 119.559 118.657 118.631
+          118.526 118.131 118.043 118.009 118.309 118.495 118.599 118.7 118.893 118.94 119.125 119.21
+          119.456 119.676 119.919 118.748 166.318 146.128 145.025 144.994 144.865 144.383 144.275 144.233
+          144.6 144.827 144.954 145.077 145.314 145.371 145.597 145.701 146.001 146.271 146.567 145.136
+          196.558 172.697 171.393 171.356 171.204 170.634 170.506 170.457 170.891 171.16 171.309 171.455
+          171.735 171.803 172.07 172.192 172.547 172.865 173.216 171.524 226.798 199.265 197.761 197.719
+          197.543 196.886 196.738 196.681 197.182 197.492 197.664 197.833 198.155 198.234 198.542 198.683
+          199.093 199.46 199.864 197.913 257.038 225.834 224.129 224.081 223.882 223.137 222.97 222.906
+          223.473 223.824 224.019 224.21 224.576 224.665 225.014 225.174 225.638 226.054 226.513 224.301
+          287.277 252.403 250.498 250.443 250.221 249.389 249.202 249.13 249.764 250.156 250.375 250.588
+          250.997 251.096 251.486 251.666 252.184 252.649 253.162 250.689 317.517 278.972 276.866 276.806
+          276.56 275.64 275.433 275.354 276.055 276.489 276.73 276.966 277.417 277.527 277.959 278.157
+          278.73 279.244 279.81 277.078 347.757 305.54 303.234 303.168 302.899 301.891 301.665 301.578
+          302.345 302.821 303.085 303.344 303.838 303.958 304.431 304.648 305.276 305.838 306.459 303.466
+          377.996 332.109 329.602 329.531 329.238 328.143 327.897 327.802 328.636 329.153 329.44 329.721
+          330.259 330.389 330.903 331.139 331.821 332.433 333.107 329.855 408.236 358.678 355.97 355.893
+          355.578 354.394 354.129 354.026 354.927 355.485 355.796 356.099 356.679 356.821 357.375 357.63
+          358.367 359.028 359.756 356.243 438.476 385.246 382.339 382.256 381.917 380.646 380.36 380.251
+          381.218 381.818 382.151 382.477 383.1 383.252 383.848 384.121 384.913 385.622 386.405 382.631
+          468.716 411.815 408.707 408.618 408.256 406.897 406.592 406.475 407.509 408.15 408.506 408.854
+          409.521 409.683 410.32 410.612 411.458 412.217 413.053 409.02 498.955 438.384 435.075 434.981
+          434.595 433.149 432.824 432.699 433.8 434.482 434.861 435.232 435.942 436.114 436.792 437.103
+          438.004 438.812 439.702 435.408 529.195 464.953 461.443 461.343 460.934 459.4 459.056 458.923
+          460.091 460.814 461.216 461.61 462.362 462.545 463.264 463.594 464.55 465.406 466.35 461.796
+          559.435 491.521 487.811 487.706 487.273 485.652 485.287 485.147 486.382 487.147 487.572 487.988
+          488.783 488.976 489.736 490.086 491.095 492.001 492.999 488.185 589.674 518.09 514.179 514.068
+          513.612 511.903 511.519 511.371 512.673 513.479 513.927 514.365 515.204 515.408 516.209 516.577
+          517.641 518.595 519.648 514.573 589.674 518.09 514.179 514.068 513.612 511.903 511.519 511.371
+          512.673 513.479 513.927 514.365 515.204 515.408 516.208 516.575 517.612 518.206 519.072 518.824
+          559.435 491.521 487.811 487.706 487.273 485.652 485.287 485.147 486.382 487.147 487.572 487.988
+          488.783 488.976 489.736 490.084 491.068 491.631 492.453 492.218 529.195 464.953 461.443 461.343
+          460.934 459.4 459.056 458.923 460.091 460.814 461.216 461.61 462.362 462.545 463.264 463.593
+          464.523 465.057 465.834 465.612 498.955 438.384 435.075 434.981 434.595 433.149 432.824 432.699
+          433.8 434.482 434.861 435.232 435.942 436.114 436.792 437.102 437.979 438.482 439.215 439.005
+          468.716 411.815 408.707 408.618 408.256 406.897 406.592 406.475 407.509 408.15 408.506 408.854
+          409.521 409.683 410.319 410.611 411.435 411.907 412.596 412.399 438.476 385.246 382.339 382.256
+          381.917 380.646 380.36 380.251 381.218 381.818 382.151 382.477 383.1 383.252 383.847 384.12
+          384.891 385.333 385.976 385.792 408.236 358.678 355.97 355.893 355.578 354.394 354.129 354.026
+          354.927 355.485 355.796 356.099 356.679 356.821 357.375 357.629 358.347 358.758 359.357 359.186
+          377.996 332.109 329.602 329.531 329.238 328.143 327.897 327.802 328.636 329.153 329.44 329.721
+          330.259 330.389 330.903 331.138 331.802 332.183 332.738 332.58 347.757 305.54 303.234 303.168
+          302.899 301.891 301.665 301.578 302.345 302.821 303.085 303.344 303.838 303.958 304.431 304.647
+          305.258 305.609 306.119 305.973 317.517 278.972 276.866 276.806 276.56 275.64 275.433 275.354
+          276.055 276.489 276.73 276.966 277.417 277.527 277.958 278.156 278.714 279.034 279.5 279.367
+          287.277 252.403 250.498 250.443 250.221 249.389 249.202 249.13 249.764 250.156 250.375 250.588
+          250.997 251.096 251.486 251.665 252.17 252.459 252.881 252.761 257.038 225.834 224.129 224.081
+          223.882 223.137 222.97 222.906 223.473 223.824 224.019 224.21 224.576 224.665 225.014 225.174
+          225.626 225.885 226.262 226.154 226.798 199.265 197.761 197.719 197.543 196.886 196.738 196.681
+          197.182 197.492 197.664 197.833 198.155 198.234 198.542 198.683 199.081 199.31 199.643 199.548
+          196.558 172.697 171.393 171.356 171.204 170.634 170.506 170.457 170.891 171.16 171.309 171.455
+          171.735 171.803 172.069 172.192 172.537 172.735 173.024 172.941 166.318 146.128 145.025 144.994
+          144.865 144.383 144.275 144.233 144.6 144.827 144.954 145.077 145.314 145.371 145.597 145.701
+          145.993 146.161 146.405 146.335 136.079 119.559 118.657 118.631 118.526 118.131 118.043 118.009
+          118.309 118.495 118.599 118.7 118.893 118.94 119.125 119.21 119.449 119.586 119.786 119.729
+          105.839 92.9905 92.2886 92.2686 92.1868 91.88 91.8111 91.7846 92.0182 92.1629 92.2433 92.322
+          92.4725 92.509 92.6528 92.7186 92.9047 93.0113 93.1667 93.1223 75.5993 66.4218 65.9204 65.9062
+          65.8477 65.6286 65.5794 65.5604 65.7273 65.8306 65.8881 65.9443 66.0518 66.0779 66.1805 66.2276
+          66.3605 66.4367 66.5477 66.5159 45.3596 39.8531 39.5523 39.5437 39.5086 39.3772 39.3476 39.3363
+          39.4364 39.4984 39.5328 39.5666 39.6311 39.6467 39.7083 39.7366 39.8163 39.862 39.9286 39.9096
+          15.1199 13.2844 13.1841 13.1812 13.1695 13.1257 13.1159 13.1121 13.1455 13.1661 13.1776 13.1889
+          13.2104 13.2156 13.2361 13.2455 13.2721 13.2873 13.3095 13.3032
+        </DataArray>
+      </CellData>
       <Points>
         <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
           0 0 0 0.5 0 0 0 0.0061725 0 0.5 0.0061725 0
diff --git a/test/references/zeroeq2c-reference.vtu b/test/references/zeroeq2c-reference.vtu
index 9ca6b56fbb23b105d7237d9139933911e1909754..25edf3775751c23479eab627367402b153e129b2 100644
--- a/test/references/zeroeq2c-reference.vtu
+++ b/test/references/zeroeq2c-reference.vtu
@@ -459,6 +459,63 @@
           1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05 1.75183e-05
           1.75183e-05 1.75183e-05 1.75183e-05
         </DataArray>
+        <DataArray type="Float32" Name="D" NumberOfComponents="1" format="ascii">
+          2.27221e-05 2.27253e-05 2.27221e-05 2.27253e-05 2.27224e-05 2.27224e-05 2.27254e-05 2.27254e-05 2.27225e-05 2.27225e-05 2.27253e-05 2.27253e-05
+          2.27226e-05 2.27226e-05 2.27252e-05 2.27252e-05 2.27228e-05 2.27228e-05 2.27251e-05 2.27251e-05 2.27229e-05 2.27229e-05 2.27251e-05 2.27251e-05
+          2.2723e-05 2.2723e-05 2.2725e-05 2.2725e-05 2.27232e-05 2.27232e-05 2.27249e-05 2.27249e-05 2.27233e-05 2.27233e-05 2.27248e-05 2.27248e-05
+          2.27234e-05 2.27234e-05 2.27247e-05 2.27247e-05 2.27235e-05 2.27235e-05 2.27246e-05 2.27246e-05 2.27237e-05 2.27237e-05 2.27245e-05 2.27245e-05
+          2.27238e-05 2.27238e-05 2.27244e-05 2.27244e-05 2.27239e-05 2.27239e-05 2.27243e-05 2.27243e-05 2.2724e-05 2.2724e-05 2.27242e-05 2.27242e-05
+          2.27241e-05 2.27241e-05 2.27219e-05 2.27255e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05
+          2.27229e-05 2.2725e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05
+          2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27218e-05 2.27254e-05 2.27223e-05
+          2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05
+          2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27237e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05
+          2.27243e-05 2.2724e-05 2.27242e-05 2.27241e-05 2.2722e-05 2.27256e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05
+          2.27228e-05 2.27251e-05 2.27229e-05 2.2725e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05
+          2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27217e-05
+          2.27254e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.27251e-05 2.2723e-05
+          2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05
+          2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27242e-05 2.27241e-05 2.27226e-05 2.27256e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05
+          2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.2725e-05 2.2723e-05 2.27249e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05
+          2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05
+          2.27241e-05 2.27222e-05 2.27254e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05
+          2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05
+          2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27224e-05 2.27255e-05 2.27224e-05 2.27254e-05
+          2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.2725e-05 2.2723e-05 2.27249e-05 2.27231e-05 2.27249e-05
+          2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05
+          2.2724e-05 2.27243e-05 2.27241e-05 2.27223e-05 2.27254e-05 2.27224e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05
+          2.27251e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05
+          2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27223e-05 2.27255e-05
+          2.27224e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.2725e-05 2.2723e-05 2.2725e-05
+          2.27231e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05
+          2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27224e-05 2.27255e-05 2.27224e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05
+          2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05
+          2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05
+          2.27223e-05 2.27254e-05 2.27224e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.2725e-05
+          2.2723e-05 2.2725e-05 2.27231e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05
+          2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27226e-05 2.27256e-05 2.27223e-05 2.27254e-05 2.27224e-05
+          2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05
+          2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05
+          2.27243e-05 2.27241e-05 2.27217e-05 2.27254e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27251e-05
+          2.27229e-05 2.2725e-05 2.2723e-05 2.2725e-05 2.27231e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05
+          2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.27221e-05 2.27257e-05 2.27222e-05
+          2.27254e-05 2.27224e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27252e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05
+          2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05
+          2.27243e-05 2.2724e-05 2.27242e-05 2.27241e-05 2.27219e-05 2.27255e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05
+          2.27228e-05 2.27251e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27231e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05
+          2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05 2.27241e-05 2.2722e-05
+          2.27256e-05 2.27222e-05 2.27254e-05 2.27224e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27252e-05 2.27229e-05 2.27251e-05 2.2723e-05
+          2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05
+          2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27242e-05 2.27241e-05 2.27218e-05 2.27255e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05
+          2.27226e-05 2.27252e-05 2.27228e-05 2.27252e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05
+          2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27243e-05
+          2.27241e-05 2.27223e-05 2.27254e-05 2.27223e-05 2.27254e-05 2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27252e-05 2.27229e-05
+          2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05 2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05
+          2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05 2.2724e-05 2.27242e-05 2.27241e-05 2.27223e-05 2.27254e-05 2.27223e-05 2.27254e-05
+          2.27225e-05 2.27253e-05 2.27226e-05 2.27252e-05 2.27228e-05 2.27252e-05 2.27229e-05 2.27251e-05 2.2723e-05 2.2725e-05 2.27232e-05 2.27249e-05
+          2.27233e-05 2.27248e-05 2.27234e-05 2.27247e-05 2.27235e-05 2.27246e-05 2.27236e-05 2.27245e-05 2.27238e-05 2.27244e-05 2.27239e-05 2.27243e-05
+          2.2724e-05 2.27242e-05 2.27241e-05
+        </DataArray>
         <DataArray type="Float32" Name="v" NumberOfComponents="3" format="ascii">
           0 0 0 0 0 0 2.5 0 0 2.37287 0.175838 0
           0 0 0 2.21794 0.0749595 0 0 0 0 2.17943 0.0667303 0
@@ -625,6 +682,268 @@
           0 0 0 0 0 0 0 0 0
         </DataArray>
       </PointData>
+      <CellData Scalars="mu_t">
+        <DataArray type="Float32" Name="mu_t" NumberOfComponents="1" format="ascii">
+          0.00708502 0.00667486 0.00639356 0.00610375 0.00590024 0.00572896 0.00560316 0.00549708 0.00541194 0.00533958 0.00527847 0.00522219
+          0.00517211 0.00512294 0.00507933 0.00503872 0.00500188 0.00496819 0.00493875 0.00490998 0.00488467 0.00485913 0.00483609 0.00481403
+          0.00479431 0.00477546 0.00475801 0.00474018 0.00472304 0.00470433 0.00393798 0.00854053 0.0103631 0.0119707 0.0124913 0.0128371
+          0.0128758 0.0128831 0.0128133 0.0127318 0.0126329 0.0125512 0.0124658 0.0124139 0.0123645 0.012326 0.0122923 0.0122539
+          0.012204 0.0121616 0.012112 0.0120755 0.0120425 0.0120129 0.0119847 0.0119557 0.0119274 0.0119036 0.0118816 0.011884
+          0.00199176 0.00552183 0.0084755 0.010915 0.012687 0.0139744 0.0147885 0.0155325 0.0160607 0.0165198 0.0167583 0.0169146
+          0.0170047 0.0170736 0.0171621 0.0172927 0.0173877 0.0175011 0.0175757 0.0176162 0.0176362 0.0176462 0.0176539 0.0176883
+          0.0177167 0.0177549 0.0177724 0.0177832 0.0177916 0.0177745 0.00429615 0.0106573 0.0106148 0.00656695 0.00174977 0.00331242
+          0.0075018 0.01069 0.0128379 0.0142206 0.0153354 0.0165184 0.0173964 0.0183086 0.0188701 0.0192569 0.0195665 0.0198025
+          0.0200205 0.0203577 0.0206333 0.0209554 0.0211892 0.0213412 0.0214582 0.0215497 0.0216898 0.0218448 0.0219885 0.0220366
+          0.000255983 0.00128061 0.00318806 0.00865667 0.00959755 0.00962486 0.00768229 0.00510605 0.0012402 0.00355624 0.00750061 0.0103786
+          0.0126224 0.0138658 0.0149439 0.0164463 0.0175694 0.0188622 0.0198392 0.0205037 0.0210215 0.0214214 0.0217767 0.0223095
+          0.0227733 0.0232976 0.0236375 0.0239372 0.0242029 0.0244416 0.0285321 0.047924 0.032624 0.0220069 0.0162042 0.0135008
+          0.0118545 0.0108107 0.0100716 0.0101342 0.00864864 0.00638477 0.0028554 0.00230799 0.00679571 0.00971943 0.0122791 0.0135357
+          0.0143524 0.0160205 0.0173748 0.0190693 0.0203229 0.0211434 0.0217274 0.0222021 0.0228624 0.0236546 0.0243773 0.0250161
+          0.0046048 0.00628115 0.00320725 0.0121011 0.0160474 0.0172494 0.0162009 0.0145907 0.0128717 0.0108295 0.00940574 0.00847034
+          0.00795827 0.00904546 0.00878814 0.00733619 0.0048605 0.000749007 0.00493071 0.00832733 0.0112124 0.0125116 0.0133757 0.0153493
+          0.017034 0.0190974 0.0202697 0.0212737 0.0221538 0.0232997 0.0039042 0.0147693 0.0231759 0.0225305 0.0180832 0.015408
+          0.0141559 0.0137479 0.0137515 0.0140571 0.0139447 0.0127464 0.0114367 0.008844 0.00683447 0.00580465 0.00510724 0.00630581
+          0.00739166 0.00717092 0.00536168 0.00110766 0.00450565 0.00777052 0.0103821 0.0112379 0.0127304 0.0152798 0.0174049 0.0199962
+          0.0084643 0.0169298 0.0131761 0.00380615 0.00337695 0.00758312 0.00996815 0.0106616 0.0104809 0.00934309 0.00849508 0.00837684
+          0.00881063 0.0103873 0.0118126 0.0115902 0.0110276 0.00874636 0.00568792 0.0039623 0.00282642 0.0044852 0.00638868 0.00673852
+          0.00482062 0.00063599 0.00471278 0.00692203 0.00963033 0.0134559 0.00170394 0.00563106 0.0099309 0.0110655 0.0098698 0.00962953
+          0.00887195 0.00872931 0.00924907 0.00988608 0.0106808 0.0104721 0.00903356 0.0071939 0.00399265 0.00281742 0.00210439 0.00254835
+          0.00608377 0.00690301 0.00770256 0.00614896 0.00191752 0.000166502 0.000491842 0.00263305 0.00430456 0.00348446 0.0012313 0.0031405
+          0.0121328 0.0220477 0.0141798 0.00528889 0.000623055 0.00406608 0.00593832 0.00718877 0.00832929 0.00912646 0.00999173 0.00993369
+          0.00852923 0.00670528 0.00342381 0.00192743 0.00104181 0.00112136 0.00444714 0.00529245 0.0062482 0.00470826 0.000525965 0.00192447
+          0.00241944 0.00120157 0.00207682 0.000774558 0.00275787 0.00764371 0.00511897 0.0160835 0.0213738 0.0201623 0.0157557 0.0128931
+          0.0122367 0.0116416 0.0111125 0.00995835 0.00903482 0.00858118 0.00893364 0.0100961 0.0112493 0.0111575 0.0105889 0.00823759
+          0.00525246 0.00327346 0.00175158 0.00376273 0.0053653 0.00508992 0.00278593 0.00262953 0.00687443 0.00890542 0.0112284 0.0146591
+          0.00766228 0.0107661 0.00334294 0.0124438 0.0161552 0.0181909 0.0171466 0.0160772 0.015142 0.0143803 0.0136606 0.0124415
+          0.0108911 0.0085466 0.00672672 0.00545433 0.00464714 0.00620116 0.00659805 0.00591618 0.00379516 0.00144006 0.00644665 0.00925457
+          0.0116283 0.0124102 0.0139709 0.0164396 0.0183244 0.0207166 0.0361141 0.0586624 0.0355051 0.0218062 0.0163367 0.0140384
+          0.0131758 0.0126383 0.0116231 0.0104975 0.00932959 0.00830295 0.00792659 0.00854732 0.00751942 0.00584567 0.00287484 0.00216626
+          0.00684777 0.00981378 0.0124647 0.0135184 0.0144786 0.0164125 0.0179257 0.0198837 0.0209087 0.0218266 0.0227081 0.0237936
+          0.00188721 0.00520014 0.00290975 0.0100993 0.0120273 0.0131051 0.0121762 0.0112251 0.0100906 0.00895904 0.00680245 0.00414398
+          0.000756705 0.00477728 0.00858263 0.0112698 0.0134398 0.0145095 0.0154302 0.017041 0.01823 0.0198185 0.0208768 0.0216189
+          0.0221997 0.0226207 0.0232958 0.0240597 0.0247199 0.0253283 0.00523998 0.0130284 0.0142058 0.0114789 0.00892958 0.00658129
+          0.00408165 0.00105095 0.00287516 0.00650058 0.00970655 0.012139 0.0137745 0.0150032 0.0160626 0.0173569 0.0183577 0.0195088
+          0.0203225 0.0209171 0.0214209 0.0217619 0.0221419 0.0226508 0.0230726 0.0235717 0.0238752 0.0241531 0.024413 0.0246372
+          0.000939954 0.00304086 0.00376166 0.00377906 0.00517042 0.00721443 0.00969929 0.0118573 0.0134505 0.0149003 0.0160101 0.0170582
+          0.0179012 0.0186511 0.0191389 0.0195216 0.0198219 0.0200397 0.0202792 0.0205982 0.020839 0.0211415 0.0213396 0.0214798
+          0.0215965 0.0216788 0.0218215 0.0219702 0.0221016 0.022143 0.000230443 0.00107947 0.00385888 0.00745113 0.0102454 0.0125997
+          0.0140952 0.015227 0.0159309 0.0164198 0.0167007 0.0169112 0.0170286 0.0171389 0.0172464 0.017369 0.0174591 0.017562
+          0.0176236 0.0176601 0.017683 0.0176911 0.0177061 0.0177414 0.0177689 0.0178068 0.0178228 0.0178331 0.0178424 0.0178233
+          0.00388252 0.00838527 0.00995142 0.0113445 0.0118899 0.0123467 0.0125269 0.0126434 0.0126361 0.0126067 0.0125368 0.0124706
+          0.0124069 0.0123624 0.012324 0.0122921 0.0122618 0.0122239 0.0121797 0.0121419 0.0120975 0.0120676 0.0120386 0.0120129
+          0.0119889 0.0119624 0.0119377 0.0119166 0.011897 0.0119003 0.00706381 0.00662279 0.00634667 0.00607164 0.0058757 0.00570178
+          0.00556726 0.00545455 0.00536634 0.00529241 0.00523123 0.00517756 0.00512911 0.00508438 0.00504394 0.00500734 0.0049738 0.00494399
+          0.00491742 0.00489189 0.00486933 0.00484638 0.00482588 0.00480623 0.00478852 0.00477173 0.00475593 0.00473989 0.00472445 0.00470784
+        </DataArray>
+        <DataArray type="Float32" Name="l_mix" NumberOfComponents="1" format="ascii">
+          0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025
+          0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025
+          0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075
+          0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075
+          0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075
+          0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125
+          0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125
+          0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175
+          0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175
+          0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175
+          0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225
+          0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225
+          0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275
+          0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275
+          0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275
+          0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325
+          0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325
+          0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375
+          0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375
+          0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375
+          0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425
+          0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425
+          0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475
+          0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475
+          0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475
+          0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475
+          0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.19475
+          0.19475 0.19475 0.19475 0.19475 0.19475 0.19475 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425
+          0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425
+          0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425 0.17425
+          0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375
+          0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.15375
+          0.15375 0.15375 0.15375 0.15375 0.15375 0.15375 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325
+          0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325
+          0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325 0.13325
+          0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275
+          0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.11275
+          0.11275 0.11275 0.11275 0.11275 0.11275 0.11275 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225
+          0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225
+          0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225 0.09225
+          0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175
+          0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.07175
+          0.07175 0.07175 0.07175 0.07175 0.07175 0.07175 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125
+          0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125
+          0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125 0.05125
+          0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075
+          0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.03075
+          0.03075 0.03075 0.03075 0.03075 0.03075 0.03075 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025
+          0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025
+          0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025 0.01025
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          46.2357 44.8969 43.9305 42.9105 42.2007 41.5852 41.132 40.7479 40.4243 40.1466 39.9237 39.7205
+          39.5416 39.3615 39.1911 39.0316 38.898 38.7811 38.6814 38.578 38.478 38.3765 38.2951 38.2236
+          38.1696 38.0957 38.0256 37.9533 37.8938 37.8348 95.6449 96.8778 96.6406 96.1989 95.4174 94.6619
+          93.9209 93.2763 92.6569 92.1074 91.6423 91.2297 90.8552 90.5092 90.1748 89.8702 89.6208 89.3992
+          89.1955 88.9897 88.7758 88.5725 88.4125 88.2769 88.1768 88.0286 87.8855 87.7436 87.6306 87.5475
+          99.4016 105.626 108.029 110.015 110.498 110.699 110.444 110.222 109.85 109.5 109.133 108.804
+          108.477 108.202 107.933 107.716 107.545 107.402 107.244 107.077 106.875 106.695 106.56 106.464
+          106.402 106.283 106.157 106.036 105.948 105.911 99.3414 105.647 108.964 112.393 114.275 115.801
+          116.582 117.218 117.449 117.548 117.509 117.496 117.406 117.369 117.276 117.217 117.177 117.159
+          117.106 117.051 116.938 116.851 116.793 116.77 116.772 116.708 116.638 116.574 116.541 116.536
+          98.7216 104.127 106.981 110.467 113.01 115.36 117.049 118.509 119.539 120.399 120.998 121.528
+          121.859 122.144 122.291 122.49 122.653 122.845 122.961 123.063 123.075 123.112 123.155 123.24
+          123.335 123.364 123.373 123.386 123.426 123.477 96.9114 101.084 104.471 108.086 110.897 113.405
+          115.392 117.185 118.678 120.034 121.166 122.178 123.018 123.832 124.439 125.032 125.521 125.961
+          126.256 126.57 126.752 126.972 127.161 127.38 127.584 127.718 127.824 127.941 128.077 128.217
+          95.3 98.2264 102.114 105.956 108.934 111.544 113.685 115.624 117.251 118.705 120.017 121.243
+          122.37 123.508 124.465 125.359 126.178 126.966 127.616 128.248 128.695 129.12 129.456 129.853
+          130.2 130.49 130.716 130.956 131.201 131.463 95.3793 97.9784 101.067 104.461 107.391 110.027
+          112.26 114.289 116 117.544 118.932 120.253 121.459 122.642 123.695 124.711 125.694 126.681
+          127.575 128.405 129.089 129.776 130.391 131.038 131.592 132.034 132.39 132.796 133.183 133.624
+          95.4777 97.9191 100.574 103.698 106.571 109.172 111.372 113.389 115.1 116.664 118.08 119.451
+          120.694 121.93 123.018 124.083 125.112 126.123 127.071 127.968 128.766 129.587 130.367 131.142
+          131.871 132.521 133.09 133.68 134.249 134.932 95.6802 98.2833 100.73 103.542 106.22 108.689
+          110.829 112.822 114.522 116.103 117.524 118.902 120.166 121.398 122.522 123.624 124.69 125.763
+          126.718 127.65 128.464 129.27 130.101 130.919 131.722 132.458 133.132 133.818 134.55 135.471
+          95.5055 98.0181 100.521 103.415 106.199 108.81 111.115 113.23 114.995 116.617 118.059 119.432
+          120.699 121.897 122.998 124.059 125.096 126.127 127.054 127.958 128.753 129.538 130.338 131.134
+          131.916 132.633 133.282 133.938 134.63 135.505 95.3741 97.9711 100.82 103.899 106.689 109.316
+          111.652 113.786 115.567 117.175 118.612 119.972 121.215 122.405 123.458 124.478 125.472 126.429
+          127.347 128.208 128.979 129.79 130.522 131.252 131.944 132.566 133.11 133.662 134.182 134.808
+          95.2423 98.0462 101.551 104.99 107.803 110.434 112.719 114.8 116.533 118.079 119.462 120.761
+          121.955 123.088 124.106 125.071 126.015 126.961 127.798 128.565 129.197 129.855 130.43 131.032
+          131.548 131.956 132.293 132.673 133.036 133.444 96.6301 100.438 103.365 106.547 109.253 111.867
+          114.083 116.106 117.757 119.219 120.517 121.716 122.831 123.904 124.793 125.616 126.366 127.102
+          127.701 128.277 128.674 129.053 129.365 129.741 130.072 130.337 130.551 130.775 131.006 131.249
+          98.1798 102.893 105.198 108.308 110.9 113.497 115.623 117.567 119.096 120.425 121.51 122.464
+          123.255 124.013 124.565 125.096 125.522 125.9 126.172 126.46 126.621 126.818 126.993 127.201
+          127.398 127.519 127.621 127.73 127.857 127.986 98.5398 103.782 106.671 110.116 112.619 115.08
+          116.904 118.477 119.519 120.383 120.97 121.464 121.767 122.034 122.182 122.362 122.507 122.669
+          122.772 122.862 122.868 122.898 122.94 123.024 123.119 123.143 123.15 123.162 123.199 123.244
+          98.8749 104.534 107.439 110.633 112.663 114.545 115.686 116.561 116.9 117.108 117.137 117.163
+          117.118 117.096 117.019 116.967 116.927 116.901 116.85 116.798 116.687 116.607 116.553 116.536
+          116.543 116.481 116.415 116.354 116.323 116.317 98.6664 103.736 105.653 107.669 108.525 109.233
+          109.397 109.458 109.229 108.964 108.652 108.371 108.089 107.85 107.61 107.409 107.245 107.105
+          106.956 106.8 106.612 106.445 106.322 106.237 106.185 106.071 105.953 105.839 105.757 105.725
+          95.4647 96.4264 95.9996 95.4549 94.7303 94.0483 93.3718 92.7776 92.1864 91.665 91.2175 90.8278
+          90.4753 90.1551 89.8419 89.5603 89.3264 89.1223 88.9347 88.7462 88.5475 88.3601 88.2135 88.0915
+          88.0031 87.8649 87.731 87.5987 87.4946 87.4213 46.1653 44.7219 43.7691 42.7972 42.1119 41.4853
+          40.9984 40.5876 40.2492 39.9619 39.7355 39.5391 39.3632 39.1963 39.0343 38.8867 38.7624 38.6575
+          38.5659 38.472 38.3797 38.2855 38.2114 38.1471 38.0989 38.0309 37.9652 37.8983 37.8437 37.7912
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          46.2534 44.8746 43.9305 42.9347 42.2039 41.5852 41.1238 40.7281 40.4243 40.1652 39.9357 39.7205
+          39.5287 39.3432 39.1911 39.0497 38.9121 38.7811 38.6667 38.5602 38.478 38.3944 38.3106 38.2236
+          38.1378 38.0778 38.0256 37.9713 37.91 37.8348 138.76 134.624 131.792 128.804 126.612 124.756
+          123.372 122.184 121.273 120.496 119.807 119.162 118.586 118.03 117.573 117.149 116.736 116.343
+          116 115.68 115.434 115.183 114.932 114.671 114.413 114.233 114.077 113.914 113.73 113.504
+          231.267 224.373 219.653 214.673 211.02 207.926 205.619 203.641 202.121 200.826 199.679 198.603
+          197.644 196.716 195.955 195.248 194.561 193.906 193.333 192.801 192.39 191.972 191.553 191.118
+          190.689 190.389 190.128 189.857 189.55 189.174 323.774 314.122 307.514 300.543 295.427 291.096
+          287.867 285.097 282.97 281.156 279.55 278.044 276.701 275.402 274.338 273.348 272.385 271.468
+          270.667 269.921 269.346 268.761 268.174 267.565 266.965 266.545 266.179 265.799 265.37 264.843
+          416.28 403.871 395.375 386.412 379.835 374.267 370.115 366.553 363.818 361.487 359.422 357.485
+          355.759 354.089 352.72 351.447 350.209 349.03 348 347.041 346.302 345.55 344.796 344.012
+          343.241 342.701 342.23 341.742 341.19 340.513 508.787 493.62 483.236 472.281 464.243 457.437
+          452.362 448.009 444.667 441.817 439.293 436.926 434.816 432.775 431.102 429.547 428.034 426.592
+          425.334 424.162 423.258 422.339 421.417 420.46 419.516 418.856 418.281 417.684 417.01 416.182
+          601.294 583.37 571.097 558.151 548.651 540.608 534.61 529.465 525.515 522.148 519.165 516.367
+          513.874 511.461 509.484 507.646 505.858 504.154 502.667 501.282 500.214 499.128 498.038 496.907
+          495.792 495.012 494.332 493.627 492.83 491.852 693.801 673.119 658.958 644.02 633.059 623.778
+          616.858 610.922 606.364 602.478 599.036 595.808 592.931 590.148 587.866 585.745 583.682 581.717
+          580 578.402 577.17 575.917 574.66 573.354 572.068 571.167 570.383 569.57 568.65 567.521
+          786.308 762.868 746.819 729.889 717.467 706.948 699.105 692.378 687.212 682.809 678.907 675.249
+          671.989 668.834 666.249 663.845 661.506 659.279 657.334 655.523 654.126 652.705 651.281 649.801
+          648.343 647.323 646.434 645.512 644.47 643.191 878.814 852.617 834.68 815.759 801.875 790.119
+          781.353 773.834 768.061 763.139 758.779 754.69 751.046 747.52 744.631 741.944 739.331 736.841
+          734.667 732.643 731.082 729.494 727.902 726.248 724.619 723.479 722.486 721.455 720.29 718.86
+          877.516 849.272 831.612 813.606 800.202 788.222 778.811 770.769 764.734 759.646 755.218 751.243
+          747.643 744.376 741.652 739.195 736.762 734.493 732.467 730.628 729.215 727.767 726.317 724.795
+          723.268 722.246 721.339 720.409 719.341 718.032 785.146 759.875 744.074 727.964 715.97 705.251
+          696.831 689.636 684.236 679.684 675.721 672.165 668.944 666.02 663.584 661.385 659.208 657.178
+          655.365 653.72 652.455 651.16 649.862 648.501 647.135 646.22 645.409 644.577 643.621 642.45
+          692.776 670.478 656.536 642.321 631.739 622.28 614.851 608.502 603.737 599.721 596.224 593.087
+          590.244 587.665 585.515 583.575 581.654 579.863 578.263 576.812 575.696 574.553 573.408 572.206
+          571.001 570.194 569.479 568.744 567.901 566.868 600.406 581.081 568.998 556.678 547.507 539.31
+          532.871 527.368 523.239 519.758 516.728 514.009 511.545 509.31 507.446 505.765 504.1 502.548
+          501.161 499.903 498.936 497.946 496.954 495.912 494.868 494.168 493.548 492.912 492.181 491.285
+          508.036 491.684 481.46 471.035 463.275 456.339 450.891 446.235 442.741 439.795 437.231 434.93
+          432.846 430.954 429.378 427.955 426.546 425.233 424.06 422.995 422.177 421.339 420.499 419.618
+          418.734 418.143 417.618 417.079 416.461 415.703 415.665 402.287 393.921 385.392 379.043 373.368
+          368.911 365.101 362.242 359.833 357.735 355.852 354.147 352.599 351.309 350.145 348.993 347.918
+          346.958 346.087 345.418 344.732 344.045 343.324 342.601 342.117 341.687 341.246 340.741 340.121
+          323.295 312.89 306.383 299.75 294.811 290.397 286.93 283.968 281.744 279.87 278.238 276.774
+          275.447 274.244 273.24 272.335 271.439 270.603 269.856 269.179 268.658 268.125 267.59 267.03
+          266.467 266.091 265.757 265.414 265.02 264.538 230.925 223.493 218.845 214.107 210.58 207.427
+          204.95 202.834 201.246 199.907 198.741 197.696 196.748 195.888 195.172 194.525 193.885 193.288
+          192.754 192.271 191.899 191.518 191.136 190.735 190.334 190.065 189.826 189.581 189.3 188.956
+          138.555 134.096 131.307 128.464 126.348 124.456 122.97 121.7 120.747 119.944 119.245 118.617
+          118.049 117.533 117.103 116.715 116.331 115.973 115.653 115.362 115.139 114.911 114.682 114.441
+          114.2 114.039 113.896 113.749 113.58 113.374 46.1851 44.6985 43.7691 42.8214 42.1159 41.4853
+          40.9901 40.5668 40.2492 39.9814 39.7483 39.5391 39.3496 39.1777 39.0343 38.905 38.7769 38.6575
+          38.5509 38.4541 38.3797 38.3035 38.2272 38.1471 38.0667 38.013 37.9652 37.9163 37.8601 37.7912
+        </DataArray>
+        <DataArray type="Float32" Name="D_t" NumberOfComponents="1" format="ascii">
+          0.00441925 0.00407261 0.00383926 0.00360171 0.00343511 0.00329681 0.00319569 0.00311107 0.00304451 0.00298857 0.00294088 0.0028972
+          0.0028585 0.00282106 0.00278883 0.00275915 0.00273175 0.00270664 0.00268484 0.00266405 0.00264663 0.00262911 0.00261284 0.00259696
+          0.0025824 0.00256985 0.00255856 0.002547 0.00253529 0.00252196 0.00361837 0.00781951 0.00946174 0.010894 0.0113392 0.0116267
+          0.0116425 0.011633 0.0115589 0.0114769 0.0113813 0.0113024 0.011222 0.0111726 0.0111275 0.0110929 0.0110631 0.0110297
+          0.0109868 0.0109513 0.0109107 0.0108818 0.0108559 0.0108328 0.010811 0.0107898 0.0107695 0.0107532 0.0107378 0.0107434
+          0.00187951 0.0052089 0.00799385 0.0102926 0.0119613 0.0131743 0.0139463 0.0146552 0.0151618 0.0156036 0.0158385 0.0159975
+          0.0160955 0.0161739 0.0162714 0.016409 0.0165129 0.0166346 0.0167195 0.0167724 0.0168058 0.0168296 0.0168508 0.0168973
+          0.0169379 0.016988 0.0170182 0.0170418 0.0170627 0.0170582 0.00406092 0.0100759 0.0100464 0.00622712 0.00166208 0.00315216
+          0.00714609 0.0101879 0.012235 0.0135563 0.014633 0.0157814 0.0166405 0.0175319 0.0180873 0.0184764 0.0187921 0.0190377
+          0.0192658 0.0196083 0.0198915 0.0202198 0.0204628 0.020627 0.0207571 0.0208627 0.0210149 0.0211816 0.0213371 0.0213996
+          0.000244293 0.00123507 0.00308649 0.00839224 0.00931483 0.00934962 0.0074663 0.00496365 0.00120568 0.00345771 0.00729208 0.0100861
+          0.0122567 0.0134541 0.0145001 0.0159653 0.0170662 0.0183327 0.0192919 0.0199492 0.0204655 0.0208687 0.0212289 0.0217624
+          0.0222288 0.0227548 0.0231012 0.0234088 0.0236836 0.0239333 0.0285475 0.0479041 0.0325615 0.021949 0.0161595 0.0134634
+          0.0118217 0.0107826 0.0100489 0.0101104 0.00862074 0.00635624 0.00283913 0.00229197 0.00674174 0.00963126 0.0121507 0.0133733
+          0.0141651 0.0158047 0.0171395 0.018811 0.0200475 0.0208593 0.0214397 0.0219143 0.0225726 0.023362 0.0240838 0.0247276
+          0.00482877 0.00650927 0.00330166 0.0124219 0.0164341 0.0176324 0.0165361 0.0148757 0.0131118 0.0110235 0.00956849 0.00861308
+          0.00809108 0.00919295 0.00892118 0.00743495 0.00491726 0.000756443 0.00497242 0.00838602 0.0112732 0.0125574 0.0134047 0.0153682
+          0.0170441 0.0190985 0.020262 0.0212598 0.0221361 0.0232875 0.00413364 0.0156139 0.024442 0.0236684 0.0189161 0.0160612
+          0.0147173 0.0142647 0.0142465 0.014545 0.0144138 0.0131638 0.0118027 0.00912068 0.00704357 0.00597855 0.00525789 0.00648968
+          0.00760076 0.00736305 0.00549592 0.00113358 0.00460303 0.00792638 0.0105719 0.0114229 0.0129193 0.0154868 0.017623 0.0202424
+          0.0089689 0.0179312 0.0139426 0.00402253 0.0035625 0.0079866 0.0104817 0.0111928 0.0109864 0.00977942 0.00887993 0.00874591
+          0.00918943 0.0108246 0.0123011 0.0120617 0.0114693 0.00909089 0.00590796 0.00411271 0.00293203 0.00465082 0.00662002 0.0069742
+          0.00498251 0.000656288 0.00485634 0.00712186 0.00989135 0.013809 0.00180559 0.00596556 0.0105172 0.0117154 0.0104458 0.0101839
+          0.00937246 0.00920982 0.00974489 0.0104018 0.0112232 0.01099 0.0094692 0.00753261 0.00417689 0.00294509 0.00219853 0.00266073
+          0.00634815 0.00719846 0.00802734 0.00640486 0.00199637 0.000173239 0.00051154 0.00273732 0.00447255 0.00361745 0.00127681 0.00325334
+          0.0128551 0.0233469 0.015001 0.00558831 0.000657345 0.00428384 0.00624733 0.00755156 0.00873721 0.00956077 0.0104546 0.0103821
+          0.00890435 0.00699228 0.00356662 0.00200574 0.00108339 0.00116518 0.00461884 0.00549463 0.00648486 0.0048847 0.000545362 0.00199442
+          0.00250636 0.00124404 0.00214851 0.000800228 0.00284502 0.00788062 0.00541683 0.0169846 0.0225197 0.0211705 0.0164803 0.0134392
+          0.0127215 0.0120774 0.0115095 0.0102999 0.00933423 0.00885715 0.00921347 0.0104048 0.0115851 0.0114828 0.0108905 0.00846612
+          0.00539511 0.00336084 0.00179794 0.00386104 0.00550034 0.00521068 0.00284816 0.00268377 0.0070053 0.00905951 0.0114048 0.0148807
+          0.00802686 0.0111414 0.00344016 0.0127773 0.016554 0.0186059 0.0175087 0.0163932 0.0154215 0.0146314 0.0138882 0.0126413
+          0.0110611 0.00867657 0.00682682 0.0055341 0.00471469 0.00628942 0.00668505 0.00598476 0.00383279 0.00145178 0.00649091 0.00930518
+          0.0116733 0.0124393 0.0139882 0.0164468 0.0183218 0.0207142 0.0361506 0.0587166 0.0355052 0.0217937 0.016321 0.0140204
+          0.0131544 0.0126144 0.011599 0.0104744 0.00930899 0.0082862 0.00791199 0.00852843 0.00749518 0.00581895 0.00285799 0.00215085
+          0.00679247 0.0097242 0.0123343 0.0133591 0.0142964 0.0162001 0.0176907 0.0196204 0.0206306 0.021538 0.0224116 0.023493
+          0.00180368 0.00502872 0.00282449 0.00981807 0.0117028 0.0127624 0.0118695 0.0109545 0.00985524 0.00875236 0.00664451 0.00404638
+          0.000738405 0.00466158 0.00837133 0.0109855 0.0130883 0.0141177 0.0150102 0.0165807 0.0177442 0.0192969 0.0203339 0.0210652
+          0.0216409 0.0220626 0.0227322 0.0234894 0.0241462 0.024755 0.00495598 0.0123354 0.0134723 0.0109106 0.00850723 0.00628263
+          0.00390221 0.00100583 0.00275439 0.00623107 0.00930671 0.0116376 0.0132018 0.0143807 0.0154058 0.0166612 0.0176363 0.0187554
+          0.0195502 0.0201361 0.020636 0.0209801 0.021362 0.0218685 0.0222912 0.0227891 0.0230983 0.0233833 0.0236509 0.0238838
+          0.00088847 0.0028748 0.00355747 0.00357558 0.00489437 0.00683203 0.00918736 0.011232 0.0127441 0.0141266 0.0151919 0.0162008
+          0.0170151 0.0177409 0.0182184 0.0185972 0.0188984 0.0191216 0.0193654 0.0196854 0.0199308 0.0202355 0.0204406 0.0205904
+          0.0207177 0.0208121 0.0209645 0.0211226 0.0212641 0.0213178 0.00021745 0.00101818 0.0036388 0.00702382 0.00965583 0.0118725
+          0.0132807 0.0143465 0.0150102 0.015473 0.0157415 0.0159453 0.0160624 0.0161736 0.0162827 0.0164069 0.0165008 0.0166073
+          0.0166752 0.0167199 0.016752 0.0167703 0.016795 0.0168392 0.0168759 0.0169229 0.0169492 0.0169701 0.0169897 0.0169811
+          0.0035667 0.00767337 0.00908098 0.0103195 0.0107887 0.0111763 0.0113178 0.0114036 0.0113828 0.0113443 0.0112716 0.0112038
+          0.0111398 0.0110943 0.0110562 0.0110249 0.0109955 0.01096 0.0109198 0.0108861 0.0108479 0.0108227 0.0107984 0.010777
+          0.0107572 0.0107366 0.010718 0.0107028 0.0106882 0.0106932 0.0044014 0.00402908 0.00380045 0.00357539 0.0034151 0.00327473
+          0.00316659 0.0030766 0.00300745 0.00295002 0.00290192 0.00285985 0.00282194 0.00278749 0.00275721 0.00273012 0.00270476 0.0026821
+          0.00266197 0.00264318 0.00262736 0.00261134 0.00259657 0.0025821 0.00256867 0.00255733 0.00254694 0.00253642 0.00252571 0.00251363
+        </DataArray>
+      </CellData>
       <Points>
         <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
           0 0 0 0.1 0 0 0 0.05 0 0.1 0.05 0
diff --git a/test/references/zeroeq2cni-reference.vtu b/test/references/zeroeq2cni-reference.vtu
index 7f1c2eb68e3f4b806283ee707c1c84ba56337f19..959ed82d2db1165bbe47dd99f5ab51f84e06a498 100644
--- a/test/references/zeroeq2cni-reference.vtu
+++ b/test/references/zeroeq2cni-reference.vtu
@@ -459,6 +459,177 @@
           1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05 1.72735e-05
           1.72735e-05 1.72735e-05 1.72735e-05
         </DataArray>
+        <DataArray type="Float32" Name="D" NumberOfComponents="1" format="ascii">
+          2.47641e-05 2.47642e-05 2.62845e-05 2.62786e-05 2.47641e-05 2.62725e-05 2.47642e-05 2.62665e-05 2.47641e-05 2.62603e-05 2.47642e-05 2.62543e-05
+          2.47641e-05 2.62481e-05 2.47642e-05 2.62422e-05 2.47641e-05 2.62362e-05 2.47642e-05 2.62304e-05 2.47641e-05 2.62246e-05 2.47641e-05 2.62189e-05
+          2.4764e-05 2.62133e-05 2.47641e-05 2.62078e-05 2.4764e-05 2.62024e-05 2.47641e-05 2.61971e-05 2.4764e-05 2.61918e-05 2.47641e-05 2.61867e-05
+          2.4764e-05 2.61816e-05 2.4764e-05 2.61766e-05 2.4764e-05 2.61717e-05 2.4764e-05 2.61669e-05 2.4764e-05 2.61621e-05 2.4764e-05 2.61575e-05
+          2.47639e-05 2.61529e-05 2.4764e-05 2.61484e-05 2.47639e-05 2.61439e-05 2.47639e-05 2.61396e-05 2.47639e-05 2.61354e-05 2.47639e-05 2.61313e-05
+          2.47639e-05 2.62493e-05 2.62851e-05 2.62849e-05 2.62842e-05 2.62837e-05 2.62828e-05 2.62822e-05 2.62814e-05 2.62808e-05 2.628e-05 2.62794e-05
+          2.62786e-05 2.6278e-05 2.62771e-05 2.62764e-05 2.62755e-05 2.62747e-05 2.62737e-05 2.62729e-05 2.62719e-05 2.6271e-05 2.627e-05 2.6269e-05
+          2.62679e-05 2.62669e-05 2.62658e-05 2.62647e-05 2.62636e-05 2.62625e-05 2.62614e-05 2.62606e-05 2.63463e-05 2.62845e-05 2.62846e-05 2.62845e-05
+          2.62845e-05 2.62843e-05 2.62843e-05 2.62841e-05 2.62841e-05 2.62838e-05 2.62838e-05 2.62836e-05 2.62836e-05 2.62834e-05 2.62833e-05 2.62831e-05
+          2.6283e-05 2.62828e-05 2.62827e-05 2.62825e-05 2.62824e-05 2.62821e-05 2.6282e-05 2.62817e-05 2.62816e-05 2.62813e-05 2.62811e-05 2.62808e-05
+          2.62806e-05 2.62804e-05 2.62805e-05 2.63461e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.6285e-05 2.62851e-05
+          2.6285e-05 2.6285e-05 2.62849e-05 2.62849e-05 2.62848e-05 2.62849e-05 2.62847e-05 2.62848e-05 2.62846e-05 2.62847e-05 2.62845e-05 2.62845e-05
+          2.62844e-05 2.62844e-05 2.62843e-05 2.62843e-05 2.62842e-05 2.62841e-05 2.6284e-05 2.6284e-05 2.62839e-05 2.62842e-05 2.63441e-05 2.62845e-05
+          2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62846e-05 2.62846e-05 2.62846e-05 2.6285e-05 2.63347e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05
+          2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05
+          2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.62849e-05 2.6285e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62853e-05
+          2.63329e-05 2.62845e-05 2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62847e-05 2.62847e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05
+          2.62848e-05 2.62848e-05 2.62849e-05 2.62848e-05 2.62849e-05 2.62849e-05 2.62854e-05 2.63277e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62853e-05
+          2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62851e-05 2.6285e-05 2.62851e-05
+          2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.62849e-05 2.62849e-05
+          2.62849e-05 2.62854e-05 2.63269e-05 2.62845e-05 2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62846e-05 2.62847e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62848e-05
+          2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62854e-05 2.63239e-05 2.62851e-05 2.62853e-05
+          2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62851e-05
+          2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05
+          2.62849e-05 2.6285e-05 2.62849e-05 2.62855e-05 2.63244e-05 2.62845e-05 2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05
+          2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62854e-05 2.63239e-05
+          2.62851e-05 2.62853e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05
+          2.62851e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05
+          2.6285e-05 2.6285e-05 2.62849e-05 2.6285e-05 2.62849e-05 2.62854e-05 2.63268e-05 2.62845e-05 2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05
+          2.62848e-05 2.62847e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62849e-05
+          2.62854e-05 2.63277e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05
+          2.62851e-05 2.62852e-05 2.62851e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.6285e-05
+          2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.62849e-05 2.6285e-05 2.62849e-05 2.62853e-05 2.6333e-05 2.62845e-05 2.62847e-05 2.62845e-05
+          2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62847e-05 2.62848e-05 2.62847e-05
+          2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62849e-05 2.62849e-05
+          2.62849e-05 2.62849e-05 2.62853e-05 2.6335e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05
+          2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05
+          2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.62849e-05 2.6285e-05 2.62849e-05 2.62853e-05 2.63451e-05 2.62845e-05
+          2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62847e-05
+          2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05
+          2.62849e-05 2.62849e-05 2.62849e-05 2.62849e-05 2.62852e-05 2.63509e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62852e-05
+          2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05
+          2.6285e-05 2.62851e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.62849e-05 2.6285e-05 2.62849e-05 2.62852e-05
+          2.63717e-05 2.62845e-05 2.62847e-05 2.62845e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05 2.62847e-05 2.62846e-05
+          2.62847e-05 2.62847e-05 2.62847e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62847e-05 2.62848e-05 2.62848e-05 2.62848e-05 2.62848e-05
+          2.62848e-05 2.62848e-05 2.62849e-05 2.62848e-05 2.62849e-05 2.62849e-05 2.6285e-05 2.64088e-05 2.62851e-05 2.62853e-05 2.62851e-05 2.62853e-05
+          2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62852e-05 2.62851e-05 2.62851e-05 2.6285e-05 2.62851e-05
+          2.6285e-05 2.62851e-05 2.6285e-05 2.62851e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.6285e-05 2.62849e-05 2.6285e-05
+          2.62849e-05 2.62849e-05 2.62849e-05
+        </DataArray>
+        <DataArray type="Float32" Name="lambda" 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 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 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>
+        <DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
+          297 297 307 306.961 297 306.922 297 306.882 297 306.843 297 306.803
+          297 306.763 297 306.724 297 306.686 297 306.647 297 306.61 297 306.573
+          297 306.537 297 306.501 297 306.465 297 306.431 297 306.397 297 306.363
+          297 306.33 297 306.297 297 306.266 297 306.234 297 306.203 297 306.173
+          297 306.143 297 306.113 297 306.084 297 306.056 297 306.029 297 306.002
+          297 306.769 307 306.998 306.994 306.99 306.985 306.981 306.976 306.972 306.967 306.963
+          306.958 306.953 306.948 306.943 306.938 306.932 306.927 306.921 306.915 306.909 306.902 306.896
+          306.889 306.882 306.876 306.868 306.861 306.854 306.847 306.842 307.398 307 307 306.999
+          306.999 306.998 306.997 306.997 306.996 306.995 306.994 306.993 306.993 306.992 306.991 306.99
+          306.989 306.988 306.987 306.985 306.984 306.983 306.982 306.98 306.979 306.977 306.976 306.974
+          306.972 306.971 306.971 307.397 307 307 307 307 307 307 306.999 306.999
+          306.999 306.999 306.999 306.999 306.998 306.998 306.998 306.998 306.997 306.997 306.997 306.997
+          306.996 306.996 306.996 306.995 306.995 306.995 306.994 306.994 306.993 306.995 307.384 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 306.999 306.999 306.999 306.999 306.999 306.999 306.999 306.999 306.999
+          306.999 306.999 306.998 306.998 307.001 307.323 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307.002
+          307.311 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307.003 307.278 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307.003 307.272 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307.003 307.253 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307.004 307.256 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307.004 307.253
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307.003 307.272 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307.003 307.278 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307.003 307.312 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307.003 307.325 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307.002 307.391 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307.002 307.428 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307.002
+          307.563 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307.001 307.803 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307 307 307 307 307 307 307 307 307 307
+          307 307 307
+        </DataArray>
         <DataArray type="Float32" Name="v" NumberOfComponents="3" format="ascii">
           0 0 0 0 0 0 0.5 0 0 0.46842 8.18961e-17 0
           0 0 0 0.432948 6.74151e-17 0 0 0 0 0.422668 7.11098e-17 0
@@ -624,64 +795,321 @@
           0 0 0 0 0 0 0 0 0 0 0 0
           0 0 0 0 0 0 0 0 0
         </DataArray>
-        <DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
-          297 297 307 306.961 297 306.922 297 306.882 297 306.843 297 306.803
-          297 306.763 297 306.724 297 306.686 297 306.647 297 306.61 297 306.573
-          297 306.537 297 306.501 297 306.465 297 306.431 297 306.397 297 306.363
-          297 306.33 297 306.297 297 306.266 297 306.234 297 306.203 297 306.173
-          297 306.143 297 306.113 297 306.084 297 306.056 297 306.029 297 306.002
-          297 306.769 307 306.998 306.994 306.99 306.985 306.981 306.976 306.972 306.967 306.963
-          306.958 306.953 306.948 306.943 306.938 306.932 306.927 306.921 306.915 306.909 306.902 306.896
-          306.889 306.882 306.876 306.868 306.861 306.854 306.847 306.842 307.398 307 307 306.999
-          306.999 306.998 306.997 306.997 306.996 306.995 306.994 306.993 306.993 306.992 306.991 306.99
-          306.989 306.988 306.987 306.985 306.984 306.983 306.982 306.98 306.979 306.977 306.976 306.974
-          306.972 306.971 306.971 307.397 307 307 307 307 307 307 306.999 306.999
-          306.999 306.999 306.999 306.999 306.998 306.998 306.998 306.998 306.997 306.997 306.997 306.997
-          306.996 306.996 306.996 306.995 306.995 306.995 306.994 306.994 306.993 306.995 307.384 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 306.999 306.999 306.999 306.999 306.999 306.999 306.999 306.999 306.999
-          306.999 306.999 306.998 306.998 307.001 307.323 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307.002
-          307.311 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307.003 307.278 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307.003 307.272 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307.003 307.253 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307.004 307.256 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307.004 307.253
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307.003 307.272 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307.003 307.278 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307.003 307.312 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307.003 307.325 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307.002 307.391 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307.002 307.428 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307.002
-          307.563 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307.001 307.803 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307 307 307 307 307 307 307 307 307 307
-          307 307 307
-        </DataArray>
       </PointData>
+      <CellData Scalars="mu_t">
+        <DataArray type="Float32" Name="mu_t" NumberOfComponents="1" format="ascii">
+          0.00231078 0.00217235 0.00207693 0.00199621 0.00194893 0.00191194 0.00188976 0.00187224 0.00186112 0.00185203 0.0018461 0.00184116
+          0.00183775 0.00183472 0.00183242 0.00183038 0.00182893 0.00182774 0.00182684 0.00182597 0.00182517 0.00182449 0.00182398 0.00182372
+          0.00182355 0.00182336 0.0018232 0.00182379 0.00182501 0.00182629 0.000542587 0.00127932 0.00161638 0.00180893 0.00183016 0.00182344
+          0.00177664 0.00173049 0.00167753 0.00163009 0.00158511 0.00154578 0.00151075 0.00148028 0.00145379 0.00143079 0.00141109 0.00139398
+          0.00137942 0.00136671 0.00135591 0.00134653 0.00133876 0.00133222 0.00132726 0.00132371 0.00132224 0.00132363 0.00132911 0.00133557
+          0.000878954 0.00227547 0.00333706 0.0042887 0.00488303 0.00529107 0.00552777 0.00568759 0.0057848 0.00585618 0.00590389 0.0059422
+          0.00596991 0.00599319 0.00601088 0.00602606 0.00603824 0.00604879 0.00605753 0.00606484 0.00607103 0.00607596 0.00608059 0.00608384
+          0.0060873 0.00608804 0.00608809 0.00608147 0.00606891 0.00604036 0.00150604 0.00332185 0.00387284 0.00406874 0.00392469 0.00369502
+          0.00343782 0.00318332 0.00295933 0.00275317 0.00257975 0.00242304 0.00229195 0.00217389 0.00207477 0.00198556 0.00191039 0.00184276
+          0.00178559 0.00173419 0.00169063 0.00165172 0.00161897 0.00159058 0.00156782 0.00155108 0.00154088 0.00154226 0.00155423 0.0015822
+          0.00119357 0.00293031 0.00414478 0.00532607 0.006178 0.0069621 0.00753488 0.00801741 0.00836335 0.00864776 0.00885611 0.00902985
+          0.00916119 0.00927255 0.00935883 0.00943296 0.00949164 0.00954256 0.00958351 0.00961893 0.00964786 0.00967246 0.00969336 0.00970998
+          0.00972492 0.00973288 0.00973824 0.00972604 0.0096962 0.00956665 0.0022833 0.00515712 0.00670322 0.00769112 0.00787602 0.00789116
+          0.00768546 0.00745608 0.00718758 0.0069362 0.00670113 0.00649156 0.00630926 0.0061497 0.00601475 0.00589753 0.00579961 0.0057148
+          0.00564426 0.00558315 0.00553236 0.00548868 0.00545277 0.00542329 0.00540081 0.00538719 0.00538338 0.0053989 0.00543686 0.00548827
+          0.00187427 0.0044864 0.00610363 0.00736824 0.0081133 0.00890227 0.00950345 0.0101026 0.0105589 0.0109737 0.0112857 0.0115587
+          0.0117652 0.0119443 0.0120817 0.012201 0.0122942 0.0123754 0.0124399 0.0124958 0.012541 0.0125793 0.0126116 0.0126365
+          0.0126584 0.0126677 0.0126722 0.0126424 0.0125836 0.0124288 0.00282043 0.00640646 0.00869841 0.0102752 0.0108174 0.0111821
+          0.0111657 0.011124 0.0109506 0.0107994 0.0106183 0.0104697 0.0103253 0.0102085 0.0101035 0.0100185 0.00994469 0.00988466
+          0.00983323 0.00979096 0.00975507 0.00972537 0.00970084 0.00968095 0.00966625 0.0096566 0.00965632 0.00967056 0.00971341 0.00977615
+          0.00260116 0.00625703 0.00859179 0.0102199 0.0109796 0.0117343 0.0121939 0.0126943 0.0130373 0.0133854 0.0136313 0.0138665
+          0.0140353 0.014192 0.0143067 0.0144118 0.0144905 0.0145622 0.0146172 0.0146664 0.0147052 0.0147386 0.0147663 0.014787
+          0.0148049 0.014808 0.0148072 0.0147663 0.0147047 0.0145418 0.00339136 0.00763843 0.01037 0.0122782 0.0130611 0.0137462
+          0.0139838 0.0142411 0.014302 0.014399 0.0144081 0.0144479 0.0144463 0.0144656 0.0144638 0.0144749 0.0144747 0.0144821
+          0.0144831 0.0144881 0.0144895 0.0144924 0.0144943 0.0144948 0.0144963 0.0144906 0.0144889 0.0144729 0.014475 0.014503
+          0.00339175 0.00763824 0.0103677 0.0122742 0.0130561 0.0137413 0.01398 0.0142391 0.0143022 0.0144018 0.0144134 0.0144556
+          0.0144564 0.0144777 0.0144779 0.0144908 0.0144921 0.014501 0.0145031 0.0145093 0.0145117 0.0145156 0.0145183 0.0145195
+          0.0145216 0.0145165 0.0145153 0.0144996 0.0145019 0.0145299 0.0026026 0.00626044 0.00859761 0.0102287 0.0109905 0.0117463
+          0.0122055 0.0127047 0.0130459 0.0133919 0.0136357 0.013869 0.014036 0.014191 0.0143042 0.0144079 0.0144855 0.014556
+          0.0146101 0.0146584 0.0146965 0.0147293 0.0147564 0.0147765 0.014794 0.0147967 0.0147956 0.0147544 0.0146928 0.01453
+          0.00282084 0.00640498 0.00869444 0.0102707 0.0108135 0.0111798 0.0111652 0.0111255 0.0109541 0.010805 0.0106259 0.0104792
+          0.0103366 0.0102215 0.010118 0.0100346 0.009962 0.0099032 0.00985286 0.00981163 0.00977665 0.00974783 0.00972407 0.00970494
+          0.00969094 0.00968197 0.00968228 0.00969699 0.00974029 0.00980342 0.00187543 0.00448841 0.00610662 0.00737303 0.00811899 0.00890804
+          0.00950853 0.0101067 0.0105619 0.0109757 0.0112867 0.0115588 0.0117645 0.0119428 0.0120795 0.0121982 0.0122908 0.0123716
+          0.0124356 0.012491 0.0125359 0.0125739 0.0126059 0.0126305 0.0126523 0.0126614 0.0126659 0.012636 0.0125772 0.0124226
+          0.0022835 0.0051553 0.00669985 0.00768918 0.0078764 0.00789423 0.0076909 0.00746371 0.00719705 0.00694738 0.00671379 0.00650565
+          0.00632459 0.00616627 0.00603241 0.00591625 0.00581928 0.00573541 0.0056657 0.00560542 0.00555536 0.00551242 0.00547719 0.0054484
+          0.00542657 0.00541366 0.00541054 0.00542672 0.00546527 0.00551683 0.00119468 0.00293161 0.00414534 0.00532636 0.00617765 0.00696118
+          0.00753358 0.0080159 0.00836179 0.00864618 0.00885455 0.00902826 0.00915958 0.00927087 0.00935709 0.00943112 0.00948973 0.00954053
+          0.00958142 0.00961672 0.00964558 0.00967008 0.00969094 0.00970749 0.00972243 0.0097304 0.00973584 0.00972362 0.00969376 0.00956475
+          0.00150699 0.00332276 0.00387435 0.00407353 0.00393292 0.00370651 0.00345208 0.00320002 0.00297812 0.00277386 0.00260214 0.00244703
+          0.00231741 0.00220079 0.00210302 0.00201513 0.00194122 0.00187485 0.00181886 0.00176864 0.00172621 0.00168843 0.00165676 0.00162948
+          0.0016078 0.0015922 0.0015832 0.00158588 0.00159913 0.00162808 0.00087926 0.00227469 0.00333404 0.00428477 0.00487898 0.00528752
+          0.00552482 0.00568529 0.00578299 0.0058548 0.00590282 0.0059414 0.00596928 0.00599273 0.00601052 0.00602579 0.00603801 0.00604861
+          0.00605738 0.00606471 0.0060709 0.00607584 0.00608046 0.00608373 0.00608719 0.00608798 0.00608812 0.00608164 0.00606914 0.00603976
+          0.000542083 0.00127628 0.00161048 0.00180151 0.00182156 0.00181408 0.00176664 0.00172004 0.00166669 0.00161898 0.00157374 0.00153424
+          0.00149904 0.00146845 0.00144185 0.00141877 0.00139897 0.00138182 0.00136717 0.00135441 0.00134353 0.00133409 0.00132623 0.0013196
+          0.00131452 0.00131083 0.00130919 0.00131033 0.00131545 0.0013214 0.00229775 0.00216106 0.00206702 0.00198735 0.00194072 0.00190419
+          0.0018823 0.00186498 0.001854 0.00184499 0.00183912 0.00183422 0.00183083 0.00182781 0.0018255 0.00182345 0.00182197 0.00182076
+          0.00181983 0.00181893 0.00181809 0.00181737 0.00181683 0.00181653 0.00181632 0.0018161 0.0018159 0.00181646 0.00181766 0.00181893
+        </DataArray>
+        <DataArray type="Float32" Name="l_mix" NumberOfComponents="1" format="ascii">
+          0.0143804 0.0144563 0.0145106 0.0145594 0.01459 0.0146146 0.0146297 0.014642 0.0146491 0.014655 0.0146592 0.0146632
+          0.0146661 0.0146684 0.0146696 0.0146706 0.0146717 0.0146731 0.0146743 0.014675 0.0146751 0.0146752 0.0146756 0.0146764
+          0.0146775 0.0146773 0.014677 0.0146761 0.0146753 0.0146734 0.0348804 0.0349563 0.0350106 0.0350594 0.03509 0.0351146
+          0.0351297 0.035142 0.0351491 0.035155 0.0351592 0.0351632 0.0351661 0.0351684 0.0351696 0.0351706 0.0351717 0.0351731
+          0.0351743 0.035175 0.0351751 0.0351752 0.0351756 0.0351764 0.0351775 0.0351773 0.035177 0.0351761 0.0351753 0.0351734
+          0.0553804 0.0554563 0.0555106 0.0555594 0.05559 0.0556146 0.0556297 0.0556419 0.0556491 0.055655 0.0556592 0.0556632
+          0.0556661 0.0556684 0.0556696 0.0556706 0.0556717 0.0556731 0.0556743 0.055675 0.0556751 0.0556752 0.0556756 0.0556764
+          0.0556775 0.0556773 0.055677 0.0556761 0.0556753 0.0556734 0.0758804 0.0759563 0.0760106 0.0760594 0.07609 0.0761146
+          0.0761297 0.076142 0.0761491 0.076155 0.0761592 0.0761632 0.0761661 0.0761684 0.0761696 0.0761706 0.0761717 0.0761731
+          0.0761743 0.076175 0.0761751 0.0761752 0.0761757 0.0761764 0.0761775 0.0761773 0.076177 0.0761761 0.0761753 0.0761734
+          0.0963804 0.0964563 0.0965106 0.0965594 0.09659 0.0966146 0.0966297 0.096642 0.0966491 0.096655 0.0966592 0.0966632
+          0.0966661 0.0966684 0.0966696 0.0966706 0.0966717 0.0966731 0.0966743 0.096675 0.0966752 0.0966752 0.0966756 0.0966764
+          0.0966775 0.0966773 0.096677 0.0966761 0.0966753 0.0966734 0.11688 0.116956 0.117011 0.117059 0.11709 0.117115
+          0.11713 0.117142 0.117149 0.117155 0.117159 0.117163 0.117166 0.117168 0.11717 0.117171 0.117172 0.117173
+          0.117174 0.117175 0.117175 0.117175 0.117176 0.117176 0.117178 0.117177 0.117177 0.117176 0.117175 0.117173
+          0.13738 0.137456 0.137511 0.137559 0.13759 0.137615 0.13763 0.137642 0.137649 0.137655 0.137659 0.137663
+          0.137666 0.137668 0.13767 0.137671 0.137672 0.137673 0.137674 0.137675 0.137675 0.137675 0.137676 0.137676
+          0.137678 0.137677 0.137677 0.137676 0.137675 0.137673 0.15788 0.157956 0.158011 0.158059 0.15809 0.158115
+          0.15813 0.158142 0.158149 0.158155 0.158159 0.158163 0.158166 0.158168 0.15817 0.158171 0.158172 0.158173
+          0.158174 0.158175 0.158175 0.158175 0.158176 0.158176 0.158178 0.158177 0.158177 0.158176 0.158175 0.158173
+          0.17838 0.178456 0.178511 0.178559 0.17859 0.178615 0.17863 0.178642 0.178649 0.178655 0.178659 0.178663
+          0.178666 0.178668 0.17867 0.178671 0.178672 0.178673 0.178674 0.178675 0.178675 0.178675 0.178676 0.178676
+          0.178678 0.178677 0.178677 0.178676 0.178675 0.178673 0.19888 0.198956 0.199011 0.199059 0.19909 0.199115
+          0.19913 0.199142 0.199149 0.199155 0.199159 0.199163 0.199166 0.199168 0.19917 0.199171 0.199172 0.199173
+          0.199174 0.199175 0.199175 0.199175 0.199176 0.199176 0.199178 0.199177 0.199177 0.199176 0.199175 0.199173
+          0.198942 0.199019 0.199073 0.199122 0.199153 0.199178 0.199193 0.199205 0.199212 0.199218 0.199222 0.199226
+          0.199229 0.199231 0.199232 0.199233 0.199234 0.199236 0.199237 0.199237 0.199238 0.199238 0.199238 0.199239
+          0.19924 0.19924 0.199239 0.199238 0.199237 0.199235 0.178442 0.178519 0.178573 0.178622 0.178653 0.178678
+          0.178693 0.178705 0.178712 0.178718 0.178722 0.178726 0.178729 0.178731 0.178732 0.178733 0.178734 0.178736
+          0.178737 0.178738 0.178738 0.178738 0.178738 0.178739 0.17874 0.17874 0.178739 0.178738 0.178737 0.178735
+          0.157942 0.158019 0.158073 0.158122 0.158153 0.158178 0.158193 0.158205 0.158212 0.158218 0.158222 0.158226
+          0.158229 0.158231 0.158232 0.158233 0.158234 0.158236 0.158237 0.158238 0.158238 0.158238 0.158238 0.158239
+          0.15824 0.15824 0.158239 0.158238 0.158237 0.158235 0.137442 0.137519 0.137573 0.137622 0.137653 0.137678
+          0.137693 0.137705 0.137712 0.137718 0.137722 0.137726 0.137729 0.137731 0.137732 0.137733 0.137734 0.137736
+          0.137737 0.137737 0.137738 0.137738 0.137738 0.137739 0.13774 0.13774 0.137739 0.137738 0.137737 0.137735
+          0.116942 0.117019 0.117073 0.117122 0.117153 0.117178 0.117193 0.117205 0.117212 0.117218 0.117222 0.117226
+          0.117229 0.117231 0.117232 0.117233 0.117234 0.117236 0.117237 0.117238 0.117238 0.117238 0.117238 0.117239
+          0.11724 0.11724 0.117239 0.117238 0.117237 0.117235 0.0964422 0.0965186 0.0965732 0.0966223 0.096653 0.0966776
+          0.0966928 0.096705 0.0967121 0.096718 0.0967222 0.0967261 0.096729 0.0967311 0.0967323 0.0967333 0.0967343 0.0967357
+          0.0967368 0.0967375 0.0967376 0.0967376 0.096738 0.0967387 0.0967398 0.0967395 0.0967392 0.0967383 0.0967374 0.0967354
+          0.0759422 0.0760186 0.0760733 0.0761223 0.076153 0.0761776 0.0761928 0.076205 0.0762121 0.076218 0.0762222 0.0762261
+          0.076229 0.0762312 0.0762323 0.0762333 0.0762343 0.0762357 0.0762368 0.0762375 0.0762376 0.0762376 0.076238 0.0762387
+          0.0762398 0.0762395 0.0762392 0.0762383 0.0762374 0.0762354 0.0554422 0.0555186 0.0555733 0.0556223 0.055653 0.0556776
+          0.0556928 0.055705 0.0557121 0.055718 0.0557222 0.0557261 0.0557289 0.0557312 0.0557323 0.0557333 0.0557343 0.0557357
+          0.0557368 0.0557375 0.0557376 0.0557376 0.055738 0.0557387 0.0557398 0.0557395 0.0557392 0.0557383 0.0557374 0.0557354
+          0.0349422 0.0350186 0.0350733 0.0351223 0.035153 0.0351776 0.0351928 0.035205 0.0352121 0.035218 0.0352222 0.0352261
+          0.0352289 0.0352312 0.0352323 0.0352333 0.0352343 0.0352357 0.0352368 0.0352375 0.0352376 0.0352376 0.035238 0.0352387
+          0.0352398 0.0352395 0.0352392 0.0352383 0.0352374 0.0352354 0.0144422 0.0145186 0.0145733 0.0146223 0.014653 0.0146776
+          0.0146928 0.014705 0.0147121 0.014718 0.0147222 0.0147261 0.014729 0.0147312 0.0147323 0.0147333 0.0147343 0.0147357
+          0.0147368 0.0147375 0.0147376 0.0147376 0.014738 0.0147387 0.0147398 0.0147395 0.0147392 0.0147383 0.0147374 0.0147354
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          19.9435 19.2507 18.7507 18.3192 18.0683 17.8679 17.7481 17.6525 17.5877 17.534 17.501 17.4754
+          17.4585 17.4413 17.425 17.4103 17.4017 17.3972 17.3942 17.3889 17.3811 17.374 17.3706 17.3713
+          17.3753 17.371 17.3668 17.3669 17.373 17.3946 40.7377 40.5696 40.1735 39.689 39.2612 38.8797
+          38.5781 38.3213 38.1077 37.9237 37.7836 37.6675 37.575 37.489 37.4111 37.3419 37.291 37.253
+          37.2225 37.1898 37.1552 37.1243 37.1042 37.0946 37.0946 37.0794 37.0681 37.0698 37.0909 37.1477
+          42.1387 44.1092 45.0543 45.639 45.7298 45.6853 45.5096 45.319 45.1015 44.9013 44.7279 44.5808
+          44.4545 44.3374 44.2285 44.1322 44.0581 44.001 43.9542 43.906 43.8569 43.8129 43.7834 43.7664
+          43.7631 43.7412 43.7263 43.7233 43.7429 43.7952 42.1857 44.4337 45.8934 47.068 47.6363 47.9791
+          48.0782 48.1082 48.0511 47.9862 47.9171 47.8617 47.8084 47.7557 47.6985 47.6483 47.6129 47.591
+          47.5737 47.5513 47.5233 47.4977 47.4845 47.4817 47.4912 47.4758 47.4643 47.4547 47.4596 47.4829
+          41.9299 43.9148 45.4337 46.7932 47.6042 48.2125 48.5413 48.7818 48.8915 48.9733 49.0201 49.0668
+          49.0954 49.1151 49.1164 49.1181 49.1257 49.1425 49.1574 49.1634 49.1589 49.1539 49.1584 49.1709
+          49.1934 49.186 49.1794 49.1658 49.1585 49.1407 41.8553 43.7908 45.3421 46.8137 47.7898 48.5782
+          49.0741 49.4663 49.7013 49.8919 50.0266 50.1495 50.2394 50.3121 50.3559 50.3945 50.4323 50.4755
+          50.512 50.5367 50.5472 50.5551 50.5705 50.5922 50.6225 50.619 50.6141 50.5946 50.5737 50.5173
+          41.7247 43.5126 45.0009 46.4542 47.4802 48.3525 48.9479 49.4447 49.7748 50.0537 50.2623 50.4508
+          50.5942 50.7136 50.7952 50.8668 50.9313 50.9979 51.0536 51.0947 51.1187 51.1382 51.1632 51.1927
+          51.2295 51.2292 51.2253 51.1996 51.1657 51.0828 41.6979 43.474 44.9483 46.4083 47.4711 48.4014
+          49.0671 49.637 50.0353 50.376 50.6371 50.8711 51.0516 51.2026 51.3096 51.4028 51.4849 51.5666
+          51.6346 51.6862 51.7186 51.7452 51.7763 51.8106 51.8516 51.8531 51.8498 51.8191 51.7743 51.6678
+          41.6374 43.3537 44.7871 46.2183 47.283 48.2309 48.9279 49.5349 49.9714 50.3491 50.6429 50.9061
+          51.111 51.2832 51.4073 51.5154 51.6094 51.7015 51.7779 51.8367 51.8749 51.9065 51.9417 51.9792
+          52.0228 52.0254 52.022 51.9872 51.9343 51.8109 41.6297 43.3608 44.803 46.2407 47.3142 48.2762
+          48.9917 49.6191 50.0758 50.4724 50.7827 51.0602 51.277 51.4591 51.5914 51.7061 51.8057 51.9025
+          51.9827 52.0447 52.0855 52.1192 52.1563 52.1953 52.2402 52.2433 52.2399 52.2031 52.1457 52.0095
+          40.4033 42.0727 43.461 44.8464 45.8804 46.8076 47.4969 48.1015 48.5414 48.9233 49.2218 49.4887
+          49.6969 49.8718 49.9984 50.1083 50.2034 50.296 50.3724 50.4314 50.47 50.5017 50.5366 50.5735
+          50.6159 50.618 50.6137 50.5769 50.52 50.3859 40.4107 42.0657 43.4452 44.824 45.8492 46.7627
+          47.4343 48.0193 48.4397 48.8036 49.0863 49.3398 49.5367 49.7022 49.8212 49.9247 50.0146 50.1028
+          50.1757 50.2318 50.2679 50.2976 50.3308 50.3663 50.4076 50.4092 50.405 50.3702 50.3176 50.196
+          40.4693 42.182 43.6007 45.0071 46.0303 46.9269 47.5682 48.1176 48.5013 48.8297 49.081 49.3064
+          49.48 49.6252 49.7279 49.8173 49.8958 49.9741 50.0391 50.0883 50.1189 50.1439 50.1732 50.2057
+          50.2445 50.2453 50.2411 50.2104 50.1657 50.0605 40.4952 42.2191 43.6511 45.0508 46.0384 46.8788
+          47.4523 47.9311 48.2491 48.5178 48.7187 48.9003 49.0383 49.1532 49.2314 49.3001 49.3618 49.4257
+          49.4788 49.5181 49.5406 49.5589 49.5825 49.6104 49.6453 49.6443 49.6397 49.6139 49.5797 49.4974
+          40.6217 42.4883 43.9808 45.3982 46.3375 47.097 47.5746 47.9525 48.1789 48.3625 48.4922 48.6106
+          48.6971 48.7669 48.8089 48.8459 48.8819 48.9234 48.9582 48.9817 48.9914 48.9987 49.0131 49.0335
+          49.0623 49.0583 49.0529 49.0332 49.0118 48.9551 40.6939 42.608 44.0692 45.3782 46.1582 46.7439
+          47.0602 47.2916 47.397 47.4755 47.5204 47.5653 47.5927 47.6115 47.6125 47.6141 47.6211 47.6372
+          47.6513 47.6569 47.6521 47.6471 47.6511 47.6628 47.6841 47.6765 47.6696 47.6557 47.6476 47.6282
+          40.9418 43.1105 44.5145 45.6456 46.1918 46.5217 46.6167 46.6455 46.5902 46.5276 46.4609 46.4077
+          46.3563 46.3058 46.2507 46.2025 46.1685 46.1477 46.1311 46.1097 46.0828 46.0583 46.0455 46.043
+          46.0521 46.0372 46.0259 46.0165 46.0206 46.0414 40.8967 42.7979 43.7056 44.2678 44.3536 44.3098
+          44.1398 43.9558 43.7458 43.5529 43.3858 43.2444 43.1229 43.0106 42.906 42.8137 42.7427 42.6883
+          42.6436 42.5978 42.5509 42.509 42.4809 42.465 42.4622 42.4414 42.4273 42.4246 42.4434 42.4932
+          39.5415 39.3787 38.9958 38.5278 38.1148 37.7467 37.456 37.2085 37.0029 36.8259 36.6913 36.58
+          36.4916 36.4094 36.3349 36.2688 36.2204 36.1844 36.1556 36.1248 36.0919 36.0627 36.0438 36.0352
+          36.0358 36.0215 36.011 36.0131 36.034 36.0896 19.3597 18.6918 18.211 17.7955 17.5544 17.3618
+          17.247 17.1554 17.0936 17.0423 17.0111 16.987 16.9712 16.955 16.9398 16.926 16.9182 16.9142
+          16.9117 16.9069 16.8997 16.8931 16.8902 16.8912 16.8954 16.8916 16.8879 16.8883 16.8948 16.9164
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          27.9932 27.1346 26.5449 26.0342 25.7214 25.4761 25.3255 25.2059 25.136 25.079 25.0378 24.9995
+          24.9714 24.9498 24.9382 24.9284 24.9177 24.9044 24.8929 24.8862 24.8848 24.8842 24.88 24.8729
+          24.8619 24.8645 24.8674 24.8753 24.883 24.9012 67.8993 65.6137 64.0463 62.6912 61.8616 61.2118
+          60.8131 60.4965 60.3114 60.1607 60.0516 59.9503 59.876 59.8189 59.7883 59.7624 59.734 59.6987
+          59.6684 59.6507 59.6469 59.6453 59.6342 59.6155 59.5864 59.5934 59.601 59.6219 59.6423 59.6903
+          107.805 104.093 101.548 99.3482 98.0019 96.9475 96.3007 95.787 95.4869 95.2424 95.0654 94.9011
+          94.7806 94.6879 94.6384 94.5963 94.5502 94.493 94.444 94.4152 94.4091 94.4065 94.3885 94.3582
+          94.3109 94.3222 94.3346 94.3685 94.4016 94.4795 147.711 142.572 139.049 136.005 134.142 132.683
+          131.788 131.078 130.662 130.324 130.079 129.852 129.685 129.557 129.488 129.43 129.366 129.287
+          129.219 129.18 129.171 129.168 129.143 129.101 129.035 129.051 129.068 129.115 129.161 129.269
+          187.617 181.051 176.551 172.662 170.282 168.419 167.276 166.368 165.838 165.406 165.093 164.803
+          164.59 164.426 164.339 164.264 164.183 164.082 163.995 163.944 163.933 163.929 163.897 163.843
+          163.76 163.78 163.802 163.862 163.92 164.058 227.523 219.53 214.052 209.319 206.423 204.155
+          202.763 201.659 201.013 200.488 200.107 199.754 199.494 199.295 199.189 199.098 198.999 198.876
+          198.771 198.709 198.696 198.69 198.651 198.586 198.484 198.509 198.535 198.608 198.679 198.847
+          267.429 258.009 251.554 245.976 242.563 239.89 238.251 236.949 236.189 235.569 235.121 234.704
+          234.399 234.164 234.039 233.932 233.815 233.67 233.546 233.473 233.458 233.451 233.406 233.329
+          233.209 233.238 233.269 233.355 233.439 233.636 307.336 296.488 289.055 282.633 278.703 275.626
+          273.739 272.24 271.364 270.651 270.134 269.655 269.304 269.033 268.889 268.766 268.632 268.465
+          268.322 268.238 268.22 268.212 268.16 268.071 267.933 267.966 268.003 268.102 268.198 268.425
+          347.242 334.967 326.557 319.29 314.844 311.362 309.226 307.53 306.54 305.733 305.148 304.606
+          304.208 303.902 303.739 303.6 303.448 303.259 303.097 303.002 302.982 302.973 302.914 302.814
+          302.658 302.695 302.736 302.848 302.957 303.214 387.148 373.446 364.058 355.947 350.984 347.097
+          344.714 342.821 341.715 340.814 340.162 339.557 339.113 338.771 338.589 338.434 338.264 338.053
+          337.873 337.767 337.744 337.734 337.668 337.557 337.382 337.424 337.47 337.595 337.717 338.003
+          375.932 362.719 353.69 345.88 341.11 337.374 335.088 333.274 332.22 331.362 330.744 330.17
+          329.752 329.431 329.265 329.123 328.968 328.771 328.604 328.508 328.493 328.49 328.433 328.331
+          328.168 328.215 328.266 328.394 328.522 328.814 337.194 325.357 317.268 310.271 305.998 302.65
+          300.602 298.977 298.033 297.264 296.711 296.196 295.821 295.534 295.385 295.258 295.119 294.943
+          294.793 294.707 294.694 294.691 294.64 294.548 294.402 294.444 294.49 294.605 294.719 294.981
+          298.456 287.995 280.846 274.662 270.885 267.927 266.117 264.68 263.845 263.166 262.677 262.222
+          261.891 261.637 261.505 261.393 261.27 261.114 260.982 260.906 260.894 260.892 260.846 260.766
+          260.637 260.674 260.714 260.816 260.917 261.148 259.718 250.633 244.424 239.053 235.773 233.203
+          231.631 230.383 229.658 229.068 228.643 228.249 227.961 227.74 227.626 227.528 227.421 227.286
+          227.171 227.105 227.095 227.093 227.053 226.983 226.871 226.903 226.939 227.027 227.114 227.315
+          220.98 213.271 208.002 203.444 200.66 198.479 197.145 196.086 195.471 194.97 194.61 194.275
+          194.03 193.843 193.746 193.663 193.573 193.458 193.36 193.304 193.296 193.294 193.26 193.201
+          193.106 193.133 193.163 193.238 193.312 193.483 182.242 175.909 171.58 167.835 165.548 163.756
+          162.66 161.789 161.284 160.872 160.576 160.301 160.1 159.946 159.866 159.798 159.724 159.629
+          159.549 159.503 159.496 159.495 159.467 159.418 159.34 159.363 159.387 159.449 159.51 159.65
+          143.504 138.547 135.158 132.226 130.435 129.032 128.174 127.493 127.097 126.774 126.542 126.327
+          126.169 126.049 125.987 125.933 125.875 125.801 125.738 125.702 125.697 125.696 125.674 125.636
+          125.575 125.592 125.611 125.66 125.707 125.817 104.766 101.185 98.736 96.6172 95.3228 94.3086
+          93.6881 93.1956 92.9093 92.6765 92.5087 92.3528 92.2391 92.1522 92.1068 92.0685 92.0262 91.9728
+          91.9274 91.9015 91.8974 91.8966 91.8809 91.8532 91.809 91.8218 91.8356 91.8705 91.9051 91.9844
+          66.0285 63.8226 62.314 61.0082 60.2103 59.5849 59.2024 58.8987 58.7221 58.5785 58.475 58.3789
+          58.3088 58.2551 58.2272 58.2035 58.1774 58.1445 58.1165 58.1005 58.098 58.0975 58.0878 58.0707
+          58.0435 58.0513 58.0599 58.0814 58.1027 58.1517 27.2906 26.4606 25.892 25.3992 25.0978 24.8613
+          24.7166 24.6017 24.5349 24.4805 24.4414 24.405 24.3784 24.3581 24.3475 24.3385 24.3287 24.3162
+          24.3056 24.2995 24.2986 24.2984 24.2947 24.2882 24.2779 24.2809 24.2841 24.2923 24.3004 24.3189
+        </DataArray>
+        <DataArray type="Float32" Name="D_t" NumberOfComponents="1" format="ascii">
+          0.000103287 9.59451e-05 9.09296e-05 8.67037e-05 8.42226e-05 8.22878e-05 8.11238e-05 8.02044e-05 7.96263e-05 7.91532e-05 7.88387e-05 7.85716e-05
+          7.83841e-05 7.82207e-05 7.81005e-05 7.79944e-05 7.7913e-05 7.78409e-05 7.77836e-05 7.77332e-05 7.76914e-05 7.76561e-05 7.76246e-05 7.7601e-05
+          7.75772e-05 7.75676e-05 7.75595e-05 7.75902e-05 7.76487e-05 7.78161e-05 0.000570771 0.000548797 0.000529961 0.000512014 0.000499399 0.000489047
+          0.000481855 0.000475973 0.000471737 0.00046818 0.000465511 0.00046322 0.000461443 0.000459897 0.000458669 0.000457592 0.00045672 0.000455954
+          0.000455321 0.000454769 0.000454305 0.000453907 0.000453564 0.00045329 0.00045305 0.000452918 0.00045284 0.000453031 0.000453458 0.000454546
+          0.000983401 0.000993144 0.000989044 0.000979685 0.000968028 0.000956432 0.000946237 0.000937126 0.000929629 0.000923083 0.000917761 0.000913126
+          0.000909348 0.00090605 0.000903341 0.00090097 0.000899008 0.000897287 0.000895851 0.000894593 0.000893535 0.000892619 0.000891842 0.000891201
+          0.000890671 0.000890337 0.000890156 0.000890424 0.000891142 0.00089296 0.00137755 0.0013988 0.00140796 0.00141145 0.0014084 0.0014027
+          0.00139588 0.00138905 0.00138291 0.0013774 0.00137278 0.00136876 0.00136545 0.00136258 0.00136022 0.00135818 0.00135649 0.00135503
+          0.00135381 0.00135276 0.00135188 0.00135112 0.00135048 0.00134995 0.00134952 0.00134925 0.00134911 0.00134934 0.00134997 0.00135179
+          0.00176094 0.00177863 0.00179356 0.00180577 0.00181131 0.00181399 0.00181377 0.00181268 0.00181088 0.0018091 0.00180735 0.00180584
+          0.00180452 0.00180341 0.00180249 0.00180173 0.0018011 0.00180059 0.00180016 0.00179982 0.00179953 0.0017993 0.00179911 0.00179896
+          0.00179885 0.0017988 0.00179881 0.00179898 0.00179937 0.00180025 0.00214807 0.00216688 0.00218655 0.00220659 0.0022209 0.00223222
+          0.00223941 0.00224477 0.00224812 0.00225073 0.00225247 0.00225395 0.00225502 0.00225599 0.00225674 0.00225743 0.00225799 0.0022585
+          0.00225892 0.00225931 0.00225963 0.00225992 0.00226017 0.00226038 0.00226056 0.00226068 0.00226077 0.00226074 0.00226063 0.00226005
+          0.00253106 0.00254535 0.00256567 0.00258893 0.00260893 0.00262711 0.00264108 0.00265306 0.00266212 0.00266989 0.00267587 0.00268107
+          0.00268516 0.00268875 0.00269163 0.00269417 0.00269622 0.00269805 0.00269954 0.00270086 0.00270195 0.0027029 0.00270369 0.00270434
+          0.00270487 0.00270519 0.00270536 0.00270501 0.0027042 0.00270213 0.00291833 0.00293374 0.00295612 0.00298331 0.00300868 0.00303323
+          0.00305367 0.00307194 0.00308653 0.00309924 0.00310931 0.00311804 0.00312499 0.00313103 0.00313588 0.00314012 0.00314355 0.00314655
+          0.003149 0.00315114 0.00315291 0.00315444 0.00315571 0.00315674 0.0031576 0.00315808 0.00315831 0.00315762 0.00315603 0.00315225
+          0.00330288 0.00331626 0.003339 0.00336812 0.00339727 0.00342652 0.003452 0.00347537 0.00349462 0.00351161 0.0035253 0.00353723
+          0.00354679 0.0035551 0.00356179 0.00356761 0.00357232 0.00357643 0.00357978 0.0035827 0.00358511 0.00358718 0.00358891 0.0035903
+          0.00359144 0.00359206 0.00359232 0.00359126 0.0035889 0.00358346 0.00369058 0.00370654 0.00373252 0.00376544 0.00379865 0.00383238
+          0.00386227 0.00388993 0.00391299 0.00393341 0.00394998 0.00396439 0.00397598 0.00398601 0.0039941 0.00400111 0.00400679 0.00401173
+          0.00401577 0.00401928 0.00402217 0.00402464 0.00402671 0.00402837 0.00402974 0.00403047 0.00403076 0.00402943 0.00402646 0.00401941
+          0.00369057 0.00370652 0.00373248 0.00376539 0.00379859 0.00383233 0.00386221 0.00388988 0.00391296 0.00393339 0.00394997 0.00396438
+          0.00397598 0.00398602 0.00399412 0.00400114 0.00400683 0.00401178 0.00401582 0.00401933 0.00402222 0.0040247 0.00402677 0.00402844
+          0.0040298 0.00403054 0.00403084 0.0040295 0.00402654 0.00401948 0.00330287 0.00331623 0.00333894 0.00336802 0.00339715 0.0034264
+          0.00345189 0.00347528 0.00349455 0.00351158 0.0035253 0.00353725 0.00354684 0.00355518 0.00356189 0.00356773 0.00357245 0.00357658
+          0.00357995 0.00358288 0.0035853 0.00358738 0.00358912 0.00359052 0.00359166 0.00359229 0.00359255 0.0035915 0.00358914 0.0035837
+          0.00291831 0.00293368 0.00295601 0.00298315 0.0030085 0.00303305 0.0030535 0.00307181 0.00308645 0.00309921 0.00310932 0.0031181
+          0.00312509 0.00313117 0.00313606 0.00314033 0.00314378 0.00314681 0.00314928 0.00315145 0.00315323 0.00315478 0.00315606 0.00315711
+          0.00315798 0.00315847 0.00315871 0.00315803 0.00315644 0.00315267 0.00253103 0.00254528 0.00256553 0.00258875 0.00260872 0.00262691
+          0.00264092 0.00265295 0.00266206 0.0026699 0.00267593 0.00268119 0.00268533 0.00268897 0.00269189 0.00269447 0.00269656 0.00269842
+          0.00269994 0.00270128 0.00270239 0.00270336 0.00270417 0.00270484 0.00270539 0.00270572 0.0027059 0.00270556 0.00270475 0.00270269
+          0.00214804 0.00216678 0.00218637 0.00220637 0.00222067 0.00223203 0.00223927 0.0022447 0.00224812 0.0022508 0.00225261 0.00225416
+          0.00225529 0.00225631 0.00225711 0.00225785 0.00225844 0.002259 0.00225945 0.00225987 0.00226022 0.00226053 0.0022608 0.00226103
+          0.00226123 0.00226137 0.00226148 0.00226146 0.00226135 0.00226077 0.0017609 0.00177852 0.0017934 0.00180558 0.00181115 0.00181388
+          0.00181373 0.00181272 0.00181099 0.00180929 0.00180761 0.00180616 0.0018049 0.00180385 0.00180298 0.00180226 0.00180168 0.0018012
+          0.00180081 0.00180049 0.00180024 0.00180003 0.00179986 0.00179974 0.00179965 0.00179962 0.00179964 0.00179983 0.00180022 0.00180109
+          0.00137751 0.00139869 0.00140782 0.00141133 0.00140836 0.00140274 0.00139602 0.00138928 0.00138323 0.00137781 0.00137327 0.00136932
+          0.00136607 0.00136326 0.00136096 0.00135897 0.00135733 0.00135591 0.00135474 0.00135372 0.00135287 0.00135215 0.00135154 0.00135104
+          0.00135064 0.0013504 0.00135028 0.00135054 0.00135118 0.001353 0.000983383 0.00099311 0.000989048 0.000979775 0.000968217 0.000956721
+          0.000946617 0.000937593 0.000930173 0.0009237 0.000918444 0.000913872 0.00091015 0.000906907 0.000904247 0.000901924 0.000900005 0.000898325
+          0.000896927 0.000895706 0.000894681 0.000893797 0.000893051 0.000892438 0.000891935 0.000891627 0.000891471 0.000891763 0.000892502 0.000894339
+          0.000570825 0.000548984 0.000530293 0.000512466 0.000499946 0.000489669 0.000482539 0.000476709 0.000472518 0.000469003 0.000466371 0.000464115
+          0.00046237 0.000460853 0.000459652 0.000458601 0.000457753 0.000457009 0.000456398 0.000455865 0.00045542 0.00045504 0.000454714 0.000454457
+          0.000454233 0.000454116 0.000454053 0.000454259 0.000454704 0.000455819 0.000103196 9.58977e-05 9.09235e-05 8.67263e-05 8.42661e-05 8.23464e-05
+          8.11946e-05 8.02849e-05 7.97153e-05 7.92495e-05 7.89416e-05 7.86804e-05 7.84985e-05 7.834e-05 7.82245e-05 7.81226e-05 7.80453e-05 7.79768e-05
+          7.79231e-05 7.78759e-05 7.78373e-05 7.7805e-05 7.77765e-05 7.77557e-05 7.77349e-05 7.77282e-05 7.77232e-05 7.77575e-05 7.78204e-05 7.79947e-05
+        </DataArray>
+        <DataArray type="Float32" Name="lambda_t" NumberOfComponents="1" format="ascii">
+          0.0326387 0.0303201 0.0287366 0.0274024 0.0266197 0.0260096 0.0256432 0.025354 0.0251727 0.0250245 0.0249265 0.0248434
+          0.0247855 0.0247352 0.0246985 0.0246662 0.0246418 0.0246202 0.0246033 0.0245886 0.0245766 0.0245666 0.0245578 0.0245514
+          0.024545 0.0245431 0.0245416 0.0245524 0.0245727 0.0248007 0.178531 0.171667 0.165783 0.160178 0.15624 0.153009
+          0.150767 0.148934 0.147616 0.146511 0.145683 0.144974 0.144425 0.143948 0.143571 0.143241 0.142974 0.142741
+          0.14255 0.142384 0.142245 0.142127 0.142027 0.141947 0.141879 0.141843 0.141825 0.141891 0.142044 0.143766
+          0.30759 0.310639 0.309359 0.306433 0.302789 0.299164 0.295977 0.293129 0.290786 0.28874 0.287077 0.285629
+          0.284449 0.28342 0.282575 0.281836 0.281224 0.280688 0.280241 0.279851 0.279522 0.279238 0.278998 0.278801
+          0.278638 0.278536 0.278482 0.27857 0.278838 0.281406 0.430873 0.437519 0.440386 0.441478 0.440525 0.438739
+          0.436609 0.434471 0.432552 0.43083 0.429386 0.428128 0.427093 0.426196 0.425459 0.424821 0.424294 0.423837
+          0.423458 0.423128 0.422853 0.422616 0.422418 0.422254 0.422121 0.422038 0.421995 0.42207 0.422337 0.425424
+          0.550789 0.556322 0.560994 0.564811 0.566544 0.567382 0.567314 0.566973 0.56641 0.565854 0.565308 0.564835
+          0.564422 0.564077 0.563788 0.56355 0.563354 0.563193 0.563061 0.562953 0.562864 0.562792 0.562732 0.562687
+          0.562653 0.562638 0.56264 0.562698 0.562921 0.566138 0.671878 0.677761 0.683913 0.690182 0.694656 0.698199
+          0.700447 0.702123 0.703171 0.703987 0.704532 0.704994 0.70533 0.705633 0.705868 0.706084 0.706257 0.706419
+          0.70655 0.706672 0.706772 0.706863 0.70694 0.707006 0.707062 0.707101 0.70713 0.707127 0.707231 0.710357
+          0.791668 0.796141 0.802495 0.809771 0.816027 0.821712 0.826081 0.82983 0.832662 0.835094 0.836962 0.83859
+          0.839868 0.840993 0.841891 0.842687 0.84333 0.843901 0.844367 0.84478 0.84512 0.845416 0.845664 0.845867
+          0.846036 0.846135 0.846188 0.846088 0.846012 0.849044 0.9128 0.917622 0.924622 0.933124 0.941061 0.948739
+          0.955131 0.960845 0.965411 0.969386 0.972536 0.975266 0.97744 0.97933 0.980847 0.982172 0.983244 0.984183
+          0.984949 0.98562 0.986173 0.98665 0.987048 0.987371 0.987638 0.98779 0.987862 0.987659 0.987388 0.990234
+          1.03308 1.03727 1.04438 1.05349 1.0626 1.07175 1.07972 1.08703 1.09305 1.09837 1.10265 1.10638
+          1.10937 1.11197 1.11406 1.11588 1.11736 1.11864 1.11969 1.1206 1.12136 1.122 1.12254 1.12298
+          1.12334 1.12353 1.12361 1.1233 1.12284 1.12553 1.15434 1.15934 1.16746 1.17776 1.18815 1.1987
+          1.20805 1.2167 1.22391 1.2303 1.23548 1.23999 1.24361 1.24675 1.24928 1.25147 1.25325 1.2548
+          1.25606 1.25716 1.25806 1.25883 1.25948 1.26 1.26043 1.26066 1.26075 1.26035 1.25975 1.26235
+          1.15434 1.15933 1.16745 1.17774 1.18813 1.19868 1.20803 1.21668 1.2239 1.23029 1.23548 1.23999
+          1.24361 1.24676 1.24929 1.25148 1.25326 1.25481 1.25607 1.25717 1.25808 1.25885 1.2595 1.26002
+          1.26045 1.26068 1.26077 1.26038 1.25978 1.26237 1.03308 1.03726 1.04436 1.05346 1.06257 1.07172
+          1.07969 1.087 1.09303 1.09836 1.10265 1.10639 1.10939 1.112 1.11409 1.11592 1.1174 1.11869
+          1.11974 1.12066 1.12142 1.12207 1.12261 1.12305 1.12341 1.1236 1.12369 1.12337 1.12291 1.1256
+          0.912794 0.917603 0.924586 0.933074 0.941004 0.948682 0.95508 0.960806 0.965386 0.969375 0.97254 0.975285
+          0.977471 0.979374 0.980902 0.982236 0.983317 0.984264 0.985038 0.985715 0.986274 0.986756 0.987159 0.987486
+          0.987757 0.987912 0.987987 0.987786 0.987517 0.990361 0.791662 0.796119 0.802452 0.809713 0.815962 0.821651
+          0.826031 0.829795 0.832645 0.835096 0.836982 0.838627 0.839921 0.841062 0.841973 0.842781 0.843435 0.844016
+          0.844491 0.844911 0.845259 0.845562 0.845815 0.846024 0.846197 0.8463 0.846357 0.84626 0.846185 0.849215
+          0.671868 0.67773 0.683858 0.690113 0.694586 0.698139 0.700404 0.702101 0.703171 0.70401 0.704576 0.705059
+          0.705413 0.705734 0.705983 0.706214 0.7064 0.706572 0.706714 0.706845 0.706954 0.707053 0.707137 0.707209
+          0.707271 0.707315 0.707348 0.707349 0.707455 0.710579 0.550778 0.556289 0.560942 0.564753 0.566494 0.567349
+          0.567302 0.566986 0.566446 0.565913 0.565389 0.564935 0.56454 0.564213 0.563939 0.563715 0.563531 0.563382
+          0.56326 0.563161 0.563081 0.563017 0.562964 0.562926 0.562897 0.562888 0.562894 0.562956 0.563181 0.566393
+          0.430861 0.437484 0.440339 0.44144 0.440508 0.438751 0.436651 0.434542 0.43265 0.430953 0.429533 0.428297
+          0.427281 0.426403 0.425683 0.42506 0.424547 0.424104 0.423736 0.423418 0.423154 0.422926 0.422736 0.422581
+          0.422455 0.422379 0.422343 0.422425 0.422696 0.42578 0.307585 0.310627 0.309356 0.306456 0.302841 0.299245
+          0.296085 0.293262 0.290941 0.288917 0.287273 0.285843 0.284678 0.283664 0.282832 0.282105 0.281505 0.28098
+          0.280542 0.28016 0.27984 0.279563 0.27933 0.279138 0.278981 0.278885 0.278836 0.278928 0.279199 0.281768
+          0.178544 0.171712 0.165866 0.16029 0.156374 0.153159 0.150929 0.149106 0.147795 0.146695 0.145872 0.145166
+          0.144621 0.144146 0.143771 0.143442 0.143177 0.142944 0.142753 0.142586 0.142447 0.142328 0.142226 0.142146
+          0.142076 0.142039 0.14202 0.142084 0.142236 0.14396 0.0322779 0.0299951 0.0284393 0.0271265 0.026357 0.0257565
+          0.0253962 0.0251117 0.0249336 0.0247878 0.0246916 0.0246099 0.0245529 0.0245034 0.0244672 0.0244353 0.0244112 0.0243898
+          0.0243729 0.0243582 0.0243461 0.024336 0.0243271 0.0243206 0.0243141 0.024312 0.0243104 0.0243212 0.0243416 0.0245677
+        </DataArray>
+      </CellData>
       <Points>
         <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
           0 0 0 0.1 0 0 0 0.05 0 0.1 0.05 0
diff --git a/test/references/zeroeqchannel-reference.vtu b/test/references/zeroeqchannel-reference.vtu
index acc44abf908030ce1c126755d7cdb316d140e5d6..5fb2ced26ee222e35b792d6ae7d2e8a34a4c207d 100644
--- a/test/references/zeroeqchannel-reference.vtu
+++ b/test/references/zeroeqchannel-reference.vtu
@@ -251,13 +251,151 @@
           2.65047 0.00211994 0 2.7407 0.00202987 0 2.65847 0.00108585 0 2.74577 0.00116827 0
           2.66245 -0.000509596 0 2.74597 -0.00075674 0 2.5 0 0 2.60115 0 0
           2.50665 0 0 2.61156 0 0 2.52273 0 0 2.62812 0 0
-          2.5427 0 0 2.64649 0 0 2.56267 1.75348e-38 0 2.66433 0 0
-          2.58075 1.24265e-38 0 2.68082 -1.36825e-38 0 2.59725 0 0 2.69591 -1.51127e-38 0
-          2.61281 0 0 2.70978 0 0 2.62706 -1.6163e-38 0 2.72244 0 0
+          2.5427 0 0 2.64649 0 0 2.56267 0 0 2.66433 0 0
+          2.58075 0 0 2.68082 0 0 2.59725 0 0 2.69591 0 0
+          2.61281 0 0 2.70978 0 0 2.62706 0 0 2.72244 0 0
           2.63929 0 0 2.73345 0 0 2.64931 0 0 2.74175 0 0
           2.65713 0 0 2.74635 0 0 2.661 0 0 2.74462 -0.000309358 0
         </DataArray>
       </PointData>
+      <CellData Scalars="mu_t">
+        <DataArray type="Float32" Name="mu_t" NumberOfComponents="1" format="ascii">
+          0.0124504 0.0116027 0.0110872 0.0105385 0.0101755 0.00983526 0.00959285 0.00936724 0.00919544 0.0090331 0.00890382 0.00878059
+          0.00868015 0.00858343 0.00850356 0.00842587 0.00836177 0.00829881 0.00824885 0.00820048 0.00816805 0.00814098 0.00814752 0.0081966
+          0.00665392 0.00742696 0.0157457 0.0185618 0.021236 0.0221148 0.0228432 0.02298 0.0230985 0.0230103 0.0229557 0.0228198
+          0.022724 0.0225874 0.0224829 0.0223525 0.0222496 0.0221293 0.0220355 0.0219269 0.0218445 0.0217362 0.0216552 0.0214654
+          0.0209718 0.0207163 0.00125763 0.00447649 0.00995667 0.0156754 0.0199985 0.0235139 0.0256717 0.0274406 0.0285211 0.0294609
+          0.0300494 0.0305989 0.0309488 0.0312817 0.031476 0.0316681 0.0317631 0.0318675 0.0319046 0.0319532 0.0319282 0.0318781
+          0.0316016 0.0311641 0.0316045 0.00579701 0.0118657 0.00963985 0.00555448 0.00119276 0.00702816 0.0132532 0.0187989 0.0228333
+          0.0262556 0.0285436 0.0306098 0.0320303 0.0333609 0.0343218 0.0352643 0.035959 0.0366361 0.0371069 0.0375542 0.0377937
+          0.0379476 0.0378149 0.0376445 0.038448 0.00321818 0.00701852 0.00890253 0.0100051 0.00955555 0.0084462 0.00522417 0.00108
+          0.00449883 0.0102921 0.0158763 0.0206689 0.0243477 0.0276536 0.0299515 0.032215 0.0338241 0.0354218 0.036596 0.0377506
+          0.0385369 0.0392062 0.0395323 0.0398707 0.0407981 0.00571065 0.0130704 0.015185 0.0157987 0.01539 0.0145957 0.0139939
+          0.0128498 0.0110401 0.0091117 0.00545532 0.00138477 0.00406413 0.00955914 0.015065 0.0197905 0.0236246 0.0271451 0.029535
+          0.0319695 0.0335455 0.0350842 0.0359845 0.0368435 0.0378268 0.000592142 0.00193879 0.00502449 0.00890413 0.011283 0.012587
+          0.0131359 0.0130428 0.0130474 0.0126195 0.0123761 0.0116085 0.0100876 0.00885033 0.00565224 0.00246989 0.00243803 0.00729887
+          0.0125609 0.0169904 0.021072 0.0242668 0.0263981 0.0284105 0.0284873 0.00489595 0.0115008 0.0143589 0.0163301 0.0166073
+          0.0168295 0.0168317 0.0165878 0.016252 0.0152722 0.0147213 0.0138474 0.0135655 0.0129519 0.0127725 0.0120234 0.0109125
+          0.0103172 0.00796253 0.00617226 0.00277956 0.000255198 0.00403462 0.00743175 0.00901901 0.00064844 0.00113634 0.000835885 0.00407387
+          0.00697671 0.00943756 0.0108856 0.0120294 0.0128753 0.0136809 0.0141732 0.0143726 0.014375 0.013763 0.0134864 0.0128444
+          0.0127661 0.0124164 0.0126087 0.0120986 0.0122305 0.0119948 0.0110598 0.010666 0.00778307 0.00544287 0.0107649 0.0134194
+          0.0171798 0.0170467 0.0175842 0.0172296 0.0167898 0.0162536 0.0151939 0.0147173 0.0140496 0.0141031 0.0141153 0.0143507
+          0.0143683 0.0144297 0.0139146 0.0138943 0.0134986 0.0136386 0.0136487 0.0138372 0.0137341 0.011209 0.00390576 0.00615955
+          0.00500126 0.00322374 0.000648207 0.00140888 0.00342367 0.00515099 0.00680611 0.00854416 0.00983073 0.0108906 0.0114577 0.0115399
+          0.0117037 0.0117007 0.0121068 0.0125071 0.0131214 0.0136962 0.0141422 0.0144653 0.0145485 0.0138269 0.0120052 0.000839234
+          0.00500953 0.00939956 0.0120917 0.0144031 0.0160976 0.0161401 0.0163353 0.0154978 0.014439 0.013481 0.0126341 0.0123416
+          0.0124046 0.0125792 0.0128045 0.0129244 0.0126638 0.0127181 0.012579 0.0128873 0.0131923 0.0135529 0.0137342 0.0130788
+          0.00205711 0.00137078 0.000413238 0.000213417 0.000194021 0.000687623 0.00114339 0.00207803 0.00308644 0.00459754 0.00582319 0.00707262
+          0.00768371 0.00811861 0.00823318 0.00854241 0.00888523 0.00962853 0.0102686 0.0111193 0.0115349 0.0120836 0.0122 0.0117512
+          0.0117288 0.00638272 0.0095636 0.0123147 0.0144628 0.0155616 0.0166798 0.016898 0.017399 0.0159399 0.0158379 0.0135702
+          0.013324 0.0118886 0.0119366 0.0113858 0.0116327 0.0108927 0.0110238 0.00989649 0.0099561 0.00949564 0.00918491 0.00958772
+          0.00950815 0.0126245 0.0039909 0.00584697 0.00730306 0.00834882 0.00897751 0.0100027 0.0105629 0.0108807 0.0105696 0.00910884
+          0.00805424 0.00632117 0.00546168 0.00501382 0.00475995 0.0046599 0.00444977 0.00325211 0.00267858 0.00190008 0.00132218 0.00161902
+          0.00187201 0.00204248 0.00609298
+        </DataArray>
+        <DataArray type="Float32" Name="l_mix" NumberOfComponents="1" format="ascii">
+          0.0187616 0.0186478 0.0185727 0.0184864 0.0184262 0.0183663 0.0183223 0.0182794 0.0182462 0.0182135 0.0181873 0.0181615
+          0.0181404 0.0181194 0.0181021 0.0180848 0.0180706 0.0180563 0.018045 0.0180339 0.0180264 0.01802 0.0180215 0.018033
+          0.0176243 0.0614569 0.0614469 0.0614397 0.0614305 0.0614236 0.0614162 0.0614106 0.0614048 0.0614002 0.0613955 0.0613917
+          0.0613878 0.0613845 0.0613812 0.0613785 0.0613757 0.0613734 0.061371 0.0613691 0.0613672 0.0613659 0.0613648 0.0613651
+          0.0613671 0.0612839 0.1025 0.102499 0.102499 0.102499 0.102499 0.102498 0.102498 0.102498 0.102498 0.102498
+          0.102498 0.102497 0.102497 0.102497 0.102497 0.102497 0.102497 0.102497 0.102497 0.102497 0.102497 0.102497
+          0.102497 0.102497 0.102492 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435
+          0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435 0.1435
+          0.1435 0.1435 0.1435 0.1435 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845
+          0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845 0.1845
+          0.1845 0.1845 0.1845 0.1845 0.1845 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255
+          0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2255
+          0.2255 0.2255 0.2255 0.2255 0.2255 0.2255 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665
+          0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665
+          0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.2665 0.3075 0.3075 0.3075 0.3075 0.3075
+          0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075
+          0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3075 0.3485 0.3485 0.3485 0.3485
+          0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485
+          0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3485 0.3895 0.3895 0.3895
+          0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895
+          0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.3895 0.4305 0.4305
+          0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305
+          0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4305 0.4715
+          0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715
+          0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715 0.4715
+          0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125
+          0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125 0.5125
+          0.5125 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535
+          0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535 0.5535
+          0.5535 0.5535 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945
+          0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945 0.5945
+          0.5945 0.5945 0.5945
+        </DataArray>
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
+          65.316 63.3659 62.1492 60.8222 59.9295 59.076 58.4619 57.8814 57.4369 57.0113 56.6715 56.3438
+          56.0764 55.8162 55.6014 55.3905 55.2167 55.0444 54.9081 54.7739 54.6859 54.6111 54.6291 54.7646
+          68.2865 134.877 135.995 135.433 134.666 133.623 132.579 131.591 130.657 129.828 129.055 128.377
+          127.748 127.196 126.677 126.219 125.787 125.406 125.046 124.737 124.45 124.225 124.041 123.942
+          123.838 133.945 139.382 146.214 148.734 151.173 151.896 152.387 152.194 151.96 151.493 151.073
+          150.579 150.151 149.699 149.298 148.888 148.521 148.155 147.829 147.513 147.238 146.97 146.75
+          146.446 145.84 157.86 139.028 145.875 149.827 154.026 156.437 158.591 159.695 160.615 160.953
+          161.243 161.228 161.248 161.107 161.006 160.807 160.651 160.432 160.257 160.039 159.863 159.64
+          159.445 159.052 158.284 171.636 138.207 144.117 148.156 152.707 155.801 158.816 160.887 162.783
+          164.028 165.183 165.881 166.539 166.873 167.213 167.329 167.487 167.498 167.552 167.501 167.488
+          167.368 167.254 166.867 166.083 180.316 137.755 143.075 146.871 151.29 154.414 157.525 159.842
+          162.083 163.816 165.491 166.784 168.006 168.893 169.767 170.343 170.924 171.262 171.629 171.799
+          172.01 172.038 172.061 171.743 171.017 185.819 137.491 142.435 146.024 150.268 153.316 156.404
+          158.72 161.008 162.821 164.598 166.075 167.524 168.734 169.929 170.898 171.836 172.549 173.278
+          173.766 174.269 174.531 174.754 174.56 173.945 189.066 137.359 142.099 145.513 149.569 152.52
+          155.546 157.834 160.123 161.938 163.75 165.245 166.74 168.008 169.261 170.347 171.419 172.339
+          173.261 174.006 174.722 175.227 175.653 175.641 175.191 190.474 137.258 141.846 145.149 149.085
+          151.965 154.929 157.181 159.446 161.248 163.064 164.559 166.069 167.342 168.621 169.716 170.82
+          171.77 172.714 173.517 174.293 174.888 175.402 175.514 175.167 190.564 137.191 141.708 144.931
+          148.74 151.561 154.461 156.686 158.93 160.719 162.531 164.021 165.535 166.804 168.094 169.188
+          170.303 171.252 172.211 173.01 173.801 174.391 174.91 175.038 174.703 190.173 137.159 141.623
+          144.79 148.516 151.301 154.163 156.363 158.588 160.361 162.165 163.643 165.152 166.411 167.697
+          168.783 169.897 170.838 171.798 172.588 173.377 173.957 174.471 174.595 174.273 189.78 137.197
+          141.647 144.755 148.429 151.156 153.97 156.141 158.338 160.097 161.887 163.357 164.859 166.112
+          167.395 168.476 169.586 170.519 171.476 172.255 173.037 173.607 174.112 174.231 173.917 189.43
+          137.171 141.584 144.66 148.301 151.001 153.788 155.953 158.138 159.895 161.681 163.148 164.647
+          165.896 167.173 168.25 169.354 170.281 171.233 172.005 172.78 173.341 173.836 173.95 173.64
+          189.137 137.108 141.502 144.571 148.19 150.881 153.651 155.808 157.978 159.736 161.508 162.981
+          164.468 165.723 166.994 168.075 169.172 170.102 171.045 171.819 172.585 173.145 173.638 173.747
+          173.442 188.893 137.088 141.469 144.526 148.135 150.82 153.588 155.746 157.914 159.681 161.443
+          162.927 164.404 165.664 166.931 168.014 169.108 170.042 170.975 171.755 172.506 173.062 173.554
+          173.653 173.347 188.727
+        </DataArray>
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
+          65.316 63.3659 62.1492 60.8222 59.9295 59.076 58.4619 57.8814 57.4369 57.0113 56.6715 56.3438
+          56.0764 55.8162 55.6014 55.3905 55.2167 55.0444 54.9081 54.7756 54.6859 54.6111 54.6291 54.7646
+          50.3303 195.948 190.098 186.447 182.467 179.788 177.228 175.386 173.644 172.311 171.034 170.014
+          169.031 168.229 167.449 166.804 166.171 165.65 165.133 164.724 164.327 164.058 163.833 163.887
+          164.294 150.991 326.58 316.83 310.746 304.111 299.647 295.38 292.309 289.407 287.184 285.057
+          283.357 281.719 280.382 279.081 278.007 276.952 276.083 275.222 274.54 273.878 273.43 273.056
+          273.145 273.823 251.651 457.212 443.561 435.044 425.755 419.506 413.532 409.233 405.17 402.058
+          399.079 396.7 394.406 392.535 390.713 389.21 387.733 386.517 385.311 384.356 383.429 382.801
+          382.278 382.404 383.352 352.312 587.844 570.293 559.342 547.4 539.365 531.684 526.157 520.932
+          516.932 513.102 510.043 507.094 504.687 502.346 500.413 498.514 496.95 495.4 494.173 492.98
+          492.173 491.5 491.662 492.882 452.973 718.476 697.025 683.641 669.044 659.224 649.836 643.081
+          636.695 631.806 627.124 623.386 619.781 616.84 613.978 611.616 609.295 607.384 605.489 603.989
+          602.531 601.545 600.722 600.92 602.411 553.633 849.108 823.757 807.939 790.689 779.083 767.988
+          760.004 752.458 746.679 741.147 736.729 732.469 728.993 725.611 722.819 720.076 717.817 715.578
+          713.805 712.082 710.917 709.944 710.178 711.94 654.294 979.74 950.489 932.237 912.333 898.942
+          886.14 876.928 868.22 861.553 855.17 850.072 845.156 841.146 837.243 834.021 830.857 828.251
+          825.666 823.621 821.633 820.289 819.167 819.436 821.469 754.954 1110.37 1077.22 1056.54 1033.98
+          1018.8 1004.29 993.852 983.983 976.427 969.192 963.415 957.844 953.298 948.876 945.224 941.638
+          938.684 935.755 933.437 931.185 929.661 928.389 928.694 930.998 855.615 1241 1203.95 1180.83
+          1155.62 1138.66 1122.44 1110.78 1099.75 1091.3 1083.21 1076.76 1070.53 1065.45 1060.51 1056.43
+          1052.42 1049.12 1045.84 1043.25 1040.74 1039.03 1037.61 1037.95 1040.53 956.276 1371.64 1330.68
+          1305.13 1277.27 1258.52 1240.6 1227.7 1215.51 1206.17 1197.24 1190.1 1183.22 1177.6 1172.14
+          1167.63 1163.2 1159.55 1155.93 1153.07 1150.29 1148.4 1146.83 1147.21 1150.06 1056.94 1502.27
+          1457.42 1429.43 1398.91 1378.38 1358.75 1344.62 1331.27 1321.05 1311.26 1303.44 1295.91 1289.76
+          1283.77 1278.83 1273.98 1269.98 1266.02 1262.89 1259.84 1257.78 1256.06 1256.47 1259.59 1157.6
+          1632.9 1584.15 1553.73 1520.56 1498.24 1476.9 1461.55 1447.03 1435.92 1425.28 1416.79 1408.59
+          1401.91 1395.41 1390.04 1384.76 1380.42 1376.11 1372.7 1369.39 1367.15 1365.28 1365.73 1369.12
+          1258.26 1763.53 1710.88 1678.03 1642.2 1618.1 1595.05 1578.47 1562.8 1550.8 1539.31 1530.13
+          1521.28 1514.06 1507.04 1501.24 1495.54 1490.85 1486.2 1482.52 1478.94 1476.52 1474.5 1474.99
+          1478.64 1358.92 1894.16 1837.61 1802.33 1763.84 1737.96 1713.2 1695.39 1678.56 1665.67 1653.33
+          1643.47 1633.97 1626.21 1618.67 1612.44 1606.32 1601.28 1596.29 1592.33 1588.49 1585.89 1583.72
+          1584.24 1588.17 1459.58
+        </DataArray>
+      </CellData>
       <Points>
         <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
           0 0 0 0.2 0 0 0 0.1 0 0.2 0.1 0