diff --git a/MaterialLib/MPL/VariableType.h b/MaterialLib/MPL/VariableType.h
index 9489f61c46c156f374d3ea8ec60a71a6d8850b80..ce4599002594f078c3168342ceeb2b138d90356b 100644
--- a/MaterialLib/MPL/VariableType.h
+++ b/MaterialLib/MPL/VariableType.h
@@ -61,8 +61,9 @@ enum class Variable : int
 
 /// Data type for primary variables, designed to contain both scalar and vector
 /// data.
-using VariableType = std::variant<double, Vector, Eigen::Matrix<double, 4, 1>,
-                                  Eigen::Matrix<double, 6, 1>>;
+using VariableType =
+    std::variant<std::monostate, double, Vector, Eigen::Matrix<double, 4, 1>,
+                 Eigen::Matrix<double, 6, 1>>;
 
 /// The VariableArray is a std::array of fixed size. Its size is determined by
 /// the Variable enumerator list. Data type of that array is defined by the
diff --git a/ProcessLib/ComponentTransport/ComponentTransportFEM.h b/ProcessLib/ComponentTransport/ComponentTransportFEM.h
index 35f87091e1894dffe6f9eb9a1a88097ee9ad9c17..0e64d8fda203840b9a2798fab0aaa14c689c4e00 100644
--- a/ProcessLib/ComponentTransport/ComponentTransportFEM.h
+++ b/ProcessLib/ComponentTransport/ComponentTransportFEM.h
@@ -855,14 +855,15 @@ public:
         auto const& phase = medium.phase("AqueousLiquid");
 
         // local_x contains the local concentration and pressure values
-        NumLib::shapeFunctionInterpolate(
-            local_C, shape_matrices.N,
-            std::get<double>(vars[static_cast<int>(
-                MaterialPropertyLib::Variable::concentration)]));
-        NumLib::shapeFunctionInterpolate(
-            local_p, shape_matrices.N,
-            std::get<double>(vars[static_cast<int>(
-                MaterialPropertyLib::Variable::phase_pressure)]));
+        double c_int_pt;
+        NumLib::shapeFunctionInterpolate(local_C, shape_matrices.N, c_int_pt);
+        vars[static_cast<int>(MaterialPropertyLib::Variable::concentration)]
+            .emplace<double>(c_int_pt);
+
+        double p_int_pt;
+        NumLib::shapeFunctionInterpolate(local_p, shape_matrices.N, p_int_pt);
+        vars[static_cast<int>(MaterialPropertyLib::Variable::phase_pressure)]
+            .emplace<double>(p_int_pt);
 
         // TODO (naumov) Temporary value not used by current material models.
         // Need extension of secondary variables interface.
diff --git a/ProcessLib/Output/ProcessOutput.cpp b/ProcessLib/Output/ProcessOutput.cpp
index ba04136d8ddc25384dddcd5b45913f5b3fe7ab08..4df937cbaeb884c78ecfd78af18af11b0806352d 100644
--- a/ProcessLib/Output/ProcessOutput.cpp
+++ b/ProcessLib/Output/ProcessOutput.cpp
@@ -10,14 +10,18 @@
 
 #include "ProcessOutput.h"
 
+#ifndef _WIN32
+#ifndef __APPLE__
+#include <cfenv>
+#endif  // __APPLE__
+#endif  // _WIN32
+
 #include "InfoLib/GitInfo.h"
+#include "IntegrationPointWriter.h"
 #include "MathLib/LinAlg/LinAlg.h"
 #include "MeshLib/IO/VtkIO/VtuInterface.h"
 #include "NumLib/DOF/LocalToGlobalIndexMap.h"
 
-#include "IntegrationPointWriter.h"
-
-
 /// Copies the ogs_version string containing the release number and the git
 /// hash.
 static void addOgsVersion(MeshLib::Mesh& mesh)
@@ -253,8 +257,29 @@ void makeOutput(std::string const& file_name, MeshLib::Mesh const& mesh,
 {
     // Write output file
     DBUG("Writing output to '{:s}'.", file_name);
+
+    // Store floating-point exception handling. Output of NaN's triggers
+    // floating point exceptions. Because we are not debugging VTK (or other
+    // libraries) at this point, the possibly set exceptions are temporary
+    // disabled and restored before end of the function.
+#ifndef _WIN32
+#ifndef __APPLE__
+    fenv_t fe_env;
+    fegetenv(&fe_env);
+    fesetenv(FE_DFL_ENV);  // Set default environment effectively disabling
+                           // exceptions.
+#endif  //_WIN32
+#endif  //__APPLE__
+
     MeshLib::IO::VtuInterface vtu_interface(&mesh, data_mode, compress_output);
     vtu_interface.writeToFile(file_name);
+
+    // Restore floating-point exception handling.
+#ifndef _WIN32
+#ifndef __APPLE__
+    fesetenv(&fe_env);
+#endif  //_WIN32
+#endif  //__APPLE__
 }
 
 }  // namespace ProcessLib
diff --git a/ProcessLib/RichardsMechanics/RichardsMechanicsFEM-impl.h b/ProcessLib/RichardsMechanics/RichardsMechanicsFEM-impl.h
index 56080a2cec8626a71cf75e63f9671287fe7003d5..11f2ec9e5d7c1a109b026b1a74432487c23bf1d2 100644
--- a/ProcessLib/RichardsMechanics/RichardsMechanicsFEM-impl.h
+++ b/ProcessLib/RichardsMechanics/RichardsMechanicsFEM-impl.h
@@ -305,11 +305,7 @@ void RichardsMechanicsLocalAssembler<
                 dNdx_u, N_u, x_coord, _is_axially_symmetric);
 
         auto& eps = _ip_data[ip].eps;
-        variables[static_cast<int>(MPL::Variable::volumetric_strain_rate)]
-            .emplace<double>(identity2.transpose() * B * u_dot);
 
-        auto& sigma_sw = _ip_data[ip].sigma_sw;
-        auto const& sigma_sw_prev = _ip_data[ip].sigma_sw_prev;
         auto& S_L = _ip_data[ip].saturation;
         auto const S_L_prev = _ip_data[ip].saturation_prev;
 
@@ -374,19 +370,79 @@ void RichardsMechanicsLocalAssembler<
              chi_S_L_prev * (-p_cap_ip + p_cap_dot_ip * dt)) /
             dt;
 
-        // Use previous time step porosity for porosity update, ...
-        variables[static_cast<int>(MPL::Variable::porosity)] =
-            _ip_data[ip].porosity_prev;
+        // Set volumetric strain rate for the general case without swelling.
+        double const div_u_dot = identity2.transpose() * B * u_dot;
+        variables[static_cast<int>(MPL::Variable::volumetric_strain_rate)]
+            .emplace<double>(div_u_dot);
+
         auto& porosity = _ip_data[ip].porosity;
-        porosity = solid_phase.property(MPL::PropertyType::porosity)
-                       .template value<double>(variables, x_position, t, dt);
-        // ... then use new porosity.
-        variables[static_cast<int>(MPL::Variable::porosity)] = porosity;
+        {  // Porosity update
+
+            // Use previous time step porosity for porosity update, ...
+            variables[static_cast<int>(MPL::Variable::porosity)] =
+                _ip_data[ip].porosity_prev;
+            porosity =
+                solid_phase.property(MPL::PropertyType::porosity)
+                    .template value<double>(variables, x_position, t, dt);
+            // ... then use new porosity.
+            variables[static_cast<int>(MPL::Variable::porosity)] = porosity;
+        }
+
+        // Swelling and possibly volumetric strain rate update.
+        auto& sigma_sw = _ip_data[ip].sigma_sw;
+        {
+            auto const& sigma_sw_prev = _ip_data[ip].sigma_sw_prev;
+
+            // If there is swelling, compute it. Update volumetric strain rate,
+            // s.t. it corresponds to the mechanical part only.
+            sigma_sw = sigma_sw_prev;
+            if (solid_phase.hasProperty(
+                    MPL::PropertyType::swelling_stress_rate))
+            {
+                using DimMatrix = Eigen::Matrix<double, 3, 3>;
+                auto const sigma_sw_dot =
+                    MathLib::KelvinVector::tensorToKelvin<DisplacementDim>(
+                        solid_phase
+                            .property(MPL::PropertyType::swelling_stress_rate)
+                            .template value<DimMatrix>(variables, x_position, t,
+                                                       dt));
+                sigma_sw += sigma_sw_dot * dt;
+
+                auto const C_el = _ip_data[ip].computeElasticTangentStiffness(
+                    t, x_position, dt, temperature);
+
+                variables[static_cast<int>(
+                              MPL::Variable::volumetric_strain_rate)]
+                    .emplace<double>(div_u_dot + identity2.transpose() *
+                                                     C_el.inverse() *
+                                                     sigma_sw_dot);
+            }
+
+            if (solid_phase.hasProperty(MPL::PropertyType::transport_porosity))
+            {
+                double& phi_tr = _ip_data[ip].transport_porosity;
+
+                // Use previous time step transport_porosity for
+                // transport_porosity update, ...
+                variables[static_cast<int>(MPL::Variable::transport_porosity)] =
+                    _ip_data[ip].transport_porosity_prev;
+                // ... then use new transport_porosity.
+                phi_tr =
+                    solid_phase.property(MPL::PropertyType::transport_porosity)
+                        .template value<double>(variables, x_position, t, dt);
+                variables[static_cast<int>(MPL::Variable::transport_porosity)] =
+                    phi_tr;
+            }
+            else
+            {
+                variables[static_cast<int>(MPL::Variable::transport_porosity)] =
+                    porosity;
+            }
+        }
 
         double const k_rel =
             medium->property(MPL::PropertyType::relative_permeability)
                 .template value<double>(variables, x_position, t, dt);
