diff --git a/dumux/porousmediumflow/2pncmin/implicit/model.hh b/dumux/porousmediumflow/2pncmin/implicit/model.hh
index 436e2f45680e73be5a246d3e0b0e0bda038a6229..3b9e31c0aa296be2e623b29c1a3a7abeeb65bd4e 100644
--- a/dumux/porousmediumflow/2pncmin/implicit/model.hh
+++ b/dumux/porousmediumflow/2pncmin/implicit/model.hh
@@ -110,8 +110,8 @@ namespace Dumux
 template<class TypeTag>
 class TwoPNCMinModel: public TwoPNCModel<TypeTag>
 {
-    typedef TwoPNCMinModel<TypeTag> ThisType;
-    typedef TwoPNCModel<TypeTag> ParentType;
+    typedef Dumux::TwoPNCMinModel<TypeTag> ThisType;
+    typedef Dumux::TwoPNCModel<TypeTag> ParentType;
 
     typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
     typedef typename GET_PROP_TYPE(TypeTag, Problem) Problem;
@@ -119,13 +119,8 @@ class TwoPNCMinModel: public TwoPNCModel<TypeTag>
     typedef typename GET_PROP_TYPE(TypeTag, GridView) GridView;
 
     typedef typename GET_PROP_TYPE(TypeTag, FVElementGeometry) FVElementGeometry;
-    typedef typename GET_PROP_TYPE(TypeTag, PrimaryVariables) PrimaryVariables;
     typedef typename GET_PROP_TYPE(TypeTag, VolumeVariables) VolumeVariables;
     typedef typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables) ElementVolumeVariables;
-    typedef typename GET_PROP_TYPE(TypeTag, ElementBoundaryTypes) ElementBoundaryTypes;
-    typedef typename GET_PROP_TYPE(TypeTag, FluxVariables) FluxVariables;
-    typedef typename GET_PROP_TYPE(TypeTag, VertexMapper) VertexMapper;
-    typedef typename GET_PROP_TYPE(TypeTag, ElementMapper) ElementMapper;
     typedef typename GET_PROP_TYPE(TypeTag, SolutionVector) SolutionVector;
     typedef typename GET_PROP_TYPE(TypeTag, Indices) Indices;
     typedef Dumux::Constants<Scalar> Constant;
@@ -182,37 +177,32 @@ public:
      */
     template<class MultiWriter>
     //additional output of the permeability and the precipitate volume fractions
-    void addOutputVtkFields(const SolutionVector &sol,
-                            MultiWriter &writer)
+    void addOutputVtkFields(const SolutionVector &sol, MultiWriter &writer)
     {
         typedef Dune::BlockVector<Dune::FieldVector<Scalar, 1> > ScalarField;
         typedef Dune::BlockVector<Dune::FieldVector<double, dim> > VectorField;
 
         // get the number of degrees of freedom
-        unsigned numDofs = this->numDofs();
+        auto numDofs = this->numDofs();
 
         // create the required scalar fields
-        ScalarField *Sg           = writer.allocateManagedBuffer (numDofs);
-        ScalarField *Sl        = writer.allocateManagedBuffer (numDofs);
+        ScalarField *Sg           = writer.allocateManagedBuffer(numDofs);
+        ScalarField *Sl           = writer.allocateManagedBuffer(numDofs);
         ScalarField *pg           = writer.allocateManagedBuffer (numDofs);
         ScalarField *pl           = writer.allocateManagedBuffer (numDofs);
-        ScalarField *pc        = writer.allocateManagedBuffer (numDofs);
-        ScalarField *rhoL       = writer.allocateManagedBuffer (numDofs);
-        ScalarField *rhoG       = writer.allocateManagedBuffer (numDofs);
-        ScalarField *mobL       = writer.allocateManagedBuffer (numDofs);
-        ScalarField *mobG        = writer.allocateManagedBuffer (numDofs);
+        ScalarField *pc           = writer.allocateManagedBuffer (numDofs);
+        ScalarField *rhoL         = writer.allocateManagedBuffer (numDofs);
+        ScalarField *rhoG         = writer.allocateManagedBuffer (numDofs);
+        ScalarField *mobL         = writer.allocateManagedBuffer (numDofs);
+        ScalarField *mobG         = writer.allocateManagedBuffer (numDofs);
         ScalarField *phasePresence = writer.allocateManagedBuffer (numDofs);
-        ScalarField *temperature   = writer.allocateManagedBuffer (numDofs);
-        ScalarField *poro          = writer.allocateManagedBuffer (numDofs);
-        ScalarField *boxVolume     = writer.allocateManagedBuffer (numDofs);
-        ScalarField *cellNum        = writer.allocateManagedBuffer (numDofs);
-        ScalarField *permeabilityFactor    = writer.allocateManagedBuffer (numDofs);
-        ScalarField *precipitateVolumeFraction[numSPhases] ;
+        ScalarField *temperature  = writer.allocateManagedBuffer (numDofs);
+        ScalarField *poro         = writer.allocateManagedBuffer (numDofs);
+        ScalarField *permeabilityFactor = writer.allocateManagedBuffer (numDofs);
+        ScalarField *precipitateVolumeFraction[numSPhases];
 
         for (int i = 0; i < numSPhases; ++i)
-        {
-            precipitateVolumeFraction[i]= writer.allocateManagedBuffer (numDofs);
-        }
+            precipitateVolumeFraction[i] = writer.allocateManagedBuffer(numDofs);
 
         ScalarField *massFraction[numPhases][numComponents];
         for (int i = 0; i < numPhases; ++i)
@@ -227,8 +217,6 @@ public:
         for (int j = 0; j < dim; ++j) //Permeability only in main directions xx and yy
             Perm[j] = writer.allocateManagedBuffer(numDofs);
 
-        *boxVolume = 0;
-
         VectorField *velocityN = writer.template allocateManagedBuffer<double, dim>(numDofs);
         VectorField *velocityW = writer.template allocateManagedBuffer<double, dim>(numDofs);
         ImplicitVelocityOutput<TypeTag> velocityOutput(this->problem_());
@@ -240,76 +228,58 @@ public:
             {
                 (*velocityN)[i] = Scalar(0);
                 (*velocityW)[i] = Scalar(0);
-                (*cellNum)[i] = Scalar(0.0);
             }
         }
 
-        unsigned numElements = this->gridView_().size(0);
-        ScalarField *rank =
-                writer.allocateManagedBuffer (numElements);
-
-        FVElementGeometry fvGeometry;
-        VolumeVariables volVars;
-        ElementVolumeVariables elemVolVars;
+        auto numElements = this->gridView_().size(0);
+        ScalarField *rank = writer.allocateManagedBuffer(numElements);
 
         for (const auto& element : elements(this->gridView_()))
         {
-            int idx = this->problem_().elementMapper().index(element);
-            (*rank)[idx] = this->gridView_().comm().rank();
+            auto eIdxGlobal = this->problem_().elementMapper().index(element);
+            (*rank)[eIdxGlobal] = this->gridView_().comm().rank();
+            FVElementGeometry fvGeometry;
             fvGeometry.update(this->gridView_(), element);
 
+            ElementVolumeVariables elemVolVars;
             elemVolVars.update(this->problem_(),
-                    element,
-                    fvGeometry,
-                    false /* oldSol? */);
-
-            int numVerts = element.subEntities(dim);
-
-            for (int i = 0; i < numVerts; ++i)
-            {
-                int globalIdx = this->vertexMapper().subIndex(element, i, dim);
-                volVars.update(sol[globalIdx],
-                               this->problem_(),
                                element,
                                fvGeometry,
-                               i,
-                               false);
+                               false /* oldSol? */);
 
-                (*Sg)[globalIdx]              = volVars.saturation(nPhaseIdx);
-                (*Sl)[globalIdx]              = volVars.saturation(wPhaseIdx);
-                (*pg)[globalIdx]                = volVars.pressure(nPhaseIdx);
-                (*pl)[globalIdx]                 = volVars.pressure(wPhaseIdx);
-                (*pc)[globalIdx]              = volVars.capillaryPressure();
-                (*rhoL)[globalIdx]               = volVars.density(wPhaseIdx);
-                (*rhoG)[globalIdx]               = volVars.density(nPhaseIdx);
-                (*mobL)[globalIdx]               = volVars.mobility(wPhaseIdx);
-                (*mobG)[globalIdx]               = volVars.mobility(nPhaseIdx);
-                (*boxVolume)[globalIdx]        += fvGeometry.subContVol[i].volume;
-                (*poro)[globalIdx]              = volVars.porosity();
+            for (int scvIdx = 0; scvIdx < fvGeometry.numScv; ++scvIdx)
+            {
+                auto dofIdxGlobal = this->dofMapper().subIndex(element, scvIdx, dofCodim);
+
+                (*Sg)[dofIdxGlobal] = elemVolVars[scvIdx].saturation(nPhaseIdx);
+                (*Sl)[dofIdxGlobal] = elemVolVars[scvIdx].saturation(wPhaseIdx);
+                (*pg)[dofIdxGlobal] = elemVolVars[scvIdx].pressure(nPhaseIdx);
+                (*pl)[dofIdxGlobal] = elemVolVars[scvIdx].pressure(wPhaseIdx);
+                (*pc)[dofIdxGlobal] = elemVolVars[scvIdx].capillaryPressure();
+                (*rhoL)[dofIdxGlobal] = elemVolVars[scvIdx].density(wPhaseIdx);
+                (*rhoG)[dofIdxGlobal] = elemVolVars[scvIdx].density(nPhaseIdx);
+                (*mobL)[dofIdxGlobal] = elemVolVars[scvIdx].mobility(wPhaseIdx);
+                (*mobG)[dofIdxGlobal] = elemVolVars[scvIdx].mobility(nPhaseIdx);
+                (*poro)[dofIdxGlobal] = elemVolVars[scvIdx].porosity();
 
                 for (int sPhaseIdx = 0; sPhaseIdx < numSPhases; ++sPhaseIdx)
-                {
-                    (*precipitateVolumeFraction[sPhaseIdx])[globalIdx]   = volVars.precipitateVolumeFraction(sPhaseIdx + numPhases);
-                }
-                (*temperature)[globalIdx]      = volVars.temperature();
-                (*permeabilityFactor)[globalIdx]      = volVars.permeabilityFactor();
-                (*phasePresence)[globalIdx]  = this->staticDat_[globalIdx].phasePresence;
+                    (*precipitateVolumeFraction[sPhaseIdx])[dofIdxGlobal] = elemVolVars[scvIdx].precipitateVolumeFraction(sPhaseIdx + numPhases);
+
+                (*temperature)[dofIdxGlobal] = elemVolVars[scvIdx].temperature();
+                (*permeabilityFactor)[dofIdxGlobal] = elemVolVars[scvIdx].permeabilityFactor();
+                (*phasePresence)[dofIdxGlobal] = this->staticDat_[dofIdxGlobal].phasePresence;
 
                 for (int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx)
                     for (int compIdx = 0; compIdx < numComponents; ++compIdx)
-                    {
-                        (*massFraction[phaseIdx][compIdx])[globalIdx]= volVars.massFraction(phaseIdx,compIdx);
+                        (*massFraction[phaseIdx][compIdx])[dofIdxGlobal]= elemVolVars[scvIdx].massFraction(phaseIdx,compIdx);
 
-                        Valgrind::CheckDefined((*massFraction[phaseIdx][compIdx])[globalIdx]);
-
-                    }
                 for (int compIdx = 0; compIdx < numComponents; ++compIdx)
-                    (*molarity[compIdx])[globalIdx] = (volVars.molarity(wPhaseIdx, compIdx));
+                    (*molarity[compIdx])[dofIdxGlobal] = (elemVolVars[scvIdx].molarity(wPhaseIdx, compIdx));
 
-                Tensor K = this->perm_(this->problem_().spatialParams().intrinsicPermeability(element, fvGeometry, i));
+                Tensor K = this->perm_(this->problem_().spatialParams().intrinsicPermeability(element, fvGeometry, scvIdx));
 
                 for (int j = 0; j<dim; ++j)
-                    (*Perm[j])[globalIdx] = K[j][j] * volVars.permeabilityFactor();
+                    (*Perm[j])[dofIdxGlobal] = K[j][j] * elemVolVars[scvIdx].permeabilityFactor();
             };
 
             // velocity output
@@ -319,55 +289,48 @@ public:
             }
         }  // loop over element
 
-        writer.attachVertexData(*Sg, "Sg");
-        writer.attachVertexData(*Sl, "Sl");
-        writer.attachVertexData(*pg, "pg");
-        writer.attachVertexData(*pl, "pl");
-        writer.attachVertexData(*pc, "pc");
-        writer.attachVertexData(*rhoL, "rhoL");
-        writer.attachVertexData(*rhoG, "rhoG");
-        writer.attachVertexData(*mobL, "mobL");
-        writer.attachVertexData(*mobG, "mobG");
-        writer.attachVertexData(*poro, "porosity");
-        writer.attachVertexData(*permeabilityFactor, "permeabilityFactor");
-        writer.attachVertexData(*temperature, "temperature");
-        writer.attachVertexData(*phasePresence, "phase presence");
-        writer.attachVertexData(*boxVolume, "boxVolume");
-
+        writer.attachDofData(*Sg, "Sg", isBox);
+        writer.attachDofData(*Sl, "Sl", isBox);
+        writer.attachDofData(*pg, "pg", isBox);
+        writer.attachDofData(*pl, "pl", isBox);
+        writer.attachDofData(*pc, "pc", isBox);
+        writer.attachDofData(*rhoL, "rhoL", isBox);
+        writer.attachDofData(*rhoG, "rhoG", isBox);
+        writer.attachDofData(*mobL, "mobL", isBox);
+        writer.attachDofData(*mobG, "mobG", isBox);
+        writer.attachDofData(*poro, "porosity", isBox);
+        writer.attachDofData(*permeabilityFactor, "permeabilityFactor", isBox);
+        writer.attachDofData(*temperature, "temperature", isBox);
+        writer.attachDofData(*phasePresence, "phase presence", isBox);
 
         for (int i = 0; i < numSPhases; ++i)
         {
             std::ostringstream oss;
-            oss << "precipitateVolumeFraction_"
-                << FluidSystem::phaseName(numPhases + i);
-            writer.attachDofData(*precipitateVolumeFraction[i], oss.str().c_str(), isBox);
+            oss << "precipitateVolumeFraction_" << FluidSystem::phaseName(numPhases + i);
+            writer.attachDofData(*precipitateVolumeFraction[i], oss.str(), isBox);
         }
 
-        writer.attachVertexData(*Perm[0], "Kxx");
+        writer.attachDofData(*Perm[0], "Kxx", isBox);
         if (dim >= 2)
-            writer.attachVertexData(*Perm[1], "Kyy");
+            writer.attachDofData(*Perm[1], "Kyy", isBox);
         if (dim == 3)
-            writer.attachVertexData(*Perm[2], "Kzz");
+            writer.attachDofData(*Perm[2], "Kzz", isBox);
 
         for (int i = 0; i < numPhases; ++i)
         {
             for (int j = 0; j < numComponents; ++j)
             {
                 std::ostringstream oss;
-                oss << "X^"
-                << FluidSystem::phaseName(i)
-                << "_"
-                << FluidSystem::componentName(j);
-                writer.attachVertexData(*massFraction[i][j], oss.str().c_str());
+                oss << "X^" << FluidSystem::phaseName(i) << "_" << FluidSystem::componentName(j);
+                writer.attachDofData(*massFraction[i][j], oss.str(), isBox);
             }
         }
 
         for (int j = 0; j < numComponents; ++j)
         {
             std::ostringstream oss;
-            oss << "m^w_"
-                << FluidSystem::componentName(j);
-            writer.attachVertexData(*molarity[j], oss.str().c_str());
+            oss << "m^w_" << FluidSystem::componentName(j);
+            writer.attachDofData(*molarity[j], oss.str(), isBox);
         }
 
         if (velocityOutput.enableOutput()) // check if velocity output is demanded
@@ -397,29 +360,24 @@ public:
         {
             FVElementGeometry fvGeometry;
             fvGeometry.update(this->gridView_(), element);
-            for (int i = 0; i < fvGeometry.numScv; ++i)
+            for (int scvIdx = 0; scvIdx < fvGeometry.numScv; ++scvIdx)
             {
-                int globalIdx = this->vertexMapper().subIndex(element, i, dim);
+                auto dofIdxGlobal = this->dofMapper().subIndex(element, scvIdx, dofCodim);
 
-                if (this->staticDat_[globalIdx].visited)
+                if (this->staticDat_[dofIdxGlobal].visited)
                     continue;
 
-                this->staticDat_[globalIdx].visited = true;
+                this->staticDat_[dofIdxGlobal].visited = true;
                 VolumeVariables volVars;
-                volVars.update(curGlobalSol[globalIdx],
+                volVars.update(curGlobalSol[dofIdxGlobal],
                                this->problem_(),
                                element,
                                fvGeometry,
-                               i,
+                               scvIdx,
                                false);
-                auto global = element.geometry().corner(i);
-                if (primaryVarSwitch_(curGlobalSol,
-                                      volVars,
-                                      globalIdx,
-                                      global))
-                {
+                auto global = element.geometry().corner(scvIdx);
+                if (primaryVarSwitch_(curGlobalSol, volVars, dofIdxGlobal, global))
                     wasSwitched = true;
-                }
             }
         }
 
@@ -429,133 +387,123 @@ public:
         if (this->gridView_().comm().size() > 1)
             wasSwitched = this->gridView_().comm().max(wasSwitched);
 
-        setSwitched_(wasSwitched);
+        this->setSwitched_(wasSwitched);
     }
 protected:
 
