diff --git a/applications/solvers/multiphase/interIsoFoam/alphaControls.H b/applications/solvers/multiphase/interIsoFoam/alphaControls.H
index ebe73c3c2c4624b7bd058509209601b4b345c035..db77d94af4dee9b8099d9d77b15fcced6e4b72cd 100644
--- a/applications/solvers/multiphase/interIsoFoam/alphaControls.H
+++ b/applications/solvers/multiphase/interIsoFoam/alphaControls.H
@@ -1,29 +1,3 @@
 const dictionary& alphaControls = mesh.solverDict(alpha1.name());
 
-//label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
-
 label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
-
-/*
-bool MULESCorr(alphaControls.lookupOrDefault("MULESCorr", false));
-
-// Apply the compression correction from the previous iteration
-// Improves efficiency for steady-simulations but can only be applied
-// once the alpha field is reasonably steady, i.e. fully developed
-bool alphaApplyPrevCorr
-(
-    alphaControls.lookupOrDefault("alphaApplyPrevCorr", false)
-);
-
-// Isotropic compression coefficient
-scalar icAlpha
-(
-    alphaControls.lookupOrDefault<scalar>("icAlpha", 0)
-);
-
-// Shear compression coefficient
-scalar scAlpha
-(
-    alphaControls.lookupOrDefault<scalar>("scAlpha", 0)
-);
-*/
diff --git a/applications/solvers/multiphase/interIsoFoam/alphaEqn.H b/applications/solvers/multiphase/interIsoFoam/alphaEqn.H
index 1bda9eef188e7479ff9d2e687904c6718b45492f..a73391a996bbfb3f05465bd144951865a74a0ddf 100644
--- a/applications/solvers/multiphase/interIsoFoam/alphaEqn.H
+++ b/applications/solvers/multiphase/interIsoFoam/alphaEqn.H
@@ -1,50 +1,53 @@
+{
+    // Note for AMR implementation:
+    // At this point we have just entered the new time step,
+    // the mesh has been refined and the alpha, phi and U contain
+    // the field values at the beginning of this time step mapped
+    // to the new mesh.
+
+    // The above assumes that we are in firstIter() of the outer
+    // corrector loop. If we are in any subsequent iter of this loop
+    // the alpha1, U and phi will be overwritten with the new time step
+    // values but still on the same mesh.
+
+
+    if (pimple.firstIter())
     {
-        // Note for AMR implementation:
-        // At this point we have just entered the new time step,
-        // the mesh has been refined and the alpha, phi and U contain
-        // the field values at the beginning of this time step mapped
-        // to the new mesh.
-
-        // The above assumes that we are in firstIter() of the outer
-        // corrector loop. If we are in any subsequent iter of this loop
-        // the alpha1, U and phi will be overwritten with the new time step
-        // values but still on the same mesh.
-
-
-        if (pimple.firstIter())
-        {
-            // Note: This assumes moveMeshOuterCorrectors is false
-            alpha10 = alpha1;
-            U0 = U;
-            phi0 = phi;
-            advector.advect();
-
-            #include "rhofs.H"
-            rhoPhi = advector.getRhoPhi(rho1f, rho2f);
-        }
-        else
-        {
-            alpha1 = alpha10;
-            // Temporarily setting U and phi to average of old and new value
-            // Note: Illegal additions if mesh is topoChanging
-            // (e.g. if moveMeshOuterCorrectors and AMR)
-            U = 0.5*U0 + 0.5*U;
-            phi = 0.5*phi0 + 0.5*phi;
-            isoAdvection advector(alpha1, phi, U);
-            advector.advect();
-            #include "rhofs.H"
-            rhoPhi = advector.getRhoPhi(rho1f, rho2f);
-            // Resetting U and phi to the new value
-            U = 2.0*U - U0;
-            phi = 2.0*phi - phi0;
-        }
-
-        alpha2 = 1.0 - alpha1;
-        mixture.correct();
+        // Note: This assumes moveMeshOuterCorrectors is false
+        // Saving field values before advection in first PIMPLE iteration
+        alpha10 = alpha1;
+        U0 = U;
+        phi0 = phi;
+    }
+    else
+    {
+        // Resetting alpha1 to value before advection in first PIMPLE iteration
+        alpha1 = alpha10;
+        // Temporarily setting U and phi to average of old and new value
+        // Note: Illegal additions if mesh is topoChanging
+        // (e.g. if moveMeshOuterCorrectors and AMR)
+        U = 0.5*U0 + 0.5*U;
+        phi = 0.5*phi0 + 0.5*phi;
+    }
 
+    advector.advect();
+    #include "rhofs.H"
+    rhoPhi = advector.getRhoPhi(rho1f, rho2f);
+
+    if (!pimple.firstIter())
+    {
+        // Resetting U and phi to the new value
+        U = 2.0*U - U0;
+        phi = 2.0*phi - phi0;
     }
-    Info<< "Phase-1 volume fraction = "
-        << alpha1.weightedAverage(mesh.Vsc()).value()
-        << "  Min(" << alpha1.name() << ") = " << min(alpha1).value()
-        << "  Max(" << alpha1.name() << ") = " << max(alpha1).value()
-        << endl;
+
+    alpha2 = 1.0 - alpha1;
+    mixture.correct();
+
+}
+
+Info<< "Phase-1 volume fraction = "
+    << alpha1.weightedAverage(mesh.Vsc()).value()
+    << "  Min(" << alpha1.name() << ") = " << min(alpha1).value()
+    << "  Max(" << alpha1.name() << ") = " << max(alpha1).value()
+    << endl;
diff --git a/applications/solvers/multiphase/interIsoFoam/alphaEqnSubCycle.H b/applications/solvers/multiphase/interIsoFoam/alphaEqnSubCycle.H
index c53d6e106b428d58df1799c11f8694c976c38439..3c8ba18f2ba7a20f4323443c0013743e7bb4deb8 100644
--- a/applications/solvers/multiphase/interIsoFoam/alphaEqnSubCycle.H
+++ b/applications/solvers/multiphase/interIsoFoam/alphaEqnSubCycle.H
@@ -13,14 +13,6 @@ if (nAlphaSubCycles > 1)
         dimensionedScalar(rhoPhi.dimensions(), Zero)
     );
 