-
         auto const mu = liquid_phase.property(MPL::PropertyType::viscosity)
                             .template value<double>(variables, x_position, t, dt);
         auto const K_intrinsic = MPL::formEigenTensor<DisplacementDim>(
@@ -396,18 +452,6 @@ void RichardsMechanicsLocalAssembler<
         GlobalDimMatrixType const rho_K_over_mu =
             K_intrinsic * rho_LR * k_rel / mu;
 
-        sigma_sw = sigma_sw_prev;
-        if (solid_phase.hasProperty(MPL::PropertyType::swelling_stress_rate))
-        {
-            using DimMatrix = Eigen::Matrix<double, 3, 3>;
-            sigma_sw +=
-                MathLib::KelvinVector::tensorToKelvin<DisplacementDim>(
-                    solid_phase
-                        .property(MPL::PropertyType::swelling_stress_rate)
-                        .template value<DimMatrix>(variables, x_position, t,
-                                                   dt)) *
-                dt;
-        }
         //
         // displacement equation, displacement part
         //
@@ -1341,7 +1385,7 @@ void RichardsMechanicsLocalAssembler<ShapeFunctionDisplacement,
                                      DisplacementDim>::
     computeSecondaryVariableConcrete(double const t, double const dt,
                                      std::vector<double> const& local_x,
-                                     std::vector<double> const& /*local_x_dot*/)
+                                     std::vector<double> const& local_x_dot)
 {
     auto p_L =
         Eigen::Map<typename ShapeMatricesTypePressure::template VectorType<
@@ -1352,6 +1396,20 @@ void RichardsMechanicsLocalAssembler<ShapeFunctionDisplacement,
         Eigen::Map<typename ShapeMatricesTypeDisplacement::template VectorType<
             displacement_size> const>(local_x.data() + displacement_index,
                                       displacement_size);
+
+    auto p_L_dot =
+        Eigen::Map<typename ShapeMatricesTypePressure::template VectorType<
+            pressure_size> const>(local_x_dot.data() + pressure_index,
+                                  pressure_size);
+    auto u_dot =
+        Eigen::Map<typename ShapeMatricesTypeDisplacement::template VectorType<
+            displacement_size> const>(local_x_dot.data() + displacement_index,
+                                      displacement_size);
+
+    auto const& identity2 = MathLib::KelvinVector::Invariants<
+        MathLib::KelvinVector::KelvinVectorDimensions<DisplacementDim>::value>::
+        identity2;
+
     auto const& medium = _process_data.media_map->getMedium(_element.getID());
     auto const& liquid_phase = medium->phase("AqueousLiquid");
     auto const& solid_phase = medium->phase("Solid");
@@ -1389,6 +1447,10 @@ void RichardsMechanicsLocalAssembler<ShapeFunctionDisplacement,
 
         double p_cap_ip;
         NumLib::shapeFunctionInterpolate(-p_L, N_p, p_cap_ip);
+
+        double p_cap_dot_ip;
+        NumLib::shapeFunctionInterpolate(-p_L_dot, N_p, p_cap_dot_ip);
+
         variables[static_cast<int>(MPL::Variable::capillary_pressure)] =
             p_cap_ip;
         variables[static_cast<int>(MPL::Variable::phase_pressure)] = -p_cap_ip;
@@ -1396,15 +1458,38 @@ void RichardsMechanicsLocalAssembler<ShapeFunctionDisplacement,
         auto const temperature =
             medium->property(MPL::PropertyType::reference_temperature)
                 .template value<double>(variables, x_position, t, dt);
-
         variables[static_cast<int>(MPL::Variable::temperature)] = temperature;
+
         auto& eps = _ip_data[ip].eps;
         auto& S_L = _ip_data[ip].saturation;
+        auto const S_L_prev = _ip_data[ip].saturation_prev;
         S_L = medium->property(MPL::PropertyType::saturation)
                   .template value<double>(variables, x_position, t, dt);
+        variables[static_cast<int>(MPL::Variable::liquid_saturation)] = S_L;
+        variables[static_cast<int>(MPL::Variable::liquid_saturation_rate)] =
+            (S_L - S_L_prev) / dt;
+
+        auto const chi = [medium, x_position, t, dt](double const S_L) {
+            MPL::VariableArray variables;
+            variables.fill(std::numeric_limits<double>::quiet_NaN());
+            variables[static_cast<int>(MPL::Variable::liquid_saturation)] = S_L;
+            return medium->property(MPL::PropertyType::bishops_effective_stress)
+                .template value<double>(variables, x_position, t, dt);
+        };
+        double const chi_S_L = chi(S_L);
+        double const chi_S_L_prev = chi(S_L_prev);
+
+        variables[static_cast<int>(
+            MPL::Variable::effective_pore_pressure_rate)] =
+            (chi_S_L * (-p_cap_ip) -
+             chi_S_L_prev * (-p_cap_ip + p_cap_dot_ip * dt)) /
+            dt;
+
+        // Set volumetric strain rate for the general case without swelling.
+        double const div_u_dot = identity2.transpose() * B * u_dot;
+        variables[static_cast<int>(MPL::Variable::volumetric_strain_rate)]
+            .emplace<double>(div_u_dot);
 
-        variables[static_cast<int>(MPL::Variable::transport_porosity)] =
-            _ip_data[ip].transport_porosity;
         auto& porosity = _ip_data[ip].porosity;
         {  // Porosity update
 
@@ -1418,6 +1503,57 @@ void RichardsMechanicsLocalAssembler<ShapeFunctionDisplacement,
             variables[static_cast<int>(MPL::Variable::porosity)] = porosity;
         }
 
+        // Swelling and possibly volumetric strain rate update.
+        auto& sigma_sw = _ip_data[ip].sigma_sw;
+        {
+            auto const& sigma_sw_prev = _ip_data[ip].sigma_sw_prev;
+
+            // If there is swelling, compute it. Update volumetric strain rate,
+            // s.t. it corresponds to the mechanical part only.
+            sigma_sw = sigma_sw_prev;
+            if (solid_phase.hasProperty(
+                    MPL::PropertyType::swelling_stress_rate))
+            {
+                using DimMatrix = Eigen::Matrix<double, 3, 3>;
+                auto const sigma_sw_dot =
+                    MathLib::KelvinVector::tensorToKelvin<DisplacementDim>(
+                        solid_phase
+                            .property(MPL::PropertyType::swelling_stress_rate)
+                            .template value<DimMatrix>(variables, x_position, t,
+                                                       dt));
+                sigma_sw += sigma_sw_dot * dt;
+
+                auto const C_el = _ip_data[ip].computeElasticTangentStiffness(
+                    t, x_position, dt, temperature);
+
+                variables[static_cast<int>(
+                              MPL::Variable::volumetric_strain_rate)]
+                    .emplace<double>(div_u_dot + identity2.transpose() *
+                                                     C_el.inverse() *
+                                                     sigma_sw_dot);
+            }
+
+            if (solid_phase.hasProperty(MPL::PropertyType::transport_porosity))
+            {
+                double& phi_tr = _ip_data[ip].transport_porosity;
+
+                // Use previous time step transport_porosity for
+                // transport_porosity update, ...
+                variables[static_cast<int>(MPL::Variable::transport_porosity)] =
+                    _ip_data[ip].transport_porosity_prev;
+                // ... then use new transport_porosity.
+                phi_tr =
+                    solid_phase.property(MPL::PropertyType::transport_porosity)
+                        .template value<double>(variables, x_position, t, dt);
+                variables[static_cast<int>(MPL::Variable::transport_porosity)] =
+                    phi_tr;
+            }
+            else
+            {
+                variables[static_cast<int>(MPL::Variable::transport_porosity)] =
+                    porosity;
+            }
+        }
         auto const mu = liquid_phase.property(MPL::PropertyType::viscosity)
                             .template value<double>(variables, x_position, t, dt);
         auto const rho_LR =
diff --git a/ProcessLib/RichardsMechanics/Tests.cmake b/ProcessLib/RichardsMechanics/Tests.cmake
index c29d5dca89026ed6f5c50fce9aa552b7dbaafbee..7593828cdda29475725dc5684574dd69bf796d8e 100644
--- a/ProcessLib/RichardsMechanics/Tests.cmake
+++ b/ProcessLib/RichardsMechanics/Tests.cmake
@@ -178,7 +178,7 @@ AddTest(
     GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu epsilon epsilon 1e-15 0
     GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu pressure pressure 1e-7 1e-15
     GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu pressure_interpolated pressure_interpolated 1e-7 1e-15
-    GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu saturation saturation 1e-11 1e-15
+    GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu saturation saturation 2e-11 1e-15
     GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu saturation_avg saturation_avg 1e-11 1e-15
     GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu velocity velocity 1e-15 1e-15
     GLOB RichardsFlow_2d_small_pcs_0_ts_*.vtu HydraulicFlow HydraulicFlow 1e-13 0
diff --git a/ProcessLib/TimeLoop.cpp b/ProcessLib/TimeLoop.cpp
index 8ab2d6f8f1e7d1a8400a616d1ffe22ee6303e58e..ef1e29fd1b1e1a00b267f0620506bd3cba793824 100644
--- a/ProcessLib/TimeLoop.cpp
+++ b/ProcessLib/TimeLoop.cpp
@@ -648,8 +648,8 @@ void postTimestepForAllProcesses(
         }
         auto& x = *process_solutions[process_id];
         auto& x_dot = *x_dots[process_id];
-        pcs.postTimestep(process_solutions, t, dt, process_id);
         pcs.computeSecondaryVariable(t, dt, x, x_dot, process_id);
+        pcs.postTimestep(process_solutions, t, dt, process_id);
     }
 }
 
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_0_t_0.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_0_t_0.000000.vtu
index 3ee69041eefef6249020d18e8802842bae3d6bd7..8a4bbb41b321f4211ac754bd921387af355877e5 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_0_t_0.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_0_t_0.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:7da541220edc3a065913a060e073c5cec35ac04bfff888b18b22f70f38f4535f
-size 13532
+oid sha256:eea28d1cbe959b02ba953d45e08fe2e2e06341bce3efa5cb45cda9727a7815eb
+size 11708
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_104_t_2000.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_104_t_2000.000000.vtu
index 4b5d7527f74fab91a9e4fcc7068586cb7753ee5a..ab80e73bc4dc51aeb8d51846a2a87116e2aa4489 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_104_t_2000.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_104_t_2000.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:033d9dbe98cfca74f1226f5113d487afdeb7550953cae27fa55186689c2eeef5
-size 48468
+oid sha256:7ef5d757f5f7bc1253b2b29f1f4e8fed6e0e72ca0acd2b4f0ebe4e98e3c2687b
+size 93432
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_19_t_318.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_19_t_318.000000.vtu
index e42fbeabb4ae4187e96aa73da36ffbb01a864fc9..0eb61a2ef479b0a40db1f038c2dc410db409f669 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_19_t_318.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_19_t_318.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:fca9726141c682a344087223e687591069c2f16fe41b223f6254a0ddf0304d80
-size 48344
+oid sha256:2ca17dba062b4d4e64c9044e4f75f43af5000bc3378857dbb5e4c08f395be9fc
+size 92248
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_1_t_1.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_1_t_1.000000.vtu
index 5b6631a522c09645d3e1c45dff073075509a5a78..3d43bf4a16c716fffd10d16a9447d19bbe4a0edc 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_1_t_1.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_1_t_1.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:ad3428e1dccaba727803eb8b9b658d7abac3f9d502093ebc5553f1f6f2cd6d07
-size 48052
+oid sha256:a5f41626d188dcb3e23e769a72f4da12e193b082c70858b958f34ce3fa768f22
+size 91552
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_29_t_518.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_29_t_518.000000.vtu
index c1cacaec85b0fcbb7f9af9aa876e27fde21a5f63..40331f8fb0322f036da376e3a7e7d9eba4f6eb4b 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_29_t_518.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_29_t_518.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:35893ecf4afad4d300c7eb96d7eab6644ae3cb60bca2e36584f4f6f144bef5b3
-size 48428
+oid sha256:a7fc4990ffb021c2da7b0a8d2945fd04a8838dbb413a1db82921dbd5efd1eec9
+size 93260
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_2_t_3.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_2_t_3.000000.vtu
index 81f5ac1d737b71d9d00c7f25297bdeeeeeb69b87..fd16aef94ebe0fa54121a68a439f59582ea1b833 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_2_t_3.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_2_t_3.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:73597236e896354c6b771f6f70f2edd4729c7918b9916c0d73913d0c116c10be
-size 47952
+oid sha256:97c17db12c2b656b952c81065e2569ccb8240da15d4151a0417dfd09008775a6
+size 91164
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_39_t_718.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_39_t_718.000000.vtu
index b099ed3487120384689428a3ef6dcce3d01a7e83..aeda8bdab04c577455c555017dcb591490eca56f 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_39_t_718.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_39_t_718.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:91ddd7f894c0d10ef4338a22c8697afe1a4097f829cba53f1c2ca33f0e152bec
-size 48496
+oid sha256:80823646afa01588858c70a128aa7f8b7ef6d6027741a9e4745d69c2f03f9478
+size 93252
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_3_t_8.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_3_t_8.000000.vtu
index a9215da8ff2995a40eb353792098f53fd7003313..dda6c8f2dd4b677e1741838696858e6c7a41542a 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_3_t_8.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_3_t_8.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:a08a9132e977cfef6e9f3d0f5aec61cb4261e13b2ffc03a870c539db11584bc9
-size 47600
+oid sha256:46dbdda7d2c7546cb5da1d9a93f5610e14e43adc38dbdddb41a14cd8cd2ace74
+size 90976
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_49_t_918.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_49_t_918.000000.vtu
index 16b93841e5f22a1d35e7fa627b8c1523e704c6e8..05f50fcb28c8d33b4409fd3b771ba42bdb314520 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_49_t_918.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_49_t_918.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:a4fd0d9a75db3805343305935d38951172a4cba42d1536f75d70d6367f62b917
-size 48632
+oid sha256:5094aab95673bb17d61f54957d4b7b8beae3a49a7eaeb20899647baab0292e3f
+size 92956
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_4_t_18.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_4_t_18.000000.vtu
index 75d63f7485014ef038bbd0a9f226c9b44c0b317c..2f61888211a23e3164bfc88fb005e276dd92878d 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_4_t_18.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_4_t_18.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:829724b692f3a8fbc0458988e34af4d91c8f9c66b70048edca2b377a941acf8d
-size 47940
+oid sha256:a1c2908844f09c6fe6d2059547ff33756df599a097388a71771e6142852c8184
+size 91508
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_59_t_1118.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_59_t_1118.000000.vtu
index 337f4955cce21beb4f4de0cc4efb27f645bb44e8..f6e621379c8fe572730cb76939a71aab2d9d6422 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_59_t_1118.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_59_t_1118.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:d7ee19c3ef9ec747c4b568862db73a2a7d803fb63a35287352b7a81d1dd72515
-size 48468
+oid sha256:50c6753599ad93c498d2b2585b401579d38eb06bca99344c4d7a4d5a1060ba2a
+size 92740
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_5_t_38.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_5_t_38.000000.vtu
index 9cd04fb0d26f1fece61c0c589ff04b1290fb5fa8..4af9a5b79a8fa8c57e2c677eee4854044478b301 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_5_t_38.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_5_t_38.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:44b4e6754d03ad8ecf384104727dff1cedc5e3f8592433416a9b00001152dffe
-size 48124
+oid sha256:93164144016e8a7e9b4c42883a975ce6bdcb21ee16bbada6d4ad1911b5589fa5
+size 91584
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_69_t_1318.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_69_t_1318.000000.vtu
index 9669ea1123728ddd0b7d240a07351224c371aee2..0811c9c47f97c663a5c2e135917ecb27c599f5a3 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_69_t_1318.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_69_t_1318.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:3435e5d32b9c8818dca4076d77541f52d555308984d34bab19e973c4261b2a61
-size 48536
+oid sha256:84eaf3264ef2a2141a05e08208b2a6af3d2976a3374ef8ff365d219ed9b3a908
+size 93120
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_6_t_58.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_6_t_58.000000.vtu
index ea70258d951c2d31eef52f0a1b710a6815230abe..2647ddbcce6bff85567476a136dee02030885382 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_6_t_58.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_6_t_58.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:ad1873cc0efba7291645634d7d8df99d26f92d80ee845dc7314cd34d5d93fa34
-size 48136
+oid sha256:023d2318ce8e0d22c0a855897007a4a6b2b9b7fbef0b3b888129fc8da7967fd4
+size 91960
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_79_t_1518.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_79_t_1518.000000.vtu
index 11ba159bb94b964e31d3900dc3a665d5122390ff..3682be2fd0645e91af034b1502c2f87c39f3452d 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_79_t_1518.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_79_t_1518.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:d7992c9a55f1ba04435af45643a2112257db932498fbde71b0beada24111200d
-size 48432
+oid sha256:bbf67533359623bed38dcccc419719e99286aaa591f37209a6ff3cbbcb838850
+size 92904
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_7_t_78.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_7_t_78.000000.vtu
index 6be01dded398856ce015a487410d43ee7c94dc0f..020cab47887622a815dbe3716aa3cc97f4c3c982 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_7_t_78.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_7_t_78.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:c5c40eeedc0c9562f4328ebfa2e3a058e5e661bf2f70fc7dc21b1b9653e57830
-size 48128
+oid sha256:ee36bff50d4054e4b988afaf2189d7af6e59e7dd73a6b2038f51db638369288f
+size 92264
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_89_t_1718.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_89_t_1718.000000.vtu
index 2ea1c7c1d2f6797931b0f33d1d2df9054dfcd0e0..0343b50055127cd5a41ef3e3004b9f320c3a0c87 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_89_t_1718.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_89_t_1718.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:00f3b0c7a8e723f7024954fa5a08b68f01ad8af4beca8ba7fa8604d2f507a810
-size 48424
+oid sha256:de8302d73b394ec488d6ede92e21fd70476aaefd2526c27183cf9a8e478a93f8
+size 93320
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_8_t_98.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_8_t_98.000000.vtu
index 83ff794da12bf501498aefb44ddf6a246db563f3..95ff5d9a60a3172ae6805031bf9a7b4ff717d91e 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_8_t_98.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_8_t_98.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:247404b3ba5325d7c6a3920cc431fa10f783aebabfb39e157e394d7918ae94bf
-size 48212
+oid sha256:4cc29d34a416f72d91a1e6bf6c70563231353469c8d03702d5d292f7af63f66b
+size 92288
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_99_t_1918.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_99_t_1918.000000.vtu
index 62e45fb9298fcb48002898a896b116b1dcf60187..f5e645978ca5a5fd263fd61d86b912956d6fc218 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_99_t_1918.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_99_t_1918.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:9f06657fa1ef053bef7888596244990dc096d965df6057469f0ddd3ba96e8c1e
-size 48568
+oid sha256:744795b54dcdddca8d168b4fa6b14f92cf20869617c44634ba84a5739ab65214
+size 93480
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_9_t_118.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_9_t_118.000000.vtu
index 5ca67ca3b2cb0a9507091d4d455b0044eda4b1c4..5038cae611a84de30b1afcc37713bfe7c6bf6b71 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_9_t_118.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_quasinewton_pcs_0_ts_9_t_118.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5b107ea2986209b3df1efa68a28e0a7b62a0882940e2b960f51c35d58af43988
-size 48148
+oid sha256:15fd1f1c9378bd43bc600050c31fb4ac52568cae4d3d1057d6039864fc2a6cbc
+size 92148
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_0_t_0.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_0_t_0.000000.vtu
index 870d85c42bbe0b9f2593adb579d11385d632dc61..8a4bbb41b321f4211ac754bd921387af355877e5 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_0_t_0.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_0_t_0.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:11e19c4cacb5a10faae8ed3e55b96bdc9595002dc38760e26998d693fa589b14
-size 16312
+oid sha256:eea28d1cbe959b02ba953d45e08fe2e2e06341bce3efa5cb45cda9727a7815eb
+size 11708
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_104_t_2000.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_104_t_2000.000000.vtu
index e1813b6d559597c204573e3854072440075577fc..cf1192ac7f2a2115f6480b3d9cee2dd4768c10c8 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_104_t_2000.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_104_t_2000.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:1d5090596a3dcae59c1a9eaf13527d70f5d3ccf6690da6fc259eedc6cc5395e0
-size 84120
+oid sha256:603da1d743d7e7374806542a56adcb8dfbe2a224a7aa0464f6c0005372148b8d
+size 91208
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_19_t_318.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_19_t_318.000000.vtu
index cbcffc13e0f13d96c744c8cd5f79d0b9bef0e829..04b7a4cbedbe99031d496767033077d08241df4d 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_19_t_318.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_19_t_318.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5e789936a9bf30806b773db81a84cfdd3aa366318f24ba287e7f81e973ec6be7
-size 83360
+oid sha256:78eab5dc80381ffcf1ef760290ac08798fc1100a9ebe13491922b520543e26fd
+size 90240
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_1_t_1.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_1_t_1.000000.vtu
index 0d5fd052b5a5779bb12285ae36c5109b6ea5f6bb..998bb00bfa619de42cdbd3de80741e9649cc4a7a 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_1_t_1.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_1_t_1.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:c6a3e42fc6ee8a233d3d712e13efde6da5fcf22290cd6a4d2f1a7014e655018a
-size 81752
+oid sha256:f7e3bd8ef4288ac7dfbc362f8378a6a6978b6ec6c3abc9d76f88fbc07833a2ba
+size 88508
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_29_t_518.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_29_t_518.000000.vtu
index 024153c9b82bb353c91434b4af46280015d0c4b1..65440c496c98cf70ad10a8aa22ff2f9c8597bf0f 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_29_t_518.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_29_t_518.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:4f3e5c87529c53ac157f8afae144da269ab7b381e33eaee3562a4726bf627de7
-size 83552
+oid sha256:1b75d09485109da1dc1ada04b3b6e45c5f84ed8a8affbd39883e6435ca9c26e8
+size 90520
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_2_t_3.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_2_t_3.000000.vtu
index d3e295273b11b981f651ff250db57014aa57211b..9de67bae4c2c03f52652f448b273f142d917cc9c 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_2_t_3.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_2_t_3.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e959069fe4b24266b115f4f7d1b99325685625ca9d2d480daf148d743d9d1675
-size 82240
+oid sha256:0dff299bb797e9b25f81cf5a21d0a0292505d51fc43fc64d3d776c9464ab2530
+size 88532
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_39_t_718.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_39_t_718.000000.vtu
index 741c13c7c0e1d755d19c65f7fec50f69cfe91de4..3ff4564cd1c7f4d256715d1442c954a71a369745 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_39_t_718.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_39_t_718.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:9cc18155830e27b06b4ed99094cf1718747d505a5a7a4bb587bce60d9e9b9f38
-size 83740
+oid sha256:8cb09d003ba18b8f31dcb9ff1733eca7104529d981f66f70a3b6ffff40177616
+size 90292
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_3_t_8.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_3_t_8.000000.vtu
index 7127a0d016015657779f3455503e500d5c7440bb..98f6e92a179af37ee30296f68ac7ee1cae24bde9 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_3_t_8.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_3_t_8.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:ce18971edc0ab209d727b3e7482b252a125e36394f00ab6d815677ad90729ea2
-size 82444
+oid sha256:e3532b26d021d4fff6025ff844fa100f8cb65ce58787a126451f083586887a27
+size 88416
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_49_t_918.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_49_t_918.000000.vtu
index a9804de7535d39c2004aac2a238348f019c0ddc1..f5540c458120b3013e0f07c6cd0a15aace4817cd 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_49_t_918.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_49_t_918.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:11286e29c701684bffc8738e5b8113c1afda565f8f2b5a9cc1798b4b292982a8
-size 84000
+oid sha256:ef740909ab03e9d67632b6e9cdd0901ee92d4d592a84796b9547f99d93fdd211
+size 90620
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_4_t_18.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_4_t_18.000000.vtu
index b3f2bb8008a180c8b4059e932f5ad70bc47cd52f..553bf2e345d12eb27987e7e9c0fbe21912216163 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_4_t_18.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_4_t_18.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:a51ac00135f969eb5007dba35375dbe6a0b3c97492270a2bd1f3bfd259b26dbc
-size 82512
+oid sha256:b19d02d4bcaa3f3de196b2aee162e0cdbb0956c50b13a659a8d3abc9308f2bd8
+size 89108
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_59_t_1118.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_59_t_1118.000000.vtu
index f0869ed9def11ddfbb0d3b84b847274cb09d0b61..79dc4c618363d9fb97846f45f0c7dd7fdb545c9c 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_59_t_1118.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_59_t_1118.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e4ffdb4fe2330732aaa4bfdcadce0a812dad80b3e6111dfc803b2bcc8be086d2
-size 84004
+oid sha256:923908b3ae0bdfefcc42c56b61e9edc80d988066a62024f45de20077aaf7029d
+size 90448
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_5_t_38.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_5_t_38.000000.vtu
index ed0596662b0a472ac602656880e2b0734d39c031..1267db5cd68d1ec7968bde13e5a04cca8aa27e12 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_5_t_38.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_5_t_38.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:a53bb6c92c3d2a950eb7c2c9245c43781c64c6e136ef392e4ecae6b6f3b50723
-size 82652
+oid sha256:5ece6d2d4852e24ceb2ad4120e17e7826b2aa8b2a034762592741582e42c6b04
+size 89328
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_69_t_1318.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_69_t_1318.000000.vtu
index 6c3b97ca405a39862f47b4986f8374dad8b6ce96..9d70b7e9ddb1b3295d1741f5185f96dd1c274cdf 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_69_t_1318.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_69_t_1318.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:777951935026675b32139eb6404d9d59f4d8f66503f409ad3d0c1d2eba05eb5b
-size 83912
+oid sha256:4e8aaa69512ecd17dbf6f613cffa8a10f8b03cc3e6cf4f1978c2224abab2fa28
+size 90764
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_6_t_58.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_6_t_58.000000.vtu
index efdc0965f8bf2074ad12241b7bb2aec4b31575ba..f60aada92af75f87fe46a5b214fa61af5c2dbbf3 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_6_t_58.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_6_t_58.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:9820b3d489e8e3fb604fa5e2aa79f4282c69d574b902509aa9bafefa49b8a484
-size 82776
+oid sha256:ad0455d073b66bae018eeb88c91a9810fcd6c0a875e43de87a2e00a712902285
+size 89368
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_79_t_1518.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_79_t_1518.000000.vtu
index c48cf5a89850b0bc78412ec43e44617779ce6042..656ac522de87168d8af6ba5a97fb89014931dcad 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_79_t_1518.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_79_t_1518.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:daacaaf894ddfc2da6bae7da39ac309ba2d6049bf954c3f442a5d98cc0f837fa
-size 84004
+oid sha256:1bf6d67b98ebca9ebaa02ef3fee0f9dcd0163a7e9cfa2edfd23f67fcd190b0f9
+size 90920
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_7_t_78.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_7_t_78.000000.vtu
index 9aab2fec71b109467ae7174af99e35ca2943e03a..cb5928aabe359c5a3c0e59a7cce19388c9bc4b5f 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_7_t_78.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_7_t_78.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:3cfd7d1523c0e0bed7e95ebe0e80d2939d6b0a147fa6beee0243096b874c7cb6
-size 82836
+oid sha256:5ddcd654cfd3f4bb381b8b80aeafb6ee6c70d9a39a3cb9e2c6029b5fae1d740b
+size 89584
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_89_t_1718.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_89_t_1718.000000.vtu
index 31fe999c40ab8af04460331ebe72ee2d4bb612a8..01e4470740942a73752cfab1b494ba3ecef5ce99 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_89_t_1718.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_89_t_1718.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e5ed5e603086044f9d86e4dc9fa5742f4b073320301a8f1a5355a247da8ada2a
-size 84252
+oid sha256:a0aa319adea93ea72fb426eb3882a7c1a1ebce033f90cb7a4f5dc9026e8852cf
+size 91064
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_8_t_98.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_8_t_98.000000.vtu
index f013092741688ea8a154c24cc6156cad3cf49984..b225b8465d4a6d5a325d84bfa81898502fdd16e4 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_8_t_98.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_8_t_98.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:33b28d347d3a54b395551e02dc2efbff21dafed51330e94780a4b2bb128fdd35
-size 82904
+oid sha256:2bd8ea46b612d1f29102eff90c35f6147d57b3b86826797567016913783e5ef0
+size 89332
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_99_t_1918.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_99_t_1918.000000.vtu
index 05d8b0995510989bcceb000719d40c8bd022a6a6..efd78753ba872dfa5335b0dd5439d0c111ef333d 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_99_t_1918.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_99_t_1918.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e0aa784457755337ff7b58f0d33f8fbb0df4d24a59bd0441fe239083ce32c9d6
-size 84164
+oid sha256:8041227c77e051a12a3431eb244db4d83d20817824320d94a916fc6388c79fc4
+size 91280
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_9_t_118.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_9_t_118.000000.vtu
index 0c6306e19f320959ee6840aede2de5525f792827..4c5c9a07046cae73ea0f1048dc791f4203bb504b 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_9_t_118.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_masslumping_pcs_0_ts_9_t_118.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5f553d1f5942de3b00c42ad803014d9f13eca965e242ae75fd64584981821c4d
-size 82808
+oid sha256:9753969077afcbb7ad4a1f33ee6a3c40e7b0d9ebd6c15a010b50ba6f1a4f3778
+size 89624
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_0_t_0.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_0_t_0.000000.vtu
index bf004503f50c1c0b822d3711585280b3a062256f..8a4bbb41b321f4211ac754bd921387af355877e5 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_0_t_0.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_0_t_0.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:a1cafe2a1c6d2576285969a4dbab0f42be567656d3a542a37126ba28fad06356
-size 13536
+oid sha256:eea28d1cbe959b02ba953d45e08fe2e2e06341bce3efa5cb45cda9727a7815eb
+size 11708
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_104_t_2000.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_104_t_2000.000000.vtu
index 417e78b066f0905ccca32a81da96aa9c09916c29..0ad73176f73cb0922301d2398531c6123b4a0d75 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_104_t_2000.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_104_t_2000.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5dd0f39e79db7a27eaba5a0a9a69c4d5e8add0367136a60ad0ed868f77873aa5
-size 52692
+oid sha256:bf3f322b419234487dee6ab6b5dd2bfbf2b4acb394418fdea41058e460737f73
+size 95168
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_19_t_318.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_19_t_318.000000.vtu
index c024c78c2b83e2b49b9cfb338bdf3b5e0b85c5eb..257ff7fc8288bed29857521e8ca0750538c05123 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_19_t_318.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_19_t_318.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:fbe60a1585f8a72679eacf43f5a6486540b2dcf5d6c2162d21766b11f0910a31
-size 52584
+oid sha256:0a8d02578246958ff4bc05c1e2bebcc42b378147eaea74d428cbf842908b6c7a
+size 94992
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_1_t_1.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_1_t_1.000000.vtu
index 0da46d6a30ae7cc35f6c49a18a8669eaaba3b19c..ad2e19400c41636584a2168e79e1fc98ed8ee8bb 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_1_t_1.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_1_t_1.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:b698113713591ea13c106f96536850adce70250a754d7ddaccaab9c6924d17e0
-size 52048
+oid sha256:bf29e1f3a160f5a8e02f4eb87b54744bcff4cb7d22c50ab1864fd2238dd88800
+size 92500
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_29_t_518.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_29_t_518.000000.vtu
index 6af28843099015142f872a61caafc7e7aa6b07b1..fe148ab333da0a1bad24ef6a06b2ccce83b230a5 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_29_t_518.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_29_t_518.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5bde0e64e1a2f4289d59d013a760935daebdbec904db00ccf09a2a7c2507ba0c
-size 52408
+oid sha256:4210feb00f8f182c5880c6a13c7e46b3b19fe9bde7503e68d7628f0de770e0a0
+size 94572
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_2_t_3.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_2_t_3.000000.vtu
index 2eb5f463f9d3ce45afa26753774b1ff6e1c09b78..9f08b1df389fe72d94a5308deba4ee062e76c327 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_2_t_3.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_2_t_3.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:eebf9e3acd4a9c69e2f23f3a714079151e2b05d87d11335573999aaf02132d14
-size 52276
+oid sha256:c9b3a62887aad512c21fba11f705f1155844d766a4831cf264adf73fe9af8ea9
+size 93620
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_39_t_718.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_39_t_718.000000.vtu
index 89e4b9a58ddb8c55ddc7766dc2a87d3630a2b43c..05888c8c47a06cf9cb8bdf2b8ecc0457db7bf077 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_39_t_718.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_39_t_718.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:321f962413a9a7d0969a65d8f8eb023510d9350c917a9ed460cff411d5220a44
-size 52612
+oid sha256:9a630a862ca187f0f754e5295cf82acc0d6c6476c2f607702009b72889478d4f
+size 95072
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_3_t_8.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_3_t_8.000000.vtu
index 9d51a741861f4f7866236e9ffa127be50f476297..cadefed26ad3ea56312d6dc21aa4ccafe2691834 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_3_t_8.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_3_t_8.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:b6d829e3bb639dc41e83a34ebe6ae74ca8f407fb8cb71ec9f302a45ce7dea3de
-size 52168
+oid sha256:75ceccaaf9a34b78b1af5226c4d873f607e7827fb8357a94599d9286a780e557
+size 94208
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_49_t_918.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_49_t_918.000000.vtu
index 7d73fc7ade2cc65094fc2d44aa3762f298ae124f..8f8564dd33675249e34afd33b0b74d93c3aa4173 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_49_t_918.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_49_t_918.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:99674f5b910d719b26a2a56f7589a06dc13dbee3dabb32bfbeb9f9d1d1890e14
-size 52472
+oid sha256:5bfd1bfceb2ec6bc378b6c6dcda7f0df5fdf74e80d5b8628720b0dbf9e00505c
+size 95268
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_4_t_18.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_4_t_18.000000.vtu
index 74596659c1be74da61e9df3bbf95dcd1d8363914..2147f5adde11a04a708e31eb41961dd2381322e3 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_4_t_18.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_4_t_18.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:79950980684a667175aa919fe45693a4c773be096d4b45c2c020674579c229ae
-size 52284
+oid sha256:1b6d917bcae31cb0c4f7500414f91502c3c24d3cf7e84e511620de31e1e08f79
+size 94180
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_59_t_1118.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_59_t_1118.000000.vtu
index fb36cd6dcceb644078d646c0a495bff6f2536344..4b391cf23c40e4543f2be67af67ec42bc932deb5 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_59_t_1118.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_59_t_1118.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5dc3716c43e9a90c029ee79aa28f084a4e48afec1cace0bfdfe5d4bea415b843
-size 52620
+oid sha256:438efd265f318f63d50f3473f53cb7cb141741e241b163a4f713d4b347f2e2c4
+size 95416
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_5_t_38.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_5_t_38.000000.vtu
index b51055be29a9a14e1d6fd45da5480bee0c25e904..2c81e1d0bed9ec4d44470003325b74284bfd3256 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_5_t_38.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_5_t_38.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:7d09a9fc6464e1b439948fe831208d7fd854754594b9f2480a2235c36a50b78c
-size 52192
+oid sha256:d5f7ec5f534c00bc7bb6d7d4c6737486bf175d7b654b9188ea9fd818c52057f5
+size 94176
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_69_t_1318.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_69_t_1318.000000.vtu
index 4a75bf8346f6db0eccc01599951de7fd1dcd891d..973623953470bf13a08a97191c44ac1cc1eb88cd 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_69_t_1318.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_69_t_1318.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:aafec4c68364c68833f8db8244da75c3d5c337fc9b5388e29269e66d3406c6c2
-size 52600
+oid sha256:ca3d551a63963ed640d367276b61d5736a81eae55eaf032d34d60b884e8e6fb6
+size 95208
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_6_t_58.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_6_t_58.000000.vtu
index d992a65945feb90e371ff2aee94d354adfee875b..9670112ab38622086493634300ddc11c01b104fb 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_6_t_58.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_6_t_58.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:8e5209454f89f953531fd479be05f2fa8fbd0840ab342789733cdf45a0e14213
-size 52164
+oid sha256:d01b814a034318b2778406a02e6b0d9f5808ebe874ebd446b1ea5c3d74bb44e9
+size 94384
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_79_t_1518.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_79_t_1518.000000.vtu
index 1d9cd7c53b2340a883f895243cd1887bf62a655e..47a157a7f5ca10cee538e37b3dab75360609f3e1 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_79_t_1518.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_79_t_1518.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:0f14dc70f03ccb4a17f8258a39d67de0347bad3893404621c1908c5647e41e8c
-size 52588
+oid sha256:84f8f989a9f1741f519eb87e40efafefc242bd3eef063f1eb28d2d4636624aab
+size 95564
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_7_t_78.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_7_t_78.000000.vtu
index ee7e012f1af4104df0a6866c14288d0df7918bb6..1c1dcf8591f81d4c10bc13fdacac16091582f289 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_7_t_78.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_7_t_78.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:21ab843229b82e6080943343ecf53785aca8487699f0c416a17666ada3457b59
-size 52212
+oid sha256:913dbf8776b4a1b5d047a6168f95840166551ec169976d4ae4fd7e0be8b4601c
+size 94512
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_89_t_1718.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_89_t_1718.000000.vtu
index 8972e68462d8159ac4eefdc1df92cfb0f88694bf..b9dd373d34d74df0e2fc83b805c1edcca83a7a30 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_89_t_1718.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_89_t_1718.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:456f332ceaf31f25117649cb98107791174488fe6c3bf03eb70c8374ee59b20b
-size 52672
+oid sha256:75a72a5536f1d53246da54c2ca342f0c59d1dba7c936de6bcb31eab287a41920
+size 95236
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_8_t_98.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_8_t_98.000000.vtu
index ddb609dcaf741596e79e6f6070bd50406ef079e4..6a0aae755b1e43ae19b8536775b2683b4a4f47cc 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_8_t_98.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_8_t_98.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:319970246fd3ced67377de4fecde119c1aff3c9ef38cb73bf1ec251edb99af1c
-size 52368
+oid sha256:c4a3c8a7f458c3c467945a99f48af1d89b069d8cb46d03371a5bebab2e0bee70
+size 94584
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_99_t_1918.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_99_t_1918.000000.vtu
index 9896ffe7b4e33e03280b69d306683f97517cb800..4e498b1939a4c23363b5037011567e03459c1645 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_99_t_1918.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_99_t_1918.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:7c25403a8a1e29a8ffd41c01bc60e9439d7f57e93cb5f3beff4233f13609b6bb
-size 52588
+oid sha256:534a425ce6e52c8f5cfb5e0115f46d32ccb40019b0f2111a65bf4f717c484343
+size 95452
diff --git a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_9_t_118.000000.vtu b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_9_t_118.000000.vtu
index bfc90f0a596a5a02948831fb7c7e06eb70a88eff..298af95d0151bf2d2e43b176f54f81b6ef052b7f 100644
--- a/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_9_t_118.000000.vtu
+++ b/Tests/Data/RichardsMechanics/RichardsFlow_2d_small_pcs_0_ts_9_t_118.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e84eb475f5c91adeb03488272cd4229caf57471e7e4fc4e204319fb58c83302a
-size 52408
+oid sha256:d4af83c2ebcc8efbbf225431a61275d26f9a1c06e92ded54a73c6a1c915aa9f9
+size 94548
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_10_t_0.090000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_10_t_0.090000.vtu
index 5293ef9c5b9e97098e897808caeffcffbacb3543..fae2ee7a2552f81d92914045fa10db52a90b742f 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_10_t_0.090000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_10_t_0.090000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:4f5ad137feebf7de6fa40c40b4cdfba124bea4bf7e99bb9cac8aa13f354e84df
-size 44455
+oid sha256:5c2d47c581dc5cfb2ff929700fbe5d53b4fcc60e62ccaf7a9f597b8a46526c28
+size 93187
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_11_t_0.100000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_11_t_0.100000.vtu
index 81a681aa3e00d528b3c5d203cfc55820e0685da2..88185ee94f222f6b73fe165c27e2c45e2fca3cfd 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_11_t_0.100000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_11_t_0.100000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:473b469833017b99a73ca2d3ba49d7b0ecb329463a5801c41a33eaccfa42f426
-size 44259
+oid sha256:75ce643bf0370dd20d372e298e92efa6a2005caa4fd6c56f5b72107ddcee4643
+size 93319
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_12_t_0.200000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_12_t_0.200000.vtu
index 367553388020916eaadc91b7113ce9e0071f4f92..2be2eb84baa92a58286e3ed191f28d9a79e1df2c 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_12_t_0.200000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_12_t_0.200000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:bf2549474880f556b688865882e9e8575708d697d428467c2430860a3f129b97
-size 44491
+oid sha256:f4cbd65611cfa313e51009bf4b0764331839e93b868190010fc350f82e659283
+size 93247
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_13_t_0.300000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_13_t_0.300000.vtu
index 41a2a77197b48da2cebb1484280d23b16d8a3b1c..32591c5cdb6b812369e4d94171ee9626f7fa9c5a 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_13_t_0.300000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_13_t_0.300000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:ba9614532cd6e2acbdec9f40a88909f2d755d0ccfc63616b55635de1dae6ea2e
-size 44651
+oid sha256:a1a6359462ce41ddd3a8a5481c840006ce6512745b28261bce2a6586edc70443
+size 93259
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_14_t_0.400000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_14_t_0.400000.vtu
index 29e6bbda2a47eb754c625f0760c3a4f7f04c4b86..91c5c89bd5bdd78e2f9a57221b6317ddf62c8b50 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_14_t_0.400000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_14_t_0.400000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:cb1b22f79eb49e50e7741be337b91c759b1c32ad5d86f2a0c2123f97858328d0
-size 44799
+oid sha256:363e6198152c164932e9207deb515b08288a3e878d5467ef4d93e3617dcb4828
+size 93219
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_15_t_0.500000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_15_t_0.500000.vtu
index a34b4902f1b3bb8dd3ebc8afdec47d7a3a061880..5a80097b03a6d592f3ae3388bd3579c2af978c37 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_15_t_0.500000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_15_t_0.500000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:3c6021c298ed708df2c197218d65f964c138d84ca3c4b6027548add52e0af352
-size 44863
+oid sha256:4e12ba92e31c3430cb85c0928d757abef927afd4342a5242664fd66c6a19170d
+size 93591
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_16_t_0.600000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_16_t_0.600000.vtu
index 7d8f416c5486b3170456b7a15a1735cbf7cc3cbf..1ec727df7244d1ac3f81a16ad29cec34258b42c3 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_16_t_0.600000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_16_t_0.600000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:3a46072510e8ad6960bae0a3ba615811a8b2358db756732680967a5e53468241
-size 45043
+oid sha256:0bc333fc6df9e364921d5d4a6211329faa113fa54868cc27b353a49cc345c6dd
+size 93487
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_17_t_0.700000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_17_t_0.700000.vtu
index 7de40711f2e186387f7c8372ae1fa29b63bd91c5..16b4a6d2a4489fa0ff914867fb188d766b80810f 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_17_t_0.700000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_17_t_0.700000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:04239a6b6bc28fad9b2e8485530b38e320cbb162f160b02fbb6a21348606bab9
-size 45015
+oid sha256:ac975a59cc1275031affd38c8e264f94903a7be40e96048390c9958e8b9ab7fb
+size 93671
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_18_t_0.800000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_18_t_0.800000.vtu
index 025748b30f2b7d7b695e90bbd77d63a31bb54872..2f064ec89320dd025e0e92a03df441d543658ca9 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_18_t_0.800000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_18_t_0.800000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:68a6742c31e28222f4c6ec0936bf9af39d4a38df42562f5cb0633d1cfeb4005b
-size 45051
+oid sha256:08ea803a8ce41772ba28f7fa0d8b102b7f2a15e9a06cfea3dbe66c6e80122de9
+size 93775
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_19_t_0.900000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_19_t_0.900000.vtu
index 62cf7503a36d4a12aba63024a7f42678906f9d3d..64e091410ef34e65712822b3107ae810c7efe3e5 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_19_t_0.900000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_19_t_0.900000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:96e580c2eb397d08769f18061fbc79e6a4ec12be9feb3d9a416cd9341b11d028
-size 45047
+oid sha256:80388b677b718cf78ab7ee35f9eeae82fbe443f795e4fb298133c2e142e517ad
+size 93999
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_1_t_0.001000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_1_t_0.001000.vtu
index 694e5a79c537627785dd0a65541097b25b6447ec..ce7fe0de1deaaf00d2284857b3ac39a3ea4b1251 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_1_t_0.001000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_1_t_0.001000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:bbb183e743fb5c78fc9963c9edd1f1790e9e1f6a2d84a4018a060cd96ff7517a
-size 44055
+oid sha256:81aca81522a59802c5b35b5ce58cc1a9f96841490f1c45faa7ee08bc67cf03de
+size 92099
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_20_t_1.000000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_20_t_1.000000.vtu
index 8a2507611dd828341560d2e0c809b3bf990a9111..870c150c3dbd1b8ba4e0b0acbc95552d7c5d2011 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_20_t_1.000000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_20_t_1.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:8a208933300cad68cd9cb443ac7975af911b5e7c632ce66deba063c8938afb12
-size 45183
+oid sha256:b4733a84f28976df50a45f379b09f6d34a8e13dd046034f13bb2e03e56d212d0
+size 93971
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_21_t_2.000000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_21_t_2.000000.vtu
index e43ba443f6c3ccfdef4240105ed4b87845faaf5c..76c99c88f980ea1cdd9867a929e91b41239e8665 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_21_t_2.000000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_21_t_2.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:cb705f3c1690e19abcaf8a91d0f534da7a0e74c5acbcbc97ed75052e2466c220
-size 45599
+oid sha256:0cd36ef92fe86820735dc72d059f0209a697436fe35cf589c4fbf46692907a23
+size 94739
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_22_t_3.000000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_22_t_3.000000.vtu
index 6b05cfa45261e66e9fd9d5b9502d0c4670f4d701..bc8e15eececa9024939194489ea60c53ba322896 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_22_t_3.000000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_22_t_3.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:b3e40982ab0f1c1786d580aa93df6cc5c4b72881d6f95eb260812c334bbc78ff
-size 45771
+oid sha256:c4831c5eb988616b92de6292a9602161f5c59b9e19d29050691b3beb33309864
+size 94407
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_23_t_4.000000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_23_t_4.000000.vtu
index 558fab6b760c5aa9823aebf8a1526001d2916238..8e6fb5785d8a302bd9bf7d03f5044565707c5427 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_23_t_4.000000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_23_t_4.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e12c0648a54330a420f3e48e4cd7812561c5e6fe25b328f450610bee1dafd6ce
-size 45903
+oid sha256:c93d8b1919874b7c482df0cbd62d25979fc0e09f304700ef114a334769e71271
+size 94731
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_24_t_5.000000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_24_t_5.000000.vtu
index 7dd5c665eeb4af943ff56c26f10a1383a507aadf..dc78059b79218cdfd188c9d61f961db5fd0fa588 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_24_t_5.000000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_24_t_5.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:bde1d76aa302d92d97405522e389d8918e10176428978e28449411c2e60229f1
-size 46087
+oid sha256:523a724cfc0f8d1b43da3dadd3647b650e83f1a27c311880689838644449f06d
+size 94847
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_25_t_10.000000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_25_t_10.000000.vtu
index 3f7d11e0f951f754f8259bbb74fa87203dff6085..f35ecbecf9845b3172aeacf54494c6721184a8f5 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_25_t_10.000000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_25_t_10.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:f0e9c54e60fa97d097077d405e75af9bf1f09438089af550fe7b73a0410dd78c
-size 46315
+oid sha256:402ea72f50d724eb7e7ccd87801e26a8ce2f0fe345a438a66484c4515f428261
+size 95155
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_2_t_0.010000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_2_t_0.010000.vtu
index c5112c36ef206f462d9c2efe71c8be0d294805b4..d4facce6e43c3315932ca697b8f3af2d288b3a1f 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_2_t_0.010000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_2_t_0.010000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:2f101d17782ddadbf6072a3151db272a60d5191e7625c1be172e76fae5356371
-size 44227
+oid sha256:aa350b6a64e8ad45734540cae3ebc02e550f9e08abd86fe649ee25c71ed659d0
+size 92223
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_3_t_0.020000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_3_t_0.020000.vtu
index 89b0c07e3d7905667050b88c09b1c49e70c381d1..7ccd8a8bacd65ab23339bca659e7b7ac6818fd66 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_3_t_0.020000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_3_t_0.020000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:e33d48b1f48b9021607faecbd48a7e0c3bfdac563454dda8f5d0c954fcd99c39
-size 44295
+oid sha256:144f6292e3b06e197a53752e8056b2fbe0b1f040bcc7457f62310c483e01a1d4
+size 92839
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_4_t_0.030000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_4_t_0.030000.vtu
index 9756a016592933415c3e167b5f7d59c35967509d..916ddb5f3b9afbe8af664fa08dbf5eb986ce5c43 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_4_t_0.030000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_4_t_0.030000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:10986a069ad602a55b517a045e4328491a1ca4ac506c2763eb45634a09ab646b
-size 44303
+oid sha256:9780ae5bf8b9044ba030382f672d8ec6ce12bfd1ab17cdf06e47946f4a0dc3a1
+size 92935
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_5_t_0.040000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_5_t_0.040000.vtu
index 857d9e24cd4180039ab0f3f301c9ce3c114596a3..96e03f388a8d9ef708b6d29a7abbc28b0d93d7b8 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_5_t_0.040000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_5_t_0.040000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:b4e9d199aefcbbd5d8d9acfc577627ff5c126a726dfc8e0e36b9eadba3345b9c
-size 44159
+oid sha256:1f74adc1a3350fc304c9227603e732275bef5665515310a4cc6f504581cd1a6f
+size 92831
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_6_t_0.050000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_6_t_0.050000.vtu
index 1cf9bb373f23e211a6ea6bbb2d1fd0c677087b5f..aac5305f6d63322e028c833fa90d8ea6e572b844 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_6_t_0.050000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_6_t_0.050000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:21aea250391fd67551639568d1eb60127420f6e20dcc3b6633421244f24336a2
-size 44335
+oid sha256:346939dd8337c34d2d2badf1f0dc21be158989050343dc29a08ae59426bddb67
+size 92739
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_7_t_0.060000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_7_t_0.060000.vtu
index 8370132a08f2032b74853275ad7fdc573943f755..f3fc3069640e732375746947c8773cc86eab28bf 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_7_t_0.060000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_7_t_0.060000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:5ff64da64641e7d4beefdc0859ab8ed698ed7e9fb07ae5a9cb52c61325dfca47
-size 44275
+oid sha256:04128f040eb4db7f8d6de3c04394994a0db583389b3ef4903859cd0bbee3ffd9
+size 92991
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_8_t_0.070000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_8_t_0.070000.vtu
index 9bce0fcb5301f47197e61d5238dab26f888f3b01..d077119f4d2a3e189308db50d06e03e26930de7c 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_8_t_0.070000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_8_t_0.070000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:f4ab8dba9af15c77217c7e67a6d43a171b169eb74b769d98fb0c0bb941ecc0a8
-size 44395
+oid sha256:c57f6fe5bccf4c4298417a79f34a13a730d2cdc9e3e0637b7c264951a1b6f7f4
+size 93183
diff --git a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_9_t_0.080000.vtu b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_9_t_0.080000.vtu
index f71821379b0a2abef3c5c23d3f310a42e6856b6c..5f0211392fe4ab03f655c0821b4a21e654419839 100644
--- a/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_9_t_0.080000.vtu
+++ b/Tests/Data/RichardsMechanics/gravity_pcs_0_ts_9_t_0.080000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:b77009bf25b5220f0708c92d7868e8eb972bdb8b5436cb71412fc8d65fcede52
-size 44435
+oid sha256:f05beb55b4c07e9e24fd3edbc50c4de2d9aaa635c7557f2456a9cdc23dd006c1
+size 93023
diff --git a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz.prj b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz.prj
index b7ff216e390da41129443a01bf858b78104c38e5..33a373adc48ffa2ac23fcfa56e448ff0104991a7 100644
--- a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz.prj
+++ b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz.prj
@@ -28,6 +28,7 @@
                 <secondary_variable internal_name="velocity" output_name="velocity"/>
                 <secondary_variable internal_name="saturation" output_name="saturation"/>
                 <secondary_variable internal_name="porosity" output_name="porosity"/>
