diff --git a/test/porousmediumflow/1pnc/implicit/1pnctestproblem.hh b/test/porousmediumflow/1pnc/implicit/1p2ctestproblem.hh
similarity index 55%
rename from test/porousmediumflow/1pnc/implicit/1pnctestproblem.hh
rename to test/porousmediumflow/1pnc/implicit/1p2ctestproblem.hh
index 6ce4c1397609c0a6dbe89ccc1856d9caa87a8f1d..9445668a5a505c611e435c6d71c4626b45ee704e 100644
--- a/test/porousmediumflow/1pnc/implicit/1pnctestproblem.hh
+++ b/test/porousmediumflow/1pnc/implicit/1p2ctestproblem.hh
@@ -21,59 +21,53 @@
  * \brief Definition of a problem, for the 1pnc problem:
  * Component transport of nitrogen dissolved in the water phase.
  */
-#ifndef DUMUX_1PNC_TEST_PROBLEM_HH
-#define DUMUX_1PNC_TEST_PROBLEM_HH
+#ifndef DUMUX_1P2C_TEST_PROBLEM_HH
+#define DUMUX_1P2C_TEST_PROBLEM_HH
 
 #include <dumux/discretization/cellcentered/tpfa/properties.hh>
 #include <dumux/discretization/cellcentered/mpfa/properties.hh>
 #include <dumux/discretization/box/properties.hh>
+#include <dumux/discretization/evalsolution.hh>
+#include <dumux/discretization/evalgradients.hh>
 #include <dumux/porousmediumflow/1pnc/implicit/model.hh>
 #include <dumux/porousmediumflow/problem.hh>
 
 #include <dumux/material/fluidsystems/h2on2.hh>
 #include "1pnctestspatialparams.hh"
 