-    /*!
-     * \brief Set whether there was a primary variable switch after in
-     *        the last timestep.
-     */
-    void setSwitched_(bool yesno)
-    {
-        switchFlag_ = yesno;
-    }
-
     /*!
      * \brief Set whether there was a primary variable switch after in
      *        the last timestep.
      */
     bool primaryVarSwitch_(SolutionVector &globalSol,
-                           const VolumeVariables &volVars, int globalIdx,
+                           const VolumeVariables &volVars,
+                           int dofIdxGlobal,
                            const GlobalPosition &globalPos)
     {
-            // evaluate primary variable switch
-            bool wouldSwitch = false;
-            int phasePresence = this->staticDat_[globalIdx].phasePresence;
-            int newPhasePresence = phasePresence;
+        // evaluate primary variable switch
+        bool wouldSwitch = false;
+        int phasePresence = this->staticDat_[dofIdxGlobal].phasePresence;
+        int newPhasePresence = phasePresence;
+
+        //check if a primary variable switch is necessary
+        if (phasePresence == bothPhases)
+        {
+            Scalar Smin = 0.0; //saturation threshold
+            if (this->staticDat_[dofIdxGlobal].wasSwitched)
+                Smin = -0.01;
 
-            //check if a primary variable switch is necessary
-            if (phasePresence == bothPhases)
+            //if saturation of liquid phase is smaller 0 switch
+            if (volVars.saturation(wPhaseIdx) <= Smin)
             {
-                Scalar Smin = 0.0; //saturation threshold
-                if (this->staticDat_[globalIdx].wasSwitched)
-                    Smin = -0.01;
-
-                //if saturation of liquid phase is smaller 0 switch
-                if (volVars.saturation(wPhaseIdx) <= Smin)
-                {
-                    wouldSwitch = true;
-                    //liquid phase has to disappear
-                    std::cout << "Liquid Phase disappears at vertex " << globalIdx
-                                << ", coordinated: " << globalPos << ", Sl: "
-                                << volVars.saturation(wPhaseIdx) << std::endl;
-                    newPhasePresence = nPhaseOnly;
-
-                    //switch not depending on formulation
-                    //switch "Sl" to "xgH20"
-                    globalSol[globalIdx][switchIdx]
-                            = volVars.moleFraction(nPhaseIdx, wCompIdx /*H2O*/);
-                    //Here unlike 2pnc model we do not switch all components to to mole fraction in gas phase
-                }
-                //if saturation of gas phase is smaller than 0 switch
-                else if (volVars.saturation(nPhaseIdx) <= Smin)
-                {
-                    wouldSwitch = true;
-                    //gas phase has to disappear
-                    std::cout << "Gas Phase disappears at vertex " << globalIdx
-                                << ", coordinated: " << globalPos << ", Sg: "
-                                << volVars.saturation(nPhaseIdx) << std::endl;
-                    newPhasePresence = wPhaseOnly;
-
-                    //switch "Sl" to "xlN2"
-                    globalSol[globalIdx][switchIdx] = volVars.moleFraction(wPhaseIdx, nCompIdx /*N2*/);
-                }
+                wouldSwitch = true;
+                //liquid phase has to disappear
+                std::cout << "Liquid Phase disappears at vertex " << dofIdxGlobal
+                            << ", coordinated: " << globalPos << ", Sl: "
+                            << volVars.saturation(wPhaseIdx) << std::endl;
+                newPhasePresence = nPhaseOnly;
+
+                //switch not depending on formulation
+                //switch "Sl" to "xgH20"
+                globalSol[dofIdxGlobal][switchIdx]
+                        = volVars.moleFraction(nPhaseIdx, wCompIdx /*H2O*/);
+                //Here unlike 2pnc model we do not switch all components to to mole fraction in gas phase
             }
-            else if (phasePresence == nPhaseOnly)
+            //if saturation of gas phase is smaller than 0 switch
+            else if (volVars.saturation(nPhaseIdx) <= Smin)
+            {
+                wouldSwitch = true;
+                //gas phase has to disappear
+                std::cout << "Gas Phase disappears at vertex " << dofIdxGlobal
+                            << ", coordinated: " << globalPos << ", Sg: "
+                            << volVars.saturation(nPhaseIdx) << std::endl;
+                newPhasePresence = wPhaseOnly;
+
+                //switch "Sl" to "xlN2"
+                globalSol[dofIdxGlobal][switchIdx] = volVars.moleFraction(wPhaseIdx, nCompIdx /*N2*/);
+            }
+        }
+        else if (phasePresence == nPhaseOnly)
+        {
+            Scalar sumxl = 0;
+            //Calculate sum of mole fractions (water and air) in the hypothetical liquid phase
+            for (int compIdx = 0; compIdx < numComponents; compIdx++)
             {
-                Scalar sumxl = 0;
-                //Calculate sum of mole fractions (water and air) in the hypothetical liquid phase
-                for (int compIdx = 0; compIdx < numComponents; compIdx++)
-                {
-                    sumxl += volVars.moleFraction(wPhaseIdx, compIdx);
-                }
-                Scalar xlmax = 1.0;
-                if (sumxl > xlmax)
-                    wouldSwitch = true;
-                if (this->staticDat_[globalIdx].wasSwitched)
-                    xlmax *=1.02;
-
-                //if the sum of the mole fractions would be larger than
-                //1, wetting phase appears
-                if (sumxl/*sum of mole fractions*/ > xlmax/*1*/)
-                {
-                    // liquid phase appears
-                    std::cout << "Liquid Phase appears at vertex " << globalIdx
-                              << ", coordinated: " << globalPos << ", sumxl: "
-                              << sumxl << std::endl;
-                    newPhasePresence = bothPhases;
-                    if (formulation == pgSl)
-                        globalSol[globalIdx][switchIdx] = 0.0;
-                    else if (formulation == plSg)
-                        globalSol[globalIdx][switchIdx] = 1.0;
-                    //Here unlike 2pnc model we do not switch all components to to mole fraction in gas phase
-                }
+                sumxl += volVars.moleFraction(wPhaseIdx, compIdx);
             }
-            else if (phasePresence == wPhaseOnly)
+            Scalar xlmax = 1.0;
+            if (sumxl > xlmax)
+                wouldSwitch = true;
+            if (this->staticDat_[dofIdxGlobal].wasSwitched)
+                xlmax *=1.02;
+
+            //if the sum of the mole fractions would be larger than
+            //1, wetting phase appears
+            if (sumxl/*sum of mole fractions*/ > xlmax/*1*/)
             {
-                Scalar xgmax = 1;
-                Scalar sumxg = 0;
-                //Calculate sum of mole fractions in the hypothetical gas phase
-                for (int compIdx = 0; compIdx < numComponents; compIdx++)
-                {
-                    sumxg += volVars.moleFraction(nPhaseIdx, compIdx);
-                }
-                if (sumxg > xgmax)
-                    wouldSwitch = true;
-                if (this->staticDat_[globalIdx].wasSwitched)
-                    xgmax *=1.02;
-                //liquid phase appears if sum is larger than one
-                if (sumxg > xgmax)
-                {
-                    std::cout << "Gas Phase appears at vertex " << globalIdx
-                              << ", coordinated: " << globalPos << ", sumxg: "
-                              << sumxg << std::endl;
-                    newPhasePresence = bothPhases;
-                    //saturation of the liquid phase set to 0.9999 (if formulation pgSl and vice versa)
-                    if (formulation == pgSl)
-                        globalSol[globalIdx][switchIdx] = 0.999;
-                    else if (formulation == plSg)
-                        globalSol[globalIdx][switchIdx] = 0.001;
-
-                }
+                // liquid phase appears
+                std::cout << "Liquid Phase appears at vertex " << dofIdxGlobal
+                          << ", coordinated: " << globalPos << ", sumxl: "
+                          << sumxl << std::endl;
+                newPhasePresence = bothPhases;
+                if (formulation == pgSl)
+                    globalSol[dofIdxGlobal][switchIdx] = 0.0;
+                else if (formulation == plSg)
+                    globalSol[dofIdxGlobal][switchIdx] = 1.0;
+                //Here unlike 2pnc model we do not switch all components to to mole fraction in gas phase
             }
-            this->staticDat_[globalIdx].phasePresence = newPhasePresence;
-            this->staticDat_[globalIdx].wasSwitched = wouldSwitch;
-            return phasePresence != newPhasePresence;
         }
-        // parameters given in constructor
-        bool switchFlag_;
+        else if (phasePresence == wPhaseOnly)
+        {
+            Scalar xgmax = 1;
+            Scalar sumxg = 0;
+            //Calculate sum of mole fractions in the hypothetical gas phase
+            for (int compIdx = 0; compIdx < numComponents; compIdx++)
+            {
+                sumxg += volVars.moleFraction(nPhaseIdx, compIdx);
+            }
+            if (sumxg > xgmax)
+                wouldSwitch = true;
+            if (this->staticDat_[dofIdxGlobal].wasSwitched)
+                xgmax *=1.02;
+            //liquid phase appears if sum is larger than one
+            if (sumxg > xgmax)
+            {
+                std::cout << "Gas Phase appears at vertex " << dofIdxGlobal
+                          << ", coordinated: " << globalPos << ", sumxg: "
+                          << sumxg << std::endl;
+                newPhasePresence = bothPhases;
+                //saturation of the liquid phase set to 0.9999 (if formulation pgSl and vice versa)
+                if (formulation == pgSl)
+                    globalSol[dofIdxGlobal][switchIdx] = 0.999;
+                else if (formulation == plSg)
+                    globalSol[dofIdxGlobal][switchIdx] = 0.001;
+
+            }
+        }
+        this->staticDat_[dofIdxGlobal].phasePresence = newPhasePresence;
+        this->staticDat_[dofIdxGlobal].wasSwitched = wouldSwitch;
+        return phasePresence != newPhasePresence;
+    }
 };
 
 }
diff --git a/dumux/porousmediumflow/2pncmin/implicit/volumevariables.hh b/dumux/porousmediumflow/2pncmin/implicit/volumevariables.hh
index f3bc55e3d0e83f35df9408fe1f0769aa53180d19..f5b3930f3f544c8746dff7ccd17ece33261efcea 100644
--- a/dumux/porousmediumflow/2pncmin/implicit/volumevariables.hh
+++ b/dumux/porousmediumflow/2pncmin/implicit/volumevariables.hh
@@ -22,21 +22,22 @@
  * \brief Contains the quantities which are constant within a
  *        finite volume in the two-phase, n-component mineralization model.
  */
-#ifndef DUMUX_2PNCMin_VOLUME_VARIABLES_HH
-#define DUMUX_2PNCMin_VOLUME_VARIABLES_HH
+#ifndef DUMUX_2PNCMIN_VOLUME_VARIABLES_HH
+#define DUMUX_2PNCMIN_VOLUME_VARIABLES_HH
 
-#include <dumux/implicit/model.hh>
-#include <dumux/material/fluidstates/compositional.hh>
-#include <dumux/common/math.hh>
 #include <vector>
 #include <iostream>
 
-#include "properties.hh"
-#include "indices.hh"
+#include <dumux/common/math.hh>
+#include <dumux/implicit/model.hh>
+#include <dumux/material/fluidstates/compositional.hh>
 #include <dumux/material/constraintsolvers/computefromreferencephase2pncmin.hh>
 #include <dumux/material/constraintsolvers/miscible2pnccomposition.hh>
 #include <dumux/porousmediumflow/2pnc/implicit/volumevariables.hh>
 
+#include "properties.hh"
+#include "indices.hh"
+
 namespace Dumux
 {
 
@@ -120,104 +121,96 @@ public:
                 int scvIdx,
                 bool isOldSol)
     {
-        ParentType::update(priVars,
-                           problem,
-                           element,
-                           fvGeometry,
-                           scvIdx,
-                           isOldSol);
-
+        ParentType::update(priVars, problem, element, fvGeometry, scvIdx, isOldSol);
         completeFluidState(priVars, problem, element, fvGeometry, scvIdx, this->fluidState_, isOldSol);
 
-    /////////////
+        /////////////
         // calculate the remaining quantities
         /////////////
 
-    // porosity evaluation
-    initialPorosity_ = problem.spatialParams().porosity(element, fvGeometry, scvIdx);
-    minimumPorosity_ = problem.spatialParams().porosityMin(element, fvGeometry, scvIdx);
+        // porosity evaluation
+        initialPorosity_ = problem.spatialParams().porosity(element, fvGeometry, scvIdx);
+        minimumPorosity_ = problem.spatialParams().porosityMin(element, fvGeometry, scvIdx);
 
 
-    sumPrecipitates_ = 0.0;
-    for(int sPhaseIdx = 0; sPhaseIdx < numSPhases; ++sPhaseIdx)
-    {
-       precipitateVolumeFraction_[sPhaseIdx] = priVars[numComponents + sPhaseIdx];
-       sumPrecipitates_+= precipitateVolumeFraction_[sPhaseIdx];
-    }
+        sumPrecipitates_ = 0.0;
+        for(int sPhaseIdx = 0; sPhaseIdx < numSPhases; ++sPhaseIdx)
+        {
+           precipitateVolumeFraction_[sPhaseIdx] = priVars[numComponents + sPhaseIdx];
+           sumPrecipitates_+= precipitateVolumeFraction_[sPhaseIdx];
+        }
 
-//         for(int sPhaseIdx = 0; sPhaseIdx < numSPhases; ++sPhaseIdx)
-//     {
-//         Chemistry chemistry; // the non static functions can not be called without abject
-//         saturationIdx_[sPhaseIdx] = chemistry.omega(sPhaseIdx);
-//     }
-// TODO/FIXME: The salt crust porosity is not clearly defined. However form literature review it is
-//    found that the salt crust have porosity of approx. 10 %. Thus we restrict the decrease in porosity
-//    to this limit. Moreover in the Problem files the precipitation should also be made dependent on local
-//    porosity value, as the porous media media properties change related to salt precipitation will not be
-//    accounted otherwise.
-
-//      this->porosity_ = initialPorosity_ - sumPrecipitates_;
-
-     this->porosity_ = std::max(minimumPorosity_, std::max(0.0, initialPorosity_ - sumPrecipitates_));
-
-   salinity_= 0.0;
-   moleFractionSalinity_ = 0.0;
-   for (int compIdx = numMajorComponents; compIdx< numComponents; compIdx++)    //sum of the mass fraction of the components
-   {
-       if(this->fluidState_.moleFraction(wPhaseIdx, compIdx)> 0)
-       {
-          salinity_+= this->fluidState_.massFraction(wPhaseIdx, compIdx);
-          moleFractionSalinity_ += this->fluidState_.moleFraction(wPhaseIdx, compIdx);
-       }
-    }
+        // for(int sPhaseIdx = 0; sPhaseIdx < numSPhases; ++sPhaseIdx)
+        // {
+        //     Chemistry chemistry; // the non static functions can not be called without abject
+        //     saturationIdx_[sPhaseIdx] = chemistry.omega(sPhaseIdx);
+        // }
+        // TODO/FIXME: The salt crust porosity is not clearly defined. However form literature review it is
+        // found that the salt crust have porosity of approx. 10 %. Thus we restrict the decrease in porosity
+        // to this limit. Moreover in the Problem files the precipitation should also be made dependent on local
+        // porosity value, as the porous media media properties change related to salt precipitation will not be
+        // accounted otherwise.
 
-// TODO/FIXME: Different relations for the porosoty-permeability changes are given here. We have to fins a way
-//    so that one can select the relation form the input file.
+        // this->porosity_ = initialPorosity_ - sumPrecipitates_;
 
-    // kozeny-Carman relation
-    permeabilityFactor_  =  std::pow(((1-initialPorosity_)/(1-this->porosity_)),2)
-            * std::pow((this->porosity_/initialPorosity_),3);
+        this->porosity_ = std::max(minimumPorosity_, std::max(0.0, initialPorosity_ - sumPrecipitates_));
 
-    // Verma-Pruess relation
-//  permeabilityFactor_  =  100 * std::pow(((this->porosity_/initialPorosity_)-0.9),2);
+        salinity_= 0.0;
+        moleFractionSalinity_ = 0.0;
+        for (int compIdx = numMajorComponents; compIdx< numComponents; compIdx++)    //sum of the mass fraction of the components
+        {
+            if(this->fluidState_.moleFraction(wPhaseIdx, compIdx)> 0)
+            {
+                salinity_+= this->fluidState_.massFraction(wPhaseIdx, compIdx);
+                moleFractionSalinity_ += this->fluidState_.moleFraction(wPhaseIdx, compIdx);
+            }
+        }
 
-    // Modified Fair-Hatch relation with final porosity set to 0.2 and E1=1
-//  permeabilityFactor_  =  std::pow((this->porosity_/initialPorosity_),3)
-//         * std::pow((std::pow((1 - initialPorosity_),2/3))+(std::pow((0.2 - initialPorosity_),2/3)),2)
-//         / std::pow((std::pow((1 -this->porosity_),2/3))+(std::pow((0.2 -this->porosity_),2/3)),2);
+        // TODO/FIXME: Different relations for the porosoty-permeability changes are given here. We have to fins a way
+        // so that one can select the relation form the input file.
 
-    //Timur relation with residual water saturation set to 0.001
-//    permeabilityFactor_ =  0.136 * (std::pow(this->porosity_,4.4)) / (2000 * (std::pow(0.001,2)));
+        // kozeny-Carman relation
+        permeabilityFactor_  =  std::pow(((1-initialPorosity_)/(1-this->porosity_)), 2)
+                                * std::pow((this->porosity_/initialPorosity_), 3);
 
-    //Timur relation1 with residual water saturation set to 0.001
-//    permeabilityFactor_ =  0.136 * (std::pow(this->porosity_,4.4)) / (200000 * (std::pow(0.001,2)));
+        // Verma-Pruess relation
+        // permeabilityFactor_  =  100 * std::pow(((this->porosity_/initialPorosity_)-0.9),2);
 
+        // Modified Fair-Hatch relation with final porosity set to 0.2 and E1=1
+        // permeabilityFactor_  =  std::pow((this->porosity_/initialPorosity_),3)
+        //                         * std::pow((std::pow((1 - initialPorosity_),2/3))+(std::pow((0.2 - initialPorosity_),2/3)),2)
+        //                         / std::pow((std::pow((1 -this->porosity_),2/3))+(std::pow((0.2 -this->porosity_),2/3)),2);
 
-    //Bern. relation
-   // permeabilityFactor_ = std::pow((this->porosity_/initialPorosity_),8);
+        //Timur relation with residual water saturation set to 0.001
+        // permeabilityFactor_ =  0.136 * (std::pow(this->porosity_,4.4)) / (2000 * (std::pow(0.001,2)));
 
-    //Tixier relation with residual water saturation set to 0.001
-    //permeabilityFactor_ = (std::pow((250 * (std::pow(this->porosity_,3)) / 0.001),2)) / initialPermeability_;
+        //Timur relation1 with residual water saturation set to 0.001
+        // permeabilityFactor_ =  0.136 * (std::pow(this->porosity_,4.4)) / (200000 * (std::pow(0.001,2)));
 
-    //Coates relation with residual water saturation set to 0.001
-    //permeabilityFactor_ = (std::pow((100 * (std::pow(this->porosity_,2)) * (1-0.001) / 0.001,2))) / initialPermeability_ ;
+        // Bern. relation
+        // permeabilityFactor_ = std::pow((this->porosity_/initialPorosity_),8);
 
+        //Tixier relation with residual water saturation set to 0.001
+        // permeabilityFactor_ = (std::pow((250 * (std::pow(this->porosity_,3)) / 0.001),2)) / initialPermeability_;
 
-    // energy related quantities not contained in the fluid state
-    //asImp_().updateEnergy_(priVars, problem,element, fvGeometry, scvIdx, isOldSol);
+        //Coates relation with residual water saturation set to 0.001
+        // permeabilityFactor_ = (std::pow((100 * (std::pow(this->porosity_,2)) * (1-0.001) / 0.001,2))) / initialPermeability_ ;
+
+        // energy related quantities not contained in the fluid state
+        //asImp_().updateEnergy_(priVars, problem,element, fvGeometry, scvIdx, isOldSol);
     }
 
    /*!
     * \copydoc ImplicitModel::completeFluidState
     * \param isOldSol Specifies whether this is the previous solution or the current one
     */
