diff --git a/dumux/freeflow/rans/vtkoutputfields.hh b/dumux/freeflow/rans/vtkoutputfields.hh
index 631bb23006bb565e834c90c69ef3e0e34a25e26b..ff84b83d83c4fcfe5419847d2bd3d3dc477b94da 100644
--- a/dumux/freeflow/rans/vtkoutputfields.hh
+++ b/dumux/freeflow/rans/vtkoutputfields.hh
@@ -24,10 +24,7 @@
 #ifndef DUMUX_RANS_VTK_OUTPUT_FIELDS_HH
 #define DUMUX_RANS_VTK_OUTPUT_FIELDS_HH
 
-#include <dune/common/fvector.hh>
-#include <dumux/common/properties.hh>
-#include <dumux/common/parameters.hh>
-#include <dumux/discretization/methods.hh>
+#include <dumux/freeflow/navierstokes/vtkoutputfields.hh>
 
 namespace Dumux
 {
@@ -37,59 +34,29 @@ namespace Dumux
  * \brief Adds vtk output fields for the Reynolds-Averaged Navier-Stokes model
  */
 template<class FVGridGeometry>
-class RANSVtkOutputFields
+class RANSVtkOutputFields : public NavierStokesVtkOutputFields<FVGridGeometry>
 {
-    using ctype = typename FVGridGeometry::GridView::ctype;
-    using GlobalPosition = Dune::FieldVector<ctype, FVGridGeometry::GridView::dimensionworld>;
-
-    // Helper type used for tag dispatching (to add discretization-specific fields).
-    template<DiscretizationMethod discMethod>
-    using discMethodTag = std::integral_constant<DiscretizationMethod, discMethod>;
+    enum { dim = FVGridGeometry::GridView::dimension };
 
 public:
     //! Initialize the Navier-Stokes specific vtk output fields.
     template <class VtkOutputModule>
     static void init(VtkOutputModule& vtk)
     {
-        vtk.addVolumeVariable([](const auto& v){ return v.velocity()[0]; }, "v_x [m/s]");
-        vtk.addVolumeVariable([](const auto& v){ return v.velocityGradients()[0][0]; }, "dv_x/dx [m/s]");
-        vtk.addVolumeVariable([](const auto& v){ return v.velocityGradients()[0][1]; }, "dv_x/dy [m/s]");
-        vtk.addVolumeVariable([](const auto& v){ return v.pressure(); }, "p [Pa]");
-        vtk.addVolumeVariable([](const auto& v){ return v.pressure() - 1e5; }, "p_rel [Pa]");
-        vtk.addVolumeVariable([](const auto& v){ return v.density(); }, "rho [kg/m^3]");
-        vtk.addVolumeVariable([](const auto& v){ return v.viscosity() / v.density(); }, "nu [m^2/s]");
-        vtk.addVolumeVariable([](const auto& v){ return v.dynamicEddyViscosity() / v.density(); }, "nu_t [m^2/s]");
-        vtk.addVolumeVariable([](const auto& v){ return v.wallDistance(); }, "l_w [m]");
-        vtk.addVolumeVariable([](const auto& v){ return v.yPlus(); }, "y^+ [-]");
-        vtk.addVolumeVariable([](const auto& v){ return v.uPlus(); }, "u^+ [-]");
-
-        // add discretization-specific fields
-        additionalOutput_(vtk, discMethodTag<FVGridGeometry::discMethod>{});
-    }
-
-private:
-
-    //! Adds discretization-specific fields (nothing by default).
-    template <class VtkOutputModule, class AnyMethod>
-    static void additionalOutput_(VtkOutputModule& vtk, AnyMethod)
-    { }
-
-    //! Adds discretization-specific fields (velocity vectors on the faces for the staggered discretization).
-    template <class VtkOutputModule>
-    static void additionalOutput_(VtkOutputModule& vtk, discMethodTag<DiscretizationMethod::staggered>)
-    {
-        const bool writeFaceVars = getParamFromGroup<bool>(vtk.paramGroup(), "Vtk.WriteFaceData", false);
-        if(writeFaceVars)
-        {
-            auto faceVelocityVector = [](const typename FVGridGeometry::SubControlVolumeFace& scvf, const auto& faceVars)
-                                      {
-                                          GlobalPosition velocity(0.0);
-                                          velocity[scvf.directionIndex()] = faceVars.velocitySelf();
-                                          return velocity;
-                                      };
+        NavierStokesVtkOutputFields<FVGridGeometry>::init(vtk);
 
-            vtk.addFaceVariable(faceVelocityVector, "faceVelocity");
-        }
+        vtk.addVolumeVariable([](const auto& v){ return v.velocityGradients()[0]; }, "dv_x/dx_");
+        if (dim > 1)
+            vtk.addVolumeVariable([](const auto& v){ return v.velocityGradients()[1]; }, "dv_y/dx_");
+        if (dim > 2)
+            vtk.addVolumeVariable([](const auto& v){ return v.velocityGradients()[2]; }, "dv_z/dx_");
+        vtk.addVolumeVariable([](const auto& v){ return v.pressure() - 1e5; }, "p_rel");
+        vtk.addVolumeVariable([](const auto& v){ return v.density(); }, "rho");
+        vtk.addVolumeVariable([](const auto& v){ return v.viscosity() / v.density(); }, "nu");
+        vtk.addVolumeVariable([](const auto& v){ return v.dynamicEddyViscosity() / v.density(); }, "nu_t");
+        vtk.addVolumeVariable([](const auto& v){ return v.wallDistance(); }, "l_w");
+        vtk.addVolumeVariable([](const auto& v){ return v.yPlus(); }, "y^+");
+        vtk.addVolumeVariable([](const auto& v){ return v.uPlus(); }, "u^+");
     }
 };
 
diff --git a/dumux/io/vtkoutputmodule.hh b/dumux/io/vtkoutputmodule.hh
index 55f715fd5a1b111d49aa2b4e396188c3f4301e4b..e3c8177b9d31e08542e836c91362235678d2e109 100644
--- a/dumux/io/vtkoutputmodule.hh
+++ b/dumux/io/vtkoutputmodule.hh
@@ -239,6 +239,7 @@ class VtkOutputModule
     static constexpr int dofCodim = isBox ? dim : 0;
 
     struct VolVarScalarDataInfo { std::function<Scalar(const VolumeVariables&)> get; std::string name; };
+    struct VolVarVectorDataInfo { std::function<GlobalPosition(const VolumeVariables&)> get; std::string name; };
     using Field = Vtk::template Field<GridView>;
 
 public:
@@ -293,6 +294,16 @@ public:
         volVarScalarDataInfo_.push_back(VolVarScalarDataInfo{f, name});
     }
 