-#define NONISOTHERMAL 0
-
 namespace Dumux
 {
 
 template <class TypeTag>
-class OnePNCTestProblem;
+class OnePTwoCTestProblem;
 
 namespace Properties
 {
-#if NONISOTHERMAL
-NEW_TYPE_TAG(OnePNCOutflowProblem, INHERITS_FROM(OnePNCNI));
-NEW_TYPE_TAG(OnePNCOutflowBoxProblem, INHERITS_FROM(BoxModel, OnePNCOutflowProblem));
-NEW_TYPE_TAG(OnePNCOutflowCCProblem, INHERITS_FROM(CCTpfaModel, OnePNCOutflowProblem));
-#else
-NEW_TYPE_TAG(OnePNCTestProblem, INHERITS_FROM(OnePNC));
-NEW_TYPE_TAG(OnePNCTestBoxProblem, INHERITS_FROM(BoxModel, OnePNCTestProblem));
-NEW_TYPE_TAG(OnePNCTestCCProblem, INHERITS_FROM(CCTpfaModel, OnePNCTestProblem));
-NEW_TYPE_TAG(OnePNCTestCCMpfaProblem, INHERITS_FROM(CCMpfaModel, OnePNCTestProblem));
-#endif
+NEW_TYPE_TAG(OnePTwoCTestProblem, INHERITS_FROM(OnePNC));
+NEW_TYPE_TAG(OnePTwoCTestBoxProblem, INHERITS_FROM(BoxModel, OnePTwoCTestProblem));
+NEW_TYPE_TAG(OnePTwoCTestCCTpfaProblem, INHERITS_FROM(CCTpfaModel, OnePTwoCTestProblem));
+NEW_TYPE_TAG(OnePTwoCTestCCMpfaProblem, INHERITS_FROM(CCMpfaModel, OnePTwoCTestProblem));
 
 // Set the grid type
 #if HAVE_UG
-SET_TYPE_PROP(OnePNCTestProblem, Grid, Dune::UGGrid<2>);
+SET_TYPE_PROP(OnePTwoCTestProblem, Grid, Dune::UGGrid<2>);
 #else
-SET_TYPE_PROP(OnePNCTestProblem, Grid, Dune::YaspGrid<2>);
+SET_TYPE_PROP(OnePTwoCTestProblem, Grid, Dune::YaspGrid<2>);
 #endif
 
 // Set the problem property
-SET_TYPE_PROP(OnePNCTestProblem, Problem, OnePNCTestProblem<TypeTag>);
+SET_TYPE_PROP(OnePTwoCTestProblem, Problem, OnePTwoCTestProblem<TypeTag>);
 
 // Set fluid configuration
-SET_TYPE_PROP(OnePNCTestProblem,
+SET_TYPE_PROP(OnePTwoCTestProblem,
               FluidSystem,
               FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>);
 
 // Set the spatial parameters
-SET_TYPE_PROP(OnePNCTestProblem, SpatialParams, OnePNCTestSpatialParams<TypeTag>);
+SET_TYPE_PROP(OnePTwoCTestProblem, SpatialParams, OnePNCTestSpatialParams<TypeTag>);
 
 // Define whether mole(true) or mass (false) fractions are used
-SET_BOOL_PROP(OnePNCTestProblem, UseMoles, true);
+SET_BOOL_PROP(OnePTwoCTestProblem, UseMoles, true);
 }
 
 
@@ -104,7 +98,7 @@ SET_BOOL_PROP(OnePNCTestProblem, UseMoles, true);
  * <tt>./test_cc1pnc -parameterFile ./test_cc1pnc.input</tt>
  */
 template <class TypeTag>
-class OnePNCTestProblem : public PorousMediumFlowProblem<TypeTag>
+class OnePTwoCTestProblem : public PorousMediumFlowProblem<TypeTag>
 {
     using ParentType = PorousMediumFlowProblem<TypeTag>;
 
@@ -115,6 +109,13 @@ class OnePNCTestProblem : public PorousMediumFlowProblem<TypeTag>
     using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes);
     using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables);
     using FVGridGeometry = typename GET_PROP_TYPE(TypeTag, FVGridGeometry);
+    using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry);
+    using ResidualVector = typename GET_PROP_TYPE(TypeTag, NumEqVector);
+    using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables);
+    using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace);
+    using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector);
+    using FluidState = typename GET_PROP_TYPE(TypeTag, FluidState);
+    using Element = typename GridView::template Codim<0>::Entity;
 
     // copy some indices for convenience
     enum
@@ -123,12 +124,6 @@ class OnePNCTestProblem : public PorousMediumFlowProblem<TypeTag>
         pressureIdx = Indices::pressureIdx,
         massOrMoleFracIdx = Indices::firstMoleFracIdx,
 
-        // indices for the non-isothermal case
-#if NONISOTHERMAL
-        temperatureIdx = Indices::temperatureIdx,
-        energyEqIdx = Indices::energyEqIdx,
-#endif
-
         // indices of the equations
         conti0EqIdx = Indices::conti0EqIdx,
         transportEqIdx = Indices::firstTransportEqIdx
@@ -136,13 +131,15 @@ class OnePNCTestProblem : public PorousMediumFlowProblem<TypeTag>
 
     //! property that defines whether mole or mass fractions are used
     static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles);
+    static const auto phaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx);
+    static const bool isBox = GET_PROP_VALUE(TypeTag, DiscretizationMethod) == DiscretizationMethods::Box;
 
     static const int dimWorld = GridView::dimensionworld;
     using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>;
 
 public:
