diff --git a/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C b/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C index 843ed62bf..3b60d0e77 100644 --- a/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C +++ b/applications/solvers/combustion/PDRFoam/PDRModels/turbulence/PDRkEpsilon/PDRkEpsilon.C @@ -111,7 +111,7 @@ void PDRkEpsilon::correct() // Re-calculate thermal diffusivity //***HGWalphat_ = mut_/Prt_; - //alphat_.correctBoundaryConditions(); + // alphat_.correctBoundaryConditions(); return; } @@ -192,7 +192,7 @@ void PDRkEpsilon::correct() // Re-calculate thermal diffusivity //***HGWalphat_ = mut_/Prt_; - //alphat_.correctBoundaryConditions(); + // alphat_.correctBoundaryConditions(); } diff --git a/applications/solvers/combustion/PDRFoam/bEqn.H b/applications/solvers/combustion/PDRFoam/bEqn.H index 77b4db7af..16f9d0739 100644 --- a/applications/solvers/combustion/PDRFoam/bEqn.H +++ b/applications/solvers/combustion/PDRFoam/bEqn.H @@ -30,7 +30,7 @@ if (ign.ignited()) // Calculate flame normal etc. // ~~~~~~~~~~~~~~~~~~~~~~~~~~~ - //volVectorField n(fvc::grad(b)); + // volVectorField n(fvc::grad(b)); volVectorField n(fvc::reconstruct(fvc::snGrad(b)*mesh.magSf())); volScalarField mgb("mgb", mag(n)); diff --git a/applications/solvers/combustion/XiFoam/bEqn.H b/applications/solvers/combustion/XiFoam/bEqn.H index 19da0426b..7ececc2e2 100644 --- a/applications/solvers/combustion/XiFoam/bEqn.H +++ b/applications/solvers/combustion/XiFoam/bEqn.H @@ -80,7 +80,7 @@ if (ign.ignited()) // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ volScalarField up(uPrimeCoef*sqrt((2.0/3.0)*turbulence->k())); - //volScalarField up(sqrt(mag(diag(n * n) & diag(turbulence->r())))); + // volScalarField up(sqrt(mag(diag(n * n) & diag(turbulence->r())))); volScalarField epsilon(pow(uPrimeCoef, 3)*turbulence->epsilon()); @@ -95,8 +95,8 @@ if (ign.ignited()) ) ); - //volScalarField l = 0.337*k*sqrt(k)/epsilon; - //Reta *= max((l - dimensionedScalar("dl", dimLength, 1.5e-3))/l, 0.0); + // volScalarField l = 0.337*k*sqrt(k)/epsilon; + // Reta *= max((l - dimensionedScalar("dl", dimLength, 1.5e-3))/l, 0.0); // Calculate Xi flux // ~~~~~~~~~~~~~~~~~ @@ -226,7 +226,7 @@ if (ign.ignited()) volScalarField R(Gstar*XiEqStar/(XiEqStar - scalar(1))); volScalarField G(R*(XiEq - scalar(1.001))/XiEq); - //R *= (Gstar + 2*mag(dev(symm(fvc::grad(U)))))/Gstar; + // R *= (Gstar + 2*mag(dev(symm(fvc::grad(U)))))/Gstar; // Solve for the flame wrinkling // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ diff --git a/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C b/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C index 3c5d1c2b7..52390e451 100644 --- a/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C +++ b/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointOutletVelocity/adjointOutletVelocityFvPatchVectorField.C @@ -100,7 +100,7 @@ void Foam::adjointOutletVelocityFvPatchVectorField::updateCoeffs() vectorField Uan(patch().nf()*(patch().nf() & patchInternalField())); vectorField::operator=(phiap*patch().Sf()/sqr(patch().magSf()) + UtHat); - //vectorField::operator=(Uan + UtHat); + // vectorField::operator=(Uan + UtHat); fixedValueFvPatchVectorField::updateCoeffs(); } diff --git a/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointShapeOptimizationFoam.C b/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointShapeOptimizationFoam.C index e538f0483..a89e91b35 100644 --- a/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointShapeOptimizationFoam.C +++ b/applications/solvers/incompressible/adjointShapeOptimizationFoam/adjointShapeOptimizationFoam.C @@ -91,7 +91,7 @@ int main(int argc, char *argv[]) laminarTransport.lookup("lambda") >> lambda; - //alpha += + // alpha += // mesh.relaxationFactor("alpha") // *(lambda*max(Ua & U, zeroSensitivity) - alpha); alpha += @@ -99,7 +99,7 @@ int main(int argc, char *argv[]) *(min(max(alpha + lambda*(Ua & U), zeroAlpha), alphaMax) - alpha); zeroCells(alpha, inletCells); - //zeroCells(alpha, outletCells); + // zeroCells(alpha, outletCells); // Pressure-velocity SIMPLE corrector { @@ -165,7 +165,7 @@ int main(int argc, char *argv[]) // Adjoint Momentum predictor volVectorField adjointTransposeConvection((fvc::grad(Ua) & U)); - //volVectorField adjointTransposeConvection + // volVectorField adjointTransposeConvection //( // fvc::reconstruct // ( diff --git a/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H b/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H index ed799ae4b..5a8b55ea0 100644 --- a/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H +++ b/applications/solvers/multiphase/cavitatingFoam/alphavPsi.H @@ -16,5 +16,5 @@ psiModel->correct(); - //Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl; + // Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl; } diff --git a/applications/solvers/multiphase/interFoam/interMixingFoam/alphaEqnSubCycle.H b/applications/solvers/multiphase/interFoam/interMixingFoam/alphaEqnSubCycle.H index 2f117f2cd..99e47ebf8 100644 --- a/applications/solvers/multiphase/interFoam/interMixingFoam/alphaEqnSubCycle.H +++ b/applications/solvers/multiphase/interFoam/interMixingFoam/alphaEqnSubCycle.H @@ -33,8 +33,8 @@ else { volScalarField rhoNew(alpha1*rho1 + alpha2*rho2 + alpha3*rho3); - //solve(fvm::ddt(rho) + fvc::div(rhoPhi)); - //Info<< "density error = " + // solve(fvm::ddt(rho) + fvc::div(rhoPhi)); + // Info<< "density error = " // << max((mag(rho - rhoNew)/mag(rhoNew))().primitiveField()) << endl; rho == rhoNew; diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H b/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H index 76f47f827..5ed343544 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H +++ b/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H @@ -56,7 +56,7 @@ forAllIter(PtrDictionary, fluid.phases(), iter) alpha*(1 + (1/phase.rho())*fluid.Cvm(phase)), UEqns[phasei] ); - //UEqns[phasei].relax(); + // UEqns[phasei].relax(); phasei++; } diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C index 5cc9422af..03916b542 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C +++ b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/multiphaseSystem.C @@ -687,8 +687,8 @@ Foam::multiphaseSystem::dragCoeffs() const ( max ( - //fvc::average(dm.phase1()*dm.phase2()), - //fvc::average(dm.phase1())*fvc::average(dm.phase2()), + // fvc::average(dm.phase1()*dm.phase2()), + // fvc::average(dm.phase1())*fvc::average(dm.phase2()), dm.phase1()*dm.phase2(), dm.residualPhaseFraction() ) diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/phaseModel/phaseModel.C b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/phaseModel/phaseModel.C index a1990a88c..5d47f1ccf 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/phaseModel/phaseModel.C +++ b/applications/solvers/multiphase/multiphaseEulerFoam/multiphaseSystem/phaseModel/phaseModel.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 @@ -210,7 +210,7 @@ Foam::autoPtr Foam::phaseModel::clone() const void Foam::phaseModel::correct() { - //nuModel_->correct(); + // nuModel_->correct(); } @@ -218,7 +218,7 @@ bool Foam::phaseModel::read(const dictionary& phaseDict) { phaseDict_ = phaseDict; - //if (nuModel_->read(phaseDict_)) + // if (nuModel_->read(phaseDict_)) { phaseDict_.lookup("nu") >> nu_.value(); phaseDict_.lookup("kappa") >> kappa_.value(); diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/pEqn.H b/applications/solvers/multiphase/multiphaseEulerFoam/pEqn.H index 4cf269a15..a30c128a8 100644 --- a/applications/solvers/multiphase/multiphaseEulerFoam/pEqn.H +++ b/applications/solvers/multiphase/multiphaseEulerFoam/pEqn.H @@ -5,10 +5,10 @@ // tmp pEqnComp1; // tmp pEqnComp2; - // //if (transonic) + // // if (transonic) // //{ // //} - // //else + // // else // { // surfaceScalarField phid1("phid1", fvc::interpolate(psi1)*phi1); // surfaceScalarField phid2("phid2", fvc::interpolate(psi2)*phi2); @@ -288,7 +288,7 @@ ) )/phase.rho(); - //phase.U() = fvc::reconstruct(phase.phi()); + // phase.U() = fvc::reconstruct(phase.phi()); phase.U().correctBoundaryConditions(); U += alpha*phase.U(); @@ -298,7 +298,7 @@ } } - //p = max(p, pMin); + // p = max(p, pMin); #include "continuityErrs.H" diff --git a/applications/solvers/stressAnalysis/solidDisplacementFoam/solidDisplacementFoam.C b/applications/solvers/stressAnalysis/solidDisplacementFoam/solidDisplacementFoam.C index 3dddea7d4..a21ff6c2d 100644 --- a/applications/solvers/stressAnalysis/solidDisplacementFoam/solidDisplacementFoam.C +++ b/applications/solvers/stressAnalysis/solidDisplacementFoam/solidDisplacementFoam.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,8 +89,8 @@ int main(int argc, char *argv[]) DEqn += fvc::grad(threeKalpha*T); } - //DEqn.setComponentReference(1, 0, vector::X, 0); - //DEqn.setComponentReference(1, 0, vector::Z, 0); + // DEqn.setComponentReference(1, 0, vector::X, 0); + // DEqn.setComponentReference(1, 0, vector::Z, 0); initialResidual = DEqn.solve().max().initialResidual(); diff --git a/applications/test/Function1/Test-Function1.C b/applications/test/Function1/Test-Function1.C index ab4baee15..85ea44386 100644 --- a/applications/test/Function1/Test-Function1.C +++ b/applications/test/Function1/Test-Function1.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 @@ -51,11 +51,11 @@ int main(int argc, char *argv[]) samples[3] = 3; scalarField values(4); values = 1.0; - //values[0] = 0.0; - //values[1] = 1.0; + // values[0] = 0.0; + // values[1] = 1.0; linearInterpolationWeights interpolator - //splineInterpolationWeights interpolator + // splineInterpolationWeights interpolator ( samples ); @@ -84,9 +84,9 @@ int main(int argc, char *argv[]) // // // interpolator.integrationWeights(-0.01, 1, indices, weights); -// //Pout<< "samples:" << samples << endl; -// //Pout<< "indices:" << indices << endl; -// //Pout<< "weights:" << weights << endl; +// // Pout<< "samples:" << samples << endl; +// // Pout<< "indices:" << indices << endl; +// // Pout<< "weights:" << weights << endl; // scalar sum = interpolator.weightedSum // ( // weights, diff --git a/applications/test/Map/Test-Map.C b/applications/test/Map/Test-Map.C index ea46cfcb1..f39dcfb9f 100644 --- a/applications/test/Map/Test-Map.C +++ b/applications/test/Map/Test-Map.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 @@ -48,7 +48,7 @@ int main(int argc, char *argv[]) Map::const_iterator bananaIter = banana.find(5); // This works but now I can change the value. - //Map::iterator bananaIter = banana.find(5); + // Map::iterator bananaIter = banana.find(5); if (bananaIter == banana.end()) { diff --git a/applications/test/Matrix/Test-Matrix.C b/applications/test/Matrix/Test-Matrix.C index 8a0e0a3cf..4bcb0b8b1 100644 --- a/applications/test/Matrix/Test-Matrix.C +++ b/applications/test/Matrix/Test-Matrix.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 @@ -50,7 +50,7 @@ int main(int argc, char *argv[]) hmm(2, 1) = 6.0; hmm(2, 2) = 1.0; - //Info<< hmm << endl << hmm - 2.0*(-hmm) << endl; + // Info<< hmm << endl << hmm - 2.0*(-hmm) << endl; Info<< max(hmm) << endl; Info<< min(hmm) << endl; @@ -60,9 +60,9 @@ int main(int argc, char *argv[]) Info<< hmm << endl; - //SquareMatrix hmm3(Sin); + // SquareMatrix hmm3(Sin); - //Info<< hmm3 << endl; + // Info<< hmm3 << endl; SquareMatrix hmm4; diff --git a/applications/test/PatchTools/Test-PatchTools.C b/applications/test/PatchTools/Test-PatchTools.C index 0a56d1785..c6d1afd84 100644 --- a/applications/test/PatchTools/Test-PatchTools.C +++ b/applications/test/PatchTools/Test-PatchTools.C @@ -242,7 +242,7 @@ int main(int argc, char *argv[]) forAll(en, patchEdgeI) { const edge& patchE = pp.edges()[patchEdgeI]; - //str.write(pp.localPoints()[pointi], en[pointi]); + // str.write(pp.localPoints()[pointi], en[pointi]); const point pt = patchE.centre(pp.localPoints()); str.write(linePointRef(pt, pt + 0.1*en[patchEdgeI])); } diff --git a/applications/test/dictionary/testDictRegex b/applications/test/dictionary/testDictRegex index 4a24a74ef..f2fbd11bf 100644 --- a/applications/test/dictionary/testDictRegex +++ b/applications/test/dictionary/testDictRegex @@ -24,7 +24,7 @@ keyY parentValue5; "(.*)Dict" { foo subdictValue0; - //bar $f.*; // should this really match 'foo'? + // bar $f.*; // should this really match 'foo'? // result is dependent on insert order! "a.*c" subdictValue3; diff --git a/applications/test/extendedStencil/Test-ExtendedStencil.C b/applications/test/extendedStencil/Test-ExtendedStencil.C index 6374014b9..a3e737128 100644 --- a/applications/test/extendedStencil/Test-ExtendedStencil.C +++ b/applications/test/extendedStencil/Test-ExtendedStencil.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,8 +146,8 @@ int main(int argc, char *argv[]) // ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~ // { -// //const FECCellToFaceStencil cfcStencil(mesh); -// //const extendedCentredCellToFaceStencil addressing +// // const FECCellToFaceStencil cfcStencil(mesh); +// // const extendedCentredCellToFaceStencil addressing // //( // // cfcStencil // //); @@ -249,25 +249,25 @@ int main(int argc, char *argv[]) // // ~~~~~~~~~~~~~~~~~~~~~~ // // { -// //const extendedCentredCellToFaceStencil& addressing = -// //centredCPCStencilObject::New +// // const extendedCentredCellToFaceStencil& addressing = +// // centredCPCStencilObject::New // //( // // mesh // //); // // -// //Info<< "cellPointCell:" << endl; -// //writeStencilStats(addressing.stencil()); +// // Info<< "cellPointCell:" << endl; +// // writeStencilStats(addressing.stencil()); // // // // // //// Collect stencil cell centres -// //List> stencilPoints(mesh.nFaces()); -// //addressing.collectData +// // List> stencilPoints(mesh.nFaces()); +// // addressing.collectData // //( // // mesh.C(), // // stencilPoints // //); // // -// //forAll(stencilPoints, facei) +// // forAll(stencilPoints, facei) // //{ // // writeStencilOBJ // // ( @@ -284,25 +284,25 @@ int main(int argc, char *argv[]) // // ~~~~~~~~~~~~~~~~~~~~~~ // // { -// //const extendedCentredCellToFaceStencil& addressing = -// //centredCECStencilObject::New +// // const extendedCentredCellToFaceStencil& addressing = +// // centredCECStencilObject::New // //( // // mesh // //); // // -// //Info<< "cellEdgeCell:" << endl; -// //writeStencilStats(addressing.stencil()); +// // Info<< "cellEdgeCell:" << endl; +// // writeStencilStats(addressing.stencil()); // // // // // //// Collect stencil cell centres -// //List> stencilPoints(mesh.nFaces()); -// //addressing.collectData +// // List> stencilPoints(mesh.nFaces()); +// // addressing.collectData // //( // // mesh.C(), // // stencilPoints // //); // // -// //forAll(stencilPoints, facei) +// // forAll(stencilPoints, facei) // //{ // // writeStencilOBJ // // ( diff --git a/applications/test/findCell-octree/Test-findCell-octree.C b/applications/test/findCell-octree/Test-findCell-octree.C index 1bac7302a..57d69af39 100644 --- a/applications/test/findCell-octree/Test-findCell-octree.C +++ b/applications/test/findCell-octree/Test-findCell-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 @@ -72,7 +72,7 @@ int main(int argc, char *argv[]) { indexedOctree ioc ( - treeDataCell(true, mesh, decompMode), //FACEDIAGTETS), + treeDataCell(true, mesh, decompMode), // FACEDIAGTETS), shiftedBb, 10, // maxLevel 100, // leafsize diff --git a/applications/test/hexRef8/block/system/decomposeParDict b/applications/test/hexRef8/block/system/decomposeParDict index be54c7d92..c9801ce0e 100644 --- a/applications/test/hexRef8/block/system/decomposeParDict +++ b/applications/test/hexRef8/block/system/decomposeParDict @@ -54,8 +54,8 @@ multiLevelCoeffs level0 { numberOfSubdomains 64; - //method simple; - //simpleCoeffs + // method simple; + // simpleCoeffs //{ // n (2 1 1); // delta 0.001; @@ -100,15 +100,15 @@ metisCoeffs scotchCoeffs { - //processorWeights + // processorWeights //( // 1 // 1 // 1 // 1 //); - //writeGraph true; - //strategy "b"; + // writeGraph true; + // strategy "b"; } manualCoeffs diff --git a/applications/test/parallel-communicators/Test-parallel-communicators.C b/applications/test/parallel-communicators/Test-parallel-communicators.C index d3805c24f..f9dcec2a3 100644 --- a/applications/test/parallel-communicators/Test-parallel-communicators.C +++ b/applications/test/parallel-communicators/Test-parallel-communicators.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 @@ -150,7 +150,7 @@ int main(int argc, char *argv[]) top.append(i); } - //Pout<< "bottom:" << bottom << endl; + // Pout<< "bottom:" << bottom << endl; Pout<< "top :" << top << endl; @@ -171,9 +171,9 @@ int main(int argc, char *argv[]) if (Pstream::myProcNo(comm) != -1) { - //scalar sum = sumReduce(comm, localValue); - //scalar sum = localValue; - //reduce + // scalar sum = sumReduce(comm, localValue); + // scalar sum = localValue; + // reduce //( // UPstream::treeCommunication(comm), // sum, diff --git a/applications/test/patchRegion/cavity_pinched/system/decomposeParDict b/applications/test/patchRegion/cavity_pinched/system/decomposeParDict index 8f0581f95..2246e6fd9 100644 --- a/applications/test/patchRegion/cavity_pinched/system/decomposeParDict +++ b/applications/test/patchRegion/cavity_pinched/system/decomposeParDict @@ -54,8 +54,8 @@ multiLevelCoeffs level0 { numberOfSubdomains 64; - //method simple; - //simpleCoeffs + // method simple; + // simpleCoeffs //{ // n (2 1 1); // delta 0.001; @@ -99,15 +99,15 @@ metisCoeffs scotchCoeffs { - //processorWeights + // processorWeights //( // 1 // 1 // 1 // 1 //); - //writeGraph true; - //strategy "b"; + // writeGraph true; + // strategy "b"; } manualCoeffs diff --git a/applications/test/patchRegion/cavity_pinched/system/fvSolution b/applications/test/patchRegion/cavity_pinched/system/fvSolution index a0130726c..b252e255d 100644 --- a/applications/test/patchRegion/cavity_pinched/system/fvSolution +++ b/applications/test/patchRegion/cavity_pinched/system/fvSolution @@ -19,8 +19,8 @@ solvers { p { - //solver PCG; - //preconditioner DIC; + // solver PCG; + // preconditioner DIC; solver GAMG; smoother GaussSeidel; @@ -31,8 +31,8 @@ solvers nCellsInCoarsestLevel 3; mergeLevels 1; - processorAgglomerator none; //procFaces; - //nAgglomeratingCells 20; + processorAgglomerator none; // procFaces; + // nAgglomeratingCells 20; tolerance 1e-06; relTol 0; diff --git a/applications/test/prefixOSstream/Test-prefixOSstream.C b/applications/test/prefixOSstream/Test-prefixOSstream.C index accaf914e..f9a9aafef 100644 --- a/applications/test/prefixOSstream/Test-prefixOSstream.C +++ b/applications/test/prefixOSstream/Test-prefixOSstream.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 @@ -47,7 +47,7 @@ int main(int argc, char *argv[]) { argList args(argc, argv); - //Pout.prefix() = '[' + name(Pstream::myProcNo()) + "] "; + // Pout.prefix() = '[' + name(Pstream::myProcNo()) + "] "; List list(IStringStream("1 ((0 1 2))")()); Info<< list << endl; diff --git a/applications/test/router/Gather/Gather.H b/applications/test/router/Gather/Gather.H index e95829b26..5c3e4cde7 100644 --- a/applications/test/router/Gather/Gather.H +++ b/applications/test/router/Gather/Gather.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 @@ -60,7 +60,7 @@ class Gather label nProcs_; //- Storage of type 0 - //List data0_; + // List data0_; public: diff --git a/applications/test/router/router.C b/applications/test/router/router.C index 474bb96d9..994f8b7ac 100644 --- a/applications/test/router/router.C +++ b/applications/test/router/router.C @@ -309,7 +309,7 @@ bool Foam::router::route(const labelList& path, const label pathValue) { if (weights_[path[leafI]] == labelMax) { - //Info<< "Cannot route leaf from " << path[0] + // Info<< "Cannot route leaf from " << path[0] // << " to " << path[leafI] << " of path " << path // << " since there is no valid route between them" << endl; diff --git a/applications/test/slicedField/Test-slicedField.C b/applications/test/slicedField/Test-slicedField.C index eb7d35287..02cb3eac0 100644 --- a/applications/test/slicedField/Test-slicedField.C +++ b/applications/test/slicedField/Test-slicedField.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 @@ -56,7 +56,7 @@ int main(int argc, char *argv[]) mesh ); - //Info<< min(p, p); + // Info<< min(p, p); Info<< "Reading field U\n" << endl; volVectorField U @@ -110,7 +110,7 @@ int main(int argc, char *argv[]) mesh.faceAreas() ); - //Info<< Sf << endl; + // Info<< Sf << endl; return 0; } diff --git a/applications/test/speed/scalarSpeed/Test-scalarSpeed.C b/applications/test/speed/scalarSpeed/Test-scalarSpeed.C index 6e46d90cc..85565fadc 100644 --- a/applications/test/speed/scalarSpeed/Test-scalarSpeed.C +++ b/applications/test/speed/scalarSpeed/Test-scalarSpeed.C @@ -177,7 +177,7 @@ int main() for (int j=0; j{lbrac} { - //Warning + // Warning // << "Found unknown block in zone: " << YYText() << nl // << " on line " << lineNo << endl; yy_push_state(ignoreBlock); @@ -916,7 +916,7 @@ int main(int argc, char *argv[]) // It is ok if the periodics are already ordered. We should read the // periodic shadow faces section (section 18) to give use the ordering // For now just disable. - //fluentToFoamType.insert("periodic", cyclicPolyPatch::typeName); + // fluentToFoamType.insert("periodic", cyclicPolyPatch::typeName); // Foam patch type for Fluent zone type @@ -1389,13 +1389,13 @@ int main(int argc, char *argv[]) faces[facei], owner[facei], neighbour[facei], - -1, //masterPointID - -1, //masterEdgeID - facei, //masterFace - false, //flipFaceFlux - -1, //patchID - -1, //zoneID - false //zoneFlip + -1, // masterPointID + -1, // masterEdgeID + facei, // masterFace + false, // flipFaceFlux + -1, // patchID + -1, // zoneID + false // zoneFlip ); } } diff --git a/applications/utilities/mesh/conversion/fluentMeshToFoam/fluentMeshToFoam.L b/applications/utilities/mesh/conversion/fluentMeshToFoam/fluentMeshToFoam.L index 18eccb33c..9c5a17e4f 100644 --- a/applications/utilities/mesh/conversion/fluentMeshToFoam/fluentMeshToFoam.L +++ b/applications/utilities/mesh/conversion/fluentMeshToFoam/fluentMeshToFoam.L @@ -1151,7 +1151,7 @@ int main(int argc, char *argv[]) } - //make patchless mesh before analysing boundaries + // make patchless mesh before analysing boundaries faceListList patches(0); wordList patchNames(0); @@ -1191,9 +1191,9 @@ int main(int argc, char *argv[]) Info<< endl << "Building boundary and internal patches." << endl; - //adding patches after mesh construction allows topological checks - //on whether a patch is internal or external, something fluent - //doesn't seem to mind + // adding patches after mesh construction allows topological checks + // on whether a patch is internal or external, something fluent + // doesn't seem to mind // Make boundary patches @@ -1223,7 +1223,7 @@ int main(int argc, char *argv[]) label nPatches = 0; - //colate information for all patches (internal and external) + // colate information for all patches (internal and external) for ( ; @@ -1271,7 +1271,7 @@ int main(int argc, char *argv[]) } } - //inlets and outlets + // inlets and outlets if ( curPatchType == "pressure" @@ -1293,7 +1293,7 @@ int main(int argc, char *argv[]) nPatches++; } - else if (curPatchType == "wall" ) //wall boundaries + else if (curPatchType == "wall" ) // wall boundaries { patches[nPatches] = patchFaces; patchTypes[nPatches] = wallPolyPatch::typeName; @@ -1305,7 +1305,7 @@ int main(int argc, char *argv[]) ( curPatchType == "symmetry" || curPatchType == "axis" - ) //symmetry planes + ) // symmetry planes { patches[nPatches] = patchFaces; patchTypes[nPatches] = symmetryPolyPatch::typeName; @@ -1322,7 +1322,7 @@ int main(int argc, char *argv[]) || curPatchType == "fan" || curPatchType == "radiator" || curPatchType == "porous-jump" - ) //interior boundaries - will not be added as patches + ) // interior boundaries - will not be added as patches { patches[nPatches] = patchFaces; patchTypes[nPatches] = "internal"; @@ -1333,7 +1333,7 @@ int main(int argc, char *argv[]) else if ( curPatchType == "" - ) //unnamed face regions default to interior patches + ) // unnamed face regions default to interior patches { Info<< "Patch " << faceGroupZoneIDIter() << ": Faces are defined but " @@ -1347,7 +1347,7 @@ int main(int argc, char *argv[]) nPatches++; } - else //unknown face regions are not handled + else // unknown face regions are not handled { FatalErrorInFunction << "fluent patch type " << curPatchType << " not recognised." @@ -1355,7 +1355,7 @@ int main(int argc, char *argv[]) } } - //add front and back boundaries for 2D meshes + // add front and back boundaries for 2D meshes if (dimensionOfGrid == 2) { Info<< "Creating patch for front and back planes" << endl << endl; @@ -1367,16 +1367,16 @@ int main(int argc, char *argv[]) nPatches++; } - //Now have all patch information, - //check whether each patch is internal or external - //and add boundaries to mesh - //also write face sets of all patches + // Now have all patch information, + // check whether each patch is internal or external + // and add boundaries to mesh + // also write face sets of all patches patches.setSize(nPatches); patchTypes.setSize(nPatches); patchNames.setSize(nPatches); - //old polyBoundary + // old polyBoundary const polyBoundaryMesh& oPatches = pShapeMesh.boundaryMesh(); // new patches. DynamicList newPatches(nPatches); @@ -1403,12 +1403,12 @@ int main(int argc, char *argv[]) } - //check if patch is internal - //also check internal/external-ness of first patch face - //internal faces cannot become foam boundaries - //if a face is defined as internal but is actually external - //it will be put in a default wall boundary - //internal boundaries are simply ignored + // check if patch is internal + // also check internal/external-ness of first patch face + // internal faces cannot become foam boundaries + // if a face is defined as internal but is actually external + // it will be put in a default wall boundary + // internal boundaries are simply ignored if ( @@ -1416,10 +1416,10 @@ int main(int argc, char *argv[]) && !pShapeMesh.isInternalFace(meshFaces[0]) ) { - //first face is external and has valid non-internal type + // first face is external and has valid non-internal type - //check all faces for externalness just to be sure - //and mark patch number to global list + // check all faces for externalness just to be sure + // and mark patch number to global list forAll(meshFaces, i) { label facei = meshFaces[i]; @@ -1446,7 +1446,7 @@ int main(int argc, char *argv[]) facePatchID[facei - pShapeMesh.nInternalFaces()] = nBoundaries; } - //add to boundary patch + // add to boundary patch Info<< "Adding new patch " << patchNames[patchi] << " of type " << patchTypes[patchi] diff --git a/applications/utilities/mesh/conversion/gmshToFoam/gmshToFoam.C b/applications/utilities/mesh/conversion/gmshToFoam/gmshToFoam.C index c6db8e420..a4b64a686 100644 --- a/applications/utilities/mesh/conversion/gmshToFoam/gmshToFoam.C +++ b/applications/utilities/mesh/conversion/gmshToFoam/gmshToFoam.C @@ -1001,7 +1001,7 @@ int main(int argc, char *argv[]) Info<< endl; - //Get polyMesh to write to constant + // Get polyMesh to write to constant runTime.setTime(instant(runTime.constant()), 0); diff --git a/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C b/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C index dc029768a..c5a237698 100644 --- a/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C +++ b/applications/utilities/mesh/conversion/ideasUnvToFoam/ideasUnvToFoam.C @@ -683,7 +683,7 @@ int main(int argc, char *argv[]) // Switch on additional debug info - const bool verbose = false; //true; + const bool verbose = false; // true; // Unit scale factors scalar lengthScale = 1; diff --git a/applications/utilities/mesh/conversion/sammToFoam/fillSammCellShapeTable.C b/applications/utilities/mesh/conversion/sammToFoam/fillSammCellShapeTable.C index 551d9aa74..f981a6892 100644 --- a/applications/utilities/mesh/conversion/sammToFoam/fillSammCellShapeTable.C +++ b/applications/utilities/mesh/conversion/sammToFoam/fillSammCellShapeTable.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 @@ -44,7 +44,7 @@ void Foam::sammMesh::fillSammCellShapeTable() sammShapeLookup[64] = sammTrim1Ptr_; sammShapeLookup[128] = sammTrim1Ptr_; - //SAMM trim type 2: 12 models + // SAMM trim type 2: 12 models sammShapeLookup[3] = sammTrim2Ptr_; sammShapeLookup[12] = sammTrim2Ptr_; sammShapeLookup[192] = sammTrim2Ptr_; diff --git a/applications/utilities/mesh/conversion/sammToFoam/readBoundary.C b/applications/utilities/mesh/conversion/sammToFoam/readBoundary.C index 8502c312a..addd9b419 100644 --- a/applications/utilities/mesh/conversion/sammToFoam/readBoundary.C +++ b/applications/utilities/mesh/conversion/sammToFoam/readBoundary.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 @@ -171,7 +171,7 @@ void Foam::sammMesh::readBoundary() pointLabels[2] == pointLabels[3] ) { - //Info<< "Converting collapsed quad into triangle" + // Info<< "Converting collapsed quad into triangle" // << " for face " << facei // << " in Samm boundary " << lineIndex << endl; diff --git a/applications/utilities/mesh/conversion/star3ToFoam/readBoundary.C b/applications/utilities/mesh/conversion/star3ToFoam/readBoundary.C index 4f1831bb2..9b3011ad2 100644 --- a/applications/utilities/mesh/conversion/star3ToFoam/readBoundary.C +++ b/applications/utilities/mesh/conversion/star3ToFoam/readBoundary.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 @@ -169,7 +169,7 @@ void Foam::starMesh::readBoundary() pointLabels[2] == pointLabels[3] ) { - //Info<< "Converting collapsed quad into triangle" + // Info<< "Converting collapsed quad into triangle" // << " for face " << facei // << " in Star boundary " << lineIndex << endl; diff --git a/applications/utilities/mesh/generation/blockMesh/blockMesh.C b/applications/utilities/mesh/generation/blockMesh/blockMesh.C index 87a75f7bb..05b10255c 100644 --- a/applications/utilities/mesh/generation/blockMesh/blockMesh.C +++ b/applications/utilities/mesh/generation/blockMesh/blockMesh.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 @@ -243,7 +243,7 @@ int main(int argc, char *argv[]) forAll(cellCentres, celli) { - //point cc = b.blockShape().centre(b.points()); + // point cc = b.blockShape().centre(b.points()); const point& cc = cellCentres[celli]; str << "v " << cc.x() << ' ' << cc.y() << ' ' << cc.z() << nl; diff --git a/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMesh.C b/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMesh.C index 30efa9921..2521aad43 100644 --- a/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMesh.C +++ b/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMesh.C @@ -810,7 +810,7 @@ void addCouplingPatches << '\t' << newPatches[interRegionBottomPatch[zoneI]]->type() << nl; } - else //patch using shadow face zones. + else // patch using shadow face zones. { interRegionTopPatch[zoneI] = addPatch ( @@ -1256,7 +1256,7 @@ void extrudeGeometricProperties ) ); - //forAll(extrudePatch.edges(), edgeI) + // forAll(extrudePatch.edges(), edgeI) //{ // const edge& e = extrudePatch.edges()[edgeI]; // Pout<< "Edge:" << e.centre(extrudePatch.localPoints()) << nl @@ -1599,49 +1599,49 @@ int main(int argc, char *argv[]) //// Read objects in time directory - //IOobjectList objects(mesh, runTime.timeName()); + // IOobjectList objects(mesh, runTime.timeName()); // //// Read vol fields. // - //PtrList vsFlds; - //ReadFields(mesh, objects, vsFlds); + // PtrList vsFlds; + // ReadFields(mesh, objects, vsFlds); // - //PtrList vvFlds; - //ReadFields(mesh, objects, vvFlds); + // PtrList vvFlds; + // ReadFields(mesh, objects, vvFlds); // - //PtrList vstFlds; - //ReadFields(mesh, objects, vstFlds); + // PtrList vstFlds; + // ReadFields(mesh, objects, vstFlds); // - //PtrList vsymtFlds; - //ReadFields(mesh, objects, vsymtFlds); + // PtrList vsymtFlds; + // ReadFields(mesh, objects, vsymtFlds); // - //PtrList vtFlds; - //ReadFields(mesh, objects, vtFlds); + // PtrList vtFlds; + // ReadFields(mesh, objects, vtFlds); // //// Read surface fields. // - //PtrList ssFlds; - //ReadFields(mesh, objects, ssFlds); + // PtrList ssFlds; + // ReadFields(mesh, objects, ssFlds); // - //PtrList svFlds; - //ReadFields(mesh, objects, svFlds); + // PtrList svFlds; + // ReadFields(mesh, objects, svFlds); // - //PtrList sstFlds; - //ReadFields(mesh, objects, sstFlds); + // PtrList sstFlds; + // ReadFields(mesh, objects, sstFlds); // - //PtrList ssymtFlds; - //ReadFields(mesh, objects, ssymtFlds); + // PtrList ssymtFlds; + // ReadFields(mesh, objects, ssymtFlds); // - //PtrList stFlds; - //ReadFields(mesh, objects, stFlds); + // PtrList stFlds; + // ReadFields(mesh, objects, stFlds); // //// Read point fields. // - //PtrList psFlds; - //ReadFields(pointMesh::New(mesh), objects, psFlds); + // PtrList psFlds; + // ReadFields(pointMesh::New(mesh), objects, psFlds); // - //PtrList pvFlds; - //ReadFields(pointMesh::New(mesh), objects, pvFlds); + // PtrList pvFlds; + // ReadFields(pointMesh::New(mesh), objects, pvFlds); @@ -2136,12 +2136,12 @@ int main(int argc, char *argv[]) // << " name:" << newPatches[patchi]->name() // << endl; // } -// //label nOldPatches = mesh.boundary().size(); +// // label nOldPatches = mesh.boundary().size(); // mesh.clearOut(); // mesh.removeFvBoundary(); // mesh.addFvPatches(newPatches, true); // //// Add calculated fvPatchFields for the added patches -// //for +// // for // //( // // label patchi = nOldPatches; // // patchi < mesh.boundary().size(); @@ -2152,7 +2152,7 @@ int main(int argc, char *argv[]) // // << endl; // // addCalculatedPatchFields(mesh); // //} -// //Pout<< "** Added " << mesh.boundary().size()-nOldPatches +// // Pout<< "** Added " << mesh.boundary().size()-nOldPatches // // << " patches." << endl; // } @@ -2368,7 +2368,7 @@ int main(int argc, char *argv[]) vectorField firstDisp(localRegionNormals.size()); forAll(firstDisp, regionI) { - //const point& regionPt = regionCentres[regionI]; + // const point& regionPt = regionCentres[regionI]; const point& regionPt = extrudePatch.points() [ extrudePatch.meshPoints() @@ -2724,7 +2724,7 @@ int main(int argc, char *argv[]) } } - if (zoneShadowNames.size() > 0) //if there is a top faceZone specified + if (zoneShadowNames.size() > 0) // if there is a top faceZone specified { forAll(extrudeMeshFaces, zoneFacei) { @@ -2788,7 +2788,7 @@ int main(int argc, char *argv[]) true, // flip flux interMeshTopPatch[zoneI], // patch for face -1, // zone for face - false //face flip in zone + false // face flip in zone ); } } diff --git a/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMeshDict b/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMeshDict index 6587c8429..1022b1b76 100644 --- a/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMeshDict +++ b/applications/utilities/mesh/generation/extrude/extrudeToRegionMesh/extrudeToRegionMeshDict @@ -49,7 +49,7 @@ sampleMode nearestPatchFace; oneD false; //- If oneD: specify which boundary is wanted between the layers - //oneDPolyPatchType empty; //wedge + // oneDPolyPatchType empty; // wedge //- If oneD: specify whether to duplicate points (i.e. disconnect 1D // columns) or only on non-manifold extrusion areas. Default is false. diff --git a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C index 3f6f874ed..81cafeb3e 100644 --- a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C +++ b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.C @@ -88,7 +88,7 @@ Foam::extrude2DMesh::extrude2DMesh : mesh_(mesh), dict_(dict), - //patchDict_(dict.subDict("patchInfo")), + // patchDict_(dict.subDict("patchInfo")), model_(model), modelType_(dict.lookup("extrudeModel")), patchType_(dict.lookup("patchType")), @@ -209,11 +209,11 @@ void Foam::extrude2DMesh::setRefinement { meshMod.addCell ( - -1, //masterPointID, - -1, //masterEdgeID, - -1, //masterFaceID, - celli + offset, //masterCellID, - mesh_.cellZones().whichZone(celli) //zoneID + -1, // masterPointID, + -1, // masterEdgeID, + -1, // masterFaceID, + celli + offset, // masterCellID, + mesh_.cellZones().whichZone(celli) // zoneID ); } } diff --git a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.H b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.H index 99d69412c..0cc216e86 100644 --- a/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.H +++ b/applications/utilities/mesh/generation/extrude2DMesh/extrude2DMesh/extrude2DMesh/extrude2DMesh.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 @@ -68,7 +68,7 @@ class extrude2DMesh const dictionary dict_; - //const dictionary patchDict_; + // const dictionary patchDict_; const extrudeModel& model_; @@ -85,7 +85,7 @@ class extrude2DMesh void check2D() const; //- Find extrusion direction - //void findExtrudeDirection(); + // void findExtrudeDirection(); //- Disallow default bitwise copy construct extrude2DMesh(const extrude2DMesh&); diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C index 2952a9ef3..7889a6ea3 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.C @@ -1074,7 +1074,7 @@ bool Foam::backgroundMeshDecomposition::overlapsThisProcessor const scalar radiusSqr ) const { - //return bFTreePtr_().findAnyOverlap(centre, radiusSqr); + // return bFTreePtr_().findAnyOverlap(centre, radiusSqr); return bFTreePtr_().findNearest(centre, radiusSqr).hit(); } @@ -1448,7 +1448,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::overlapProcessors //// //// if (flagOverlap) //// { -//// //if (vertexOctree.findAnyOverlap(c, rSqr)) +//// // if (vertexOctree.findAnyOverlap(c, rSqr)) ////// if (vertexOctree.findNearest(c, rSqr*1.001).hit()) ////// { ////// sphereOverlapsCandidate[sI] = true; @@ -1565,7 +1565,7 @@ Foam::labelList Foam::backgroundMeshDecomposition::overlapProcessors // // if (flagOverlap) // { -// //if (vertexOctree.findAnyOverlap(c, rSqr)) +// // if (vertexOctree.findAnyOverlap(c, rSqr)) //// if (vertexOctree.findNearest(c, rSqr*1.001).hit()) //// { //// sphereOverlapsCandidate[sI] = true; diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.H b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.H index ac374452b..2f180ec85 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.H +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/backgroundMeshDecomposition/backgroundMeshDecomposition.H @@ -95,7 +95,7 @@ class backgroundMeshDecomposition // Private data //- Method details dictionary - //dictionary coeffsDict_; + // dictionary coeffsDict_; //- Reference to runtime const Time& runTime_; 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 cb9d3a1ce..50ee7d788 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControlMesh/cellShapeControlMesh.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellShapeControlMesh/cellShapeControlMesh.C @@ -142,7 +142,7 @@ word cellShapeControlMesh::meshSubDir = "cellShapeControlMesh"; // } // } // -// //external spoke +// // external spoke // // Foam::point mirrorPt = pt + 2*d; // @@ -769,17 +769,17 @@ Foam::label Foam::cellShapeControlMesh::estimateCellCount scalar volume = CGAL::to_double(tet.volume()); scalar averagedPointCellSize = 0; - //scalar averagedPointCellSize = 1; + // scalar averagedPointCellSize = 1; // Get an average volume by averaging the cell size of the vertices for (label vI = 0; vI < 4; ++vI) { averagedPointCellSize += cit->vertex(vI)->targetCellSize(); - //averagedPointCellSize *= cit->vertex(vI)->targetCellSize(); + // averagedPointCellSize *= cit->vertex(vI)->targetCellSize(); } averagedPointCellSize /= 4; - //averagedPointCellSize = ::sqrt(averagedPointCellSize); + // averagedPointCellSize = ::sqrt(averagedPointCellSize); // if (averagedPointCellSize < small) // { diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/fileControl/fileControl.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/fileControl/fileControl.C index 8f8aac17e..d6f45f75d 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/fileControl/fileControl.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/cellSizeAndAlignmentControl/fileControl/fileControl.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 @@ -122,7 +122,7 @@ Foam::fileControl::~fileControl() // tensor alignment = Zero; // forAll(bary, pI) // { -// //alignment += bary[pI]*ch->vertex(pI)->alignment(); +// // alignment += bary[pI]*ch->vertex(pI)->alignment(); // // // Find nearest point // if (bary[pI] > nearest) 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 0177db130..8bd3d64a2 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/controlMeshRefinement/controlMeshRefinement.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/cellShapeControl/controlMeshRefinement/controlMeshRefinement.C @@ -429,7 +429,7 @@ void Foam::controlMeshRefinement::initialMeshPopulation } } - //mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end()); + // mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end()); Info<< " Inserted " << returnReduce @@ -623,7 +623,7 @@ void Foam::controlMeshRefinement::initialMeshPopulation } } - //mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end()); + // mesh_.rangeInsertWithInfo(vertices.begin(), vertices.end()); Info<< " Inserted extra points " << returnReduce 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 e884aa523..954cd5d8b 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 @@ -272,7 +272,7 @@ Foam::tmp Foam::automatic::load() } } - //smoothField(surfaceCellSize); + // smoothField(surfaceCellSize); pointCellSize.write(); diff --git a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C index eb732e6be..34b176206 100644 --- a/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C +++ b/applications/utilities/mesh/generation/foamyMesh/conformalVoronoiMesh/conformalVoronoiMesh/conformalVoronoiMesh.C @@ -530,7 +530,7 @@ void Foam::conformalVoronoiMesh::buildCellSizeAndAlignmentMesh() for (label i = 0; i < nMaxIter; ++i) { label nAdded = meshRefinement.refineMesh(decomposition_); - //cellShapeControl_.refineMesh(decomposition_); + // cellShapeControl_.refineMesh(decomposition_); reduce(nAdded, sumOp