-    tmp<volScalarField> trSubDeltaT;
-
-    if (LTS)
-    {
-        trSubDeltaT =
-            fv::localEulerDdt::localRSubDeltaT(mesh, nAlphaSubCycles);
-    }
-
     for
     (
         subCycle<volScalarField> alphaSubCycle(alpha1, nAlphaSubCycles);
diff --git a/applications/solvers/multiphase/interIsoFoam/alphaSuSp.H b/applications/solvers/multiphase/interIsoFoam/alphaSuSp.H
deleted file mode 100644
index 0b8e05e18710e49d98c8942cb771ee274ae1786f..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/interIsoFoam/alphaSuSp.H
+++ /dev/null
@@ -1,3 +0,0 @@
-zeroField Su;
-zeroField Sp;
-zeroField divU;
diff --git a/applications/solvers/multiphase/interIsoFoam/createFields.H b/applications/solvers/multiphase/interIsoFoam/createFields.H
index 02269e379a73fb9e20ffc0ade871570f5ca502b9..76b99381077dcbd5493eb383fc32962b89d3170a 100644
--- a/applications/solvers/multiphase/interIsoFoam/createFields.H
+++ b/applications/solvers/multiphase/interIsoFoam/createFields.H
@@ -121,23 +121,6 @@ if (p_rgh.needReference())
 mesh.setFluxRequired(p_rgh.name());
 mesh.setFluxRequired(alpha1.name());
 
-/*
-// MULES compressed flux is registered in case scalarTransport FO needs it.
-surfaceScalarField alphaPhiUn
-(
-    IOobject
-    (
-        "alphaPhiUn",
-        runTime.timeName(),
-        mesh,
-        IOobject::NO_READ,
-        IOobject::NO_WRITE
-    ),
-    mesh,
-    dimensionedScalar(phi.dimensions(), Zero)
-);
-*/
-
 #include "createMRF.H"
 #include "createFvOptions.H"
 
@@ -155,7 +138,6 @@ surfaceScalarField phi0
     phi
 );
 