-    OnePNCTestProblem(std::shared_ptr<const FVGridGeometry> fvGridGeometry)
-    : ParentType(fvGridGeometry)
+    OnePTwoCTestProblem(std::shared_ptr<const FVGridGeometry> fvGridGeometry)
+    : ParentType(fvGridGeometry), useNitscheTypeBc_(getParam<bool>("Problem.UseNitscheTypeBc", false))
     {
         //initialize fluid system
         FluidSystem::init();
@@ -159,7 +156,6 @@ public:
      */
     // \{
 
-#if !NONISOTHERMAL
     /*!
      * \brief Returns the temperature within the domain [K].
      *
@@ -168,8 +164,6 @@ public:
     Scalar temperature() const
     { return 273.15 + 20; } // in [K]
 
-#endif
-
     // \}
 
     /*!
@@ -187,7 +181,7 @@ public:
     {
         BoundaryTypes values;
 
-        if(globalPos[0] < eps_ || globalPos[0] > this->fvGridGeometry().bBoxMax()[0] - eps_)
+        if(globalPos[0] < eps_)
             values.setAllDirichlet();
         else
             values.setAllNeumann();
@@ -206,29 +200,110 @@ public:
         PrimaryVariables values = initial_(globalPos);
 
         // condition for the N2 molefraction at left boundary
-        if (globalPos[0] < eps_)
+        if (globalPos[0] < eps_ )
         {
             values[massOrMoleFracIdx] = 2.0e-5;
-#if NONISOTHERMAL
-            values[temperatureIdx] = 300.;
-#endif
         }
 
         return values;
     }
 
     /*!
-     * \brief Evaluate the boundary conditions for a Neumann
+     * \brief Evaluate the boundary conditions for a neumann
      *        boundary segment.
      *
-     * For this method, the \a priVars parameter stores the mass flux
-     * in normal direction of each component. Negative values mean
-     * influx.
+     * This is the method for the case where the Neumann condition is
+     * potentially solution dependent and requires some quantities that
+     * are specific to the fully-implicit method.
+     *
+     * \param values The neumann values for the conservation equations in units of
+     *                 \f$ [ \textnormal{unit of conserved quantity} / (m^2 \cdot s )] \f$
+     * \param element The finite element
+     * \param fvGeometry The finite-volume geometry
+     * \param elemVolVars All volume variables for the element
+     * \param scvf The sub control volume face
      *
-     * The units must be according to either using mole or mass fractions. (mole/(m^2*s) or kg/(m^2*s))
+     * For this method, the \a values parameter stores the flux
+     * in normal direction of each phase. Negative values mean influx.
+     * E.g. for the mass balance that would the mass flux in \f$ [ kg / (m^2 \cdot s)] \f$.
      */
-    PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const
-    { return PrimaryVariables(0.0); }
+    ResidualVector neumann(const Element& element,
+                           const FVElementGeometry& fvGeometry,
+                           const ElementVolumeVariables& elemVolVars,
+                           const SubControlVolumeFace& scvf) const
+    {
+        // set a fixed pressure on the right side of the domain
+        const Scalar dirichletPressure = 1e5;
+
+        ResidualVector flux(0.0);
+        const auto& ipGlobal = scvf.ipGlobal();
+        const auto& volVars = elemVolVars[scvf.insideScvIdx()];
+
+        // no-flow everywhere except at the right boundary
+        if(ipGlobal[0] < this->fvGridGeometry().bBoxMax()[0] - eps_)
+            return flux;
+
+        // if specified in the input file, use a Nitsche type boundary condition for the box model,
+        // otherwise compute the acutal fluxes explicitly
+        if(isBox && useNitscheTypeBc_)
+        {
+            flux[conti0EqIdx] = (volVars.pressure(phaseIdx) - dirichletPressure) * 1e7;
+            flux[transportEqIdx] = flux[conti0EqIdx]  * (useMoles ? volVars.moleFraction(phaseIdx, massOrMoleFracIdx) :
+                                                                    volVars.massFraction(phaseIdx, massOrMoleFracIdx));
+            return flux;
+        }
+
+        // construct the element solution
+        const auto elementSolution = [&]()
+        {
+            ElementSolutionVector sol;
+            sol.resize(fvGeometry.numScv());
+
+            for(auto&& scv : scvs(fvGeometry))
+                sol[scv.indexInElement()] = elemVolVars[scv].priVars();
+
+            if(isBox)
+                for(auto&& scvf : scvfs(fvGeometry))
+                    if(scvf.center()[0] > this->fvGridGeometry().bBoxMax()[0] - eps_)
+                        sol[fvGeometry.scv(scvf.insideScvIdx()).indexInElement()][pressureIdx] = dirichletPressure;
+
+            return sol;
+        }();
+
+        // evaluate the gradient
+        const auto gradient = [&]()->GlobalPosition
+        {
+            if(isBox)
+            {
+                const auto grads = evalGradients(element, element.geometry(), fvGeometry.fvGridGeometry(), elementSolution, ipGlobal);
+                return grads[pressureIdx];
+            }
+
+            else
+            {
+                const auto& scvCenter = fvGeometry.scv(scvf.insideScvIdx()).center();
+                const Scalar scvCenterPresureSol = elementSolution[0][pressureIdx];
+                auto grad = ipGlobal - scvCenter;
+                grad /= grad.two_norm2();
+                grad *= (dirichletPressure - scvCenterPresureSol);
+                return grad;
+            }
+        }();
+
+        const Scalar K = volVars.permeability();
+        const Scalar density = useMoles ? volVars.molarDensity(phaseIdx) : volVars.density(phaseIdx);
+
+        // calculate the flux
+        Scalar tpfaFlux = gradient * scvf.unitOuterNormal();
+        tpfaFlux *= -1.0  * K;
+        tpfaFlux *=  density * volVars.mobility(phaseIdx);
+        flux[conti0EqIdx] = tpfaFlux;
+
+        // emulate an outflow condition for the component transport on the right side
+        flux[transportEqIdx] = tpfaFlux  * (useMoles ? volVars.moleFraction(phaseIdx, massOrMoleFracIdx) : volVars.massFraction(phaseIdx, massOrMoleFracIdx));
+
+        return flux;
+    }
 
     // \}
 
@@ -271,15 +346,11 @@ private:
         PrimaryVariables priVars;
         priVars[pressureIdx] = 2e5 - 1e5*globalPos[0]; // initial condition for the pressure
         priVars[massOrMoleFracIdx] = 0.0;  // initial condition for the N2 molefraction
-#if NONISOTHERMAL
-        priVars[temperatureIdx] = 290.;
-#endif
         return priVars;
     }