+    //! Add a vector-valued variable
+    //! \param f A function taking a VolumeVariables object and returning the desired vector
+    //! \param name The name of the vtk field
+    //! \note This method is only available for dimWorld > 1. For 1-D problems, the overload for volVar methods returning a Scalar will be used.
+    template<class G = GlobalPosition, typename std::enable_if_t<(G::dimension > 1), int> = 0>
+    void addVolumeVariable(std::function<GlobalPosition(const VolumeVariables&)>&& f, const std::string& name)
+    {
+        volVarVectorDataInfo_.push_back(VolVarVectorDataInfo{f, name});
+    }
+
     //! Add a scalar or vector valued vtk field
     //! \param v The field to be added. Can be any indexable container. Its value type can be a number or itself an indexable container.
     //! \param name The name of the field
@@ -367,9 +378,11 @@ public:
 
         // volume variable data
         std::vector<std::vector<Scalar>> volVarScalarData;
+        std::vector<std::vector<GlobalPosition>> volVarVectorData;
 
         //! Abort if no data was registered
         if (!volVarScalarDataInfo_.empty()
+            || !volVarVectorDataInfo_.empty()
             || !fields_.empty()
             || velocityOutput.enableOutput()
             || addProcessRank)
@@ -380,6 +393,8 @@ public:
             // get fields for all volume variables
             if (!volVarScalarDataInfo_.empty())
                 volVarScalarData.resize(volVarScalarDataInfo_.size(), std::vector<Scalar>(numDofs));
+            if (!volVarVectorDataInfo_.empty())
+                volVarVectorData.resize(volVarVectorDataInfo_.size(), std::vector<GlobalPosition>(numDofs));
 
             if (velocityOutput.enableOutput())
             {
@@ -416,15 +431,21 @@ public:
                 else if (!volVarScalarDataInfo_.empty())
                     elemVolVars.bindElement(element, fvGeometry, sol_);
 
-                if (!volVarScalarDataInfo_.empty())
+                if (!volVarScalarDataInfo_.empty()
+                    || !volVarVectorDataInfo_.empty())
                 {
                     for (auto&& scv : scvs(fvGeometry))
                     {
                         const auto dofIdxGlobal = scv.dofIndex();
                         const auto& volVars = elemVolVars[scv];
 
+                        // get the scalar-valued data
                         for (std::size_t i = 0; i < volVarScalarDataInfo_.size(); ++i)
                             volVarScalarData[i][dofIdxGlobal] = volVarScalarDataInfo_[i].get(volVars);
+
+                        // get the vector-valued data
+                        for (std::size_t i = 0; i < volVarVectorDataInfo_.size(); ++i)
+                            volVarVectorData[i][dofIdxGlobal] = volVarVectorDataInfo_[i].get(volVars);
                     }
                 }
 
@@ -445,6 +466,12 @@ public:
             // volume variables if any
             for (std::size_t i = 0; i < volVarScalarDataInfo_.size(); ++i)
                 addDofDataForWriter_(sequenceWriter_, volVarScalarData[i], volVarScalarDataInfo_[i].name);
+            for (std::size_t i = 0; i < volVarVectorDataInfo_.size(); ++i)
+            {
+
+                sequenceWriter_.addCellData(Field(gridGeom_.gridView(), gridGeom_.elementMapper(), volVarVectorData[i],
+                                                  volVarVectorDataInfo_[i].name, dimWorld, 0).get());
+            }
 
             // the velocity field
             if (velocityOutput.enableOutput())
@@ -551,7 +578,9 @@ private:
     std::shared_ptr<Dune::VTKWriter<GridView>> writer_;
     Dune::VTKSequenceWriter<GridView> sequenceWriter_;
 
-    std::vector<VolVarScalarDataInfo> volVarScalarDataInfo_; //!< Registered volume variables
+    std::vector<VolVarScalarDataInfo> volVarScalarDataInfo_; //!< Registered volume variables (scalar)
+    std::vector<VolVarVectorDataInfo> volVarVectorDataInfo_; //!< Registered volume variables (vector)
+
     std::vector<Field> fields_; //!< Registered scalar and vector fields
 };
 
diff --git a/dumux/porousmediumflow/mpnc/vtkoutputfields.hh b/dumux/porousmediumflow/mpnc/vtkoutputfields.hh
index 03e28c84e9c2d2b8e89e3c0163d60fd95f0797f7..415a371a628e3912ae596d22ba69f93983d62ef3 100644
--- a/dumux/porousmediumflow/mpnc/vtkoutputfields.hh
+++ b/dumux/porousmediumflow/mpnc/vtkoutputfields.hh
@@ -43,14 +43,14 @@ public:
         for (int i = 0; i < FluidSystem::numPhases; ++i)
             vtk.addVolumeVariable([i](const auto& v){ return v.saturation(i); }, "S_"+ FluidSystem::phaseName(i));
 
-       for (int i = 0; i < FluidSystem::numPhases; ++i)
+        for (int i = 0; i < FluidSystem::numPhases; ++i)
             vtk.addVolumeVariable([i](const auto& v){ return v.pressure(i); }, "p_"+ FluidSystem::phaseName(i));
 
-       for (int i = 0; i < FluidSystem::numPhases; ++i)
+        for (int i = 0; i < FluidSystem::numPhases; ++i)
             vtk.addVolumeVariable([i](const auto& v){ return v.density(i); }, "rho_"+ FluidSystem::phaseName(i));
 
-       for (int i = 0; i < FluidSystem::numPhases; ++i)
-                  vtk.addVolumeVariable([i](const auto& v){ return v.mobility(i); },"lambda_"+ FluidSystem::phaseName(i));
+        for (int i = 0; i < FluidSystem::numPhases; ++i)
+            vtk.addVolumeVariable([i](const auto& v){ return v.mobility(i); },"lambda_"+ FluidSystem::phaseName(i));
 
         vtk.addVolumeVariable([](const auto& v){ return v.porosity(); }, "porosity");
 