-  static void completeFluidState(const PrimaryVariables& priVars,
-                                 const Problem& problem,
-                                 const Element& element,
-                                 const FVElementGeometry& fvGeometry,
-                                 int scvIdx,
-                                 FluidState& fluidState,
-                                 bool isOldSol = false)
+    static void completeFluidState(const PrimaryVariables& priVars,
+                                   const Problem& problem,
+                                   const Element& element,
+                                   const FVElementGeometry& fvGeometry,
+                                   int scvIdx,
+                                   FluidState& fluidState,
+                                   bool isOldSol = false)
 
     {
         Scalar t = Implementation::temperature_(priVars, problem, element,fvGeometry, scvIdx);
@@ -232,18 +225,24 @@ public:
 
         Scalar Sg;
         if (phasePresence == nPhaseOnly)
+        {
             Sg = 1.0;
-        else if (phasePresence == wPhaseOnly) {
+        }
+        else if (phasePresence == wPhaseOnly)
+        {
             Sg = 0.0;
         }
-        else if (phasePresence == bothPhases) {
+        else if (phasePresence == bothPhases)
+        {
             if (formulation == plSg)
                 Sg = priVars[switchIdx];
             else if (formulation == pgSl)
                 Sg = 1.0 - priVars[switchIdx];
-            else DUNE_THROW(Dune::InvalidStateException, "Formulation: " << formulation << " is invalid.");
+            else
+                DUNE_THROW(Dune::InvalidStateException, "Formulation: " << formulation << " is invalid.");
         }
-        else DUNE_THROW(Dune::InvalidStateException, "phasePresence: " << phasePresence << " is invalid.");
+        else
+            DUNE_THROW(Dune::InvalidStateException, "phasePresence: " << phasePresence << " is invalid.");
         fluidState.setSaturation(nPhaseIdx, Sg);
         fluidState.setSaturation(wPhaseIdx, 1.0 - Sg);
 
@@ -270,10 +269,11 @@ public:
         // calculate the phase compositions
         /////////////
 
-    typename FluidSystem::ParameterCache paramCache;
+        typename FluidSystem::ParameterCache paramCache;
 
         // now comes the tricky part: calculate phase composition
-        if (phasePresence == bothPhases) {
+        if (phasePresence == bothPhases)
+        {
             // both phases are present, phase composition results from
             // the gas <-> liquid equilibrium. This is
             // the job of the "MiscibleMultiPhaseComposition"
@@ -292,8 +292,8 @@ public:
                                             /*setViscosity=*/true,
                                             /*setInternalEnergy=*/false);
         }
-        else if (phasePresence == nPhaseOnly){
-
+        else if (phasePresence == nPhaseOnly)
+        {
             Dune::FieldVector<Scalar, numComponents> moleFrac;
             Dune::FieldVector<Scalar, numComponents> fugCoeffL;
             Dune::FieldVector<Scalar, numComponents> fugCoeffG;
@@ -322,10 +322,6 @@ public:
             sumMoleFracNotGas += moleFrac[wCompIdx];
             moleFrac[nCompIdx] = 1 - sumMoleFracNotGas;
 
-//          typedef Dune::FieldMatrix<Scalar, numComponents, numComponents> Matrix;
-//          typedef Dune::FieldVector<Scalar, numComponents> Vector;
-
-
             // Set fluid state mole fractions
             for (int compIdx=0; compIdx<numComponents; ++compIdx)
             {
@@ -343,11 +339,12 @@ public:
                                                     /*setInternalEnergy=*/false);
 
             }
-        else if (phasePresence == wPhaseOnly){
+        else if (phasePresence == wPhaseOnly)
+        {
 
-        // only the liquid phase is present, i.e. liquid phase
-        // composition is stored explicitly.
-        // extract _mass_ fractions in the gas phase
+            // only the liquid phase is present, i.e. liquid phase
+            // composition is stored explicitly.
+            // extract _mass_ fractions in the gas phase
             Dune::FieldVector<Scalar, numComponents> moleFrac;
 
             for (int compIdx=numMajorComponents; compIdx<numComponents; ++compIdx)
@@ -363,15 +360,15 @@ public:
             sumMoleFracNotWater += moleFrac[nCompIdx];
             moleFrac[wCompIdx] = 1 -sumMoleFracNotWater;
 
-//             convert mass to mole fractions and set the fluid state
+            // convert mass to mole fractions and set the fluid state
             for (int compIdx=0; compIdx<numComponents; ++compIdx)
             {
                 fluidState.setMoleFraction(wPhaseIdx, compIdx, moleFrac[compIdx]);
             }
 
-//             calculate the composition of the remaining phases (as
-//             well as the densities of all phases). this is the job
-//             of the "ComputeFromReferencePhase2pNc" constraint solver
+            // calculate the composition of the remaining phases (as
+            // well as the densities of all phases). this is the job
+            // of the "ComputeFromReferencePhase2pNc" constraint solver
             ComputeFromReferencePhase2pNCMin::solve(fluidState,
                                                     paramCache,
                                                     wPhaseIdx,
@@ -472,7 +469,7 @@ public:
      * compIdx of the main component (solvent) in the
      * phase is equal to the phaseIdx
      */
-     Scalar molality(int phaseIdx, int compIdx) const // [moles/Kg]
+    Scalar molality(int phaseIdx, int compIdx) const // [moles/Kg]
     { return this->fluidState_.moleFraction(phaseIdx, compIdx)
                   /(fluidState_.moleFraction(phaseIdx, phaseIdx)
                   * FluidSystem::molarMass(phaseIdx));}
@@ -506,16 +503,15 @@ protected:
     * \param scvIdx The local index of the SCV (sub-control volume)
     * \param isOldSol Evaluate function with solution of current or previous time step
     */
-        void updateEnergy_(const PrimaryVariables &priVars,
-                           const Problem &problem,
-                           const Element &element,
-                           const FVElementGeometry &fvGeometry,
-                           const int scvIdx,
-                           bool isOldSol)
-        { };
+    void updateEnergy_(const PrimaryVariables &priVars,
+                       const Problem &problem,
+                       const Element &element,
+                       const FVElementGeometry &fvGeometry,
+                       const int scvIdx,
+                       bool isOldSol)
+    {};
 
     Scalar precipitateVolumeFraction_[numSPhases];
-//     Scalar saturationIdx_[numSPhases];
     Scalar permeabilityFactor_;
     Scalar initialPorosity_;
     Scalar initialPermeability_;
diff --git a/test/porousmediumflow/2pncmin/implicit/CMakeLists.txt b/test/porousmediumflow/2pncmin/implicit/CMakeLists.txt
index 26561e8ea2aaa0fca06fc24ca8c35a181d1320d0..102ef532edcc408a4f1b5c2db867d2402cdcef48 100644
--- a/test/porousmediumflow/2pncmin/implicit/CMakeLists.txt
+++ b/test/porousmediumflow/2pncmin/implicit/CMakeLists.txt
@@ -1,15 +1,24 @@
-add_input_file_links()
-
 # isothermal tests
 add_dumux_test(test_box2pncmin test_box2pncmin test_box2pncmin.cc
                python ${CMAKE_SOURCE_DIR}/bin/runtest.py
                  --script fuzzy
                  --files ${CMAKE_SOURCE_DIR}/test/references/saltflushbox2pncmin-reference.vtu
                          ${CMAKE_CURRENT_BINARY_DIR}/saltflushbox-00044.vtu
-                 --command "${CMAKE_CURRENT_BINARY_DIR}/test_box2pncmin")
+                 --command "${CMAKE_CURRENT_BINARY_DIR}/test_box2pncmin -ParameterFile test_2pncmin.input -Problem.Name saltflushbox")
+
+add_dumux_test(test_cc2pncmin test_cc2pncmin test_cc2pncmin.cc
+               python ${CMAKE_SOURCE_DIR}/bin/runtest.py
+                 --script fuzzy
+                 --files ${CMAKE_SOURCE_DIR}/test/references/saltflushcc2pncmin-reference.vtu
+                         ${CMAKE_CURRENT_BINARY_DIR}/saltflushcc-00049.vtu
+                 --command "${CMAKE_CURRENT_BINARY_DIR}/test_cc2pncmin -ParameterFile test_2pncmin.input -Problem.Name saltflushcc")
+
+dune_symlink_to_source_files(FILES "test_2pncmin.input")
+
 #install sources
 install(FILES
 dissolutionproblem.hh
 dissolutionspatialparams.hh
 test_box2pncmin.cc
+test_cc2pncmin.cc
 DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/test/implicit/2pncmin)
diff --git a/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh b/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh
index ba30fdd5cb6eb6bec64cb1b9e7bc2d28c3e0ae1c..9953dce78fd050bdf7dabd85a1114c4eb298b106 100644
--- a/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh
+++ b/test/porousmediumflow/2pncmin/implicit/dissolutionproblem.hh
@@ -96,35 +96,35 @@ class DissolutionProblem : public ImplicitPorousMediaProblem<TypeTag>
 
     enum {
 
-            pressureIdx = Indices::pressureIdx,
-            switchIdx = Indices::switchIdx, //Saturation
-            xlNaClIdx = FluidSystem::NaClIdx,
-            precipNaClIdx = FluidSystem::numComponents,
-
-            //Indices of the components
-            wCompIdx = FluidSystem::H2OIdx,
-            nCompIdx = FluidSystem::AirIdx,
-            NaClIdx = FluidSystem::NaClIdx,
-
-            //Indices of the phases
-            wPhaseIdx = FluidSystem::wPhaseIdx,
-            nPhaseIdx = FluidSystem::nPhaseIdx,
-            sPhaseIdx = FluidSystem::sPhaseIdx,
-
-            //Index of the primary component of G and L phase
-            conti0EqIdx = Indices::conti0EqIdx,
-            contiTotalMassIdx = conti0EqIdx + FluidSystem::AirIdx,
-            precipNaClEqIdx = Indices::conti0EqIdx + FluidSystem::numComponents,
-            contiWEqIdx = conti0EqIdx + FluidSystem::H2OIdx,
-
-            // Phase State
-            wPhaseOnly = Indices::wPhaseOnly,
-            nPhaseOnly = Indices::nPhaseOnly,
-            bothPhases = Indices::bothPhases,
-
-            // Grid and world dimension
-            dim = GridView::dimension,
-            dimWorld = GridView::dimensionworld,
+        pressureIdx = Indices::pressureIdx,
+        switchIdx = Indices::switchIdx, //Saturation
+        xlNaClIdx = FluidSystem::NaClIdx,
+        precipNaClIdx = FluidSystem::numComponents,
+
+        //Indices of the components
+        wCompIdx = FluidSystem::H2OIdx,
+        nCompIdx = FluidSystem::AirIdx,
+        NaClIdx = FluidSystem::NaClIdx,
+
+        //Indices of the phases
+        wPhaseIdx = FluidSystem::wPhaseIdx,
+        nPhaseIdx = FluidSystem::nPhaseIdx,
+        sPhaseIdx = FluidSystem::sPhaseIdx,
+
+        //Index of the primary component of G and L phase
+        conti0EqIdx = Indices::conti0EqIdx,
+        contiTotalMassIdx = conti0EqIdx + FluidSystem::AirIdx,
+        precipNaClEqIdx = Indices::conti0EqIdx + FluidSystem::numComponents,
+        contiWEqIdx = conti0EqIdx + FluidSystem::H2OIdx,
+
+        // Phase State
+        wPhaseOnly = Indices::wPhaseOnly,
+        nPhaseOnly = Indices::nPhaseOnly,
+        bothPhases = Indices::bothPhases,
+
+        // Grid and world dimension
+        dim = GridView::dimension,
+        dimWorld = GridView::dimensionworld,
     };
 
 
@@ -164,7 +164,7 @@ public:
         pressureHigh_           = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FluidSystem, PressureHigh);
         temperatureLow_         = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FluidSystem, TemperatureLow);
         temperatureHigh_        = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, FluidSystem, TemperatureHigh);
-        name_                   = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, OutputName);
+        name_                   = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name);
         freqMassOutput_         = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, Output, FreqMassOutput);
         storageLastTimestep_    = 0.0;
         lastMassOutputTime_     = 0.0;
@@ -180,11 +180,6 @@ public:
                           /*np=*/nPressure_);
     }
 