-
-    static constexpr Scalar eps_ = 1e-6;
-    std::string name_;
-};
+        static constexpr Scalar eps_ = 1e-6;
+        bool useNitscheTypeBc_;
+    };
 
 } //end namespace Dumux
 
diff --git a/test/porousmediumflow/1pnc/implicit/1p2ctestspatialparams.hh b/test/porousmediumflow/1pnc/implicit/1p2ctestspatialparams.hh
deleted file mode 100644
index a99c8f314401ad79bd4377653f2752e40b0c70e7..0000000000000000000000000000000000000000
--- a/test/porousmediumflow/1pnc/implicit/1p2ctestspatialparams.hh
+++ /dev/null
@@ -1,146 +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 Definition of the spatial parameters for the 1p2c
- *        outlfow problem.
- */
-#ifndef DUMUX_1P2C_TEST_SPATIAL_PARAMS_HH
-#define DUMUX_1P2C_TEST_SPATIAL_PARAMS_HH
-
-#include <dumux/material/spatialparams/implicit1p.hh>
-
-namespace Dumux
-{
-
-/*!
- * \ingroup OnePTwoCModel
- * \ingroup ImplicitTestProblems
- *
- * \brief Definition of the spatial parameters for the 1p2c
- *        outflow problem.
- */
-template<class TypeTag>
-class OnePTwoCTestSpatialParams : public ImplicitSpatialParamsOneP<TypeTag>
-{
-    using ParentType = ImplicitSpatialParamsOneP<TypeTag>;
-    using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar);
-    using Problem = typename GET_PROP_TYPE(TypeTag, Problem);
-    using GridView = typename GET_PROP_TYPE(TypeTag, GridView);
-    using Element = typename GridView::template Codim<0>::Entity;
-    using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume);
-    using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector);
-
-    static const int dimWorld = GridView::dimensionworld;
-    using GlobalPosition = typename Dune::FieldVector<Scalar, dimWorld>;
-
-public:
-    // export permeability type
-    using PermeabilityType = Scalar;
-
-    OnePTwoCTestSpatialParams(const Problem& problem, const GridView &gridView)
-        : ParentType(problem, gridView)
-    {
-        permeability_ = 1e-10;
-        porosity_ = 0.4;
-
-        // heat conductivity of granite
-        lambdaSolid_ = 2.8;
-    }
-
-    /*!
-     * \brief Define the intrinsic permeability \f$\mathrm{[m^2]}\f$.
-     *
-     * \param globalPos The global position
-     */
-    PermeabilityType permeabilityAtPos(const GlobalPosition& globalPos) const
-    { return permeability_; }
-
-    /*!
-     * \brief Define the porosity \f$\mathrm{[-]}\f$.
-     *
-     * \param globalPos The global position
-     */
-    Scalar porosityAtPos(const GlobalPosition& globalPos) const
-    { return porosity_; }
-
-    /*!
-     * \brief Define the dispersivity.
-     *
-     * \param element The finite element
-     * \param scv The sub-control volume
-     * \param elemSol The solution for all dofs of the element
-     */
-    Scalar dispersivity(const Element &element,
-                        const SubControlVolume& scv,
-                        const ElementSolutionVector& elemSol) const
-    { return 0; }
-
-    /*!
-     * \brief Returns the heat capacity \f$[J / (kg K)]\f$ of the rock matrix.
-     *
-     * This is only required for non-isothermal models.
-     *
-     * \param element The element
-     * \param scv The sub control volume
-     * \param elemSol The element solution vector
-     */
-    Scalar solidHeatCapacity(const Element &element,
-                             const SubControlVolume& scv,
-                             const ElementSolutionVector& elemSol) const
-    { return 790; /*specific heat capacity of granite [J / (kg K)]*/ }
-
-    /*!
-     * \brief Returns the mass density \f$[kg / m^3]\f$ of the rock matrix.
-     *
-     * This is only required for non-isothermal models.
-     *
-     * \param element The element
-     * \param scv The sub control volume
-     * \param elemSol The element solution vector
-     */
-    Scalar solidDensity(const Element &element,
-                        const SubControlVolume& scv,
-                        const ElementSolutionVector& elemSol) const
-    { return 2700; /*density of granite [kg/m^3]*/ }
-
-    /*!
-     * \brief Returns the thermal conductivity \f$\mathrm{[W/(m K)]}\f$ of the porous material.
-     *
-     * \param element The element
-     * \param scv The sub control volume
-     * \param elemSol The element solution vector
-     */
-    Scalar solidThermalConductivity(const Element &element,
-                                    const SubControlVolume& scv,
-                                    const ElementSolutionVector& elemSol) const
-    { return lambdaSolid_; }
-
-
-
-private:
-    Scalar permeability_;
-    Scalar porosity_;
-    Scalar lambdaSolid_;
-};
-
-} // end namespace Dumux
-
-#endif
diff --git a/test/porousmediumflow/1pnc/implicit/CMakeLists.txt b/test/porousmediumflow/1pnc/implicit/CMakeLists.txt
index 9414d0ace4c8b187cb98a59b54e6b32c64b5291b..8e12efbd12c23159ee88bb6d3b482946a48b0fd0 100644
--- a/test/porousmediumflow/1pnc/implicit/CMakeLists.txt
+++ b/test/porousmediumflow/1pnc/implicit/CMakeLists.txt
@@ -1,10 +1,31 @@
 add_input_file_links()
 