diff --git a/dumux/porousmediumflow/nonequilibrium/vtkoutputfields.hh b/dumux/porousmediumflow/nonequilibrium/vtkoutputfields.hh
index 62253bad4bc4631bf613adbbd9160a8c4be324c2..6d5652a9e2d57a57002b022a2f4b7bde076f4ed5 100644
--- a/dumux/porousmediumflow/nonequilibrium/vtkoutputfields.hh
+++ b/dumux/porousmediumflow/nonequilibrium/vtkoutputfields.hh
@@ -42,14 +42,14 @@ public:
     static void init(VtkOutputModule& vtk)
     {
         EquilibriumVtkOutputFields::init(vtk);
-         for (int i = 0; i < numEnergyEqFluid; ++i)
-        vtk.addVolumeVariable( [i](const auto& v){ return v.temperature(i); }, "T_" + FluidSystem::phaseName(i) );
-         for (int i = 0; i < numEnergyEqSolid; ++i)
-        vtk.addVolumeVariable( [i](const auto& v){ return v.temperatureSolid(); }, "T_solid" );
+        for (int i = 0; i < numEnergyEqFluid; ++i)
+            vtk.addVolumeVariable( [i](const auto& v){ return v.temperature(i); }, "T_" + FluidSystem::phaseName(i) );
+        for (int i = 0; i < numEnergyEqSolid; ++i)
+            vtk.addVolumeVariable( [i](const auto& v){ return v.temperatureSolid(); }, "T_solid" );
         for (int i = 0; i < FluidSystem::numPhases; ++i){
-        vtk.addVolumeVariable( [i](const auto& v){ return v.reynoldsNumber(i); }, "reynoldsNumber_" + FluidSystem::phaseName(i) );
-        vtk.addVolumeVariable( [i](const auto& v){ return v.nusseltNumber(i); }, "nusseltNumber_" + FluidSystem::phaseName(i) );
-        vtk.addVolumeVariable( [i](const auto& v){ return v.prandtlNumber(i); }, "prandtlNumber_" + FluidSystem::phaseName(i) );
+            vtk.addVolumeVariable( [i](const auto& v){ return v.reynoldsNumber(i); }, "reynoldsNumber_" + FluidSystem::phaseName(i) );
+            vtk.addVolumeVariable( [i](const auto& v){ return v.nusseltNumber(i); }, "nusseltNumber_" + FluidSystem::phaseName(i) );
+            vtk.addVolumeVariable( [i](const auto& v){ return v.prandtlNumber(i); }, "prandtlNumber_" + FluidSystem::phaseName(i) );
         }
     }
 };
diff --git a/dumux/porousmediumflow/richards/vtkoutputfields.hh b/dumux/porousmediumflow/richards/vtkoutputfields.hh
index b0b1ee249695a1597b03b9c21ad935845e85e12a..3506564e988a7286763ccb5f2ec1ec7e4228e993 100644
--- a/dumux/porousmediumflow/richards/vtkoutputfields.hh
+++ b/dumux/porousmediumflow/richards/vtkoutputfields.hh
@@ -59,8 +59,7 @@ public:
             vtk.addVolumeVariable([](const auto& v){ return v.moleFraction(1, 0); }, "x^w_air");
         vtk.addVolumeVariable([](const auto& v){ return v.waterContent(Indices::wPhaseIdx); },"water content");
 
-         vtk.addVolumeVariable([](const auto& v){ return v.priVars().state(); }, "phasePresence");
-
+        vtk.addVolumeVariable([](const auto& v){ return v.priVars().state(); }, "phasePresence");
     }
 };
 
diff --git a/test/freeflow/rans/test_pipe_laufer.cc b/test/freeflow/rans/test_pipe_laufer.cc
index afd6e99c4636c8bea64c965ef793d8aa1bcb8b65..261ff49ad43065b1d55574c31c5fbb15a8c93686 100644
--- a/test/freeflow/rans/test_pipe_laufer.cc
+++ b/test/freeflow/rans/test_pipe_laufer.cc
@@ -238,7 +238,7 @@ int main(int argc, char** argv) try
         gnuplot.setOption("set log x");
         gnuplot.setOption("set xrange [1:3000]");
         gnuplot.addFileToPlot("laufer_re50000_u+y+.csv", "u 1:2 w p t 'Laufer1954a, Re=50000'");
-        gnuplot.addFileToPlot(std::string(fileName) + ".csv", "u 13:14 w l");
+        gnuplot.addFileToPlot(std::string(fileName) + ".csv", "u 10:11 w l");
         gnuplot.plot(std::string(gnuplotFileName));
     }
 #endif
diff --git a/test/references/pipe_laufer_zeroeq.vtu b/test/references/pipe_laufer_zeroeq.vtu
index c16176ac3710caebb5f7af8731c53ef288c6d943..4f3ada09cbde459faa7ce787ecb206db38eca506 100644
--- a/test/references/pipe_laufer_zeroeq.vtu
+++ b/test/references/pipe_laufer_zeroeq.vtu
@@ -2,80 +2,8 @@
 <VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
   <UnstructuredGrid>
     <Piece NumberOfCells="256" NumberOfPoints="289">
