diff --git a/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/c_ConcentrationAndPressureDependent.md b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/c_ConcentrationAndPressureDependent.md new file mode 100644 index 0000000000000000000000000000000000000000..c4d5d799ed52abdb8566c69561a83a2e1dc77cad --- /dev/null +++ b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/c_ConcentrationAndPressureDependent.md @@ -0,0 +1 @@ +\copydoc MaterialLib::Fluid::LinearConcentrationAndPressureDependentDensity diff --git a/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_fluid_density_concentration_difference_ratio.md b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_fluid_density_concentration_difference_ratio.md new file mode 100644 index 0000000000000000000000000000000000000000..0a425ecce27042fb04915162d480b961cf4493c9 --- /dev/null +++ b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_fluid_density_concentration_difference_ratio.md @@ -0,0 +1 @@ +\f$ \bar \alpha\f$ is difference ratio for fluid density depending on concentration diff --git a/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_fluid_density_pressure_difference_ratio.md b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_fluid_density_pressure_difference_ratio.md new file mode 100644 index 0000000000000000000000000000000000000000..b997188bf1ce4accae74a51a36215089b3589a7e --- /dev/null +++ b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_fluid_density_pressure_difference_ratio.md @@ -0,0 +1 @@ +\f$ \bar \alpha\f$ is difference ratio for fluid density depending on pressure diff --git a/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_concentration.md b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_concentration.md new file mode 100644 index 0000000000000000000000000000000000000000..e200f1d8ff747b570284bad199c9d476efa16b0b --- /dev/null +++ b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_concentration.md @@ -0,0 +1 @@ +\f$ C_{\text{ref}}\f$ is the reference concentration diff --git a/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_density.md b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_density.md new file mode 100644 index 0000000000000000000000000000000000000000..37ddf686c4ba3c63f4c008ada63a62d589641b8b --- /dev/null +++ b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_density.md @@ -0,0 +1 @@ +\f$ \varrho_{\text{ref}}\f$ is the reference density diff --git a/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_pressure.md b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_pressure.md new file mode 100644 index 0000000000000000000000000000000000000000..1c9f73462bfb460c4e9c362d2b8735e2aeef9c28 --- /dev/null +++ b/Documentation/ProjectFile/material/fluid/density/ConcentrationAndPressureDependent/t_reference_pressure.md @@ -0,0 +1 @@ +\f$ p_{\text{ref}}\f$ is the reference pressure diff --git a/MaterialLib/Fluid/Density/CreateFluidDensityModel.cpp b/MaterialLib/Fluid/Density/CreateFluidDensityModel.cpp index e56047ab1dbc83b83dc78418eede0673f293097c..a53a0bc3166f080ae0dc296121c8153a5f62b1b6 100644 --- a/MaterialLib/Fluid/Density/CreateFluidDensityModel.cpp +++ b/MaterialLib/Fluid/Density/CreateFluidDensityModel.cpp @@ -16,6 +16,7 @@ #include "BaseLib/Error.h" #include "IdealGasLaw.h" +#include "LinearConcentrationAndPressureDependentDensity.h" #include "LinearConcentrationDependentDensity.h" #include "LinearTemperatureDependentDensity.h" #include "LiquidDensity.h" @@ -91,6 +92,37 @@ static std::unique_ptr<FluidProperty> createLinearConcentrationDependentDensity( reference_concentration, fluid_density_difference_ratio); } +static std::unique_ptr<FluidProperty> +createLinearConcentrationAndPressureDependentDensity( + BaseLib::ConfigTree const& config) +{ + //! \ogs_file_param{material__fluid__density__type} + config.checkConfigParameter("type", "ConcentrationAndPressureDependent"); + + const double reference_density = + //! \ogs_file_param{material__fluid__density__ConcentrationAndPressureDependent__reference_density} + config.getConfigParameter<double>("reference_density"); + const double reference_concentration = + //! \ogs_file_param{material__fluid__density__ConcentrationAndPressureDependent__reference_concentration} + config.getConfigParameter<double>("reference_concentration"); + const double fluid_density_concentration_difference_ratio = + //! \ogs_file_param{material__fluid__density__ConcentrationAndPressureDependent__fluid_density_concentration_difference_ratio} + config.getConfigParameter<double>( + "fluid_density_concentration_difference_ratio"); + const double reference_pressure = + //! \ogs_file_param{material__fluid__density__ConcentrationAndPressureDependent__reference_pressure} + config.getConfigParameter<double>("reference_pressure"); + const double fluid_density_pressure_difference_ratio = + //! \ogs_file_param{material__fluid__density__ConcentrationAndPressureDependent__fluid_density_pressure_difference_ratio} + config.getConfigParameter<double>( + "fluid_density_pressure_difference_ratio"); + return std::make_unique<LinearConcentrationAndPressureDependentDensity>( + reference_density, + reference_concentration, + fluid_density_concentration_difference_ratio, + reference_pressure, + fluid_density_pressure_difference_ratio); +} std::unique_ptr<FluidProperty> createFluidDensityModel( BaseLib::ConfigTree const& config) @@ -112,6 +144,8 @@ std::unique_ptr<FluidProperty> createFluidDensityModel( return createLinearTemperatureDependentDensity(config); if (type == "ConcentrationDependent") return createLinearConcentrationDependentDensity(config); + if (type == "ConcentrationAndPressureDependent") + return createLinearConcentrationAndPressureDependentDensity(config); if (type == "IdealGasLaw") { //! \ogs_file_param{material__fluid__density__type} diff --git a/MaterialLib/Fluid/Density/LinearConcentrationAndPressureDependentDensity.h b/MaterialLib/Fluid/Density/LinearConcentrationAndPressureDependentDensity.h new file mode 100644 index 0000000000000000000000000000000000000000..79f9f29d692c5831fd37ac9aad63d3fd88ce4803 --- /dev/null +++ b/MaterialLib/Fluid/Density/LinearConcentrationAndPressureDependentDensity.h @@ -0,0 +1,111 @@ +/** + * @copyright + * Copyright (c) 2012-2018, OpenGeoSys Community (http://www.opengeosys.org) + * Distributed under a Modified BSD License. + * See accompanying file LICENSE.txt or + * http://www.opengeosys.org/project/license + * + */ + +#pragma once + +#include <string> + +#include "BaseLib/ConfigTree.h" + +#include "MaterialLib/Fluid/FluidProperty.h" + +namespace MaterialLib +{ +namespace Fluid +{ +/// Linear concentration dependent density model. +/// \f[ \varrho = \varrho_{\text{ref}} +/// (1 + \bar \alpha (C - C_{\text{ref}}) + \bar \beta (p - p_{\text{ref}}) ) +/// \f] where +/// - \f$ \varrho_{\text{ref}}\f$ is the reference density +/// - \f$ \bar \alpha\f$ is the fluid density concentration difference ratio +/// - \f$ C_{\text{ref}}\f$ is the reference concentration +/// - \f$ \bar \beta\f$ is the fluid density pressure difference ratio +/// - \f$ p_{\text{ref}}\f$ is the reference pressure +class LinearConcentrationAndPressureDependentDensity final + : public FluidProperty +{ +public: + /** + * @param reference_density \f$\rho_0\f$ + * @param reference_concentration \f$C_0\f$ + * @param fluid_density_concentration_difference_ratio \f$ \bar \alpha \f$ + * in reference + * @param reference_pressure \f$p_0\f$ + * @param fluid_density_pressure_difference_ratio \f$ \bar \beta \f$ in + * reference Coupled groundwater flow and transport: 2. Thermohaline and 3D + * convection systems + */ + explicit LinearConcentrationAndPressureDependentDensity( + const double reference_density, double reference_concentration, + const double fluid_density_concentration_difference_ratio, + double reference_pressure, + const double fluid_density_pressure_difference_ratio) + : _reference_density(reference_density), + _reference_concentration(reference_concentration), + _fluid_density_concentration_difference_ratio( + fluid_density_concentration_difference_ratio), + _reference_pressure(reference_pressure), + _fluid_density_pressure_difference_ratio( + fluid_density_pressure_difference_ratio) + { + } + + /// Get model name. + std::string getName() const override + { + return "Linear concentration and pressure dependent density"; + } + + /// Get density value. + /// \param var_vals Variable values in an array. The order of its elements + /// is given in enum class PropertyVariableType. + double getValue(const ArrayType& var_vals) const override + { + const double C = var_vals[static_cast<int>(PropertyVariableType::C)]; + const double p = var_vals[static_cast<int>(PropertyVariableType::p)]; + return _reference_density * + (1 + + _fluid_density_concentration_difference_ratio * + (C - _reference_concentration) + + _fluid_density_pressure_difference_ratio * + (p - _reference_pressure)); + } + + /// Get the partial differential of the density with respect to + /// concentration or pressure. + double getdValue(const ArrayType& /*var_vals*/, + const PropertyVariableType var) const override + { + if (var == PropertyVariableType::C) + { + return _reference_density * + _fluid_density_concentration_difference_ratio; + } + else if (var == PropertyVariableType::p) + { + return _reference_density * + _fluid_density_pressure_difference_ratio; + } + else + { + return 0; + } + } + +private: + const double _reference_density; + const double _reference_concentration; + const double _fluid_density_concentration_difference_ratio; + const double _reference_pressure; + const double _fluid_density_pressure_difference_ratio; +}; + +} // namespace Fluid +} // namespace MaterialLib diff --git a/ProcessLib/ComponentTransport/ComponentTransportFEM.h b/ProcessLib/ComponentTransport/ComponentTransportFEM.h index 7cc951be4b1ae4d7568bdc6dc849feba6c7722d4..0558f4f3941c717d9d74f0e6ff1a1a78832fcbc7 100644 --- a/ProcessLib/ComponentTransport/ComponentTransportFEM.h +++ b/ProcessLib/ComponentTransport/ComponentTransportFEM.h @@ -12,7 +12,6 @@ #include <Eigen/Dense> #include <vector> - #include "ComponentTransportProcessData.h" #include "MaterialLib/Fluid/FluidProperties/FluidProperties.h" #include "MathLib/LinAlg/Eigen/EigenMapTools.h" @@ -141,7 +140,8 @@ public: auto const num_nodes = ShapeFunction::NPOINTS; auto p_nodal_values = Eigen::Map<const NodalVectorType>(&local_x[num_nodes], num_nodes); - + auto C_nodal_values = + Eigen::Map<const NodalVectorType>(&local_x[0], num_nodes); auto const& b = _process_data.specific_body_force; MaterialLib::Fluid::FluidProperty::ArrayType vars; @@ -151,21 +151,18 @@ public: auto KCC = local_K.template block<num_nodes, num_nodes>(0, 0); auto MCC = local_M.template block<num_nodes, num_nodes>(0, 0); + auto MCp = local_M.template block<num_nodes, num_nodes>(0, num_nodes); auto Kpp = local_K.template block<num_nodes, num_nodes>(num_nodes, num_nodes); auto Mpp = local_M.template block<num_nodes, num_nodes>(num_nodes, num_nodes); + auto MpC = local_M.template block<num_nodes, num_nodes>(num_nodes, 0); auto Bp = local_b.template block<num_nodes, 1>(num_nodes, 0); for (std::size_t ip(0); ip < n_integration_points; ++ip) { pos.setIntegrationPoint(ip); - // \todo the argument to getValue() has to be changed for non - // constant storage model - auto const specific_storage = - _process_data.porous_media_properties.getSpecificStorage(t, pos) - .getValue(0.0); auto const& ip_data = _ip_data[ip]; auto const& N = ip_data.N; @@ -177,7 +174,6 @@ public: // Order matters: First C, then p! NumLib::shapeFunctionInterpolate(local_x, N, C_int_pt, p_int_pt); - // \todo the first argument has to be changed for non constant // porosity model auto const porosity = _process_data.porous_media_properties.getPorosity(t, pos) @@ -210,13 +206,21 @@ public: MaterialLib::Fluid::FluidPropertyType::Viscosity, vars); GlobalDimMatrixType const K_over_mu = K / mu; - GlobalDimVectorType const velocity = _process_data.has_gravity ? GlobalDimVectorType(-K_over_mu * (dNdx * p_nodal_values - density * b)) : GlobalDimVectorType(-K_over_mu * dNdx * p_nodal_values); + const double drho_dp = _process_data.fluid_properties->getdValue( + MaterialLib::Fluid::FluidPropertyType::Density, + vars, + MaterialLib::Fluid::PropertyVariableType::p); + + const double drho_dC = _process_data.fluid_properties->getdValue( + MaterialLib::Fluid::FluidPropertyType::Density, + vars, + MaterialLib::Fluid::PropertyVariableType::C); double const velocity_magnitude = velocity.norm(); GlobalDimMatrixType const hydrodynamic_dispersion = velocity_magnitude != 0.0 @@ -236,20 +240,25 @@ public: I); // matrix assembly + MCp.noalias() += w * N.transpose() * N * C_nodal_values * + retardation_factor * porosity * drho_dp * N; + MCC.noalias() += w * N.transpose() * retardation_factor * porosity * + density * N + + w * N.transpose() * retardation_factor * porosity * + N * C_nodal_values * drho_dC * N; + KCC.noalias() += - (dNdx.transpose() * hydrodynamic_dispersion * dNdx + - N.transpose() * velocity.transpose() * dNdx + + (-dNdx.transpose() * velocity * density * N + + dNdx.transpose() * density * hydrodynamic_dispersion * dNdx + N.transpose() * decay_rate * porosity * retardation_factor * - N) * + density * N) * w; - MCC.noalias() += - w * N.transpose() * porosity * retardation_factor * N; - Kpp.noalias() += w * dNdx.transpose() * K_over_mu * dNdx; - Mpp.noalias() += w * N.transpose() * specific_storage * N; + + Mpp.noalias() += w * N.transpose() * porosity * drho_dp * N; + MpC.noalias() += w * N.transpose() * porosity * drho_dC * N; + Kpp.noalias() += w * dNdx.transpose() * density * K_over_mu * dNdx; if (_process_data.has_gravity) - Bp += w * density * dNdx.transpose() * K_over_mu * b; - /* with Oberbeck-Boussing assumption density difference only exists - * in buoyancy effects */ + Bp += w * density * density * dNdx.transpose() * K_over_mu * b; } } @@ -275,9 +284,9 @@ public: pos.setElementID(_element.getID()); MaterialLib::Fluid::FluidProperty::ArrayType vars; - - auto const p_nodal_values = Eigen::Map<const NodalVectorType>( - &local_x[ShapeFunction::NPOINTS], ShapeFunction::NPOINTS); + auto const num_nodes = ShapeFunction::NPOINTS; + auto const p_nodal_values = + Eigen::Map<const NodalVectorType>(&local_x[num_nodes], num_nodes); for (unsigned ip = 0; ip < n_integration_points; ++ip) { diff --git a/ProcessLib/ComponentTransport/ComponentTransportProcess.h b/ProcessLib/ComponentTransport/ComponentTransportProcess.h index 0a883ad38dfed07a5d217610568916b4b551b59d..03dbc62af4e5fd04c97735febb1cc9c5e9dc4085 100644 --- a/ProcessLib/ComponentTransport/ComponentTransportProcess.h +++ b/ProcessLib/ComponentTransport/ComponentTransportProcess.h @@ -25,11 +25,17 @@ namespace ComponentTransport * * The flow process is described by * \f[ - * S \frac{\partial p}{\partial t} - * - \nabla \cdot \left[\frac{\kappa}{\mu(C)} \nabla \left( p + \rho g z \right)\right] - * - Q_p = 0, + * \phi \frac{\partial \rho}{\partial p} \frac{\partial p}{\partial t} + * + \phi \frac{\partial \rho}{\partial C} \frac{\partial C}{\partial t} + * - \nabla \cdot \left[\frac{\kappa}{\mu(C)} \rho \nabla \left( p + \rho g + * z \right)\right] + * + Q_p = 0, * \f] - * where \f$S\f$ is the storage, \f$p\f$ is the pressure, + * where the storage \f$S\f$ has been substituted by + * \f$\phi \frac{\partial \rho}{\partial p}\f$, + * \f$\phi\f$ is the porosity, + * \f$C\f$ is the concentration, + * \f$p\f$ is the pressure, * \f$\kappa\f$ is permeability, * \f$\mu\f$ is viscosity of the fluid, * \f$\rho\f$ is the density of the fluid, and @@ -37,14 +43,17 @@ namespace ComponentTransport * * The mass transport process is described by * \f[ - * \phi R \frac{\partial C}{\partial t} - + \nabla \cdot \left(\vec{q} C - D \nabla C \right) - + \phi R \vartheta C - Q_C = 0 + * \phi R C \frac{\partial \rho}{\partial p} \frac{\partial p}{\partial t} + * + \phi R \left(\rho + C \frac{\partial \rho}{\partial C}\right) + * \frac{\partial C}{\partial t} + * - \nabla \cdot \left[\frac{\kappa}{\mu(C)} \rho C \nabla \left( p + \rho + * g z \right) + * + \rho D \nabla C\right] + * + Q_C + R \vartheta \phi \rho C = 0, + * * \f] - * where \f$\phi\f$ is the porosity, - * \f$R\f$ is the retardation factor, - * \f$C\f$ is the concentration, - * \f$\vec{q} = \frac{\kappa}{\mu(C)} \nabla \left( p + \rho g z \right)\f$ + * where \f$R\f$ is the retardation factor, + * \f$\vec{q} = -\frac{\kappa}{\mu(C)} \nabla \left( p + \rho g z \right)\f$ * is the Darcy velocity, * \f$D\f$ is the hydrodynamic dispersion tensor, * \f$\vartheta\f$ is the decay rate. @@ -70,9 +79,9 @@ namespace ComponentTransport * flow couples the H process to the C process. * * \note At the moment there is not any coupling by source or sink terms, i.e., - * the coupling is implemented only by density changes due to concentration - * changes in the buoyance term in the groundwater flow. This coupling schema is - * referred to as the Boussinesq approximation. + * the coupling is implemented only by density and viscosity changes due to + * concentration changes as well as by the temporal derivatives of each + * variable. * */ class ComponentTransportProcess final : public Process { diff --git a/ProcessLib/ComponentTransport/Tests.cmake b/ProcessLib/ComponentTransport/Tests.cmake index 89070f85d7119bed5fb146d0ec8646c7934390bd..45229b6f3dc1fa9cd97be08070dd253cd15b2e7a 100644 --- a/ProcessLib/ComponentTransport/Tests.cmake +++ b/ProcessLib/ComponentTransport/Tests.cmake @@ -73,28 +73,25 @@ AddTest( TESTER vtkdiff REQUIREMENTS NOT OGS_USE_MPI DIFF_DATA - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000.vtu concentration concentration 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000.vtu pressure pressure 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 - VIS DiffusionAndStorageAndAdvection_pcs_0_ts_672_t_900.000000.vtu + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000.vtu concentration concentration 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000.vtu concentration concentration 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000.vtu concentration concentration 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000.vtu concentration concentration 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000.vtu concentration concentration 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000.vtu concentration concentration 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000.vtu pressure pressure 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000.vtu pressure pressure 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000.vtu pressure pressure 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000.vtu pressure pressure 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000.vtu pressure pressure 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000.vtu pressure pressure 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 + DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000_expected.vtu DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000.vtu darcy_velocity darcy_velocity 1e-5 1e-10 + VIS DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000.vtu ) AddTest( @@ -203,7 +200,7 @@ AddTest( EXECUTABLE_ARGS goswami_input.prj WRAPPER time TESTER vtkdiff - REQUIREMENTS NOT OGS_USE_MPI + REQUIREMENTS NOT OGS_USE_MPI AND DISABLE_GOSWAMI_UNTIL_CONSTRAINED_NEUMANN_BC DIFF_DATA ComponentTransport_pcs_0_ts_100_t_150.000000_expected.vtu ComponentTransport_pcs_0_ts_100_t_150.000000.vtu concentration concentration 1e-1 1e-5 ComponentTransport_pcs_0_ts_150_t_350.000000_expected.vtu ComponentTransport_pcs_0_ts_150_t_350.000000.vtu concentration concentration 1e-1 1e-5 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionAndStorage.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionAndStorage.prj index 3ab04541b70b6a5d5229188c3a0ca01ad09cd68d..db469defe0cfba30f873592851f9e46a89fd5154 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionAndStorage.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionAndStorage.prj @@ -13,10 +13,12 @@ </process_variables> <fluid> <density> - <type>ConcentrationDependent</type> + <type>ConcentrationAndPressureDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>0.026</fluid_density_difference_ratio> + <fluid_density_concentration_difference_ratio>0.0</fluid_density_concentration_difference_ratio> + <reference_pressure>0</reference_pressure> + <fluid_density_pressure_difference_ratio>5e-5</fluid_density_pressure_difference_ratio> </density> <viscosity> <type>Constant</type> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionOnly.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionOnly.prj index d4f8b1f7d5c29f69efa6f65eace46191a9feb907..39a9188f886c8b1baec774964dec671977e5ef58 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionOnly.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/ConcentrationDiffusionOnly.prj @@ -16,7 +16,7 @@ <type>ConcentrationDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>0.026</fluid_density_difference_ratio> + <fluid_density_difference_ratio>0.0</fluid_density_difference_ratio> </density> <viscosity> <type>Constant</type> @@ -49,7 +49,7 @@ </porosity> <storage> <type>Constant</type> - <value>1e-5</value> + <value>0</value> </storage> </porous_medium> </porous_medium> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection.prj index 0f299d664380d98d8a699f82fceee768f6894afd..d54a873821cc1b74be60914d8832064e14edcde0 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection.prj @@ -13,10 +13,12 @@ </process_variables> <fluid> <density> - <type>ConcentrationDependent</type> + <type>ConcentrationAndPressureDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>0.026</fluid_density_difference_ratio> + <fluid_density_concentration_difference_ratio>0.026</fluid_density_concentration_difference_ratio> + <reference_pressure>0.5</reference_pressure> + <fluid_density_pressure_difference_ratio>5e-5</fluid_density_pressure_difference_ratio> </density> <viscosity> <type>Constant</type> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay.prj index 8e3ac9f7863d77026d058a52ebd8b1890fc7d4b4..a021f66df7856b975eb2b3df0e8f7150d08adbab 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay.prj @@ -13,10 +13,12 @@ </process_variables> <fluid> <density> - <type>ConcentrationDependent</type> + <type>ConcentrationAndPressureDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>0.026</fluid_density_difference_ratio> + <fluid_density_concentration_difference_ratio>0.026</fluid_density_concentration_difference_ratio> + <reference_pressure>0.5</reference_pressure> + <fluid_density_pressure_difference_ratio>2e-5</fluid_density_pressure_difference_ratio> </density> <viscosity> <type>Constant</type> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_100_t_5.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_100_t_5.700000_expected.vtu index 3d76e61e066d6ebfcbe2bb2c199a5ca95810bdf4..d696a0c53b78347bf1095ae8e03e97bf13145194 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_100_t_5.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_100_t_5.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:df4bf86f57126afecb966991c4a1f46e6c6e281c551c05e38274a16ef7464839 -size 119559 +oid sha256:46eac28bb8072e66cb359bf4667aae46675bc5621b83fe6357a65595b61e0dea +size 58091 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_200_t_35.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_200_t_35.700000_expected.vtu index b56f7c759d4980742234cc14457a9154e1ebdd57..924c9bed4fb4d686dd6d6b029cfcaf213ebb3cd7 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_200_t_35.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_200_t_35.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:49368646f182fe66f91a6ac8b7019b185cad72158d6c8d27cddcdb911a68ca0b -size 119553 +oid sha256:70e95df17cff13e450cc2261c77309dcc84c22194f48c2694820c82288a15db9 +size 56735 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_300_t_155.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_300_t_155.700000_expected.vtu index e0381ab2bd278303f1c98010201d616fefdf2bb2..0966da6d13d45a396987cf2de4efa4923202859f 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_300_t_155.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_300_t_155.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:8be213ec2cdb3871e2a839e8a5444eaaf6070ac21e111ca26edac5b123a518e9 -size 118894 +oid sha256:2c69f730540b631fe9dfd74ad0f8b9183626ea8b76c47b18c8e3ece0cad8fd02 +size 56397 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_400_t_315.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_400_t_315.700000_expected.vtu index b16a825ebec754d1064db134a32cb312d7760002..f1d2fbc09345a43ae40f788b4345b1796f3ba80b 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_400_t_315.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_400_t_315.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:d527850d510f3a0f79ff931b19f4c4388d1fc719f7dc3e6c3dbb7efc6ee49035 -size 118267 +oid sha256:6bba6cdd770c5a87b78eea4cb697d4c41788bcfa1b49851dab089e252a26005b +size 53861 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_500_t_495.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_500_t_495.700000_expected.vtu index 103cbd2a24c9cc68518b330469be7439844b09b2..dcf81bdd3a2b234d966c50611cdcc36e7e06fc03 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_500_t_495.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_500_t_495.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:6355c17b2179e95db47582616c654729d9d6960948911e24184cab75543255d5 -size 117809 +oid sha256:0884092f64ff498415e5bf0d741393c4ad0da5f4e0c98b7ff554da713690ed70 +size 54313 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_600_t_720.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_600_t_720.700000_expected.vtu index f7319622b0ea2cf82bac2b0381a14da4597e105c..be1b910ec1bc65c0b07c19339f7f0c7c90715981 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_600_t_720.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_600_t_720.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:ef450681ef089b1eb3e34f3553d468cde624a19acc270ada97bbedb6d26cb558 -size 117054 +oid sha256:3e5d03820aacab2084223a7c4a3039ff122dbe54d64dec26bc35fbfcc376c159 +size 53769 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_672_t_900.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_672_t_900.000000_expected.vtu index 7aaa4948bbbf093233b0f8559eeba011ec1042b8..a03d1d4eab2416001b0d6249dcb4c18b4ba7ece4 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_672_t_900.000000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay_pcs_0_ts_672_t_900.000000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:592797e357d00e5963bbe8bf938bcc3d2da7abeaf7ff56a5a910c3e5345b1adb -size 116662 +oid sha256:11d351fbaed6023a84d732fbd48d7e2793950f8b1239b8b3ef77ec9b8569d3be +size 53001 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion.prj index b8e1db59ab12ea94a6ba34ab78e9ca75dc17ad02..779fac245bde891d303dd1a671a9a06748b05f5e 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion.prj @@ -13,10 +13,12 @@ </process_variables> <fluid> <density> - <type>ConcentrationDependent</type> + <type>ConcentrationAndPressureDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>0.026</fluid_density_difference_ratio> + <fluid_density_concentration_difference_ratio>0.026</fluid_density_concentration_difference_ratio> + <reference_pressure>0.5</reference_pressure> + <fluid_density_pressure_difference_ratio>2e-5</fluid_density_pressure_difference_ratio> </density> <viscosity> <type>Constant</type> @@ -263,7 +265,7 @@ <nonlinear_solver> <name>basic_picard</name> <type>Picard</type> - <max_iter>10</max_iter> + <max_iter>100</max_iter> <linear_solver>general_linear_solver</linear_solver> </nonlinear_solver> </nonlinear_solvers> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf.prj index 3aea08413e3a06e3f4fb0b99f06873f7348e76cb..6e09f439250d9d9f2113a448329c5288845516a9 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf.prj @@ -13,10 +13,12 @@ </process_variables> <fluid> <density> - <type>ConcentrationDependent</type> + <type>ConcentrationAndPressureDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>0.026</fluid_density_difference_ratio> + <fluid_density_concentration_difference_ratio>.026</fluid_density_concentration_difference_ratio> + <reference_pressure>0</reference_pressure> + <fluid_density_pressure_difference_ratio>5e-5</fluid_density_pressure_difference_ratio> </density> <viscosity> <type>Constant</type> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu index 9d8c3a032cbca8203f8f8da6180dcf2c6c7d3376..920b74fd843f837b5d90d99e2e4a00bdbc5b85bb 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:07a257994c89c2e5ea0d24b1e0dc71e9e3ce381857e69ca4d29a4a23ae945bd6 -size 119584 +oid sha256:8a39aa3b78a580e41b057761453b49bc413642e3a083de9a7b4a049147638e94 +size 67028 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu index da567f5602e35a20c7f1ff04796835f70a7ac18a..06a6eb1d8c35e722eb047efdeed7f2f0cd25baab 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:1c27b97dfe0e4b8bea236b307fa5f983351c7944ae8c9eec4ec33f3ec428f81b -size 118570 +oid sha256:4e6d974e125d4c5ee7176dcacfd616c570225df5864f2d5bb0db33905da7ba23 +size 66653 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu index f79da8a2c20b7076df6480149b75f5e994d0fcfb..a6dc30660b00759dbe47d2bbf6716b4c1a5062d2 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:7d90d466fb0250a42f865b9672c8ca49924e1a65df972691ce9ebc3c03788bcb -size 117171 +oid sha256:680b5f42cdc67fc7a91d3e4ed54af8f4571617c160e2b237e8632b62633d92c5 +size 65881 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu index 4954da8e1bbaea40cab57702d0875f7345c78a48..a4d326129c2a4fb8d26d2be5d2291ae90231bc47 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:2e2e955caa1c7372b4451abd7275e6469767dc5d91fdf42ba24b52380d442387 -size 116742 +oid sha256:97054bc690271781d821522f41fc69e7c70f6f8a6f235725377dd2c6b8aeacfe +size 65156 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu index ea934047f9c56900e7a32f21cb6ed119c62dfeed..f377c252cec8424ad8f3128cb785e7ce247088d2 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:5a3cd7f47b6279f8c8f0fc1c0d22c7e9edd5a32353cb76f05931975f1579efc4 -size 116643 +oid sha256:25671ac842ec3b7b50ad1f0d9e6f71253acea9e2fac5f36ecaa9b7dcdb7f2d5c +size 65665 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu index 218a60cd0d403ebb6249653255d420bd5de597d3..b3b8c861b7e0443331a64a52aa840e05ebbad580 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:31e51df82e18f55deda67ff693c984a01f3f6080d18dfe724b7eb5839d4d269a -size 116499 +oid sha256:5abf84b39b7acca8be4126f09a42b8fd9a2a3babfa1a2cd3d04cafbd5e8b7fd1 +size 65769 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu index 6b61b8e65ad5eb61adb3d28012da43fc5ddcef0e..aeb5a112e904efee7de103d3b4dd950ddbad2dad 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:ec4cb6be7b4123b8a97cf9973cb541ddab148876f8b80b2bd630b83ff664c852 -size 116572 +oid sha256:0639a37d2a31ba9bf1cb6908e2bc856fb9bb6c622aadf511c510c6f696e858c1 +size 65777 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_100_t_5.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_100_t_5.700000_expected.vtu index a3d91803df12f88c5de8d86dee1c9944a444dca9..7e36ded1eefe119b584b806dc1621482d7022315 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_100_t_5.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_100_t_5.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:3b63c9dc6902604ff81394cf978531d2d98dba728f78eb84d35b6fb138712a30 -size 118934 +oid sha256:70a66b12e1c6c2f8474f8944a349ef3bbee5e1458b0bbbcb87eb46e169d068c4 +size 56469 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_200_t_35.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_200_t_35.700000_expected.vtu index 94fa758125acbdb62acc37561b8a6a68924dab31..ca7d6e88e101015cdfe913ad03f8a7299e1ecd50 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_200_t_35.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_200_t_35.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:4d63f98cd58ecf62387026a251147b4aed5bed822832dcb75117f36c71e25f2c -size 117493 +oid sha256:0eeb6b13b70c36d430045c89c152c56c75c4f2ec992a2c3350cbd50f2a1afa54 +size 55685 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_300_t_155.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_300_t_155.700000_expected.vtu index be0d87f380a16b6fb0382172cbfb74d9240837de..8d031ef74d46118bc5c494ab2aaf5a7912fe2d93 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_300_t_155.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_300_t_155.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:d95bc16f04f59557c5ad256f1c625cde620b8861919975c3c7b7e597ab4fb142 -size 116284 +oid sha256:270fed3dbf91215e3de5e98ac6a550790e22a3e5c8a9f52b4a05ca91f60c6b50 +size 55525 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_400_t_315.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_400_t_315.700000_expected.vtu index a4367ff13d5656e52884020af47223cd12d008d4..07c01bb6210b6229f3665c707b2b2e282c4e3e68 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_400_t_315.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_400_t_315.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:5f3e9d9e169839502a0bc3895af5fce88952e59f4fd2a55186bba73a4733a376 -size 116200 +oid sha256:c5be3e441dc61457590ce71bda211ffb893c7e4bcb6353587610ec535a3ae9bc +size 54945 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_500_t_495.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_500_t_495.700000_expected.vtu index d0db67729c15583c828b4a25209a34a0be7a8c57..94549dd00779232f32c8c08aab32afaa4f62945d 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_500_t_495.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_500_t_495.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:978992197f6225ce214d23303fb03d04eb868fa2bd153b479eff438fa91379f2 -size 116122 +oid sha256:821148cd7bcceaa5a7a9738550d0ae401d5b49f22382421dfba5f4864de5771e +size 54325 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_600_t_720.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_600_t_720.700000_expected.vtu index 9a398ab67117f32c729e606c7def11b47974354b..8e44205f75cd29e6eaa175bcf072af21a31da9d6 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_600_t_720.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_600_t_720.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:7bdb267e725753e589b07cc482a99889f2d4cd05ff10cdb4015e2736b38cfa33 -size 116111 +oid sha256:534e10c445a11b43bdcd774fc26bb5cc98233d1a65dd27aba19a00efbf3f7b69 +size 52985 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_672_t_900.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_672_t_900.000000_expected.vtu index aa0b47a95b0557c9827c3377c30135216964adf6..46d90189d57ee80f907f6ed2d1acf27596826184 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_672_t_900.000000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDispersion_pcs_0_ts_672_t_900.000000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:148e98b4fb9f4adcfdbb87480ed424b066a9593109d9d171c895ec06dc31d49a -size 116300 +oid sha256:7d1f0d0b2a341a1871aebbf80100c20a01eff71cf7c24532ae95a8134002fb37 +size 56605 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_100_t_5.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_100_t_5.700000_expected.vtu index 498b118e75076268cb9022e9b9864efd6e82d105..820656ded71dc0005e7255ad9d4611c51116a2bd 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_100_t_5.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_100_t_5.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:cadfe8e09f70326f72eb292541d3aacf91c8699caa34171c4b371831d2e509c2 -size 119494 +oid sha256:77dac58be8d2f5231db87cf647d3bc15dfe2a0e14dc8e6eab286b0f3b1f1a821 +size 58159 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_200_t_35.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_200_t_35.700000_expected.vtu index 9b4f49e03fbb0cd3d167ff34e64c0e991b3995e5..d1267a454b94798d697d647a3a883c74c77fd92f 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_200_t_35.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_200_t_35.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:ab44a18f01af03e65d117cee2099039015f1d6022596f6a45188fde288276540 -size 119415 +oid sha256:884c4f54e889f2942fedb2f10ed23aaaf14c6f414614ff1d03485c21f6d01459 +size 56725 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_300_t_155.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_300_t_155.700000_expected.vtu index 10425c9d75fb88826dfba3715fad94a74acd6814..ed2240d072889d2f44820383b26809acfda91444 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_300_t_155.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_300_t_155.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:af5e3c30b69d9b5ffee73f29189eade559aa1ae9bfad060e0b031c30e4a15469 -size 118912 +oid sha256:88d498aff8a803e0bfcefd434e230fc485c900236fed65011328a51573172168 +size 56505 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_400_t_315.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_400_t_315.700000_expected.vtu index 92bb3300cce921135a57bad5facd813ab7bb3957..c3ffc1c773f5c7348b41f0ce7daa66b45821610f 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_400_t_315.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_400_t_315.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:0d5e7e4ddd2173eed858e507110719f2229c2d13dc49f4cfc9d09113db41adb0 -size 118277 +oid sha256:90b6c4a48954f0a2f9e56249edeeb2b951fc7536987bbbe7beb53ef398a2a4c3 +size 54125 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_500_t_495.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_500_t_495.700000_expected.vtu index e03cd7baeb9fd1f5e107ed6f89cb8b43d99d1aeb..eaa44e1544e2e9b9d62f956f2bf538d3141a5984 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_500_t_495.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_500_t_495.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:dca7c122a7d7cc6066a11c5299baa9f91083f7dc7478e3a33468dc95c115a36a -size 117548 +oid sha256:9c7d7c0fd5265b5dba45615c0a48f340ae3143ac69c688a13efd275618de9ca1 +size 54772 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_600_t_720.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_600_t_720.700000_expected.vtu index 200c68b1468c929ac028a4a59070aeb1925f3dca..f1a081d93331a8957fc3384515927cad94c7597f 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_600_t_720.700000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_600_t_720.700000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:2564eab4aff6f416c63658036f6e42c721a69930d82f20fa746bd2603c2bf206 -size 117020 +oid sha256:b5027b9614d6c77838dac5d04ac935180c8fa68246ad1f1ae3e4a3f11d57951f +size 54449 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_672_t_900.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_672_t_900.000000_expected.vtu index 37f5af6005a83989c227962e3afe5d47146bde5b..a2c238ebd2cf07ed8ea6d0fda0d38f9ecd9574b5 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_672_t_900.000000_expected.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvection_pcs_0_ts_672_t_900.000000_expected.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:6613aa2cb5ef7bfe5a7ba18f15f7ea8851060eb70a9fbfb374a82a8a173f9506 -size 116413 +oid sha256:e875126556f175ed8a8612e56d9087c56fd7cd205de9e5c6056dc0c975a3feec +size 53876 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf.prj b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf.prj index ffeb5e345846c5927bc484a0c7376ad540bcd498..adb2279e56259439a4b339d5fefb78d58fd7a87a 100644 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf.prj +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf.prj @@ -13,10 +13,12 @@ </process_variables> <fluid> <density> - <type>ConcentrationDependent</type> + <type>ConcentrationAndPressureDependent</type> <reference_density>1</reference_density> <reference_concentration>0</reference_concentration> - <fluid_density_difference_ratio>1</fluid_density_difference_ratio> + <fluid_density_concentration_difference_ratio>1</fluid_density_concentration_difference_ratio> + <reference_pressure>0</reference_pressure> + <fluid_density_pressure_difference_ratio>5e-5</fluid_density_pressure_difference_ratio> </density> <viscosity> <type>Constant</type> @@ -87,43 +89,15 @@ <time_stepping> <type>FixedTimeStepping</type> <t_initial> 0.0 </t_initial> - <t_end> 9e2 </t_end> + <t_end> 15e3 </t_end> <timesteps> <pair> - <repeat>10</repeat> - <delta_t>1e-2</delta_t> - </pair> - <pair> - <repeat>40</repeat> - <delta_t>4e-2</delta_t> - </pair> - <pair> - <repeat>50</repeat> - <delta_t>8e-2</delta_t> - </pair> - <pair> - <repeat>50</repeat> - <delta_t>2e-1</delta_t> - </pair> - <pair> - <repeat>50</repeat> - <delta_t>4e-1</delta_t> - </pair> - <pair> - <repeat>50</repeat> - <delta_t>8e-1</delta_t> - </pair> - <pair> - <repeat>200</repeat> - <delta_t>16e-1</delta_t> - </pair> - <pair> - <repeat>100</repeat> - <delta_t>20e-1</delta_t> + <repeat>1000</repeat> + <delta_t>25e-1</delta_t> </pair> <pair> - <repeat>500</repeat> - <delta_t>25e-1</delta_t> + <repeat>1000</repeat> + <delta_t>25e0</delta_t> </pair> </timesteps> </time_stepping> @@ -133,6 +107,10 @@ <type>VTK</type> <prefix>DiffusionAndStorageAndGravityAndDispersionHalf</prefix> <timesteps> + <pair> + <repeat>1</repeat> + <each_steps>1000</each_steps> + </pair> <pair> <repeat>1</repeat> <each_steps>100</each_steps> @@ -192,9 +170,9 @@ <value>0</value> </parameter> <parameter> - <name>c_Dirichlet_left</name> + <name>c_Neumann_left</name> <type>Constant</type> - <value>1</value> + <value>1e-6</value> </parameter> <parameter> <name>c_Dirichlet_right</name> @@ -227,8 +205,8 @@ <boundary_condition> <geometrical_set>geometry</geometrical_set> <geometry>left_half</geometry> - <type>Dirichlet</type> - <parameter>c_Dirichlet_left</parameter> + <type>Neumann</type> + <parameter>c_Neumann_left</parameter> </boundary_condition> <boundary_condition> <geometrical_set>geometry</geometrical_set> diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000_expected.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9cf14a9a882afa0fcb4135b2c2bce89b0683197a --- /dev/null +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1000_t_2500.000000_expected.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:40d8d7fcf4a4f65af2cc64ff0bd883edaabba407ea964f13cb8569acbf67df40 +size 67774 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu deleted file mode 100644 index 196756876a40c401e3208e9a6c0a97886ca37af6..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_100_t_5.700000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:2e62275214ba7128020c7de581ae026798f8be2ddcaa840c1eda31b47129b6fd -size 135481 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000_expected.vtu new file mode 100644 index 0000000000000000000000000000000000000000..d789948bc3b3966e22456e5e561dd74c23523a45 --- /dev/null +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1100_t_5000.000000_expected.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:437deac2f5703a1a611897fc91ae6e4b8497a88475ce2c41849bcf13f5544944 +size 67799 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000_expected.vtu new file mode 100644 index 0000000000000000000000000000000000000000..9244d84d213ad62b00353acc399a866acbaa949d --- /dev/null +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1200_t_7500.000000_expected.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:290cb719a64648512d7490d9696c1e93ed36aee68976831e2ac6f3bd5b86b2ab +size 67821 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000_expected.vtu new file mode 100644 index 0000000000000000000000000000000000000000..198822176ccc7c625cff1a727664d6ea748987d9 --- /dev/null +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1300_t_10000.000000_expected.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:66d24474e162a07d1cb32769df6417f7eb2bc8d455f73c1f99bc6631a57d11c8 +size 67856 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000_expected.vtu new file mode 100644 index 0000000000000000000000000000000000000000..40269c61c581431dc7896173099fd3cb18da8ca8 --- /dev/null +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1400_t_12500.000000_expected.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:7532bfa5f0301adf10159fdd38637c6e178773ffc99e868ee08380f57c9e6445 +size 67889 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000_expected.vtu new file mode 100644 index 0000000000000000000000000000000000000000..6bb06b82349004ae792e69cbe5b5f82022d8ddf6 --- /dev/null +++ b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_1500_t_15000.000000_expected.vtu @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:e80e57dffcf96677345388f25b8696f367ecb33b0d74add455290f9608aadc66 +size 67882 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu deleted file mode 100644 index 3f3711e3ea235c6d223e4946d9ec10b261db2d1c..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_200_t_35.700000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:3a7f56ef038a6c019a573113d7161c97be30ab8a667547fc46bf0e5f253fb33e -size 135278 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu deleted file mode 100644 index 81376e42bde4b475852b2c22404544a43d316542..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_300_t_155.700000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:4f05111e82372274cbf8448e032600cc774d610b982e566c1a71fc85b603bf05 -size 134619 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu deleted file mode 100644 index 8d7d5e08cbe7fec049bb48f95972a85b138ca4ec..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_400_t_315.700000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:61b72022de30a6cbc8191c21e190321e987b9d30344650953e9c3ddbb3b3187c -size 133999 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu deleted file mode 100644 index c13ead12ff1515040305ff73a03d11f7f3fecc4c..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_500_t_495.700000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:627c7f684e9274fd814cafe6924cebea9b96ae036724c4e56e5090b094049fba -size 133512 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu deleted file mode 100644 index 1dd098408b4ffcfd39ffad99bb430ff8f40e0423..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_600_t_720.700000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:67fe548d78b0e5c53b06a665c10b5d21df2fa89ec1d70017cd729d0273641f8a -size 133186 diff --git a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu b/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu deleted file mode 100644 index 56462914cf845549cc69473d7710a13a63285869..0000000000000000000000000000000000000000 --- a/Tests/Data/Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndGravityAndDispersionHalf_pcs_0_ts_672_t_900.000000_expected.vtu +++ /dev/null @@ -1,3 +0,0 @@ -version https://git-lfs.github.com/spec/v1 -oid sha256:3cc266f68f3a4d16c9f807a6c3a0c99b041f014d538023bc43ec50e1ae3c66b7 -size 132932 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_0_t_0.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_0_t_0.000000_reference.vtu index 7554fcdf672607b34181facd9cbe33342c17b958..84982c47c79cd947155113fcb418f803276637e0 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_0_t_0.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_0_t_0.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:0ec1770b288e718e3f18c610710d3bafc55088b4b09cfecd796c97681a689158 -size 436930 +oid sha256:59da4cbf7dd23d4947f7a4163fd2003caf1aa43d49443594f239f0fe6420ee65 +size 704729 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_100_t_26298000.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_100_t_26298000.000000_reference.vtu index 703e3600d1fc5de800916a8cf8b363106bb48ffd..d5e31865aae09024bfea0db50bb45c7f35078fcb 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_100_t_26298000.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_100_t_26298000.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:b813ac3b8a7057079dbfaef5ccdd7a300c6ab7b02acde193b58d501a305cb32e -size 838663 +oid sha256:85042a16555f884a27ff0358f09e470d1b0361905897dfc1bc950af9c99e5029 +size 914204 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_120_t_31557600.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_120_t_31557600.000000_reference.vtu index 88d0914eefc67ed82f364ac6c877dcaa86e120f7..7a162951dbb88bcd5d4aea871a0e8503e1ea4dce 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_120_t_31557600.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_120_t_31557600.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:366b94503cd97da443ebcafa666b28242312e534745aa6dfcb53f05716e1c24d -size 837308 +oid sha256:5c13555b26578b3f314ed8732f92da4c3f22465cffec337d567d83ce1738d4fe +size 914289 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_140_t_36817200.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_140_t_36817200.000000_reference.vtu index 967816b625a0b976257452221f8ebfa17dc5bd53..c0682695edc71f615b1d1d5081071517b61f74e9 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_140_t_36817200.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_140_t_36817200.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:6886fbace616af5f06d366f8435dbeeb3e5317d2c98ea0e337476405c943408d -size 840030 +oid sha256:0fed3567e44dbeddd826dbc779de69327f1ee0b2d56ca8eb04edc035400ff634 +size 913649 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_160_t_42076800.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_160_t_42076800.000000_reference.vtu index 79c81bb9d1e692dc48e82240d3429906ca8acf54..75f10b2cbdc3411d4b7e58d055618e419dc0612f 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_160_t_42076800.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_160_t_42076800.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:81c7a98a776418be8d18023e3a543c4c947819f1c9dd964fa646cc45d5986122 -size 837037 +oid sha256:6fa4a9ba24929c972c56457a5f06cb34d1f0f6cad0e0688fff456f3fc652278e +size 914185 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_180_t_47336400.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_180_t_47336400.000000_reference.vtu index f59f501d25d9b9d545ef02dc5ae1108d2e1569c8..647780945558c9384c5017574b2a3c22781cfe0c 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_180_t_47336400.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_180_t_47336400.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:a7146ae52d95d160067806800c5fa94eb46910c368322f453826be85ddb059d0 -size 834834 +oid sha256:29a8a3eed5932b715b7680b99bbe77534e5ab5e3a28a01cb1484c5d459f069ca +size 913217 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_200_t_52596000.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_200_t_52596000.000000_reference.vtu index d7751bec3abe55a3c2a3e1f5e8f0a19bd78ad907..6ee272dc76bb59468a8f52bcd69a1b3fa6d53ad9 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_200_t_52596000.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_200_t_52596000.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:077674e75533d9adbf415d2f70780f3fd3eb65dc987d216e5402cc7818c48f77 -size 836074 +oid sha256:4cd503a0d7272bc418762a36c59a132fec1e1556724bc212a4587aa09dcfa122 +size 913316 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_20_t_5259600.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_20_t_5259600.000000_reference.vtu index f45c4a07a7b275c1263ed1693a437ab43114d718..d8d8f7afaf814d8bc3c84f3cd6d32e03b948fcc4 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_20_t_5259600.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_20_t_5259600.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:9cdd541711936e87c26a77447228ede333c93a74cc767d6e5eb1fa723ec3c506 -size 872864 +oid sha256:be3546643e68f889679bbfb048de5a0fd24cfd6e56bacd14ebc34c1295bd7c5b +size 943331 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_220_t_57855600.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_220_t_57855600.000000_reference.vtu index 3ccd7a4c64d625ba2d6312ccc4f81736cbddd7ef..5f61f29c05d1f45cdc66f3fefbda391fce3e7e29 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_220_t_57855600.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_220_t_57855600.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:28fe4ce1a73d355a55941f1818ad356de6cf1bb99766d53069bf87cc88abda50 -size 832588 +oid sha256:859b8b8707ecb28db9b3a9d7decc63eef3afcabed04df3dcc172325cff51aefe +size 912204 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_240_t_63115200.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_240_t_63115200.000000_reference.vtu index 5ec251452c7c23fb949075f4af4c7cdf37bfae6b..d610cb536e26ec516338c634f31c951764521c79 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_240_t_63115200.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_240_t_63115200.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:a9fb890cc5beda3bd415ca959b9615ec473c75eb4cbd793d43ed6c871a0b09ed -size 832810 +oid sha256:ece1ad3a0d2486cfad0f43d7257e6b7347385ba664643202492522d6001a79d3 +size 912597 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_260_t_68374800.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_260_t_68374800.000000_reference.vtu index cc77f7600196be6b89dda57718358fc5e505a2f0..8ade33187dcefe6225fbfedabdcf90f5f47cb572 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_260_t_68374800.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_260_t_68374800.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:6220d8fed4b1e7cdab37fce1cf5bef8873d39db58544205e0ac5f7ed3da2a88b -size 832554 +oid sha256:de38588857b9079f07013cefb2907be722f736559e2797a00433a653a90c3bc0 +size 914721 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_280_t_73634400.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_280_t_73634400.000000_reference.vtu index 5460bf5fa003a414ac959437916b969cd94de15d..01ea8b72ebbde0c32bd14acc35e3da847a69ac0a 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_280_t_73634400.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_280_t_73634400.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:4bdddef09b73d269de48a8900c3550345451c7d216d299b4a240451fc2b258d7 -size 830914 +oid sha256:8b623df6858ffa23db296013d54c1b9083d81087e9742b4b9aa13ffa74bb3aea +size 913809 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_300_t_78894000.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_300_t_78894000.000000_reference.vtu index 83bd6c617b1386b5ffb10695cc53002d1ac41e38..12695b794f9b2d86912270d4fd372013b4a3ebe0 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_300_t_78894000.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_300_t_78894000.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:120ad42efa6cb24c9cbbd966e48f6042cb5230945da779000e28d8ee54ed1c9c -size 831359 +oid sha256:b21d8a573cb8b0cd5d3f3f8f2ce93c3b0db0685ca67a180bbd31b9d91ccf417a +size 911849 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_320_t_84153600.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_320_t_84153600.000000_reference.vtu index 7f63d3b5fbb6ad81ebc0b8a28cdc67749b8695f5..6bdd102819b9170e2b04218e531147089a764a81 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_320_t_84153600.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_320_t_84153600.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:c54396e9c290b176e52e1de5ea990de8a52945dd57953207d51022ac8962ee52 -size 830266 +oid sha256:f7a92b3325a252bbef4daac9ca31ee2617a84685a80164751e486d8031c25c71 +size 911888 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_340_t_89413200.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_340_t_89413200.000000_reference.vtu index 7ae03af2f8af8bb27f71d15f2c117e4882e201ab..5eb480f25c70c4a8e3dc8f37ead63f3b02c7f5a4 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_340_t_89413200.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_340_t_89413200.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:7424d59dcbcc1ad43b3ddee49912d6c09d458f5377e5b18c1e483ee90802de24 -size 830190 +oid sha256:fb68374ae7e1b4c13e4ef3f7629c0c1ee3be5a561d6277a9200043b89a410a6e +size 912133 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_360_t_94672800.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_360_t_94672800.000000_reference.vtu index 4a6e813281fa81ca453b40b7e52b208e43104e5e..a395a75199057dbe1ce58907716b0301a7be1f96 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_360_t_94672800.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_360_t_94672800.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:ebd5711c2be4179fc9a066f04ce741aa39cabacf93dbb20dca5543e3c5aea103 -size 829778 +oid sha256:c8d8101128470eb4069446058fb2bbe75d8b5cc449f5c0e0064fcefbe7c8d866 +size 910929 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_380_t_99932400.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_380_t_99932400.000000_reference.vtu index 1138450fcff474dfa0803f9db6f0d94d11d7a567..472f9e4c9bd0a1d16fdf0ff55315e66ad6832557 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_380_t_99932400.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_380_t_99932400.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:c8114bbfa00b7eaf2fe5c3fe89353f8793d43a73c8226eede0176e9e9ea51cfb -size 831528 +oid sha256:363e532da99367d80b2f7f1bbb7e9bc5b5a1d5a34f9b2400479b9974944dce99 +size 911115 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_400_t_105192000.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_400_t_105192000.000000_reference.vtu index 7472cd3975d0bb8c93248a27fcfe74044cfd2c02..d70925d6247da5cd4fb103b3973defa45885da9c 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_400_t_105192000.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_400_t_105192000.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:880d9d291c906196bd3436fa3f75510d622779002afd3677eb148b34b9c7a2fe -size 829305 +oid sha256:03967a21ad54041e1458e2b380108a584f4df577397355f76eae9e868c08eec8 +size 911993 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_40_t_10519200.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_40_t_10519200.000000_reference.vtu index 72017ea50745ad70299402d1e8802aa74d99d9b3..2a2b19be3544abc7dafd6a653f186db57a99bfe5 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_40_t_10519200.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_40_t_10519200.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:7fe4b4457ad8d8bc9c1f73a2a8738a6cdd488fd959ad19d0e948e615d45a94de -size 862063 +oid sha256:a78d2d482d1c77b9347a28a3a4c1486a01e6f59bce4b421e5c6147c98240b6eb +size 937295 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_420_t_110451600.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_420_t_110451600.000000_reference.vtu index 32c8cb0d34e7f6198e09d1145a000a46b5d63739..4c03c8c271af4676f49889147db6d6cbc78122e9 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_420_t_110451600.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_420_t_110451600.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:8f1858c57ca5156eab894552f4a6ca41b7634d88401b12933eb528bfb2f9d662 -size 829642 +oid sha256:073881599390078bb3b3261f7f6d5259a7e76be59f64480e3183ae713e95ce5d +size 912476 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_440_t_115711200.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_440_t_115711200.000000_reference.vtu index 1fb5e4a10203da1799259ce334b51735c61a2900..38d8e0926ef1acc9482f59e0df21a7a905cee46b 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_440_t_115711200.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_440_t_115711200.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:ef79ba9566e733cada9c4b9f89e5f72c956dbc6a698348802c9111a0a153b0cb -size 828945 +oid sha256:8f2509aafeb969235f2b5bbfebd7606e8eeb45db7cee0e4b1bb4ce8ed8ea8b50 +size 911287 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_460_t_120970800.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_460_t_120970800.000000_reference.vtu index 2018dfb0c89290bf912933084ec68d8eadc35efe..bea8d0af87e3cf64fed80633cbd82ba8169570ff 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_460_t_120970800.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_460_t_120970800.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:6960c3d289da4f2dca2f18630d0b00930ea78c083c5e72cbaa638a719b6ec1fa -size 831665 +oid sha256:0e3a87702b97755c9bbee23de60541647c895da9e915da40da30ed9ab9dafb8d +size 910724 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_480_t_126230400.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_480_t_126230400.000000_reference.vtu index 3411b710ee67a15d2f77c498b899b3bdfdd7c78c..ac7921a33870113c2de1b45c3477371f9cb7c042 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_480_t_126230400.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_480_t_126230400.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:9516b2c3889a8c5e5f5e77f1aa904d3be8866986f974a4d38728744294e3fa47 -size 829666 +oid sha256:697cbf188df58ab0041e86ee12131ee84f68e477a7652be865538a45d8578697 +size 911943 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_500_t_131490000.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_500_t_131490000.000000_reference.vtu index ac013ebd8eb6c3229c4cef69db2ce4ce21c6cd19..6d65e23af54c560507e95d550d28b25ea8d8dbbd 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_500_t_131490000.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_500_t_131490000.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:02ad90d3bdf18704cdfcc994720eeca86bb5198bc4f57ceae60a35c60e0ca1a4 -size 828718 +oid sha256:50a6aa05f1192d48ad5235b6a86193bbedadf85ab5d1964ca324efdbd744d558 +size 910716 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_60_t_15778800.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_60_t_15778800.000000_reference.vtu index 862cf3050f5aeb2c78cf09a1836e00fa437d116b..a47e5098daba539e683afb668a9e9a198076ccdb 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_60_t_15778800.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_60_t_15778800.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:5e3730dcf77f39fb89633ce69c26ac1f5c9ec0502e586906c67553abf5dd7aaa -size 849138 +oid sha256:b2093c2874de9a03bba1d103c76b58e361c3a35f7710cc456c957286f2520b96 +size 926188 diff --git a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_80_t_21038400.000000_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_80_t_21038400.000000_reference.vtu index 45ce80116a89bab2e665417fd18eb9b0a2770c48..e789fc561982d1f76396c6c43e7dc6e0e3adb32a 100644 --- a/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_80_t_21038400.000000_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/elder/elder_pcs_0_ts_80_t_21038400.000000_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:69318b996c04dda79f1adcb8f6b471853542a391de38cdb52f29529f4941ee6a -size 840965 +oid sha256:be56267a764d123b9826a3ab9c7d2608a464d4beec016a8bd074cd3db2835165 +size 917033 diff --git a/Tests/Data/Parabolic/ComponentTransport/heterogeneous/ogs5_H_3D/3D1P-GWFlow_1_reference.vtu b/Tests/Data/Parabolic/ComponentTransport/heterogeneous/ogs5_H_3D/3D1P-GWFlow_1_reference.vtu index 69ee33696e9f6fc81d2dbd0075ea6a5559bd44b4..400677199cc46fe8ca4d800d37a2d48769b364bf 100644 --- a/Tests/Data/Parabolic/ComponentTransport/heterogeneous/ogs5_H_3D/3D1P-GWFlow_1_reference.vtu +++ b/Tests/Data/Parabolic/ComponentTransport/heterogeneous/ogs5_H_3D/3D1P-GWFlow_1_reference.vtu @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:b3801b76c42062ca5bf281131e85ec78c06f6bb85adb88a064cb5a4b1fd5579b -size 4397901 +oid sha256:ab0fd3ff960ddf30bf78777d9115c96d0815002d12c3a2e0e2328a0801532300 +size 8272500 diff --git a/web/content/docs/benchmarks/hydro-component/HC-NonBoussinesq.pdf b/web/content/docs/benchmarks/hydro-component/HC-NonBoussinesq.pdf new file mode 100644 index 0000000000000000000000000000000000000000..692b619bc9039d7e02542bc0b99524d86292b117 --- /dev/null +++ b/web/content/docs/benchmarks/hydro-component/HC-NonBoussinesq.pdf @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:3e7584269b7a8a5a8e578da566425a5220b731efff3c323c73ac0ec8ae60a64f +size 83558 diff --git a/web/content/docs/benchmarks/hydro-component/HC-Process.pdf b/web/content/docs/benchmarks/hydro-component/HC-Process.pdf index a1d51176a6b0421bd202b08d683b12a520b29684..507e2a842e0decf5ea0c311c14c03c32f70fd8dc 100644 --- a/web/content/docs/benchmarks/hydro-component/HC-Process.pdf +++ b/web/content/docs/benchmarks/hydro-component/HC-Process.pdf @@ -1,3 +1,3 @@ version https://git-lfs.github.com/spec/v1 -oid sha256:6797b2634d5c4b49e6f7ab37b67f48ebfeb2fa939276b48dda5f9a8a22901b53 -size 246898 +oid sha256:767811d21c5002d34b587590815d239071d41aea85dc6e1bbe20919dc922b17e +size 237048 diff --git a/web/content/docs/benchmarks/hydro-component/hydro-component.pandoc b/web/content/docs/benchmarks/hydro-component/hydro-component.pandoc index 3f9ed1175bc0dd1c691a1d4e7508791d0be6c5bb..4dcdc9e49d69dfd5377ea97c90aaed5c920aa88e 100644 --- a/web/content/docs/benchmarks/hydro-component/hydro-component.pandoc +++ b/web/content/docs/benchmarks/hydro-component/hydro-component.pandoc @@ -72,3 +72,8 @@ Left side boundary conditions for this setup are pressure $p=1$ and concentratio {{< data-link "The *Diffusion, Storage, Advection, and Decay* project file" "Parabolic/ComponentTransport/SimpleSynthetics/DiffusionAndStorageAndAdvectionAndDecay.prj" >}} {{< img src="../gif/DiffusionAndStorageAndAdvectionAndDecay.gif" title="*Diffusion, Storage, Advection, and Decay*">}} + + +#### Changes With Inclusion of Non Boussinesq-Effects #### +The changes to the original setup are described in [this PDF](../HC-NonBoussinesq.pdf). +