diff --git a/applications/solvers/multiphase/multiphaseInterFoam/Allwclean b/applications/solvers/multiphase/multiphaseInterFoam/Allwclean
index 6f55580c42a1139176cd44f717656c590537704f..6b5dc2e5c65086adaceccd89880eb13770eb92c1 100755
--- a/applications/solvers/multiphase/multiphaseInterFoam/Allwclean
+++ b/applications/solvers/multiphase/multiphaseInterFoam/Allwclean
@@ -2,7 +2,7 @@
 cd ${0%/*} || exit 1    # run from this directory
 set -x
 
+wclean libso multiphaseMixture
 wclean
-wclean MRFMultiphaseInterFoam
 
 # ----------------------------------------------------------------- end-of-file
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/Allwmake b/applications/solvers/multiphase/multiphaseInterFoam/Allwmake
index 6e47f91dd922f2e8ac52df6d835e0e8bc70ef55f..6ceded9c1a94ccaf143640a65b5cd89bdfb67a7d 100755
--- a/applications/solvers/multiphase/multiphaseInterFoam/Allwmake
+++ b/applications/solvers/multiphase/multiphaseInterFoam/Allwmake
@@ -4,6 +4,5 @@ set -x
 
 wmake libso multiphaseMixture
 wmake
-wmake MRFMultiphaseInterFoam
 
 # ----------------------------------------------------------------- end-of-file
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/MRFMultiphaseInterFoam.C b/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/MRFMultiphaseInterFoam.C
deleted file mode 100644
index 8c73d798f6e9222a2049b540c0a2bf7bfc7c2afc..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/MRFMultiphaseInterFoam.C
+++ /dev/null
@@ -1,110 +0,0 @@
-/*---------------------------------------------------------------------------*\
-  =========                 |
-  \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
-   \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
-     \\/     M anipulation  |
--------------------------------------------------------------------------------
-License
-    This file is part of OpenFOAM.
-
-    OpenFOAM 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 3 of the License, or
-    (at your option) any later version.
-
-    OpenFOAM 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 OpenFOAM.  If not, see <http://www.gnu.org/licenses/>.
-
-Application
-    MRFMultiphaseInterFoam
-
-Description
-    Solver for n incompressible fluids which captures the interfaces and
-    includes surface-tension and contact-angle effects for each phase.
-
-    Turbulence modelling is generic, i.e. laminar, RAS or LES may be selected.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fvCFD.H"
-#include "multiphaseMixture.H"
-#include "turbulenceModel.H"
-#include "IOMRFZoneList.H"
-#include "pimpleControl.H"
-#include "fixedFluxPressureFvPatchScalarField.H"
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-int main(int argc, char *argv[])
-{
-    #include "setRootCase.H"
-    #include "createTime.H"
-    #include "createMesh.H"
-
-    pimpleControl pimple(mesh);
-
-    #include "initContinuityErrs.H"
-    #include "createFields.H"
-    #include "createMRFZones.H"
-    #include "readTimeControls.H"
-    #include "createPrghCorrTypes.H"
-    #include "correctPhi.H"
-    #include "CourantNo.H"
-    #include "setInitialDeltaT.H"
-
-    // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-    Info<< "\nStarting time loop\n" << endl;
-
-    while (runTime.run())
-    {
-        #include "readTimeControls.H"
-        #include "CourantNo.H"
-        #include "alphaCourantNo.H"
-        #include "setDeltaT.H"
-
-        runTime++;
-
-        Info<< "Time = " << runTime.timeName() << nl << endl;
-
-        mixture.solve();
-        rho = mixture.rho();
-        #include "zonePhaseVolumes.H"
-
-        // --- Pressure-velocity PIMPLE corrector loop
-        while (pimple.loop())
-        {
-            #include "UEqn.H"
-
-            // --- Pressure corrector loop
-            while (pimple.correct())
-            {
-                #include "pEqn.H"
-            }
-
-            if (pimple.turbCorr())
-            {
-                turbulence->correct();
-            }
-        }
-
-        runTime.write();
-
-        Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"
-            << "  ClockTime = " << runTime.elapsedClockTime() << " s"
-            << nl << endl;
-    }
-
-    Info<< "End\n" << endl;
-
-    return 0;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/Make/files b/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/Make/files
deleted file mode 100644
index c4ed7d3fc42d968535f30d60d095b1379424ea64..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/Make/files
+++ /dev/null
@@ -1,3 +0,0 @@
-MRFMultiphaseInterFoam.C
-
-EXE = $(FOAM_APPBIN)/MRFMultiphaseInterFoam
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/Make/options b/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/Make/options
deleted file mode 100644
index 11e9aee8a52c5fd7f83efceaf8ca1e8ccaf7a4a9..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/Make/options
+++ /dev/null
@@ -1,19 +0,0 @@
-EXE_INC = \
-    -I.. \
-    -I../../interFoam \
-    -I../../interFoam/MRFInterFoam \
-    -I../multiphaseMixture/lnInclude \
-    -I$(LIB_SRC)/transportModels \
-    -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
-    -I$(LIB_SRC)/transportModels/interfaceProperties/lnInclude \
-    -I$(LIB_SRC)/turbulenceModels/incompressible/turbulenceModel \
-    -I$(LIB_SRC)/finiteVolume/lnInclude
-
-EXE_LIBS = \
-    -lmultiphaseInterFoam \
-    -linterfaceProperties \
-    -lincompressibleTransportModels \
-    -lincompressibleTurbulenceModel \
-    -lincompressibleRASModels \
-    -lincompressibleLESModels \
-    -lfiniteVolume
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/UEqn.H b/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/UEqn.H
deleted file mode 100644
index 3b860b975a7a1e71895b4b408679661e3c858541..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/UEqn.H
+++ /dev/null
@@ -1,35 +0,0 @@
-    surfaceScalarField muEff
-    (
-        "muEff",
-        mixture.muf()
-      + fvc::interpolate(rho*turbulence->nut())
-    );
-
-    fvVectorMatrix UEqn
-    (
-        fvm::ddt(rho, U)
-      + fvm::div(mixture.rhoPhi(), U)
-      - fvm::laplacian(muEff, U)
-      - (fvc::grad(U) & fvc::grad(muEff))
-    //- fvc::div(muEff*(fvc::interpolate(dev(fvc::grad(U))) & mesh.Sf()))
-    );
-    mrfZones.addCoriolis(rho, UEqn);
-
-    UEqn.relax();
-
-    if (pimple.momentumPredictor())
-    {
-        solve
-        (
-            UEqn
-         ==
-            fvc::reconstruct
-            (
-                (
-                    mixture.surfaceTensionForce()
-                  - ghf*fvc::snGrad(rho)
-                  - fvc::snGrad(p_rgh)
-                ) * mesh.magSf()
-            )
-        );
-    }
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/pEqn.H b/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/pEqn.H
deleted file mode 100644
index 128622667691859179b0cc34c34eaa357580d2fc..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/pEqn.H
+++ /dev/null
@@ -1,68 +0,0 @@
-{
-    volScalarField rAU("rAU", 1.0/UEqn.A());
-    surfaceScalarField rAUf("rAUf", fvc::interpolate(rAU));
-
-    volVectorField HbyA("HbyA", U);
-    HbyA = rAU*UEqn.H();
-
-    surfaceScalarField phiHbyA
-    (
-        "phiHbyA",
-        (fvc::interpolate(HbyA) & mesh.Sf())
-      + fvc::interpolate(rho*rAU)*fvc::ddtCorr(U, phi)
-    );
-    adjustPhi(phiHbyA, U, p_rgh);
-    mrfZones.makeRelative(phiHbyA);
-
-    surfaceScalarField phig
-    (
-        - ghf*fvc::snGrad(rho)*rAUf*mesh.magSf()
-    );
-
-    phiHbyA += phig;
-
-    // Update the fixedFluxPressure BCs to ensure flux consistency
-    setSnGrad<fixedFluxPressureFvPatchScalarField>
-    (
-        p_rgh.boundaryField(),
-        (
-            phiHbyA.boundaryField()
-          - mrfZones.relative(mesh.Sf().boundaryField() & U.boundaryField())
-        )/(mesh.magSf().boundaryField()*rAUf.boundaryField())
-    );
-
-    while (pimple.correctNonOrthogonal())
-    {
-        fvScalarMatrix p_rghEqn
-        (
-            fvm::laplacian(rAUf, p_rgh) == fvc::div(phiHbyA)
-        );
-
-        p_rghEqn.setReference(pRefCell, getRefCellValue(p_rgh, pRefCell));
-
-        p_rghEqn.solve(mesh.solver(p_rgh.select(pimple.finalInnerIter())));
-
-        if (pimple.finalNonOrthogonalIter())
-        {
-            phi = phiHbyA - p_rghEqn.flux();
-
-            U = HbyA + rAU*fvc::reconstruct((phig - p_rghEqn.flux())/rAUf);
-            U.correctBoundaryConditions();
-        }
-    }
-
-    #include "continuityErrs.H"
-
-    p == p_rgh + rho*gh;
-
-    if (p_rgh.needReference())
-    {
-        p += dimensionedScalar
-        (
-            "p",
-            p.dimensions(),
-            pRefValue - getRefCellValue(p, pRefCell)
-        );
-        p_rgh = p - rho*gh;
-    }
-}
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/zonePhaseVolumes.H b/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/zonePhaseVolumes.H
deleted file mode 100644
index 0c5d12217b5a4df9420a27bd341057f17dc9c48f..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/multiphaseInterFoam/MRFMultiphaseInterFoam/zonePhaseVolumes.H
+++ /dev/null
@@ -1,26 +0,0 @@
-{
-    const scalarField& V = mesh.V();
-
-    forAll(mesh.cellZones(), czi)
-    {
-        const labelList& cellLabels = mesh.cellZones()[czi];
-
-        forAllConstIter(PtrDictionary<phase>, mixture.phases(), iter)
-        {
-            const volScalarField& alpha = iter();
-            scalar phaseVolume = 0;
-
-            forAll(cellLabels, cli)
-            {
-                label celli = cellLabels[cli];
-                phaseVolume += alpha[celli]*V[celli];
-            }
-
-            reduce(phaseVolume, sumOp<scalar>());
-
-            Info<< alpha.name()
-                << " phase volume in zone " << mesh.cellZones()[czi].name()
-                << " = " << phaseVolume*1e6 << " ml " << endl;
-        }
-    }
-}
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/Make/options b/applications/solvers/multiphase/multiphaseInterFoam/Make/options
index 022293a58fe2755a668ac229e466b8791c50ae5d..27f633d621e864eab235e833aadcb853d65b8daa 100644
--- a/applications/solvers/multiphase/multiphaseInterFoam/Make/options
+++ b/applications/solvers/multiphase/multiphaseInterFoam/Make/options
@@ -5,7 +5,10 @@ EXE_INC = \
     -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
     -I$(LIB_SRC)/transportModels/interfaceProperties/lnInclude \
     -I$(LIB_SRC)/turbulenceModels/incompressible/turbulenceModel \
-    -I$(LIB_SRC)/finiteVolume/lnInclude
+    -I$(LIB_SRC)/finiteVolume/lnInclude \
+    -I$(LIB_SRC)/fvOptions/lnInclude \
+    -I$(LIB_SRC)/meshTools/lnInclude \
+    -I$(LIB_SRC)/sampling/lnInclude
 
 EXE_LIBS = \
     -lmultiphaseInterFoam \
@@ -14,4 +17,7 @@ EXE_LIBS = \
     -lincompressibleTurbulenceModel \
     -lincompressibleRASModels \
     -lincompressibleLESModels \
-    -lfiniteVolume
+    -lfiniteVolume \
+    -lfvOptions \
+    -lmeshTools \
+    -lsampling
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H b/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H
index fbcba7db72d751ac5b48d8055789b54eb8877b73..5dd13a4ecf5acc74371ee6695be0be1202ae1dd0 100644
--- a/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H
+++ b/applications/solvers/multiphase/multiphaseInterFoam/UEqn.H
@@ -3,10 +3,14 @@
         fvm::ddt(rho, U)
       + fvm::div(mixture.rhoPhi(), U)
       + turbulence->divDevRhoReff(rho, U)
+     ==
+        fvOptions(rho, U)
     );
 
     UEqn.relax();
 
+    fvOptions.constrain(UEqn);
+
     if (pimple.momentumPredictor())
     {
         solve
@@ -22,4 +26,6 @@
                 ) * mesh.magSf()
             )
         );
+
+        fvOptions.correct(U);
     }
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/createFields.H b/applications/solvers/multiphase/multiphaseInterFoam/createFields.H
index 78fa0ec3098b1bebee455b270da92606c3bcae07..c19f9ea9e3effaca5c09d2c4f9b044039007f252 100644
--- a/applications/solvers/multiphase/multiphaseInterFoam/createFields.H
+++ b/applications/solvers/multiphase/multiphaseInterFoam/createFields.H
@@ -90,3 +90,5 @@
             pRefValue - getRefCellValue(p, pRefCell)
         );
     }
+
+    fv::IOoptionList fvOptions(mesh);
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/multiphaseInterFoam.C b/applications/solvers/multiphase/multiphaseInterFoam/multiphaseInterFoam.C
index d2c565b915c6d8e5fa8eee67c274be58694b947b..fdd93eae5da22ccd9cd473f517e8ce25aa6b3a72 100644
--- a/applications/solvers/multiphase/multiphaseInterFoam/multiphaseInterFoam.C
+++ b/applications/solvers/multiphase/multiphaseInterFoam/multiphaseInterFoam.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2014 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -36,6 +36,7 @@ Description
 #include "multiphaseMixture.H"
 #include "turbulenceModel.H"
 #include "pimpleControl.H"
+#include "fvIOoptionList.H"
 #include "fixedFluxPressureFvPatchScalarField.H"
 
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
diff --git a/applications/solvers/multiphase/multiphaseInterFoam/pEqn.H b/applications/solvers/multiphase/multiphaseInterFoam/pEqn.H
index a40c2be91b917517513202a15c2bf2eb5ad843ad..8ce663528d16962db57247c1d6453fd3726f4f4d 100644
--- a/applications/solvers/multiphase/multiphaseInterFoam/pEqn.H
+++ b/applications/solvers/multiphase/multiphaseInterFoam/pEqn.H
@@ -12,6 +12,7 @@
       + fvc::interpolate(rho*rAU)*fvc::ddtCorr(U, phi)
     );
     adjustPhi(phiHbyA, U, p_rgh);
+    fvOptions.makeRelative(phiHbyA);
 
     surfaceScalarField phig
     (
@@ -29,7 +30,7 @@
         p_rgh.boundaryField(),
         (
             phiHbyA.boundaryField()
-          - (mesh.Sf().boundaryField() & U.boundaryField())
+          - fvOptions.relative(mesh.Sf().boundaryField() & U.boundaryField())
         )/(mesh.magSf().boundaryField()*rAUf.boundaryField())
     );
 
@@ -50,6 +51,7 @@
 
             U = HbyA + rAU*fvc::reconstruct((phig - p_rghEqn.flux())/rAUf);
             U.correctBoundaryConditions();
+            fvOptions.correct(U);
         }
     }
 
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/U b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/U
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/U
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/U
index b2024d5b773409c0ff9c135f42cf79b8b96d8111..b13f9a2d8cba15ec76d481d1682aea55c02e654a 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/U
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/U
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.air b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.air
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.air
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.air
index 3b026125b2da25f0c5f0b4722a698e8fa386070e..436352993835380e0d112c009d7b98d3347591e6 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.air
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.air
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.mercury b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.mercury
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.mercury
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.mercury
index 7fb8dd6a40d69d33610d6e2770c7e7d049866023..58a898efca449980a8f132322eec2fa3bf089d62 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.mercury
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.mercury
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.oil b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.oil
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.oil
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.oil
index 43b245bed14865f3dade2cddc2e20e12b1eb35a1..b8e2333b422a54e5b6e2f4676667e7bc3eed8bc4 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.oil
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.oil
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.water b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.water
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.water
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.water
index 613e7cf1e9009cd088cd84c61bc88526c95c8ea1..cfa5d44c55d7c08a8e49bf9b452f080c5c707bc4 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/alpha.water
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/alpha.water
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/p_rgh b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/p_rgh
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/p_rgh
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/p_rgh
index 3ea5cd88c81a7b9f0626293c405cf5a46d30dfd2..7b7a6e046b268bb733b4a49ae7fbbec2b671fe3d 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/p_rgh
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0.org/p_rgh
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/U b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/U
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/U
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/U
index b2024d5b773409c0ff9c135f42cf79b8b96d8111..b13f9a2d8cba15ec76d481d1682aea55c02e654a 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0.org/U
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/U
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.air b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.air
similarity index 99%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.air
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.air
index ed1b0a21f522df64bfc1929cc153f95474ceedf8..4cad3a396bcf62b6e9f3b0aff658a532b6e2be38 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.air
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.air
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.mercury b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.mercury
similarity index 99%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.mercury
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.mercury
index ad43adf298c2a4352aa88e7fd6c9865a690b6e17..e414b356b61d35b0c4a967a656822b1177930f4a 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.mercury
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.mercury
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.oil b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.oil
similarity index 99%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.oil
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.oil
index 8b4649379fa46e71e403a1a14a1500adffebd11b..1820db5e7939fb1ce3a69c90d125d9312f1eb272 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.oil
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.oil
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.water b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.water
similarity index 99%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.water
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.water
index 10bf5279e5d323ca7160b8ff2704117efba105d0..de2872a53331306c5a390f2a807e6f254daebd3b 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/alpha.water
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/alpha.water
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/p_rgh b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/p_rgh
similarity index 94%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/p_rgh
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/p_rgh
index 3ea5cd88c81a7b9f0626293c405cf5a46d30dfd2..7b7a6e046b268bb733b4a49ae7fbbec2b671fe3d 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/0/p_rgh
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/0/p_rgh
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/Allclean b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/Allclean
similarity index 100%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/Allclean
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/Allclean
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/Allrun b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/Allrun
similarity index 100%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/Allrun
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/Allrun
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/g b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/g
similarity index 93%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/g
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/g
index 36eafd9d27f4de5efbe8142b0e846e5a812d6360..099c2ee8a62844bf34ffe9a2ea32e432404ccf87 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/g
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/g
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4 b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/polyMesh/blockMeshDict.m4
similarity index 99%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/polyMesh/blockMeshDict.m4
index baeabd1414066827d3ef646a62627bfe042992f6..2b215888a71c4f049ce41ce41a9c6154f2946c2a 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/polyMesh/blockMeshDict.m4
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/polyMesh/blockMeshDict.m4
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/polyMesh/boundary b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/polyMesh/boundary
similarity index 91%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/polyMesh/boundary
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/polyMesh/boundary
index 7ee4864d8bbaaf41eac0ae71fef2adeef519200b..e1125126de82d454ab3ac4da655292f87261882b 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/polyMesh/boundary
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/polyMesh/boundary
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
@@ -20,12 +20,14 @@ FoamFile
     rotor
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          192;
         startFace       5952;
     }
     stator
     {
         type            wall;
+        inGroups        1(wall);
         nFaces          192;
         startFace       6144;
     }
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/transportProperties b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/transportProperties
similarity index 96%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/transportProperties
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/transportProperties
index d74633a02a68e74171ab72df5fc957943be64bc2..79b59a2cbbd6ec3083cf6bd6a7565b2881a2c3f3 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/transportProperties
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/transportProperties
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/turbulenceProperties b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/turbulenceProperties
similarity index 92%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/turbulenceProperties
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/turbulenceProperties
index b2fc0a43429976f47ac3533c8284c22d1f81909d..8e0954f71164cc422e17f963f55e7813f8e8c6a8 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/turbulenceProperties
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/constant/turbulenceProperties
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/makeMesh b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/makeMesh
similarity index 100%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/makeMesh
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/makeMesh
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/controlDict b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/controlDict
similarity index 92%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/controlDict
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/controlDict
index 6d4e722854ff4b8242c41d10aa850f073fc1102d..1f50b40157537551cf5e89e0d3be355fb9593336 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/controlDict
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/controlDict
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
@@ -15,7 +15,7 @@ FoamFile
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-application     MRFMultiphaseInterFoam;
+application     multiphaseInterFoam;
 
 startFrom       startTime;
 
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/MRFProperties b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvOptions
similarity index 62%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/MRFProperties
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvOptions
index c9bc352a738b3fc246e66e410d5924d8c171622f..6cc02ab9a77c8b61117b079fbbbcf6024859ff6d 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/constant/MRFProperties
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvOptions
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
@@ -10,22 +10,28 @@ FoamFile
     version     2.0;
     format      ascii;
     class       dictionary;
-    location    "constant";
-    object      MRFProperties;
+    location    "system";
+    object      fvOptions;
 }
 // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
 
-zone1
+MRF1
 {
-    cellZone    rotor;
-    active      yes;
+    type            MRFSource;
+    active          yes;
+    selectionMode   cellZone;
+    cellZone        rotor;
 
-    // Fixed patches (by default they 'move' with the MRF zone)
-    nonRotatingPatches ();
+    MRFSourceCoeffs
+    {
+        // Fixed patches (by default they 'move' with the MRF zone)
+        nonRotatingPatches ();
 
-    origin    (0 0 0);
-    axis      (0 0 1);
-    omega     constant 6.2831853;
+        origin    (0 0 0);
+        axis      (0 0 1);
+        omega     constant 6.2831853;
+    }
 }
 
+
 // ************************************************************************* //
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/fvSchemes b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvSchemes
similarity index 95%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/fvSchemes
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvSchemes
index f2a3633fe52b92a93bd0feb37de558e173050433..17714c6ce73d2b59ba5fc2fb030e6bc046a2a441 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/fvSchemes
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvSchemes
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/fvSolution b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvSolution
similarity index 96%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/fvSolution
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvSolution
index cd2b6c160901786b92075684348f343e35e5c6f4..e6e9fbddd0d30a29b2354eb229f5200797db8f1b 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/fvSolution
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/fvSolution
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/setFieldsDict b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/setFieldsDict
similarity index 96%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/setFieldsDict
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/setFieldsDict
index d9e536a99f6678d3f779255d8f0d83eec1376418..6e8f2f034c8ef44b05bd30e21e1d55c4a6aac48b 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/setFieldsDict
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/setFieldsDict
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
diff --git a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/topoSetDict b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/topoSetDict
similarity index 93%
rename from tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/topoSetDict
rename to tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/topoSetDict
index 439171e72f2aac910b45762f3788a7356153fb45..8aa466295f7f3e8f5019b4d3adb936147f7cc26f 100644
--- a/tutorials/multiphase/MRFMultiphaseInterFoam/mixerVessel2D/system/topoSetDict
+++ b/tutorials/multiphase/multiphaseInterFoam/laminar/mixerVessel2D/system/topoSetDict
@@ -1,7 +1,7 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  2.3.0                                 |
+|  \\    /   O peration     | Version:  2.3.x                                 |
 |   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/