+                <secondary_variable internal_name="transport_porosity" output_name="transport_porosity"/>
             </secondary_variables>
             <specific_body_force>0 0</specific_body_force>
         </process>
@@ -82,7 +83,7 @@
                         </property>
                         <property>
                             <name>transport_porosity</name>
-                            <type>PorosityFromMassBalance</type>
+                            <type>TransportPorosityFromMassBalance</type>
                             <initial_porosity>phi0</initial_porosity>
                             <minimal_porosity>0</minimal_porosity>
                             <maximal_porosity>1</maximal_porosity>
diff --git a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_27_t_1.500000.vtu b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_27_t_1.500000.vtu
index ed565cd7b169f8b52147a911b0377bb9c6e1c26a..c68d4706d03891dcf58e98d215c1f34bb1cb7646 100644
--- a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_27_t_1.500000.vtu
+++ b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_27_t_1.500000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:d21e56920e2a95fd6ff432af81ce6a6a3773730eebc01b408299070bc50bdc05
-size 29775
+oid sha256:fc8f6130e6ad02ef2f16651297527cebc68b7e861fea10c4d6818f4cd0fc8686
+size 30839
diff --git a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_32_t_2.000000.vtu b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_32_t_2.000000.vtu
index 4e9140eebac5954ff0add877e4eaed6b25fa9a21..50de15750c0cfcbabc3d9c9a4060b9bca0189300 100644
--- a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_32_t_2.000000.vtu
+++ b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_32_t_2.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:41c4909272065ed37a25bf60e8ed94fe861a9b9a032b981fa76f62924b36d300
-size 30283
+oid sha256:c878d7a6ae69cfd8c878596c2975b28ee004bd35d1e50a378298bb402feeba48
+size 30979
diff --git a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_4_t_1.000000.vtu b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_4_t_1.000000.vtu
index 1f24b7b6f0ce395e3d89082a8dfd10a284cf139b..30954152847576279ed54f2c0687d5b7ef8af25c 100644
--- a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_4_t_1.000000.vtu
+++ b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_4_t_1.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:078b677e68142d875b39f48398569fa30c08e58bc75e3d954a6b7f504260bc42
+oid sha256:d3c7e9f114ea4d19c1a31aa981bcda82d2ec5d76365d601d413637d78f528dea
 size 8999
