diff --git a/dumux/material/fluidsystems/h2on2liquidphase.hh b/dumux/material/fluidsystems/h2on2liquidphase.hh
deleted file mode 100644
index ab9447380773cdde1ceaff7063f11f3a5132bef5..0000000000000000000000000000000000000000
--- a/dumux/material/fluidsystems/h2on2liquidphase.hh
+++ /dev/null
@@ -1,624 +0,0 @@
-// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*-
-// vi: set et ts=4 sw=4 sts=4:
-/*****************************************************************************
- *   See the file COPYING for full copying permissions.                      *
- *                                                                           *
- *   This program is free software: you can redistribute it and/or modify    *
- *   it under the terms of the GNU General Public License as published by    *
- *   the Free Software Foundation, either version 2 of the License, or       *
- *   (at your option) any later version.                                     *
- *                                                                           *
- *   This program is distributed in the hope that it will be useful,         *
- *   but WITHOUT ANY WARRANTY; without even the implied warranty of          *
- *   MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the            *
- *   GNU General Public License for more details.                            *
- *                                                                           *
- *   You should have received a copy of the GNU General Public License       *
- *   along with this program.  If not, see <http://www.gnu.org/licenses/>.   *
- *****************************************************************************/
-/*!
- * \file
- *
- * \brief A one-phase (water-phase) fluid system with water and nitrogen as components.
- */
-#ifndef DUMUX_H2O_N2_LIQUIDPHASE_FLUID_SYSTEM_HH
-#define DUMUX_H2O_N2_LIQUIDPHASE_FLUID_SYSTEM_HH
-
-#include <cassert>
-
-#include <dumux/material/idealgas.hh>
-
-#include <dumux/material/components/n2.hh>
-#include <dumux/material/components/h2o.hh>
-#include <dumux/material/components/simpleh2o.hh>
-#include <dumux/material/components/tabulatedcomponent.hh>
-#include <dumux/material/binarycoefficients/h2o_n2.hh>
-
-#include <dumux/common/valgrind.hh>
-#include <dumux/common/exceptions.hh>
-
-#include <dumux/material/fluidsystems/base.hh>
-
-#ifdef DUMUX_PROPERTIES_HH
-#include <dumux/common/basicproperties.hh>
-#include <dumux/material/fluidsystems/defaultcomponents.hh>
-#endif
-
-namespace Dumux
-{
-namespace FluidSystems
-{
-
-/*!
- * \ingroup Fluidsystems
- *
- * \brief A one-phase (water-phase) fluid system with water and nitrogen as components.
- *
- * This FluidSystem can be used without the PropertySystem that is applied in Dumux,
- * as all Parameters are defined via template parameters. Hence it is in an
- * additional namespace Dumux::FluidSystems::.
- * An adapter class using Dumux::FluidSystem<TypeTag> is also provided
- * at the end of this file.
- */
-template <class Scalar, bool useComplexRelations = true>
-class H2ON2LiquidPhase
-    : public BaseFluidSystem<Scalar, H2ON2LiquidPhase<Scalar, useComplexRelations> >
-{
-    typedef H2ON2LiquidPhase<Scalar, useComplexRelations> ThisType;
-    typedef BaseFluidSystem<Scalar, ThisType> Base;
-
-    // convenience typedefs
-    typedef Dumux::IdealGas<Scalar> IdealGas;
-    typedef Dumux::H2O<Scalar> IapwsH2O;
-    typedef Dumux::TabulatedComponent<Scalar, IapwsH2O > TabulatedH2O;
-    typedef Dumux::N2<Scalar> SimpleN2;
-
-public:
-    /****************************************
-     * Fluid phase related static parameters
-     ****************************************/
-
-    //! Number of phases in the fluid system
-    static constexpr int numPhases = 1;
-
-    static constexpr int wPhaseIdx = 0; // index of the wetting phase
-
-    /*!
-     * \brief Return the human readable name of a fluid phase.
-     *
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    static const char *phaseName(int phaseIdx)
-    {
-        static const char *name[] = {
-            "w"
-        };
-
-        assert(0 <= phaseIdx && phaseIdx < numPhases);
-        return name[phaseIdx];
-    }
-
-    /*!
-     * \brief Return whether a phase is liquid.
-     *
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    static bool isLiquid(int phaseIdx)
-    {
-        assert(0 <= phaseIdx && phaseIdx < numPhases);
-        return true; //only water phase present
-    }
-
-    /*!
-     * \brief Returns true if and only if a fluid phase is assumed to
-     *        be an ideal mixture.
-     *
-     * We define an ideal mixture as a fluid phase where the fugacity
-     * coefficients of all components times the pressure of the phase
-     * are independent on the fluid composition. This assumption is true
-     * if Henry's law and Rault's law apply. If you are unsure what
-     * this function should return, it is safe to return false. The
-     * only damage done will be (slightly) increased computation times
-     * in some cases.
-     *
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    static bool isIdealMixture(int phaseIdx)
-    {
-        assert(0 <= phaseIdx && phaseIdx < numPhases);
-        // we assume Henry's and Rault's laws for the water phase and
-        // and no interaction between gas molecules of different
-        // components, so all phases are ideal mixtures!
-        return true;
-    }
-
-    /*!
-     * \brief Returns true if and only if a fluid phase is assumed to
-     *        be compressible.
-     *
-     * Compressible means that the partial derivative of the density
-     * to the fluid pressure is always larger than zero.
-     *
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    static bool isCompressible(int phaseIdx)
-    {
-        assert(0 <= phaseIdx && phaseIdx < numPhases);
-        // the water component decides for the liquid phase...
-        return H2O::liquidIsCompressible();
-    }
-
-    /*!
-     * \brief Returns true if and only if a fluid phase is assumed to
-     *        be an ideal gas.
-     *
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    static bool isIdealGas(int phaseIdx)
-    {
-        assert(0 <= phaseIdx && phaseIdx < numPhases);
-        return false; // not a gas (only liquid phase present)
-    }
-
-    /****************************************
-     * Component related static parameters
-     ****************************************/
-
-    //! Number of components in the fluid system
-    static constexpr int numComponents = 2;
-
-    static constexpr int H2OIdx = 0;
-    static constexpr int N2Idx = 1;
-
-    //! The components for pure water
-    typedef TabulatedH2O H2O;
-    //typedef SimpleH2O H2O;
-    //typedef IapwsH2O H2O;
-
-    //! The components for pure nitrogen
-    typedef SimpleN2 N2;
-
-    /*!
-     * \brief Return the human readable name of a component
-     *
-     * \param compIdx The index of the component to consider
-     */
-    static const char *componentName(int compIdx)
-    {
-        static const char *name[] = {
-            H2O::name(),
-            N2::name()
-        };
-
-        assert(0 <= compIdx && compIdx < numComponents);
-        return name[compIdx];
-    }
-
-    /*!
-     * \brief Return the molar mass of a component in \f$\mathrm{[kg/mol]}\f$.
-     *
-     * \param compIdx The index of the component to consider
-     */
-    static Scalar molarMass(int compIdx)
-    {
-        static const Scalar M[] = {
-            H2O::molarMass(),
-            N2::molarMass(),
-        };
-
-        assert(0 <= compIdx && compIdx < numComponents);
-        return M[compIdx];
-    }
-
-    /*!
-     * \brief Critical temperature of a component \f$\mathrm{[K]}\f$.
-     *
-     * \param compIdx The index of the component to consider
-     */
-    static Scalar criticalTemperature(int compIdx)
-    {
-        static const Scalar Tcrit[] = {
-            H2O::criticalTemperature(), // H2O
-            N2::criticalTemperature() // N2
-        };
-
-        assert(0 <= compIdx && compIdx < numComponents);
-        return Tcrit[compIdx];
-    }
-
-    /*!
-     * \brief Critical pressure of a component \f$\mathrm{[Pa]}\f$.
-     *
-     * \param compIdx The index of the component to consider
-     */
-    static Scalar criticalPressure(int compIdx)
-    {
-        static const Scalar pcrit[] = {
-            H2O::criticalPressure(),
-            N2::criticalPressure()
-        };
-
-        assert(0 <= compIdx && compIdx < numComponents);
-        return pcrit[compIdx];
-    }
-
-    /*!
-     * \brief Molar volume of a component at the critical point \f$\mathrm{[m^3/mol]}\f$.
-     *
-     * \param compIdx The index of the component to consider
-     */
-    static Scalar criticalMolarVolume(int compIdx)
-    {
-        DUNE_THROW(Dune::NotImplemented,
-                   "H2ON2OnePhaseFluidSystem::criticalMolarVolume()");
-        return 0;
-    }
-
-    /*!
-     * \brief The acentric factor of a component \f$\mathrm{[-]}\f$.
-     *
-     * \param compIdx The index of the component to consider
-     */
-    static Scalar acentricFactor(int compIdx)
-    {
-        static const Scalar accFac[] = {
-            H2O::acentricFactor(), // H2O (from Reid, et al.)
-            N2::acentricFactor()
-        };
-
-        assert(0 <= compIdx && compIdx < numComponents);
-        return accFac[compIdx];
-    }
-
-    /****************************************
-     * thermodynamic relations
-     ****************************************/
-
-    /*!
-     * \brief Initialize the fluid system's static parameters generically.
-     *
-     * If a tabulated H2O component is used, we do our best to create
-     * tables that always work.
-     */
-    static void init()
-    {
-        init(/*tempMin=*/273.15,
-             /*tempMax=*/623.15,
-             /*numTemp=*/100,
-             /*pMin=*/0.0,
-             /*pMax=*/20e6,
-             /*numP=*/200);
-    }
-
-    /*!
-     * \brief Initialize the fluid system's static parameters using
-     *        problem specific temperature and pressure ranges.
-     *
-     * \param tempMin The minimum temperature used for tabulation of water \f$\mathrm{[K]}\f$
-     * \param tempMax The maximum temperature used for tabulation of water \f$\mathrm{[K]}\f$
-     * \param nTemp The number of ticks on the temperature axis of the  table of water
-     * \param pressMin The minimum pressure used for tabulation of water \f$\mathrm{[Pa]}\f$
-     * \param pressMax The maximum pressure used for tabulation of water \f$\mathrm{[Pa]}\f$
-     * \param nPress The number of ticks on the pressure axis of the  table of water
-     */
-    static void init(Scalar tempMin, Scalar tempMax, unsigned nTemp,
-                     Scalar pressMin, Scalar pressMax, unsigned nPress)
-    {
-        if (useComplexRelations)
-            std::cout << "Using complex H2O-N2 fluid system\n";
-        else
-            std::cout << "Using fast H2O-N2 fluid system\n";
-
-        if (H2O::isTabulated) {
-            std::cout << "Initializing tables for the H2O fluid properties ("
-                      << nTemp*nPress
-                      << " entries).\n";
-
-            TabulatedH2O::init(tempMin, tempMax, nTemp,
-                               pressMin, pressMax, nPress);
-        }
-    }
-
-    /*!
-     * \brief Given a phase's composition, temperature, pressure, and
-     *        the partial pressures of all components, return its
-     *        density \f$\mathrm{[kg/m^3]}\f$.
-     *
-     * If useComplexRelations == true, we apply Eq. (7)
-     * in Class et al. (2002a) \cite A3:class:2002b <BR>
-     * for the liquid density.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    using Base::density;
-    template <class FluidState>
-    static Scalar density(const FluidState &fluidState,
-                          int phaseIdx)
-    {
-        assert(0 <= phaseIdx  && phaseIdx < numPhases);
-
-        Scalar T = fluidState.temperature(phaseIdx);
-        Scalar p = fluidState.pressure(phaseIdx);
-
-        Scalar sumMoleFrac = 0;
-        for (int compIdx = 0; compIdx < numComponents; ++compIdx)
-            sumMoleFrac += fluidState.moleFraction(phaseIdx, compIdx);
-
-        // liquid phase
-        if (phaseIdx == wPhaseIdx) {
-            if (!useComplexRelations)
-                // assume pure water
-                return H2O::liquidDensity(T, p);
-            else
-            {
-                // See: Eq. (7) in Class et al. (2002a)
-                Scalar rholH2O = H2O::liquidDensity(T, p);
-                Scalar clH2O = rholH2O/H2O::molarMass();
-
-                // this assumes each nitrogen molecule displaces exactly one
-                // water molecule in the liquid
-                return
-                    clH2O
-                    * (H2O::molarMass()*fluidState.moleFraction(wPhaseIdx, H2OIdx)
-                       +
-                       N2::molarMass()*fluidState.moleFraction(wPhaseIdx, N2Idx))
-                    / sumMoleFrac;
-            }
-        }
-        else //gas phase index
-            DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-
-    /*!
-     * \brief Calculate the dynamic viscosity of a fluid phase \f$\mathrm{[Pa*s]}\f$.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    using Base::viscosity;
-    template <class FluidState>
-    static Scalar viscosity(const FluidState &fluidState,
-                            int phaseIdx)
-    {
-        assert(0 <= phaseIdx  && phaseIdx < numPhases);
-
-        Scalar T = fluidState.temperature(phaseIdx);
-        Scalar p = fluidState.pressure(phaseIdx);
-
-        // liquid phase
-        if (phaseIdx == wPhaseIdx) {
-            // assume pure water for the liquid phase
-            return H2O::liquidViscosity(T, p);
-        }
-       else //gas phase index
-           DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-
-    /*!
-     * \brief Calculate the fugacity coefficient \f$\mathrm{[Pa]}\f$ of an individual
-     *        component in a fluid phase.
-     *
-     * The fugacity coefficient \f$\phi^\kappa_\alpha\f$ of
-     * component \f$\kappa\f$ in phase \f$\alpha\f$ is connected to
-     * the fugacity \f$f^\kappa_\alpha\f$ and the component's mole
-     * fraction \f$x^\kappa_\alpha\f$ by means of the relation
-     *
-     * \f[
-     f^\kappa_\alpha = \phi^\kappa_\alpha\;x^\kappa_\alpha\;p_\alpha
-     \f]
-     * where \f$p_\alpha\f$ is the pressure of the fluid phase.
-     *
-     * The quantity "fugacity" itself is just an other way to express
-     * the chemical potential \f$\zeta^\kappa_\alpha\f$ of the
-     * component. It is defined via
-     *
-     * \f[
-     f^\kappa_\alpha := \exp\left\{\frac{\zeta^\kappa_\alpha}{k_B T_\alpha} \right\}
-     \f]
-     * where \f$k_B = 1.380\cdot10^{-23}\;J/K\f$ is the Boltzmann constant.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     * \param compIdx The index of the component to consider
-     */
-    using Base::fugacityCoefficient;
-    template <class FluidState>
-    static Scalar fugacityCoefficient(const FluidState &fluidState,
-                                      int phaseIdx,
-                                      int compIdx)
-    {
-        assert(0 <= phaseIdx  && phaseIdx < numPhases);
-        assert(0 <= compIdx  && compIdx < numComponents);
-
-        Scalar T = fluidState.temperature(phaseIdx);
-        Scalar p = fluidState.pressure(phaseIdx);
-
-        // liquid phase
-        if (phaseIdx == wPhaseIdx) {
-            if (compIdx == H2OIdx)
-                return H2O::vaporPressure(T)/p;
-            return Dumux::BinaryCoeff::H2O_N2::henry(T)/p;
-        }
-        else //gas phase index
-            DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-
-
-    /*!
-     * \brief Calculate the molecular diffusion coefficient for a
-     *        component in a fluid phase \f$\mathrm{[mol^2 * s / (kg*m^3)]}\f$.
-     *
-     * Molecular diffusion of a compoent \f$\kappa\f$ is caused by a
-     * gradient of the chemical potential and follows the law
-     *
-     * \f[ J = - D \mathbf{grad} \mu_\kappa \f]
-     *
-     * where \f$\mu_\kappa\f$ is the component's chemical potential,
-     * \f$D\f$ is the diffusion coefficient and \f$J\f$ is the
-     * diffusive flux. \f$mu_\kappa\f$ is connected to the component's
-     * fugacity \f$f_\kappa\f$ by the relation
-     *
-     * \f[ \mu_\kappa = R T_\alpha \mathrm{ln} \frac{f_\kappa}{p_\alpha} \f]
-     *
-     * where \f$p_\alpha\f$ and \f$T_\alpha\f$ are the fluid phase'
-     * pressure and temperature.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     * \param compIdx The index of the component to consider
-     */
-    using Base::diffusionCoefficient;
-    template <class FluidState>
-    static Scalar diffusionCoefficient(const FluidState &fluidState,
-                                       int phaseIdx,
-                                       int compIdx)
-    {
-        DUNE_THROW(Dune::NotImplemented, "Diffusion coefficients");
-    }
-
-    /*!
-     * \brief Given a phase's composition, temperature and pressure,
-     *        return the binary diffusion coefficient \f$\mathrm{[m^2/s]}\f$ for components
-     *        \f$i\f$ and \f$j\f$ in this phase.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     * \param compIIdx The index of the first component to consider
-     * \param compJIdx The index of the second component to consider
-     */
-    using Base::binaryDiffusionCoefficient;
-    template <class FluidState>
-    static Scalar binaryDiffusionCoefficient(const FluidState &fluidState,
-                                             int phaseIdx,
-                                             int compIIdx,
-                                             int compJIdx)
-
-    {
-        static Scalar undefined(1e10);
-        Valgrind::SetUndefined(undefined);
-
-        if (compIIdx > compJIdx)
-            std::swap(compIIdx, compJIdx);
-
-#ifndef NDEBUG
-        if (compIIdx == compJIdx ||
-            phaseIdx > numPhases - 1 ||
-            compJIdx > numComponents - 1)
-        {
-            DUNE_THROW(Dune::InvalidStateException,
-                       "Binary diffusion coefficient of components "
-                       << compIIdx << " and " << compJIdx
-                       << " in phase " << phaseIdx << " is undefined!\n");
-        }
-#endif
-
-        Scalar T = fluidState.temperature(phaseIdx);
-        Scalar p = fluidState.pressure(phaseIdx);
-
-        // liquid phase
-        if (phaseIdx == wPhaseIdx) {
-            if (compIIdx == H2OIdx && compJIdx == N2Idx)
-                return BinaryCoeff::H2O_N2::liquidDiffCoeff(T, p);
-            return undefined;
-        }
-        else //gas phase index
-            DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-
-    /*!
-     * \brief Given a phase's composition, temperature, pressure and
-     *        density, calculate its specific enthalpy \f$\mathrm{[J/kg]}\f$.
-     *
-     *  \todo This fluid system neglects the contribution of
-     *        gas-molecules in the liquid phase. This contribution is
-     *        probably not big. Somebody would have to find out the
-     *        enthalpy of solution for this system. ...
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    using Base::enthalpy;
-    template <class FluidState>
-    static Scalar enthalpy(const FluidState &fluidState,
-                           int phaseIdx)
-    {
-        Scalar T = fluidState.temperature(phaseIdx);
-        Scalar p = fluidState.pressure(phaseIdx);
-        Valgrind::CheckDefined(T);
-        Valgrind::CheckDefined(p);
-
-        // liquid phase
-        if (phaseIdx == wPhaseIdx) {
-            // TODO: correct way to deal with the solutes???
-            return H2O::liquidEnthalpy(T, p);
-        }
-        else //gas phase index
-            DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-
-    /*!
-     * \brief Thermal conductivity of a fluid phase \f$\mathrm{[W/(m K)]}\f$.
-     *
-     * Use the conductivity of water as a first approximation.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    using Base::thermalConductivity;
-    template <class FluidState>
-    static Scalar thermalConductivity(const FluidState &fluidState,
-                                      const int phaseIdx)
-    {
-        assert(0 <= phaseIdx  && phaseIdx < numPhases);
-
-        Scalar temperature = fluidState.temperature(phaseIdx);
-        Scalar pressure = fluidState.pressure(phaseIdx);
-        if (phaseIdx == wPhaseIdx)
-        {
-            return H2O::liquidThermalConductivity(temperature, pressure);
-        }
-        else //gas phase index
-            DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-
-    /*!
-     * \brief Specific isobaric heat capacity of a fluid phase.
-     *        \f$\mathrm{[J/(kg K)]}\f$.
-     *
-     * \param fluidState An arbitrary fluid state
-     * \param phaseIdx The index of the fluid phase to consider
-     */
-    using Base::heatCapacity;
-    template <class FluidState>
-    static Scalar heatCapacity(const FluidState &fluidState,
-                               int phaseIdx)
-    {
-        if (phaseIdx == wPhaseIdx) {
-            return H2O::liquidHeatCapacity(fluidState.temperature(phaseIdx),
-                                           fluidState.pressure(phaseIdx));
-        }
-        else //gas phase index
-            DUNE_THROW(Dune::InvalidStateException, "Invalid phase index " << phaseIdx);
-    }
-};
-
-} // end namespace FluidSystems
-
-#ifdef DUMUX_PROPERTIES_HH
-/*!
- * \brief A one-phase fluid system with water and nitrogen as components.
- *
- * This is an adapter to use Dumux::H2ON2LiquidPhaseFluidSystem<TypeTag>, as is
- * done with most other classes in Dumux.
- */
-template<class TypeTag>
-class H2ON2LiquidPhaseFluidSystem
-: public FluidSystems::H2ON2LiquidPhase<typename GET_PROP_TYPE(TypeTag, Scalar),
-                             GET_PROP_VALUE(TypeTag, EnableComplicatedFluidSystem)>
-{};
-#endif
-
-} // end namespace
-
-#endif
diff --git a/dumux/material/fluidsystems/h2on2liquidphasefluidsystem.hh b/dumux/material/fluidsystems/h2on2liquidphasefluidsystem.hh
index 803271af5e9e216f144c3988eb5a291e364b093c..1d8c094c046c3bd979e78c75398441d3d361def3 100644
--- a/dumux/material/fluidsystems/h2on2liquidphasefluidsystem.hh
+++ b/dumux/material/fluidsystems/h2on2liquidphasefluidsystem.hh
@@ -1,8 +1,8 @@
 #ifndef DUMUX_H2O_N2_LIQUIDPHASE_FLUID_SYSTEM_HH_OLD
 #define DUMUX_H2O_N2_LIQUIDPHASE_FLUID_SYSTEM_HH_OLD
 
-#warning this header is deprecated, use dumux/material/fluidsystems/h2on2liquidphase.hh instead
+#warning this header is deprecated, use dumux/material/fluidsystems/h2on2.hh instead
 
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
+#include <dumux/material/fluidsystems/h2on2.hh>
 
 #endif
diff --git a/test/geomechanics/el1p2c/el1p2cproblem.hh b/test/geomechanics/el1p2c/el1p2cproblem.hh
index bb5c93122b759ee071265c2403c57414152e3e84..36e0ff9882ef3d17aef759d6b666cd6ed375d01c 100644
--- a/test/geomechanics/el1p2c/el1p2cproblem.hh
+++ b/test/geomechanics/el1p2c/el1p2cproblem.hh
@@ -29,7 +29,7 @@
 #include <dumux/geomechanics/el1p2c/model.hh>
 #include <dumux/porousmediumflow/implicit/problem.hh>
 
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
+#include <dumux/material/fluidsystems/h2on2.hh>
 #include "el1p2cspatialparams.hh"
 #include <dumux/linear/amgbackend.hh>
 
@@ -53,7 +53,7 @@ namespace Dumux
     { private:
         typedef typename GET_PROP_TYPE(TypeTag, Scalar) Scalar;
     public:
-        typedef Dumux::FluidSystems::H2ON2LiquidPhase<Scalar, false> type;
+        typedef Dumux::FluidSystems::H2ON2<Scalar, false> type;
     };
 
     // Set the soil properties
diff --git a/test/material/fluidsystems/checkfluidsystem.hh b/test/material/fluidsystems/checkfluidsystem.hh
index 25e149e1269b10218111ef9d865ed2bd8eb1f9fe..3d81e3ce78cd6f9dae9ef6eda4138ec503a139ce 100644
--- a/test/material/fluidsystems/checkfluidsystem.hh
+++ b/test/material/fluidsystems/checkfluidsystem.hh
@@ -42,7 +42,6 @@
 #include <dumux/material/fluidsystems/h2oairxylene.hh>
 #include <dumux/material/fluidsystems/h2on2.hh>
 #include <dumux/material/fluidsystems/h2on2kinetic.hh>
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
 #include <dumux/material/fluidsystems/h2on2o2.hh>
 #include <dumux/material/fluidsystems/liquidphase.hh>
 #include <dumux/material/fluidsystems/purewatersimple.hh>
diff --git a/test/material/fluidsystems/test_fluidsystems.cc b/test/material/fluidsystems/test_fluidsystems.cc
index 60fdef393cbb21c4afabe40e08d83e34e2f8c56c..d52255f7ff394bdeadbf611c7b9092016079682a 100644
--- a/test/material/fluidsystems/test_fluidsystems.cc
+++ b/test/material/fluidsystems/test_fluidsystems.cc
@@ -42,7 +42,6 @@
 #include <dumux/material/fluidsystems/h2oairxylene.hh>
 #include <dumux/material/fluidsystems/h2on2.hh>
 #include <dumux/material/fluidsystems/h2on2kinetic.hh>
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
 #include <dumux/material/fluidsystems/h2on2o2.hh>
 #include <dumux/material/fluidsystems/liquidphase.hh>
 #include <dumux/material/fluidsystems/purewatersimple.hh>
@@ -67,8 +66,8 @@ int main()
     typedef Dumux::H2O<Scalar> H2O;
     typedef Dumux::N2<Scalar> N2;
 
-    typedef Dumux::LiquidPhase<Scalar, H2O> Liquid;
-    typedef Dumux::GasPhase<Scalar, N2> Gas;
+    typedef Dumux::FluidSystems::LiquidPhase<Scalar, H2O> Liquid;
+    typedef Dumux::FluidSystems::GasPhase<Scalar, N2> Gas;
 
     int success = 0;
     std::string collectedExceptions;
@@ -171,12 +170,10 @@ int main()
     // base
 
     // Brine -- Air
-    {   typedef Dumux::Brine<Scalar> Brine;
-        const bool enableComplexRelations=false;
+    {   const bool enableComplexRelations=false;
         typedef Dumux::FluidSystems::BrineAir<Scalar, H2O, enableComplexRelations> FluidSystem;
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
-    {   typedef Dumux::Brine<Scalar> Brine;
-        const bool enableComplexRelations=true;
+    {   const bool enableComplexRelations=true;
         typedef Dumux::FluidSystems::BrineAir<Scalar, H2O, enableComplexRelations> FluidSystem;
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
 
@@ -226,12 +223,6 @@ int main()
     {   typedef Dumux::FluidSystems::H2ON2Kinetic<Scalar, /*enableComplexRelations=*/true> FluidSystem;
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
 
-    // H2O -- N2 -- liquid phase
-    {   typedef Dumux::FluidSystems::H2ON2LiquidPhase<Scalar, /*enableComplexRelations=*/false> FluidSystem;
-        success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
-    {   typedef Dumux::FluidSystems::H2ON2LiquidPhase<Scalar, /*enableComplexRelations=*/true> FluidSystem;
-        success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
-
     // H2O -- N2 -- o2
     {   typedef Dumux::FluidSystems::H2ON2O2<Scalar, /*enableComplexRelations=*/false> FluidSystem;
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
@@ -239,7 +230,7 @@ int main()
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
 
     // liquid phase
-    {   typedef Dumux::LiquidPhase<Scalar, H2O> FluidSystem;
+    {   typedef Dumux::FluidSystems::LiquidPhase<Scalar, H2O> FluidSystem;
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
     {   typedef Dumux::FluidSystems::LiquidPhase<Scalar, H2O> FluidSystem;
         success += Dumux::checkFluidSystem<Scalar, FluidSystem>(); }
diff --git a/test/porousmediumflow/1p2c/implicit/1p2cniconductionproblem.hh b/test/porousmediumflow/1p2c/implicit/1p2cniconductionproblem.hh
index 016744434116bdc9110e0d2d3ad4cbde511213b6..64d0ea9a0b40f164e8e33a2935764b115e48d6b0 100644
--- a/test/porousmediumflow/1p2c/implicit/1p2cniconductionproblem.hh
+++ b/test/porousmediumflow/1p2c/implicit/1p2cniconductionproblem.hh
@@ -30,7 +30,7 @@
 #include <dumux/porousmediumflow/1p2c/implicit/model.hh>
 #include <dumux/porousmediumflow/implicit/problem.hh>
 
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
+#include <dumux/material/fluidsystems/h2on2.hh>
 #include <dumux/material/fluidmatrixinteractions/1p/thermalconductivityaverage.hh>
 #include "1p2cnispatialparams.hh"
 
@@ -58,7 +58,7 @@ SET_TYPE_PROP(OnePTwoCNIConductionProblem, Problem,
 // Set fluid configuration
 SET_TYPE_PROP(OnePTwoCNIConductionProblem,
               FluidSystem,
-              Dumux::FluidSystems::H2ON2LiquidPhase<typename GET_PROP_TYPE(TypeTag, Scalar), true>);
+              Dumux::FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), true>);
 
 // Set the spatial parameters
 SET_TYPE_PROP(OnePTwoCNIConductionProblem,
diff --git a/test/porousmediumflow/1p2c/implicit/1p2cniconvectionproblem.hh b/test/porousmediumflow/1p2c/implicit/1p2cniconvectionproblem.hh
index 8cf0b9de805dc801499e70eb6d285f560f98704d..3cffb90c27f564cdf6f53c6a8b8dffc81f3d2464 100644
--- a/test/porousmediumflow/1p2c/implicit/1p2cniconvectionproblem.hh
+++ b/test/porousmediumflow/1p2c/implicit/1p2cniconvectionproblem.hh
@@ -31,7 +31,7 @@
 #include <dumux/porousmediumflow/1p2c/implicit/model.hh>
 #include <dumux/porousmediumflow/implicit/problem.hh>
 #include <dumux/material/components/h2o.hh>
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
+#include <dumux/material/fluidsystems/h2on2.hh>
 #include <dumux/material/fluidmatrixinteractions/1p/thermalconductivityaverage.hh>
 #include "1p2cnispatialparams.hh"
 
@@ -57,7 +57,7 @@ SET_TYPE_PROP(OnePTwoCNIConvectionProblem, Problem,
 // Set fluid configuration
 SET_TYPE_PROP(OnePTwoCNIConvectionProblem,
               FluidSystem,
-              Dumux::FluidSystems::H2ON2LiquidPhase<typename GET_PROP_TYPE(TypeTag, Scalar), true>);
+              Dumux::FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), true>);
 
 // Set the spatial parameters
 SET_TYPE_PROP(OnePTwoCNIConvectionProblem,
diff --git a/test/porousmediumflow/1p2c/implicit/1p2coutflowproblem.hh b/test/porousmediumflow/1p2c/implicit/1p2coutflowproblem.hh
index 30d6682a5f2a264607de70d1c8b4ea2128f06c9a..473de62ad5aec82c27cbf6fee0bf5166ae0203f8 100644
--- a/test/porousmediumflow/1p2c/implicit/1p2coutflowproblem.hh
+++ b/test/porousmediumflow/1p2c/implicit/1p2coutflowproblem.hh
@@ -32,7 +32,7 @@
 #include <dumux/porousmediumflow/1p2c/implicit/model.hh>
 #include <dumux/porousmediumflow/implicit/problem.hh>
 
-#include <dumux/material/fluidsystems/h2on2liquidphase.hh>
+#include <dumux/material/fluidsystems/h2on2.hh>
 #include "1p2coutflowspatialparams.hh"
 
 #define NONISOTHERMAL 0
@@ -68,7 +68,7 @@ SET_TYPE_PROP(OnePTwoCOutflowProblem, Problem, Dumux::OnePTwoCOutflowProblem<Typ
 // Set fluid configuration
 SET_TYPE_PROP(OnePTwoCOutflowProblem,
               FluidSystem,
-              Dumux::FluidSystems::H2ON2LiquidPhase<typename GET_PROP_TYPE(TypeTag, Scalar), false>);
+              Dumux::FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>);
 
 // Set the spatial parameters
 SET_TYPE_PROP(OnePTwoCOutflowProblem,