-    void init()
-    {
-        ParentType::init();
-    }
-
     ~DissolutionProblem()
     {
         outfile.close();
@@ -228,10 +223,8 @@ public:
      * \brief Specifies which kind of boundary condition should be
      *        used for which equation on a given boundary segment.
      */
-    void boundaryTypes(BoundaryTypes &bcTypes, const Vertex &vertex) const
+    void boundaryTypesAtPos(BoundaryTypes &bcTypes, const GlobalPosition &globalPos) const
     {
-        auto globalPos = vertex.geometry().center();
-
         const Scalar rmax = this->bBoxMax()[0]; // outerRadius_;
         const Scalar rmin = this->bBoxMin()[0]; // well radius equal to the first value of the dgf grid file
 
@@ -253,10 +246,8 @@ public:
      *
      * For this method, the \a values parameter stores primary variables.
      */
-    void dirichlet(PrimaryVariables &values, const Vertex &vertex) const
+    void dirichletAtPos(PrimaryVariables &values, const GlobalPosition &globalPos) const
     {
-        auto globalPos = vertex.geometry().center();
-
         const Scalar rmax = this->bBoxMax()[0];
         const Scalar rmin = this->bBoxMin()[0];
 
@@ -376,9 +367,9 @@ public:
     /*!
      * \brief Return the initial phase state inside a control volume.
      */
-    int initialPhasePresence(const Vertex &vert,
-                             int globalIdx,
-                             const GlobalPosition &globalPos) const
+    int initialPhasePresence(const Element& element,
+                             const FVElementGeometry& fvGeometry,
+                             int scvIdx) const
     {
         return bothPhases;
     }
diff --git a/test/porousmediumflow/2pncmin/implicit/grids/test_2pncmin.dgf b/test/porousmediumflow/2pncmin/implicit/grids/test_2pncmin.dgf
deleted file mode 100644
index 3235f2499227e8a97410ee3e29ded49fe441ec6c..0000000000000000000000000000000000000000
--- a/test/porousmediumflow/2pncmin/implicit/grids/test_2pncmin.dgf
+++ /dev/null
@@ -1,11 +0,0 @@
-DGF
-Interval
-0 0   % first corner 
-40 10 % second corner
-20 10% 1 cells in x and 1 in y direction
-# 
-
-BOUNDARYDOMAIN
-default 1    % all boundaries have id 1
-#BOUNDARYDOMAIN
-# unitcube.dgf 
diff --git a/test/porousmediumflow/2pncmin/implicit/test_box2pncmin.input b/test/porousmediumflow/2pncmin/implicit/test_2pncmin.input
similarity index 95%
rename from test/porousmediumflow/2pncmin/implicit/test_box2pncmin.input
rename to test/porousmediumflow/2pncmin/implicit/test_2pncmin.input
index a188e5ec20a7309f6be24cb60d01bbec60bbd474..02470b48386c7409c891fe21d01057b8cc3ecd83 100644
--- a/test/porousmediumflow/2pncmin/implicit/test_box2pncmin.input
+++ b/test/porousmediumflow/2pncmin/implicit/test_2pncmin.input
@@ -2,17 +2,15 @@
 # Everything behind a '#' is a comment.
 # Type "./test_2pncmin --help" for more information.
 
-# Mandatory arguments
-
-
 [TimeManager]
 TEnd = 1e6                         # duration of the simulation [s]
 DtInitial = 10                      # initial time step size [s]
 MaxTimeStepSize = 50000             # maximum time step size
 
-
 [Grid]
-File = grids/test_2pncmin.dgf
+LowerLeft = 0 0
+UpperRight = 40 10
+Cells = 20 10
 
 [FluidSystem]
 NTemperature =  100                 # [-] number of tabularization entries
@@ -23,7 +21,7 @@ TemperatureLow = 273.15             # [Pa]low end for tabularization of fluid pr
 TemperatureHigh = 400.00            # [Pa]high end for tabularization of fluid properties
 
 [Problem]
-OutputName          = saltflushbox  # [-]  name for output files
+Name                = saltflush     # [-]  name for output files
 ReservoirPressure   = 11E6          # [Pa] Initial reservoir pressure
 reservoirSaturation = 0.4           # [-]  Initial saturation
 solidity            = 0.0           # [-]  Initial solid salt precipitate
@@ -64,4 +62,4 @@ FreqRestart = 1000                 # how often restart files are written out
 FreqOutput = 50                    # frequency of VTK output
 FreqMassOutput = 2                 # frequency of mass and evaporation rate output (Darcy)
 FreqFluxOutput = 1000              # frequency of detailed flux output
-FreqVaporFluxOutput = 2            # frequency of summarized flux output
\ No newline at end of file
+FreqVaporFluxOutput = 2            # frequency of summarized flux output
diff --git a/test/porousmediumflow/2pncmin/implicit/test_box2pncmin.cc b/test/porousmediumflow/2pncmin/implicit/test_box2pncmin.cc
index 5dd4a233b8efd5b7d82bda1f2b46d41f47e09753..f8195f933fc04a8d4f22dd77ae09a9f77aeff920 100644
--- a/test/porousmediumflow/2pncmin/implicit/test_box2pncmin.cc
+++ b/test/porousmediumflow/2pncmin/implicit/test_box2pncmin.cc
@@ -23,8 +23,6 @@
  */
 #include <config.h>
 #include "dissolutionproblem.hh"
-#include <dune/grid/io/file/dgfparser.hh>
-#include <iostream>
 #include <dumux/common/start.hh>
 
 /*!
@@ -43,19 +41,7 @@ void usage(const char *progName, const std::string &errorMsg)
                     errorMessageOut += " [options]\n";
                     errorMessageOut += errorMsg;
                     errorMessageOut += "\n\nThe list of mandatory options for this program is:\n"
-                                        "\t-TimeManager.TEnd              End of the simulation [s] \n"
-                                        "\t-TimeManager.DtInitial         Initial timestep size [s] \n"
-                                        "\t-Grid.File                     Name of the file containing the grid \n"
-                                        "\t                               definition in DGF format\n"
-                                        "\t-FluidSystem.NTemperature      Number of tabularization entries [-] \n"
-                                        "\t-FluidSystem.NPressure         Number of tabularization entries [-] \n"
-                                        "\t-FluidSystem.PressureLow       Low end for tabularization of fluid properties [Pa] \n"
-                                        "\t-FluidSystem.PressureHigh      High end for tabularization of fluid properties [Pa] \n"
-                                        "\t-FluidSystem.TemperatureLow    Low end for tabularization of fluid properties [Pa] \n"
-                                        "\t-FluidSystem.TemperatureHigh   High end for tabularization of fluid properties [Pa] \n"
-                                        "\t-SimulationControl.Name        The name of the output files [-] \n"
-                                        "\t-InitialConditions.Temperature Initial temperature in the reservoir [K] \n"
-                                        "\t-InitialConditions.DepthBOR    Depth below ground surface [m] \n";
+                                        "\t-ParameterFile Parameter file (Input file) \n";
 
         std::cout << errorMessageOut
                   << "\n";
diff --git a/test/porousmediumflow/2pncmin/implicit/test_cc2pncmin.cc b/test/porousmediumflow/2pncmin/implicit/test_cc2pncmin.cc
new file mode 100644
index 0000000000000000000000000000000000000000..8f510ad5fb62fb60cff8fe0d3b2b9b0bc4fbce78
--- /dev/null
+++ b/test/porousmediumflow/2pncmin/implicit/test_cc2pncmin.cc
@@ -0,0 +1,55 @@
+// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
+// vi: set et ts=4 sw=4 sts=4:
+/*****************************************************************************
+ *   See the file COPYING for full copying permissions.                      *
+ *                                                                           *
+ *   This program is free software: you can redistribute it and/or modify    *
+ *   it under the terms of the GNU General Public License as published by    *
+ *   the Free Software Foundation, either version 2 of the License, or       *
+ *   (at your option) any later version.                                     *
+ *                                                                           *
+ *   This program is distributed in the hope that it will be useful,         *
+ *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
+ *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
+ *   GNU General Public License for more details.                            *
+ *                                                                           *
+ *   You should have received a copy of the GNU General Public License       *
+ *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
+ *****************************************************************************/
+/*!
+ * \file
+ *
+ * \brief Test for the two-phase n-component isothermal cc model.
+ */
+#include <config.h>
+#include "dissolutionproblem.hh"
+#include <dumux/common/start.hh>
+
+/*!
+ * \brief Provides an interface for customizing error messages associated with
+ *        reading in parameters.
+ *
+ * \param progName  The name of the program, that was tried to be started.
+ * \param errorMsg  The error message that was issued by the start function.
+ *                  Comprises the thing that went wrong and a general help message.
+ */
+void usage(const char *progName, const std::string &errorMsg)
+{
+    if (errorMsg.size() > 0) {
+        std::string errorMessageOut = "\nUsage: ";
+                    errorMessageOut += progName;
+                    errorMessageOut += " [options]\n";
+                    errorMessageOut += errorMsg;
+                    errorMessageOut += "\n\nThe list of mandatory options for this program is:\n"
+                                        "\t-ParameterFile Parameter file (Input file) \n";
+
+        std::cout << errorMessageOut
+                  << "\n";
+    }
+}
+
+int main(int argc, char** argv)
+{
+    typedef TTAG(DissolutionCCProblem) ProblemTypeTag;
+    return Dumux::start<ProblemTypeTag>(argc, argv, usage);
+}
diff --git a/test/references/saltflushbox2pncmin-reference.vtu b/test/references/saltflushbox2pncmin-reference.vtu
index ea8ba91652142f1a8bbe7797b0eccb25e0e00688..8ae883e6b4155eb92733748f021e7b83807f03be 100644
--- a/test/references/saltflushbox2pncmin-reference.vtu
+++ b/test/references/saltflushbox2pncmin-reference.vtu
@@ -289,28 +289,6 @@
           1 1 1 1 1 1 1 3 3 3 3 3
           3 3 3
         </DataArray>
-        <DataArray type="Float32" Name="boxVolume" NumberOfComponents="1" format="ascii">
-          0.5 1 1 2 1 2 1 2 1 2 1 2
-          1 2 1 2 1 2 1 2 1 2 1 2
-          1 2 1 2 1 2 1 2 1 2 1 2
-          1 2 1 2 0.5 1 1 2 2 2 2 2
-          2 2 2 2 2 2 2 2 2 2 2 2
-          2 2 1 1 2 2 2 2 2 2 2 2
-          2 2 2 2 2 2 2 2 2 2 2 1
-          1 2 2 2 2 2 2 2 2 2 2 2
-          2 2 2 2 2 2 2 2 1 1 2 2
-          2 2 2 2 2 2 2 2 2 2 2 2
-          2 2 2 2 2 1 1 2 2 2 2 2
-          2 2 2 2 2 2 2 2 2 2 2 2
-          2 2 1 1 2 2 2 2 2 2 2 2
-          2 2 2 2 2 2 2 2 2 2 2 1
-          1 2 2 2 2 2 2 2 2 2 2 2
-          2 2 2 2 2 2 2 2 1 1 2 2
-          2 2 2 2 2 2 2 2 2 2 2 2
-          2 2 2 2 2 1 0.5 1 1 1 1 1
-          1 1 1 1 1 1 1 1 1 1 1 1
-          1 1 0.5
-        </DataArray>
         <DataArray type="Float32" Name="precipitateVolumeFraction_NaCl" NumberOfComponents="1" format="ascii">
           0 8.38742e-12 0 8.38742e-12 6.31898e-11 6.45642e-11 0.000214915 0.000205298 0.0503585 0.0499074 0.0523779 0.0523736
           0.0523886 0.0523846 0.0523974 0.0523961 0.0524049 0.0524012 0.0524107 0.0524076 0.00442482 0.0044062 0.00443673 0.00442071
diff --git a/test/references/saltflushcc2pncmin-reference.vtu b/test/references/saltflushcc2pncmin-reference.vtu
new file mode 100644
index 0000000000000000000000000000000000000000..02d09064ff9105c42d025d079940618ee61776cb
--- /dev/null
+++ b/test/references/saltflushcc2pncmin-reference.vtu
@@ -0,0 +1,778 @@
+<?xml version="1.0"?>
+<VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
+  <UnstructuredGrid>
+    <Piece NumberOfCells="200" NumberOfPoints="231">
+      <CellData Scalars="Sg" Vectors="velocityW">
+        <DataArray type="Float32" Name="Sg" NumberOfComponents="1" format="ascii">
+          0.0382404 0.0335022 0 0 0 0 0 0 0 0 0 0
+          0 0.0403411 0.0719252 0.0987404 0.180518 0.554442 0.627773 0.632185 0.050986 0.04508 0.00419928 0
+          0 0 0 0 0 0 0 0 0 0.0527634 0.0883385 0.125779
+          0.279617 0.617319 0.637052 0.640498 0.0539991 0.0505695 0.00865615 0 0 0 0 0
+          0 0 0 0 0 0.0566254 0.097877 0.14726 0.386582 0.631791 0.637086 0.640511
+          0.0534581 0.0521515 0.011266 0 0 0 0 0 0 0 0 0
+          0 0.057019 0.104142 0.167225 0.461178 0.635218 0.63709 0.640513 0.0526973 0.0523096 0.0130345 0
+          0 0 0 0 0 0 0 0 0 0.0561456 0.108847 0.18699
+          0.515279 0.636262 0.63709 0.640515 0.0521511 0.0521681 0.0147686 0 0 0 0 0
+          0 0 0 0 0 0.0550589 0.11314 0.209356 0.557506 0.636644 0.637091 0.640517
+          0.0517264 0.0519823 0.0163213 0 0 0 0 0 0 0 0 0
+          0 0.0543756 0.117859 0.239621 0.590837 0.636802 0.637095 0.640523 0.0513686 0.0517741 0.0179683 0
+          0 0 0 0 0 0 0 0 0 0.0546099 0.123845 0.286807
+          0.614925 0.636935 0.637165 0.640588 0.0512722 0.0518166 0.0196858 0 0 0 0 0
+          0 0 0 0 0 0.0576365 0.133287 0.363043 0.629857 0.637784 0.637987 0.641332
+          0.0606157 0.0699204 0.0510376 0 0 0 0 0 0 0 0 0
+          0 0.0997739 0.208287 0.526754 0.644193 0.645144 0.645301 0.648091
+        </DataArray>
+        <DataArray type="Float32" Name="Sl" NumberOfComponents="1" format="ascii">
+          0.96176 0.966498 1 1 1 1 1 1 1 1 1 1
+          1 0.959659 0.928075 0.90126 0.819482 0.445558 0.372227 0.367815 0.949014 0.95492 0.995801 1
+          1 1 1 1 1 1 1 1 1 0.947237 0.911662 0.874221
+          0.720383 0.382681 0.362948 0.359502 0.946001 0.949431 0.991344 1 1 1 1 1
+          1 1 1 1 1 0.943375 0.902123 0.85274 0.613418 0.368209 0.362914 0.359489
+          0.946542 0.947848 0.988734 1 1 1 1 1 1 1 1 1
+          1 0.942981 0.895858 0.832775 0.538822 0.364782 0.36291 0.359487 0.947303 0.94769 0.986965 1
+          1 1 1 1 1 1 1 1 1 0.943854 0.891153 0.81301
+          0.484721 0.363738 0.36291 0.359485 0.947849 0.947832 0.985231 1 1 1 1 1
+          1 1 1 1 1 0.944941 0.88686 0.790644 0.442494 0.363356 0.362909 0.359483
+          0.948274 0.948018 0.983679 1 1 1 1 1 1 1 1 1
+          1 0.945624 0.882141 0.760379 0.409163 0.363198 0.362905 0.359477 0.948631 0.948226 0.982032 1
+          1 1 1 1 1 1 1 1 1 0.94539 0.876155 0.713193
+          0.385075 0.363065 0.362835 0.359412 0.948728 0.948183 0.980314 1 1 1 1 1
+          1 1 1 1 1 0.942364 0.866713 0.636957 0.370143 0.362216 0.362013 0.358668
+          0.939384 0.93008 0.948962 1 1 1 1 1 1 1 1 1
+          1 0.900226 0.791713 0.473246 0.355807 0.354856 0.354699 0.351909
+        </DataArray>
+        <DataArray type="Float32" Name="pg" NumberOfComponents="1" format="ascii">
+          1.30011e+07 1.29882e+07 1.29691e+07 1.29467e+07 1.28103e+07 1.25651e+07 1.23065e+07 1.20399e+07 1.17689e+07 1.14954e+07 1.13381e+07 1.12975e+07
+          1.12566e+07 1.12149e+07 1.1165e+07 1.11069e+07 1.10463e+07 1.10126e+07 1.10079e+07 1.10031e+07 1.29959e+07 1.29803e+07 1.29599e+07 1.2938e+07
+          1.28031e+07 1.25577e+07 1.22978e+07 1.20303e+07 1.17587e+07 1.1485e+07 1.13275e+07 1.1287e+07 1.12461e+07 1.12049e+07 1.11548e+07 1.10962e+07
+          1.10336e+07 1.10119e+07 1.10074e+07 1.10026e+07 1.29925e+07 1.29736e+07 1.29514e+07 1.29296e+07 1.27979e+07 1.25539e+07 1.22909e+07 1.20217e+07
+          1.17491e+07 1.14747e+07 1.1317e+07 1.12765e+07 1.12358e+07 1.11948e+07 1.11449e+07 1.10861e+07 1.10253e+07 1.10115e+07 1.1007e+07 1.10023e+07
+          1.29899e+07 1.29676e+07 1.29434e+07 1.29211e+07 1.27949e+07 1.25529e+07 1.22856e+07 1.20139e+07 1.17399e+07 1.14647e+07 1.13066e+07 1.12661e+07
+          1.12255e+07 1.11847e+07 1.11353e+07 1.10766e+07 1.10212e+07 1.10112e+07 1.10067e+07 1.10022e+07 1.29877e+07 1.29621e+07 1.29356e+07 1.29125e+07
+          1.27933e+07 1.25537e+07 1.22812e+07 1.20067e+07 1.1731e+07 1.14547e+07 1.12963e+07 1.12558e+07 1.12152e+07 1.11745e+07 1.11257e+07 1.10673e+07
+          1.10186e+07 1.10109e+07 1.10064e+07 1.1002e+07 1.29856e+07 1.29567e+07 1.29279e+07 1.29035e+07 1.27924e+07 1.25555e+07 1.22774e+07 1.19996e+07
+          1.17222e+07 1.14448e+07 1.12859e+07 1.12454e+07 1.12049e+07 1.11643e+07 1.1116e+07 1.10577e+07 1.10168e+07 1.10105e+07 1.10061e+07 1.10019e+07
+          1.29833e+07 1.29511e+07 1.292e+07 1.28942e+07 1.27915e+07 1.25573e+07 1.22734e+07 1.19925e+07 1.17133e+07 1.14349e+07 1.12756e+07 1.12351e+07
+          1.11947e+07 1.11541e+07 1.11062e+07 1.10476e+07 1.10155e+07 1.10101e+07 1.10058e+07 1.10018e+07 1.29808e+07 1.29452e+07 1.29119e+07 1.28842e+07
+          1.27898e+07 1.25583e+07 1.22686e+07 1.19848e+07 1.17041e+07 1.14249e+07 1.12652e+07 1.12247e+07 1.11844e+07 1.11441e+07 1.10963e+07 1.10378e+07
+          1.10146e+07 1.10097e+07 1.10054e+07 1.10016e+07 1.29774e+07 1.29387e+07 1.29036e+07 1.28739e+07 1.27856e+07 1.25566e+07 1.22622e+07 1.19764e+07
+          1.16945e+07 1.14147e+07 1.12547e+07 1.12143e+07 1.11742e+07 1.11344e+07 1.10861e+07 1.103e+07 1.10141e+07 1.10092e+07 1.10049e+07 1.10013e+07
+          1.29725e+07 1.29314e+07 1.28951e+07 1.2864e+07 1.27768e+07 1.25492e+07 1.22537e+07 1.19668e+07 1.16844e+07 1.14042e+07 1.12441e+07 1.12038e+07
+          1.11639e+07 1.11253e+07 1.10754e+07 1.10256e+07 1.10137e+07 1.10085e+07 1.10042e+07 1.10008e+07
+        </DataArray>
+        <DataArray type="Float32" Name="pl" NumberOfComponents="1" format="ascii">
+          1.30006e+07 1.29876e+07 1.29686e+07 1.29462e+07 1.28098e+07 1.25646e+07 1.2306e+07 1.20394e+07 1.17684e+07 1.14949e+07 1.13376e+07 1.1297e+07
+          1.12561e+07 1.12144e+07 1.11645e+07 1.11064e+07 1.10457e+07 1.10117e+07 1.10069e+07 1.1002e+07 1.29954e+07 1.29798e+07 1.29594e+07 1.29375e+07
+          1.28026e+07 1.25572e+07 1.22973e+07 1.20298e+07 1.17582e+07 1.14845e+07 1.1327e+07 1.12865e+07 1.12456e+07 1.12043e+07 1.11543e+07 1.10957e+07
+          1.10329e+07 1.10108e+07 1.10063e+07 1.10015e+07 1.29919e+07 1.29731e+07 1.29509e+07 1.29291e+07 1.27974e+07 1.25534e+07 1.22904e+07 1.20212e+07
+          1.17486e+07 1.14742e+07 1.13165e+07 1.1276e+07 1.12353e+07 1.11943e+07 1.11444e+07 1.10856e+07 1.10246e+07 1.10104e+07 1.10059e+07 1.10012e+07
+          1.29894e+07 1.29671e+07 1.29428e+07 1.29206e+07 1.27944e+07 1.25524e+07 1.22851e+07 1.20134e+07 1.17394e+07 1.14642e+07 1.13061e+07 1.12656e+07
+          1.1225e+07 1.11842e+07 1.11347e+07 1.10761e+07 1.10204e+07 1.10101e+07 1.10056e+07 1.10011e+07 1.29871e+07 1.29616e+07 1.29351e+07 1.2912e+07
+          1.27928e+07 1.25532e+07 1.22807e+07 1.20062e+07 1.17305e+07 1.14542e+07 1.12958e+07 1.12553e+07 1.12147e+07 1.1174e+07 1.11251e+07 1.10667e+07
+          1.10177e+07 1.10098e+07 1.10053e+07 1.10009e+07 1.2985e+07 1.29561e+07 1.29274e+07 1.2903e+07 1.27919e+07 1.2555e+07 1.22769e+07 1.19991e+07
+          1.17217e+07 1.14443e+07 1.12854e+07 1.12449e+07 1.12044e+07 1.11638e+07 1.11155e+07 1.10571e+07 1.10159e+07 1.10094e+07 1.1005e+07 1.10008e+07
+          1.29828e+07 1.29506e+07 1.29195e+07 1.28937e+07 1.2791e+07 1.25568e+07 1.22729e+07 1.1992e+07 1.17128e+07 1.14344e+07 1.12751e+07 1.12346e+07
+          1.11942e+07 1.11536e+07 1.11057e+07 1.1047e+07 1.10145e+07 1.1009e+07 1.10047e+07 1.10007e+07 1.29803e+07 1.29447e+07 1.29114e+07 1.28837e+07
+          1.27893e+07 1.25578e+07 1.22681e+07 1.19843e+07 1.17036e+07 1.14244e+07 1.12647e+07 1.12242e+07 1.11839e+07 1.11436e+07 1.10957e+07 1.10372e+07
+          1.10136e+07 1.10086e+07 1.10043e+07 1.10005e+07 1.29769e+07 1.29382e+07 1.29031e+07 1.28734e+07 1.27851e+07 1.25561e+07 1.22617e+07 1.19759e+07
+          1.1694e+07 1.14142e+07 1.12542e+07 1.12138e+07 1.11737e+07 1.11338e+07 1.10856e+07 1.10293e+07 1.1013e+07 1.10081e+07 1.10038e+07 1.10002e+07
+          1.2972e+07 1.29309e+07 1.28946e+07 1.28635e+07 1.27763e+07 1.25487e+07 1.22532e+07 1.19663e+07 1.16839e+07 1.14037e+07 1.12436e+07 1.12033e+07
+          1.11634e+07 1.11248e+07 1.10748e+07 1.10247e+07 1.10126e+07 1.10074e+07 1.10031e+07 1.09997e+07
+        </DataArray>
+        <DataArray type="Float32" Name="pc" NumberOfComponents="1" format="ascii">
+          512.076 510.491 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687
+          499.687 512.784 523.788 533.708 567.844 901.916 1076.94 1091.01 516.414 514.391 501.004 499.687
+          499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 517.028 529.794 544.305
+          619.558 1045.68 1107.18 1119.08 517.456 516.271 502.413 499.687 499.687 499.687 499.687 499.687
+          499.687 499.687 499.687 499.687 499.687 518.37 533.38 553.189 695.102 1089.73 1107.3 1119.12
+          517.269 516.817 503.243 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687
+          499.687 518.507 535.776 561.848 767.817 1101 1107.31 1119.13 517.005 516.871 503.809 499.687
+          499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 518.202 537.596 570.834
+          837.594 1104.51 1107.31 1119.14 516.817 516.823 504.365 499.687 499.687 499.687 499.687 499.687
+          499.687 499.687 499.687 499.687 499.687 517.824 539.274 581.541 907.597 1105.8 1107.31 1119.15
+          516.67 516.758 504.864 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687
+          499.687 517.587 541.136 597.039 977.239 1106.33 1107.33 1119.17 516.546 516.686 505.395 499.687
+          499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 517.668 543.526 623.883
+          1038.89 1106.78 1107.56 1119.39 516.513 516.701 505.951 499.687 499.687 499.687 499.687 499.687
+          499.687 499.687 499.687 499.687 499.687 518.722 547.361 676.12 1083.52 1109.68 1110.37 1122.01
+          519.766 523.068 516.432 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687 499.687
+          499.687 534.102 581.016 855.001 1132.27 1135.74 1136.32 1146.7
+        </DataArray>
+        <DataArray type="Float32" Name="rhoL" NumberOfComponents="1" format="ascii">
+          932.39 938.88 951.119 1091.08 1090.65 1090.11 1089.48 1088.77 1088 1087.18 1085.9 1084.89
+          1084.15 1083.84 1083.82 1083.8 1083.77 1083.76 1083.76 1083.76 929.102 932.427 941.324 1091.59
+          1091.17 1090.62 1089.96 1089.21 1088.38 1087.5 1086.09 1084.97 1084.15 1083.84 1083.82 1083.79
+          1083.77 1083.76 1083.76 1083.76 928.708 930.483 936.696 1060.76 1091.47 1090.94 1090.29 1089.53
+          1088.68 1087.77 1086.29 1085.08 1084.18 1083.83 1083.81 1083.79 1083.76 1083.76 1083.76 1083.76
+          928.593 929.608 934.025 1036.3 1091.67 1091.18 1090.54 1089.78 1088.92 1087.99 1086.45 1085.19
+          1084.23 1083.83 1083.81 1083.79 1083.76 1083.76 1083.76 1083.76 928.544 929.151 932.361 1018.21
+          1091.82 1091.35 1090.74 1089.98 1089.12 1088.17 1086.59 1085.28 1084.27 1083.83 1083.81 1083.78
+          1083.76 1083.76 1083.76 1083.75 928.52 928.89 931.256 1003.03 1091.94 1091.5 1090.9 1090.16
+          1089.29 1088.34 1086.72 1085.36 1084.31 1083.82 1083.8 1083.78 1083.76 1083.76 1083.76 1083.75
+          928.506 928.734 930.493 990.516 1092.03 1091.63 1091.05 1090.32 1089.46 1088.49 1086.84 1085.43
+          1084.34 1083.82 1083.8 1083.77 1083.76 1083.76 1083.76 1083.75 928.498 928.639 929.961 978.305
+          1092.11 1091.74 1091.18 1090.47 1089.61 1088.64 1086.96 1085.51 1084.37 1083.81 1083.79 1083.77
+          1083.76 1083.76 1083.76 1083.75 928.493 928.583 929.623 967.301 1092.18 1091.83 1091.29 1090.59
+          1089.74 1088.77 1087.06 1085.57 1084.38 1083.81 1083.79 1083.77 1083.76 1083.76 1083.76 1083.75
+          928.489 928.557 929.604 971.565 1092.15 1091.8 1091.28 1090.6 1089.76 1088.79 1087.06 1085.5
+          1084.23 1083.81 1083.79 1083.76 1083.76 1083.76 1083.76 1083.75
+        </DataArray>
+        <DataArray type="Float32" Name="rhoG" NumberOfComponents="1" format="ascii">
+          107.08 106.975 106.824 106.644 105.512 103.476 101.329 99.1166 96.8675 94.5992 93.3058 92.9824
+          92.6517 92.3086 91.8932 91.4094 90.9041 90.6232 90.5847 90.5441 107.034 106.906 106.741 106.564
+          105.446 103.408 101.25 99.0307 96.778 94.5079 93.2151 92.8933 92.5647 92.225 91.8079 91.3203
+          90.7981 90.6175 90.5802 90.5402 107.005 106.849 106.668 106.491 105.399 103.372 101.188 98.9545
+          96.6937 94.419 93.1251 92.8045 92.4778 92.1414 91.7257 91.2359 90.7293 90.6143 90.577 90.538
+          106.984 106.799 106.599 106.418 105.371 103.36 101.14 98.8861 96.6138 94.3322 93.036 92.7164
+          92.3912 92.057 91.6453 91.1567 90.6949 90.6118 90.5745 90.5366 106.965 106.752 106.534 106.345
+          105.356 103.365 101.102 98.8228 96.5367 94.2468 92.9477 92.6287 92.3048 91.9722 91.5654 91.0789
+          90.6733 90.6092 90.5721 90.5355 106.948 106.707 106.469 106.269 105.347 103.377 101.067 98.7618
+          96.4607 94.162 92.8596 92.5413 92.2187 91.8871 91.4849 90.9988 90.6582 90.6062 90.5697 90.5345
+          106.929 106.661 106.403 106.19 105.338 103.391 101.032 98.6999 96.3843 94.0771 92.7716 92.4539
+          92.1327 91.8025 91.4032 90.9154 90.6476 90.6029 90.567 90.5333 106.908 106.612 106.335 106.107
+          105.322 103.398 100.99 98.6342 96.3059 93.9914 92.6833 92.3664 92.0469 91.719 91.3204 90.8337
+          90.6404 90.5992 90.5637 90.5318 106.88 106.557 106.265 106.02 105.287 103.383 100.936 98.5621
+          96.2244 93.9045 92.5946 92.2786 91.9614 91.6376 91.2361 90.7683 90.6358 90.5948 90.5594 90.5294
+          106.839 106.496 106.195 105.938 105.214 103.321 100.865 98.4826 96.14 93.8173 92.5066 92.1919
+          91.8777 91.5623 91.1468 90.7318 90.6328 90.5893 90.5538 90.5254
+        </DataArray>
+        <DataArray type="Float32" Name="mobL" NumberOfComponents="1" format="ascii">
+          4343.78 4099.29 4295.19 2954.66 2954.32 2953.94 2953.52 2953.07 2952.61 2952.16 2951.49 2951.05
+          2950.79 2411.08 2034.42 1750.87 1066.23 26.3243 6.37004 5.7419 4287.17 4186.94 4636.01 2955.13
+          2954.79 2954.39 2953.92 2953.4 2952.87 2952.36 2951.59 2951.08 2950.79 2257.2 1857.08 1496.05
+          530.919 8.06321 5.10431 4.68605 4254.93 4189.87 4777.38 2971.55 2955.08 2954.68 2954.2 2953.66
+          2953.09 2952.54 2951.69 2951.13 2950.8 2210.9 1759.5 1314.31 211.493 5.79608 5.10006 4.68443
+          4279.39 4218.03 4877.91 3054.34 2955.27 2954.9 2954.42 2953.87 2953.27 2952.69 2951.78 2951.18
+          2950.82 2206.22 1697.54 1160.74 95.4166 5.33794 5.09956 4.68421 4302.44 4251.2 4947.52 3160.74
+          2955.42 2955.06 2954.6 2954.04 2953.43 2952.82 2951.86 2951.22 2950.83 2216.61 1652.09 1022.37
+          47.579 5.20398 5.09946 4.68399 4317.95 4277.29 4985.71 3287.92 2955.53 2955.2 2954.75 2954.19
+          2953.57 2952.94 2951.94 2951.25 2950.85 2229.59 1611.42 881.131 25.0346 5.15558 5.09944 4.68373
+          4329.34 4296.27 5006.76 3428.87 2955.63 2955.33 2954.89 2954.34 2953.71 2953.05 2952.01 2951.29
+          2950.86 2237.78 1567.6 713.945 13.8573 5.13564 5.09889 4.68301 4338.47 4310.51 5009.36 3610.98
+          2955.71 2955.44 2955.02 2954.47 2953.83 2953.16 2952.08 2951.33 2950.87 2234.97 1513.29 502.182
+          8.49433 5.119 5.09018 4.67548 4341.14 4315.25 4995.12 3828.92 2955.78 2955.53 2955.13 2954.59
+          2953.95 2953.27 2952.15 2951.36 2950.88 2198.89 1430.52 263.933 6.0673 5.01317 4.98815 4.58877
+          4128.66 3914.77 4240.51 3737.03 2955.75 2955.5 2955.12 2954.59 2953.96 2953.28 2952.15 2951.33
+          2950.83 1740.57 887.525 40.3602 4.26666 4.16347 4.14657 3.85546
+        </DataArray>
+        <DataArray type="Float32" Name="mobG" NumberOfComponents="1" format="ascii">
+          8.41753 5.61304 0 0 0 0 0 0 0 0 0 0
+          0 9.91057 56.8943 146.284 856.955 18490.8 24972.3 25387.6 20.1896 13.8983 0.00545342 0
+          0 0 0 0 0 0 0 0 0 22.3951 105.097 298.885
+          2979.91 23999.1 25848.6 26176.8 24.0183 19.6944 0.0745299 0 0 0 0 0
+          0 0 0 0 0 27.7214 142.523 474.323 7257.87 25350.4 25851.8 26178.2
+          23.2983 21.6187 0.179388 0 0 0 0 0 0 0 0 0
+          0 28.3069 171.283 686.708 11578.7 25674.5 25852.2 26178.3 22.3103 21.8176 0.288662 0
+          0 0 0 0 0 0 0 0 0 27.0187 195.193 948.674
+          15392.9 25773.5 25852.2 26178.5 21.6182 21.6396 0.43181 0 0 0 0 0
+          0 0 0 0 0 25.4706 218.811 1312.59 18744.5 25809.8 25852.3 26178.7
+          21.09 21.4073 0.594411 0 0 0 0 0 0 0 0 0
+          0 24.5278 246.824 1928.74 21604 25824.9 25852.7 26179.3 20.6516 21.1488 0.806607 0
+          0 0 0 0 0 0 0 0 0 24.8484 285.572 3199.07
+          23778.3 25837.4 25859.3 26185.4 20.5346 21.2014 1.076 0 0 0 0 0
+          0 0 0 0 0 29.2416 354.327 6124.77 25168.1 25918.2 25937.5 26256.6
+          34.0372 52.2734 20.2515 0 0 0 0 0 0 0 0 0
+          0 150.869 1293.49 16272.3 26530.6 26621.9 26637 26905.5
+        </DataArray>
+        <DataArray type="Float32" Name="porosity" NumberOfComponents="1" format="ascii">
+          0.11 0.11 0.11 0.0985496 0.0576168 0.0576056 0.0575982 0.057592 0.0575865 0.0575817 0.105569 0.105561
+          0.105554 0.105512 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548 0.11 0.11 0.11 0.107358
+          0.0576197 0.0576085 0.0576013 0.0575951 0.0575893 0.0575847 0.105582 0.105572 0.105565 0.105511 0.105492 0.105491
+          0.10549 0.105489 0.105486 0.10548 0.11 0.11 0.11 0.10923 0.0587671 0.0576101 0.0576043 0.0575969
+          0.0575906 0.0575868 0.105589 0.10558 0.105572 0.105514 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548
+          0.11 0.11 0.11 0.109612 0.060443 0.0576111 0.0576062 0.0575979 0.0575916 0.0575879 0.105593 0.105585
+          0.105577 0.105518 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548 0.11 0.11 0.11 0.109769
+          0.0622884 0.0576132 0.0576076 0.0575989 0.0575936 0.0575887 0.105595 0.105588 0.10558 0.105522 0.105492 0.105491
+          0.10549 0.105489 0.105486 0.10548 0.11 0.11 0.11 0.109857 0.0643345 0.0576154 0.0576088 0.0575999
+          0.0575951 0.0575896 0.105598 0.105591 0.105582 0.105526 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548
+          0.11 0.11 0.11 0.109899 0.0667925 0.0576174 0.0576099 0.0576009 0.0575964 0.0575904 0.105601 0.105594
+          0.105586 0.10553 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548 0.11 0.11 0.11 0.109934
+          0.069984 0.0576193 0.0576112 0.0576034 0.0575973 0.0575912 0.105603 0.105596 0.105589 0.105533 0.105492 0.105491
+          0.10549 0.105489 0.105486 0.10548 0.11 0.11 0.11 0.10996 0.0746747 0.0576212 0.0576125 0.0576055
+          0.0575982 0.0575921 0.105607 0.105601 0.105593 0.105533 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548
+          0.11 0.11 0.11 0.109962 0.0730343 0.0576236 0.0576153 0.0576077 0.0576009 0.0575946 0.105627 0.105624
+          0.105615 0.105516 0.105492 0.105491 0.10549 0.105489 0.105486 0.10548
+        </DataArray>
+        <DataArray type="Float32" Name="permeabilityFactor" NumberOfComponents="1" format="ascii">
+          1 1 1 0.700944 0.128173 0.128095 0.128043 0.128001 0.127962 0.127929 0.875214 0.874993
+          0.874823 0.873695 0.873161 0.87314 0.873111 0.873069 0.872999 0.872844 1 1 1 0.924175
+          0.128192 0.128115 0.128065 0.128022 0.127982 0.127949 0.875572 0.875305 0.875112 0.873662 0.87316 0.873139
+          0.87311 0.873069 0.872999 0.872845 1 1 1 0.977465 0.136336 0.128126 0.128085 0.128034
+          0.12799 0.127964 0.875768 0.875527 0.875306 0.873738 0.87316 0.873139 0.87311 0.873069 0.872999 0.872845
+          1 1 1 0.988588 0.148866 0.128133 0.128099 0.128041 0.127998 0.127972 0.875854 0.87566
+          0.87543 0.873842 0.873159 0.873139 0.87311 0.873069 0.872999 0.872846 1 1 1 0.9932
+          0.163563 0.128148 0.128108 0.128048 0.128011 0.127977 0.875915 0.875742 0.875513 0.873963 0.873159 0.873138
+          0.87311 0.873069 0.872999 0.872846 1 1 1 0.995777 0.181006 0.128162 0.128117 0.128055
+          0.128022 0.127983 0.875993 0.87581 0.875582 0.874073 0.873159 0.873138 0.87311 0.873069 0.873 0.872847
+          1 1 1 0.997013 0.203624 0.128176 0.128125 0.128062 0.12803 0.127989 0.876067 0.875881
+          0.875666 0.874169 0.873159 0.873138 0.87311 0.873069 0.873 0.872847 1 1 1 0.998057
+          0.23584 0.12819 0.128133 0.128079 0.128037 0.127995 0.876142 0.875959 0.875763 0.874247 0.873159 0.873138
+          0.873111 0.873069 0.873 0.872848 1 1 1 0.99882 0.289423 0.128203 0.128142 0.128094
+          0.128043 0.128001 0.876247 0.876069 0.875877 0.874267 0.873159 0.873138 0.873111 0.87307 0.873 0.872848
+          1 1 1 0.998865 0.269808 0.128219 0.128162 0.128109 0.128062 0.128018 0.876781 0.876701
+          0.876463 0.873793 0.873157 0.873137 0.87311 0.873069 0.873 0.872849
+        </DataArray>
+        <DataArray type="Float32" Name="temperature" NumberOfComponents="1" format="ascii">
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+          418.15 418.15 418.15 418.15 418.15 418.15 418.15 418.15
+        </DataArray>
+        <DataArray type="Float32" Name="phase presence" NumberOfComponents="1" format="ascii">
+          3 3 1 1 1 1 1 1 1 1 1 1
+          1 3 3 3 3 3 3 3 3 3 3 1
+          1 1 1 1 1 1 1 1 1 3 3 3
+          3 3 3 3 3 3 3 1 1 1 1 1
+          1 1 1 1 1 3 3 3 3 3 3 3
+          3 3 3 1 1 1 1 1 1 1 1 1
+          1 3 3 3 3 3 3 3 3 3 3 1
+          1 1 1 1 1 1 1 1 1 3 3 3
+          3 3 3 3 3 3 3 1 1 1 1 1
+          1 1 1 1 1 3 3 3 3 3 3 3
+          3 3 3 1 1 1 1 1 1 1 1 1
+          1 3 3 3 3 3 3 3 3 3 3 1
+          1 1 1 1 1 1 1 1 1 3 3 3
+          3 3 3 3 3 3 3 1 1 1 1 1
+          1 1 1 1 1 3 3 3 3 3 3 3
+          3 3 3 1 1 1 1 1 1 1 1 1
+          1 3 3 3 3 3 3 3
+        </DataArray>
+        <DataArray type="Float32" Name="precipitateVolumeFraction_NaCl" NumberOfComponents="1" format="ascii">
+          1.04464e-12 4.38988e-11 3.30927e-10 0.0114504 0.0523832 0.0523944 0.0524018 0.052408 0.0524135 0.0524183 0.00443123 0.00443948
+          0.0044458 0.00448789 0.00450785 0.00450861 0.0045097 0.00451127 0.00451389 0.00451966 1.04365e-12 4.36923e-11 3.28616e-10 0.00264174
+          0.0523803 0.0523915 0.0523987 0.0524049 0.0524107 0.0524153 0.0044179 0.00442786 0.00443504 0.00448914 0.00450787 0.00450864
+          0.00450973 0.00451128 0.00451389 0.00451964 1.04263e-12 4.33868e-11 3.21397e-10 0.00076964 0.0512329 0.0523899 0.0523957 0.0524031
+          0.0524094 0.0524132 0.00441061 0.00441959 0.00442782 0.00448629 0.00450788 0.00450865 0.00450974 0.00451127 0.00451389 0.00451962
+          1.04158e-12 4.319e-11 3.16165e-10 0.000388171 0.049557 0.0523889 0.0523938 0.0524021 0.0524084 0.0524121 0.00440739 0.00441463
+          0.00442319 0.00448242 0.00450789 0.00450866 0.00450974 0.00451127 0.00451388 0.0045196 1.04051e-12 4.30314e-11 3.11853e-10 0.000230911
+          0.0477116 0.0523867 0.0523924 0.0524011 0.0524064 0.0524113 0.00440512 0.00441156 0.00442008 0.00447789 0.0045079 0.00450867
+          0.00450973 0.00451126 0.00451387 0.00451958 1.03944e-12 4.28815e-11 3.07712e-10 0.000143278 0.0456655 0.0523846 0.0523912 0.0524001
+          0.0524049 0.0524104 0.00440221 0.00440902 0.00441754 0.00447379 0.0045079 0.00450868 0.00450973 0.00451126 0.00451386 0.00451956
+          1.03837e-12 4.27205e-11 3.03123e-10 0.000101294 0.0432075 0.0523826 0.0523901 0.0523991 0.0524036 0.0524096 0.00439946 0.0044064
+          0.00441438 0.00447021 0.00450791 0.00450869 0.00450972 0.00451125 0.00451385 0.00451954 1.03732e-12 4.25169e-11 2.97249e-10 6.58602e-05
+          0.040016 0.0523807 0.0523888 0.0523966 0.0524027 0.0524088 0.00439666 0.0044035 0.00441077 0.00446731 0.00450792 0.0045087
+          0.00450971 0.00451125 0.00451384 0.00451952 1.03629e-12 4.2198e-11 2.88882e-10 4.0001e-05 0.0353253 0.0523788 0.0523875 0.0523945
+          0.0524018 0.0524079 0.00439274 0.00439939 0.00440652 0.00446654 0.00450792 0.0045087 0.00450971 0.00451125 0.00451383 0.00451951
+          1.03531e-12 4.20114e-11 2.88295e-10 3.84701e-05 0.0369657 0.0523764 0.0523847 0.0523923 0.0523991 0.0524054 0.00437288 0.00437585
+          0.0043847 0.00448425 0.00450797 0.00450874 0.00450972 0.00451125 0.00451383 0.0045195
+        </DataArray>
+        <DataArray type="Float32" Name="Kxx" NumberOfComponents="1" format="ascii">
+          2.23e-14 2.23e-14 2.23e-14 1.56311e-14 2.85825e-15 2.85651e-15 2.85536e-15 2.85441e-15 2.85355e-15 2.85281e-15 1.95173e-14 1.95123e-14
+          1.95086e-14 1.94834e-14 1.94715e-14 1.9471e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94644e-14 2.23e-14 2.23e-14 2.23e-14 2.06091e-14
+          2.85869e-15 2.85696e-15 2.85584e-15 2.85489e-15 2.85399e-15 2.85327e-15 1.95253e-14 1.95193e-14 1.9515e-14 1.94827e-14 1.94715e-14 1.9471e-14
+          1.94704e-14 1.94694e-14 1.94679e-14 1.94644e-14 2.23e-14 2.23e-14 2.23e-14 2.17975e-14 3.0403e-15 2.8572e-15 2.85631e-15 2.85516e-15
+          2.85418e-15 2.85359e-15 1.95296e-14 1.95242e-14 1.95193e-14 1.94844e-14 1.94715e-14 1.9471e-14 1.94703e-14 1.94694e-14 1.94679e-14 1.94644e-14
+          2.23e-14 2.23e-14 2.23e-14 2.20455e-14 3.3197e-15 2.85736e-15 2.8566e-15 2.85532e-15 2.85435e-15 2.85377e-15 1.95315e-14 1.95272e-14
+          1.95221e-14 1.94867e-14 1.94715e-14 1.9471e-14 1.94703e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.21484e-14
+          3.64744e-15 2.85769e-15 2.85681e-15 2.85548e-15 2.85465e-15 2.8539e-15 1.95329e-14 1.95291e-14 1.9524e-14 1.94894e-14 1.94715e-14 1.9471e-14
+          1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.22058e-14 4.03642e-15 2.85802e-15 2.857e-15 2.85563e-15
+          2.85489e-15 2.85403e-15 1.95346e-14 1.95306e-14 1.95255e-14 1.94918e-14 1.94714e-14 1.9471e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14
+          2.23e-14 2.23e-14 2.23e-14 2.22334e-14 4.54081e-15 2.85833e-15 2.85718e-15 2.85578e-15 2.85508e-15 2.85416e-15 1.95363e-14 1.95321e-14
+          1.95274e-14 1.9494e-14 1.94714e-14 1.9471e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.22567e-14
+          5.25923e-15 2.85864e-15 2.85738e-15 2.85616e-15 2.85523e-15 2.85428e-15 1.9538e-14 1.95339e-14 1.95295e-14 1.94957e-14 1.94714e-14 1.9471e-14
+          1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.22737e-14 6.45413e-15 2.85893e-15 2.85757e-15 2.8565e-15
+          2.85536e-15 2.85441e-15 1.95403e-14 1.95363e-14 1.95321e-14 1.94962e-14 1.94714e-14 1.9471e-14 1.94704e-14 1.94695e-14 1.94679e-14 1.94645e-14
+          2.23e-14 2.23e-14 2.23e-14 2.22747e-14 6.01672e-15 2.85929e-15 2.858e-15 2.85684e-15 2.85579e-15 2.85481e-15 1.95522e-14 1.95504e-14
+          1.95451e-14 1.94856e-14 1.94714e-14 1.94709e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14
+        </DataArray>
+        <DataArray type="Float32" Name="Kyy" NumberOfComponents="1" format="ascii">
+          2.23e-14 2.23e-14 2.23e-14 1.56311e-14 2.85825e-15 2.85651e-15 2.85536e-15 2.85441e-15 2.85355e-15 2.85281e-15 1.95173e-14 1.95123e-14
+          1.95086e-14 1.94834e-14 1.94715e-14 1.9471e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94644e-14 2.23e-14 2.23e-14 2.23e-14 2.06091e-14
+          2.85869e-15 2.85696e-15 2.85584e-15 2.85489e-15 2.85399e-15 2.85327e-15 1.95253e-14 1.95193e-14 1.9515e-14 1.94827e-14 1.94715e-14 1.9471e-14
+          1.94704e-14 1.94694e-14 1.94679e-14 1.94644e-14 2.23e-14 2.23e-14 2.23e-14 2.17975e-14 3.0403e-15 2.8572e-15 2.85631e-15 2.85516e-15
+          2.85418e-15 2.85359e-15 1.95296e-14 1.95242e-14 1.95193e-14 1.94844e-14 1.94715e-14 1.9471e-14 1.94703e-14 1.94694e-14 1.94679e-14 1.94644e-14
+          2.23e-14 2.23e-14 2.23e-14 2.20455e-14 3.3197e-15 2.85736e-15 2.8566e-15 2.85532e-15 2.85435e-15 2.85377e-15 1.95315e-14 1.95272e-14
+          1.95221e-14 1.94867e-14 1.94715e-14 1.9471e-14 1.94703e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.21484e-14
+          3.64744e-15 2.85769e-15 2.85681e-15 2.85548e-15 2.85465e-15 2.8539e-15 1.95329e-14 1.95291e-14 1.9524e-14 1.94894e-14 1.94715e-14 1.9471e-14
+          1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.22058e-14 4.03642e-15 2.85802e-15 2.857e-15 2.85563e-15
+          2.85489e-15 2.85403e-15 1.95346e-14 1.95306e-14 1.95255e-14 1.94918e-14 1.94714e-14 1.9471e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14
+          2.23e-14 2.23e-14 2.23e-14 2.22334e-14 4.54081e-15 2.85833e-15 2.85718e-15 2.85578e-15 2.85508e-15 2.85416e-15 1.95363e-14 1.95321e-14
+          1.95274e-14 1.9494e-14 1.94714e-14 1.9471e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.22567e-14
+          5.25923e-15 2.85864e-15 2.85738e-15 2.85616e-15 2.85523e-15 2.85428e-15 1.9538e-14 1.95339e-14 1.95295e-14 1.94957e-14 1.94714e-14 1.9471e-14
+          1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14 2.23e-14 2.23e-14 2.23e-14 2.22737e-14 6.45413e-15 2.85893e-15 2.85757e-15 2.8565e-15
+          2.85536e-15 2.85441e-15 1.95403e-14 1.95363e-14 1.95321e-14 1.94962e-14 1.94714e-14 1.9471e-14 1.94704e-14 1.94695e-14 1.94679e-14 1.94645e-14
+          2.23e-14 2.23e-14 2.23e-14 2.22747e-14 6.01672e-15 2.85929e-15 2.858e-15 2.85684e-15 2.85579e-15 2.85481e-15 1.95522e-14 1.95504e-14
+          1.95451e-14 1.94856e-14 1.94714e-14 1.94709e-14 1.94704e-14 1.94694e-14 1.94679e-14 1.94645e-14
+        </DataArray>
+        <DataArray type="Float32" Name="X^liquid_H2O" NumberOfComponents="1" format="ascii">
+          0.991575 0.980696 0.960249 0.837543 0.831904 0.825213 0.817347 0.808336 0.798358 0.787751 0.769255 0.754147
+          0.743259 0.738838 0.738843 0.738849 0.738856 0.738859 0.73886 0.73886 0.99708 0.991497 0.976585 0.845224
+          0.839787 0.832991 0.824703 0.814999 0.804138 0.792548 0.772259 0.755503 0.743225 0.738839 0.738844 0.73885
+          0.738857 0.738859 0.73886 0.73886 0.997738 0.994749 0.984326 0.874691 0.844366 0.837968 0.829819 0.820014
+          0.808832 0.796749 0.775286 0.75728 0.743871 0.73884 0.738845 0.738851 0.738858 0.738859 0.73886 0.73886
+          0.997928 0.996211 0.988794 0.897618 0.847444 0.841479 0.83358 0.823831 0.812514 0.800134 0.777846 0.75891
+          0.74464 0.738841 0.738846 0.738852 0.738858 0.738859 0.73886 0.73886 0.998008 0.996973 0.991576 0.914594
+          0.849694 0.84416 0.836561 0.826939 0.815571 0.802983 0.780034 0.760333 0.745319 0.738842 0.738847 0.738853
+          0.738859 0.738859 0.73886 0.73886 0.998048 0.997406 0.993421 0.928741 0.851463 0.846364 0.839098 0.829652
+          0.81829 0.805553 0.78203 0.761629 0.745939 0.738843 0.738848 0.738854 0.738859 0.738859 0.73886 0.73886
+          0.998069 0.997663 0.994693 0.940422 0.852935 0.848281 0.841371 0.832136 0.820824 0.807981 0.783943 0.762856
+          0.746506 0.738844 0.738849 0.738855 0.738859 0.738859 0.73886 0.73886 0.99808 0.997818 0.995578 0.951663
+          0.854199 0.849978 0.843428 0.83443 0.823206 0.8103 0.785794 0.764027 0.747008 0.738845 0.73885 0.738856
+          0.738859 0.738859 0.73886 0.73886 0.998085 0.997907 0.996139 0.96166 0.855221 0.851383 0.845144 0.836383
+          0.825281 0.812361 0.787436 0.764996 0.747287 0.738846 0.738851 0.738857 0.738859 0.73886 0.73886 0.73886
+          0.998089 0.997945 0.996163 0.95755 0.854754 0.851018 0.845041 0.836519 0.825579 0.812722 0.78747 0.764105
+          0.745048 0.738847 0.738853 0.738858 0.738859 0.73886 0.73886 0.73886
+        </DataArray>
+        <DataArray type="Float32" Name="X^liquid_Air" NumberOfComponents="1" format="ascii">
+          0.00180484 0.00178953 0.00172044 -0.10818 -0.101927 -0.094507 -0.085784 -0.0757913 -0.0647255 -0.0529631 -0.0324509 -0.0156967
+          -0.00362265 0.00128095 0.00127506 0.0012682 0.00126104 0.00125705 0.00125651 0.00125593 0.00181089 0.00180175 0.00178044 -0.116698
+          -0.110669 -0.103133 -0.0939408 -0.0831796 -0.0711355 -0.0582823 -0.0357828 -0.0172008 -0.00358445 0.00127977 0.00127385 0.00126694
+          0.00125953 0.00125697 0.00125644 0.00125588 0.00181122 0.00180481 0.00178877 -0.0952281 -0.115747 -0.108652 -0.0996148 -0.088741
+          -0.0763407 -0.0629409 -0.0391397 -0.0191711 -0.00430131 0.00127858 0.00127269 0.00126574 0.00125856 0.00125693 0.0012564 0.00125584
+          0.00181108 0.00180575 0.00179312 -0.077628 -0.119159 -0.112545 -0.103786 -0.0929741 -0.0804236 -0.0666946 -0.041978 -0.0209783
+          -0.00515321 0.00127738 0.00127155 0.00126462 0.00125807 0.00125689 0.00125636 0.00125583 0.00181086 0.00180589 0.00179544 -0.0645681
+          -0.121654 -0.115519 -0.107092 -0.0964214 -0.0838144 -0.0698547 -0.0444048 -0.0225563 -0.00590648 0.00127618 0.00127041 0.00126351
+          0.00125776 0.00125685 0.00125633 0.00125581 0.0018106 0.00180565 0.0017966 -0.0534821 -0.123617 -0.117963 -0.109905 -0.0994297
+          -0.0868301 -0.0727042 -0.0466177 -0.0239939 -0.00659474 0.00127497 0.00126927 0.00126238 0.00125755 0.00125681 0.00125629 0.0012558
+          0.00181031 0.00180517 0.00179704 -0.0443163 -0.125248 -0.120088 -0.112426 -0.102185 -0.0896396 -0.0753973 -0.0487402 -0.0253553
+          -0.00722292 0.00127377 0.00126811 0.0012612 0.0012574 0.00125676 0.00125626 0.00125578 0.00180995 0.00180451 0.00179696 -0.0351977
+          -0.12665 -0.12197 -0.114707 -0.104728 -0.0922813 -0.077969 -0.0507919 -0.0266535 -0.00778005 0.00127259 0.00126694 0.00126004
+          0.0012573 0.00125671 0.00125621 0.00125576 0.00180947 0.00180368 0.00179645 -0.0268274 -0.127783 -0.123528 -0.11661 -0.106894
+          -0.0945825 -0.0802544 -0.0526134 -0.0277281 -0.00808895 0.00127144 0.00126574 0.00125911 0.00125723 0.00125665 0.00125615 0.00125572
+          0.00180878 0.00180267 0.00179526 -0.029846 -0.127266 -0.123124 -0.116495 -0.107045 -0.094913 -0.0806546 -0.0526508 -0.0267402
+          -0.00560654 0.00127037 0.00126448 0.00125859 0.00125719 0.00125657 0.00125607 0.00125567
+        </DataArray>
+        <DataArray type="Float32" Name="X^liquid_NaCl" NumberOfComponents="1" format="ascii">
+          0.00662057 0.0175147 0.0380308 0.270637 0.270023 0.269294 0.268437 0.267455 0.266367 0.265212 0.263196 0.26155
+          0.260363 0.259881 0.259882 0.259883 0.259883 0.259884 0.259884 0.259884 0.0011093 0.00670119 0.0216342 0.271473
+          0.270882 0.270142 0.269238 0.268181 0.266997 0.265734 0.263523 0.261698 0.26036 0.259882 0.259882 0.259883
+          0.259884 0.259884 0.259884 0.259884 0.000450882 0.00344645 0.0138848 0.220537 0.271381 0.270684 0.269796 0.268727
+          0.267509 0.266192 0.263853 0.261891 0.26043 0.259882 0.259882 0.259883 0.259884 0.259884 0.259884 0.259884
+          0.000261046 0.00198299 0.00941321 0.18001 0.271716 0.271066 0.270206 0.269143 0.26791 0.266561 0.264132 0.262069
+          0.260514 0.259882 0.259882 0.259883 0.259884 0.259884 0.259884 0.259884 0.000181034 0.00122154 0.006629 0.149974
+          0.271961 0.271359 0.270531 0.269482 0.268243 0.266872 0.264371 0.262224 0.260588 0.259882 0.259882 0.259883
+          0.259884 0.259884 0.259884 0.259884 0.000141633 0.000788681 0.00478239 0.124741 0.272153 0.271599 0.270807 0.269778
+          0.26854 0.267152 0.264588 0.262365 0.260655 0.259882 0.259883 0.259883 0.259884 0.259884 0.259884 0.259884
+          0.000121122 0.000531332 0.00350976 0.103894 0.272313 0.271808 0.271055 0.270048 0.268816 0.267416 0.264797 0.262499
+          0.260717 0.259882 0.259883 0.259883 0.259884 0.259884 0.259884 0.259884 0.000110446 0.000377333 0.002625 0.083535
+          0.272451 0.271993 0.271279 0.270298 0.269075 0.267669 0.264998 0.262626 0.260772 0.259882 0.259883 0.259883
+          0.259884 0.259884 0.259884 0.259884 0.000105066 0.000289394 0.00206479 0.065167 0.272562 0.272146 0.271466 0.270511
+          0.269301 0.267893 0.265177 0.262732 0.260802 0.259882 0.259883 0.259884 0.259884 0.259884 0.259884 0.259884
+          0.000102488 0.000252231 0.00204154 0.0722963 0.272511 0.272106 0.271455 0.270526 0.269334 0.267933 0.265181 0.262635
+          0.260558 0.259882 0.259883 0.259884 0.259884 0.259884 0.259884 0.259884
+        </DataArray>
+        <DataArray type="Float32" Name="X^gas_H2O" NumberOfComponents="1" format="ascii">
+          0.0200655 0.0200161 0.0199176 0.0195899 0.0197099 0.0199865 0.0202761 0.0205713 0.0208694 0.0211727 0.0211187 0.0208974
+          0.0206902 0.0210448 0.0211401 0.0212522 0.0213706 0.0214369 0.0214461 0.0214557 0.0201086 0.0200976 0.0200337 0.0197222
+          0.0198448 0.0201237 0.0204125 0.0207016 0.0209894 0.0212796 0.0211956 0.0209447 0.0207077 0.0210639 0.0211598 0.021273
+          0.0213956 0.0214383 0.0214471 0.0214566 0.020118 0.0201288 0.0200971 0.0197951 0.0199246 0.0202097 0.0205083 0.0208018
+          0.0210892 0.0213751 0.0212726 0.021 0.0207557 0.0210831 0.0211788 0.0212927 0.0214118 0.0214391 0.0214479 0.0214571
+          0.0201233 0.0201474 0.0201384 0.0198458 0.0199773 0.0202674 0.0205791 0.02088 0.0211702 0.0214553 0.0213405 0.021052
+          0.0208031 0.0211024 0.0211974 0.0213112 0.02142 0.0214396 0.0214485 0.0214575 0.0201273 0.020161 0.0201685 0.0198853
+          0.0200148 0.0203089 0.0206353 0.0209453 0.0212399 0.0215256 0.0214014 0.0210996 0.0208441 0.0211219 0.0212159 0.0213295
+          0.0214251 0.0214403 0.021449 0.0214577 0.0201308 0.0201723 0.0201924 0.0199185 0.0200438 0.0203411 0.0206834 0.0210034
+          0.0213033 0.0215907 0.0214585 0.0211445 0.0208814 0.0211415 0.0212346 0.0213483 0.0214286 0.021441 0.0214496 0.021458
+          0.0201344 0.0201826 0.020213 0.0199479 0.020068 0.0203686 0.0207273 0.0210578 0.0213637 0.0216533 0.0215142 0.0211881
+          0.0209161 0.021161 0.0212537 0.0213679 0.0214311 0.0214418 0.0214503 0.0214583 0.0201386 0.0201929 0.0202314 0.0199743
+          0.0200904 0.0203939 0.020769 0.0211099 0.0214219 0.0217142 0.0215687 0.0212306 0.0209484 0.0211804 0.021273 0.0213872
+          0.0214329 0.0214426 0.0214511 0.0214586 0.0201439 0.0202038 0.0202483 0.0199966 0.0201127 0.0204189 0.0208077 0.0211577
+          0.0214755 0.0217708 0.0216196 0.0212693 0.0209747 0.0211992 0.0212927 0.0214026 0.021434 0.0214437 0.0214521 0.0214592
+          0.0201516 0.0202156 0.0202619 0.0200068 0.0201194 0.0204252 0.0208204 0.0211768 0.0214993 0.0217972 0.0216405 0.0212718
+          0.0209314 0.0212167 0.0213136 0.0214112 0.0214347 0.021445 0.0214534 0.0214601
+        </DataArray>
+        <DataArray type="Float32" Name="X^gas_Air" NumberOfComponents="1" format="ascii">
+          0.979935 0.979984 0.957475 -67.8898 -64.794 -61.4141 -57.0976 -51.7515 -45.3964 -38.1939 -23.9033 -11.6702
+          -2.70573 0.978955 0.97886 0.978748 0.978629 0.978563 0.978554 0.978544 0.979891 0.979902 0.979966 -73.0601
+          -70.1679 -66.8496 -62.3859 -56.6889 -49.8185 -41.9865 -26.3506 -12.7944 -2.67959 0.978936 0.97884 0.978727
+          0.978604 0.978562 0.978553 0.978543 0.979882 0.979871 0.979903 -57.8233 -73.2828 -70.3077 -66.0549 -60.4001
+          -53.4062 -45.3058 -28.8145 -14.2641 -3.22014 0.978917 0.978821 0.978707 0.978588 0.978561 0.978552 0.978543
+          0.979877 0.979853 0.979862 -46.05 -75.3682 -72.7305 -68.7468 -63.2251 -56.2229 -47.9841 -30.9007 -15.6137
+          -3.86273 0.978898 0.978803 0.978689 0.97858 0.97856 0.978552 0.978543 0.979873 0.979839 0.979832 -37.6666
+          -76.8865 -74.5673 -70.8769 -65.527 -58.5656 -50.2433 -32.6883 -16.7947 -4.43203 0.978878 0.978784 0.97867
+          0.978575 0.97856 0.978551 0.978542 0.979869 0.979828 0.979808 -30.7754 -78.0772 -76.0674 -72.6877 -67.5373
+          -60.6519 -52.2837 -34.3211 -17.8727 -4.95321 0.978858 0.978765 0.978652 0.978571 0.978559 0.97855 0.978542
+          0.979866 0.979817 0.979787 -25.2215 -79.0667 -77.3671 -74.3113 -69.3807 -62.598 -54.2142 -35.889 -18.8952
+          -5.42993 0.978839 0.978746 0.978632 0.978569 0.978558 0.97855 0.978542 0.979861 0.979807 0.979769 -19.8215
+          -79.9225 -78.5204 -75.7861 -71.0874 -64.4314 -56.0601 -37.4063 -19.872 -5.85387 0.97882 0.978727 0.978613
+          0.978567 0.978557 0.978549 0.978541 0.979856 0.979796 0.979752 -14.9674 -80.6305 -79.4892 -77.0307 -72.5524
+          -66.0369 -57.7069 -38.758 -20.6846 -6.09166 0.978801 0.978707 0.978597 0.978566 0.978556 0.978548 0.978541
+          0.979848 0.979784 0.979738 -16.7316 -80.3746 -79.2874 -77.0113 -72.7087 -66.3169 -58.0393 -38.8215 -19.9733
+          -4.22613 0.978783 0.978686 0.978589 0.978565 0.978555 0.978547 0.97854
+        </DataArray>
+        <DataArray type="Float32" Name="X^gas_NaCl" NumberOfComponents="1" format="ascii">
+          3.22335e-10 8.60076e-10 1.89792e-09 1.523e-08 1.53921e-08 1.56922e-08 1.60217e-08 1.6376e-08 1.67526e-08 1.71501e-08 1.73846e-08 1.74373e-08
+          1.74378e-08 1.78098e-08 1.78904e-08 1.79851e-08 1.80852e-08 1.81413e-08 1.8149e-08 1.81572e-08 5.38254e-11 3.26808e-10 1.06777e-09 1.52405e-08
+          1.54009e-08 1.57017e-08 1.60333e-08 1.63894e-08 1.67674e-08 1.71662e-08 1.74016e-08 1.74552e-08 1.74531e-08 1.7826e-08 1.7907e-08 1.80027e-08
+          1.81063e-08 1.81424e-08 1.81499e-08 1.81579e-08 2.18736e-11 1.67789e-10 6.82061e-10 1.20081e-08 1.54072e-08 1.57066e-08 1.60424e-08 1.64013e-08
+          1.67814e-08 1.71818e-08 1.74184e-08 1.74732e-08 1.74831e-08 1.78421e-08 1.79231e-08 1.80194e-08 1.81201e-08 1.81431e-08 1.81505e-08 1.81584e-08
+          1.2665e-11 9.64885e-11 4.6126e-10 9.57553e-09 1.54109e-08 1.57079e-08 1.60495e-08 1.64121e-08 1.67947e-08 1.71972e-08 1.7435e-08 1.74906e-08
+          1.75106e-08 1.78585e-08 1.79388e-08 1.8035e-08 1.81269e-08 1.81436e-08 1.81511e-08 1.81587e-08 8.78415e-12 5.94327e-11 3.24402e-10 7.84528e-09
+          1.54128e-08 1.5707e-08 1.60553e-08 1.64222e-08 1.68076e-08 1.72123e-08 1.74514e-08 1.75077e-08 1.7534e-08 1.7875e-08 1.79545e-08 1.80505e-08
+          1.81313e-08 1.81441e-08 1.81515e-08 1.81589e-08 6.87326e-12 3.83771e-11 2.33878e-10 6.43663e-09 1.5414e-08 1.57049e-08 1.60604e-08 1.64319e-08
+          1.68204e-08 1.72273e-08 1.74677e-08 1.75246e-08 1.75554e-08 1.78916e-08 1.79703e-08 1.80664e-08 1.81343e-08 1.81447e-08 1.8152e-08 1.81591e-08
+          5.87884e-12 2.58611e-11 1.71595e-10 5.30215e-09 1.54151e-08 1.57026e-08 1.60657e-08 1.64418e-08 1.68333e-08 1.72424e-08 1.7484e-08 1.75414e-08
+          1.75754e-08 1.79081e-08 1.79864e-08 1.80829e-08 1.81364e-08 1.81454e-08 1.81526e-08 1.81593e-08 5.3617e-12 1.83722e-11 1.28342e-10 4.21837e-09
+          1.54172e-08 1.57014e-08 1.6072e-08 1.64523e-08 1.68466e-08 1.72577e-08 1.75004e-08 1.75582e-08 1.75944e-08 1.79244e-08 1.80027e-08 1.80992e-08
+          1.81378e-08 1.81461e-08 1.81532e-08 1.81596e-08 5.10181e-12 1.40968e-11 1.00979e-10 3.26024e-09 1.54222e-08 1.57035e-08 1.60804e-08 1.6464e-08
+          1.68604e-08 1.72733e-08 1.75168e-08 1.7575e-08 1.7612e-08 1.79403e-08 1.80193e-08 1.81123e-08 1.81388e-08 1.8147e-08 1.81541e-08 1.81601e-08
+          4.97853e-12 1.22932e-11 9.99067e-11 3.6343e-09 1.54328e-08 1.57128e-08 1.60915e-08 1.64771e-08 1.6875e-08 1.72891e-08 1.75333e-08 1.75911e-08
+          1.76119e-08 1.79551e-08 1.8037e-08 1.81196e-08 1.81394e-08 1.81481e-08 1.81552e-08 1.81609e-08
+        </DataArray>
+        <DataArray type="Float32" Name="m^w_H2O" NumberOfComponents="1" format="ascii">
+          51319.7 51110 50696.7 50725.4 50364.1 49934 49429.5 48852.9 48215.6 47539.4 46368.3 45415.2
+          44729.3 44450.5 44450 44449.4 44448.7 44448.4 44448.3 44448.3 51422.7 51317.7 51028.3 51214.3
+          50865.4 50428.3 49896.4 49275.2 48581.5 47842.6 46557.7 45500.5 44726.9 44450.4 44449.9 44449.3
+          44448.6 44448.4 44448.3 44448.3 51434.8 51378.7 51179.9 51502.9 51156.9 50744.8 50221.4 49593.3
+          48878.8 48108.2 46748.6 45612.2 44767.4 44450.3 44449.8 44449.2 44448.5 44448.4 44448.3 44448.3
+          51438.2 51405.8 51265.5 51634.1 51352.8 50968.2 50460.4 49835.5 49112 48322.3 46910 45714.7
+          44815.5 44450.2 44449.7 44449.1 44448.5 44448.4 44448.3 44448.3 51439.7 51419.9 51318.2 51692.3
+          51496.1 51138.9 50649.9 50032.8 49305.8 48502.6 47048 45804.2 44858.1 44450.1 44449.6 44449
+          44448.4 44448.4 44448.3 44448.3 51440.3 51427.7 51352.7 51709.7 51608.9 51279.3 50811.2 50205.1
+          49478.2 48665.2 47173.9 45885.7 44897 44450 44449.5 44448.9 44448.4 44448.4 44448.3 44448.3
+          51440.7 51432.4 51376.4 51706.6 51702.6 51401.4 50955.8 50362.8 49638.8 48818.9 47294.6 45962.9
+          44932.4 44449.9 44449.4 44448.8 44448.4 44448.3 44448.3 44448.3 51440.8 51435.1 51392.7 51679.6
+          51783.2 51509.6 51086.6 50508.5 49789.8 48965.7 47411.4 46036.5 44963.9 44449.8 44449.3 44448.6
+          44448.4 44448.3 44448.3 44448.3 51440.8 51436.6 51402.9 51635.1 51848.3 51599 51195.8 50632.6
+          49921.4 49096.1 47515 46097.4 44981.2 44449.7 44449.2 44448.6 44448.4 44448.3 44448.3 44448.3
+          51440.8 51437.1 51403.2 51641 51818.3 51575.7 51189 50641 49940.2 49118.8 47516.9 46041.1
+          44840.2 44449.6 44449 44448.5 44448.4 44448.3 44448.3 44448.2
+        </DataArray>
+        <DataArray type="Float32" Name="m^w_Air" NumberOfComponents="1" format="ascii">
+          58.1081 58.0164 56.5035 -4075.72 -3838.64 -3557.41 -3227.2 -2849.43 -2431.67 -1988.28 -1216.8 -588.023
+          -135.618 47.9403 47.7189 47.4611 47.1919 47.0422 47.0217 47.0001 58.0975 58.0112 57.8719 -4398.68
+          -4169.84 -3883.93 -3535.63 -3128.45 -2673.42 -2188.6 -1341.97 -644.419 -134.187 47.8957 47.6735 47.4136
+          47.1354 47.0392 47.0193 46.998 58.0832 57.9883 57.8567 -3488.05 -4362.38 -4092.99 -3750.33 -3338.62
+          -2869.84 -2364.13 -1468.13 -718.308 -161.029 47.8512 47.6296 47.3687 47.0988 47.0375 47.0176 46.9968
+          58.0716 57.9642 57.8323 -2777.82 -4491.82 -4240.57 -3908.24 -3498.67 -3023.99 -2505.62 -1574.83 -786.095
+          -192.93 47.8062 47.5868 47.3265 47.0804 47.0361 47.0163 46.9961 58.0615 57.9402 57.8037 -2270.15
+          -4586.47 -4353.32 -4033.46 -3629.07 -3152.06 -2624.79 -1666.09 -845.299 -221.14 47.761 47.5443 47.285
+          47.0689 47.0347 47.015 46.9955 58.0518 57.916 57.7725 -1852.36 -4660.96 -4446.02 -4140.04 -3742.9
+          -3266 -2732.27 -1749.32 -899.24 -246.917 47.7157 47.5014 47.2424 47.0609 47.0332 47.0137 46.995
+          58.0416 57.8908 57.7392 -1515.75 -4722.88 -4526.65 -4235.57 -3847.17 -3372.18 -2833.89 -1829.17 -950.327
+          -270.445 47.6706 47.4578 47.1979 47.0552 47.0314 47.0123 46.9943 58.0296 57.8638 57.7038 -1189.02
+          -4776.12 -4598.06 -4322.03 -3943.46 -3472.05 -2930.94 -1906.38 -999.05 -291.314 47.6261 47.4137 47.1544
+          47.0514 47.0294 47.0105 46.9935 58.014 57.8337 57.6663 -896.071 -4819.13 -4657.19 -4394.2 -4025.5
+          -3559.06 -3017.22 -1974.93 -1039.39 -302.884 47.5827 47.3688 47.1196 47.0489 47.0271 47.0082 46.9922
+          57.9914 57.7998 57.6271 -1001.29 -4799.47 -4641.83 -4389.82 -4031.2 -3571.55 -3032.32 -1976.33 -1002.3
+          -209.903 47.5426 47.3212 47.1001 47.0473 47.0242 47.0052 46.9901
+        </DataArray>
+        <DataArray type="Float32" Name="m^w_NaCl" NumberOfComponents="1" format="ascii">
+          105.624 281.373 618.927 5052.58 5039.14 5023.02 5004.14 4982.6 4958.82 4933.61 4890.32 4855.2
+          4829.91 4819.6 4819.51 4819.42 4819.32 4819.27 4819.26 4819.25 17.6352 106.914 348.456 5070.54
+          5057.57 5041.19 5021.3 4998.12 4972.27 4944.75 4897.28 4858.33 4829.81 4819.58 4819.5 4819.4
+          4819.3 4819.27 4819.26 4819.25 7.16491 54.8718 222.54 4002.82 5068.27 5052.82 5033.25 5009.81
+          4983.19 4954.51 4904.29 4862.43 4831.28 4819.56 4819.48 4819.39 4819.29 4819.27 4819.26 4819.25
+          4.14775 31.5419 150.441 3191.91 5075.46 5061.04 5042.03 5018.71 4991.76 4962.37 4910.22 4866.18
+          4833.04 4819.55 4819.47 4819.37 4819.28 4819.26 4819.26 4819.25 2.87629 19.4207 105.755 2612.89
+          5080.72 5067.31 5048.99 5025.96 4998.88 4968.99 4915.28 4869.47 4834.6 4819.53 4819.45 4819.36
+          4819.28 4819.26 4819.26 4819.25 2.25022 12.5353 76.2049 2140.89 5084.86 5072.48 5054.92 5032.29
+          5005.21 4974.96 4919.9 4872.45 4836.02 4819.51 4819.44 4819.34 4819.27 4819.26 4819.26 4819.25
+          1.92432 8.44356 55.8803 1760.84 5088.31 5076.97 5060.23 5038.08 5011.1 4980.6 4924.33 4875.28
+          4837.31 4819.5 4819.42 4819.32 4819.27 4819.26 4819.26 4819.25 1.75469 5.99571 41.7699 1398.34
+          5091.26 5080.95 5065.04 5043.43 5016.65 4985.99 4928.61 4877.98 4838.45 4819.48 4819.4 4819.31
+          4819.27 4819.26 4819.26 4819.25 1.6692 4.5981 32.8437 1078.6 5093.64 5084.24 5069.04 5047.98
+          5021.47 4990.77 4932.41 4880.21 4839.08 4819.46 4819.39 4819.3 4819.27 4819.26 4819.25 4819.25
+          1.62824 4.00752 32.4732 1201.87 5092.53 5083.37 5068.78 5048.28 5022.15 4991.59 4932.47 4878.12
+          4833.88 4819.45 4819.37 4819.29 4819.27 4819.26 4819.25 4819.25
+        </DataArray>
+        <DataArray type="Float32" Name="velocityW" NumberOfComponents="3" format="ascii">
+          2.59281e-07 -3.69978e-07 0 7.49143e-07 -1.22246e-07 0 8.77141e-07 -6.60705e-09 0 9.29013e-07 -1.02096e-07 0
+          1.00448e-06 -3.01819e-08 0 1.06269e-06 -2.79548e-08 0 1.10732e-06 -1.65926e-08 0 1.13316e-06 -9.14292e-09 0
+          1.14712e-06 -4.71828e-09 0 1.15393e-06 -1.98579e-09 0 1.16155e-06 -5.55894e-09 0 1.17297e-06 -5.83442e-09 0
+          1.18925e-06 -1.04613e-08 0 1.18551e-06 -2.59783e-08 0 1.161e-06 -1.40524e-08 0 1.09262e-06 2.52801e-09 0
+          6.94029e-07 4.44584e-08 0 1.77363e-07 -1.53943e-09 0 7.65694e-10 -9.99789e-10 0 7.17068e-10 -9.2476e-10 0
+          5.73596e-07 -4.55888e-07 0 8.48201e-07 -1.7457e-07 0 1.02062e-06 -4.00759e-08 0 1.04468e-06 -1.19395e-07 0
+          1.01817e-06 -3.91325e-08 0 1.06638e-06 -4.30783e-08 0 1.11233e-06 -2.43987e-08 0 1.13642e-06 -1.33288e-08 0
+          1.14917e-06 -6.85871e-09 0 1.15535e-06 -2.88165e-09 0 1.16219e-06 -8.04329e-09 0 1.17193e-06 -8.21119e-09 0
+          1.18236e-06 -1.33014e-08 0 1.1445e-06 -2.57763e-08 0 1.07985e-06 -1.9951e-08 0 9.86416e-07 -5.12514e-09 0
+          5.14184e-07 1.74902e-08 0 5.73122e-08 -1.3453e-09 0 2.97645e-10 -1.00884e-09 0 5.57031e-10 -9.35167e-10 0
+          8.15068e-07 -5.82384e-07 0 9.66504e-07 -2.62516e-07 0 1.09269e-06 -9.99517e-08 0 1.09576e-06 -1.30063e-07 0
+          1.05286e-06 -6.01329e-08 0 1.08601e-06 -7.01173e-08 0 1.12272e-06 -3.85994e-08 0 1.14241e-06 -2.09132e-08 0
+          1.15276e-06 -1.07271e-08 0 1.15777e-06 -4.49907e-09 0 1.1632e-06 -1.24842e-08 0 1.17055e-06 -1.2294e-08 0
+          1.17653e-06 -1.74326e-08 0 1.12704e-06 -2.35922e-08 0 1.04122e-06 -2.91802e-08 0 8.9373e-07 -1.89848e-08 0
+          4.04623e-07 -1.07117e-08 0 1.4754e-08 -1.11206e-09 0 2.43099e-10 -1.02153e-09 0 5.41122e-10 -9.49817e-10 0
+          1.02394e-06 -6.42061e-07 0 1.10146e-06 -3.18078e-07 0 1.17163e-06 -1.40062e-07 0 1.15702e-06 -1.12152e-07 0
+          1.10515e-06 -8.28793e-08 0 1.11337e-06 -8.95938e-08 0 1.13728e-06 -4.93441e-08 0 1.15066e-06 -2.65997e-08 0
+          1.15764e-06 -1.36036e-08 0 1.161e-06 -5.69755e-09 0 1.1646e-06 -1.5725e-08 0 1.16935e-06 -1.50843e-08 0
+          1.17278e-06 -1.93594e-08 0 1.11824e-06 -2.03474e-08 0 1.01612e-06 -3.30058e-08 0 7.99302e-07 -2.52917e-08 0
+          3.19184e-07 -9.65958e-09 0 4.90711e-09 -1.05897e-09 0 2.29611e-10 -1.02635e-09 0 5.29513e-10 -9.55772e-10 0
+          1.21487e-06 -6.67569e-07 0 1.24112e-06 -3.44944e-07 0 1.26245e-06 -1.55887e-07 0 1.22471e-06 -8.56688e-08 0
+          1.15706e-06 -1.02285e-07 0 1.14249e-06 -1.01085e-07 0 1.15446e-06 -5.57038e-08 0 1.16051e-06 -2.98464e-08 0
+          1.16343e-06 -1.52024e-08 0 1.1648e-06 -6.35501e-09 0 1.16629e-06 -1.75349e-08 0 1.16841e-06 -1.66909e-08 0
+          1.1704e-06 -2.04726e-08 0 1.11295e-06 -1.8814e-08 0 9.97317e-07 -3.1858e-08 0 7.1369e-07 -2.13677e-08 0
+          2.45493e-07 -5.82134e-09 0 1.95631e-09 -1.03808e-09 0 2.2199e-10 -1.027e-09 0 5.19411e-10 -9.57748e-10 0
+          1.39969e-06 -6.6999e-07 0 1.38172e-06 -3.47085e-07 0 1.36082e-06 -1.50619e-07 0 1.29872e-06 -5.01275e-08 0
+          1.20989e-06 -1.1742e-07 0 1.17299e-06 -1.05578e-07 0 1.17312e-06 -5.71655e-08 0 1.17111e-06 -3.02974e-08 0
+          1.1696e-06 -1.53456e-08 0 1.16882e-06 -6.402e-09 0 1.16807e-06 -1.77801e-08 0 1.16746e-06 -1.71795e-08 0
+          1.16846e-06 -2.1486e-08 0 1.10934e-06 -1.95623e-08 0 9.82665e-07 -2.76495e-08 0 6.34855e-07 -1.28401e-08 0
+          1.77546e-07 -3.38755e-09 0 8.95383e-10 -1.02717e-09 0 2.1509e-10 -1.02456e-09 0 5.09205e-10 -9.57128e-10 0
+          1.58959e-06 -6.49195e-07 0 1.52227e-06 -3.25635e-07 0 1.46535e-06 -1.29612e-07 0 1.38446e-06 -4.8764e-09 0
+          1.27066e-06 -1.26502e-07 0 1.20659e-06 -1.02335e-07 0 1.1923e-06 -5.32249e-08 0 1.18159e-06 -2.7773e-08 0
+          1.17556e-06 -1.39812e-08 0 1.17267e-06 -5.82555e-09 0 1.16964e-06 -1.63895e-08 0 1.1661e-06 -1.64781e-08 0
+          1.16585e-06 -2.2566e-08 0 1.10618e-06 -2.34281e-08 0 9.70038e-07 -2.27298e-08 0 5.60354e-07 -8.09206e-09 0
+          1.13397e-07 -2.05544e-09 0 4.78865e-10 -1.01914e-09 0 2.08238e-10 -1.01836e-09 0 4.97589e-10 -9.53345e-10 0
+          1.79699e-06 -5.93911e-07 0 1.65943e-06 -2.78853e-07 0 1.57235e-06 -1.00675e-07 0 1.49839e-06 4.10391e-08 0
+          1.35919e-06 -1.21002e-07 0 1.24531e-06 -8.75903e-08 0 1.21061e-06 -4.33662e-08 0 1.19095e-06 -2.23319e-08 0
+          1.18074e-06 -1.11898e-08 0 1.17595e-06 -4.66288e-09 0 1.17073e-06 -1.33513e-08 0 1.16391e-06 -1.43192e-08 0
+          1.16101e-06 -2.31523e-08 0 1.10166e-06 -3.17546e-08 0 9.52123e-07 -1.72415e-08 0 4.88755e-07 -1.09408e-08 0
+          5.79516e-08 -1.395e-09 0 3.13764e-10 -1.00086e-09 0 2.01314e-10 -9.98455e-10 0 4.82442e-10 -9.37227e-10 0
+          2.03815e-06 -4.73182e-07 0 1.78119e-06 -2.02639e-07 0 1.6699e-06 -7.3815e-08 0 1.67121e-06 5.02041e-08 0
+          1.51634e-06 -7.36313e-08 0 1.29227e-06 -5.22259e-08 0 1.22516e-06 -2.77165e-08 0 1.19792e-06 -1.44112e-08 0
+          1.18457e-06 -7.21793e-09 0 1.17834e-06 -3.01136e-09 0 1.17124e-06 -8.76497e-09 0 1.16076e-06 -1.02356e-08 0
+          1.15158e-06 -2.12041e-08 0 1.09038e-06 -4.53147e-08 0 9.08526e-07 -5.33182e-09 0 4.12912e-07 -9.39894e-09 0
+          2.11135e-08 -1.01704e-09 0 2.49743e-10 -8.96463e-10 0 1.91456e-10 -8.92215e-10 0 4.54242e-10 -8.41814e-10 0
+          2.28576e-06 -3.90939e-07 0 1.73844e-06 -1.56541e-07 0 1.52725e-06 -6.22757e-08 0 1.50774e-06 3.83661e-08 0
+          1.42346e-06 -3.44161e-08 0 1.27599e-06 -2.77999e-08 0 1.22976e-06 -1.85329e-08 0 1.20143e-06 -9.91495e-09 0
+          1.18666e-06 -4.97988e-09 0 1.17971e-06 -2.07962e-09 0 1.1716e-06 -6.10664e-09 0 1.15787e-06 -7.64347e-09 0
+          1.13101e-06 -1.92136e-08 0 9.79077e-07 -5.33951e-08 0 6.3963e-07 3.44374e-09 0 2.18837e-07 -4.76362e-09 0
+          2.49798e-09 -8.48879e-10 0 1.94807e-10 -8.06336e-10 0 1.55545e-10 -8.01614e-10 0 3.56583e-10 -7.5962e-10 0
+        </DataArray>
+        <DataArray type="Float32" Name="velocityN" NumberOfComponents="3" format="ascii">
+          5.02893e-10 7.8954e-10 0 1.20465e-09 8.53226e-10 0 5.96338e-10 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 2.40677e-09 1.76335e-09 0 1.84938e-08 1.03432e-08 0 5.92812e-08 2.79113e-08 0
+          1.83858e-07 1.97393e-07 0 5.56258e-07 -9.68343e-08 0 1.00823e-06 -1.75355e-07 0 1.40176e-06 -2.15677e-07 0
+          2.62974e-09 9.24149e-10 0 3.33404e-09 1.30354e-09 0 1.58195e-09 4.54411e-13 0 6.40608e-13 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 5.46035e-09 2.87421e-09 0 3.54112e-08 1.43537e-08 0 1.21152e-07 4.08083e-08 0
+          4.05699e-07 3.12329e-07 0 8.37357e-07 -1.72406e-07 0 1.12683e-06 -2.15745e-07 0 1.31177e-06 -2.67587e-07 0
+          4.12653e-09 9.39824e-10 0 4.96756e-09 1.95418e-09 0 2.44874e-09 6.24434e-12 0 8.95523e-12 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 6.73727e-09 4.48435e-09 0 4.75269e-08 2.13189e-08 0 1.81208e-07 6.66303e-08 0
+          6.28453e-07 4.42504e-07 0 1.03949e-06 -2.72145e-07 0 1.14059e-06 -2.74844e-07 0 1.22592e-06 -3.43323e-07 0
+          5.03659e-09 7.14151e-10 0 5.81634e-09 2.16297e-09 0 2.94854e-09 1.9221e-11 0 2.21046e-11 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 6.81332e-09 5.0537e-09 0 5.57194e-08 2.66284e-08 0 2.34217e-07 9.6293e-08 0
+          7.47865e-07 4.21922e-07 0 1.1222e-06 -2.9226e-07 0 1.13148e-06 -2.99517e-07 0 1.16301e-06 -3.76833e-07 0
+          5.79935e-09 5.67469e-10 0 6.40393e-09 2.15067e-09 0 3.25907e-09 3.49136e-11 0 3.70525e-11 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 6.42452e-09 5.01173e-09 0 6.1928e-08 3.11569e-08 0 2.80359e-07 1.37026e-07 0
+          8.01319e-07 3.30031e-07 0 1.13413e-06 -2.77734e-07 0 1.11039e-06 -3.02887e-07 0 1.10863e-06 -3.88141e-07 0
+          6.54782e-09 5.4373e-10 0 6.95531e-09 2.14887e-09 0 3.53099e-09 5.42436e-11 0 5.84501e-11 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 5.98998e-09 4.74853e-09 0 6.81481e-08 3.5649e-08 0 3.2339e-07 1.97108e-07 0
+          8.31233e-07 2.07101e-07 0 1.12027e-06 -2.56889e-07 0 1.08177e-06 -2.90796e-07 0 1.05389e-06 -3.85237e-07 0
+          7.32311e-09 6.38183e-10 0 7.49991e-09 2.24159e-09 0 3.79651e-09 7.94407e-11 0 8.56015e-11 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 5.7265e-09 4.48127e-09 0 7.60925e-08 4.07114e-08 0 3.7214e-07 2.8392e-07 0
+          8.66714e-07 6.49466e-08 0 1.10686e-06 -2.34731e-07 0 1.04971e-06 -2.64131e-07 0 9.91827e-07 -3.68877e-07 0
+          8.17284e-09 8.93012e-10 0 8.01731e-09 2.44974e-09 0 4.04882e-09 1.12438e-10 0 1.24456e-10 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 5.7906e-09 4.32944e-09 0 8.70145e-08 4.7379e-08 0 4.42611e-07 3.84022e-07 0
+          9.34428e-07 -8.72488e-08 0 1.10922e-06 -2.04346e-07 0 1.01764e-06 -2.19507e-07 0 9.14551e-07 -3.3292e-07 0
+          9.226e-09 1.40732e-09 0 8.58116e-09 2.77301e-09 0 4.32822e-09 1.5464e-10 0 1.7784e-10 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 6.8656e-09 4.46775e-09 0 1.03725e-07 5.95519e-08 0 5.7128e-07 4.25447e-07 0
+          1.07685e-06 -2.17568e-07 0 1.13869e-06 -1.52597e-07 0 9.90889e-07 -1.51208e-07 0 8.11418e-07 -2.60024e-07 0
+          1.36356e-08 1.74505e-09 0 1.83748e-08 2.96191e-09 0 1.4083e-08 1.77762e-10 0 3.51753e-09 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 3.66464e-08 4.64178e-09 0 3.50374e-07 6.78013e-08 0 1.25523e-06 4.17497e-07 0
+          1.61447e-06 -2.70986e-07 0 1.22604e-06 -1.19448e-07 0 9.95209e-07 -1.10362e-07 0 6.72223e-07 -2.1125e-07 0
+        </DataArray>
+        <DataArray type="Float32" Name="process rank" NumberOfComponents="1" format="ascii">
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0 0 0 0 0
+          0 0 0 0 0 0 0 0
+        </DataArray>
+      </CellData>
+      <Points>
+        <DataArray type="Float32" Name="Coordinates" NumberOfComponents="3" format="ascii">
+          0 0 0 2 0 0 0 1 0 2 1 0
+          4 0 0 4 1 0 6 0 0 6 1 0
+          8 0 0 8 1 0 10 0 0 10 1 0
+          12 0 0 12 1 0 14 0 0 14 1 0
+          16 0 0 16 1 0 18 0 0 18 1 0
+          20 0 0 20 1 0 22 0 0 22 1 0
+          24 0 0 24 1 0 26 0 0 26 1 0
+          28 0 0 28 1 0 30 0 0 30 1 0
+          32 0 0 32 1 0 34 0 0 34 1 0
+          36 0 0 36 1 0 38 0 0 38 1 0
+          40 0 0 40 1 0 0 2 0 2 2 0
+          4 2 0 6 2 0 8 2 0 10 2 0
+          12 2 0 14 2 0 16 2 0 18 2 0
+          20 2 0 22 2 0 24 2 0 26 2 0
+          28 2 0 30 2 0 32 2 0 34 2 0
+          36 2 0 38 2 0 40 2 0 0 3 0
+          2 3 0 4 3 0 6 3 0 8 3 0
+          10 3 0 12 3 0 14 3 0 16 3 0
+          18 3 0 20 3 0 22 3 0 24 3 0
+          26 3 0 28 3 0 30 3 0 32 3 0
+          34 3 0 36 3 0 38 3 0 40 3 0
+          0 4 0 2 4 0 4 4 0 6 4 0
+          8 4 0 10 4 0 12 4 0 14 4 0
+          16 4 0 18 4 0 20 4 0 22 4 0
+          24 4 0 26 4 0 28 4 0 30 4 0
+          32 4 0 34 4 0 36 4 0 38 4 0
+          40 4 0 0 5 0 2 5 0 4 5 0
+          6 5 0 8 5 0 10 5 0 12 5 0
+          14 5 0 16 5 0 18 5 0 20 5 0
+          22 5 0 24 5 0 26 5 0 28 5 0
+          30 5 0 32 5 0 34 5 0 36 5 0
+          38 5 0 40 5 0 0 6 0 2 6 0
+          4 6 0 6 6 0 8 6 0 10 6 0
+          12 6 0 14 6 0 16 6 0 18 6 0
+          20 6 0 22 6 0 24 6 0 26 6 0
+          28 6 0 30 6 0 32 6 0 34 6 0
+          36 6 0 38 6 0 40 6 0 0 7 0
+          2 7 0 4 7 0 6 7 0 8 7 0
+          10 7 0 12 7 0 14 7 0 16 7 0
+          18 7 0 20 7 0 22 7 0 24 7 0
+          26 7 0 28 7 0 30 7 0 32 7 0
+          34 7 0 36 7 0 38 7 0 40 7 0
+          0 8 0 2 8 0 4 8 0 6 8 0
+          8 8 0 10 8 0 12 8 0 14 8 0
+          16 8 0 18 8 0 20 8 0 22 8 0
+          24 8 0 26 8 0 28 8 0 30 8 0
+          32 8 0 34 8 0 36 8 0 38 8 0
+          40 8 0 0 9 0 2 9 0 4 9 0
+          6 9 0 8 9 0 10 9 0 12 9 0
+          14 9 0 16 9 0 18 9 0 20 9 0
+          22 9 0 24 9 0 26 9 0 28 9 0
+          30 9 0 32 9 0 34 9 0 36 9 0
+          38 9 0 40 9 0 0 10 0 2 10 0
+          4 10 0 6 10 0 8 10 0 10 10 0
+          12 10 0 14 10 0 16 10 0 18 10 0
+          20 10 0 22 10 0 24 10 0 26 10 0
+          28 10 0 30 10 0 32 10 0 34 10 0
+          36 10 0 38 10 0 40 10 0
+        </DataArray>
+      </Points>
+      <Cells>
+        <DataArray type="Int32" Name="connectivity" NumberOfComponents="1" format="ascii">
+          0 1 3 2 1 4 5 3 4 6 7 5
+          6 8 9 7 8 10 11 9 10 12 13 11
+          12 14 15 13 14 16 17 15 16 18 19 17
+          18 20 21 19 20 22 23 21 22 24 25 23
+          24 26 27 25 26 28 29 27 28 30 31 29
+          30 32 33 31 32 34 35 33 34 36 37 35
+          36 38 39 37 38 40 41 39 2 3 43 42
+          3 5 44 43 5 7 45 44 7 9 46 45
+          9 11 47 46 11 13 48 47 13 15 49 48
+          15 17 50 49 17 19 51 50 19 21 52 51
+          21 23 53 52 23 25 54 53 25 27 55 54
+          27 29 56 55 29 31 57 56 31 33 58 57
+          33 35 59 58 35 37 60 59 37 39 61 60
+          39 41 62 61 42 43 64 63 43 44 65 64
+          44 45 66 65 45 46 67 66 46 47 68 67
+          47 48 69 68 48 49 70 69 49 50 71 70
+          50 51 72 71 51 52 73 72 52 53 74 73
+          53 54 75 74 54 55 76 75 55 56 77 76
+          56 57 78 77 57 58 79 78 58 59 80 79
+          59 60 81 80 60 61 82 81 61 62 83 82
+          63 64 85 84 64 65 86 85 65 66 87 86
+          66 67 88 87 67 68 89 88 68 69 90 89
+          69 70 91 90 70 71 92 91 71 72 93 92
+          72 73 94 93 73 74 95 94 74 75 96 95
+          75 76 97 96 76 77 98 97 77 78 99 98
+          78 79 100 99 79 80 101 100 80 81 102 101
+          81 82 103 102 82 83 104 103 84 85 106 105
+          85 86 107 106 86 87 108 107 87 88 109 108
+          88 89 110 109 89 90 111 110 90 91 112 111
+          91 92 113 112 92 93 114 113 93 94 115 114
+          94 95 116 115 95 96 117 116 96 97 118 117
+          97 98 119 118 98 99 120 119 99 100 121 120
+          100 101 122 121 101 102 123 122 102 103 124 123
+          103 104 125 124 105 106 127 126 106 107 128 127
+          107 108 129 128 108 109 130 129 109 110 131 130
+          110 111 132 131 111 112 133 132 112 113 134 133
+          113 114 135 134 114 115 136 135 115 116 137 136
+          116 117 138 137 117 118 139 138 118 119 140 139
+          119 120 141 140 120 121 142 141 121 122 143 142
+          122 123 144 143 123 124 145 144 124 125 146 145
+          126 127 148 147 127 128 149 148 128 129 150 149
+          129 130 151 150 130 131 152 151 131 132 153 152
+          132 133 154 153 133 134 155 154 134 135 156 155
+          135 136 157 156 136 137 158 157 137 138 159 158
+          138 139 160 159 139 140 161 160 140 141 162 161
+          141 142 163 162 142 143 164 163 143 144 165 164
+          144 145 166 165 145 146 167 166 147 148 169 168
+          148 149 170 169 149 150 171 170 150 151 172 171
+          151 152 173 172 152 153 174 173 153 154 175 174
+          154 155 176 175 155 156 177 176 156 157 178 177
+          157 158 179 178 158 159 180 179 159 160 181 180
+          160 161 182 181 161 162 183 182 162 163 184 183
+          163 164 185 184 164 165 186 185 165 166 187 186
+          166 167 188 187 168 169 190 189 169 170 191 190
+          170 171 192 191 171 172 193 192 172 173 194 193
+          173 174 195 194 174 175 196 195 175 176 197 196
+          176 177 198 197 177 178 199 198 178 179 200 199
+          179 180 201 200 180 181 202 201 181 182 203 202
+          182 183 204 203 183 184 205 204 184 185 206 205
+          185 186 207 206 186 187 208 207 187 188 209 208
+          189 190 211 210 190 191 212 211 191 192 213 212
+          192 193 214 213 193 194 215 214 194 195 216 215
+          195 196 217 216 196 197 218 217 197 198 219 218
+          198 199 220 219 199 200 221 220 200 201 222 221
+          201 202 223 222 202 203 224 223 203 204 225 224
+          204 205 226 225 205 206 227 226 206 207 228 227
+          207 208 229 228 208 209 230 229
+        </DataArray>
+        <DataArray type="Int32" Name="offsets" NumberOfComponents="1" format="ascii">
+          4 8 12 16 20 24 28 32 36 40 44 48
+          52 56 60 64 68 72 76 80 84 88 92 96
+          100 104 108 112 116 120 124 128 132 136 140 144
+          148 152 156 160 164 168 172 176 180 184 188 192
+          196 200 204 208 212 216 220 224 228 232 236 240
+          244 248 252 256 260 264 268 272 276 280 284 288
+          292 296 300 304 308 312 316 320 324 328 332 336
+          340 344 348 352 356 360 364 368 372 376 380 384
+          388 392 396 400 404 408 412 416 420 424 428 432
+          436 440 444 448 452 456 460 464 468 472 476 480
+          484 488 492 496 500 504 508 512 516 520 524 528
+          532 536 540 544 548 552 556 560 564 568 572 576
+          580 584 588 592 596 600 604 608 612 616 620 624
+          628 632 636 640 644 648 652 656 660 664 668 672
+          676 680 684 688 692 696 700 704 708 712 716 720
+          724 728 732 736 740 744 748 752 756 760 764 768
+          772 776 780 784 788 792 796 800
+        </DataArray>
+        <DataArray type="UInt8" Name="types" NumberOfComponents="1" format="ascii">
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9 9 9 9 9
+          9 9 9 9 9 9 9 9
+        </DataArray>
+      </Cells>
+    </Piece>
+  </UnstructuredGrid>
+</VTKFile>