diff --git a/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H b/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H
index e9f612f71d..1fca47a0ef 100644
--- a/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H
+++ b/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H
@@ -115,7 +115,7 @@ class VoFCavitation
public:
//- Runtime type information
- TypeName("VoFCavitation");
+ TypeName("compressible::VoFCavitation");
// Constructors
diff --git a/applications/solvers/modules/compressibleVoF/fvModels/VoFSolidificationMeltingSource/Make/options b/applications/solvers/modules/compressibleVoF/fvModels/VoFSolidificationMeltingSource/Make/options
index 6ec08e7b9d..1f8b3073e4 100644
--- a/applications/solvers/modules/compressibleVoF/fvModels/VoFSolidificationMeltingSource/Make/options
+++ b/applications/solvers/modules/compressibleVoF/fvModels/VoFSolidificationMeltingSource/Make/options
@@ -9,4 +9,5 @@ EXE_INC = \
-I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/meshTools/lnInclude
-LIB_LIBS =
+LIB_LIBS = \
+ -lcompressibleVoF
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/HeatTransferPhaseSystem.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/HeatTransferPhaseSystem.C
similarity index 99%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/HeatTransferPhaseSystem.C
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/HeatTransferPhaseSystem.C
index f9fe20d8b5..5db3155369 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/HeatTransferPhaseSystem.C
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/HeatTransferPhaseSystem.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
- \\ / A nd | Copyright (C) 2020-2022 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/HeatTransferPhaseSystem.H b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/HeatTransferPhaseSystem.H
similarity index 99%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/HeatTransferPhaseSystem.H
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/HeatTransferPhaseSystem.H
index 81bc8c64be..aae3d7539e 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/HeatTransferPhaseSystem.H
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/HeatTransferPhaseSystem.H
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
- \\ / A nd | Copyright (C) 2015-2022 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2015-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/heatTransferPhaseSystem.C
similarity index 96%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.C
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/heatTransferPhaseSystem.C
index 7f12d71cca..30c53bb531 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.C
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/heatTransferPhaseSystem.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
- \\ / A nd | Copyright (C) 2020-2022 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.H b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/heatTransferPhaseSystem.H
similarity index 98%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.H
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/heatTransferPhaseSystem.H
index b8558cf286..c230398547 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.H
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/HeatTransferPhaseSystem/heatTransferPhaseSystem.H
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
- \\ / A nd | Copyright (C) 2020-2022 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/Make/files b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/Make/files
index 301e729592..4c5e3be992 100644
--- a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/Make/files
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/Make/files
@@ -1,3 +1,9 @@
+HeatTransferPhaseSystem/heatTransferPhaseSystem.C
+TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
+
+diameterModels/IATE/IATEsources/wallBoiling/IATEwallBoiling.C
+populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C
+
derivedFvPatchFields/wallBoilingSubModels/partitioningModels/partitioningModel/partitioningModel.C
derivedFvPatchFields/wallBoilingSubModels/partitioningModels/partitioningModel/partitioningModelNew.C
derivedFvPatchFields/wallBoilingSubModels/partitioningModels/phaseFraction/phaseFraction.C
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.C
similarity index 100%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.C
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.C
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.H b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.H
similarity index 100%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.H
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/TwoResistanceHeatTransferPhaseSystem.H
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
similarity index 96%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
index e93216ac26..48b1f3afd4 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
- \\ / A nd | Copyright (C) 2020-2022 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H
similarity index 97%
rename from applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H
rename to applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H
index 3b3adcb8e5..247ecc6c2d 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H
@@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
- \\ / A nd | Copyright (C) 2020-2022 OpenFOAM Foundation
+ \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/diameterModels/IATE/IATEsources/wallBoiling/IATEwallBoiling.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/diameterModels/IATE/IATEsources/wallBoiling/IATEwallBoiling.C
new file mode 100644
index 0000000000..85ee9b9f90
--- /dev/null
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/diameterModels/IATE/IATEsources/wallBoiling/IATEwallBoiling.C
@@ -0,0 +1,133 @@
+/*---------------------------------------------------------------------------*\
+ ========= |
+ \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
+ \\ / O peration | Website: https://openfoam.org
+ \\ / A nd | Copyright (C) 2016-2023 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 "IATEwallBoiling.H"
+#include "alphatWallBoilingWallFunctionFvPatchScalarField.H"
+#include "fvmSup.H"
+#include "addToRunTimeSelectionTable.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace diameterModels
+{
+namespace IATEsources
+{
+ defineTypeNameAndDebug(wallBoiling, 0);
+ addToRunTimeSelectionTable(IATEsource, wallBoiling, dictionary);
+}
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
+
+Foam::diameterModels::IATEsources::wallBoiling::wallBoiling
+(
+ const IATE& iate,
+ const dictionary& dict
+)
+:
+ IATEsource(iate)
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
+
+Foam::tmp
+Foam::diameterModels::IATEsources::wallBoiling::R
+(
+ const volScalarField& alphai,
+ volScalarField& kappai
+) const
+{
+ volScalarField::Internal R
+ (
+ IOobject
+ (
+ typedName("R"),
+ phase().time().name(),
+ phase().mesh()
+ ),
+ phase().mesh(),
+ dimensionedScalar(dimless/dimTime, 0)
+ );
+
+ volScalarField::Internal Rdk
+ (
+ IOobject
+ (
+ typedName("Rdk"),
+ phase().time().name(),
+ phase().mesh()
+ ),
+ phase().mesh(),
+ dimensionedScalar(kappai.dimensions()/dimTime, 0)
+ );
+
+ const volScalarField& alphat =
+ phase().mesh().lookupObject
+ (
+ IOobject::groupName("alphat", otherPhase().name())
+ );
+
+ const volScalarField::Boundary& alphatBf = alphat.boundaryField();
+
+ const scalarField& rho = phase().rho();
+
+ typedef compressible::alphatWallBoilingWallFunctionFvPatchScalarField
+ alphatWallBoilingWallFunction;
+
+ forAll(alphatBf, patchi)
+ {
+ if (isA(alphatBf[patchi]))
+ {
+ const alphatWallBoilingWallFunction& alphatw =
+ refCast(alphatBf[patchi]);
+
+ const scalarField& dmdt = alphatw.dmdtf();
+ const scalarField& dDep = alphatw.dDeparture();
+
+ const labelList& faceCells = alphatw.patch().faceCells();
+
+ forAll(alphatw, facei)
+ {
+ if (dmdt[facei] > small)
+ {
+ const label faceCelli = faceCells[facei];
+ R[faceCelli] =
+ dmdt[facei]/(alphai[faceCelli]*rho[faceCelli]);
+ Rdk[faceCelli] = R[faceCelli]*(6.0/dDep[facei]);
+ }
+ }
+ }
+ }
+
+ return Rdk - fvm::Sp(R, kappai);
+}
+
+
+// ************************************************************************* //
diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C
new file mode 100644
index 0000000000..4da9569618
--- /dev/null
+++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C
@@ -0,0 +1,182 @@
+/*---------------------------------------------------------------------------*\
+ ========= |
+ \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
+ \\ / O peration | Website: https://openfoam.org
+ \\ / A nd | Copyright (C) 2018-2023 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 "wallBoiling.H"
+#include "addToRunTimeSelectionTable.H"
+#include "alphatWallBoilingWallFunctionFvPatchScalarField.H"
+#include "phaseSystem.H"
+
+// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
+
+namespace Foam
+{
+namespace diameterModels
+{
+namespace nucleationModels
+{
+ defineTypeNameAndDebug(wallBoiling, 0);
+ addToRunTimeSelectionTable
+ (
+ nucleationModel,
+ wallBoiling,
+ dictionary
+ );
+}
+}
+}
+
+
+// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
+
+Foam::diameterModels::nucleationModels::wallBoiling::
+wallBoiling
+(
+ const populationBalanceModel& popBal,
+ const dictionary& dict
+)
+:
+ nucleationModel(popBal, dict)
+{}
+
+
+// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
+
+void Foam::diameterModels::nucleationModels::wallBoiling::precompute()
+{
+ const volScalarField& alphat =
+ popBal_.mesh().lookupObject
+ (
+ IOobject::groupName("alphat", popBal_.continuousPhase().name())
+ );
+
+ const volScalarField::Boundary& alphatBf = alphat.boundaryField();
+
+ typedef compressible::alphatWallBoilingWallFunctionFvPatchScalarField
+ alphatWallBoilingWallFunction;
+
+ forAll(alphatBf, patchi)
+ {
+ if (isA(alphatBf[patchi]))
+ {
+ const alphatWallBoilingWallFunction& alphatw =
+ refCast(alphatBf[patchi]);
+
+ const scalarField& dDep = alphatw.dDeparture();
+
+ if (min(dDep) < velGroup_.sizeGroups().first().dSph().value())
+ {
+ Warning
+ << "Minimum departure diameter " << min(dDep)
+ << " m outside of range ["
+ << velGroup_.sizeGroups().first().dSph().value() << ", "
+ << velGroup_.sizeGroups().last().dSph().value() << "] m"
+ << " at patch " << alphatw.patch().name()
+ << endl
+ << " The nucleation rate in populationBalance "
+ << popBal_.name() << " is set to zero." << endl
+ << " Adjust discretisation over property space to"
+ << " suppress this warning."
+ << endl;
+ }
+ else if (max(dDep) > velGroup_.sizeGroups().last().dSph().value())
+ {
+ Warning
+ << "Maximum departure diameter " << max(dDep)
+ << " m outside of range ["
+ << velGroup_.sizeGroups().first().dSph().value() << ", "
+ << velGroup_.sizeGroups().last().dSph().value() << "] m"
+ << " at patch " << alphatw.patch().name()
+ << endl
+ << " The nucleation rate in populationBalance "
+ << popBal_.name() << " is set to zero." << endl
+ << " Adjust discretisation over property space to"
+ << " suppress this warning."
+ << endl;
+ }
+ }
+ }
+}
+
+
+void
+Foam::diameterModels::nucleationModels::wallBoiling::addToNucleationRate
+(
+ volScalarField& nucleationRate,
+ const label i
+)
+{
+ const sizeGroup& fi = popBal_.sizeGroups()[i];
+ const phaseModel& phase = fi.phase();
+ const volScalarField& rho = phase.rho();
+
+ const volScalarField& alphat =
+ popBal_.mesh().lookupObject
+ (
+ IOobject::groupName("alphat", popBal_.continuousPhase().name())
+ );
+
+ const volScalarField::Boundary& alphatBf = alphat.boundaryField();
+
+ typedef compressible::alphatWallBoilingWallFunctionFvPatchScalarField
+ alphatWallBoilingWallFunction;
+
+ forAll(alphatBf, patchi)
+ {
+ if
+ (
+ isA(alphatBf[patchi])
+ )
+ {
+ const alphatWallBoilingWallFunction& alphatw =
+ refCast(alphatBf[patchi]);
+
+ const scalarField& dmdt = alphatw.dmdtf();
+ const scalarField& dDep = alphatw.dDeparture();
+
+ const labelList& faceCells = alphatw.patch().faceCells();
+
+ dimensionedScalar unitLength("unitLength", dimLength, 1);
+
+ forAll(alphatw, facei)
+ {
+ if (dmdt[facei] > small)
+ {
+ const label faceCelli = faceCells[facei];
+
+ nucleationRate[faceCelli] +=
+ popBal_.eta
+ (
+ i,
+ fi.x()/pow3(fi.dSph())*pow3(dDep[facei]*unitLength)
+ ).value()
+ *dmdt[facei]/rho[faceCelli]/fi.x().value();
+ }
+ }
+ }
+ }
+}
+
+
+// ************************************************************************* //
diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/Make/files b/applications/solvers/modules/multiphaseEuler/phaseSystems/Make/files
index 1786ef3140..2637e32327 100644
--- a/applications/solvers/modules/multiphaseEuler/phaseSystems/Make/files
+++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/Make/files
@@ -20,9 +20,6 @@ phaseSystem/phaseSystem.C
phaseSystem/phaseSystemNew.C
phaseSystem/phaseSystemSolve.C
-PhaseSystems/HeatTransferPhaseSystem/heatTransferPhaseSystem.C
-PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.C
-
diameterModels/diameterModel/diameterModel.C
diameterModels/diameterModel/diameterModelNew.C
diameterModels/sphericalDiameter/sphericalDiameter.C
@@ -38,7 +35,6 @@ diameterModels/IATE/IATEsources/wakeEntrainmentCoalescence/IATEwakeEntrainmentCo
diameterModels/IATE/IATEsources/turbulentBreakUp/IATEturbulentBreakUp.C
diameterModels/IATE/IATEsources/randomCoalescence/IATErandomCoalescence.C
diameterModels/IATE/IATEsources/phaseChange/IATEphaseChange.C
-diameterModels/IATE/IATEsources/wallBoiling/IATEwallBoiling.C
sizeGroup = diameterModels/velocityGroup/sizeGroup
$(sizeGroup)/sizeGroup.C
@@ -97,7 +93,6 @@ $(driftModels)/phaseChange/phaseChange.C
nucleationModels = populationBalanceModel/nucleationModels
$(nucleationModels)/nucleationModel/nucleationModel.C
$(nucleationModels)/reactionDriven/reactionDriven.C
-$(nucleationModels)/wallBoiling/wallBoiling.C
BlendedInterfacialModel/blendingMethods/blendingMethod/blendingMethod.C
BlendedInterfacialModel/blendingMethods/blendingMethod/blendingMethodNew.C
diff --git a/src/twoPhaseModels/interfaceProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H b/src/twoPhaseModels/interfaceProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H
index 1bf624874c..0e564b01ab 100644
--- a/src/twoPhaseModels/interfaceProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H
+++ b/src/twoPhaseModels/interfaceProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H
@@ -42,7 +42,7 @@ Description
\verbatim
{
- type alphaContactAngle;
+ type contactAngle;
limit none;
theta0 70;
}
@@ -86,7 +86,7 @@ class alphaContactAngleFvPatchScalarField
public:
//- Runtime type information
- TypeName("alphaContactAngle");
+ TypeName("contactAngle");
//- Alpha limit options
enum limitControls