-dune_add_test(NAME test_1pnc_box
-              SOURCES test_1pnc.cc
-              COMPILE_DEFINITIONS TYPETAG=OnePNCTestBoxProblem
+dune_add_test(NAME test_1p2c_box
+              SOURCES test_1p2c_fv.cc
+              COMPILE_DEFINITIONS TYPETAG=OnePTwoCTestBoxProblem
               COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
               CMD_ARGS  --script fuzzy
-                        --files ${CMAKE_SOURCE_DIR}/test/references/1ptestcc-reference.vtu
-                                ${CMAKE_CURRENT_BINARY_DIR}/1p_tpfa-00010.vtu
-                        --command "${CMAKE_CURRENT_BINARY_DIR}/test_1pnc_box")
+                        --files ${CMAKE_SOURCE_DIR}/test/references/outflowbox-reference.vtu
+                                ${CMAKE_CURRENT_BINARY_DIR}/1pnctestbox-00009.vtu
+                        --command "${CMAKE_CURRENT_BINARY_DIR}/test_1p2c_box test_1p2c_fv.input -Problem.Name 1pnctestbox"
+                        --zeroThreshold {"velocity_w \(m/s\)_1":1e-15})
+
+dune_add_test(NAME test_1p2c_tpfa
+              SOURCES test_1p2c_fv.cc
+              COMPILE_DEFINITIONS TYPETAG=OnePTwoCTestCCTpfaProblem
+              COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
+              CMD_ARGS  --script fuzzy
+                        --files ${CMAKE_SOURCE_DIR}/test/references/1p2ctestcc-reference.vtu
+                                ${CMAKE_CURRENT_BINARY_DIR}/1pnctest_tpfa-00009.vtu
+                        --command "${CMAKE_CURRENT_BINARY_DIR}/test_1p2c_tpfa test_1p2c_fv.input -Problem.Name 1pnctest_tpfa"
+                        --zeroThreshold {"velocity_w \(m/s\)_1":1e-15})
+
+dune_add_test(NAME test_1p2c_mpfa
+              SOURCES test_1p2c_fv.cc
+              COMPILE_DEFINITIONS TYPETAG=OnePTwoCTestCCMpfaProblem
+              COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py
+              CMD_ARGS  --script fuzzy
+                        --files ${CMAKE_SOURCE_DIR}/test/references/1p2ctestcc-reference.vtu
+                                ${CMAKE_CURRENT_BINARY_DIR}/1pnctest_mpfa-00009.vtu
+                        --command "${CMAKE_CURRENT_BINARY_DIR}/test_1p2c_mpfa test_1p2c_fv.input -Problem.Name 1pnctest_mpfa"
+                        --zeroThreshold {"velocity_w \(m/s\)_1":1e-15})
diff --git a/test/porousmediumflow/1pnc/implicit/test_1pnc.cc b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc
similarity index 96%
rename from test/porousmediumflow/1pnc/implicit/test_1pnc.cc
rename to test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc
index 7bb227b2e8d055b89c4d3db83eda3c651db2dc43..8192151acf6ad08a4b3b6b7c944824d3fe7fba9e 100644
--- a/test/porousmediumflow/1pnc/implicit/test_1pnc.cc
+++ b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.cc
@@ -23,7 +23,7 @@
  */
  #include <config.h>
 