-      <CellData Scalars="v_x [m/s]" Vectors="velocity_Air (m/s)">
-        <DataArray type="Float32" Name="v_x [m/s]" NumberOfComponents="1" format="ascii">
-          2.07761 1.47958 1.28367 1.25467 1.2256 1.19748 1.1905 1.18952 1.1839 1.17538 1.16979 1.17192
-          1.17724 1.18028 1.18099 1.18075 2.38628 2.14543 1.94733 1.84353 1.78739 1.76159 1.76636 1.77234
-          1.76679 1.75639 1.74958 1.7531 1.75962 1.76261 1.76304 1.76251 2.48263 2.40526 2.27794 2.16452
-          2.08742 2.04048 2.01824 2.00498 1.99072 1.97588 1.97047 1.97997 1.98992 1.99312 1.99343 1.99278
-          2.51407 2.52122 2.48153 2.41111 2.34207 2.28411 2.23834 2.20558 2.18118 2.16111 2.15029 2.1515
-          2.15494 2.15515 2.15383 2.15234 2.52057 2.5554 2.56969 2.55829 2.53194 2.49793 2.45943 2.42442
-          2.39621 2.37341 2.35442 2.33973 2.33042 2.32449 2.31988 2.31677 2.52129 2.56089 2.59214 2.61312
-          2.6256 2.62815 2.61908 2.6043 2.58925 2.57518 2.56046 2.54427 2.53032 2.52023 2.51276 2.50816
-          2.52126 2.56117 2.59479 2.62329 2.64923 2.67126 2.68737 2.69894 2.70788 2.71458 2.71691 2.71332
-          2.70763 2.70291 2.69919 2.69686 2.52119 2.56104 2.59478 2.62384 2.65108 2.67635 2.69959 2.72192
-          2.74377 2.76466 2.78269 2.79612 2.80658 2.81594 2.82425 2.83 2.52119 2.56104 2.59478 2.62384
-          2.65108 2.67635 2.69959 2.72192 2.74377 2.76466 2.78269 2.79612 2.80658 2.81594 2.82425 2.83
-          2.52126 2.56117 2.59479 2.62329 2.64923 2.67126 2.68737 2.69894 2.70788 2.71458 2.71691 2.71332
-          2.70763 2.70291 2.69919 2.69686 2.52129 2.56089 2.59214 2.61312 2.6256 2.62815 2.61908 2.6043
-          2.58925 2.57518 2.56046 2.54427 2.53032 2.52023 2.51276 2.50816 2.52057 2.5554 2.56969 2.55829
-          2.53194 2.49793 2.45943 2.42442 2.39621 2.37341 2.35442 2.33973 2.33042 2.32449 2.31988 2.31677
-          2.51407 2.52122 2.48153 2.41111 2.34207 2.28411 2.23834 2.20558 2.18118 2.16111 2.15029 2.1515
-          2.15494 2.15515 2.15383 2.15234 2.48263 2.40526 2.27794 2.16452 2.08742 2.04048 2.01824 2.00498
-          1.99072 1.97588 1.97047 1.97997 1.98992 1.99312 1.99343 1.99278 2.38628 2.14543 1.94733 1.84353
-          1.78739 1.76159 1.76636 1.77234 1.76679 1.75639 1.74958 1.7531 1.75962 1.76261 1.76304 1.76251
-          2.07761 1.47958 1.28367 1.25467 1.2256 1.19748 1.1905 1.18952 1.1839 1.17538 1.16979 1.17192
-          1.17724 1.18028 1.18099 1.18075
-        </DataArray>
-        <DataArray type="Float32" Name="dv_x/dx [m/s]" NumberOfComponents="1" format="ascii">
-          -0.95686 -0.635157 -0.179922 -0.0464533 -0.0457548 -0.0280812 -0.00636892 -0.00527861 -0.0113137 -0.0112903 -0.0027612 0.0059661
-          0.00668688 0.00299378 0.00037709 -0.000371439 -0.385348 -0.35116 -0.241522 -0.127953 -0.0655552 -0.0168229 0.00859883 0.000348277
-          -0.0127609 -0.0137686 -0.00262868 0.00803264 0.00760658 0.00273242 -7.92547e-05 -0.00084692 -0.123792 -0.163751 -0.192587 -0.152414
-          -0.0992347 -0.0553436 -0.0283987 -0.0220144 -0.0232791 -0.0162027 0.00326662 0.0155584 0.0105211 0.00280934 -0.000268182 -0.00103498
-          0.0114385 -0.0260362 -0.0880861 -0.111566 -0.101605 -0.0829837 -0.0628222 -0.0457291 -0.0355761 -0.024713 -0.00768423 0.00372169
-          0.00291362 -0.000891487 -0.00224355 -0.00237188 0.0557332 0.0392977 0.00230937 -0.0301996 -0.0482888 -0.0580147 -0.0588047 -0.0505745
-          -0.0408131 -0.0334319 -0.0269454 -0.0191991 -0.0121905 -0.00843178 -0.00617655 -0.00497851 0.0633478 0.056677 0.0417843 0.0267666
-          0.0120249 -0.00521208 -0.0190776 -0.0238655 -0.0232978 -0.0230369 -0.0247241 -0.0241065 -0.0192386 -0.0140473 -0.00964972 -0.00736024
-          0.0638551 0.0588229 0.0496947 0.0435467 0.038378 0.0305152 0.0221386 0.0164115 0.0125123 0.00721903 -0.00100371 -0.00742319
-          -0.0083278 -0.00675228 -0.00484026 -0.00372104 0.0637564 0.0588739 0.0502416 0.0450384 0.0420084 0.038806 0.0364566 0.0353462
-          0.0341902 0.0311362 0.0251649 0.0191133 0.0158566 0.0141348 0.0112495 0.00919434 0.0637564 0.0588739 0.0502416 0.0450384
-          0.0420084 0.038806 0.0364566 0.0353462 0.0341902 0.0311362 0.0251649 0.0191133 0.0158566 0.0141348 0.0112495 0.00919434
-          0.0638551 0.0588229 0.0496947 0.0435467 0.038378 0.0305152 0.0221386 0.0164115 0.0125123 0.00721903 -0.00100371 -0.00742319
-          -0.0083278 -0.00675228 -0.00484026 -0.00372104 0.0633478 0.056677 0.0417843 0.0267666 0.0120249 -0.00521208 -0.0190776 -0.0238655
-          -0.0232978 -0.0230369 -0.0247241 -0.0241065 -0.0192386 -0.0140473 -0.00964972 -0.00736024 0.0557332 0.0392977 0.00230937 -0.0301996
-          -0.0482888 -0.0580147 -0.0588047 -0.0505745 -0.0408131 -0.0334319 -0.0269454 -0.0191991 -0.0121905 -0.00843178 -0.00617655 -0.00497851
-          0.0114385 -0.0260362 -0.0880861 -0.111566 -0.101605 -0.0829837 -0.0628222 -0.0457291 -0.0355761 -0.024713 -0.00768423 0.00372169
-          0.00291362 -0.000891487 -0.00224355 -0.00237188 -0.123792 -0.163751 -0.192587 -0.152414 -0.0992347 -0.0553436 -0.0283987 -0.0220144
-          -0.0232791 -0.0162027 0.00326662 0.0155584 0.0105211 0.00280934 -0.000268182 -0.00103498 -0.385348 -0.35116 -0.241522 -0.127953
-          -0.0655552 -0.0168229 0.00859883 0.000348277 -0.0127609 -0.0137686 -0.00262868 0.00803264 0.00760658 0.00273242 -7.92547e-05 -0.00084692
-          -0.95686 -0.635157 -0.179922 -0.0464533 -0.0457548 -0.0280812 -0.00636892 -0.00527861 -0.0113137 -0.0112903 -0.0027612 0.0059661
-          0.00668688 0.00299378 0.00037709 -0.000371439
-        </DataArray>
-        <DataArray type="Float32" Name="dv_x/dy [m/s]" NumberOfComponents="1" format="ascii">
-          71.6647 154.597 154.087 136.72 130.434 130.973 133.701 135.317 135.334 134.897 134.615 134.935
-          135.215 135.202 135.139 135.07 39.1814 89.551 96.1864 88.0195 83.3731 81.5524 80.0763 78.8884
-          78.0526 77.4415 77.4585 78.1704 78.6185 78.6341 78.5962 78.5561 8.83074 25.9671 36.9134 39.2201
-          38.3288 36.1063 32.6142 29.9373 28.6342 27.9666 27.6889 27.53 27.3165 27.1246 27.0035 26.9377
-          1.87278 7.41083 14.4002 19.4353 21.9405 22.5785 21.7757 20.7025 20.0136 19.6207 18.9506 17.7568
-          16.8062 16.3555 16.1127 15.991 0.254612 1.39841 3.89971 7.12168 9.99591 12.1292 13.4232 14.057
-          14.3867 14.5981 14.4606 13.8472 13.2342 12.8709 12.6545 12.5446 0.0174282 0.145258 0.632041 1.63685
-          2.95342 4.36494 5.74016 6.91287 7.84874 8.59144 9.12835 9.40803 9.49903 9.52962 9.5519 9.57169
-          -0.00186854 0.00272496 0.0475259 0.19288 0.458353 0.867036 1.44807 2.11568 2.7794 3.40825 3.99744 4.52997
-          4.9692 5.31906 5.60285 5.78896 -0.00103646 -0.0019143 -0.000129744 0.00781458 0.0264059 0.0723988 0.173897 0.327112
-          0.51074 0.712754 0.93622 1.17829 1.4083 1.60852 1.77987 1.89475 0.00103646 0.0019143 0.000129744 -0.00781458
-          -0.0264059 -0.0723988 -0.173897 -0.327112 -0.51074 -0.712754 -0.93622 -1.17829 -1.4083 -1.60852 -1.77987 -1.89475
-          0.00186854 -0.00272496 -0.0475259 -0.19288 -0.458353 -0.867036 -1.44807 -2.11568 -2.7794 -3.40825 -3.99744 -4.52997
-          -4.9692 -5.31906 -5.60285 -5.78896 -0.0174282 -0.145258 -0.632041 -1.63685 -2.95342 -4.36494 -5.74016 -6.91287
-          -7.84874 -8.59144 -9.12835 -9.40803 -9.49903 -9.52962 -9.5519 -9.57169 -0.254612 -1.39841 -3.89971 -7.12168
-          -9.99591 -12.1292 -13.4232 -14.057 -14.3867 -14.5981 -14.4606 -13.8472 -13.2342 -12.8709 -12.6545 -12.5446
-          -1.87278 -7.41083 -14.4002 -19.4353 -21.9405 -22.5785 -21.7757 -20.7025 -20.0136 -19.6207 -18.9506 -17.7568
-          -16.8062 -16.3555 -16.1127 -15.991 -8.83074 -25.9671 -36.9134 -39.2201 -38.3288 -36.1063 -32.6142 -29.9373
-          -28.6342 -27.9666 -27.6889 -27.53 -27.3165 -27.1246 -27.0035 -26.9377 -39.1814 -89.551 -96.1864 -88.0195
-          -83.3731 -81.5524 -80.0763 -78.8884 -78.0526 -77.4415 -77.4585 -78.1704 -78.6185 -78.6341 -78.5962 -78.5561
-          -71.6647 -154.597 -154.087 -136.72 -130.434 -130.973 -133.701 -135.317 -135.334 -134.897 -134.615 -134.935
-          -135.215 -135.202 -135.139 -135.07
-        </DataArray>
-        <DataArray type="Float32" Name="p [Pa]" NumberOfComponents="1" format="ascii">
+      <CellData Scalars="p" Vectors="velocity_Air (m/s)">
+        <DataArray type="Float32" Name="p" NumberOfComponents="1" format="ascii">
           100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000 100001 100001 100001 100001 100001 100001 100001 100001
           100001 100000 100000 100000 100000 100000 100000 100000 100001 100001 100001 100001