-
 volVectorField U0
 (
     IOobject
@@ -169,7 +151,6 @@ volVectorField U0
     U
 );
 
-
 volScalarField alpha10
 (
     IOobject
@@ -183,5 +164,4 @@ volScalarField alpha10
     alpha1
 );
 
-
 isoAdvection advector(alpha1, phi, U);
diff --git a/applications/solvers/multiphase/interIsoFoam/interIsoFoam.C b/applications/solvers/multiphase/interIsoFoam/interIsoFoam.C
index 024e502633967874d92ba0e83a220532f7fe3580..1593cae755a79f4fbf2a8b2b5257687d7fbf1a55 100644
--- a/applications/solvers/multiphase/interIsoFoam/interIsoFoam.C
+++ b/applications/solvers/multiphase/interIsoFoam/interIsoFoam.C
@@ -75,17 +75,13 @@ int main(int argc, char *argv[])
     #include "initContinuityErrs.H"
     #include "createDyMControls.H"
     #include "createFields.H"
-//    #include "createAlphaFluxes.H"
     #include "initCorrectPhi.H"
     #include "createUfIfPresent.H"
 
     turbulence->validate();
 
-    if (!LTS)
-    {
-        #include "CourantNo.H"
-        #include "setInitialDeltaT.H"
-    }
+    #include "CourantNo.H"
+    #include "setInitialDeltaT.H"
 
     // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
     Info<< "\nStarting time loop\n" << endl;