- #include "1pnctestproblem.hh"
+ #include "1p2ctestproblem.hh"
 
  #include <ctime>
  #include <iostream>
@@ -120,7 +120,8 @@
      vtkWriter.write(0.0);
 
      // instantiate time loop
-     auto timeLoop = std::make_shared<CheckPointTimeLoop<Scalar>>(0.0, dt, tEnd);
+    //  auto timeLoop = std::make_shared<CheckPointTimeLoop<Scalar>>(0.0, dt, tEnd);
+     auto timeLoop = std::make_shared<TimeLoop<Scalar>>(0.0, dt, tEnd);
      timeLoop->setMaxTimeStepSize(maxDt);
 
      // the assembler with time loop for instationary problem
@@ -137,7 +138,8 @@
      NewtonMethod<NewtonController, Assembler, LinearSolver> nonLinearSolver(newtonController, assembler, linearSolver);
 
      // set some check points for the time loop
-     timeLoop->setPeriodicCheckPoint(tEnd/10.0);
+    //  timeLoop->setPeriodicCheckPoint(1);
+    //  timeLoop->setPeriodicCheckPoint(tEnd/10.0);
 
      // time loop
      timeLoop->start(); do
@@ -172,7 +174,7 @@
          timeLoop->advanceTimeStep();
 
          // write vtk output