diff --git a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_55_t_2.500000.vtu b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_55_t_2.500000.vtu
index dae5fe50c003ea666f175d0d5db4cbe5fdc4b5a7..758f0b8e5a1fc05f038c96061a23ac8714a33ff0 100644
--- a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_55_t_2.500000.vtu
+++ b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_55_t_2.500000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:4b390f810e00b766ffe940009832c0daa1774b1a648602cd250a94daf6aed85b
-size 30287
+oid sha256:5d9fedaf336538495e90596afb803e6f6e22a1469c0cbae474fe34f508bbe7d3
+size 30871
diff --git a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_60_t_3.000000.vtu b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_60_t_3.000000.vtu
index 07c8507b1320fd6e1f6f9200a1e4da8768124780..82ac094124f306d049e404d6d57082b49be7a7ae 100644
--- a/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_60_t_3.000000.vtu
+++ b/Tests/Data/RichardsMechanics/orthotropic_power_law_permeability_xyz_pcs_0_ts_60_t_3.000000.vtu
@@ -1,3 +1,3 @@
 version https://git-lfs.github.com/spec/v1
-oid sha256:47e13bd547f1b4b93c1a173afbaf11f1e61427d774398f730e73e7c79d46fdce
-size 30311
+oid sha256:e948b8ca919d665656ee44a79ffd20c1cf08cebaba6a8724107b994cb6057239
+size 30887