@@ -99,7 +27,7 @@
           100001 100001 100001 100001 100001 100001 100001 100001 100001 100000 100000 100000
           100000 100000 100000 100000
         </DataArray>
-        <DataArray type="Float32" Name="p_rel [Pa]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="p_rel" NumberOfComponents="1" format="ascii">
           1.30543 1.17114 1.0534 0.957444 0.867397 0.780484 0.700841 0.624126 0.545742 0.467086 0.389893 0.318209
           0.249301 0.178674 0.107209 0.0356539 1.30533 1.17127 1.05352 0.957484 0.867414 0.780489 0.700836 0.624126
           0.545745 0.467091 0.389894 0.318207 0.249299 0.178673 0.107209 0.0356541 1.30511 1.17134 1.05363 0.957553
@@ -123,7 +51,7 @@
           1.30543 1.17114 1.0534 0.957444 0.867397 0.780484 0.700841 0.624126 0.545742 0.467086 0.389893 0.318209
           0.249301 0.178674 0.107209 0.0356539
         </DataArray>
-        <DataArray type="Float32" Name="rho [kg/m^3]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="rho" NumberOfComponents="1" format="ascii">
           1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
           1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013
           1.23013 1.23013 1.23012 1.23012 1.23012 1.23012 1.23012 1.23012 1.23014 1.23013 1.23013 1.23013
@@ -147,7 +75,7 @@
           1.23014 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23013 1.23012 1.23012
           1.23012 1.23012 1.23012 1.23012
         </DataArray>
-        <DataArray type="Float32" Name="nu [m^2/s]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="nu" NumberOfComponents="1" format="ascii">
           1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
           1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05
           1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05
@@ -171,7 +99,7 @@
           1.43726e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43727e-05 1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
           1.43728e-05 1.43728e-05 1.43728e-05 1.43728e-05
         </DataArray>
-        <DataArray type="Float32" Name="nu_t [m^2/s]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="nu_t" NumberOfComponents="1" format="ascii">
           7.91604e-07 3.43486e-06 3.41343e-06 2.72149e-06 2.48886e-06 2.50844e-06 2.60859e-06 2.66875e-06 2.66939e-06 2.65304e-06 2.64253e-06 2.65448e-06
           2.66491e-06 2.66445e-06 2.66207e-06 2.65949e-06 1.59309e-05 4.79202e-05 0.000114341 0.000146157 0.000134052 0.000131497 0.000130955 0.000130076
           0.000128709 0.00012742 0.000127266 0.000128644 0.000129564 0.000129581 0.000129477 0.000129366 1.28196e-05 3.85614e-05 0.000113892 0.000201837
@@ -195,7 +123,7 @@
           7.91604e-07 3.43486e-06 3.41343e-06 2.72149e-06 2.48886e-06 2.50844e-06 2.60859e-06 2.66875e-06 2.66939e-06 2.65304e-06 2.64253e-06 2.65448e-06
           2.66491e-06 2.66445e-06 2.66207e-06 2.65949e-06
         </DataArray>
-        <DataArray type="Float32" Name="l_w [m]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="l_w" NumberOfComponents="1" format="ascii">
           0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461
           0.00179461 0.00179461 0.00179461 0.00179461 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166
           0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.00610166 0.0121315 0.0121315 0.0121315 0.0121315
@@ -219,7 +147,7 @@
           0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461 0.00179461
           0.00179461 0.00179461 0.00179461 0.00179461
         </DataArray>
-        <DataArray type="Float32" Name="y^+ [-]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="y^+" NumberOfComponents="1" format="ascii">
           4.00731 5.88574 5.87602 5.53497 5.40624 5.4174 5.47353 5.5065 5.50685 5.49794 5.49219 5.49872
           5.50441 5.50415 5.50286 5.50145 13.6249 20.0115 19.9785 18.8189 18.3812 18.4192 18.61 18.7221
           18.7233 18.693 18.6735 18.6957 18.715 18.7141 18.7097 18.7049 27.0894 39.7876 39.7219 37.4164
@@ -243,7 +171,7 @@
           4.00731 5.88574 5.87602 5.53497 5.40624 5.4174 5.47353 5.5065 5.50685 5.49794 5.49219 5.49872
           5.50441 5.50415 5.50286 5.50145
         </DataArray>
