diff --git a/applications/test/LduMatrix/LduMatrixTest.C b/applications/test/LduMatrix/LduMatrixTest.C
deleted file mode 100644
index 13038bef45..0000000000
--- a/applications/test/LduMatrix/LduMatrixTest.C
+++ /dev/null
@@ -1,162 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 2011-2012 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "argList.H"
-#include "Time.H"
-#include "fvMesh.H"
-#include "volFields.H"
-#include "LduMatrix.H"
-#include "diagTensorField.H"
-#include "TPCG.H"
-#include "TPBiCG.H"
-#include "NoPreconditioner.H"
-
-using namespace Foam;
-
-typedef Foam::LduMatrix
- lduVectorMatrix;
-defineNamedTemplateTypeNameAndDebug(lduVectorMatrix, 0);
-
-typedef Foam::DiagonalSolver
- lduVectorDiagonalSolver;
-defineNamedTemplateTypeNameAndDebug(lduVectorDiagonalSolver, 0);
-
-template<>
-const vector lduVectorMatrix::great_(1e15, 1e15, 1e15);
-
-template<>
-const vector lduVectorMatrix::small_(1e-15, 1e-15, 1e-15);
-
-namespace Foam
-{
- typedef LduMatrix::preconditioner
- lduVectorPreconditioner;
- defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, symMatrix);
- defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, asymMatrix);
-
- typedef LduMatrix::smoother
- lduVectorSmoother;
- defineTemplateRunTimeSelectionTable(lduVectorSmoother, symMatrix);
- defineTemplateRunTimeSelectionTable(lduVectorSmoother, asymMatrix);
-
- typedef LduMatrix::solver
- lduVectorSolver;
- defineTemplateRunTimeSelectionTable(lduVectorSolver, symMatrix);
- defineTemplateRunTimeSelectionTable(lduVectorSolver, asymMatrix);
-
- typedef TPCG TPCGVector;
- defineNamedTemplateTypeNameAndDebug(TPCGVector, 0);
-
- LduMatrix::solver::
- addsymMatrixConstructorToTable
- addTPCGSymMatrixConstructorToTable_;
-
- typedef TPBiCG TPBiCGVector;
- defineNamedTemplateTypeNameAndDebug(TPBiCGVector, 0);
-
- LduMatrix::solver::
- addasymMatrixConstructorToTable
- addTPBiCGSymMatrixConstructorToTable_;
-
- typedef NoPreconditioner NoPreconditionerVector;
- defineNamedTemplateTypeNameAndDebug(NoPreconditionerVector, 0);
-
- LduMatrix::preconditioner::
- addsymMatrixConstructorToTable
- addNoPreconditionerSymMatrixConstructorToTable_;
-
- LduMatrix::preconditioner::
- addasymMatrixConstructorToTable
- addNoPreconditionerAsymMatrixConstructorToTable_;
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-// Main program:
-
-int main(int argc, char *argv[])
-{
- #include "setRootCase.H"
-
- #include "createTime.H"
- #include "createMesh.H"
-
- volVectorField psi
- (
- IOobject
- (
- "U",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
-
- lduVectorMatrix testMatrix(mesh);
- testMatrix.diag() = 2*pTraits::one;
- testMatrix.source() = pTraits::one;
- testMatrix.upper() = 0.1;
- testMatrix.lower() = -0.1;
-
- Info<< testMatrix << endl;
-
- FieldField boundaryCoeffs(0);
- FieldField internalCoeffs(0);
-
- autoPtr testMatrixSolver =
- lduVectorMatrix::solver::New
- (
- psi.name(),
- testMatrix,
- boundaryCoeffs,
- internalCoeffs,
- psi.boundaryField().interfaces(),
- IStringStream
- (
- "PBiCG"
- "{"
- " preconditioner none;"
- " tolerance (1e-05 1e-05 1e-05);"
- " relTol (0 0 0);"
- "}"
- )()
- );
-
- lduVectorMatrix::solverPerformance solverPerf =
- testMatrixSolver->solve(psi);
-
- solverPerf.print();
-
- Info<< psi << endl;
-
- Info<< "End\n" << endl;
-
- return 0;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/test/LduMatrix/LduMatrixTest2.C b/applications/test/LduMatrix/LduMatrixTest2.C
deleted file mode 100644
index f8694eb481..0000000000
--- a/applications/test/LduMatrix/LduMatrixTest2.C
+++ /dev/null
@@ -1,162 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 2011-2012 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 .
-
-\*---------------------------------------------------------------------------*/
-
-#include "argList.H"
-#include "Time.H"
-#include "fvMesh.H"
-#include "volFields.H"
-#include "LduMatrix.H"
-#include "tensorField.H"
-#include "TPCG.H"
-#include "TPBiCG.H"
-#include "NoPreconditioner.H"
-
-using namespace Foam;
-
-typedef Foam::LduMatrix
- lduVectorMatrix;
-defineNamedTemplateTypeNameAndDebug(lduVectorMatrix, 0);
-
-typedef Foam::DiagonalSolver
- lduVectorDiagonalSolver;
-defineNamedTemplateTypeNameAndDebug(lduVectorDiagonalSolver, 0);
-
-template<>
-const vector lduVectorMatrix::great_(1e15, 1e15, 1e15);
-
-template<>
-const vector lduVectorMatrix::small_(1e-15, 1e-15, 1e-15);
-
-namespace Foam
-{
- typedef LduMatrix::preconditioner
- lduVectorPreconditioner;
- defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, symMatrix);
- defineTemplateRunTimeSelectionTable(lduVectorPreconditioner, asymMatrix);
-
- typedef LduMatrix::smoother
- lduVectorSmoother;
- defineTemplateRunTimeSelectionTable(lduVectorSmoother, symMatrix);
- defineTemplateRunTimeSelectionTable(lduVectorSmoother, asymMatrix);
-
- typedef LduMatrix::solver
- lduVectorSolver;
- defineTemplateRunTimeSelectionTable(lduVectorSolver, symMatrix);
- defineTemplateRunTimeSelectionTable(lduVectorSolver, asymMatrix);
-
- typedef TPCG TPCGVector;
- defineNamedTemplateTypeNameAndDebug(TPCGVector, 0);
-
- LduMatrix::solver::
- addsymMatrixConstructorToTable
- addTPCGSymMatrixConstructorToTable_;
-
- typedef TPBiCG TPBiCGVector;
- defineNamedTemplateTypeNameAndDebug(TPBiCGVector, 0);
-
- LduMatrix::solver::
- addasymMatrixConstructorToTable
- addTPBiCGSymMatrixConstructorToTable_;
-
- typedef NoPreconditioner NoPreconditionerVector;
- defineNamedTemplateTypeNameAndDebug(NoPreconditionerVector, 0);
-
- LduMatrix::preconditioner::
- addsymMatrixConstructorToTable
- addNoPreconditionerSymMatrixConstructorToTable_;
-
- LduMatrix::preconditioner::
- addasymMatrixConstructorToTable
- addNoPreconditionerAsymMatrixConstructorToTable_;
-}
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-// Main program:
-
-int main(int argc, char *argv[])
-{
- #include "setRootCase.H"
-
- #include "createTime.H"
- #include "createMesh.H"
-
- volVectorField psi
- (
- IOobject
- (
- "U",
- runTime.timeName(),
- mesh,
- IOobject::MUST_READ,
- IOobject::AUTO_WRITE
- ),
- mesh
- );
-
- lduVectorMatrix testMatrix(mesh);
- testMatrix.diag() = 2*I;
- testMatrix.source() = pTraits::one;
- testMatrix.upper() = 0.1;
- testMatrix.lower() = -0.1;
-
- Info<< testMatrix << endl;
-
- FieldField boundaryCoeffs(0);
- FieldField internalCoeffs(0);
-
- autoPtr testMatrixSolver =
- lduVectorMatrix::solver::New
- (
- psi.name(),
- testMatrix,
- //boundaryCoeffs,
- //internalCoeffs,
- //psi.boundaryField().interfaces(),
- IStringStream
- (
- "PBiCG"
- "{"
- " preconditioner none;"
- " tolerance (1e-05 1e-05 1e-05);"
- " relTol (0 0 0);"
- "}"
- )()
- );
-
- lduVectorMatrix::solverPerformance solverPerf =
- testMatrixSolver->solve(psi);
-
- solverPerf.print();
-
- Info<< psi << endl;
-
- Info<< "End\n" << endl;
-
- return 0;
-}
-
-
-// ************************************************************************* //
diff --git a/applications/test/LduMatrix/LduMatrixTest3.C b/applications/test/LduMatrix/LduMatrixTest3.C
deleted file mode 100644
index 46f8a78554..0000000000
--- a/applications/test/LduMatrix/LduMatrixTest3.C
+++ /dev/null
@@ -1,147 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | Copyright (C) 2011-2015 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 .
-
-Application
- icoFoam
-
-Description
- Transient solver for incompressible, laminar flow of Newtonian fluids.
-
-\*---------------------------------------------------------------------------*/
-
-#include "fvCFD.H"
-#include "LduMatrix.H"
-#include "diagTensorField.H"
-
-typedef LduMatrix lduVectorMatrix;
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-int main(int argc, char *argv[])
-{
- #include "setRootCase.H"
-
- #include "createTime.H"
- #include "createMesh.H"
- #include "createFields.H"
- #include "initContinuityErrs.H"
-
- // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
- Info<< "\nStarting time loop\n" << endl;
-
- while (runTime.loop())
- {
- Info<< "Time = " << runTime.timeName() << nl << endl;
-
- #include "readPISOControls.H"
- #include "CourantNo.H"
-
- fvVectorMatrix UEqn
- (
- fvm::ddt(U)
- + fvm::div(phi, U)
- - fvm::laplacian(nu, U)
- );
-
- fvVectorMatrix UEqnp(UEqn == -fvc::grad(p));
-
- lduVectorMatrix U3Eqnp(mesh);
- U3Eqnp.diag() = UEqnp.diag();
- U3Eqnp.upper() = UEqnp.upper();
- U3Eqnp.lower() = UEqnp.lower();
- U3Eqnp.source() = UEqnp.source();
-
- UEqnp.addBoundaryDiag(U3Eqnp.diag(), 0);
- UEqnp.addBoundarySource(U3Eqnp.source(), false);
-
- autoPtr U3EqnpSolver =
- lduVectorMatrix::solver::New
- (
- U.name(),
- U3Eqnp,
- dictionary
- (
- IStringStream
- (
- "{"
- " solver PBiCG;"
- " preconditioner DILU;"
- " tolerance (1e-5 1e-5 1);"
- " relTol (0 0 0);"
- "}"
- )()
- )
- );
-
- U3EqnpSolver->solve(U).print(Info);
-
- // --- PISO loop
-
- for (int corr=0; corr