@@ -93,17 +89,9 @@ int main(int argc, char *argv[])
     while (runTime.run())
     {
         #include "readDyMControls.H"
-
-        if (LTS)
-        {
-            #include "setRDeltaT.H"
-        }
-        else
-        {
-            #include "CourantNo.H"
-            #include "alphaCourantNo.H"
-            #include "setDeltaT.H"
-        }
+        #include "CourantNo.H"
+        #include "alphaCourantNo.H"
+        #include "setDeltaT.H"
 
         runTime++;
 
@@ -118,12 +106,6 @@ int main(int argc, char *argv[])
 
                 if (mesh.changing())
                 {
-                    // Do not apply previous time-step mesh compression flux
-                    // if the mesh topology changed
-                    if (mesh.topoChanging())
-                    {
-//                        talphaPhi1Corr0.clear();
-                    }
 
                     gh = (g & mesh.C()) - ghRef;
                     ghf = (g & mesh.Cf()) - ghRef;
diff --git a/applications/solvers/multiphase/interIsoFoam/setRDeltaT.H b/applications/solvers/multiphase/interIsoFoam/setRDeltaT.H
deleted file mode 100644
index 26b237e7952c09077bb03a21630514435740dc9b..0000000000000000000000000000000000000000
--- a/applications/solvers/multiphase/interIsoFoam/setRDeltaT.H
+++ /dev/null
@@ -1,136 +0,0 @@
-{
-    volScalarField& rDeltaT = trDeltaT.ref();
-
-    const dictionary& pimpleDict = pimple.dict();
-
-    scalar maxCo
-    (
-        pimpleDict.lookupOrDefault<scalar>("maxCo", 0.9)
-    );
-
-    scalar maxAlphaCo
-    (
-        pimpleDict.lookupOrDefault<scalar>("maxAlphaCo", 0.2)
-    );
-
-    scalar rDeltaTSmoothingCoeff
-    (
-        pimpleDict.lookupOrDefault<scalar>("rDeltaTSmoothingCoeff", 0.1)
-    );
-
-    label nAlphaSpreadIter
-    (
-        pimpleDict.lookupOrDefault<label>("nAlphaSpreadIter", 1)
-    );
-
-    scalar alphaSpreadDiff
-    (
-        pimpleDict.lookupOrDefault<scalar>("alphaSpreadDiff", 0.2)
-    );
-
-    scalar alphaSpreadMax
-    (
-        pimpleDict.lookupOrDefault<scalar>("alphaSpreadMax", 0.99)
-    );
-
-    scalar alphaSpreadMin
-    (
-        pimpleDict.lookupOrDefault<scalar>("alphaSpreadMin", 0.01)
-    );
-
-    label nAlphaSweepIter
-    (
-        pimpleDict.lookupOrDefault<label>("nAlphaSweepIter", 5)
-    );
-
-    scalar rDeltaTDampingCoeff
-    (
-        pimpleDict.lookupOrDefault<scalar>("rDeltaTDampingCoeff", 1.0)
-    );
-
-    scalar maxDeltaT
-    (
-        pimpleDict.lookupOrDefault<scalar>("maxDeltaT", GREAT)
-    );
-
-    volScalarField rDeltaT0("rDeltaT0", rDeltaT);
-
-    // Set the reciprocal time-step from the local Courant number
-    rDeltaT.ref() = max
-    (
-        1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
-        fvc::surfaceSum(mag(rhoPhi))()()
-       /((2*maxCo)*mesh.V()*rho())
-    );
-
-    if (maxAlphaCo < maxCo)
-    {
-        // Further limit the reciprocal time-step
-        // in the vicinity of the interface
-
-        volScalarField alpha1Bar(fvc::average(alpha1));
-
-        rDeltaT.ref() = max
-        (
-            rDeltaT(),
-            pos0(alpha1Bar() - alphaSpreadMin)
-           *pos0(alphaSpreadMax - alpha1Bar())
-           *fvc::surfaceSum(mag(phi))()()
-           /((2*maxAlphaCo)*mesh.V())
-        );
-    }
-
-    // Update tho boundary values of the reciprocal time-step
-    rDeltaT.correctBoundaryConditions();
-
-    Info<< "Flow time scale min/max = "
-        << gMin(1/rDeltaT.primitiveField())
-        << ", " << gMax(1/rDeltaT.primitiveField()) << endl;
-
-    if (rDeltaTSmoothingCoeff < 1.0)
-    {
-        fvc::smooth(rDeltaT, rDeltaTSmoothingCoeff);
-    }
-
-    if (nAlphaSpreadIter > 0)
-    {
-        fvc::spread
-        (
-            rDeltaT,
-            alpha1,
-            nAlphaSpreadIter,
-            alphaSpreadDiff,
-            alphaSpreadMax,
-            alphaSpreadMin
-        );
-    }
-
-    if (nAlphaSweepIter > 0)
-    {
-        fvc::sweep(rDeltaT, alpha1, nAlphaSweepIter, alphaSpreadDiff);
-    }
-
-    Info<< "Smoothed flow time scale min/max = "
-        << gMin(1/rDeltaT.primitiveField())
-        << ", " << gMax(1/rDeltaT.primitiveField()) << endl;
-
-    // Limit rate of change of time scale
-    // - reduce as much as required
-    // - only increase at a fraction of old time scale
-    if
-    (
-        rDeltaTDampingCoeff < 1.0
-     && runTime.timeIndex() > runTime.startTimeIndex() + 1
-    )
-    {
-        rDeltaT = max
-        (
-            rDeltaT,
-            (scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0
-        );
-
-        Info<< "Damped flow time scale min/max = "
-            << gMin(1/rDeltaT.primitiveField())
-            << ", " << gMax(1/rDeltaT.primitiveField()) << endl;
-    }
-}
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C
index 1d4062a9980771bc5f8235953b896260cb32797f..1bb244e84aa94686654054c7f3bc657cae58f56d 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C
@@ -6,6 +6,7 @@
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
                 isoAdvector | Copyright (C) 2016-2017 DHI
+              Modified work | Copyright (C) 2018 Johan Roenby
 -------------------------------------------------------------------------------
 
 License
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.H b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.H
index 7aa04e6aec16aedfffa217aa5b3e33cf45119c51..d12506b8f72a9b901f7d23151d261d497a7420ad 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.H
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.H
@@ -6,6 +6,7 @@
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
                 isoAdvector | Copyright (C) 2016-2017 DHI
+              Modified work | Copyright (C) 2018 Johan Roenby
 -------------------------------------------------------------------------------
 
 License
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.C b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.C
index 8e26f5c606573c1c1de9c3443d465e00c45c8431..0b3179edd9b94e094d87591cd9cc678c46aadb03 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.C
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.C
@@ -6,6 +6,7 @@
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
                 isoAdvector | Copyright (C) 2016-2017 DHI
+              Modified work | Copyright (C) 2018 Johan Roenby
 -------------------------------------------------------------------------------
 
 License
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.H b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.H
index bc58ed71fd8388bcf26e530ee0f5404f60dc3c97..e6cbe81a9fe1f83c000c3e103295cb4f684335c3 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.H
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutCell/isoCutCell.H
@@ -6,6 +6,7 @@
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
                 isoAdvector | Copyright (C) 2016-2017 DHI
+              Modified work | Copyright (C) 2018 Johan Roenby
 -------------------------------------------------------------------------------
 
 License
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.C b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.C
index 43bc4bb61032dc14a3c85f7f7ed7b813b7c453d8..e0e335b55d1b672a71e2c88d607b43abed8df312 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.C
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.C
@@ -6,6 +6,7 @@
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
                 isoAdvector | Copyright (C) 2016-2017 DHI
+              Modified work | Copyright (C) 2018 Johan Roenby
 -------------------------------------------------------------------------------
 
 License
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H
index 46e746977f4242a040a7117ac24fcdfff0990dbe..e1404e74415b978a38e3a1ea53e99ea20f3d6f43 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H
@@ -6,6 +6,7 @@
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
                 isoAdvector | Copyright (C) 2016-2017 DHI
+              Modified work | Copyright (C) 2018 Johan Roenby
 -------------------------------------------------------------------------------
 
 License
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/U b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/U
index 5ac9838bc851af30285472943b7cbc8947cab252..a94b7efa0979e6643c8d5200de9a49145a54928a 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/U
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/U
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/alpha.water b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/alpha.water
index 33c24db83b4cbef36be3bd64835292f09e7210ae..37865f4ef2180860e0f377bfe96ccb4959c50ae4 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/alpha.water
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/alpha.water
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/p_rgh b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/p_rgh
index 481f0a268f94ba12f326cacc92859bb00ea30deb..68bb74ccfc432521d058c9a82746f666f37237cd 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/p_rgh
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/0.orig/p_rgh
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/dynamicMeshDict b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/dynamicMeshDict
index eb61c253db6f20ab9252abb10417338eb2733eaa..0f9623f244f49dde51abef5456075f3f7728d3ff 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/dynamicMeshDict
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/dynamicMeshDict
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/g b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/g
index ac04af46dd8e720a0982f9bb674920a93beea97e..abc208807166736c3e6e79b6af09a77709e4c8b2 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/g
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/g
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/transportProperties b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/transportProperties
index 37551da4d5b5277fb46e3f2ffc967be988460283..84ac74aab245e37a03a3e12950794419d5b2b205 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/transportProperties
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/transportProperties
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/turbulenceProperties b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/turbulenceProperties
index 8b144cad5f5e837bca31e23d5858a2c947c567a6..5eec04267266e7fd15e7701a875d683d5e658cd9 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/turbulenceProperties
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/constant/turbulenceProperties
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/blockMeshDict b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/blockMeshDict
index 7cefb52001e173455c6ee01bca1798ac1bcb614d..814938ce85dcbf5165b9b1f8f8ff6f8362dd3346 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/blockMeshDict
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/blockMeshDict
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/controlDict b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/controlDict
index 5e9079b14efbb2d6f9b4bd3dc4e7b5eb3fe63d18..1ce0f5a1452e65d29919ca45121f560dd0f90129 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/controlDict
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/controlDict
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/decomposeParDict b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/decomposeParDict
index b2a4b7e2dfbc323af94650f3e36191812a0a8f6d..7b18f1b23b00c6f9e1250ab076c6d4e224acf595 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/decomposeParDict
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/decomposeParDict
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSchemes b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSchemes
index f808a3220ea19052731af0638325dc69f57220b2..b5d690a026930a5e0269b57ed75afa005b4c4366 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSchemes
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSchemes
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSolution b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSolution
index 62559f06a81ad60bfef5549d45c3241a690a7fe6..8cb6b0675d5cdfb72a9c81c8234a908d34fca0a0 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSolution
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/fvSolution
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/setFieldsDict b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/setFieldsDict
index 7a8e532cce5db98aa0268cea05e53162867676ec..3d982f0edf576aab85ef1cf0e668613de223a854 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/setFieldsDict
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/setFieldsDict
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/topoSetDict b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/topoSetDict
index d23d2fc637fb118a3764b04af8353ffc9ac174fd..789c09a3f425ba528c89d1424237ecb328a1b035 100644
--- a/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/topoSetDict
+++ b/tutorials/multiphase/interIsoFoam/damBreakWithObstacle/system/topoSetDict
@@ -1,8 +1,8 @@
 /*--------------------------------*- C++ -*----------------------------------*\
 | =========                 |                                                 |
 | \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox           |
-|  \\    /   O peration     | Version:  5                                     |
-|   \\  /    A nd           | Web:      www.OpenFOAM.org                      |
+|  \\    /   O peration     | Version:  plus                                  |
+|   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
 \*---------------------------------------------------------------------------*/
 FoamFile
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/0.orig/U b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/0.orig/U
index b4570e1f9b4b42da7532a827272da582e9af4e9b..2ceab091b5003713648be662a6ca6eebd6176875 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/0.orig/U
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/0.orig/U
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/dynamicMeshDict b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/dynamicMeshDict
index 80b685433069d2fcdb39107b0db8238642de2d77..0d234e3050053c7590aa9b6089f7c448c2932b97 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/dynamicMeshDict
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/dynamicMeshDict
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/g b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/g
index 048d630dce2084c7f63fb2a99fe98918879cc5a0..195dbea3f3cac083e26f182b8ae44f0074c8486c 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/g
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/g
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/transportProperties b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/transportProperties
index 53dd43b4a4d3f14bfec093f2a74f778cf7d23e97..f7055c5a380fdefb3602e3d1a1da4e72dd28a81f 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/transportProperties
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/transportProperties
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/turbulenceProperties b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/turbulenceProperties
index f903d8e21ec7fb8c4d73974557ec1f791fe8fe1c..5eec04267266e7fd15e7701a875d683d5e658cd9 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/turbulenceProperties
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/constant/turbulenceProperties
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/blockMeshDict b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/blockMeshDict
index b3c8c15c2b6d911cd3e7b5ddc1ac039c654a2ad8..20064f063167df36fffddb3255e398a7a00a07e3 100644
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/blockMeshDict
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/blockMeshDict
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/controlDict b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/controlDict
index 522cb08b7940c2d549a63ed403946475c6760ec1..99bdc6404ff7c913bff3eeb74aa40c0196a68230 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/controlDict
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/controlDict
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/decomposeParDict b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/decomposeParDict
index d8f4b26e99d36d662d73087b4689989081f2c15e..28839d76e1c3259378a8a35330871cb3f7c06947 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/decomposeParDict
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/decomposeParDict
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSchemes b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSchemes
index cd951fd6e4d6a517a409540a87149af9a9271ea6..2ed4977b7df7cedd845b3e67335bab87b9480617 100644
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSchemes
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSchemes
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSolution b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSolution
index 16066726eac83cf322835556a76ed8a41612953d..2a708ba9c495597ef596b584d51666c54c797105 100644
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSolution
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/fvSolution
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;
diff --git a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/setAlphaFieldDict b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/setAlphaFieldDict
index 7b5498bba04d00de900307aef46eaef6188d8891..b4a6c3060b1dd51b98cbcbbe2fc3063c73dfa5c9 100755
--- a/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/setAlphaFieldDict
+++ b/tutorials/multiphase/interIsoFoam/discInConstantFlowCyclicBCs/system/setAlphaFieldDict
@@ -4,7 +4,8 @@
 |  \\    /   O peration     | Version:  plus                                  |
 |   \\  /    A nd           | Web:      www.OpenFOAM.com                      |
 |    \\/     M anipulation  |                                                 |
-\*---------------------------------------------------------------------------*/FoamFile
+\*---------------------------------------------------------------------------*/
+FoamFile
 {
     version     2.0;
     format      ascii;