-         if (timeLoop->isCheckPoint())
+        //  if (timeLoop->isCheckPoint())
              vtkWriter.write(timeLoop->time());
 
          // report statistics of this time step
diff --git a/test/porousmediumflow/1pnc/implicit/test_box1pnc.input b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.input
similarity index 71%
rename from test/porousmediumflow/1pnc/implicit/test_box1pnc.input
rename to test/porousmediumflow/1pnc/implicit/test_1p2c_fv.input
index da81d0709316f2bea7d129faad18037a197e01f0..cabdfa329110f576158d79372efa700e7d2774f0 100644
--- a/test/porousmediumflow/1pnc/implicit/test_box1pnc.input
+++ b/test/porousmediumflow/1pnc/implicit/test_1p2c_fv.input
@@ -8,8 +8,9 @@ UpperRight = 1 1
 Cells = 20 2
 
 [Problem]
-Name = 1pnctestbox # name passed to the output routines
+Name = outflowtest # name passed to the output routines
 EnableGravity = 0 # disable gravity
+UseNitscheTypeBc = true
 
 [Vtk]
 AddVelocity = 1 # enable velocity output
diff --git a/test/porousmediumflow/1pnc/implicit/test_box1p2c.input b/test/porousmediumflow/1pnc/implicit/test_box1p2c.input
deleted file mode 100644
index 85a6863ffc9d55dd83165058342f7f38da8dc4a7..0000000000000000000000000000000000000000
--- a/test/porousmediumflow/1pnc/implicit/test_box1p2c.input
+++ /dev/null
@@ -1,15 +0,0 @@
-[TimeManager]
-DtInitial = 1 # [s]
-TEnd = 100 # [s]
-
-[Grid]
-LowerLeft = 0 0
-UpperRight = 1 1
-Cells = 20 2
-
-[Problem]
-Name = outflowbox # name passed to the output routines
-EnableGravity = 0 # disable gravity
-
-[Vtk]
-AddVelocity = 1 # enable velocity output
diff --git a/test/porousmediumflow/1pnc/implicit/test_cc1pnc.input b/test/porousmediumflow/1pnc/implicit/test_cc1pnc.input
deleted file mode 100644
index 7a4802f5a223f2c9d8b24c4b76941bbb73b5d804..0000000000000000000000000000000000000000
--- a/test/porousmediumflow/1pnc/implicit/test_cc1pnc.input
+++ /dev/null
@@ -1,15 +0,0 @@
-[TimeManager]
-DtInitial = 1 # [s]
-TEnd = 100 # [s]
-
-[Grid]
-LowerLeft = 0 0
-UpperRight = 1 1
-Cells = 20 2
-
-[Problem]
-Name = 1pnctestcc # name passed to the output routines
-EnableGravity = 0 # disable gravity
-
-[Vtk]
-AddVelocity = 1 # enable velocity output
diff --git a/test/references/1p2ctestcc-reference.vtu b/test/references/1p2ctestcc-reference.vtu
index 80794763ebcfbec93fcbc71ae2b2a6a71532a002..9ff55a4e2cdd5f6793c4a0cc36670cfbd03b156a 100644
--- a/test/references/1p2ctestcc-reference.vtu
+++ b/test/references/1p2ctestcc-reference.vtu
@@ -2,8 +2,8 @@
 <VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
   <UnstructuredGrid>
     <Piece NumberOfCells="40" NumberOfPoints="63">
