From 1d85fecf4d0e0963ff2bab3c44c9df0959515a0a Mon Sep 17 00:00:00 2001 From: Mark Olesen Date: Tue, 11 Dec 2018 23:50:15 +0100 Subject: [PATCH] ENH: use Zero when zero-initializing types - makes the intent clearer and avoids the need for additional constructor casting. Eg, labelList(10, Zero) vs. labelList(10, 0) scalarField(10, Zero) vs. scalarField(10, scalar(0)) vectorField(10, Zero) vs. vectorField(10, vector::zero) --- .../chemFoam/readInitialConditions.H | 4 +- .../T/smoluchowskiJumpTFvPatchScalarField.C | 2 +- .../BCs/U/maxwellSlipUFvPatchVectorField.C | 2 +- .../fluid/createFluidFields.H | 2 +- .../fluid/createFluidFields.H | 2 +- .../fluid/initContinuityErrs.H | 2 +- .../overPimpleDyMFoam/interpolatedFaces.H | 9 ++-- .../VoFPatchTransfer/VoFPatchTransfer.C | 4 +- .../laserDTRM/DTRMParticle/DTRMParticleIO.C | 4 +- .../noReflection/noReflection.C | 2 +- .../interCondensatingEvaporatingFoam/eEqn.H | 2 +- ...ixedMultiPhaseHeatFluxFvPatchScalarField.C | 8 ++-- .../tractionDisplacementFvPatchVectorField.C | 2 +- ...DisplacementCorrectionFvPatchVectorField.C | 2 +- .../CompactListList/Test-CompactListList.C | 2 +- .../test/PatchFunction1/Test-PatchFunction1.C | 2 +- applications/test/parallel/Test-parallel.C | 2 +- applications/test/syncTools/Test-syncTools.C | 6 +-- .../mesh/advanced/modifyMesh/modifyMesh.C | 2 +- .../refinementLevel/refinementLevel.C | 2 +- .../snappyRefineMesh/snappyRefineMesh.C | 2 +- .../mesh/conversion/ansysToFoam/ansysToFoam.L | 2 +- .../fluentMeshToFoam/fluentMeshToFoam.L | 2 +- .../extrude/extrudeMesh/extrudeMesh.C | 2 +- .../extrudedMesh/extrudedMeshTemplates.C | 2 +- .../extrudeToRegionMesh/extrudeToRegionMesh.C | 6 +-- .../extrude2DMesh/extrude2DMeshApp.C | 2 +- .../DelaunayMesh/DistributedDelaunayMesh.C | 2 +- .../PrintTable/PrintTable.C | 2 +- .../backgroundMeshDecomposition.C | 8 ++-- .../conformalVoronoiMeshCalcDualMesh.C | 2 +- .../conformalVoronoiMeshFeaturePoints.C | 2 +- .../conformalVoronoiMeshIO.C | 8 ++-- .../conformalVoronoiMeshTemplates.C | 2 +- .../conformationSurfaces.C | 8 ++-- .../autoDensity/autoDensity.C | 2 +- .../searchableBoxFeatures.C | 2 +- .../searchablePlateFeatures.C | 2 +- .../generation/snappyHexMesh/snappyHexMesh.C | 10 ++-- .../manipulation/checkMesh/checkTopology.C | 2 +- .../createBaffles/createBaffles.C | 2 +- .../mergeOrSplitBaffles/mergeOrSplitBaffles.C | 2 +- .../manipulation/mirrorMesh/mirrorFvMesh.C | 2 +- .../orientFaceZone/orientFaceZone.C | 2 +- .../manipulation/renumberMesh/renumberMesh.C | 4 +- .../splitMeshRegions/splitMeshRegions.C | 6 +-- .../decomposePar/domainDecompositionMesh.C | 2 +- .../domainDecompositionTemplates.C | 2 +- .../decomposePar/faMeshDecomposition.C | 4 +- .../redistributePar/redistributePar.C | 2 +- .../graphics/PVReaders/vtkPVFoam/vtkPVFoam.C | 4 +- .../particleTracks/particleTracks.C | 2 +- .../steadyParticleTracks.C | 4 +- .../miscellaneous/pdfPlot/createFields.H | 2 +- .../viewFactorsGen/viewFactorsGen.C | 4 +- .../tabulatedWallFunction/general/general.C | 2 +- .../surfaceBooleanFeatures.C | 2 +- .../surface/surfaceCheck/surfaceCheck.C | 8 ++-- .../surface/surfaceInflate/surfaceInflate.C | 8 ++-- src/ODE/ODESolvers/SIBS/SIBS.C | 20 ++++---- .../Lists/Distribution/Distribution.C | 2 +- .../containers/Lists/ListOps/ListOps.C | 2 +- .../Lists/ListOps/ListOpsTemplates.C | 2 +- .../Lists/SortableList/SortableList.C | 7 +++ .../Lists/SortableList/SortableList.H | 6 ++- .../decomposedBlockData/decomposedBlockData.C | 2 +- src/OpenFOAM/db/IOstreams/Pstreams/UPstream.C | 4 +- src/OpenFOAM/db/IOstreams/Pstreams/exchange.C | 4 +- .../geometricZeroField/geometricZeroField.H | 10 +++- src/OpenFOAM/graph/curve/curve.C | 2 +- .../uniformInterpolationTable.C | 4 +- .../lduMatrix/lduAddressing/lduAddressing.C | 6 +-- .../matrices/lduMatrix/lduMatrix/lduMatrix.C | 12 ++--- .../lduMatrix/lduMatrix/lduMatrixATmul.C | 2 +- .../GAMGAgglomerateLduAddressing.C | 8 +++- .../pairGAMGAgglomerate.C | 2 +- .../masterCoarsestGAMGProcAgglomeration.C | 2 +- .../procFacesGAMGProcAgglomeration.C | 2 +- .../GAMG/GAMGSolverAgglomerateMatrix.C | 4 +- .../interfaces/GAMGInterface/GAMGInterface.C | 2 +- .../matrices/scalarMatrices/scalarMatrices.C | 4 +- .../scalarMatrices/scalarMatricesTemplates.C | 2 +- .../meshes/ProcessorTopology/commSchedule.C | 2 +- .../meshes/bandCompression/bandCompression.C | 2 +- .../meshes/lduMesh/lduPrimitiveMesh.C | 4 +- .../cellMatcher/degenerateMatcher.C | 6 +-- .../meshShapes/cellMatcher/hexMatcher.C | 8 ++-- .../meshShapes/cellMatcher/prismMatcher.C | 8 ++-- .../meshShapes/cellMatcher/pyrMatcher.C | 8 ++-- .../meshShapes/cellMatcher/tetMatcher.C | 8 ++-- .../meshShapes/cellMatcher/tetWedgeMatcher.C | 8 ++-- .../meshShapes/cellMatcher/wedgeMatcher.C | 8 ++-- .../pointMesh/pointMeshMapper/pointMapper.C | 6 +-- .../pointMeshMapper/pointPatchMapper.C | 6 +-- .../polyMesh/globalMeshData/globalMeshData.C | 2 +- .../mapPolyMesh/cellMapper/cellMapper.C | 4 +- .../mapPolyMesh/faceMapper/faceMapper.C | 4 +- .../mapPolyMesh/mapDistribute/mapDistribute.C | 4 +- .../mapDistribute/mapDistributeBase.C | 8 ++-- .../polyMeshTetDecomposition.C | 2 +- .../primitiveMesh/primitiveMeshCellCells.C | 2 +- .../primitiveMeshCellCentresAndVols.C | 6 +-- .../meshes/primitiveMesh/primitiveMeshCells.C | 2 +- .../primitiveMeshCheck/primitiveMeshCheck.C | 2 +- .../primitiveMesh/primitiveMeshPointCells.C | 2 +- .../functions/Function1/Table/TableBase.C | 2 +- .../functions/Polynomial/polynomialFunction.C | 2 +- .../globalIndexAndTransform.C | 2 +- .../globalIndexAndTransformI.H | 4 +- .../ThermalDiffusivity/ThermalDiffusivity.C | 2 +- ...allHeatFluxTemperatureFvPatchScalarField.C | 2 +- ...fixedIncidentRadiationFvPatchScalarField.C | 2 +- ...tletMachNumberPressureFvPatchScalarField.C | 6 +-- .../thermalBaffle1DFvPatchScalarField.C | 6 +-- ...tureCoupledBaffleMixedFvPatchScalarField.C | 4 +- ...eratureRadCoupledMixedFvPatchScalarField.C | 8 ++-- .../wallHeatTransferFvPatchScalarField.C | 4 +- .../LES/dynamicLagrangian/dynamicLagrangian.C | 2 +- .../turbulenceModels/RAS/v2f/v2f.C | 2 +- .../epsilonWallFunctionFvPatchScalarField.C | 4 +- ...utUBlendedWallFunctionFvPatchScalarField.C | 2 +- .../nutURoughWallFunctionFvPatchScalarField.C | 4 +- ...tUSpaldingWallFunctionFvPatchScalarField.C | 2 +- ...UTabulatedWallFunctionFvPatchScalarField.C | 2 +- .../nutUWallFunctionFvPatchScalarField.C | 4 +- .../nutkRoughWallFunctionFvPatchScalarField.C | 4 +- .../nutkWallFunctionFvPatchScalarField.C | 2 +- .../turbulenceModels/laminar/Stokes/Stokes.C | 2 +- .../laminar/laminarModel/laminarModel.C | 2 +- ...tkAtmRoughWallFunctionFvPatchScalarField.C | 2 +- .../powerLawLopesdaCosta.C | 2 +- src/combustionModels/EDC/EDC.C | 2 +- .../relaxation/relaxation.C | 2 +- .../diffusionMulticomponent.C | 2 +- .../zoneCombustion/zoneCombustion.C | 4 +- src/conversion/ccm/reader/ccmReaderMesh.C | 8 ++-- src/conversion/common/reader/calcPointCells.C | 2 +- .../common/reader/createPolyBoundary.C | 2 +- src/conversion/polyDualMesh/polyDualMesh.C | 6 +-- src/conversion/starcd/STARCDMeshReader.C | 4 +- .../dynamicRefineFvMeshTemplates.C | 4 +- src/dynamicMesh/boundaryMesh/boundaryMesh.C | 2 +- .../fvMeshDistribute/fvMeshDistribute.C | 8 ++-- src/dynamicMesh/fvMeshSubset/fvMeshSubset.C | 6 +-- src/dynamicMesh/meshCut/cellCuts/cellCuts.C | 2 +- .../multiDirRefinement/multiDirRefinement.C | 6 +-- .../meshCut/wallLayerCells/wallLayerCells.C | 2 +- .../displacementInterpolationMotionSolver.C | 2 +- src/dynamicMesh/polyMeshAdder/polyMeshAdder.C | 10 ++-- .../polyMeshFilter/polyMeshFilter.C | 4 +- .../polyTopoChange/addPatchCellLayer.C | 4 +- .../polyTopoChange/combineFaces.C | 2 +- .../polyTopoChange/hexRef8/hexRef8.C | 12 ++--- .../polyTopoChange/hexRef8/hexRef8Data.C | 7 ++- .../hexRef8/refinementHistory.C | 6 +-- .../polyTopoChange/polyTopoChange.C | 14 +++--- .../polyTopoChange/removeCells.C | 4 +- .../polyTopoChange/removeFaces.C | 2 +- .../fvMotionSolverEngineMesh.C | 2 +- .../layeredEngineMesh/layeredEngineMesh.C | 2 +- src/finiteArea/faMatrices/faMatrix/faMatrix.C | 14 +++--- .../faMatrices/faMatrix/faMatrixSolve.C | 2 +- .../faScalarMatrix/faScalarMatrix.C | 2 +- .../faGlobalMeshData/faGlobalMeshData.C | 2 +- .../faMesh/faMeshDemandDrivenData.C | 34 +++++++------- .../faMesh/faMeshMapper/faEdgeMapper.C | 2 +- .../faMesh/faMeshMapper/faPatchMapper.C | 2 +- .../faMesh/faPatches/faPatch/faPatch.C | 2 +- .../fixedGradient/fixedGradientFaPatchField.C | 4 +- .../basic/fixedValue/fixedValueFaPatchField.C | 2 +- .../zeroGradient/zeroGradientFaPatchField.C | 8 ++-- .../zeroGradient/zeroGradientFaPatchField.H | 2 +- .../EulerFaD2dt2Scheme/EulerFaD2dt2Scheme.C | 14 +----- .../leastSquaresFaVectors.C | 2 +- .../edgeInterpolation/edgeInterpolation.C | 6 +-- .../schemes/NVDscheme/faNVDscheme.C | 4 +- .../volSurfaceMapping/volSurfaceMapping.C | 6 +-- .../cfdTools/general/MRF/MRFZone.C | 6 +-- .../cfdTools/general/levelSet/levelSet.C | 5 +- .../general/levelSet/levelSetTemplates.C | 4 +- .../porosityModel/fixedCoeff/fixedCoeff.C | 2 +- .../general/porosityModel/powerLaw/powerLaw.C | 2 +- .../solidification/solidification.C | 2 +- ...OutletTotalTemperatureFvPatchScalarField.C | 2 +- ...mappedVelocityFluxFixedValueFvPatchField.C | 2 +- .../partialSlip/partialSlipFvPatchField.C | 2 +- .../plenumPressureFvPatchScalarField.C | 2 +- .../prghPressureFvPatchScalarField.C | 2 +- .../prghTotalPressureFvPatchScalarField.C | 2 +- .../swirlFanVelocityFvPatchField.C | 12 ++--- .../totalPressureFvPatchScalarField.C | 2 +- .../totalTemperatureFvPatchScalarField.C | 2 +- .../derived/turbulentDFSEMInlet/eddy/eddy.C | 10 ++-- .../turbulentDFSEMInletFvPatchVectorField.C | 16 +++---- .../ddtSchemes/SLTSDdtScheme/SLTSDdtScheme.C | 2 +- .../CentredFitSnGrad/CentredFitSnGradData.C | 2 +- .../fvMatrices/fvMatrix/fvMatrix.C | 4 +- .../fvMatrices/fvMatrix/fvMatrixSolve.C | 2 +- .../fvScalarMatrix/fvScalarMatrix.C | 2 +- .../solvers/MULES/CMULESTemplates.C | 6 +-- .../fvMatrices/solvers/MULES/MULESTemplates.C | 6 +-- .../isoAdvection/isoAdvection/isoAdvection.C | 4 +- .../isoAdvection/isoCutCell/isoCutCell.C | 16 +++---- .../isoAdvection/isoCutFace/isoCutFace.C | 12 ++--- .../fvMesh/fvMeshMapper/fvSurfaceMapper.C | 4 +- .../columnFvMesh/columnFvMesh.C | 2 +- .../singleCellFvMesh/singleCellFvMesh.C | 2 +- .../schemes/FitData/FitData.C | 2 +- .../volPointInterpolate.C | 2 +- .../eulerianParticle/eulerianParticle.C | 4 +- .../field/fluxSummary/fluxSummary.C | 10 ++-- .../ReynoldsAnalogy/ReynoldsAnalogy.C | 4 +- .../field/histogram/histogram.C | 4 +- src/functionObjects/field/pressure/pressure.C | 2 +- .../field/reference/reference.C | 2 +- .../regionSizeDistribution.C | 10 ++-- src/functionObjects/field/setFlow/setFlow.C | 2 +- .../stabilityBlendingFactor.C | 8 ++-- src/functionObjects/forces/forces/forces.C | 2 +- .../energySpectrum/energySpectrum.C | 2 +- .../utilities/residuals/residuals.C | 2 +- .../thermoCoupleProbes/thermoCoupleProbes.C | 14 +++--- .../MGridGenGAMGAgglomerate.C | 4 +- .../MGridGenGAMGAgglomeration.C | 2 +- .../patchTransformedInterpolation.C | 4 +- ...surfaceDisplacementPointPatchVectorField.C | 2 +- ...aceSlipDisplacementPointPatchVectorField.C | 2 +- ...irectionalPressureGradientExplicitSource.C | 2 +- .../effectivenessHeatExchangerSource.C | 2 +- .../clouds/Templates/DSMCCloud/DSMCCloud.C | 36 +++++---------- .../FreeStream/FreeStream.C | 2 +- src/lagrangian/basic/Cloud/CloudIO.C | 2 +- .../basic/InteractionLists/InteractionLists.C | 4 +- .../ReactingMultiphaseParcel.C | 14 +++--- .../Templates/ReactingParcel/ReactingParcel.C | 4 +- .../PatchCollisionDensity.C | 2 +- .../ParticleForceList/ParticleForceList.C | 4 +- .../CellZoneInjection/CellZoneInjection.C | 2 +- .../ConeNozzleInjection/ConeNozzleInjection.C | 2 +- .../PatchInjection/patchInjectionBase.C | 4 +- .../DistortedSphereDragForce.C | 2 +- .../Drag/NonSphereDrag/NonSphereDragForce.C | 2 +- .../Drag/SphereDrag/SphereDragForce.C | 2 +- .../ParticleForces/Gravity/GravityForce.C | 2 +- .../ParticleForces/Interface/InterfaceForce.C | 2 +- .../ParticleForces/Lift/LiftForce/LiftForce.C | 2 +- .../NonInertialFrame/NonInertialFrameForce.C | 2 +- .../Paramagnetic/ParamagneticForce.C | 2 +- .../PressureGradient/PressureGradientForce.C | 2 +- .../Kinematic/ParticleForces/SRF/SRFForce.C | 2 +- .../ParticleForces/forceSuSp/forceSuSp.H | 9 ++-- .../ParticleForces/forceSuSp/forceSuSpI.H | 6 +++ .../AveragingMethod/AveragingMethod.C | 2 +- .../correlationFunction/correlationFunction.C | 2 +- .../molecule/mdTools/averageMDFields.H | 12 ++--- .../molecule/mdTools/createMDFields.H | 6 +-- .../molecule/mdTools/resetMDFields.H | 6 +-- .../clouds/Templates/SprayCloud/SprayCloudI.H | 4 +- .../BreakupModel/BreakupModel/BreakupModel.C | 4 +- .../ORourkeCollision/ORourkeCollision.C | 2 +- .../BrownianMotion/BrownianMotionForce.C | 2 +- src/lumpedPointMotion/lumpedPointMovement.C | 2 +- .../projectCurveEdge/projectCurveEdge.C | 4 +- .../blockEdges/projectEdge/projectEdge.C | 4 +- .../blockFaces/projectFace/projectFace.C | 10 ++-- .../medialAxisMeshMover.C | 4 +- .../meshRefinement/meshRefinement.C | 4 +- .../meshRefinement/meshRefinementBaffles.C | 10 ++-- .../meshRefinement/meshRefinementGapRefine.C | 2 +- .../refinementSurfaces/refinementSurfaces.C | 12 ++--- .../shellSurfaces/shellSurfaces.C | 2 +- .../snappyHexMeshDriver/snappyLayerDriver.C | 18 ++++---- .../snappyHexMeshDriver/snappyRefineDriver.C | 8 ++-- .../snappyHexMeshDriver/snappySnapDriver.C | 8 ++-- .../snappySnapDriverFeature.C | 2 +- .../AMIInterpolationParallelOps.C | 2 +- .../AMIMethod/directAMI/directAMI.C | 2 +- src/meshTools/cellQuality/cellQuality.C | 4 +- .../extendedEdgeMesh/extendedEdgeMesh.C | 2 +- .../momentOfInertia/momentOfInertia.C | 2 +- .../polyMeshZipUpCells/polyMeshZipUpCells.C | 8 ++-- src/meshTools/processorLOD/box/box.C | 2 +- .../searchableSurfaceCollection.C | 2 +- .../intersectedSurface/edgeSurface.C | 2 +- .../intersectedSurface/intersectedSurface.C | 2 +- .../triSurfaceSearch/triSurfaceRegionSearch.C | 2 +- .../triSurfaceTools/triSurfaceCurvature.C | 2 +- .../cellCellStencil/cellCellStencil.C | 2 +- .../cellVolumeWeightCellCellStencil.C | 6 +-- .../inverseDistanceCellCellStencil.C | 14 +++--- .../leastSquaresCellCellStencil.C | 2 +- .../trackingInverseDistanceCellCellStencil.C | 4 +- .../dynamicOversetFvMeshTemplates.C | 2 +- .../fvMeshPrimitiveLduAddressing.C | 2 +- .../oversetAdjustPhi/oversetAdjustPhi.C | 4 +- .../oversetPolyPatch/oversetGAMGInterface.C | 2 +- src/overset/regionsToCell/findRefCells.C | 4 +- .../singleProcessorFaceSetsConstraint.C | 2 +- .../decompose/ptscotchDecomp/ptscotchDecomp.C | 2 +- .../distributedTriSurfaceMesh.C | 2 +- src/randomProcesses/noise/noiseFFT/noiseFFT.C | 10 ++-- .../noiseModels/surfaceNoise/surfaceNoise.C | 10 ++-- ...sRadiativeCoupledMixedFvPatchScalarField.C | 8 ++-- .../regionModel/regionModel1D/regionModel1D.C | 6 +-- .../singleLayerRegion/singleLayerRegion.C | 2 +- .../kinematicSingleLayer.C | 2 +- .../curvatureSeparation/curvatureSeparation.C | 8 ++-- .../drippingInjection/drippingInjection.C | 2 +- .../injectionModelList/injectionModelList.C | 4 +- .../patchInjection/patchInjection.C | 4 +- .../transferModel/transferModel.C | 2 +- .../transferModelList/transferModelList.C | 4 +- .../thermalBaffleModel/thermalBaffleModel.C | 6 +-- .../springRenumber/springRenumber.C | 2 +- .../meshToMesh/meshToMeshParallelOps.C | 8 ++-- .../sampledSet/cellCentre/cellCentreSet.C | 2 +- .../surface/isoSurface/isoSurfaceTemplates.C | 2 +- .../surface/isoSurface/isoSurfaceTopo.C | 2 +- ...ableBaffleMassFractionFvPatchScalarField.C | 6 +-- .../surfaceFormats/ac3d/AC3DsurfaceFormat.C | 2 +- .../surfaceFormats/vtk/VTKsurfaceFormat.C | 6 +-- .../TDACChemistryModel/reduction/DAC/DAC.C | 16 +++---- .../TDACChemistryModel/reduction/DRG/DRG.C | 8 ++-- .../reduction/DRGEP/DRGEP.C | 16 +++---- .../TDACChemistryModel/reduction/EFA/EFA.C | 20 ++++---- .../TDACChemistryModel/reduction/PFA/PFA.C | 18 ++++---- .../tabulation/ISAT/binaryTree/binaryTree.C | 6 +-- .../ISAT/chemPointISAT/chemPointISAT.C | 6 +-- ...iffusiveRadiationMixedFvPatchScalarField.C | 2 +- .../radiationModels/solarLoad/solarLoad.C | 16 +++---- .../radiationModels/viewFactor/viewFactor.C | 26 +++++------ .../greyMeanAbsorptionEmission.C | 2 +- .../greyMeanSolidAbsorptionEmission.C | 4 +- .../wideBandAbsorptionEmission.C | 2 +- .../chemkinReader/chemkinReader.C | 2 +- .../pyrolysisChemistryModel.C | 14 +++--- ...emperatureCoupledMixedFvPatchScalarField.C | 46 +++++++++---------- .../mixerFvMesh/mixerFvMesh.C | 2 +- .../alphaFixedPressureFvPatchScalarField.C | 2 +- .../derived/Boussinesq/BoussinesqWaveModel.C | 2 +- src/waveModels/waveModel/waveModel.C | 10 ++-- .../validation/WatersKing/WatersKing.C | 10 ++-- 342 files changed, 814 insertions(+), 803 deletions(-) diff --git a/applications/solvers/combustion/chemFoam/readInitialConditions.H b/applications/solvers/combustion/chemFoam/readInitialConditions.H index e5f0599cee..5ffe9c97a9 100644 --- a/applications/solvers/combustion/chemFoam/readInitialConditions.H +++ b/applications/solvers/combustion/chemFoam/readInitialConditions.H @@ -29,8 +29,8 @@ ); } - scalarList Y0(nSpecie, 0.0); - scalarList X0(nSpecie, 0.0); + scalarList Y0(nSpecie, Zero); + scalarList X0(nSpecie, Zero); dictionary fractions(initialConditions.subDict("fractions")); if (fractionBasis == "mole") diff --git a/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C b/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C index ef0cf6b6dd..e3565ca63c 100644 --- a/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C +++ b/applications/solvers/compressible/rhoCentralFoam/BCs/T/smoluchowskiJumpTFvPatchScalarField.C @@ -44,7 +44,7 @@ Foam::smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField psiName_("thermo:psi"), muName_("thermo:mu"), accommodationCoeff_(1.0), - Twall_(p.size(), 0.0), + Twall_(p.size(), Zero), gamma_(1.4) { refValue() = 0.0; diff --git a/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C b/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C index 612f76a3ff..1dd6431324 100644 --- a/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C +++ b/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C @@ -45,7 +45,7 @@ Foam::maxwellSlipUFvPatchVectorField::maxwellSlipUFvPatchVectorField muName_("thermo:mu"), tauMCName_("tauMC"), accommodationCoeff_(1.0), - Uwall_(p.size(), vector(0.0, 0.0, 0.0)), + Uwall_(p.size(), Zero), thermalCreep_(true), curvature_(true) {} diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H index 6cafd11a6f..06567b8b5b 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/chtMultiRegionSimpleFoam/fluid/createFluidFields.H @@ -12,7 +12,7 @@ PtrList radiation(fluidRegions.size()); List initialMassFluid(fluidRegions.size()); List