From fc2b2d0c05e633858fd899066d144fc2384f1c65 Mon Sep 17 00:00:00 2001 From: Henry Weller Date: Thu, 25 Jan 2018 09:46:37 +0000 Subject: [PATCH] OpenFOAM: Rationalized the naming of scalar limits In early versions of OpenFOAM the scalar limits were simple macro replacements and the names were capitalized to indicate this. The scalar limits are now static constants which is a huge improvement on the use of macros and for consistency the names have been changed to camel-case to indicate this and improve readability of the code: GREAT -> great ROOTGREAT -> rootGreat VGREAT -> vGreat ROOTVGREAT -> rootVGreat SMALL -> small ROOTSMALL -> rootSmall VSMALL -> vSmall ROOTVSMALL -> rootVSmall The original capitalized are still currently supported but their use is deprecated. --- .../basic/potentialFoam/potentialFoam.C | 4 +- .../turbulence/PDRkEpsilon/PDRkEpsilon.C | 4 +- .../solvers/combustion/PDRFoam/bEqn.H | 4 +- .../SCOPE/SCOPELaminarFlameSpeed.C | 10 +-- .../solvers/combustion/PDRFoam/setDeltaT.H | 4 +- applications/solvers/combustion/XiFoam/bEqn.H | 4 +- .../fireFoam/setMultiRegionDeltaT.H | 16 ++-- .../combustion/reactingFoam/setRDeltaT.H | 12 +-- .../T/smoluchowskiJumpTFvPatchScalarField.C | 4 +- .../BCs/U/maxwellSlipUFvPatchVectorField.C | 4 +- .../compressible/rhoPimpleFoam/setRDeltaT.H | 2 +- .../fluid/compressibleMultiRegionCourantNo.H | 2 +- .../fluid/createFluidFields.H | 4 +- .../chtMultiRegionSimpleFoam/fluid/pEqn.H | 2 +- .../fluid/compressibleMultiRegionCourantNo.H | 2 +- .../fluid/createFluidFields.H | 2 +- .../chtMultiRegionFoam/fluid/pEqn.H | 2 +- .../include/setInitialMultiRegionDeltaT.H | 12 +-- .../include/setMultiRegionDeltaT.H | 14 ++-- .../solid/solidRegionDiffusionNo.H | 2 +- .../adjointOutletVelocityFvPatchVectorField.C | 4 +- .../boundaryFoam/evaluateNearWall.H | 10 +-- .../lagrangian/coalChemistryFoam/setRDeltaT.H | 8 +- .../reactingParcelFoam/setMultiRegionDeltaT.H | 4 +- .../reactingParcelFoam/setRDeltaT.H | 8 +- .../simpleReactingParcelFoam/createFields.H | 2 +- .../lagrangian/sprayFoam/createFields.H | 2 +- .../solvers/multiphase/VoF/setDeltaT.H | 4 +- .../solvers/multiphase/VoF/setRDeltaT.H | 2 +- .../multiphase/cavitatingFoam/setDeltaT.H | 4 +- .../cavitatingFoam/setInitialDeltaT.H | 6 +- .../multiphaseMixtureThermo.C | 6 +- .../BinghamPlastic/BinghamPlastic.C | 4 +- .../threePhaseInterfaceProperties.C | 4 +- .../threePhaseInterfaceProperties.H | 4 +- .../multiphaseEulerFoam/multiphaseEulerFoam.C | 4 +- .../multiphaseSystem/multiphaseSystem.C | 6 +- .../multiphaseMixture/multiphaseMixture.C | 6 +- ...ayatillekeWallFunctionFvPatchScalarField.C | 6 +- ...allBoilingWallFunctionFvPatchScalarField.C | 2 +- .../IATEsource/wallBoiling.C | 4 +- .../NonRandomTwoLiquid/NonRandomTwoLiquid.C | 8 +- .../Saturated/Saturated.C | 6 +- .../interfacialModels/dragModels/Lain/Lain.C | 2 +- .../virtualMassModels/Lamb/Lamb.C | 4 +- .../blendingMethods/linear/linear.C | 6 +- .../HeatAndMassTransferPhaseSystem.C | 8 +- ...terfaceCompositionPhaseChangePhaseSystem.C | 2 +- .../ThermalPhaseChangePhaseSystem.C | 4 +- .../velocityGroup/velocityGroup.C | 4 +- .../driftModels/phaseChange/phaseChange.C | 2 +- .../wallBoiling/wallBoiling.C | 2 +- .../multiphaseSystem/multiphaseSystem.C | 4 +- .../reactingMultiphaseEulerFoam/setRDeltaT.H | 2 +- .../reactingTwoPhaseEulerFoam/setRDeltaT.H | 2 +- ...sonJacksonParticleSlipFvPatchVectorField.C | 2 +- ...onJacksonParticleThetaFvPatchScalarField.C | 6 +- .../JohnsonJacksonSchaefferFrictionalStress.C | 4 +- .../Schaeffer/SchaefferFrictionalStress.C | 6 +- .../randomCoalescence/randomCoalescence.C | 4 +- .../IATEsources/wallBoiling/wallBoiling.C | 4 +- .../interfacialModels/dragModels/Lain/Lain.C | 4 +- .../virtualMassModels/Lamb/Lamb.C | 4 +- ...sonJacksonParticleSlipFvPatchVectorField.C | 4 +- ...onJacksonParticleThetaFvPatchScalarField.C | 8 +- .../JohnsonJacksonSchaefferFrictionalStress.C | 6 +- .../Schaeffer/SchaefferFrictionalStress.C | 6 +- .../blendingMethods/linear/linear.C | 6 +- .../randomCoalescence/randomCoalescence.C | 4 +- .../kineticEnergyLimiter.H | 4 +- .../test/PatchTools/Test-PatchTools.C | 4 +- .../test/Polynomial/Test-Polynomial.C | 6 +- .../test/fieldMapping/Test-fieldMapping.C | 4 +- .../Test-findSphereFeatureEdges-octree.C | 6 +- .../test/quaternion/Test-quaternion.C | 4 +- applications/test/router/router.C | 6 +- applications/test/syncTools/Test-syncTools.C | 24 +++--- .../test/tetTetOverlap/Test-tetTetOverlap.C | 4 +- .../test/vectorTools/Test-vectorTools.C | 16 ++-- .../advanced/autoRefineMesh/autoRefineMesh.C | 18 ++--- .../combinePatchFaces/combinePatchFaces.C | 4 +- .../mesh/advanced/modifyMesh/modifyMesh.C | 16 ++-- .../mesh/advanced/selectCells/edgeStats.C | 18 ++--- .../mesh/advanced/splitCells/splitCells.C | 14 ++-- .../mesh/conversion/cfx4ToFoam/cfx4ToFoam.C | 6 +- .../ideasUnvToFoam/ideasUnvToFoam.C | 4 +- .../mesh/conversion/kivaToFoam/checkPatch.H | 8 +- .../mesh/conversion/kivaToFoam/kivaToFoam.C | 4 +- .../mesh/conversion/kivaToFoam/readKivaGrid.H | 10 +-- .../mesh/conversion/plot3dToFoam/hexBlock.C | 4 +- .../conversion/plot3dToFoam/plot3dToFoam.C | 8 +- .../star3ToFoam/createCoupleMatches.C | 26 +++---- .../star3ToFoam/mergeCoupleFacePoints.C | 4 +- .../mesh/conversion/star3ToFoam/readPoints.C | 4 +- .../star3ToFoam/readSeparatedPoints.C | 4 +- .../extrude/extrudeMesh/extrudeMesh.C | 4 +- .../extrude2DMesh/extrude2DMesh.C | 4 +- .../cellSizeAndAlignmentGrid.C | 6 +- .../DelaunayMesh/DelaunayMeshIO.C | 4 +- .../backgroundMeshDecomposition.C | 20 ++--- .../cellAspectRatioControl.C | 4 +- .../cellShapeControl/cellShapeControl.C | 8 +- .../cellShapeControlMesh.C | 10 +-- .../searchableSurfaceControl.C | 12 +-- .../controlMeshRefinement.C | 6 +- .../smoothAlignmentSolver.C | 6 +- .../cellSizeFunction/uniform/uniform.C | 6 +- .../automatic/automatic.C | 4 +- .../conformalVoronoiMesh.C | 6 +- .../conformalVoronoiMeshCalcDualMesh.C | 18 ++--- .../conformalVoronoiMeshConformToSurface.C | 10 +-- .../conformalVoronoiMeshFeaturePoints.C | 12 +-- .../conformalVoronoiMeshZones.C | 4 +- .../conformationSurfaces.C | 12 +-- .../autoDensity/autoDensity.C | 14 ++-- .../rampHoldFall/rampHoldFall.C | 4 +- .../searchableBoxFeatures.C | 6 +- .../searchablePlateFeatures.C | 6 +- .../vectorTools/vectorTools.H | 12 +-- .../foamyHexMeshBackgroundMesh.C | 10 +-- .../foamyHexMeshSurfaceSimplify.C | 10 +-- .../foamyHexMeshSurfaceSimplify_non_octree.C | 6 +- .../generation/snappyHexMesh/snappyHexMesh.C | 4 +- .../manipulation/checkMesh/checkGeometry.C | 6 +- .../manipulation/createPatch/createPatch.C | 4 +- .../manipulation/polyDualMesh/polyDualMesh.C | 4 +- .../mesh/manipulation/refineMesh/refineMesh.C | 18 ++--- .../graphics/PVReaders/vtkPVFoam/vtkPVFoam.C | 4 +- .../utilities/postProcessing/noise/noise.C | 4 +- .../applyBoundaryLayer/applyBoundaryLayer.C | 4 +- .../preProcessing/engineSwirl/createFields.H | 2 +- .../preProcessing/engineSwirl/engineSwirl.C | 4 +- .../preProcessing/setWaves/setWaves.C | 2 +- .../viewFactorsGen/searchingEngine.H | 2 +- .../viewFactorsGen/viewFactorsGen.C | 6 +- .../SpaldingsLaw/SpaldingsLaw.C | 6 +- .../tabulatedWallFunction/general/general.C | 4 +- .../surface/surfaceCheck/surfaceCheck.C | 8 +- .../surface/surfaceClean/collapseBase.C | 6 +- .../surfaceExtractCloseness.C | 4 +- .../surfaceExtractPointCloseness.C | 4 +- .../surfaceFeatureExtract.C | 2 +- .../surfaceFeatureExtractUtilities.C | 14 ++-- .../surface/surfaceFind/surfaceFind.C | 6 +- .../surface/surfaceHookUp/surfaceHookUp.C | 12 +-- .../surface/surfaceInertia/surfaceInertia.C | 20 ++--- .../surfaceRedistributePar.C | 4 +- .../surfaceSplitNonManifolds.C | 10 +-- src/ODE/ODESolvers/ODESolver/ODESolver.C | 4 +- src/ODE/ODESolvers/SIBS/SIBS.C | 10 +-- .../adaptiveSolver/adaptiveSolver.C | 4 +- src/ODE/ODESolvers/seulex/seulex.C | 10 +-- .../dynamicIndexedOctree.C | 2 +- .../algorithms/indexedOctree/indexedOctree.C | 36 ++++----- .../algorithms/indexedOctree/treeDataCell.C | 6 +- .../Lists/Distribution/Distribution.C | 4 +- .../db/IOstreams/IOstreams/IOstream.H | 4 +- src/OpenFOAM/db/Time/Time.C | 28 +++---- src/OpenFOAM/db/Time/TimeIO.C | 4 +- src/OpenFOAM/db/Time/instant/instant.C | 4 +- src/OpenFOAM/db/Time/timeSelector.C | 4 +- .../timeControl/timeControlFunctionObject.C | 8 +- .../timeControl/timeControlFunctionObject.H | 6 +- src/OpenFOAM/dimensionSet/dimensionSet.C | 4 +- .../Fields/symmTensorField/symmTensorField.C | 8 +- .../fields/Fields/tensorField/tensorField.C | 8 +- .../Fields/transformField/transformField.C | 6 +- .../linearInterpolationWeights.C | 6 +- .../splineInterpolationWeights.C | 4 +- .../CalcPatchToPatchWeights.C | 14 ++-- .../PatchToPatchInterpolation.H | 4 +- .../uniformInterpolationTable.C | 4 +- .../matrices/DiagonalMatrix/DiagonalMatrix.C | 6 +- .../matrices/LUscalarMatrix/LUscalarMatrix.C | 6 +- .../LduMatrix/LduMatrix/SolverPerformance.H | 4 +- src/OpenFOAM/matrices/QRMatrix/QRMatrix.C | 4 +- .../pairGAMGAgglomerate.C | 6 +- .../lduMatrix/solvers/GAMG/GAMGSolverScale.C | 4 +- .../matrices/scalarMatrices/SVD/SVD.C | 4 +- .../matrices/scalarMatrices/SVD/SVDI.H | 4 +- .../matrices/scalarMatrices/scalarMatrices.C | 4 +- src/OpenFOAM/matrices/solution/solution.C | 6 +- src/OpenFOAM/meshes/boundBox/boundBox.C | 20 ++--- src/OpenFOAM/meshes/boundBox/boundBox.H | 6 +- .../meshes/boundBox/boundBoxTemplates.C | 6 +- src/OpenFOAM/meshes/meshShapes/cell/cell.C | 6 +- .../meshes/meshShapes/cellModel/cellModel.C | 8 +- src/OpenFOAM/meshes/meshShapes/face/face.C | 12 +-- .../meshShapes/face/faceAreaInContact.C | 4 +- .../meshShapes/face/faceContactSphere.C | 6 +- .../meshes/meshShapes/face/faceIntersection.C | 14 ++-- .../meshes/meshShapes/face/faceTemplates.C | 4 +- src/OpenFOAM/meshes/meshTools/matchPoints.C | 14 ++-- .../mapPolyMesh/cellMapper/cellMapper.C | 4 +- src/OpenFOAM/meshes/polyMesh/polyMesh.C | 6 +- .../polyMesh/polyMeshCheck/polyMeshCheck.C | 14 ++-- .../polyMesh/polyMeshCheck/polyMeshTools.C | 10 +-- .../polyMeshTetDecomposition.C | 8 +- .../basic/coupled/coupledPolyPatch.C | 16 ++-- .../constraint/cyclic/cyclicPolyPatch.C | 24 +++--- .../constraint/oldCyclic/oldCyclicPolyPatch.C | 16 ++-- .../constraint/processor/processorPolyPatch.C | 12 +-- .../symmetryPlane/symmetryPlanePolyPatch.C | 4 +- .../constraint/wedge/wedgePolyPatch.C | 8 +- .../PatchTools/PatchToolsNormals.C | 10 +-- .../PatchTools/PatchToolsSortEdges.C | 16 ++-- .../PrimitivePatch/PrimitivePatchMeshData.C | 6 +- .../PrimitivePatchProjectPoints.C | 10 +-- .../meshes/primitiveMesh/primitiveMesh.H | 4 +- .../primitiveMeshCellCentresAndVols.C | 4 +- .../primitiveMeshCheck/primitiveMeshCheck.C | 34 ++++----- .../primitiveMeshCheckEdgeLength.C | 6 +- .../primitiveMeshCheck/primitiveMeshTools.C | 42 +++++------ .../primitiveMeshFaceCentresAndAreas.C | 4 +- .../primitiveMesh/primitiveMeshFindCell.C | 4 +- .../meshes/primitiveShapes/cut/cutTemplates.C | 4 +- .../meshes/primitiveShapes/line/line.C | 12 +-- .../meshes/primitiveShapes/line/lineI.H | 4 +- .../primitiveShapes/objectHit/PointHit.H | 6 +- .../primitiveShapes/objectHit/pointHitSort.H | 4 +- .../meshes/primitiveShapes/plane/plane.C | 26 +++---- .../tetrahedron/tetrahedronI.H | 36 ++++----- .../primitiveShapes/triangle/intersection.H | 4 +- .../primitiveShapes/triangle/triangleI.H | 40 +++++----- .../meshes/treeBoundBox/treeBoundBox.C | 24 +++--- .../meshes/treeBoundBox/treeBoundBox.H | 6 +- .../DiagTensor/diagTensor/diagTensor.C | 10 +-- src/OpenFOAM/primitives/Scalar/Scalar.H | 4 +- src/OpenFOAM/primitives/Scalar/doubleFloat.H | 28 +------ .../Scalar/doubleScalar/doubleScalar.H | 20 +++++ .../Scalar/floatScalar/floatScalar.H | 19 +++++ .../sphericalTensor/sphericalTensor.C | 10 +-- .../sphericalTensor2D/sphericalTensor2D.C | 10 +-- .../SymmTensor/symmTensor/symmTensor.C | 10 +-- .../SymmTensor2D/symmTensor2D/symmTensor2D.C | 10 +-- .../primitives/Tensor/tensor/tensor.C | 26 +++---- .../primitives/Tensor2D/tensor2D/tensor2D.C | 18 ++--- .../Vector/complexVector/complexVector.C | 10 +-- .../primitives/Vector/vector/vector.C | 10 +-- .../primitives/Vector2D/vector2D/vector2D.C | 10 +-- .../PolynomialEntry/PolynomialEntry.C | 6 +- .../functions/Polynomial/Polynomial.C | 4 +- .../functions/Polynomial/polynomialFunction.C | 4 +- .../globalIndexAndTransform.C | 16 ++-- .../globalIndexAndTransform.H | 4 +- .../globalIndexAndTransformI.H | 4 +- .../polynomialEqns/cubicEqn/cubicEqnI.H | 4 +- .../polynomialEqns/linearEqn/linearEqnI.H | 6 +- .../quadraticEqn/quadraticEqnI.H | 4 +- .../random/cachedRandom/cachedRandom.C | 12 +-- .../cachedRandom/cachedRandomTemplates.C | 10 +-- .../ranges/scalarRange/scalarRange.C | 6 +- .../ranges/scalarRange/scalarRanges.C | 4 +- .../compactSpatialTensor.C | 10 +-- .../spatialTensor/spatialTensor.C | 10 +-- .../spatialVector/spatialVector.C | 10 +-- src/OpenFOAM/primitives/transform/transform.H | 8 +- src/OpenFOAM/primitives/triad/triad.C | 18 ++--- src/OpenFOAM/primitives/triad/triadI.H | 4 +- .../RAS/buoyantKEpsilon/buoyantKEpsilon.C | 8 +- ...oupledTemperatureMixedFvPatchScalarField.C | 4 +- ...RateAdvectiveDiffusiveFvPatchScalarField.C | 4 +- ...ayatillekeWallFunctionFvPatchScalarField.C | 8 +- .../RAS/LamBremhorstKE/LamBremhorstKE.C | 6 +- .../RAS/LienCubicKE/LienCubicKE.C | 6 +- .../RAS/LienLeschziner/LienLeschziner.C | 6 +- .../RAS/kkLOmega/kkLOmega.C | 20 ++--- .../RAS/qZeta/qZeta.H | 6 +- ...ayatillekeWallFunctionFvPatchScalarField.C | 4 +- .../turbulenceModels/LES/LESModel/LESModel.C | 8 +- .../turbulenceModels/LES/LESModel/LESModel.H | 4 +- .../LES/LESdeltas/LESdelta/LESdelta.C | 4 +- .../smoothDelta/smoothDeltaDeltaDataI.H | 8 +- .../LESdeltas/vanDriestDelta/vanDriestDelta.C | 8 +- .../SpalartAllmarasDDES/SpalartAllmarasDDES.C | 6 +- .../SpalartAllmarasDES/SpalartAllmarasDES.C | 4 +- .../SpalartAllmarasIDDES.C | 8 +- .../turbulenceModels/LES/WALE/WALE.C | 6 +- .../LES/dynamicKEqn/dynamicKEqn.C | 8 +- .../LES/dynamicLagrangian/dynamicLagrangian.C | 4 +- .../turbulenceModels/RAS/LRR/LRR.C | 4 +- .../turbulenceModels/RAS/RASModel/RASModel.C | 8 +- .../turbulenceModels/RAS/RASModel/RASModel.H | 8 +- .../turbulenceModels/RAS/SSG/SSG.C | 4 +- .../RAS/SpalartAllmaras/SpalartAllmaras.C | 4 +- .../atmBoundaryLayer/atmBoundaryLayer.C | 4 +- .../RAS/kOmegaSSTLM/kOmegaSSTLM.C | 4 +- .../RAS/kOmegaSSTSAS/kOmegaSSTSAS.C | 6 +- .../RAS/realizableKE/realizableKE.C | 4 +- .../turbulenceModels/RAS/v2f/v2f.C | 4 +- .../ReynoldsStress/ReynoldsStress.C | 6 +- .../fixedShearStressFvPatchVectorField.C | 4 +- .../fWallFunctionFvPatchScalarField.C | 6 +- .../kLowReWallFunctionFvPatchScalarField.C | 4 +- .../nutURoughWallFunctionFvPatchScalarField.C | 8 +- ...tUSpaldingWallFunctionFvPatchScalarField.C | 10 +-- ...UTabulatedWallFunctionFvPatchScalarField.C | 8 +- src/combustionModels/EDC/EDC.C | 18 ++--- src/combustionModels/FSD/FSD.C | 6 +- .../relaxation/relaxation.C | 4 +- src/combustionModels/PaSR/PaSR.C | 6 +- src/conversion/ensight/file/ensightFile.H | 4 +- .../meshReader/starcd/STARCDMeshReader.C | 4 +- .../dynamicRefineFvMesh/dynamicRefineFvMesh.C | 8 +- .../dynamicRefineFvMesh/dynamicRefineFvMesh.H | 4 +- src/dynamicMesh/boundaryMesh/boundaryMesh.C | 4 +- .../layerAdditionRemoval.C | 12 +-- src/dynamicMesh/meshCut/cellCuts/cellCuts.C | 20 ++--- .../meshCut/cellLooper/cellLooper.C | 4 +- .../meshCut/cellLooper/geomCellLooper.C | 14 ++-- .../meshCut/cellLooper/hexCellLooper.C | 4 +- .../meshCut/cellLooper/topoCellLooper.C | 6 +- .../meshCut/directions/directions.C | 4 +- .../meshCutAndRemove/meshCutAndRemove.C | 4 +- .../meshModifiers/meshCutter/meshCutter.C | 4 +- .../meshCut/refineCell/refineCell.C | 10 +-- .../motionSmoother/motionSmootherAlgo.C | 14 ++-- .../motionSmoother/motionSmootherAlgoCheck.C | 24 +++--- .../motionSmootherAlgoTemplates.C | 4 +- .../polyMeshGeometry/polyMeshGeometry.C | 74 +++++++++---------- .../displacementInterpolationMotionSolver.C | 14 ++-- .../displacementLayeredMotionMotionSolver.C | 6 +- .../layeredSolver/pointEdgeStructuredWalkI.H | 6 +- .../solidBodyMotionFunctions/SDA/SDA.C | 4 +- .../perfectInterface/perfectInterface.C | 4 +- .../pointPatchDist/externalPointEdgePointI.H | 12 +-- .../pointPatchDist/pointPatchDist.C | 4 +- .../polyMeshAdder/faceCoupleInfo.C | 12 +-- .../polyMeshFilter/polyMeshFilter.C | 8 +- .../polyTopoChange/addPatchCellLayer.C | 4 +- .../polyTopoChange/combineFaces.C | 8 +- .../polyTopoChange/edgeCollapser.C | 26 +++---- .../polyTopoChange/hexRef8/hexRef8.C | 24 +++--- .../polyTopoChange/hexRef8/hexRef8.H | 6 +- .../pointEdgeCollapse/pointEdgeCollapseI.H | 10 +-- .../polyTopoChange/polyTopoChange.H | 4 +- .../polyTopoChange/refinementDistanceDataI.H | 4 +- .../polyTopoChange/removePoints.C | 6 +- .../slidingInterface/coupleSlidingInterface.C | 6 +- .../enrichedPatch/enrichedPatchCutFaces.C | 6 +- .../enrichedPatch/enrichedPatchFaces.C | 10 +-- .../slidingInterfaceProjectPoints.C | 34 ++++----- src/engine/engineMesh/engineMesh/engineMesh.C | 10 +-- src/engine/engineTime/engineTime/engineTime.C | 4 +- src/engine/engineValve/engineValve.C | 4 +- src/engine/ignition/ignitionSite.C | 6 +- src/engine/include/StCorr.H | 2 +- .../cfdTools/general/adjustPhi/adjustPhi.C | 14 ++-- .../general/include/createTimeControls.H | 4 +- .../cfdTools/general/include/gh.H | 2 +- .../general/include/readTimeControls.H | 4 +- .../cfdTools/general/include/setDeltaT.H | 4 +- .../general/include/setInitialDeltaT.H | 4 +- .../general/pressureControl/pressureControl.C | 12 +-- .../pimpleControl/pimpleControl.C | 2 +- .../derived/advective/advectiveFvPatchField.C | 6 +- .../derived/fixedMean/fixedMeanFvPatchField.C | 4 +- .../fixedProfile/fixedProfileFvPatchField.C | 4 +- .../flowRateInletVelocityFvPatchVectorField.C | 6 +- ...flowRateOutletVelocityFvPatchVectorField.C | 6 +- .../movingWallVelocityFvPatchVectorField.C | 4 +- .../outletMappedUniformInletFvPatchField.C | 4 +- .../prghPressureFvPatchScalarField.C | 4 +- .../prghTotalPressureFvPatchScalarField.C | 4 +- .../supersonicFreestreamFvPatchVectorField.C | 4 +- .../timeVaryingMappedFixedValueFvPatchField.C | 4 +- .../variableHeightFlowRateFvPatchField.C | 4 +- .../waveTransmissiveFvPatchField.C | 4 +- .../backwardDdtScheme/backwardDdtScheme.C | 2 +- .../backwardDdtScheme/backwardDdtScheme.H | 4 +- .../finiteVolume/fvc/fvcSmooth/smoothDataI.H | 8 +- .../finiteVolume/fvc/fvcSmooth/sweepDataI.H | 8 +- .../cellLimitedGrad/cellLimitedGrad.H | 6 +- .../cellLimitedGrad/cellLimitedGrads.C | 6 +- .../cellMDLimitedGrad/cellMDLimitedGrads.C | 6 +- .../faceLimitedGrad/faceLimitedGrad.H | 6 +- .../faceLimitedGrad/faceLimitedGrads.C | 6 +- .../faceMDLimitedGrad/faceMDLimitedGrads.C | 6 +- .../CentredFitSnGrad/CentredFitSnGradData.C | 4 +- .../limitedSnGrad/limitedSnGrad.C | 4 +- .../solvers/MULES/CMULESTemplates.C | 10 +-- .../fvMatrices/solvers/MULES/MULES.C | 6 +- .../fvMatrices/solvers/MULES/MULESTemplates.C | 8 +- .../extendedUpwindCellToFaceStencil.C | 6 +- src/finiteVolume/fvMesh/fvMeshGeometry.C | 8 +- .../constraint/processor/processorFvPatch.C | 4 +- .../Poisson/PoissonPatchDistMethod.C | 4 +- .../advectionDiffusionPatchDistMethod.C | 6 +- .../meshWave/meshWavePatchDistMethod.C | 6 +- .../meshWave/wallDistData/wallDistData.C | 4 +- .../fvMesh/wallDist/wallDist/wallDist.C | 6 +- .../wallDist/wallPointYPlus/wallPointYPlus.H | 4 +- .../wallDist/wallPointYPlus/wallPointYPlusI.H | 4 +- .../cellPointWeight/cellPointWeight.C | 8 +- .../findCellPointFaceTet.H | 6 +- .../findCellPointFaceTriangle.H | 6 +- .../interpolationCellPointFace.C | 10 +-- .../interpolationPointMVC/pointMVCWeight.C | 6 +- .../limitedSchemes/Gamma/Gamma.H | 4 +- .../limitedSchemes/Phi/Phi.H | 6 +- .../limitedSchemes/QUICK/QUICK.H | 4 +- .../limitedSchemes/QUICK/QUICKV.H | 4 +- .../filteredLinear/filteredLinear.H | 4 +- .../filteredLinear2/filteredLinear2.H | 6 +- .../filteredLinear2/filteredLinear2V.H | 6 +- .../filteredLinear3/filteredLinear3.H | 4 +- .../filteredLinear3/filteredLinear3V.H | 4 +- .../limitedCubic/limitedCubic.H | 6 +- .../limitedCubic/limitedCubicV.H | 6 +- .../limitedLinear/limitedLinear.H | 4 +- .../schemes/FitData/FitData.C | 8 +- .../schemes/linearUpwind/linearUpwindV.C | 6 +- .../surfaceInterpolation.C | 4 +- .../field/fieldAverage/fieldAverage.C | 4 +- .../surfaceFieldValue/surfaceFieldValue.C | 8 +- src/functionObjects/field/flowType/flowType.C | 4 +- .../field/histogram/histogram.C | 4 +- .../field/interfaceHeight/interfaceHeight.C | 4 +- src/functionObjects/field/pressure/pressure.C | 6 +- .../field/streamFunction/streamFunction.C | 16 ++-- .../field/streamLine/streamLine.C | 8 +- .../field/streamLine/streamLineParticle.C | 6 +- src/functionObjects/forces/forces/forces.C | 14 ++-- .../lagrangian/dsmcFields/dsmcFields.C | 4 +- .../pairPatchAgglomeration.C | 6 +- .../motionDirectionalDiffusivity.C | 4 +- ...surfaceDisplacementPointPatchVectorField.C | 4 +- ...aceSlipDisplacementPointPatchVectorField.C | 4 +- ...meVaryingMappedFixedValuePointPatchField.C | 4 +- .../actuationDiskSource/actuationDiskSource.C | 12 +-- .../actuationDiskSourceTemplates.C | 6 +- .../effectivenessHeatExchangerSource.C | 4 +- .../radialActuationDiskSource.C | 6 +- .../radialActuationDiskSourceTemplates.C | 6 +- .../derived/rotorDiskSource/rotorDiskSource.C | 8 +- .../rotorDiskSourceTemplates.C | 8 +- .../trimModel/targetCoeff/targetCoeffTrim.C | 10 +-- .../tabulatedAccelerationSourceTemplates.C | 4 +- .../clouds/Templates/DSMCCloud/DSMCCloud.C | 12 +-- .../parcels/Templates/DSMCParcel/DSMCParcel.C | 6 +- .../LarsenBorgnakkeVariableHardSphere.C | 10 +-- .../VariableHardSphere/VariableHardSphere.C | 4 +- .../FreeStream/FreeStream.C | 4 +- .../MaxwellianThermal/MaxwellianThermal.C | 6 +- .../MixedDiffuseSpecular.C | 6 +- src/lagrangian/basic/particle/particle.C | 8 +- .../COxidationDiffusionLimitedRate.C | 4 +- .../COxidationHurtMitchell.C | 8 +- .../COxidationIntrinsicRate.C | 8 +- .../COxidationKineticDiffusionLimitedRate.C | 4 +- .../COxidationMurphyShaddix.C | 6 +- .../distributionModels/general/general.C | 4 +- .../KinematicCloud/KinematicCloudI.H | 6 +- .../cloudSolution/cloudSolution.C | 4 +- .../clouds/Templates/MPPICCloud/MPPICCloud.C | 6 +- .../Templates/ReactingCloud/ReactingCloudI.H | 6 +- .../Templates/ThermoCloud/ThermoCloudI.H | 6 +- .../integrationScheme/analytical/analytical.C | 6 +- .../KinematicParcel/KinematicParcel.C | 6 +- .../KinematicParcel/KinematicParcelI.H | 10 +-- .../ReactingMultiphaseParcel.C | 6 +- .../ReactingMultiphaseParcelIO.C | 14 ++-- .../Templates/ReactingParcel/ReactingParcel.C | 18 ++--- .../Templates/ThermoParcel/ThermoParcel.C | 4 +- .../Templates/ThermoParcel/ThermoParcelI.H | 4 +- .../phaseProperties/phaseProperties.C | 4 +- .../ParticleCollector/ParticleCollector.C | 8 +- .../PairCollision/PairCollision.C | 8 +- .../PairSpringSliderDashpot.C | 16 ++-- .../WallLocalSpringSliderDashpot.C | 18 ++--- .../WallSpringSliderDashpot.C | 16 ++-- .../ConeInjection/ConeInjection.C | 4 +- .../ConeNozzleInjection/ConeNozzleInjection.C | 4 +- .../FieldActivatedInjection.C | 4 +- .../InflationInjection/InflationInjection.C | 4 +- .../InjectionModel/InjectionModel.C | 6 +- .../InjectionModel/InjectionModelList.C | 6 +- .../ManualInjection/ManualInjection.C | 4 +- .../Drag/NonSphereDrag/NonSphereDragForce.C | 4 +- .../PlessisMasliyahDragForce.C | 4 +- .../Lift/SaffmanMeiLift/SaffmanMeiLiftForce.C | 8 +- .../AveragingMethod/AveragingMethod.C | 4 +- .../absolute/absolute.C | 4 +- .../IsotropyModels/Stochastic/Stochastic.C | 4 +- .../HarrisCrighton/HarrisCrighton.C | 4 +- .../MPPIC/ParticleStressModels/Lun/Lun.C | 4 +- .../TimeScaleModels/equilibrium/equilibrium.C | 6 +- .../TimeScaleModels/isotropic/isotropic.C | 4 +- .../nonEquilibrium/nonEquilibrium.C | 4 +- .../SingleMixtureFraction.C | 4 +- .../LiquidEvaporation/LiquidEvaporation.C | 10 +-- .../LiquidEvaporationBoil.C | 10 +-- .../PhaseChangeModel/PhaseChangeModel.C | 6 +- .../HeatTransferModel/HeatTransferModel.C | 4 +- .../ThermoSurfaceFilm/ThermoSurfaceFilm.C | 8 +- .../molecule/mdTools/averageMDFields.H | 2 +- .../molecule/molecule/moleculeI.H | 10 +-- .../molecule/moleculeCloud/moleculeCloud.C | 12 +-- .../molecule/moleculeCloud/moleculeCloudI.H | 14 ++-- .../molecule/reducedUnits/reducedUnits.C | 8 +- .../derived/pitchForkRing/pitchForkRing.C | 6 +- .../Templates/SprayParcel/SprayParcel.C | 4 +- .../Templates/SprayParcel/SprayParcelI.H | 6 +- .../Templates/SprayParcel/SprayParcelIO.C | 4 +- .../LISAAtomization/LISAAtomization.C | 4 +- .../LISAAtomization/LISASMDCalcMethod1.H | 2 +- .../LISAAtomization/LISASMDCalcMethod2.H | 2 +- .../BreakupModel/PilchErdman/PilchErdman.C | 6 +- .../BreakupModel/ReitzKHRT/ReitzKHRT.C | 12 +-- .../spray/submodels/BreakupModel/SHF/SHF.C | 4 +- .../BreakupModel/TAB/TABSMDCalcMethod2.H | 2 +- .../ORourkeCollision/ORourkeCollision.C | 16 ++-- .../TrajectoryCollision/TrajectoryCollision.C | 12 +-- .../GradientDispersionRAS.C | 10 +-- .../StochasticDispersionRAS.C | 8 +- .../blockDescriptor/blockDescriptor.C | 4 +- .../blockEdges/BSplineEdge/BSpline.C | 6 +- .../blockMesh/blockEdges/arcEdge/arcEdge.C | 10 +-- .../blockMesh/blockEdges/lineEdge/lineEdge.C | 4 +- .../blockEdges/polyLineEdge/polyLine.C | 10 +-- .../projectCurveEdge/projectCurveEdge.C | 6 +- .../blockEdges/projectEdge/projectEdge.C | 8 +- .../blockEdges/splineEdge/CatmullRomSpline.C | 6 +- src/mesh/blockMesh/blockMesh/blockMeshMerge.C | 6 +- .../projectVertex/projectVertex.C | 6 +- .../extrudeModel/extrudeModel/extrudeModel.C | 4 +- src/mesh/extrudeModel/sector/sector.C | 4 +- .../extrudeModel/sigmaRadial/sigmaRadial.C | 4 +- .../medialAxisMeshMover.C | 26 +++---- .../meshRefinement/meshRefinement.C | 22 +++--- .../meshRefinement/meshRefinementBaffles.C | 10 +-- .../meshRefinementProblemCells.C | 16 ++-- .../meshRefinement/meshRefinementRefine.C | 8 +- .../refinementFeatures/refinementFeatures.C | 20 ++--- .../refinementSurfaces/refinementSurfaces.C | 6 +- .../layerParameters/layerParameters.C | 14 ++-- .../pointData/pointDataI.H | 4 +- .../refinementParameters.C | 4 +- .../snappyHexMeshDriver/snappyLayerDriver.C | 28 +++---- .../snappyLayerDriverShrink.C | 26 +++---- .../snappyLayerDriverTemplates.C | 4 +- .../snappyHexMeshDriver/snappySnapDriver.C | 20 ++--- .../snappySnapDriverFeature.C | 26 +++---- .../trackedParticle/trackedParticle.C | 4 +- .../AMIInterpolation/AMIInterpolation.C | 8 +- .../AMIInterpolationParallelOps.C | 4 +- .../AMIMethod/directAMI/directAMI.C | 6 +- .../faceAreaWeightAMI/faceAreaWeightAMI.C | 6 +- .../AMIMethod/mapNearestAMI/mapNearestAMI.C | 4 +- .../sweptFaceAreaWeightAMI.C | 6 +- .../faceAreaIntersect/faceAreaIntersect.C | 6 +- .../cyclicACMIPolyPatch/cyclicACMIPolyPatch.C | 4 +- .../cyclicAMIPolyPatch/cyclicAMIPolyPatch.C | 10 +-- .../PatchEdgeFaceWave/patchEdgeFaceInfoI.H | 8 +- .../PointEdgeWave/pointEdgePointI.H | 12 +-- .../cellClassification/cellClassification.C | 4 +- src/meshTools/cellDist/cellDistFuncs.C | 4 +- .../cellDist/patchWave/patchDataWave.C | 6 +- src/meshTools/cellDist/patchWave/patchWave.C | 6 +- .../cellDist/wallPoint/wallPointDataI.H | 4 +- src/meshTools/cellDist/wallPoint/wallPointI.H | 12 +-- src/meshTools/cellFeatures/cellFeatures.C | 4 +- src/meshTools/cellQuality/cellQuality.C | 18 ++--- .../coordinateRotation/axesRotation.C | 4 +- .../coordinateRotation/cylindrical.C | 8 +- .../extendedEdgeMesh/extendedEdgeMesh.C | 14 ++-- .../extendedEdgeMeshTemplates.C | 8 +- .../extendedFeatureEdgeMesh.C | 4 +- .../extendedFeatureEdgeMeshTemplates.C | 8 +- src/meshTools/indexedOctree/treeDataFace.C | 14 ++-- src/meshTools/indexedOctree/treeDataPoint.C | 4 +- .../indexedOctree/treeDataPrimitivePatch.C | 10 +-- .../indexedOctree/treeDataTriSurface.C | 4 +- .../mappedPolyPatch/mappedPatchBase.C | 26 +++---- src/meshTools/meshSearch/meshSearch.C | 20 ++--- src/meshTools/meshTools/meshTools.C | 20 ++--- .../polyMeshZipUpCells/polyMeshZipUpCells.C | 4 +- .../primitiveMeshGeometry.C | 50 ++++++------- .../searchableBox/searchableBox.C | 10 +-- .../searchableCylinder/searchableCylinder.C | 32 ++++---- .../searchableDisk/searchableDisk.C | 8 +- .../searchableExtrudedCircle.C | 8 +- .../searchablePlane/searchablePlane.C | 8 +- .../searchablePlane/searchablePlane.H | 4 +- .../searchablePlate/searchablePlate.C | 8 +- .../searchableSphere/searchableSphere.C | 10 +-- .../searchableSurfaceCollection.C | 6 +- .../searchableSurfaceWithGaps.C | 6 +- .../searchableSurfaceWithGaps.H | 4 +- .../searchableSurfacesQueries.C | 4 +- .../triSurfaceMesh/triSurfaceMesh.C | 12 +-- .../targetVolumeToCell/targetVolumeToCell.C | 8 +- .../faceSources/normalToFace/normalToFace.C | 8 +- .../faceSources/regionToFace/regionToFace.C | 4 +- src/meshTools/surfaceSets/surfaceSets.C | 8 +- .../booleanSurface/booleanSurface.C | 4 +- .../intersectedSurface/intersectedSurface.C | 16 ++-- .../surfaceIntersection/edgeIntersections.C | 12 +-- .../surfaceIntersection/surfaceIntersection.C | 16 ++-- .../surfaceIntersectionFuncs.C | 4 +- .../orientedSurface/orientedSurface.C | 6 +- .../surfaceFeatures/surfaceFeatures.C | 10 +-- .../surfaceLocation/surfaceLocation.C | 4 +- .../triSurfaceSearch/triSurfaceRegionSearch.C | 6 +- .../triSurfaceSearch/triSurfaceSearch.C | 6 +- .../pointToPointPlanarInterpolation.C | 8 +- .../triSurfaceTools/triSurfaceTools.C | 32 ++++---- .../triSurface/triangleFuncs/triangleFuncs.C | 10 +-- .../twoDPointCorrector/twoDPointCorrector.C | 6 +- .../hierarchGeomDecomp/hierarchGeomDecomp.C | 22 +++--- .../distributedTriSurfaceMesh.C | 16 ++-- src/randomProcesses/noise/noiseFFT.C | 4 +- .../processes/UOprocess/UOprocess.C | 6 +- .../pyrolysisModel/pyrolysisModel.C | 6 +- .../pyrolysisModel/pyrolysisModelCollection.C | 4 +- .../reactingOneDim/reactingOneDim.C | 4 +- ...ilmHeightInletVelocityFvPatchVectorField.C | 4 +- ...linedFilmNusseltHeightFvPatchScalarField.C | 8 +- ...lmNusseltInletVelocityFvPatchVectorField.C | 6 +- ...alphatFilmWallFunctionFvPatchScalarField.C | 6 +- .../nutkFilmWallFunctionFvPatchScalarField.C | 8 +- .../kinematicSingleLayer.C | 8 +- .../contactAngleForce/contactAngleForce.C | 8 +- .../BrunDrippingInjection.C | 4 +- .../curvatureSeparation/curvatureSeparation.C | 10 +-- .../drippingInjection/drippingInjection.C | 4 +- .../injectionModelList/injectionModelList.C | 4 +- .../transferModelList/transferModelList.C | 4 +- .../thixotropicViscosity.C | 8 +- .../solidification/solidification.C | 4 +- .../standardPhaseChange/standardPhaseChange.C | 6 +- .../waxSolventEvaporation.C | 8 +- .../thermoSingleLayer/thermoSingleLayer.C | 6 +- .../linearAxialAngularSpring.C | 10 +-- .../restraints/linearSpring/linearSpring.C | 4 +- .../rigidBodyMotion/rigidBodyMotion.C | 12 +-- .../rigidBodySolver/rigidBodySolver.C | 4 +- src/sampling/cuttingPlane/cuttingPlane.C | 6 +- .../calcMethod/mapNearest/mapNearestMethod.C | 6 +- .../meshToMesh/meshToMeshParallelOps.C | 4 +- .../calculateMeshToMesh0Addressing.C | 4 +- src/sampling/probes/patchProbes.C | 8 +- src/sampling/probes/patchProbesTemplates.C | 6 +- src/sampling/probes/probes.C | 4 +- src/sampling/probes/probesTemplates.C | 8 +- src/sampling/sampledSet/circle/circleSet.C | 4 +- src/sampling/sampledSet/face/faceOnlySet.C | 6 +- .../sampledSet/patchCloud/patchCloudSet.C | 8 +- .../sampledSet/polyLine/polyLineSet.C | 8 +- .../sampledSet/sampledSet/sampledSet.C | 6 +- src/sampling/sampledSet/uniform/uniformSet.C | 6 +- .../distanceSurface/distanceSurface.C | 8 +- .../sampledSurface/isoSurface/isoSurface.C | 4 +- .../isoSurface/isoSurfaceCell.C | 10 +-- .../isoSurface/isoSurfaceCellTemplates.C | 4 +- .../isoSurface/isoSurfaceTemplates.C | 4 +- .../sampledTriSurfaceMesh.C | 14 ++-- .../sampledThresholdCellFaces.C | 6 +- .../sixDoFRigidBodyMotionAxisConstraint.C | 4 +- .../sixDoFRigidBodyMotionLineConstraint.C | 4 +- .../linearAxialAngularSpring.C | 10 +-- .../restraints/linearSpring/linearSpring.C | 4 +- .../tabulatedAxialAngularSpring.C | 8 +- .../sixDoFRigidBodyMotion.C | 12 +-- src/surfMesh/MeshedSurface/MeshedSurface.C | 4 +- src/surfMesh/MeshedSurface/MeshedSurface.H | 4 +- .../surfaceFormats/ac3d/AC3DsurfaceFormat.C | 4 +- .../surfaceFormats/stl/STLsurfaceFormat.C | 8 +- .../surfaceFormats/tri/TRIsurfaceFormat.C | 4 +- .../StandardChemistryModel.C | 20 ++--- .../TDACChemistryModel/TDACChemistryModel.C | 18 ++--- .../TDACChemistryModel/reduction/DRG/DRG.C | 4 +- .../reduction/DRGEP/DRGEP.C | 12 +-- .../TDACChemistryModel/reduction/EFA/EFA.C | 34 ++++----- .../TDACChemistryModel/reduction/PFA/PFA.C | 4 +- .../ISAT/chemPointISAT/chemPointISAT.C | 4 +- .../EulerImplicit/EulerImplicit.C | 10 +-- .../laminarFlameSpeed/Gulders/Gulders.C | 6 +- .../laminarFlameSpeed/GuldersEGR/GuldersEGR.C | 4 +- .../RaviPetersen/RaviPetersen.C | 4 +- .../radiation/radiationModels/P1/P1.C | 4 +- .../radiativeIntensityRay.C | 4 +- .../chemkinReader/chemkinReader.C | 8 +- .../multiComponentMixture.C | 4 +- .../pyrolysisChemistryModel.C | 10 +-- .../Reactions/solidReaction/solidReaction.C | 10 +-- .../equationOfState/Boussinesq/BoussinesqI.H | 6 +- .../PengRobinsonGas/PengRobinsonGasI.H | 6 +- .../adiabaticPerfectFluidI.H | 6 +- .../icoPolynomial/icoPolynomialI.H | 6 +- .../incompressiblePerfectGasI.H | 6 +- .../specie/equationOfState/linear/linearI.H | 6 +- .../perfectFluid/perfectFluidI.H | 6 +- .../equationOfState/rhoConst/rhoConstI.H | 6 +- .../reaction/Reactions/Reaction/Reaction.C | 10 +-- .../ReversibleReaction/ReversibleReaction.C | 4 +- .../ArrheniusReactionRateI.H | 6 +- .../JanevReactionRate/JanevReactionRateI.H | 6 +- .../LandauTellerReactionRateI.H | 12 +-- .../SRIFallOffFunction/SRIFallOffFunctionI.H | 4 +- .../TroeFallOffFunctionI.H | 6 +- .../powerSeries/powerSeriesReactionRateI.H | 4 +- .../specie/specie/specieI.H | 16 ++-- .../specie/thermo/eConst/eConstThermoI.H | 6 +- .../specie/thermo/hConst/hConstThermoI.H | 6 +- .../thermo/hPolynomial/hPolynomialThermoI.H | 6 +- .../specie/thermo/hPower/hPowerThermoI.H | 6 +- .../thermo/hRefConst/hRefConstThermoI.H | 6 +- .../specie/thermo/janaf/janafThermoI.H | 6 +- .../specie/thermo/thermo/thermoI.H | 10 +-- .../specie/transport/const/constTransportI.H | 6 +- .../logPolynomial/logPolynomialTransportI.H | 6 +- .../polynomial/polynomialTransportI.H | 6 +- .../sutherland/sutherlandTransportI.H | 6 +- .../liquidMixtureProperties.C | 18 ++--- .../NSRDSfunctions/NSRDSfunc14/NSRDSfunc14.H | 6 +- .../movingConeTopoFvMesh.C | 14 ++-- .../viscosityModels/Casson/Casson.C | 4 +- .../HerschelBulkley/HerschelBulkley.C | 4 +- .../viscosityModels/powerLaw/powerLaw.C | 4 +- ...namicAlphaContactAngleFvPatchScalarField.C | 6 +- .../faceTriangulation/faceTriangulation.C | 28 +++---- .../triSurface/interfaces/STL/readSTLBINARY.C | 4 +- src/triSurface/triSurface/triSurface.C | 2 +- src/triSurface/triSurface/triSurface.H | 2 +- .../waveVelocityFvPatchVectorField.C | 4 +- src/waves/waveModels/Airy/Airy.C | 6 +- src/waves/waveModels/solitary/solitary.C | 4 +- .../validation/WatersKing/WatersKing.C | 6 +- 729 files changed, 2822 insertions(+), 2809 deletions(-) diff --git a/applications/solvers/basic/potentialFoam/potentialFoam.C b/applications/solvers/basic/potentialFoam/potentialFoam.C index 6dbe9f44a..e0b2a419b 100644 --- a/applications/solvers/basic/potentialFoam/potentialFoam.C +++ b/applications/solvers/basic/potentialFoam/potentialFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -150,7 +150,7 @@ int main(int argc, char *argv[]) // Calculate the flow-direction filter tensor volScalarField magSqrU(magSqr(U)); - volSymmTensorField F(sqr(U)/(magSqrU + SMALL*average(magSqrU))); + volSymmTensorField F(sqr(U)/(magSqrU + small*average(magSqrU))); // Calculate the divergence of the flow-direction filtered div(U*U) // Filtering with the flow-direction generates a more reasonable diff --git a/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C b/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C index 4a2a35635..843ed62bf 100644 --- a/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C +++ b/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -146,7 +146,7 @@ void PDRkEpsilon::correct() volScalarField GR(drag.Gk()); volScalarField LI - (C4_*(Lobs + dimensionedScalar("minLength", dimLength, VSMALL))); + (C4_*(Lobs + dimensionedScalar("minLength", dimLength, vSmall))); // Dissipation equation tmp epsEqn diff --git a/applications/solvers/combustion/PDRFoam/bEqn.H b/applications/solvers/combustion/PDRFoam/bEqn.H index e9f1a7327..77b4db7af 100644 --- a/applications/solvers/combustion/PDRFoam/bEqn.H +++ b/applications/solvers/combustion/PDRFoam/bEqn.H @@ -35,14 +35,14 @@ if (ign.ignited()) volScalarField mgb("mgb", mag(n)); - dimensionedScalar dMgb("dMgb", mgb.dimensions(), SMALL); + dimensionedScalar dMgb("dMgb", mgb.dimensions(), small); { volScalarField bc(b*c); dMgb += 1.0e-3* (bc*mgb)().weightedAverage(mesh.V()) - /(bc.weightedAverage(mesh.V()) + SMALL); + /(bc.weightedAverage(mesh.V()) + small); } mgb += dMgb; diff --git a/applications/solvers/combustion/PDRFoam/laminarFlameSpeed/SCOPE/SCOPELaminarFlameSpeed.C b/applications/solvers/combustion/PDRFoam/laminarFlameSpeed/SCOPE/SCOPELaminarFlameSpeed.C index afdebbd2c..66208a0f1 100644 --- a/applications/solvers/combustion/PDRFoam/laminarFlameSpeed/SCOPE/SCOPELaminarFlameSpeed.C +++ b/applications/solvers/combustion/PDRFoam/laminarFlameSpeed/SCOPE/SCOPELaminarFlameSpeed.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -91,14 +91,14 @@ Foam::laminarFlameSpeedModels::SCOPE::SCOPE MaPolyL_(coeffsDict_.subDict("lowerMaPolynomial")), MaPolyU_(coeffsDict_.subDict("upperMaPolynomial")) { - SuPolyL_.ll = max(SuPolyL_.ll, LFL_) + SMALL; - SuPolyU_.ul = min(SuPolyU_.ul, UFL_) - SMALL; + SuPolyL_.ll = max(SuPolyL_.ll, LFL_) + small; + SuPolyU_.ul = min(SuPolyU_.ul, UFL_) - small; SuPolyL_.lu = 0.5*(SuPolyL_.ul + SuPolyU_.ll); - SuPolyU_.lu = SuPolyL_.lu - SMALL; + SuPolyU_.lu = SuPolyL_.lu - small; MaPolyL_.lu = 0.5*(MaPolyL_.ul + MaPolyU_.ll); - MaPolyU_.lu = MaPolyL_.lu - SMALL; + MaPolyU_.lu = MaPolyL_.lu - small; if (debug) { diff --git a/applications/solvers/combustion/PDRFoam/setDeltaT.H b/applications/solvers/combustion/PDRFoam/setDeltaT.H index e14cc3cc0..b003854e7 100644 --- a/applications/solvers/combustion/PDRFoam/setDeltaT.H +++ b/applications/solvers/combustion/PDRFoam/setDeltaT.H @@ -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-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -33,7 +33,7 @@ Description if (adjustTimeStep) { - scalar maxDeltaTFact = maxCo/(CoNum + StCoNum + SMALL); + scalar maxDeltaTFact = maxCo/(CoNum + StCoNum + small); scalar deltaTFact = min(min(maxDeltaTFact, 1.0 + 0.1*maxDeltaTFact), 1.2); runTime.setDeltaT diff --git a/applications/solvers/combustion/XiFoam/bEqn.H b/applications/solvers/combustion/XiFoam/bEqn.H index 6e66e8014..19da0426b 100644 --- a/applications/solvers/combustion/XiFoam/bEqn.H +++ b/applications/solvers/combustion/XiFoam/bEqn.H @@ -17,8 +17,8 @@ if (ign.ignited()) dimensionedScalar dMgb = 1.0e-3* (b*c*mgb)().weightedAverage(mesh.V()) - /((b*c)().weightedAverage(mesh.V()) + SMALL) - + dimensionedScalar("ddMgb", mgb.dimensions(), SMALL); + /((b*c)().weightedAverage(mesh.V()) + small) + + dimensionedScalar("ddMgb", mgb.dimensions(), small); mgb += dMgb; diff --git a/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H b/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H index a12464614..2fd30a826 100644 --- a/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H +++ b/applications/solvers/combustion/fireFoam/setMultiRegionDeltaT.H @@ -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-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -33,20 +33,20 @@ Description if (adjustTimeStep) { - if (CoNum == -GREAT) + if (CoNum == -great) { - CoNum = SMALL; + CoNum = small; } - if (DiNum == -GREAT) + if (DiNum == -great) { - DiNum = SMALL; + DiNum = small; } - const scalar TFactorFluid = maxCo/(CoNum + SMALL); - const scalar TFactorSolid = maxDi/(DiNum + SMALL); - const scalar TFactorFilm = maxCo/(surfaceFilm.CourantNumber() + SMALL); + const scalar TFactorFluid = maxCo/(CoNum + small); + const scalar TFactorSolid = maxDi/(DiNum + small); + const scalar TFactorFilm = maxCo/(surfaceFilm.CourantNumber() + small); const scalar dt0 = runTime.deltaTValue(); diff --git a/applications/solvers/combustion/reactingFoam/setRDeltaT.H b/applications/solvers/combustion/reactingFoam/setRDeltaT.H index 0a0ecd7cf..9f03d1cbc 100644 --- a/applications/solvers/combustion/reactingFoam/setRDeltaT.H +++ b/applications/solvers/combustion/reactingFoam/setRDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -32,7 +32,7 @@ License scalar maxCo(readScalar(pimpleDict.lookup("maxCo"))); // Maximum time scale - scalar maxDeltaT(pimpleDict.lookupOrDefault("maxDeltaT", GREAT)); + scalar maxDeltaT(pimpleDict.lookupOrDefault("maxDeltaT", great)); // Smoothing parameter (0-1) when smoothing iterations > 0 scalar rDeltaTSmoothingCoeff @@ -84,8 +84,8 @@ License ); Info<< " Temperature = " - << 1/(gMax(rDeltaTT.field()) + VSMALL) << ", " - << 1/(gMin(rDeltaTT.field()) + VSMALL) << endl; + << 1/(gMax(rDeltaTT.field()) + vSmall) << ", " + << 1/(gMin(rDeltaTT.field()) + vSmall) << endl; rDeltaT.ref() = max(rDeltaT(), rDeltaTT); } @@ -136,8 +136,8 @@ License if (foundY) { Info<< " Composition = " - << 1/(gMax(rDeltaTY.field()) + VSMALL) << ", " - << 1/(gMin(rDeltaTY.field()) + VSMALL) << endl; + << 1/(gMax(rDeltaTY.field()) + vSmall) << ", " + << 1/(gMin(rDeltaTY.field()) + vSmall) << endl; rDeltaT.ref() = max(rDeltaT(), rDeltaTY); } diff --git a/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C b/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C index d9a4a4e7d..58a51aa2c 100644 --- a/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C +++ b/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -90,7 +90,7 @@ Foam::smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField { if ( - mag(accommodationCoeff_) < SMALL + mag(accommodationCoeff_) < small || mag(accommodationCoeff_) > 2.0 ) { diff --git a/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C b/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C index 43cc740a9..4499a5cea 100644 --- a/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C +++ b/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -92,7 +92,7 @@ Foam::maxwellSlipUFvPatchVectorField::maxwellSlipUFvPatchVectorField { if ( - mag(accommodationCoeff_) < SMALL + mag(accommodationCoeff_) < small || mag(accommodationCoeff_) > 2.0 ) { diff --git a/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H b/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H index db42fb022..4f8019a94 100644 --- a/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H +++ b/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H @@ -20,7 +20,7 @@ scalar maxDeltaT ( - pimpleDict.lookupOrDefault("maxDeltaT", GREAT) + pimpleDict.lookupOrDefault("maxDeltaT", great) ); volScalarField rDeltaT0("rDeltaT0", rDeltaT); diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/compressibleMultiRegionCourantNo.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/compressibleMultiRegionCourantNo.H index 3ca2f6858..e070c5966 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/compressibleMultiRegionCourantNo.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/compressibleMultiRegionCourantNo.H @@ -1,4 +1,4 @@ - scalar CoNum = -GREAT; + scalar CoNum = -great; forAll(fluidRegions, regionI) { CoNum = max diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H index 7acec8782..c1bb05fc2 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H @@ -131,7 +131,7 @@ forAll(fluidRegions, i) dimensionedScalar ghRef ( - mag(gFluid[i].value()) > SMALL + mag(gFluid[i].value()) > small ? gFluid[i] & (cmptMag(gFluid[i].value())/mag(gFluid[i].value()))*hRefFluid[i] : dimensionedScalar("ghRef", gFluid[i].dimensions()*dimLength, 0) @@ -226,7 +226,7 @@ forAll(fluidRegions, i) "rhoMax", simpleDict, dimDensity, - GREAT + great ) ) ); diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H index de9e253df..dc0e091d4 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/pEqn.H @@ -27,7 +27,7 @@ constrainPressure(p_rgh, rho, U, phiHbyA, rhorAUf, MRF); dimensionedScalar compressibility = fvc::domainIntegrate(psi); - bool compressible = (compressibility.value() > SMALL); + bool compressible = (compressibility.value() > small); // Solve pressure for (int nonOrth=0; nonOrth<=nNonOrthCorr; nonOrth++) diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H index 82dc87584..d62806050 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H @@ -1,4 +1,4 @@ - scalar CoNum = -GREAT; + scalar CoNum = -great; forAll(fluidRegions, regionI) { diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/createFluidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/createFluidFields.H index fa84e2e81..9f001d43a 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/createFluidFields.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/createFluidFields.H @@ -127,7 +127,7 @@ forAll(fluidRegions, i) dimensionedScalar ghRef ( - mag(gFluid[i].value()) > SMALL + mag(gFluid[i].value()) > small ? gFluid[i] & (cmptMag(gFluid[i].value())/mag(gFluid[i].value()))*hRefFluid[i] : dimensionedScalar("ghRef", gFluid[i].dimensions()*dimLength, 0) diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H index 8773c152b..c29dbe5fc 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/pEqn.H @@ -1,6 +1,6 @@ bool closedVolume = p_rgh.needReference(); dimensionedScalar compressibility = fvc::domainIntegrate(psi); -bool compressible = (compressibility.value() > SMALL); +bool compressible = (compressibility.value() > small); rho = thermo.rho(); diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setInitialMultiRegionDeltaT.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setInitialMultiRegionDeltaT.H index f768c3c8b..27575ee3b 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setInitialMultiRegionDeltaT.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setInitialMultiRegionDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -31,16 +31,16 @@ Description if (adjustTimeStep) { - if ((runTime.timeIndex() == 0) && ((CoNum > SMALL) || (DiNum > SMALL))) + if ((runTime.timeIndex() == 0) && ((CoNum > small) || (DiNum > small))) { - if (CoNum < SMALL) + if (CoNum < small) { - CoNum = SMALL; + CoNum = small; } - if (DiNum < SMALL) + if (DiNum < small) { - DiNum = SMALL; + DiNum = small; } runTime.setDeltaT diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setMultiRegionDeltaT.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setMultiRegionDeltaT.H index 7db610212..5c5d2aa09 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setMultiRegionDeltaT.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/include/setMultiRegionDeltaT.H @@ -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-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -33,18 +33,18 @@ Description if (adjustTimeStep) { - if (CoNum == -GREAT) + if (CoNum == -great) { - CoNum = SMALL; + CoNum = small; } - if (DiNum == -GREAT) + if (DiNum == -great) { - DiNum = SMALL; + DiNum = small; } - scalar maxDeltaTFluid = maxCo/(CoNum + SMALL); - scalar maxDeltaTSolid = maxDi/(DiNum + SMALL); + scalar maxDeltaTFluid = maxCo/(CoNum + small); + scalar maxDeltaTSolid = maxDi/(DiNum + small); scalar deltaTFluid = min diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/solidRegionDiffusionNo.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/solidRegionDiffusionNo.H index ec93c58da..1d8cac491 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/solidRegionDiffusionNo.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/solidRegionDiffusionNo.H @@ -1,4 +1,4 @@ -scalar DiNum = -GREAT; +scalar DiNum = -great; forAll(solidRegions, i) { diff --git a/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C b/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C index 7b00d6627..3c5d1c2b7 100644 --- a/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C +++ b/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -95,7 +95,7 @@ void Foam::adjointOutletVelocityFvPatchVectorField::updateCoeffs() patch().lookupPatchField("U"); scalarField Un(mag(patch().nf() & Up)); - vectorField UtHat((Up - patch().nf()*Un)/(Un + SMALL)); + vectorField UtHat((Up - patch().nf()*Un)/(Un + small)); vectorField Uan(patch().nf()*(patch().nf() & patchInternalField())); diff --git a/applications/solvers/incompressible/boundaryFoam/evaluateNearWall.H b/applications/solvers/incompressible/boundaryFoam/evaluateNearWall.H index 3534caebd..9813bf8cd 100644 --- a/applications/solvers/incompressible/boundaryFoam/evaluateNearWall.H +++ b/applications/solvers/incompressible/boundaryFoam/evaluateNearWall.H @@ -13,17 +13,17 @@ scalar uTau = ::sqrt(mag(tauw)); - scalar yPlus = uTau*y[cellId]/(nu + ROOTVSMALL); + scalar yPlus = uTau*y[cellId]/(nu + rootVSmall); - scalar uPlus = magUp/(uTau + ROOTVSMALL); + scalar uPlus = magUp/(uTau + rootVSmall); scalar nutPlus = nut/nu; - scalar kPlus = k/(sqr(uTau) + ROOTVSMALL); + scalar kPlus = k/(sqr(uTau) + rootVSmall); - scalar epsilonPlus = epsilon*nu/(pow4(uTau) + ROOTVSMALL); + scalar epsilonPlus = epsilon*nu/(pow4(uTau) + rootVSmall); -// scalar omegaPlus = omega*nu/(sqr(uTau) + ROOTVSMALL); +// scalar omegaPlus = omega*nu/(sqr(uTau) + rootVSmall); scalar Rey = magUp*y[cellId]/nu; diff --git a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H index a97b811db..a47e4abcd 100644 --- a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H +++ b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -32,7 +32,7 @@ License scalar maxCo(readScalar(pimpleDict.lookup("maxCo"))); // Maximum time scale - scalar maxDeltaT(pimpleDict.lookupOrDefault("maxDeltaT", GREAT)); + scalar maxDeltaT(pimpleDict.lookupOrDefault("maxDeltaT", great)); // Smoothing parameter (0-1) when smoothing iterations > 0 scalar rDeltaTSmoothingCoeff @@ -91,8 +91,8 @@ License ); Info<< " Temperature = " - << gMin(1/(rDeltaTT.field() + VSMALL)) << ", " - << gMax(1/(rDeltaTT.field() + VSMALL)) << endl; + << gMin(1/(rDeltaTT.field() + vSmall)) << ", " + << gMax(1/(rDeltaTT.field() + vSmall)) << endl; rDeltaT.ref() = max ( diff --git a/applications/solvers/lagrangian/reactingParcelFoam/setMultiRegionDeltaT.H b/applications/solvers/lagrangian/reactingParcelFoam/setMultiRegionDeltaT.H index a61829a6b..3bb1c30c2 100644 --- a/applications/solvers/lagrangian/reactingParcelFoam/setMultiRegionDeltaT.H +++ b/applications/solvers/lagrangian/reactingParcelFoam/setMultiRegionDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -34,7 +34,7 @@ Description if (adjustTimeStep) { const scalar maxDeltaTFact = - min(maxCo/(CoNum + SMALL), maxCo/(surfaceFilm.CourantNumber() + SMALL)); + min(maxCo/(CoNum + small), maxCo/(surfaceFilm.CourantNumber() + small)); const scalar deltaTFact = min(min(maxDeltaTFact, 1.0 + 0.1*maxDeltaTFact), 1.2); diff --git a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H index 15f114afb..6aa443eab 100644 --- a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H +++ b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -32,7 +32,7 @@ License scalar maxCo(readScalar(pimpleDict.lookup("maxCo"))); // Maximum time scale - scalar maxDeltaT(pimpleDict.lookupOrDefault("maxDeltaT", GREAT)); + scalar maxDeltaT(pimpleDict.lookupOrDefault("maxDeltaT", great)); // Smoothing parameter (0-1) when smoothing iterations > 0 scalar rDeltaTSmoothingCoeff @@ -90,8 +90,8 @@ License ); Info<< " Temperature = " - << gMin(1/(rDeltaTT.field() + VSMALL)) << ", " - << gMax(1/(rDeltaTT.field() + VSMALL)) << endl; + << gMin(1/(rDeltaTT.field() + vSmall)) << ", " + << gMax(1/(rDeltaTT.field() + vSmall)) << endl; rDeltaT.ref() = max ( diff --git a/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/createFields.H b/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/createFields.H index 4d58ba7b4..9bdd95442 100644 --- a/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/createFields.H +++ b/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/createFields.H @@ -59,7 +59,7 @@ dimensionedScalar rhoMax "rhoMax", simple.dict(), dimDensity, - GREAT + great ) ); diff --git a/applications/solvers/lagrangian/sprayFoam/createFields.H b/applications/solvers/lagrangian/sprayFoam/createFields.H index 020efe380..64d58295c 100644 --- a/applications/solvers/lagrangian/sprayFoam/createFields.H +++ b/applications/solvers/lagrangian/sprayFoam/createFields.H @@ -59,7 +59,7 @@ dimensionedScalar rhoMax "rhoMax", pimple.dict(), dimDensity, - GREAT + great ) ); diff --git a/applications/solvers/multiphase/VoF/setDeltaT.H b/applications/solvers/multiphase/VoF/setDeltaT.H index 924d24c8e..b5f546bc8 100644 --- a/applications/solvers/multiphase/VoF/setDeltaT.H +++ b/applications/solvers/multiphase/VoF/setDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -34,7 +34,7 @@ Description if (adjustTimeStep) { scalar maxDeltaTFact = - min(maxCo/(CoNum + SMALL), maxAlphaCo/(alphaCoNum + SMALL)); + min(maxCo/(CoNum + small), maxAlphaCo/(alphaCoNum + small)); scalar deltaTFact = min(min(maxDeltaTFact, 1.0 + 0.1*maxDeltaTFact), 1.2); diff --git a/applications/solvers/multiphase/VoF/setRDeltaT.H b/applications/solvers/multiphase/VoF/setRDeltaT.H index f9725ec97..5254a98cf 100644 --- a/applications/solvers/multiphase/VoF/setRDeltaT.H +++ b/applications/solvers/multiphase/VoF/setRDeltaT.H @@ -50,7 +50,7 @@ scalar maxDeltaT ( - pimpleDict.lookupOrDefault("maxDeltaT", GREAT) + pimpleDict.lookupOrDefault("maxDeltaT", great) ); volScalarField rDeltaT0("rDeltaT0", rDeltaT); diff --git a/applications/solvers/multiphase/cavitatingFoam/setDeltaT.H b/applications/solvers/multiphase/cavitatingFoam/setDeltaT.H index bd6093af1..cf402dccf 100644 --- a/applications/solvers/multiphase/cavitatingFoam/setDeltaT.H +++ b/applications/solvers/multiphase/cavitatingFoam/setDeltaT.H @@ -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-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -34,7 +34,7 @@ Description if (adjustTimeStep) { scalar maxDeltaTFact = - min(maxCo/(CoNum + SMALL), maxAcousticCo/(acousticCoNum + SMALL)); + min(maxCo/(CoNum + small), maxAcousticCo/(acousticCoNum + small)); scalar deltaTFact = min(min(maxDeltaTFact, 1.0 + 0.1*maxDeltaTFact), 1.2); diff --git a/applications/solvers/multiphase/cavitatingFoam/setInitialDeltaT.H b/applications/solvers/multiphase/cavitatingFoam/setInitialDeltaT.H index 52c04603c..0e2594a5c 100644 --- a/applications/solvers/multiphase/cavitatingFoam/setInitialDeltaT.H +++ b/applications/solvers/multiphase/cavitatingFoam/setInitialDeltaT.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -32,10 +32,10 @@ Description if (adjustTimeStep) { - if (CoNum > SMALL) + if (CoNum > small) { scalar maxDeltaTFact = - min(maxCo/(CoNum + SMALL), maxAcousticCo/(acousticCoNum + SMALL)); + min(maxCo/(CoNum + small), maxAcousticCo/(acousticCoNum + small)); runTime.setDeltaT ( diff --git a/applications/solvers/multiphase/compressibleMultiphaseInterFoam/multiphaseMixtureThermo/multiphaseMixtureThermo.C b/applications/solvers/multiphase/compressibleMultiphaseInterFoam/multiphaseMixtureThermo/multiphaseMixtureThermo.C index 1cfc445e2..2263096cf 100644 --- a/applications/solvers/multiphase/compressibleMultiphaseInterFoam/multiphaseMixtureThermo/multiphaseMixtureThermo.C +++ b/applications/solvers/multiphase/compressibleMultiphaseInterFoam/multiphaseMixtureThermo/multiphaseMixtureThermo.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -889,7 +889,7 @@ void Foam::multiphaseMixtureThermo::correctContactAngle scalar uTheta = tp().uTheta(); // Calculate the dynamic contact angle if required - if (uTheta > SMALL) + if (uTheta > small) { scalar thetaA = convertToRad*tp().thetaA(matched); scalar thetaR = convertToRad*tp().thetaR(matched); @@ -909,7 +909,7 @@ void Foam::multiphaseMixtureThermo::correctContactAngle ); // Normalise nWall - nWall /= (mag(nWall) + SMALL); + nWall /= (mag(nWall) + small); // Calculate Uwall resolved normal to the interface parallel to // the interface diff --git a/applications/solvers/multiphase/driftFluxFoam/mixtureViscosityModels/BinghamPlastic/BinghamPlastic.C b/applications/solvers/multiphase/driftFluxFoam/mixtureViscosityModels/BinghamPlastic/BinghamPlastic.C index 2711e79d9..1fa8430c3 100644 --- a/applications/solvers/multiphase/driftFluxFoam/mixtureViscosityModels/BinghamPlastic/BinghamPlastic.C +++ b/applications/solvers/multiphase/driftFluxFoam/mixtureViscosityModels/BinghamPlastic/BinghamPlastic.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -106,7 +106,7 @@ Foam::mixtureViscosityModels::BinghamPlastic::mu volScalarField mup(plastic::mu(muc)); - dimensionedScalar tauySmall("tauySmall", tauy.dimensions(), SMALL); + dimensionedScalar tauySmall("tauySmall", tauy.dimensions(), small); return min ( diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.C b/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.C index a2df55aa5..fed7b5c28 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.C +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -73,7 +73,7 @@ void Foam::threePhaseInterfaceProperties::correctContactAngle scalarField sumTwoPhaseAlpha ( - twoPhaseAlpha2 + twoPhaseAlpha3 + SMALL + twoPhaseAlpha2 + twoPhaseAlpha3 + small ); twoPhaseAlpha2 /= sumTwoPhaseAlpha; diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.H b/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.H index 826d6658d..162eaa6b2 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.H +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/threePhaseInterfaceProperties/threePhaseInterfaceProperties.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -133,7 +133,7 @@ public: return (limitedAlpha2*sigma12_ + limitedAlpha3*sigma13_) - /(limitedAlpha2 + limitedAlpha3 + SMALL); + /(limitedAlpha2 + limitedAlpha3 + small); } tmp sigmaK() const diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseEulerFoam.C b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseEulerFoam.C index c27bf597e..a1b7f7f71 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseEulerFoam.C +++ b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseEulerFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -67,7 +67,7 @@ int main(int argc, char *argv[]) ( "maxSlamVelocity", dimVelocity, - fluid.lookupOrDefault("maxSlamVelocity", GREAT) + fluid.lookupOrDefault("maxSlamVelocity", great) ); turbulence->validate(); diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C index 8963e026e..7b82d3d1f 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C +++ b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -296,7 +296,7 @@ void Foam::multiphaseSystem::correctContactAngle scalar uTheta = tp().uTheta(); // Calculate the dynamic contact angle if required - if (uTheta > SMALL) + if (uTheta > small) { scalar thetaA = convertToRad*tp().thetaA(matched); scalar thetaR = convertToRad*tp().thetaR(matched); @@ -316,7 +316,7 @@ void Foam::multiphaseSystem::correctContactAngle ); // Normalise nWall - nWall /= (mag(nWall) + SMALL); + nWall /= (mag(nWall) + small); // Calculate Uwall resolved normal to the interface parallel to // the interface diff --git a/applications/solvers/multiphase/multiphaseInterFoam/multiphaseMixture/multiphaseMixture.C b/applications/solvers/multiphase/multiphaseInterFoam/multiphaseMixture/multiphaseMixture.C index fdb1ec547..20c8c6e8c 100644 --- a/applications/solvers/multiphase/multiphaseInterFoam/multiphaseMixture/multiphaseMixture.C +++ b/applications/solvers/multiphase/multiphaseInterFoam/multiphaseMixture/multiphaseMixture.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -459,7 +459,7 @@ void Foam::multiphaseMixture::correctContactAngle scalar uTheta = tp().uTheta(); // Calculate the dynamic contact angle if required - if (uTheta > SMALL) + if (uTheta > small) { scalar thetaA = convertToRad*tp().thetaA(matched); scalar thetaR = convertToRad*tp().thetaR(matched); @@ -479,7 +479,7 @@ void Foam::multiphaseMixture::correctContactAngle ); // Normalise nWall - nWall /= (mag(nWall) + SMALL); + nWall /= (mag(nWall) + small); // Calculate Uwall resolved normal to the interface parallel to // the interface diff --git a/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatPhaseChangeJayatillekeWallFunction/alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField.C b/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatPhaseChangeJayatillekeWallFunction/alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField.C index 3db4032c6..f6d8e847c 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatPhaseChangeJayatillekeWallFunction/alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField.C +++ b/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatPhaseChangeJayatillekeWallFunction/alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField.C @@ -93,7 +93,7 @@ alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField::yPlusTherm scalar df = 1 - 1.0/(ypt*kappa_*Prat[facei]); scalar yptNew = ypt - f/df; - if (yptNew < VSMALL) + if (yptNew < vSmall) { ypsf[facei] = 0; } @@ -194,7 +194,7 @@ alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField::calcAlphat scalar A = qDot[facei]*rhow[facei]*uTau[facei]*y[facei]; scalar B = qDot[facei]*Pr[facei]*yPlus[facei]; scalar C = Pr[facei]*0.5*rhow[facei]*uTau[facei]*sqr(magUp[facei]); - alphaEff = A/(B + C + VSMALL); + alphaEff = A/(B + C + vSmall); } else { @@ -206,7 +206,7 @@ alphatPhaseChangeJayatillekeWallFunctionFvPatchScalarField::calcAlphat scalar C = 0.5*rhow[facei]*uTau[facei] *(Prt_*sqr(magUp[facei]) + (Pr[facei] - Prt_)*sqr(magUc)); - alphaEff = A/(B + C + VSMALL); + alphaEff = A/(B + C + vSmall); } // Update convective heat transfer turbulent thermal diffusivity diff --git a/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C b/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C index 81bdd7021..4146e24fa 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C +++ b/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C @@ -547,7 +547,7 @@ void alphatWallBoilingWallFunctionFvPatchScalarField::updateCoeffs() const scalarField Al ( - fLiquid*4.8*exp( min(-Ja/80, log(VGREAT))) + fLiquid*4.8*exp( min(-Ja/80, log(vGreat))) ); const scalarField A2(min(pi*sqr(dDep_)*N*Al/4, scalar(1))); diff --git a/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/wallBoilingSubModels/IATEsource/wallBoiling.C b/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/wallBoilingSubModels/IATEsource/wallBoiling.C index bac1c27b7..b93893305 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/wallBoilingSubModels/IATEsource/wallBoiling.C +++ b/applications/solvers/multiphase/reactingEulerFoam/derivedFvPatchFields/wallBoilingSubModels/IATEsource/wallBoiling.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2016-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2016-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -124,7 +124,7 @@ Foam::diameterModels::IATEsources::wallBoiling::R forAll(alphatw, facei) { - if (dmdt[facei] > SMALL) + if (dmdt[facei] > small) { const label faceCelli = faceCells[facei]; R[faceCelli] = diff --git a/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/NonRandomTwoLiquid/NonRandomTwoLiquid.C b/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/NonRandomTwoLiquid/NonRandomTwoLiquid.C index 7f1222f79..4a2af750c 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/NonRandomTwoLiquid/NonRandomTwoLiquid.C +++ b/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/NonRandomTwoLiquid/NonRandomTwoLiquid.C @@ -185,8 +185,8 @@ update ( sqr(X2) *( - tau21*sqr(G21)/max(sqr(X1 + X2*G21), SMALL) - + tau12*G12/max(sqr(X2 + X1*G12), SMALL) + tau21*sqr(G21)/max(sqr(X1 + X2*G21), small) + + tau12*G12/max(sqr(X2 + X1*G12), small) ) ); gamma2_ = @@ -194,8 +194,8 @@ update ( sqr(X1) *( - tau12*sqr(G12)/max(sqr(X2 + X1*G12), SMALL) - + tau21*G21/max(sqr(X1 + X2*G21), SMALL) + tau12*sqr(G12)/max(sqr(X2 + X1*G12), small) + + tau21*G21/max(sqr(X1 + X2*G21), small) ) ); } diff --git a/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/Saturated/Saturated.C b/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/Saturated/Saturated.C index 5821ac204..8ae1921fd 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/Saturated/Saturated.C +++ b/applications/solvers/multiphase/reactingEulerFoam/interfacialCompositionModels/interfaceCompositionModels/Saturated/Saturated.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2015-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2015-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -116,7 +116,7 @@ Foam::interfaceCompositionModels::Saturated::Yf return this->thermo_.Y()[speciesIndex] *(scalar(1) - wRatioByP()*saturationModel_->pSat(Tf)) - /max(scalar(1) - this->thermo_.Y()[saturatedIndex_], SMALL); + /max(scalar(1) - this->thermo_.Y()[saturatedIndex_], small); } } @@ -143,7 +143,7 @@ Foam::interfaceCompositionModels::Saturated::YfPrime return - this->thermo_.Y()[speciesIndex] *wRatioByP()*saturationModel_->pSatPrime(Tf) - /max(scalar(1) - this->thermo_.Y()[saturatedIndex_], SMALL); + /max(scalar(1) - this->thermo_.Y()[saturatedIndex_], small); } } diff --git a/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/dragModels/Lain/Lain.C b/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/dragModels/Lain/Lain.C index f5ba83172..106cbd29f 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/dragModels/Lain/Lain.C +++ b/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/dragModels/Lain/Lain.C @@ -67,7 +67,7 @@ Foam::tmp Foam::dragModels::Lain::CdRe() const return neg(Re - 1.5)*16.0 + pos0(Re - 1.5)*neg(Re - 80)*14.9*pow(Re, 0.22) - + pos0(Re - 80)*neg(Re - 1500)*48*(1 - 2.21/sqrt(max(Re, SMALL))) + + pos0(Re - 80)*neg(Re - 1500)*48*(1 - 2.21/sqrt(max(Re, small))) + pos0(Re - 1500)*2.61*Re; } diff --git a/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C b/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C index 616949c6b..a2daf9842 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C +++ b/applications/solvers/multiphase/reactingEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -67,7 +67,7 @@ Foam::virtualMassModels::Lamb::~Lamb() Foam::tmp Foam::virtualMassModels::Lamb::Cvm() const { - volScalarField E(min(max(pair_.E(), SMALL), 1 - SMALL)); + volScalarField E(min(max(pair_.E(), small), 1 - small)); volScalarField rtOmEsq(sqrt(1 - sqr(E))); return diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/BlendedInterfacialModel/blendingMethods/linear/linear.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/BlendedInterfacialModel/blendingMethods/linear/linear.C index 510665353..0142f8bf9 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/BlendedInterfacialModel/blendingMethods/linear/linear.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/BlendedInterfacialModel/blendingMethods/linear/linear.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -128,7 +128,7 @@ Foam::tmp Foam::blendingMethods::linear::f1 max ( (phase2 - minPartAlpha) - /(minFullAlpha - minPartAlpha + SMALL), + /(minFullAlpha - minPartAlpha + small), scalar(0) ), scalar(1) @@ -153,7 +153,7 @@ Foam::tmp Foam::blendingMethods::linear::f2 max ( (phase1 - minPartAlpha) - /(minFullAlpha - minPartAlpha + SMALL), + /(minFullAlpha - minPartAlpha + small), scalar(0) ), scalar(1) diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/HeatAndMassTransferPhaseSystem/HeatAndMassTransferPhaseSystem.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/HeatAndMassTransferPhaseSystem/HeatAndMassTransferPhaseSystem.C index bbd0a394a..53dbe3323 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/HeatAndMassTransferPhaseSystem/HeatAndMassTransferPhaseSystem.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/HeatAndMassTransferPhaseSystem/HeatAndMassTransferPhaseSystem.C @@ -108,7 +108,7 @@ HeatAndMassTransferPhaseSystem ( "small", heatTransferModel::dimK, - SMALL + small ) ), zeroGradientFvPatchScalarField::typeName @@ -258,7 +258,7 @@ Foam::HeatAndMassTransferPhaseSystem::heatTransfer() const /max ( K1 + K2, - dimensionedScalar("small", heatTransferModel::dimK, SMALL) + dimensionedScalar("small", heatTransferModel::dimK, small) ) ); @@ -360,8 +360,8 @@ void Foam::HeatAndMassTransferPhaseSystem::correctThermo() ); // Limit the H[12] to avoid /0 - H1.max(SMALL); - H2.max(SMALL); + H1.max(small); + H2.max(small); Tf = (H1*T1 + H2*T2)/(H1 + H2); diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/InterfaceCompositionPhaseChangePhaseSystem/InterfaceCompositionPhaseChangePhaseSystem.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/InterfaceCompositionPhaseChangePhaseSystem/InterfaceCompositionPhaseChangePhaseSystem.C index a78786fe4..e7de788c5 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/InterfaceCompositionPhaseChangePhaseSystem/InterfaceCompositionPhaseChangePhaseSystem.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/InterfaceCompositionPhaseChangePhaseSystem/InterfaceCompositionPhaseChangePhaseSystem.C @@ -470,7 +470,7 @@ correctThermo() volScalarField H1(this->heatTransferModels_[pair][pair.first()]->K()); volScalarField H2(this->heatTransferModels_[pair][pair.second()]->K()); - dimensionedScalar HSmall("small", heatTransferModel::dimK, SMALL); + dimensionedScalar HSmall("small", heatTransferModel::dimK, small); volScalarField mDotL ( diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/ThermalPhaseChangePhaseSystem/ThermalPhaseChangePhaseSystem.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/ThermalPhaseChangePhaseSystem/ThermalPhaseChangePhaseSystem.C index 06de0ed78..bba44beb1 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/ThermalPhaseChangePhaseSystem/ThermalPhaseChangePhaseSystem.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/PhaseSystems/ThermalPhaseChangePhaseSystem/ThermalPhaseChangePhaseSystem.C @@ -553,8 +553,8 @@ void Foam::ThermalPhaseChangePhaseSystem::correctThermo() ); // Limit the H[12] to avoid /0 - H1.max(SMALL); - H2.max(SMALL); + H1.max(small); + H2.max(small); Tf = (H1*T1 + H2*T2 + iDmdtNew*L)/(H1 + H2); diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/diameterModels/velocityGroup/velocityGroup.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/diameterModels/velocityGroup/velocityGroup.C index e54d3109f..6ac0b4e16 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/diameterModels/velocityGroup/velocityGroup.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/diameterModels/velocityGroup/velocityGroup.C @@ -74,7 +74,7 @@ Foam::diameterModels::velocityGroup::secondMoment() const const sizeGroup& fi = sizeGroups_[i]; m2 += sqr(fi.d())*formFactor()*fi - *max(fi.phase(), SMALL)/fi.x(); + *max(fi.phase(), small)/fi.x(); } return tm2; @@ -106,7 +106,7 @@ Foam::diameterModels::velocityGroup::thirdMoment() const const sizeGroup& fi = sizeGroups_[i]; m3 += pow3(fi.d())*formFactor()*fi - *max(fi.phase(), SMALL)/fi.x(); + *max(fi.phase(), small)/fi.x(); } return tm3; diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/driftModels/phaseChange/phaseChange.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/driftModels/phaseChange/phaseChange.C index 8e9b193be..8a66cc95d 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/driftModels/phaseChange/phaseChange.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/driftModels/phaseChange/phaseChange.C @@ -103,7 +103,7 @@ void Foam::diameterModels::driftModels::phaseChange::correct() { const sizeGroup& fi = *popBal_.sizeGroups()[i]; - N_ += fi*max(fi.phase(), SMALL)/fi.x(); + N_ += fi*max(fi.phase(), small)/fi.x(); } } diff --git a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C index 0b63146b7..210bf51b3 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C +++ b/applications/solvers/multiphase/reactingEulerFoam/phaseSystems/populationBalanceModel/nucleationModels/wallBoiling/wallBoiling.C @@ -178,7 +178,7 @@ nucleationRate forAll(alphatw, facei) { - if (dmdt[facei] > SMALL) + if (dmdt[facei] > small) { const label faceCelli = faceCells[facei]; diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C index da2b86516..e794c4703 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C @@ -405,7 +405,7 @@ void Foam::multiphaseSystem::correctContactAngle scalar uTheta = tp().uTheta(); // Calculate the dynamic contact angle if required - if (uTheta > SMALL) + if (uTheta > small) { scalar thetaA = convertToRad*tp().thetaA(matched); scalar thetaR = convertToRad*tp().thetaR(matched); @@ -425,7 +425,7 @@ void Foam::multiphaseSystem::correctContactAngle ); // Normalise nWall - nWall /= (mag(nWall) + SMALL); + nWall /= (mag(nWall) + small); // Calculate Uwall resolved normal to the interface parallel to // the interface diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H index d89c09f9d..8de77ec75 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H @@ -10,7 +10,7 @@ scalar maxDeltaT ( - pimpleDict.lookupOrDefault("maxDeltaT", GREAT) + pimpleDict.lookupOrDefault("maxDeltaT", great) ); scalar rDeltaTSmoothingCoeff diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H index 4cb3de01e..691114e52 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H @@ -10,7 +10,7 @@ scalar maxDeltaT ( - pimpleDict.lookupOrDefault("maxDeltaT", GREAT) + pimpleDict.lookupOrDefault("maxDeltaT", great) ); scalar rDeltaTSmoothingCoeff diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C index b9d9ec854..64a2a52c9 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C @@ -230,7 +230,7 @@ void Foam::JohnsonJacksonParticleSlipFvPatchVectorField::updateCoeffs() *gs0 *specularityCoefficient_.value() *sqrt(3*Theta) - /max(6*(nu - nuFric)*alphaMax.value(), SMALL) + /max(6*(nu - nuFric)*alphaMax.value(), small) ); this->valueFraction() = c/(c + patch().deltaCoeffs()); diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C index 7b14876fe..cda82519f 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C @@ -254,7 +254,7 @@ void Foam::JohnsonJacksonParticleThetaFvPatchScalarField::updateCoeffs() *gs0 *(scalar(1) - sqr(restitutionCoefficient_.value())) *sqrt(3*Theta) - /max(4*kappa*alphaMax.value(), SMALL) + /max(4*kappa*alphaMax.value(), small) ); this->valueFraction() = c/(c + patch().deltaCoeffs()); @@ -267,14 +267,14 @@ void Foam::JohnsonJacksonParticleThetaFvPatchScalarField::updateCoeffs() this->refValue() = 0.0; this->refGrad() = - pos0(alpha - SMALL) + pos0(alpha - small) *constant::mathematical::pi *specularityCoefficient_.value() *alpha *gs0 *sqrt(3*Theta) *magSqr(U) - /max(6*kappa*alphaMax.value(), SMALL); + /max(6*kappa*alphaMax.value(), small); this->valueFraction() = 0; } diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C index a869cc9c1..399e11d90 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C @@ -155,7 +155,7 @@ JohnsonJacksonSchaeffer::nu 0.5*pf[celli]*sin(phi_.value()) /( sqrt((1.0/3.0)*sqr(tr(D[celli])) - invariantII(D[celli])) - + SMALL + + small ); } } @@ -174,7 +174,7 @@ JohnsonJacksonSchaeffer::nu pf.boundaryField()[patchi]*sin(phi_.value()) /( mag(U.boundaryField()[patchi].snGrad()) - + SMALL + + small ) ); } diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C index eeabe622e..573059fa3 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -144,7 +144,7 @@ Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::nu 0.5*pf[celli]*sin(phi_.value()) /( sqrt((1.0/3.0)*sqr(tr(D[celli])) - invariantII(D[celli])) - + SMALL + + small ); } } @@ -163,7 +163,7 @@ Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::nu pf.boundaryField()[patchi]*sin(phi_.value()) /( mag(U.boundaryField()[patchi].snGrad()) - + SMALL + + small ) ); } diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C index 10739955e..8681b2cd6 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -88,7 +88,7 @@ Foam::diameterModels::IATEsources::randomCoalescence::R forAll(R, celli) { - if (alpha[celli] < alphaMax - SMALL) + if (alpha[celli] < alphaMax - small) { const scalar cbrtAlphaMaxMAlpha = cbrtAlphaMax - cbrt(alpha[celli]); diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/wallBoiling/wallBoiling.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/wallBoiling/wallBoiling.C index bac1c27b7..b93893305 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/wallBoiling/wallBoiling.C +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/wallBoiling/wallBoiling.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2016-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2016-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -124,7 +124,7 @@ Foam::diameterModels::IATEsources::wallBoiling::R forAll(alphatw, facei) { - if (dmdt[facei] > SMALL) + if (dmdt[facei] > small) { const label faceCelli = faceCells[facei]; R[faceCelli] = diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Lain/Lain.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Lain/Lain.C index e172ecd7b..9f4b3ecc0 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Lain/Lain.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/dragModels/Lain/Lain.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -67,7 +67,7 @@ Foam::tmp Foam::dragModels::Lain::CdRe() const return neg(Re - 1.5)*16.0 + pos0(Re - 1.5)*neg(Re - 80.0)*14.9*pow(Re, 0.22) - + pos0(Re - 80.0)*neg(Re - 1500.0)*48*(1.0 - 2.21/sqrt(max(Re, SMALL))) + + pos0(Re - 80.0)*neg(Re - 1500.0)*48*(1.0 - 2.21/sqrt(max(Re, small))) + pos0(Re - 1500.0)*2.61*Re; } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C index 9e248c8bd..a2daf9842 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/interfacialModels/virtualMassModels/Lamb/Lamb.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -67,7 +67,7 @@ Foam::virtualMassModels::Lamb::~Lamb() Foam::tmp Foam::virtualMassModels::Lamb::Cvm() const { - volScalarField E(min(max(pair_.E(), SMALL), 1 - SMALL)); + volScalarField E(min(max(pair_.E(), small), 1 - small)); volScalarField rtOmEsq(sqrt(1 - sqr(E))); return diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C index 651de2ea0..e2ba1dd58 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -230,7 +230,7 @@ void Foam::JohnsonJacksonParticleSlipFvPatchVectorField::updateCoeffs() *gs0 *specularityCoefficient_.value() *sqrt(3.0*Theta) - /max(6.0*(nu - nuFric)*alphaMax.value(), SMALL) + /max(6.0*(nu - nuFric)*alphaMax.value(), small) ); this->valueFraction() = c/(c + patch().deltaCoeffs()); diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C index 0fa9d5faf..4ff2faf52 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -254,7 +254,7 @@ void Foam::JohnsonJacksonParticleThetaFvPatchScalarField::updateCoeffs() *gs0 *(scalar(1) - sqr(restitutionCoefficient_.value())) *sqrt(3.0*Theta) - /max(4.0*kappa*alphaMax.value(), SMALL) + /max(4.0*kappa*alphaMax.value(), small) ); this->valueFraction() = c/(c + patch().deltaCoeffs()); @@ -267,14 +267,14 @@ void Foam::JohnsonJacksonParticleThetaFvPatchScalarField::updateCoeffs() this->refValue() = 0.0; this->refGrad() = - pos0(alpha - SMALL) + pos0(alpha - small) *constant::mathematical::pi *specularityCoefficient_.value() *alpha *gs0 *sqrt(3.0*Theta) *magSqr(U) - /max(6.0*kappa*alphaMax.value(), SMALL); + /max(6.0*kappa*alphaMax.value(), small); this->valueFraction() = 0.0; } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C index 67517beb0..748f289d1 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/JohnsonJacksonSchaeffer/JohnsonJacksonSchaefferFrictionalStress.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2016-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2016-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -155,7 +155,7 @@ JohnsonJacksonSchaeffer::nu 0.5*pf[celli]*sin(phi_.value()) /( sqrt((1.0/3.0)*sqr(tr(D[celli])) - invariantII(D[celli])) - + SMALL + + small ); } } @@ -174,7 +174,7 @@ JohnsonJacksonSchaeffer::nu pf.boundaryField()[patchi]*sin(phi_.value()) /( mag(U.boundaryField()[patchi].snGrad()) - + SMALL + + small ) ); } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C index eeabe622e..573059fa3 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/phaseCompressibleTurbulenceModels/kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -144,7 +144,7 @@ Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::nu 0.5*pf[celli]*sin(phi_.value()) /( sqrt((1.0/3.0)*sqr(tr(D[celli])) - invariantII(D[celli])) - + SMALL + + small ); } } @@ -163,7 +163,7 @@ Foam::kineticTheoryModels::frictionalStressModels::Schaeffer::nu pf.boundaryField()[patchi]*sin(phi_.value()) /( mag(U.boundaryField()[patchi].snGrad()) - + SMALL + + small ) ); } diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C index 428cfc314..8e18fcc0e 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2014-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2014-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -128,7 +128,7 @@ Foam::tmp Foam::blendingMethods::linear::f1 max ( (phase1 - maxFullAlpha) - /(maxPartAlpha - maxFullAlpha + SMALL), + /(maxPartAlpha - maxFullAlpha + small), scalar(0) ), scalar(1) @@ -153,7 +153,7 @@ Foam::tmp Foam::blendingMethods::linear::f2 max ( (maxPartAlpha - phase2) - /(maxPartAlpha - maxFullAlpha + SMALL), + /(maxPartAlpha - maxFullAlpha + small), scalar(0) ), scalar(1) diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C index 480937663..21ea1a5f5 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/diameterModels/IATE/IATEsources/randomCoalescence/randomCoalescence.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -89,7 +89,7 @@ Foam::diameterModels::IATEsources::randomCoalescence::R() const forAll(R, celli) { - if (alpha[celli] < alphaMax - SMALL) + if (alpha[celli] < alphaMax - small) { scalar cbrtAlphaMaxMAlpha = cbrtAlphaMax - cbrt(alpha[celli]); diff --git a/applications/solvers/stressAnalysis/solidEquilibriumDisplacementFoam/kineticEnergyLimiter.H b/applications/solvers/stressAnalysis/solidEquilibriumDisplacementFoam/kineticEnergyLimiter.H index 589566e3a..b1190f12a 100644 --- a/applications/solvers/stressAnalysis/solidEquilibriumDisplacementFoam/kineticEnergyLimiter.H +++ b/applications/solvers/stressAnalysis/solidEquilibriumDisplacementFoam/kineticEnergyLimiter.H @@ -8,10 +8,10 @@ if (!(runTime.timeIndex() % 5)) dimensionedScalar intKineticPower = fvc::domainIntegrate(kineticPower); Info<< "kineticPower = " << intKineticPower.value() << endl; - scalar smi = intKineticPower.value()/(intKineticEnergy.value() + VSMALL); + scalar smi = intKineticPower.value()/(intKineticEnergy.value() + vSmall); Info<< "smi = " << smi << endl; - if (smi < -SMALL) + if (smi < -small) { Info<< "Resetting Dcorr to 0" << endl; Dcorr == dimensionedVector("0", Dcorr.dimensions(), Zero); diff --git a/applications/test/PatchTools/Test-PatchTools.C b/applications/test/PatchTools/Test-PatchTools.C index 6300b86ab..0a56d1785 100644 --- a/applications/test/PatchTools/Test-PatchTools.C +++ b/applications/test/PatchTools/Test-PatchTools.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -189,7 +189,7 @@ using namespace Foam; // } // } // -// extrudeN /= mag(extrudeN)+VSMALL; +// extrudeN /= mag(extrudeN)+vSmall; // // return textrudeN; //} diff --git a/applications/test/Polynomial/Test-Polynomial.C b/applications/test/Polynomial/Test-Polynomial.C index 352d15f96..8525157ef 100644 --- a/applications/test/Polynomial/Test-Polynomial.C +++ b/applications/test/Polynomial/Test-Polynomial.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-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -164,12 +164,12 @@ int main(int argc, char *argv[]) Info<< " px, pxTest = " << px << ", " << pxTest << endl; Info<< " ipx, ipxTest = " << ipx << ", " << ipxTest << endl; - if (mag(px - pxTest) > SMALL) + if (mag(px - pxTest) > small) { Info<< " *** WARNING: px != pxTest: " << px - pxTest << endl; } - if (mag(ipx - ipxTest) > SMALL) + if (mag(ipx - ipxTest) > small) { Info<< " *** WARNING: ipx != ipxTest: " << ipx - ipxTest << endl; } diff --git a/applications/test/fieldMapping/Test-fieldMapping.C b/applications/test/fieldMapping/Test-fieldMapping.C index d0545b7bb..e6a5ec995 100644 --- a/applications/test/fieldMapping/Test-fieldMapping.C +++ b/applications/test/fieldMapping/Test-fieldMapping.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -150,7 +150,7 @@ int main(int argc, char *argv[]) const scalar totalVol = gSum(mesh.V()); // Face removal engine. No checking for not merging boundary faces. - removeFaces faceRemover(mesh, GREAT); + removeFaces faceRemover(mesh, great); while (runTime.loop()) diff --git a/applications/test/findSphereFeatureEdges-octree/Test-findSphereFeatureEdges-octree.C b/applications/test/findSphereFeatureEdges-octree/Test-findSphereFeatureEdges-octree.C index 0c2f95429..4d3240380 100644 --- a/applications/test/findSphereFeatureEdges-octree/Test-findSphereFeatureEdges-octree.C +++ b/applications/test/findSphereFeatureEdges-octree/Test-findSphereFeatureEdges-octree.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -66,8 +66,8 @@ int main(int argc, char *argv[]) efem.points() ); - bb.min() -= point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL); - bb.max() += point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL); + bb.min() -= point(rootVSmall, rootVSmall, rootVSmall); + bb.max() += point(rootVSmall, rootVSmall, rootVSmall); labelList allEdges(identity(efem.edges().size())); diff --git a/applications/test/quaternion/Test-quaternion.C b/applications/test/quaternion/Test-quaternion.C index c3acadf7c..d6e0745d6 100644 --- a/applications/test/quaternion/Test-quaternion.C +++ b/applications/test/quaternion/Test-quaternion.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -87,7 +87,7 @@ int main(int argc, char *argv[]) - quaternion(quaternion::rotationSequence(rs), angles) .eulerAngles(quaternion::rotationSequence(rs)) ) - > SMALL + > small ) { FatalErrorInFunction diff --git a/applications/test/router/router.C b/applications/test/router/router.C index 0b55495be..1eca91b66 100644 --- a/applications/test/router/router.C +++ b/applications/test/router/router.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -147,7 +147,7 @@ void Foam::router::fixWeights // to choose one. Here: smallest angle to vector end-start vector n(coords_[endNodeI] - coords_[startNodeI]); - scalar maxCosAngle = -GREAT; + scalar maxCosAngle = -great; forAll(myNeighbours, neighbourI) { @@ -159,7 +159,7 @@ void Foam::router::fixWeights scalar magN2 = mag(n2); - if (magN2 > SMALL) + if (magN2 > small) { n2 /= mag(n2); diff --git a/applications/test/syncTools/Test-syncTools.C b/applications/test/syncTools/Test-syncTools.C index a94ff5217..84990cf5e 100644 --- a/applications/test/syncTools/Test-syncTools.C +++ b/applications/test/syncTools/Test-syncTools.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -209,7 +209,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen) { // Create some data. Use slightly perturbed positions. Map sparseData; - pointField fullData(mesh.nPoints(), point(GREAT, GREAT, GREAT)); + pointField fullData(mesh.nPoints(), point(great, great, great)); forAll(localPoints, i) { @@ -235,7 +235,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen) mesh, fullData, minMagSqrEqOp(), - point(GREAT, GREAT, GREAT) + point(great, great, great) // true // apply separation ); @@ -245,7 +245,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen) { const point& fullPt = fullData[meshPointi]; - if (fullPt != point(GREAT, GREAT, GREAT)) + if (fullPt != point(great, great, great)) { const point& sparsePt = sparseData[meshPointi]; @@ -285,7 +285,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen) { // Create some data. Use slightly perturbed positions. EdgeMap sparseData; - pointField fullData(mesh.nEdges(), point(GREAT, GREAT, GREAT)); + pointField fullData(mesh.nEdges(), point(great, great, great)); const edgeList& edges = allBoundary.edges(); const labelList meshEdges = allBoundary.meshEdges @@ -319,7 +319,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen) mesh, fullData, minMagSqrEqOp(), - point(GREAT, GREAT, GREAT) + point(great, great, great) ); // Compare. @@ -328,7 +328,7 @@ void testSparseData(const polyMesh& mesh, Random& rndGen) { const point& fullPt = fullData[meshEdgeI]; - if (fullPt != point(GREAT, GREAT, GREAT)) + if (fullPt != point(great, great, great)) { const point& sparsePt = sparseData[mesh.edges()[meshEdgeI]]; @@ -384,12 +384,12 @@ void testPointSync(const polyMesh& mesh, Random& rndGen) mesh, syncedPoints, minMagSqrEqOp(), - point(GREAT, GREAT, GREAT) + point(great, great, great) ); forAll(syncedPoints, pointi) { - if (mag(syncedPoints[pointi] - mesh.points()[pointi]) > SMALL) + if (mag(syncedPoints[pointi] - mesh.points()[pointi]) > small) { FatalErrorInFunction << "Point " << pointi @@ -458,14 +458,14 @@ void testEdgeSync(const polyMesh& mesh, Random& rndGen) mesh, syncedMids, minMagSqrEqOp(), - point(GREAT, GREAT, GREAT) + point(great, great, great) ); forAll(syncedMids, edgeI) { point eMid = edges[edgeI].centre(mesh.points()); - if (mag(syncedMids[edgeI] - eMid) > SMALL) + if (mag(syncedMids[edgeI] - eMid) > small) { FatalErrorInFunction << "Edge " << edgeI @@ -534,7 +534,7 @@ void testFaceSync(const polyMesh& mesh, Random& rndGen) forAll(syncedFc, facei) { - if (mag(syncedFc[facei] - mesh.faceCentres()[facei]) > SMALL) + if (mag(syncedFc[facei] - mesh.faceCentres()[facei]) > small) { FatalErrorInFunction << "Face " << facei diff --git a/applications/test/tetTetOverlap/Test-tetTetOverlap.C b/applications/test/tetTetOverlap/Test-tetTetOverlap.C index b85db9c68..2a19a8dc3 100644 --- a/applications/test/tetTetOverlap/Test-tetTetOverlap.C +++ b/applications/test/tetTetOverlap/Test-tetTetOverlap.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -171,7 +171,7 @@ int main(int argc, char *argv[]) Info<< "Sum inside and outside: " << volIn + volOut << endl; - if (mag(volIn + volOut - makeTetPointRef(tetA).mag()) > SMALL) + if (mag(volIn + volOut - makeTetPointRef(tetA).mag()) > small) { FatalErrorInFunction << "Tet volumes do not sum up to input tet." diff --git a/applications/test/vectorTools/Test-vectorTools.C b/applications/test/vectorTools/Test-vectorTools.C index 85d18ed98..2d7a4aa2b 100644 --- a/applications/test/vectorTools/Test-vectorTools.C +++ b/applications/test/vectorTools/Test-vectorTools.C @@ -35,8 +35,8 @@ int main() vector b(2.0, 2.0, 2.0); test(a, b, 0.0); - test(a, b, VSMALL); - test(a, b, SMALL); + test(a, b, vSmall); + test(a, b, small); test(a, b, 1e-3); test(a, b, 1e-1); @@ -44,8 +44,8 @@ int main() b = vector(0,2,0); test(a, b, 0.0); - test(a, b, VSMALL); - test(a, b, SMALL); + test(a, b, vSmall); + test(a, b, small); test(a, b, 1e-3); test(a, b, 1e-1); @@ -53,8 +53,8 @@ int main() b = vector(-1,0,0); test(a, b, 0.0); - test(a, b, VSMALL); - test(a, b, SMALL); + test(a, b, vSmall); + test(a, b, small); test(a, b, 1e-3); test(a, b, 1e-1); @@ -62,8 +62,8 @@ int main() b = vector(-1,2,0); test(a, b, 0.0); - test(a, b, VSMALL); - test(a, b, SMALL); + test(a, b, vSmall); + test(a, b, small); test(a, b, 1e-3); test(a, b, 1e-1); diff --git a/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C b/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C index d1b5e9cde..da50cd732 100644 --- a/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C +++ b/applications/utilities/mesh/advanced/autoRefineMesh/autoRefineMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -108,20 +108,20 @@ scalar getEdgeStats(const primitiveMesh& mesh, const direction excludeCmpt) label nY = 0; label nZ = 0; - scalar minX = GREAT; - scalar maxX = -GREAT; + scalar minX = great; + scalar maxX = -great; vector x(1, 0, 0); - scalar minY = GREAT; - scalar maxY = -GREAT; + scalar minY = great; + scalar maxY = -great; vector y(0, 1, 0); - scalar minZ = GREAT; - scalar maxZ = -GREAT; + scalar minZ = great; + scalar maxZ = -great; vector z(0, 0, 1); - scalar minOther = GREAT; - scalar maxOther = -GREAT; + scalar minOther = great; + scalar maxOther = -great; const edgeList& edges = mesh.edges(); diff --git a/applications/utilities/mesh/advanced/combinePatchFaces/combinePatchFaces.C b/applications/utilities/mesh/advanced/combinePatchFaces/combinePatchFaces.C index 9854ec2fe..60d56d01e 100644 --- a/applications/utilities/mesh/advanced/combinePatchFaces/combinePatchFaces.C +++ b/applications/utilities/mesh/advanced/combinePatchFaces/combinePatchFaces.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -135,7 +135,7 @@ label mergePatchFaces } else { - mesh.checkFacePyramids(false, -SMALL, &errorFaces); + mesh.checkFacePyramids(false, -small, &errorFaces); } // Sets where the master is in error diff --git a/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C b/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C index 00240beb1..5736725de 100644 --- a/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C +++ b/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -72,10 +72,10 @@ label findPoint(const primitivePatch& pp, const point& nearPoint) const labelList& meshPoints = pp.meshPoints(); // Find nearest and next nearest - scalar minDistSqr = GREAT; + scalar minDistSqr = great; label minI = -1; - scalar almostMinDistSqr = GREAT; + scalar almostMinDistSqr = great; label almostMinI = -1; forAll(meshPoints, i) @@ -136,10 +136,10 @@ label findEdge const edgeList& edges = pp.edges(); // Find nearest and next nearest - scalar minDist = GREAT; + scalar minDist = great; label minI = -1; - scalar almostMinDist = GREAT; + scalar almostMinDist = great; label almostMinI = -1; forAll(edges, edgeI) @@ -218,10 +218,10 @@ label findFace const pointField& points = pp.points(); // Find nearest and next nearest - scalar minDist = GREAT; + scalar minDist = great; label minI = -1; - scalar almostMinDist = GREAT; + scalar almostMinDist = great; label almostMinI = -1; forAll(pp, patchFacei) @@ -289,7 +289,7 @@ label findCell(const primitiveMesh& mesh, const point& nearPoint) const labelList& cPoints = mesh.cellPoints()[celli]; label minI = -1; - scalar minDistSqr = GREAT; + scalar minDistSqr = great; forAll(cPoints, i) { diff --git a/applications/utilities/mesh/advanced/selectCells/edgeStats.C b/applications/utilities/mesh/advanced/selectCells/edgeStats.C index bf56a995e..6904f4635 100644 --- a/applications/utilities/mesh/advanced/selectCells/edgeStats.C +++ b/applications/utilities/mesh/advanced/selectCells/edgeStats.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -127,20 +127,20 @@ Foam::scalar Foam::edgeStats::minLen(Ostream& os) const label nY = 0; label nZ = 0; - scalar minX = GREAT; - scalar maxX = -GREAT; + scalar minX = great; + scalar maxX = -great; vector x(1, 0, 0); - scalar minY = GREAT; - scalar maxY = -GREAT; + scalar minY = great; + scalar maxY = -great; vector y(0, 1, 0); - scalar minZ = GREAT; - scalar maxZ = -GREAT; + scalar minZ = great; + scalar maxZ = -great; vector z(0, 0, 1); - scalar minOther = GREAT; - scalar maxOther = -GREAT; + scalar minOther = great; + scalar maxOther = -great; const edgeList& edges = mesh_.edges(); diff --git a/applications/utilities/mesh/advanced/splitCells/splitCells.C b/applications/utilities/mesh/advanced/splitCells/splitCells.C index 5bb9f63d5..794060b30 100644 --- a/applications/utilities/mesh/advanced/splitCells/splitCells.C +++ b/applications/utilities/mesh/advanced/splitCells/splitCells.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -133,7 +133,7 @@ bool largerAngle // which quadrant angle is. (Is correct for unwarped faces only!) // Correct for non-outwards pointing normal. vector c1c0(mesh.faceCentres()[f1] - mesh.faceCentres()[f0]); - c1c0 /= mag(c1c0) + VSMALL; + c1c0 /= mag(c1c0) + vSmall; scalar fcCosAngle = n0 & c1c0; @@ -282,10 +282,10 @@ bool splitHex loop[3] = ev.vertToEVert(e[1]); scalarField loopWeights(4); - loopWeights[0] = -GREAT; - loopWeights[1] = -GREAT; - loopWeights[2] = -GREAT; - loopWeights[3] = -GREAT; + loopWeights[0] = -great; + loopWeights[1] = -great; + loopWeights[2] = -great; + loopWeights[3] = -great; cutCells.append(celli); cellLoops.append(loop); @@ -393,7 +393,7 @@ void collectCuts // Cut information per mesh entity boolList vertIsCut(mesh.nPoints(), false); boolList edgeIsCut(mesh.nEdges(), false); - scalarField edgeWeight(mesh.nEdges(), -GREAT); + scalarField edgeWeight(mesh.nEdges(), -great); forAllConstIter(cellSet, cellsToCut, iter) { diff --git a/applications/utilities/mesh/conversion/cfx4ToFoam/cfx4ToFoam.C b/applications/utilities/mesh/conversion/cfx4ToFoam/cfx4ToFoam.C index c243107be..d62a81e34 100644 --- a/applications/utilities/mesh/conversion/cfx4ToFoam/cfx4ToFoam.C +++ b/applications/utilities/mesh/conversion/cfx4ToFoam/cfx4ToFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -247,7 +247,7 @@ int main(int argc, char *argv[]) // N^2 algorithm, sorry but I cannot quickly come up with // something better. - scalar sqrMergeTol = GREAT; + scalar sqrMergeTol = great; forAll(blockPFaces, blockPFaceLabel) { @@ -533,7 +533,7 @@ int main(int argc, char *argv[]) } // Scale the points - if (scaleFactor > 1.0 + SMALL || scaleFactor < 1.0 - SMALL) + if (scaleFactor > 1.0 + small || scaleFactor < 1.0 - small) { points *= scaleFactor; } diff --git a/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C b/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C index 813d683f8..456d024df 100644 --- a/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C +++ b/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -1251,7 +1251,7 @@ int main(int argc, char *argv[]) if (own[j] == c1) { const face& f = boundaryFaces[old]; - if (mag(centers[j]- f.centre(points)) < SMALL) + if (mag(centers[j]- f.centre(points)) < small) { noveau = j; break; diff --git a/applications/utilities/mesh/conversion/kivaToFoam/checkPatch.H b/applications/utilities/mesh/conversion/kivaToFoam/checkPatch.H index 6e9eaae38..0c05587c9 100644 --- a/applications/utilities/mesh/conversion/kivaToFoam/checkPatch.H +++ b/applications/utilities/mesh/conversion/kivaToFoam/checkPatch.H @@ -39,10 +39,10 @@ if ( - mag(points[quadFace[0]].y()) < SMALL - && mag(points[quadFace[1]].y()) < SMALL - && mag(points[quadFace[2]].y()) < SMALL - && mag(points[quadFace[3]].y()) < SMALL + mag(points[quadFace[0]].y()) < small + && mag(points[quadFace[1]].y()) < small + && mag(points[quadFace[2]].y()) < small + && mag(points[quadFace[3]].y()) < small ) { bcIndex = SYMMETRYPLANE; diff --git a/applications/utilities/mesh/conversion/kivaToFoam/kivaToFoam.C b/applications/utilities/mesh/conversion/kivaToFoam/kivaToFoam.C index 99d522f74..673fae016 100644 --- a/applications/utilities/mesh/conversion/kivaToFoam/kivaToFoam.C +++ b/applications/utilities/mesh/conversion/kivaToFoam/kivaToFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -107,7 +107,7 @@ int main(int argc, char *argv[]) } } - scalar zHeadMin = -GREAT; + scalar zHeadMin = -great; args.optionReadIfPresent("zHeadMin", zHeadMin); #include "readKivaGrid.H" diff --git a/applications/utilities/mesh/conversion/kivaToFoam/readKivaGrid.H b/applications/utilities/mesh/conversion/kivaToFoam/readKivaGrid.H index 994f0c57a..a0151838a 100644 --- a/applications/utilities/mesh/conversion/kivaToFoam/readKivaGrid.H +++ b/applications/utilities/mesh/conversion/kivaToFoam/readKivaGrid.H @@ -134,7 +134,7 @@ for (label i=0; i, pFaces[CYLINDERHEAD][0], iter) { @@ -337,7 +337,7 @@ if } } - minz += SMALL; + minz += small; SLList newLinerFaces; @@ -345,7 +345,7 @@ if { const face& pf = iter(); - scalar minfz = GREAT; + scalar minfz = great; forAll(pf, pfi) { minfz = min(minfz, points[pf[pfi]].z()); @@ -374,7 +374,7 @@ if { const face& pf = iter(); - scalar minfz = GREAT; + scalar minfz = great; forAll(pf, pfi) { minfz = min(minfz, points[pf[pfi]].z()); diff --git a/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C b/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C index 15f7edb53..d7b774662 100644 --- a/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C +++ b/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -55,7 +55,7 @@ void hexBlock::setHandedness() vector y = p[vtxLabel(i, j+1, k)] - p[vtxLabel(i, j, k)]; vector z = p[vtxLabel(i, j, k+1)] - p[vtxLabel(i, j, k)]; - if (mag(x) > SMALL && mag(y) > SMALL && mag(z) > SMALL) + if (mag(x) > small && mag(y) > small && mag(z) > small) { Info<< "Looking at cell " << i << ' ' << j << ' ' << k diff --git a/applications/utilities/mesh/conversion/plot3dToFoam/plot3dToFoam.C b/applications/utilities/mesh/conversion/plot3dToFoam/plot3dToFoam.C index 0b451189e..976da074f 100644 --- a/applications/utilities/mesh/conversion/plot3dToFoam/plot3dToFoam.C +++ b/applications/utilities/mesh/conversion/plot3dToFoam/plot3dToFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -179,18 +179,18 @@ int main(int argc, char *argv[]) mergePoints ( points, - SMALL, + small, false, oldToNew, newPoints ); - Info<< "Merged points within " << SMALL << " distance. Merged from " + Info<< "Merged points within " << small << " distance. Merged from " << oldToNew.size() << " down to " << newPoints.size() << " points." << endl; // Scale the points - if (scaleFactor > 1.0 + SMALL || scaleFactor < 1.0 - SMALL) + if (scaleFactor > 1.0 + small || scaleFactor < 1.0 - small) { newPoints *= scaleFactor; } diff --git a/applications/utilities/mesh/conversion/star3ToFoam/createCoupleMatches.C b/applications/utilities/mesh/conversion/star3ToFoam/createCoupleMatches.C index cfb77ef05..38bb73d4b 100644 --- a/applications/utilities/mesh/conversion/star3ToFoam/createCoupleMatches.C +++ b/applications/utilities/mesh/conversion/star3ToFoam/createCoupleMatches.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -89,7 +89,7 @@ void Foam::starMesh::createCoupleMatches() mag ( -(masterFace.normal(points_) & slaveFace.normal(points_))/ - (masterFace.mag(points_)*slaveFace.mag(points_) + VSMALL) + (masterFace.mag(points_)*slaveFace.mag(points_) + vSmall) ); if (faceAreaAngle < 0.94) @@ -163,7 +163,7 @@ void Foam::starMesh::createCoupleMatches() // Find common plane vector n = masterFace.normal(points_); - n /= mag(n) + VSMALL; + n /= mag(n) + vSmall; // Loop through all edges of the master face. For every edge, // intersect it with all edges of the cutting face. @@ -202,7 +202,7 @@ void Foam::starMesh::createCoupleMatches() << "e: " << e << endl; #endif - if (mag(det) > SMALL) + if (mag(det) > small) { // non-singular matrix. Look for intersection scalar beta = ((S - P) & (n ^ d))/det; @@ -345,7 +345,7 @@ void Foam::starMesh::createCoupleMatches() bool colinear = false; - if (mag(ps) < SMALL) + if (mag(ps) < small) { // colinear because P and S are the same point colinear = true; @@ -548,7 +548,7 @@ void Foam::starMesh::createCoupleMatches() { label nextPointLabel = -1; label usedI = -1; - scalar minAlpha = GREAT; + scalar minAlpha = great; label i = 0; @@ -742,7 +742,7 @@ void Foam::starMesh::createCoupleMatches() { label nextPointLabel = -1; label usedI = -1; - scalar minAlpha = GREAT; + scalar minAlpha = great; label i = 0; @@ -1000,7 +1000,7 @@ void Foam::starMesh::createCoupleMatches() // and exit. vector planeNormal = newMasterFace.normal(points_); - planeNormal /= mag(planeNormal) + VSMALL; + planeNormal /= mag(planeNormal) + vSmall; #ifdef DEBUG_RIGHT_HAND_WALK Info<< "planeNormal: " << planeNormal << endl; @@ -1117,17 +1117,17 @@ void Foam::starMesh::createCoupleMatches() // vector along the edge vector ahead = curEdge.vec(points_); ahead -= planeNormal*(planeNormal & ahead); - ahead /= mag(ahead) + VSMALL; + ahead /= mag(ahead) + vSmall; // vector pointing right vector right = ahead ^ planeNormal; - right /= mag(right) + VSMALL; + right /= mag(right) + vSmall; // first edge taken for reference edge nextEdge = edgesToConsider.first(); vector nextEdgeVec = nextEdge.vec(points_); nextEdgeVec -= planeNormal*(planeNormal & nextEdgeVec); - nextEdgeVec /= mag(nextEdgeVec) + VSMALL; + nextEdgeVec /= mag(nextEdgeVec) + vSmall; scalar rightTurn = nextEdgeVec & right; scalar goStraight = nextEdgeVec & ahead; @@ -1148,7 +1148,7 @@ void Foam::starMesh::createCoupleMatches() // right-hand walk rule vector newDir = etcIter().vec(points_); newDir -= planeNormal*(planeNormal & newDir); - newDir /= mag(newDir) + VSMALL; + newDir /= mag(newDir) + vSmall; scalar curRightTurn = newDir & right; scalar curGoStraight = newDir & ahead; @@ -1345,7 +1345,7 @@ void Foam::starMesh::createCoupleMatches() ( masterFace.normal(points_) & intersectedFace.normal(points_) - ) < VSMALL + ) < vSmall ) { intersectedFace.flip(); diff --git a/applications/utilities/mesh/conversion/star3ToFoam/mergeCoupleFacePoints.C b/applications/utilities/mesh/conversion/star3ToFoam/mergeCoupleFacePoints.C index 7addc9c68..258e272d0 100644 --- a/applications/utilities/mesh/conversion/star3ToFoam/mergeCoupleFacePoints.C +++ b/applications/utilities/mesh/conversion/star3ToFoam/mergeCoupleFacePoints.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -71,7 +71,7 @@ void Foam::starMesh::mergeCoupleFacePoints() label nPointsInCell = 0; - scalar pointMergeTol = GREAT; + scalar pointMergeTol = great; forAll(curFaces, facei) { diff --git a/applications/utilities/mesh/conversion/star3ToFoam/readPoints.C b/applications/utilities/mesh/conversion/star3ToFoam/readPoints.C index 3965e6e94..e35bbf86e 100644 --- a/applications/utilities/mesh/conversion/star3ToFoam/readPoints.C +++ b/applications/utilities/mesh/conversion/star3ToFoam/readPoints.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -153,7 +153,7 @@ void Foam::starMesh::readPoints(const scalar scaleFactor) starPointLabelLookup_[pointLabel] = p; } - if (scaleFactor > 1.0 + SMALL || scaleFactor < 1.0 - SMALL) + if (scaleFactor > 1.0 + small || scaleFactor < 1.0 - small) { points_ *= scaleFactor; } diff --git a/applications/utilities/mesh/conversion/star3ToFoam/readSeparatedPoints.C b/applications/utilities/mesh/conversion/star3ToFoam/readSeparatedPoints.C index 73782190c..2dd0f7c4e 100644 --- a/applications/utilities/mesh/conversion/star3ToFoam/readSeparatedPoints.C +++ b/applications/utilities/mesh/conversion/star3ToFoam/readSeparatedPoints.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -97,7 +97,7 @@ void Foam::starMesh::readPoints(const scalar scaleFactor) starPointLabelLookup_[pointLabel] = p; } - if (scaleFactor > 1.0 + SMALL || scaleFactor < 1.0 - SMALL) + if (scaleFactor > 1.0 + small || scaleFactor < 1.0 - small) { points_ *= scaleFactor; } diff --git a/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C b/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C index ad8b944d0..21e9ea6d9 100644 --- a/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C +++ b/applications/utilities/mesh/generation/extrude/extrudeMesh/extrudeMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -605,7 +605,7 @@ int main(int argc, char *argv[]) // Check if wedge (has layer0 different from original patch points) // If so move the mesh to starting position. - if (gMax(mag(layer0Points-extrudePatch.localPoints())) > SMALL) + if (gMax(mag(layer0Points-extrudePatch.localPoints())) > small) { Info<< "Moving mesh to layer0 points since differ from original" << " points - this can happen for wedge extrusions." << nl diff --git a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C index 7a6ae09e3..3f6f874ed 100644 --- a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C +++ b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -54,7 +54,7 @@ void Foam::extrude2DMesh::check2D() const //void Foam::extrude2DMesh::findExtrudeDirection() //{ -// scalar minRange = GREAT; +// scalar minRange = great; // for (direction dir = 0; dir < 3; dir++) // { diff --git a/applications/utilities/mesh/generation/foamyMesh/cellSizeAndAlignmentGrid/cellSizeAndAlignmentGrid.C b/applications/utilities/mesh/generation/foamyMesh/cellSizeAndAlignmentGrid/cellSizeAndAlignmentGrid.C index 8a21d3bab..f131f64aa 100644 --- a/applications/utilities/mesh/generation/foamyMesh/cellSizeAndAlignmentGrid/cellSizeAndAlignmentGrid.C +++ b/applications/utilities/mesh/generation/foamyMesh/cellSizeAndAlignmentGrid/cellSizeAndAlignmentGrid.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -186,7 +186,7 @@ Foam::tmp buildPointField(const T& mesh) { tmp tPoints ( - new pointField(mesh.vertexCount(), point(GREAT, GREAT, GREAT)) + new pointField(mesh.vertexCount(), point(great, great, great)) ); pointField& points = tPoints.ref(); @@ -543,7 +543,7 @@ int main(int argc, char *argv[]) scalar dist = mag(points[pI] - points[adjPointIndex]); -// dist = max(dist, SMALL); +// dist = max(dist, small); triad tmpTriad = alignments[adjPointIndex]; diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C index 70bbb2e4b..9ccc2de49 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/DelaunayMesh/DelaunayMeshIO.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -136,7 +136,7 @@ void Foam::DelaunayMesh::printInfo(Ostream& os) const triInfoTable.add("Faces", Triangulation::number_of_finite_facets()); triInfoTable.add("Cells", Triangulation::number_of_finite_cells()); - scalar minSize = GREAT; + scalar minSize = great; scalar maxSize = 0; for diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C index 88c31a0f7..2952a9ef3 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -565,14 +565,14 @@ bool Foam::backgroundMeshDecomposition::refineCell // geometry.findSurfaceNearest // ( // samplePoints, -// scalarField(samplePoints.size(), sqr(GREAT)), +// scalarField(samplePoints.size(), sqr(great)), // hitInfo, // hitSurfaces // ); // // // weightEstimate = 0.0; // -// scalar minCellSize = GREAT; +// scalar minCellSize = great; // // forAll(samplePoints, i) // { @@ -717,8 +717,8 @@ void Foam::backgroundMeshDecomposition::buildPatchAndTree() Pstream::gatherList(allBackgroundMeshBounds_); Pstream::scatterList(allBackgroundMeshBounds_); - point bbMin(GREAT, GREAT, GREAT); - point bbMax(-GREAT, -GREAT, -GREAT); + point bbMin(great, great, great); + point bbMax(-great, -great, -great); forAll(allBackgroundMeshBounds_, proci) { @@ -882,7 +882,7 @@ Foam::backgroundMeshDecomposition::distribute forAll(icellWeights, cI) { - if (icellWeights[cI] > 1 - SMALL) + if (icellWeights[cI] > 1 - small) { nOccupiedCells++; } @@ -1122,7 +1122,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::processorNearestPosition { // Candidate points may lie just outside a processor box, increase // test range by using overlaps rather than contains - if (allBackgroundMeshBounds_[proci].overlaps(pt, sqr(SMALL*100))) + if (allBackgroundMeshBounds_[proci].overlaps(pt, sqr(small*100))) { toCandidateProc.append(proci); testPoints.append(pt); @@ -1144,7 +1144,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::processorNearestPosition map().distribute(testPoints); - List distanceSqrToCandidate(testPoints.size(), sqr(GREAT)); + List distanceSqrToCandidate(testPoints.size(), sqr(great)); // Test candidate points on candidate processors forAll(testPoints, tPI) @@ -1152,7 +1152,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::processorNearestPosition pointIndexHit info = bFTreePtr_().findNearest ( testPoints[tPI], - sqr(GREAT) + sqr(great) ); if (info.hit()) @@ -1183,7 +1183,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::processorNearestPosition ptBlockStart[pI] ); - scalar nearestProcDistSqr = GREAT; + scalar nearestProcDistSqr = great; forAll(ptNearestProcResults, pPRI) { diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellAspectRatioControl/cellAspectRatioControl.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellAspectRatioControl/cellAspectRatioControl.C index 191ddf53a..c71354cd0 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellAspectRatioControl/cellAspectRatioControl.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellAspectRatioControl/cellAspectRatioControl.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -45,7 +45,7 @@ Foam::cellAspectRatioControl::cellAspectRatioControl ) { // Normalise the direction - aspectRatioDirection_ /= mag(aspectRatioDirection_) + SMALL; + aspectRatioDirection_ /= mag(aspectRatioDirection_) + small; Info<< nl << "Cell Aspect Ratio Control" << nl diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControl/cellShapeControl.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControl/cellShapeControl.C index f84e010d0..aa57e2360 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControl/cellShapeControl.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControl/cellShapeControl.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -210,7 +210,7 @@ Foam::tensor Foam::cellShapeControl::cellAlignment(const point& pt) const for (label pI = 0; pI < 4; ++pI) { - if (bary[pI] > SMALL) + if (bary[pI] > small) { tri += triad(bary[pI]*ch->vertex(pI)->alignment()); } @@ -288,7 +288,7 @@ void Foam::cellShapeControl::cellSizeAndAlignment { size += bary[pI]*ch->vertex(pI)->targetCellSize(); - if (bary[pI] > SMALL) + if (bary[pI] > small) { tri += triad(bary[pI]*ch->vertex(pI)->alignment()); } @@ -318,7 +318,7 @@ void Foam::cellShapeControl::cellSizeAndAlignment { // Force orthogonalization of triad. - scalar dotProd = GREAT; + scalar dotProd = great; if (dir == 0) { dotProd = v[1] & v[2]; diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControlMesh/cellShapeControlMesh.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControlMesh/cellShapeControlMesh.C index 35734e40c..cb9d3a1ce 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControlMesh/cellShapeControlMesh.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControlMesh/cellShapeControlMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -58,7 +58,7 @@ word cellShapeControlMesh::meshSubDir = "cellShapeControlMesh"; // geometryToConformTo.findSurfaceNearest // ( // pt, -// sqr(GREAT), +// sqr(great), // surfHit, // hitSurface // ); @@ -92,7 +92,7 @@ word cellShapeControlMesh::meshSubDir = "cellShapeControlMesh"; // // const label s = 36;//foamyHexMeshControls().alignmentSearchSpokes(); // -// scalar closestSpokeHitDistance = GREAT; +// scalar closestSpokeHitDistance = great; // // pointIndexHit closestSpokeHit; // @@ -194,7 +194,7 @@ word cellShapeControlMesh::meshSubDir = "cellShapeControlMesh"; // // Secondary alignment // vector ns = np ^ na; // -// if (mag(ns) < SMALL) +// if (mag(ns) < small) // { // FatalErrorInFunction // << "Parallel normals detected in spoke search." << nl @@ -781,7 +781,7 @@ Foam::label Foam::cellShapeControlMesh::estimateCellCount averagedPointCellSize /= 4; //averagedPointCellSize = ::sqrt(averagedPointCellSize); -// if (averagedPointCellSize < SMALL) +// if (averagedPointCellSize < small) // { // Pout<< "Volume = " << volume << endl; // diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/searchableSurfaceControl/searchableSurfaceControl.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/searchableSurfaceControl/searchableSurfaceControl.C index c0782e3a3..3d9ac0fb7 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/searchableSurfaceControl/searchableSurfaceControl.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/searchableSurfaceControl/searchableSurfaceControl.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -62,7 +62,7 @@ addToRunTimeSelectionTable //// geometryToConformTo_.findSurfaceNearest //// ( //// pt, -//// sqr(GREAT), +//// sqr(great), //// surfHit, //// hitSurface //// ); @@ -102,7 +102,7 @@ addToRunTimeSelectionTable // // vector na = Zero; // -// scalar smallestAngle = GREAT; +// scalar smallestAngle = great; // // for (label pnI = 1; pnI < ptNormals.size(); ++pnI) // { @@ -120,7 +120,7 @@ addToRunTimeSelectionTable // // Secondary alignment // vector ns = np ^ na; // -// if (mag(ns) < SMALL) +// if (mag(ns) < small) // { // WarningInFunction // << "Parallel normals detected in spoke search." << nl @@ -367,7 +367,7 @@ void Foam::searchableSurfaceControl::initialVertices infoFeature ); - scalar limitedCellSize = GREAT; + scalar limitedCellSize = great; autoPtr pointAlignment; @@ -426,7 +426,7 @@ void Foam::searchableSurfaceControl::initialVertices vectorField normals(1); searchableSurface_.getNormal(infoList, normals); - if (mag(normals[0]) < SMALL) + if (mag(normals[0]) < small) { normals[0] = vector(1, 1, 1); } diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/controlMeshRefinement/controlMeshRefinement.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/controlMeshRefinement/controlMeshRefinement.C index 79e153146..0177db130 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/controlMeshRefinement/controlMeshRefinement.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/controlMeshRefinement/controlMeshRefinement.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -334,7 +334,7 @@ void Foam::controlMeshRefinement::initialMeshPopulation keep = decomposition().positionOnThisProcessor(pt); } - if (keep && geometryToConformTo_.wellOutside(pt, SMALL)) + if (keep && geometryToConformTo_.wellOutside(pt, small)) { keep = false; } @@ -509,7 +509,7 @@ void Foam::controlMeshRefinement::initialMeshPopulation keep = decomposition().positionOnThisProcessor(pt); } - if (keep && geometryToConformTo_.wellOutside(pt, SMALL)) + if (keep && geometryToConformTo_.wellOutside(pt, small)) { keep = false; } diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/smoothAlignmentSolver/smoothAlignmentSolver.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/smoothAlignmentSolver/smoothAlignmentSolver.C index e975f6d4f..d811d0074 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/smoothAlignmentSolver/smoothAlignmentSolver.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/smoothAlignmentSolver/smoothAlignmentSolver.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -209,7 +209,7 @@ Foam::tmp Foam::smoothAlignmentSolver::buildPointField { tmp tPoints ( - new pointField(mesh.vertexCount(), point(GREAT, GREAT, GREAT)) + new pointField(mesh.vertexCount(), point(great, great, great)) ); pointField& points = tPoints.ref(); @@ -376,7 +376,7 @@ void Foam::smoothAlignmentSolver::smoothAlignments { if (tmpTriad.set(dir)) { - tmpTriad[dir] *= 1.0/(dist + SMALL); + tmpTriad[dir] *= 1.0/(dist + small); } } diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/cellSizeFunction/uniform/uniform.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/cellSizeFunction/uniform/uniform.C index 32c67a618..e9e6f517b 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/cellSizeFunction/uniform/uniform.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/cellSizeFunction/uniform/uniform.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -86,7 +86,7 @@ bool uniform::cellSize surface_.findNearest ( pointField(1, pt), - scalarField(1, sqr(GREAT)), + scalarField(1, sqr(great)), regionIndices_, hits ); @@ -179,7 +179,7 @@ bool uniform::setCellSize // surface_.findNearest // ( // pointField(1, pt), -// scalarField(1, sqr(GREAT)), +// scalarField(1, sqr(great)), // hits // ); // diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/surfaceCellSizeFunction/cellSizeCalculationType/automatic/automatic.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/surfaceCellSizeFunction/cellSizeCalculationType/automatic/automatic.C index dae322af5..e884aa523 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/surfaceCellSizeFunction/cellSizeCalculationType/automatic/automatic.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellSizeControlSurfaces/surfaceCellSizeFunction/cellSizeCalculationType/automatic/automatic.C @@ -69,9 +69,9 @@ void Foam::automatic::smoothField(triSurfaceScalarField& surf) const scalar faceValue = surf[faceLabel]; const scalar distance = mag(faceCentre - fC); - newValue += faceValue/(distance + SMALL); + newValue += faceValue/(distance + small); - totalDist += 1.0/(distance + SMALL); + totalDist += 1.0/(distance + small); if (value < faceValue) { diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C index d94dc425a..eb732e6be 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -160,7 +160,7 @@ void Foam::conformalVoronoiMesh::insertInternalPoints Info<< " " << nInserted << " points inserted" << ", failed to insert " << nPoints - nInserted << " (" - << 100.0*(nPoints - nInserted)/(nInserted + SMALL) + << 100.0*(nPoints - nInserted)/(nInserted + small) << " %)"<< endl; for @@ -1155,7 +1155,7 @@ void Foam::conformalVoronoiMesh::move() scalar rABMag = mag(rAB); - if (rABMag < SMALL) + if (rABMag < small) { // Removal of close points diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C index 152957e7b..72d7831f8 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshCalcDualMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -479,7 +479,7 @@ Foam::label Foam::conformalVoronoiMesh::mergeIdenticalDualVertices //// geometryToConformTo_.findSurfaceNearest //// ( //// pt, -//// sqr(GREAT), +//// sqr(great), //// surfHit, //// hitSurface //// ); @@ -643,7 +643,7 @@ Foam::label Foam::conformalVoronoiMesh::mergeIdenticalDualVertices // scalar targetFaceSize = averageAnyCellSize(vA, vB); // // // Selecting faces to collapse based on angle to -// // surface, so set collapseSizeLimitCoeff to GREAT to +// // surface, so set collapseSizeLimitCoeff to great to // // allow collapse of all faces // // faceCollapseMode mode = collapseFace @@ -653,7 +653,7 @@ Foam::label Foam::conformalVoronoiMesh::mergeIdenticalDualVertices // boundaryPts, // dualPtIndexMap, // targetFaceSize, -// GREAT, +// great, // maxFC // ); // @@ -844,7 +844,7 @@ void Foam::conformalVoronoiMesh::checkCellSizing() label nWrongFaces = 0; - if (maxNonOrtho < 180.0 - SMALL) + if (maxNonOrtho < 180.0 - small) { polyMeshGeometry::checkFaceDotProduct ( @@ -1011,7 +1011,7 @@ Foam::labelHashSet Foam::conformalVoronoiMesh::checkPolyMeshQuality const vectorField& fAreas = pMesh.faceAreas(); - scalar faceAreaLimit = SMALL; + scalar faceAreaLimit = small; forAll(fAreas, fI) { @@ -1443,7 +1443,7 @@ void Foam::conformalVoronoiMesh::indexDualVertices // ); // // vector snapDir = nearestPointOnTet - dual; -// snapDir /= mag(snapDir) + SMALL; +// snapDir /= mag(snapDir) + small; // // drawDelaunayCell(tetToSnapTo, cit, offset); // offset += 1; @@ -1454,7 +1454,7 @@ void Foam::conformalVoronoiMesh::indexDualVertices // List(1, hitInfo), // norm // ); -// norm[0] /= mag(norm[0]) + SMALL; +// norm[0] /= mag(norm[0]) + small; // // if // ( @@ -1868,7 +1868,7 @@ void Foam::conformalVoronoiMesh::createFacesOwnerNeighbourAndPatches vector fN = f.normal(pts); - if (mag(fN) < SMALL) + if (mag(fN) < small) { nextCell = vc2; continue; diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshConformToSurface.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshConformToSurface.C index 9567b8886..2948547f3 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshConformToSurface.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshConformToSurface.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -1981,8 +1981,8 @@ void Foam::conformalVoronoiMesh::buildEdgeLocationTree geometryToConformTo_.globalBounds().extend(rndGen_, 1e-4) ); - overallBb.min() -= Foam::point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL); - overallBb.max() += Foam::point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL); + overallBb.min() -= Foam::point(rootVSmall, rootVSmall, rootVSmall); + overallBb.max() += Foam::point(rootVSmall, rootVSmall, rootVSmall); edgeLocationTreePtr_.reset ( @@ -2008,8 +2008,8 @@ void Foam::conformalVoronoiMesh::buildSurfacePtLocationTree geometryToConformTo_.globalBounds().extend(rndGen_, 1e-4) ); - overallBb.min() -= Foam::point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL); - overallBb.max() += Foam::point(ROOTVSMALL, ROOTVSMALL, ROOTVSMALL); + overallBb.min() -= Foam::point(rootVSmall, rootVSmall, rootVSmall); + overallBb.max() += Foam::point(rootVSmall, rootVSmall, rootVSmall); surfacePtLocationTreePtr_.reset ( diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshFeaturePoints.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshFeaturePoints.C index d886d195c..3eeeb4a18 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshFeaturePoints.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshFeaturePoints.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -221,12 +221,12 @@ void Foam::conformalVoronoiMesh::createEdgePointGroupByCirculating // Calculate master point vector masterPtVec(normalDir + nextNormalDir); - masterPtVec /= mag(masterPtVec) + SMALL; + masterPtVec /= mag(masterPtVec) + small; if ( - ((normalDir ^ nextNormalDir) & edDir) < SMALL - || mag(masterPtVec) < SMALL + ((normalDir ^ nextNormalDir) & edDir) < small + || mag(masterPtVec) < small ) { // Info<< " IGNORE REGION" << endl; @@ -235,7 +235,7 @@ void Foam::conformalVoronoiMesh::createEdgePointGroupByCirculating if ( circ.size() == 2 - && mag((normal & nextNormal) - 1) < SMALL + && mag((normal & nextNormal) - 1) < small ) { const vector n = 0.5*(normal + nextNormal); @@ -278,7 +278,7 @@ void Foam::conformalVoronoiMesh::createEdgePointGroupByCirculating ); // Specialise for size = 1 && baffle - if (mag((normalDir & nextNormalDir) - 1) < SMALL) + if (mag((normalDir & nextNormalDir) - 1) < small) { if (inside) { diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshZones.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshZones.C index 99f287129..5a1512f7f 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshZones.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMeshZones.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -482,7 +482,7 @@ void Foam::conformalVoronoiMesh::calcFaceZones ); vector fN = faces[facei].normal(mesh.points()); - fN /= mag(fN) + SMALL; + fN /= mag(fN) + small; if ((norm[0] & fN) < 0) { diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformationSurfaces/conformationSurfaces.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformationSurfaces/conformationSurfaces.C index be5f1cadf..59438c71b 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformationSurfaces/conformationSurfaces.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformationSurfaces/conformationSurfaces.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -120,8 +120,8 @@ void Foam::conformationSurfaces::hasBoundedVolume Info<< " Sum of all the surface normals (if near zero, surface is" << " probably closed):" << nl << " Note: Does not include baffle surfaces in calculation" << nl - << " Sum = " << sum/(totalTriangles + SMALL) << nl - << " mag(Sum) = " << mag(sum)/(totalTriangles + SMALL) + << " Sum = " << sum/(totalTriangles + small) << nl + << " mag(Sum) = " << mag(sum)/(totalTriangles + small) << endl; } @@ -738,13 +738,13 @@ Foam::Field Foam::conformationSurfaces::wellInOutSide ) { pointField sample(1, samplePts[i]); - scalarField nearestDistSqr(1, GREAT); + scalarField nearestDistSqr(1, great); List info; surface.findNearest(sample, nearestDistSqr, info); vector hitDir = info[0].rawPoint() - samplePts[i]; - hitDir /= mag(hitDir) + SMALL; + hitDir /= mag(hitDir) + small; pointIndexHit surfHit; label hitSurface; @@ -1264,7 +1264,7 @@ Foam::label Foam::conformationSurfaces::findPatch(const point& pt) const pointIndexHit surfHit; label hitSurface; - findSurfaceNearest(pt, sqr(GREAT), surfHit, hitSurface); + findSurfaceNearest(pt, sqr(great), surfHit, hitSurface); return getPatchID(hitSurface, surfHit); } diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/initialPointsMethod/autoDensity/autoDensity.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/initialPointsMethod/autoDensity/autoDensity.C index e2d100150..c41a8568e 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/initialPointsMethod/autoDensity/autoDensity.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/initialPointsMethod/autoDensity/autoDensity.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -301,9 +301,9 @@ bool Foam::autoDensity::fillBox label initialSize = initialPoints.size(); - scalar maxCellSize = -GREAT; + scalar maxCellSize = -great; - scalar minCellSize = GREAT; + scalar minCellSize = great; scalar maxDensity = 1/pow3(minCellSize); @@ -639,7 +639,7 @@ bool Foam::autoDensity::fillBox // randomly shuffled, but unfiormly sampling space and have wellInside // and size data already - maxDensity = 1/pow3(max(minCellSize, SMALL)); + maxDensity = 1/pow3(max(minCellSize, small)); forAll(insidePoints, i) { @@ -723,7 +723,7 @@ bool Foam::autoDensity::fillBox << endl; } - maxDensity = 1/pow3(max(minCellSize, SMALL)); + maxDensity = 1/pow3(max(minCellSize, small)); while (true) { @@ -760,7 +760,7 @@ bool Foam::autoDensity::fillBox // 1/(minimum cell size)^3, gives the maximum permissible // point density - maxDensity = 1/pow3(max(minCellSize, SMALL)); + maxDensity = 1/pow3(max(minCellSize, small)); } if (maxCellSize/minCellSize > maxSizeRatio_) @@ -781,7 +781,7 @@ bool Foam::autoDensity::fillBox return false; } - scalar localDensity = 1/pow3(max(localSize, SMALL)); + scalar localDensity = 1/pow3(max(localSize, small)); // Accept possible placements proportional to the relative local // density diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/relaxationModel/rampHoldFall/rampHoldFall.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/relaxationModel/rampHoldFall/rampHoldFall.C index 4baf53cff..0e1d2cb22 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/relaxationModel/rampHoldFall/rampHoldFall.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/relaxationModel/rampHoldFall/rampHoldFall.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -68,7 +68,7 @@ scalar rampHoldFall::relaxation() scalar tEnd = runTime_.time().endTime().value(); scalar tSpan = tEnd - tStart; - if (tSpan < VSMALL) + if (tSpan < vSmall) { return rampStartRelaxation_; } diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchableBoxFeatures.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchableBoxFeatures.C index 16a18de19..5545fb6d6 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchableBoxFeatures.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchableBoxFeatures.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -125,8 +125,8 @@ Foam::searchableBoxFeatures::features() const normalDirections[eI][j] = ( ( - (cross/(mag(cross) + VSMALL)) - & (fC0tofE0/(mag(fC0tofE0)+ VSMALL)) + (cross/(mag(cross) + vSmall)) + & (fC0tofE0/(mag(fC0tofE0)+ vSmall)) ) > 0.0 ? 1 diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchablePlateFeatures.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchablePlateFeatures.C index 039d41a39..f0a960bb3 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchablePlateFeatures.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/searchableSurfaceFeatures/searchablePlateFeatures.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2013-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -143,8 +143,8 @@ Foam::searchablePlateFeatures::features() const normalDirections[eI][j] = ( ( - (cross/(mag(cross) + VSMALL)) - & (fC0tofE0/(mag(fC0tofE0)+ VSMALL)) + (cross/(mag(cross) + vSmall)) + & (fC0tofE0/(mag(fC0tofE0)+ vSmall)) ) > 0.0 ? 1 diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/vectorTools/vectorTools.H b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/vectorTools/vectorTools.H index a4593e2eb..9fb2400e2 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/vectorTools/vectorTools.H +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/vectorTools/vectorTools.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -55,7 +55,7 @@ namespace vectorTools ( const Vector& a, const Vector& b, - const T& tolerance = SMALL + const T& tolerance = small ) { return (mag(a ^ b) < tolerance) ? true : false; @@ -72,7 +72,7 @@ namespace vectorTools ( const Vector& a, const Vector& b, - const T& tolerance = SMALL + const T& tolerance = small ) { return (mag(a & b) < tolerance) ? true : false; @@ -106,7 +106,7 @@ namespace vectorTools ( const Vector& a, const Vector& b, - const T& tolerance = SMALL + const T& tolerance = small ) { scalar cosPhi = (a & b)/(mag(a)*mag(b) + tolerance); @@ -121,7 +121,7 @@ namespace vectorTools ( const Vector& a, const Vector& b, - const T& tolerance = SMALL + const T& tolerance = small ) { scalar cosPhi = (a & b)/(mag(a)*mag(b) + tolerance); @@ -136,7 +136,7 @@ namespace vectorTools ( const Vector& a, const Vector& b, - const T& tolerance = SMALL + const T& tolerance = small ) { return radToDeg(radAngleBetween(a, b, tolerance)); diff --git a/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshBackgroundMesh/foamyHexMeshBackgroundMesh.C b/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshBackgroundMesh/foamyHexMeshBackgroundMesh.C index 78cad8c31..9330575c6 100644 --- a/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshBackgroundMesh/foamyHexMeshBackgroundMesh.C +++ b/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshBackgroundMesh/foamyHexMeshBackgroundMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -310,7 +310,7 @@ tmp signedDistance const labelList& surfaces ) { - tmp tfld(new scalarField(points.size(), Foam::sqr(GREAT))); + tmp tfld(new scalarField(points.size(), Foam::sqr(great))); scalarField& fld = tfld.ref(); // Find nearest @@ -321,7 +321,7 @@ tmp signedDistance geometry, surfaces, points, - scalarField(points.size(), Foam::sqr(GREAT)),//distSqr + scalarField(points.size(), Foam::sqr(great)),//distSqr nearestSurfaces, nearest ); @@ -682,7 +682,7 @@ int main(int argc, char *argv[]) dimensionedScalar("zero", dimLength, 0) ); { - scalarField pointDistSqr(fvm.nPoints(), -sqr(GREAT)); + scalarField pointDistSqr(fvm.nPoints(), -sqr(great)); for (label facei = 0; facei < fvm.nInternalFaces(); facei++) { label own = fvm.faceOwner()[facei]; @@ -699,7 +699,7 @@ int main(int argc, char *argv[]) fvm, pointDistSqr, maxEqOp(), - -sqr(GREAT) // null value + -sqr(great) // null value ); pointDistance.primitiveFieldRef() = signedDistance diff --git a/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify.C b/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify.C index ca9d18953..e5933f5e2 100644 --- a/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify.C +++ b/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -111,7 +111,7 @@ class distanceCalc geometry, surfaces, samples, - scalarField(1, GREAT), + scalarField(1, great), volumeType::OUTSIDE, nearestSurfaces, distance @@ -201,7 +201,7 @@ public: ////- Surface intersects bb (but not using intersection test) //scalar ccDist = signedDistance(bb.midpoint()); //scalar ccVal = ccDist - _iso_val; - //if (mag(ccVal) < SMALL) + //if (mag(ccVal) < small) //{ // return true; //} @@ -323,7 +323,7 @@ public: //samples[6] = point(c.xmax(), c.ymax(), c.zmax()); //samples[7] = point(c.xmin(), c.ymax(), c.zmax()); - //scalarField nearestDistSqr(8, GREAT); + //scalarField nearestDistSqr(8, great); // //Foam::List nearestInfo; //surf_.findNearest(samples, nearestDistSqr, nearestInfo); @@ -568,7 +568,7 @@ int main(int argc, char *argv[]) geometryToConformTo.findSurfaceNearest ( s.faceCentres(), - scalarField(s.size(), sqr(GREAT)), + scalarField(s.size(), sqr(great)), hitInfo, hitSurfaces ); diff --git a/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify_non_octree.C b/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify_non_octree.C index d26bd0eaa..3b80ee3b0 100644 --- a/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify_non_octree.C +++ b/applications/utilities/mesh/generation/foamyMesh/foamyHexMeshSurfaceSimplify/foamyHexMeshSurfaceSimplify_non_octree.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -173,7 +173,7 @@ int main(int argc, char *argv[]) geometry, surfaces, points, - scalarField(points.size(), sqr(GREAT)), + scalarField(points.size(), sqr(great)), searchableSurface::OUTSIDE, // for non-closed surfaces treat as // outside nearestSurfaces, @@ -280,7 +280,7 @@ int main(int argc, char *argv[]) geometryToConformTo.findSurfaceNearest ( s.faceCentres(), - scalarField(s.size(), sqr(GREAT)), + scalarField(s.size(), sqr(great)), hitInfo, hitSurfaces ); diff --git a/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C b/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C index fbd1f2ccf..8fb4b43e0 100644 --- a/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C +++ b/applications/utilities/mesh/generation/snappyHexMesh/snappyHexMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -321,7 +321,7 @@ autoPtr createRefinementSurfaces minLevel, maxLevel, gapLevel, - scalarField(nRegions, -GREAT), //perpendicularAngle, + scalarField(nRegions, -great), //perpendicularAngle, patchInfo ) ); diff --git a/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C b/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C index 9b058128e..6b4e17d74 100644 --- a/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C +++ b/applications/utilities/mesh/manipulation/checkMesh/checkGeometry.C @@ -143,7 +143,7 @@ bool Foam::checkWedges const point& pt = p[pp.meshPoints()[i]]; scalar d = mag((pt - p0) & pp.n()); - if (d > ROOTSMALL) + if (d > rootSmall) { if (report) { @@ -176,7 +176,7 @@ bool Foam::checkWedges vector d(p[p1]-p[p0]); scalar magD = mag(d); - if (magD > ROOTVSMALL) + if (magD > rootVSmall) { d /= magD; @@ -666,7 +666,7 @@ Foam::label Foam::checkGeometry { faceSet faces(mesh, "wrongOrientedFaces", mesh.nFaces()/100 + 1); - if (mesh.checkFacePyramids(true, -SMALL, &faces)) + if (mesh.checkFacePyramids(true, -small, &faces)) { noFailedChecks++; diff --git a/applications/utilities/mesh/manipulation/createPatch/createPatch.C b/applications/utilities/mesh/manipulation/createPatch/createPatch.C index 0270ea607..dfd5417d1 100644 --- a/applications/utilities/mesh/manipulation/createPatch/createPatch.C +++ b/applications/utilities/mesh/manipulation/createPatch/createPatch.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -864,7 +864,7 @@ int main(int argc, char *argv[]) mesh, newPoints, minMagSqrEqOp(), - point(GREAT, GREAT, GREAT) + point(great, great, great) ); scalarField diff(mag(newPoints-mesh.points())); diff --git a/applications/utilities/mesh/manipulation/polyDualMesh/polyDualMesh.C b/applications/utilities/mesh/manipulation/polyDualMesh/polyDualMesh.C index 90c6fc1e7..78af4c17c 100644 --- a/applications/utilities/mesh/manipulation/polyDualMesh/polyDualMesh.C +++ b/applications/utilities/mesh/manipulation/polyDualMesh/polyDualMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -197,7 +197,7 @@ void simpleMarkFeatures - allBoundary[f0].centre(allBoundary.points()) ); - if (concaveMultiCells && (c1c0 & n0) > SMALL) + if (concaveMultiCells && (c1c0 & n0) > small) { // Found concave edge. Make into multiCell features Info<< "Detected concave feature edge:" << edgeI diff --git a/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C b/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C index 7f6fc57a1..efbdf8fde 100644 --- a/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C +++ b/applications/utilities/mesh/manipulation/refineMesh/refineMesh.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -61,20 +61,20 @@ void printEdgeStats(const polyMesh& mesh) label nY = 0; label nZ = 0; - scalar minX = GREAT; - scalar maxX = -GREAT; + scalar minX = great; + scalar maxX = -great; static const vector x(1, 0, 0); - scalar minY = GREAT; - scalar maxY = -GREAT; + scalar minY = great; + scalar maxY = -great; static const vector y(0, 1, 0); - scalar minZ = GREAT; - scalar maxZ = -GREAT; + scalar minZ = great; + scalar maxZ = -great; static const vector z(0, 0, 1); - scalar minOther = GREAT; - scalar maxOther = -GREAT; + scalar minOther = great; + scalar maxOther = -great; PackedBoolList isMasterEdge(syncTools::getMasterEdges(mesh)); diff --git a/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.C b/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.C index 9be4935d3..7c005d22b 100644 --- a/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.C +++ b/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -600,7 +600,7 @@ double* Foam::vtkPVFoam::findTimes(int& nTimeSteps) // skip "0/" time if requested and possible if (nTimes > 1 && reader_->GetSkipZeroTime()) { - if (mag(timeLst[timeI].value()) < SMALL) + if (mag(timeLst[timeI].value()) < small) { ++timeI; --nTimes; diff --git a/applications/utilities/postProcessing/noise/noise.C b/applications/utilities/postProcessing/noise/noise.C index 4f45c42fa..c27da7f8f 100644 --- a/applications/utilities/postProcessing/noise/noise.C +++ b/applications/utilities/postProcessing/noise/noise.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::scalar checkUniformTimeStep(const scalarField& t) deltaT = dT; } - if (mag(deltaT - dT) > SMALL) + if (mag(deltaT - dT) > small) { FatalErrorInFunction << "Unable to process data with a variable time step" diff --git a/applications/utilities/preProcessing/applyBoundaryLayer/applyBoundaryLayer.C b/applications/utilities/preProcessing/applyBoundaryLayer/applyBoundaryLayer.C index 026feb77d..d417f10e4 100644 --- a/applications/utilities/preProcessing/applyBoundaryLayer/applyBoundaryLayer.C +++ b/applications/utilities/preProcessing/applyBoundaryLayer/applyBoundaryLayer.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -190,7 +190,7 @@ int main(int argc, char *argv[]) if (omegaHeader.typeHeaderOk(true)) { volScalarField omega(omegaHeader, mesh); - dimensionedScalar k0("VSMALL", k.dimensions(), VSMALL); + dimensionedScalar k0("vSmall", k.dimensions(), vSmall); omega = (1 - mask)*omega + mask*epsilon/(Cmu*k + k0); // Do not correct BC - wall functions will use non-updated k from diff --git a/applications/utilities/preProcessing/engineSwirl/createFields.H b/applications/utilities/preProcessing/engineSwirl/createFields.H index a77933c8f..7537487fc 100644 --- a/applications/utilities/preProcessing/engineSwirl/createFields.H +++ b/applications/utilities/preProcessing/engineSwirl/createFields.H @@ -67,7 +67,7 @@ vector xT = vector ); // if swirl is around (1, 0, 0) we have to find another transformation -if (mag(yT) < SMALL) +if (mag(yT) < small) { yT = vector(zT.y(), -zT.x(), 0); xT = vector(-zT.x()*zT.z(), -zT.y()*zT.z(), zT.x()*zT.x() + zT.y()*zT.y()); diff --git a/applications/utilities/preProcessing/engineSwirl/engineSwirl.C b/applications/utilities/preProcessing/engineSwirl/engineSwirl.C index 43e86814c..3c921e930 100644 --- a/applications/utilities/preProcessing/engineSwirl/engineSwirl.C +++ b/applications/utilities/preProcessing/engineSwirl/engineSwirl.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -62,7 +62,7 @@ int main(int argc, char *argv[]) { scalar b = j1(swirlProfile*r/cylinderRadius).value(); scalar vEff = omega*b; - r = max(r, SMALL); + r = max(r, small); U[celli] = ((vEff/r)*(c & yT))*xT + (-(vEff/r)*(c & xT))*yT; Umax = max(Umax, mag(U[celli])); } diff --git a/applications/utilities/preProcessing/setWaves/setWaves.C b/applications/utilities/preProcessing/setWaves/setWaves.C index d7221bfa0..d58d79d37 100644 --- a/applications/utilities/preProcessing/setWaves/setWaves.C +++ b/applications/utilities/preProcessing/setWaves/setWaves.C @@ -285,7 +285,7 @@ int main(int argc, char *argv[]) 1 /( wallDist(mesh, labelList(1, patchi)).y() - + dimensionedScalar("ySmall", dimLength, SMALL) + + dimensionedScalar("ySmall", dimLength, small) ) ); diff --git a/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H b/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H index 6c41655c1..3711aff9b 100644 --- a/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H +++ b/applications/utilities/preProcessing/viewFactorsGen/searchingEngine.H @@ -21,7 +21,7 @@ dict.add distributedTriSurfaceMesh::FROZEN ] ); -dict.add("mergeDistance", SMALL); +dict.add("mergeDistance", small); labelHashSet includePatches; forAll(patches, patchi) diff --git a/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C b/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C index d318bd738..0bfbdf1c6 100644 --- a/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C +++ b/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -196,7 +196,7 @@ scalar calculateViewFactorFij vector r = i - j; scalar rMag = mag(r); - if (rMag > SMALL) + if (rMag > small) { scalar dAiMag = mag(dAi); scalar dAjMag = mag(dAj); @@ -434,7 +434,7 @@ int main(int argc, char *argv[]) ) = upp.localPoints(); point cfo = cf; - scalar dist = GREAT; + scalar dist = great; forAll(availablePoints, iPoint) { point cfFine = availablePoints[iPoint]; diff --git a/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/SpaldingsLaw/SpaldingsLaw.C b/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/SpaldingsLaw/SpaldingsLaw.C index bf5143bd6..79ab67807 100644 --- a/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/SpaldingsLaw/SpaldingsLaw.C +++ b/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/SpaldingsLaw/SpaldingsLaw.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -76,7 +76,7 @@ void Foam::tabulatedWallFunctions::SpaldingsLaw::invertFunction() // Newton iterations to determine u+ label iter = 0; - scalar error = GREAT; + scalar error = great; do { scalar kUPlus = min(kappa_*uPlus, 50); @@ -97,7 +97,7 @@ void Foam::tabulatedWallFunctions::SpaldingsLaw::invertFunction() - 1 )/E_; - scalar uPlusNew = uPlus - f/(df + ROOTVSMALL); + scalar uPlusNew = uPlus - f/(df + rootVSmall); error = mag((uPlus - uPlusNew)/uPlusNew); uPlus = uPlusNew; } while (error > tolerance_ && ++iter < maxIters_); diff --git a/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/general/general.C b/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/general/general.C index 7857569be..45f173e2c 100644 --- a/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/general/general.C +++ b/applications/utilities/preProcessing/wallFunctionTable/tabulatedWallFunction/general/general.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -71,7 +71,7 @@ void Foam::tabulatedWallFunctions::general::invertTable() Rey[i] = yPlus_[i]*uPlus_[i]; if (invertedTable_.log10()) { - Rey[i] = ::log10(max(ROOTVSMALL, Rey[i])); + Rey[i] = ::log10(max(rootVSmall, Rey[i])); } } diff --git a/applications/utilities/surface/surfaceCheck/surfaceCheck.C b/applications/utilities/surface/surfaceCheck/surfaceCheck.C index acdd407c2..ea06f8644 100644 --- a/applications/utilities/surface/surfaceCheck/surfaceCheck.C +++ b/applications/utilities/surface/surfaceCheck/surfaceCheck.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -132,11 +132,11 @@ labelList countBins label index = -1; - if (Foam::mag(val - min) < SMALL) + if (Foam::mag(val - min) < small) { index = 0; } - else if (val >= max - SMALL) + else if (val >= max - small) { index = nBins - 1; } @@ -366,7 +366,7 @@ int main(int argc, char *argv[]) << endl; - if (triQ[minIndex] < SMALL) + if (triQ[minIndex] < small) { WarningInFunction << triQ[minIndex] << ". This might give problems in" diff --git a/applications/utilities/surface/surfaceClean/collapseBase.C b/applications/utilities/surface/surfaceClean/collapseBase.C index 17152e6a9..897b36a04 100644 --- a/applications/utilities/surface/surfaceClean/collapseBase.C +++ b/applications/utilities/surface/surfaceClean/collapseBase.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -226,7 +226,7 @@ static bool insertSorted { scalar w = sortedWeights[sortedI]; - if (mag(w - weight) < SMALL) + if (mag(w - weight) < small) { WarningInFunction << "Trying to insert weight " << weight << " which is close to" @@ -585,7 +585,7 @@ static labelPair getSpanPoints { const pointField& localPoints = surf.localPoints(); - scalar maxDist = -GREAT; + scalar maxDist = -great; labelPair maxPair; forAll(outsideVerts, i) diff --git a/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractCloseness.C b/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractCloseness.C index 1c6fb0521..584d2271e 100644 --- a/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractCloseness.C +++ b/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractCloseness.C @@ -67,8 +67,8 @@ void Foam::extractCloseness // Find all intersections (in order) searchSurf.findLineAll(start, end, allHitinfo); - scalarField internalCloseness(start.size(), GREAT); - scalarField externalCloseness(start.size(), GREAT); + scalarField internalCloseness(start.size(), great); + scalarField externalCloseness(start.size(), great); forAll(allHitinfo, fi) { diff --git a/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractPointCloseness.C b/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractPointCloseness.C index a0b2bde71..1d7509b2d 100644 --- a/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractPointCloseness.C +++ b/applications/utilities/surface/surfaceFeatureExtract/surfaceExtractPointCloseness.C @@ -209,8 +209,8 @@ void Foam::extractPointCloseness // Find all intersections (in order) searchSurf.findLineAll(start, end, allHitinfo); - scalarField internalCloseness(points.size(), GREAT); - scalarField externalCloseness(points.size(), GREAT); + scalarField internalCloseness(points.size(), great); + scalarField externalCloseness(points.size(), great); i = 0; forAll(points, pi) diff --git a/applications/utilities/surface/surfaceFeatureExtract/surfaceFeatureExtract.C b/applications/utilities/surface/surfaceFeatureExtract/surfaceFeatureExtract.C index f435f3c7c..9faac49f5 100644 --- a/applications/utilities/surface/surfaceFeatureExtract/surfaceFeatureExtract.C +++ b/applications/utilities/surface/surfaceFeatureExtract/surfaceFeatureExtract.C @@ -197,7 +197,7 @@ int main(int argc, char *argv[]) dictionary trimDict = surfaceDict.subDict("trimFeatures"); scalar minLen = - trimDict.lookupOrAddDefault("minLen", -GREAT); + trimDict.lookupOrAddDefault("minLen", -great); label minElem = trimDict.lookupOrAddDefault