-      <CellData Scalars="P" Vectors="velocity">
-        <DataArray type="Float32" Name="P" NumberOfComponents="1" format="ascii">
+      <CellData Scalars="pressure" Vectors="velocity_w (m/s)">
+        <DataArray type="Float32" Name="pressure" NumberOfComponents="1" format="ascii">
           197500 192500 187500 182501 177501 172501 167501 162501 157501 152501 147501 142501
           137501 132501 127501 122501 117501 112500 107500 102500 197500 192500 187500 182501
           177501 172501 167501 162501 157501 152501 147501 142501 137501 132501 127501 122501
@@ -15,7 +15,7 @@
           77500.7 72500.8 67500.8 62500.9 57500.9 52501 47501 42500.9 37500.9 32500.8 27500.8 22500.7
           17500.6 12500.4 7500.27 2500.1
         </DataArray>
-        <DataArray type="Float32" Name="velocity" NumberOfComponents="3" format="ascii">
+        <DataArray type="Float32" Name="velocity_w (m/s)" NumberOfComponents="3" format="ascii">
           0.00997014 2.9018e-18 0 0.00997016 2.90179e-18 0 0.00997018 0 0 0.00997021 2.90178e-18 0
           0.00997023 2.90178e-18 0 0.00997025 2.90177e-18 0 0.00997027 2.90177e-18 0 0.0099703 2.90176e-18 0
           0.00997032 2.90176e-18 0 0.00997034 2.90176e-18 0 0.00997037 2.90175e-18 0 0.00997039 2.90175e-18 0
diff --git a/test/references/outflowbox-reference.vtu b/test/references/outflowbox-reference.vtu
index 40699b6cdd3a74e7b26403cc6db8d5b05655eecb..ce25af260b4a90d1bb950e84c03f8f8c81397b5b 100644
--- a/test/references/outflowbox-reference.vtu
+++ b/test/references/outflowbox-reference.vtu
@@ -2,8 +2,8 @@
 <VTKFile type="UnstructuredGrid" version="0.1" byte_order="LittleEndian">
   <UnstructuredGrid>
     <Piece NumberOfCells="40" NumberOfPoints="63">
-      <PointData Scalars="P" Vectors="velocity">
-        <DataArray type="Float32" Name="P" NumberOfComponents="1" format="ascii">
+      <PointData Scalars="pressure" Vectors="velocity_w (m/s)">
+        <DataArray type="Float32" Name="pressure" NumberOfComponents="1" format="ascii">
           200000 195000 200000 195000 190000 190000 185000 185000 180001 180001 175001 175001
           170001 170001 165001 165001 160001 160001 155001 155001 150001 150001 145001 145001
           140001 140001 135001 135001 130001 130001 125001 125001 120001 120001 115000 115000
@@ -19,7 +19,7 @@
           70000.8 65000.9 60000.9 55001 50001 45001 40000.9 35000.9 30000.8 25000.7 20000.6 15000.5
           10000.3 5000.18 0
         </DataArray>
-        <DataArray type="Float32" Name="velocity" NumberOfComponents="3" format="ascii">
+        <DataArray type="Float32" Name="velocity_w (m/s)" NumberOfComponents="3" format="ascii">
           0.00997014 1.4509e-18 0 0.00997015 2.11437e-17 0 0.00997014 2.9018e-18 0 0.00997015 -3.62724e-19 0
           0.00997017 2.69473e-17 0 0.00997017 3.26451e-18 0 0.0099702 6.52902e-18 0 0.0099702 7.25446e-19 0
           0.00997022 5.3895e-17 0 0.00997022 3.62722e-19 0 0.00997024 5.67968e-17 0 0.00997024 -3.62722e-19 0