-        <DataArray type="Float32" Name="u^+ [-]" NumberOfComponents="1" format="ascii">
+        <DataArray type="Float32" Name="u^+" NumberOfComponents="1" format="ascii">
           64.7357 31.3883 27.2772 28.3039 28.3064 27.5999 27.1576 26.9727 26.8436 26.6935 26.5944 26.6113
           26.7045 26.7746 26.7969 26.7984 74.3532 45.5141 41.3797 41.5878 41.2813 40.6017 40.2941 40.1883
           40.0601 39.8886 39.7756 39.8082 39.915 39.9846 40.0037 40.0019 77.3554 51.0261 48.405 48.829
@@ -267,6 +195,138 @@
           64.7357 31.3883 27.2772 28.3039 28.3064 27.5999 27.1576 26.9727 26.8436 26.6935 26.5944 26.6113
           26.7045 26.7746 26.7969 26.7984
         </DataArray>
+        <DataArray type="Float32" Name="dv_x/dx_" NumberOfComponents="3" format="ascii">
+          -0.95686 71.6647 0 -0.635157 154.597 0 -0.179922 154.087 0 -0.0464533 136.72 0
+          -0.0457548 130.434 0 -0.0280812 130.973 0 -0.00636892 133.701 0 -0.00527861 135.317 0
+          -0.0113137 135.334 0 -0.0112903 134.897 0 -0.0027612 134.615 0 0.0059661 134.935 0
+          0.00668688 135.215 0 0.00299378 135.202 0 0.00037709 135.139 0 -0.000371439 135.07 0
+          -0.385348 39.1814 0 -0.35116 89.551 0 -0.241522 96.1864 0 -0.127953 88.0195 0
+          -0.0655552 83.3731 0 -0.0168229 81.5524 0 0.00859883 80.0763 0 0.000348277 78.8884 0
+          -0.0127609 78.0526 0 -0.0137686 77.4415 0 -0.00262868 77.4585 0 0.00803264 78.1704 0
+          0.00760658 78.6185 0 0.00273242 78.6341 0 -7.92547e-05 78.5962 0 -0.00084692 78.5561 0
+          -0.123792 8.83074 0 -0.163751 25.9671 0 -0.192587 36.9134 0 -0.152414 39.2201 0
+          -0.0992347 38.3288 0 -0.0553436 36.1063 0 -0.0283987 32.6142 0 -0.0220144 29.9373 0
+          -0.0232791 28.6342 0 -0.0162027 27.9666 0 0.00326662 27.6889 0 0.0155584 27.53 0
+          0.0105211 27.3165 0 0.00280934 27.1246 0 -0.000268182 27.0035 0 -0.00103498 26.9377 0
+          0.0114385 1.87278 0 -0.0260362 7.41083 0 -0.0880861 14.4002 0 -0.111566 19.4353 0
+          -0.101605 21.9405 0 -0.0829837 22.5785 0 -0.0628222 21.7757 0 -0.0457291 20.7025 0
+          -0.0355761 20.0136 0 -0.024713 19.6207 0 -0.00768423 18.9506 0 0.00372169 17.7568 0
+          0.00291362 16.8062 0 -0.000891487 16.3555 0 -0.00224355 16.1127 0 -0.00237188 15.991 0
+          0.0557332 0.254612 0 0.0392977 1.39841 0 0.00230937 3.89971 0 -0.0301996 7.12168 0
+          -0.0482888 9.99591 0 -0.0580147 12.1292 0 -0.0588047 13.4232 0 -0.0505745 14.057 0
+          -0.0408131 14.3867 0 -0.0334319 14.5981 0 -0.0269454 14.4606 0 -0.0191991 13.8472 0
+          -0.0121905 13.2342 0 -0.00843178 12.8709 0 -0.00617655 12.6545 0 -0.00497851 12.5446 0
+          0.0633478 0.0174282 0 0.056677 0.145258 0 0.0417843 0.632041 0 0.0267666 1.63685 0
+          0.0120249 2.95342 0 -0.00521208 4.36494 0 -0.0190776 5.74016 0 -0.0238655 6.91287 0
+          -0.0232978 7.84874 0 -0.0230369 8.59144 0 -0.0247241 9.12835 0 -0.0241065 9.40803 0
+          -0.0192386 9.49903 0 -0.0140473 9.52962 0 -0.00964972 9.5519 0 -0.00736024 9.57169 0
+          0.0638551 -0.00186854 0 0.0588229 0.00272496 0 0.0496947 0.0475259 0 0.0435467 0.19288 0
+          0.038378 0.458353 0 0.0305152 0.867036 0 0.0221386 1.44807 0 0.0164115 2.11568 0
+          0.0125123 2.7794 0 0.00721903 3.40825 0 -0.00100371 3.99744 0 -0.00742319 4.52997 0
+          -0.0083278 4.9692 0 -0.00675228 5.31906 0 -0.00484026 5.60285 0 -0.00372104 5.78896 0
+          0.0637564 -0.00103646 0 0.0588739 -0.0019143 0 0.0502416 -0.000129744 0 0.0450384 0.00781458 0
+          0.0420084 0.0264059 0 0.038806 0.0723988 0 0.0364566 0.173897 0 0.0353462 0.327112 0
+          0.0341902 0.51074 0 0.0311362 0.712754 0 0.0251649 0.93622 0 0.0191133 1.17829 0
+          0.0158566 1.4083 0 0.0141348 1.60852 0 0.0112495 1.77987 0 0.00919434 1.89475 0
+          0.0637564 0.00103646 0 0.0588739 0.0019143 0 0.0502416 0.000129744 0 0.0450384 -0.00781458 0
+          0.0420084 -0.0264059 0 0.038806 -0.0723988 0 0.0364566 -0.173897 0 0.0353462 -0.327112 0
+          0.0341902 -0.51074 0 0.0311362 -0.712754 0 0.0251649 -0.93622 0 0.0191133 -1.17829 0
+          0.0158566 -1.4083 0 0.0141348 -1.60852 0 0.0112495 -1.77987 0 0.00919434 -1.89475 0
+          0.0638551 0.00186854 0 0.0588229 -0.00272496 0 0.0496947 -0.0475259 0 0.0435467 -0.19288 0
+          0.038378 -0.458353 0 0.0305152 -0.867036 0 0.0221386 -1.44807 0 0.0164115 -2.11568 0
+          0.0125123 -2.7794 0 0.00721903 -3.40825 0 -0.00100371 -3.99744 0 -0.00742319 -4.52997 0
+          -0.0083278 -4.9692 0 -0.00675228 -5.31906 0 -0.00484026 -5.60285 0 -0.00372104 -5.78896 0
+          0.0633478 -0.0174282 0 0.056677 -0.145258 0 0.0417843 -0.632041 0 0.0267666 -1.63685 0
+          0.0120249 -2.95342 0 -0.00521208 -4.36494 0 -0.0190776 -5.74016 0 -0.0238655 -6.91287 0
+          -0.0232978 -7.84874 0 -0.0230369 -8.59144 0 -0.0247241 -9.12835 0 -0.0241065 -9.40803 0
+          -0.0192386 -9.49903 0 -0.0140473 -9.52962 0 -0.00964972 -9.5519 0 -0.00736024 -9.57169 0
+          0.0557332 -0.254612 0 0.0392977 -1.39841 0 0.00230937 -3.89971 0 -0.0301996 -7.12168 0
+          -0.0482888 -9.99591 0 -0.0580147 -12.1292 0 -0.0588047 -13.4232 0 -0.0505745 -14.057 0
+          -0.0408131 -14.3867 0 -0.0334319 -14.5981 0 -0.0269454 -14.4606 0 -0.0191991 -13.8472 0
+          -0.0121905 -13.2342 0 -0.00843178 -12.8709 0 -0.00617655 -12.6545 0 -0.00497851 -12.5446 0
+          0.0114385 -1.87278 0 -0.0260362 -7.41083 0 -0.0880861 -14.4002 0 -0.111566 -19.4353 0
+          -0.101605 -21.9405 0 -0.0829837 -22.5785 0 -0.0628222 -21.7757 0 -0.0457291 -20.7025 0
+          -0.0355761 -20.0136 0 -0.024713 -19.6207 0 -0.00768423 -18.9506 0 0.00372169 -17.7568 0
+          0.00291362 -16.8062 0 -0.000891487 -16.3555 0 -0.00224355 -16.1127 0 -0.00237188 -15.991 0
+          -0.123792 -8.83074 0 -0.163751 -25.9671 0 -0.192587 -36.9134 0 -0.152414 -39.2201 0
+          -0.0992347 -38.3288 0 -0.0553436 -36.1063 0 -0.0283987 -32.6142 0 -0.0220144 -29.9373 0
+          -0.0232791 -28.6342 0 -0.0162027 -27.9666 0 0.00326662 -27.6889 0 0.0155584 -27.53 0
+          0.0105211 -27.3165 0 0.00280934 -27.1246 0 -0.000268182 -27.0035 0 -0.00103498 -26.9377 0
+          -0.385348 -39.1814 0 -0.35116 -89.551 0 -0.241522 -96.1864 0 -0.127953 -88.0195 0
+          -0.0655552 -83.3731 0 -0.0168229 -81.5524 0 0.00859883 -80.0763 0 0.000348277 -78.8884 0
+          -0.0127609 -78.0526 0 -0.0137686 -77.4415 0 -0.00262868 -77.4585 0 0.00803264 -78.1704 0
+          0.00760658 -78.6185 0 0.00273242 -78.6341 0 -7.92547e-05 -78.5962 0 -0.00084692 -78.5561 0
+          -0.95686 -71.6647 0 -0.635157 -154.597 0 -0.179922 -154.087 0 -0.0464533 -136.72 0
+          -0.0457548 -130.434 0 -0.0280812 -130.973 0 -0.00636892 -133.701 0 -0.00527861 -135.317 0
+          -0.0113137 -135.334 0 -0.0112903 -134.897 0 -0.0027612 -134.615 0 0.0059661 -134.935 0
+          0.00668688 -135.215 0 0.00299378 -135.202 0 0.00037709 -135.139 0 -0.000371439 -135.07 0
+        </DataArray>
+        <DataArray type="Float32" Name="dv_y/dx_" NumberOfComponents="3" format="ascii">
+          -0.0022671 0.775467 0 -0.00184745 0.471494 0 -0.000766845 0.159525 0 3.66296e-07 0.0728904 0
+          -4.37907e-06 0.0706851 0 -9.71167e-05 0.0149689 0 -2.7572e-05 -0.0145588 0 2.13103e-05 0.00470758 0
+          1.33476e-05 0.0131363 0 -1.34816e-05 0.017659 0 -3.54994e-05 0.00249735 0 -1.46196e-05 -0.0119107 0
+          1.04802e-05 -0.00735523 0 1.07284e-05 -0.0022655 0 4.29864e-06 0.000527793 0 1.0855e-06 0.000773293 0
+          -0.00436187 0.430479 0 -0.00396977 0.36066 0 -0.00214029 0.194989 0 -0.000305743 0.10608 0
+          -0.000203956 0.0813726 0 -0.000390837 0.0254976 0 -6.29287e-05 -0.00481706 0 0.000116738 0.0105023 0
+          5.79734e-05 0.0167737 0 -5.01397e-05 0.020314 0 -0.000137386 -0.00072646 0 -4.85681e-05 -0.01627 0
+          4.37142e-05 -0.00766426 0 3.78905e-05 -0.00214828 0 1.47692e-05 0.000752769 0 2.77732e-06 0.000907942 0
+          -0.00342184 0.0748794 0 -0.00379484 0.171496 0 -0.00287211 0.179848 0 -0.00093919 0.130918 0
+          -0.000670759 0.0954006 0 -0.000809866 0.0550691 0 -0.000151576 0.0267178 0 0.000199856 0.0262622 0
+          9.44853e-05 0.0255742 0 -0.0001582 0.025149 0 -0.000338032 -0.00115837 0 -7.19921e-05 -0.0168897 0
+          0.000127261 -0.00594911 0 8.03335e-05 -0.000908849 0 2.95722e-05 0.00162915 0 3.65192e-06 0.00128994 0
+          -0.00212474 -0.0346393 0 -0.00275451 0.0285776 0 -0.00261008 0.0883533 0 -0.00128342 0.0966105 0
+          -0.00108209 0.0823237 0 -0.001186 0.0709599 0 -0.000396437 0.054524 0 0.000103498 0.0419193 0
+          4.50857e-05 0.0346916 0 -0.000359633 0.0296016 0 -0.000624084 0.0109256 0 -0.000104032 -0.0020934 0
+          0.000228731 0.00136235 0 0.000125627 0.00299948 0 4.02255e-05 0.00390764 0 -5.07688e-06 0.00215087 0
+          -0.00137256 -0.0630051 0 -0.00180134 -0.038258 0 -0.00176941 0.00406146 0 -0.00103692 0.0299613 0
+          -0.00108651 0.035798 0 -0.00126045 0.0465438 0 -0.000622275 0.0486563 0 -0.000121594 0.0400922 0
+          -0.000105163 0.0337507 0 -0.000543406 0.0281939 0 -0.000851756 0.0233976 0 -0.000226996 0.0164049 0
+          0.000209808 0.0113622 0 0.000121588 0.0087477 0 1.58176e-05 0.00728715 0 -5.32968e-05 0.00339108 0
+          -0.00100163 -0.0677067 0 -0.00123266 -0.0566849 0 -0.00106207 -0.0364678 0 -0.000563268 -0.0208514 0
+          -0.000705803 -0.0121588 0 -0.000894228 0.00309965 0 -0.000542833 0.0148619 0 -0.000234735 0.014989 0
+          -0.000224906 0.0143614 0 -0.000594561 0.012914 0 -0.000891597 0.0180081 0 -0.000377135 0.0192352 0
+          5.49769e-05 0.0138436 0 3.31568e-05 0.0102984 0 -8.1325e-05 0.00793135 0 -0.000181893 0.00349129 0
+          -0.000672271 -0.0679808 0 -0.000808938 -0.0594808 0 -0.000631045 -0.0469129 0 -0.000264663 -0.0407043 0
+          -0.000325626 -0.0362262 0 -0.000402052 -0.0269805 0 -0.000244569 -0.0183331 0 -0.000137491 -0.01576 0
+          -0.000171082 -0.0135818 0 -0.000427557 -0.0117501 0 -0.000650944 -0.00332341 0 -0.000359298 0.00327909 0
+          -7.40989e-05 0.00193709 0 -6.62323e-05 0.000829451 0 -0.000200432 6.1613e-05 0 -0.000335403 -0.000139357 0
+          -0.000245538 -0.0678546 0 -0.000295645 -0.0596908 0 -0.000226974 -0.0482044 0 -8.79731e-05 -0.0444269 0
+          -9.54296e-05 -0.0419311 0 -9.84197e-05 -0.0369365 0 -4.3793e-05 -0.0330278 0 -2.34197e-05 -0.0318066 0
+          -4.65655e-05 -0.0301653 0 -0.000138312 -0.0279347 0 -0.000223164 -0.0200986 0 -0.000143171 -0.0123845 0
+          -5.39722e-05 -0.0111599 0 -5.02563e-05 -0.0101062 0 -0.000124413 -0.00908756 0 -0.00019977 -0.00432727 0
+          0.000245538 -0.0678546 0 0.000295645 -0.0596908 0 0.000226974 -0.0482044 0 8.79731e-05 -0.0444269 0
+          9.54296e-05 -0.0419311 0 9.84197e-05 -0.0369365 0 4.3793e-05 -0.0330278 0 2.34197e-05 -0.0318066 0
+          4.65655e-05 -0.0301653 0 0.000138312 -0.0279347 0 0.000223164 -0.0200986 0 0.000143171 -0.0123845 0
+          5.39722e-05 -0.0111599 0 5.02563e-05 -0.0101062 0 0.000124413 -0.00908756 0 0.00019977 -0.00432727 0
+          0.000672271 -0.0679808 0 0.000808938 -0.0594808 0 0.000631045 -0.0469129 0 0.000264663 -0.0407043 0
+          0.000325626 -0.0362262 0 0.000402052 -0.0269805 0 0.000244569 -0.0183331 0 0.000137491 -0.01576 0
+          0.000171082 -0.0135818 0 0.000427557 -0.0117501 0 0.000650944 -0.00332341 0 0.000359298 0.00327909 0
+          7.40989e-05 0.00193709 0 6.62323e-05 0.000829451 0 0.000200432 6.1613e-05 0 0.000335403 -0.000139357 0
+          0.00100163 -0.0677067 0 0.00123266 -0.0566849 0 0.00106207 -0.0364678 0 0.000563268 -0.0208514 0
+          0.000705803 -0.0121588 0 0.000894228 0.00309965 0 0.000542833 0.0148619 0 0.000234735 0.014989 0
+          0.000224906 0.0143614 0 0.000594561 0.012914 0 0.000891597 0.0180081 0 0.000377135 0.0192352 0
+          -5.49769e-05 0.0138436 0 -3.31568e-05 0.0102984 0 8.1325e-05 0.00793135 0 0.000181893 0.00349129 0
+          0.00137256 -0.0630051 0 0.00180134 -0.038258 0 0.00176941 0.00406146 0 0.00103692 0.0299613 0
+          0.00108651 0.035798 0 0.00126045 0.0465438 0 0.000622275 0.0486563 0 0.000121594 0.0400922 0
+          0.000105163 0.0337507 0 0.000543406 0.0281939 0 0.000851756 0.0233976 0 0.000226996 0.0164049 0
+          -0.000209808 0.0113622 0 -0.000121588 0.0087477 0 -1.58176e-05 0.00728715 0 5.32968e-05 0.00339108 0
+          0.00212474 -0.0346393 0 0.00275451 0.0285776 0 0.00261008 0.0883533 0 0.00128342 0.0966105 0
+          0.00108209 0.0823237 0 0.001186 0.0709599 0 0.000396437 0.054524 0 -0.000103498 0.0419193 0
+          -4.50857e-05 0.0346916 0 0.000359633 0.0296016 0 0.000624084 0.0109256 0 0.000104032 -0.0020934 0
+          -0.000228731 0.00136235 0 -0.000125627 0.00299948 0 -4.02255e-05 0.00390764 0 5.07688e-06 0.00215087 0
+          0.00342184 0.0748794 0 0.00379484 0.171496 0 0.00287211 0.179848 0 0.00093919 0.130918 0
+          0.000670759 0.0954006 0 0.000809866 0.0550691 0 0.000151576 0.0267178 0 -0.000199856 0.0262622 0
+          -9.44853e-05 0.0255742 0 0.0001582 0.025149 0 0.000338032 -0.00115837 0 7.19921e-05 -0.0168897 0
+          -0.000127261 -0.00594911 0 -8.03335e-05 -0.000908849 0 -2.95722e-05 0.00162915 0 -3.65192e-06 0.00128994 0
+          0.00436187 0.430479 0 0.00396977 0.36066 0 0.00214029 0.194989 0 0.000305743 0.10608 0
+          0.000203956 0.0813726 0 0.000390837 0.0254976 0 6.29287e-05 -0.00481706 0 -0.000116738 0.0105023 0
+          -5.79734e-05 0.0167737 0 5.01397e-05 0.020314 0 0.000137386 -0.00072646 0 4.85681e-05 -0.01627 0
+          -4.37142e-05 -0.00766426 0 -3.78905e-05 -0.00214828 0 -1.47692e-05 0.000752769 0 -2.77732e-06 0.000907942 0
+          0.0022671 0.775467 0 0.00184745 0.471494 0 0.000766845 0.159525 0 -3.66296e-07 0.0728904 0
+          4.37907e-06 0.0706851 0 9.71167e-05 0.0149689 0 2.7572e-05 -0.0145588 0 -2.13103e-05 0.00470758 0
+          -1.33476e-05 0.0131363 0 1.34816e-05 0.017659 0 3.54994e-05 0.00249735 0 1.46196e-05 -0.0119107 0
+          -1.04802e-05 -0.00735523 0 -1.07284e-05 -0.0022655 0 -4.29864e-06 0.000527793 0 -1.0855e-06 0.000773293 0
+        </DataArray>
         <DataArray type="Float32" Name="velocity_Air (m/s)" NumberOfComponents="3" format="ascii">
           2.07761 0.00242566 0 1.47957 0.00100872 0 1.28367 0.000116336 0 1.25468 5.01453e-05 0
           1.22561 0.000116787 0 1.1975 4.46784e-05 0 1.19052 -4.59293e-06 0 1.18953 1.02362e-05 0