Go to the source code of this file.
Classes | |
class | messageStream |
Class to handle messaging in a simple, consistent stream-based manner. More... | |
Namespaces | |
Foam | |
Namespace for OpenFOAM. | |
Macros | |
#define | FUNCTION_NAME __func__ |
#define | SeriousErrorIn(functionName) ::Foam::SeriousError((functionName), __FILE__, __LINE__) |
Report an error message using Foam::SeriousError. More... | |
#define | SeriousErrorInFunction SeriousErrorIn(FUNCTION_NAME) |
Report an error message using Foam::SeriousError. More... | |
#define | SeriousIOErrorIn(functionName, ios) ::Foam::SeriousError((functionName), __FILE__, __LINE__, ios) |
Report an IO error message using Foam::SeriousError. More... | |
#define | SeriousIOErrorInFunction(ios) SeriousIOErrorIn(FUNCTION_NAME, ios) |
Report an IO error message using Foam::SeriousError. More... | |
#define | WarningIn(functionName) ::Foam::Warning((functionName), __FILE__, __LINE__) |
Report a warning using Foam::Warning. More... | |
#define | WarningInFunction WarningIn(FUNCTION_NAME) |
Report a warning using Foam::Warning. More... | |
#define | IOWarningIn(functionName, ios) ::Foam::Warning((functionName), __FILE__, __LINE__, (ios)) |
Report an IO warning using Foam::Warning. More... | |
#define | IOWarningInFunction(ios) IOWarningIn(FUNCTION_NAME, ios) |
Report an IO warning using Foam::Warning. More... | |
#define | InfoIn(functionName) ::Foam::Info((functionName), __FILE__, __LINE__) |
Report an information message using Foam::Info. More... | |
#define | InfoInFunction InfoIn(FUNCTION_NAME) |
Report an information message using Foam::Info. More... | |
#define | InfoHeader if (::Foam::writeInfoHeader) Info |
Report write to Foam::Info if the local log switch is true. More... | |
#define | Log if (log) Info |
Report write to Foam::Info if the local log switch is true. More... | |
#define | IOInfoIn(functionName, ios) ::Foam::Info((functionName), __FILE__, __LINE__, (ios)) |
Report an IO information message using Foam::Info. More... | |
#define | IOInfoInFunction(ios) IOInfoIn(FUNCTION_NAME, ios) |
Report an IO information message using Foam::Info. More... | |
#define | DebugInfo if (debug) Info |
Report an information message using Foam::Info. More... | |
#define | DebugInFunction if (debug) InfoInFunction |
Report an information message using Foam::Info. More... | |
#define | DebugVar(var) |
Report a variable name and value. More... | |
Variables | |
messageStream | SeriousError |
messageStream | Warning |
messageStream | Info |
bool | writeInfoHeader = true |
Original source file messageStream.H
Definition in file messageStream.H.
#define FUNCTION_NAME __func__ |
Definition at line 218 of file messageStream.H.
Referenced by Foam::chMod(), Foam::cp(), Foam::exists(), Foam::fileSize(), fvMesh::fvMesh(), Foam::highResLastModified(), particle::hitFace(), Foam::isDir(), Foam::isFile(), Foam::lastModified(), Foam::ln(), fvMesh::mapFields(), Foam::mkDir(), Foam::mode(), Foam::mv(), Foam::mvBak(), Foam::operator<<(), masterUncollatedFileOperation::readAndSend(), Foam::readDir(), fvMesh::readUpdate(), fvMesh::removeFvBoundary(), Foam::rm(), Foam::rmDir(), sampledSetParticle::sampledSetParticle(), particle::track(), particle::trackToAndHitFace(), particle::trackToCell(), particle::trackToFace(), and Foam::type().
#define SeriousErrorIn | ( | functionName | ) | ::Foam::SeriousError((functionName), __FILE__, __LINE__) |
Report an error message using Foam::SeriousError.
for functionName in file __FILE__ at line __LINE__
Definition at line 224 of file messageStream.H.
#define SeriousErrorInFunction SeriousErrorIn(FUNCTION_NAME) |
Report an error message using Foam::SeriousError.
for FUNCTION_NAME in file __FILE__ at line __LINE__
Definition at line 229 of file messageStream.H.
Referenced by zone::checkDefinition(), Foam::polyMeshCheck::checkFaceDotProduct(), Foam::polyMeshCheck::checkFacePyramids(), Foam::polyMeshCheck::checkFaceTets(), Foam::operator<<(), coupledPolyPatch::order(), and regIOobject::writeObject().
#define SeriousIOErrorIn | ( | functionName, | |
ios | |||
) | ::Foam::SeriousError((functionName), __FILE__, __LINE__, ios) |
Report an IO error message using Foam::SeriousError.
for functionName in file __FILE__ at line __LINE__ for a particular IOstream
Definition at line 235 of file messageStream.H.
#define SeriousIOErrorInFunction | ( | ios | ) | SeriousIOErrorIn(FUNCTION_NAME, ios) |
Report an IO error message using Foam::SeriousError.
for FUNCTION_NAME in file __FILE__ at line __LINE__ for a particular IOstream
Definition at line 241 of file messageStream.H.
Referenced by IOobject::readHeader().
#define WarningIn | ( | functionName | ) | ::Foam::Warning((functionName), __FILE__, __LINE__) |
Report a warning using Foam::Warning.
for functionName in file __FILE__ at line __LINE__
Definition at line 246 of file messageStream.H.
Referenced by fvMeshAdder::MapDimFields(), and refinementHistory::refinementHistory().
#define WarningInFunction WarningIn(FUNCTION_NAME) |
Report a warning using Foam::Warning.
for FUNCTION_NAME in file __FILE__ at line __LINE__
Definition at line 251 of file messageStream.H.
Referenced by polyTopoChange::addMesh(), faceZoneSet::addSet(), massSource::addsSupToField(), fileMonitor::addWatch(), manualGAMGProcAgglomeration::agglomerate(), faceZoneToFaceZone::applyToSet(), setToCellZone::applyToSet(), setToPointZone::applyToSet(), setToFaceZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), searchableSurfaceToFaceZone::applyToSet(), setsToFaceZone::applyToSet(), fieldToCell::applyToSet(), planeToFaceZone::applyToSet(), patchFluxToFace::applyToSet(), ash::ash(), Foam::average(), bufferedAccumulator< scalar >::averaged(), booleanSurface::booleanSurface(), C::C(), CaCO3::CaCO3(), Foam::meshTools::calcBoxPointNormals(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), forces::calcForcesMoment(), wedgePolyPatch::calcGeometry(), mappedPatchBase::calcMapping(), snappySnapDriver::calcNearestSurface(), addPatchCellLayer::calcSidePatch(), ThermoParcel< ParcelType >::calcSurfaceValues(), LiquidEvaporation< CloudType >::calculate(), LiquidEvaporationBoil< CloudType >::calculate(), COxidationMurphyShaddix< CloudType >::calculate(), ReactingParcel< ParcelType >::cellValueSourceCorrection(), ThermoParcel< ParcelType >::cellValueSourceCorrection(), cellModel::centre(), faceZone::checkAddressing(), Foam::polyMeshCheck::checkCellDeterminant(), meshRefinement::checkData(), zone::checkDefinition(), triSurface::checkEdges(), Foam::polyMeshCheck::checkFaceAngles(), Foam::polyMeshCheck::checkFaceArea(), Foam::polyMeshCheck::checkFaceFlatness(), MeshedSurface< Foam::face >::checkFaces(), Foam::polyMeshCheck::checkFaceSkewness(), Foam::polyMeshCheck::checkFaceTwist(), Foam::polyMeshCheck::checkFaceWeights(), regIOobject::checkIn(), edgeCollapser::checkMeshQuality(), Foam::polyMeshCheck::checkNonOrtho(), objectRegistry::checkOut(), AMIMethod::checkPatches(), enrichedPatch::checkSupport(), triSurface::checkTriangles(), Foam::polyMeshCheck::checkTriangleTwist(), Foam::polyMeshCheck::checkVolRatio(), MeshedSurface< Foam::face >::checkZones(), surfMesh::checkZones(), dlLibraryTable::close(), collatedFileOperation::collatedFileOperation(), IOstream::compressionEnum(), ConstantRateDevolatilisation< CloudType >::ConstantRateDevolatilisation(), waxSolventEvaporation::correctModel(), hexCellLooper::cut(), cuttingPlane::cuttingPlane(), structuredDecomp::decompose(), decomposedBlockData::decomposedBlockData(), Cloud< passiveParticle >::deleteLostParticles(), faceZoneSet::deleteSet(), directions::directions(), distanceSurface::distanceSurface(), Foam::dlOpen(), Foam::dlSym(), snappyLayerDriver::doLayers(), snappySnapDriver::doSnap(), Foam::eigenValues(), SpalartAllmaras< BasicMomentumTransportModel >::epsilon(), hexRef8::faceLevel(), tetIndices::faceTriIs(), extendedEdgeMesh::featurePointNormals(), logFiles::file(), fileMonitorWatcher::fileMonitorWatcher(), IOobject::fileNameComponents(), fileOperation::filePath(), probes::findElements(), patchProbes::findElements(), indexedOctree< Foam::treeDataFace >::findLine(), polyTopoChanger::findModifierID(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::findNearest(), IOstream::formatEnum(), Foam::gAverage(), objectRegistry::getEvent(), DelaunayMesh< CellSizeDelaunay >::getNewCellIndex(), particle::getNewParticleID(), DelaunayMesh< CellSizeDelaunay >::getNewVertexIndex(), polyBoundaryMesh::groupPatchIDs(), particle::hitCyclicAMIPatch(), AMIMethod::initialise(), faceAreaWeightAMI::interArea(), IOdistributionMap::IOdistributionMap(), CompositionModel< Foam::ThermoCloud< CloudType > >::L(), lduPrimitiveMesh::lduPrimitiveMesh(), janafThermo< EquationOfState >::limit(), LiquidEvaporation< CloudType >::LiquidEvaporation(), LiquidEvaporationBoil< CloudType >::LiquidEvaporationBoil(), Foam::ln(), cellModel::mag(), fvMeshAdder::MapPointFields(), fvMeshAdder::MapSurfaceFields(), fvMeshAdder::MapVolFields(), masterUncollatedFileOperation::masterUncollatedFileOperation(), meshRefinement::mergeBaffles(), meshToMesh0::meshToMesh0(), motionSmootherAlgo::modifyMotionPoints(), wallDist::n(), NamedEnum< compressibleField, 8 >::names(), polyBoundaryMesh::nbrEdges(), cyclicAMIPolyPatch::nbrPatchID(), cyclicPolyPatch::nbrPatchID(), sootModel::New(), combustionModel::New(), cellCuts::nonAnchorPoints(), fileOperation::nProcs(), SpalartAllmaras< BasicMomentumTransportModel >::omega(), dlLibraryTable::open(), listPlusEqOp< T >::operator()(), Time::operator++(), lduMatrix::operator+=(), lduMatrix::operator-=(), Foam::operator<<(), InflationInjection< CloudType >::parcelsToInject(), ParticleErosion< CloudType >::ParticleErosion(), patchInteractionDataList::patchInteractionDataList(), PatchPostProcessing< CloudType >::PatchPostProcessing(), polyBoundaryMesh::patchSet(), polyBoundaryMesh::polyBoundaryMesh(), polyMesh::polyMesh(), Foam::polyMeshZipUpCells(), Polynomial< Type >::Polynomial(), turbulenceFields::processField(), processorCyclicFvPatchField< Type >::processorCyclicFvPatchField(), fileOperation::processorsPath(), liquidMixtureProperties::pvInvert(), liquidProperties::pvInvert(), AC3DsurfaceFormat< Face >::read(), Fickian< unityLewisFourier< laminarThermophysicalTransportModel > >::read(), wallHeatFlux::read(), systemCall::read(), wallShearStress::read(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::read(), wallHeatTransferCoeff::read(), layerAverage::read(), probes::read(), pressure::read(), damping::readCoeffs(), Time::readDict(), surfMesh::readUpdate(), Foam::readUpto(), refinementHistory::refinementHistory(), kOmegaSSTLM< BasicMomentumTransportModel >::ReThetat0(), Foam::reusable(), Foam::rmDir(), timeSelector::select0(), InteractionLists< typename CloudType::parcelType >::sendReferredData(), cellSizeFunction::setCellSize(), ReactingParcel< ParcelType >::setCellValues(), ThermoParcel< ParcelType >::setCellValues(), MomentumParcel< ParcelType >::setCellValues(), Time::setControls(), removeCells::setRefinement(), refinementIterator::setRefinement(), perfectInterface::setRefinement(), meshCutter::setRefinement(), sigmaRadial::sigmaRadial(), SingleKineticRateDevolatilisation< CloudType >::SingleKineticRateDevolatilisation(), seulex::solve(), PatchTools::sortedPointEdges(), splineInterpolationWeights::splineInterpolationWeights(), meshRefinement::splitMesh(), meshRefinement::splitMeshRegions(), regionFunctionObject::store(), faceZoneSet::subset(), hexRef8::subset(), surfaceIntersection::surfaceIntersection(), surfacePatchIOList::surfacePatchIOList(), faceZoneSet::sync(), TAB< CloudType >::TAB(), polyMesh::tetBasePtIs(), thresholdCellFaces::thresholdCellFaces(), CellZoneInjection< CloudType >::topoChange(), distribution::totalEntries(), particle::trackToFace(), triSurfaceSearch::tree(), treeBoundBox::treeBoundBox(), IOobject::typeHeaderOk(), inclinedFilmNusseltHeightFvPatchScalarField::updateCoeffs(), inclinedFilmNusseltInletVelocityFvPatchVectorField::updateCoeffs(), edgeVertex::updateLabels(), fileMonitor::updateStates(), IOobject::warnNoRereading(), graph::write(), surfaceFieldValue::write(), dictionary::write(), CompactIOList< face, label >::writeObject(), absorptionCoeffs::~absorptionCoeffs(), dlLibraryTable::~dlLibraryTable(), and fileMonitorWatcher::~fileMonitorWatcher().
#define IOWarningIn | ( | functionName, | |
ios | |||
) | ::Foam::Warning((functionName), __FILE__, __LINE__, (ios)) |
Report an IO warning using Foam::Warning.
for functionName in file __FILE__ at line __LINE__ for a particular IOstream
Definition at line 257 of file messageStream.H.
#define IOWarningInFunction | ( | ios | ) | IOWarningIn(FUNCTION_NAME, ios) |
Report an IO warning using Foam::Warning.
for FUNCTION_NAME in file __FILE__ at line __LINE__ for a particular IOstream
Definition at line 263 of file messageStream.H.
Referenced by preserveBafflesConstraint::add(), dictionary::add(), dictionary::changeKeyword(), regIOobject::headerOk(), layerParameters::layerParameters(), dictionary::lookupEntryPtrBackwardsCompatible(), NamedEnum< compressibleField, 8 >::names(), Function1< Foam::Vector2D >::New(), plane::plane(), timeControl::read(), cloudSolution::read(), functionObjectList::read(), Time::readDict(), IOobject::readHeader(), mappedPatchBase::readListOrField(), Maxwell< BasicMomentumTransportModel >::readModeCoefficients(), refinementRegions::refinementRegions(), refinementSurfaces::refinementSurfaces(), Time::setControls(), surfaceZonesInfo::surfaceZonesInfo(), Time::Time(), and wedge::wedge().
#define InfoIn | ( | functionName | ) | ::Foam::Info((functionName), __FILE__, __LINE__) |
Report an information message using Foam::Info.
for functionName in file __FILE__ at line __LINE__
Definition at line 268 of file messageStream.H.
#define InfoInFunction InfoIn(FUNCTION_NAME) |
Report an information message using Foam::Info.
for FUNCTION_NAME in file __FILE__ at line __LINE__
Definition at line 273 of file messageStream.H.
Referenced by nearWallFields::calcAddressing(), faceZone::calcCellLayers(), faceZone::calcFaceZonePatch(), zone::calcLookupMap(), viewFactor::calculate(), MeshedSurfaceProxy< Face >::canWriteType(), CentredFitData< Polynomial >::CentredFitData(), CentredFitSnGradData< Polynomial >::CentredFitSnGradData(), primitiveMesh::checkCellsZipUp(), primitiveMesh::checkCellVolumes(), primitiveMesh::checkClosedBoundary(), primitiveMesh::checkClosedCells(), primitiveMesh::checkConcaveCells(), primitiveMesh::checkFaceAngles(), primitiveMesh::checkFaceAreas(), primitiveMesh::checkFaceFaces(), primitiveMesh::checkFaceFlatness(), primitiveMesh::checkFaceOrthogonality(), primitiveMesh::checkFacePyramids(), primitiveMesh::checkFaceSkewness(), primitiveMesh::checkFaceVertices(), primitiveMesh::checkMesh(), primitiveMesh::checkPoints(), PrimitivePatch< IndirectList< face >, const pointField & >::checkTopology(), primitiveMesh::checkUpperTriangular(), surfMesh::clearAddressing(), polyMesh::clearAddressing(), polyMesh::clearCellTree(), surfMesh::clearGeom(), PrimitivePatch< IndirectList< face >, const pointField & >::clearGeom(), polyMesh::clearGeom(), PrimitivePatch< IndirectList< face >, const pointField & >::clearPatchMeshAddr(), polyMesh::clearTetBasePtIs(), PrimitivePatch< IndirectList< face >, const pointField & >::clearTopology(), dlLibraryTable::close(), vtkPVFoam::convertVolInternalField(), hePsiThermo< BasicPsiThermo, MixtureType >::correct(), heRhoThermo< BasicRhoThermo, MixtureType >::correct(), heSolidThermo< BasicSolidThermo, MixtureType >::correct(), heheuPsiThermo< BasicPsiThermo, MixtureType >::correct(), phaseStabilisedSnGrad< Type >::correction(), limitedSnGrad< Type >::correction(), Foam::cp(), fvMesh::delta(), distributedTriSurfaceMesh::distribute(), distributedTriSurfaceMesh::distributedTriSurfaceMesh(), ListHashTable< T, Key, Hash >::erase(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::evaluate(), ListHashTable< T, Key, Hash >::find(), HashTable< Foam::phase *>::find(), patchProbes::findElements(), fileOperation::findInstance(), mappedPatchBase::findSamples(), MeshZones< cellZone, polyMesh >::findZoneID(), ListHashTable< T, Key, Hash >::found(), HashTable< Foam::phase *>::found(), ddtScheme< Type >::fvcDdtPhiCoeff(), fvMatrix< Type >::fvMatrix(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::GeometricBoundaryField(), GeometricField< vector, pointPatchField, pointMesh >::GeometricField(), IFstream::IFstream(), interpolationCellPointFace< Type >::interpolate(), surfaceInterpolationScheme< GType >::interpolate(), IOobject::IOobject(), IOobjectList::lookup(), IOobjectList::lookupClass(), PrimitivePatch< IndirectList< face >, const pointField & >::meshEdges(), polyMesh::movePoints(), fileOperationInitialise::New(), optionalCpuLoad::New(), blockVertex::New(), interpolationWeights::New(), thermophysicalProperties::New(), snGradScheme< Type >::New(), blockFace::New(), gradScheme< Type >::New(), ddtScheme< Type >::New(), surfaceInterpolationScheme< GType >::New(), d2dt2Scheme< Type >::New(), divScheme< Type >::New(), GAMGProcAgglomeration::New(), fvPatch::New(), blockEdge::New(), solidProperties::New(), facePointPatch::New(), polyMeshModifier::New(), convectionScheme< Type >::New(), multivariateSurfaceInterpolationScheme< Type >::New(), block::New(), limitedSurfaceInterpolationScheme< scalar >::New(), liquidProperties::New(), laplacianScheme< Type, GType >::New(), cellZone::New(), pointZone::New(), coordinateSystem::New(), UnsortedMeshedSurface< Face >::New(), pointPatchField< vector >::New(), faceZone::New(), MeshedSurface< Foam::face >::New(), fvsPatchField< Type >::New(), fvPatchField< Type >::New(), polyPatch::New(), OFstream::OFstream(), dlLibraryTable::open(), dictionary::read(), Foam::readDir(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::readField(), uncollatedFileOperation::readHeader(), IOobject::readHeader(), regIOobject::readHeaderOk(), surfMesh::readUpdate(), polyMesh::readUpdate(), fvMatrix< Type >::relax(), GeometricField< vector, pointPatchField, pointMesh >::relax(), polyMesh::removeBoundary(), surfMesh::removeZones(), ListHashTable< T, Key, Hash >::resize(), HashTable< Foam::phase *>::resize(), searchablePlate::searchablePlate(), IOobject::setBad(), surfMesh::setInstance(), polyMesh::setInstance(), polyMesh::setPoints(), polyMesh::setPointsInstance(), HashTable< Foam::phase *>::sortedToc(), MeshedSurface< Foam::face >::stitchFaces(), GeometricField< vector, pointPatchField, pointMesh >::storeOldTime(), GeometricField< vector, pointPatchField, pointMesh >::storePrevIter(), PrimitivePatch< IndirectList< face >, const pointField & >::surfaceType(), thermo< Thermo, Type >::T(), timer::timer(), ListHashTable< T, Key, Hash >::toc(), polyMesh::topoChange(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::updateCoeffs(), UpwindFitData< Polynomial >::UpwindFitData(), fvMesh::V(), fvMesh::V00(), wallLayerCells::wallLayerCells(), ParticleTracks< CloudType >::write(), MeshedSurfaceProxy< Face >::write(), edgeMesh::write(), UnsortedMeshedSurface< Face >::write(), MeshedSurface< Foam::face >::write(), IOobject::writeHeader(), dlLibraryTable::~dlLibraryTable(), fvMatrix< Type >::~fvMatrix(), leastSquaresVectors::~leastSquaresVectors(), LeastSquaresVectors< Stencil >::~LeastSquaresVectors(), skewCorrectionVectors::~skewCorrectionVectors(), and timer::~timer().
#define InfoHeader if (::Foam::writeInfoHeader) Info |
Report write to Foam::Info if the local log switch is true.
Definition at line 276 of file messageStream.H.
Referenced by collatedFileOperation::collatedFileOperation(), masterUncollatedFileOperation::masterUncollatedFileOperation(), and uncollatedFileOperation::uncollatedFileOperation().
#define Log if (log) Info |
Report write to Foam::Info if the local log switch is true.
Definition at line 280 of file messageStream.H.
Referenced by fieldAverage::addMeanFieldType(), fieldAverage::addPrime2MeanFieldType(), fieldAverage::calcAverages(), nearWallFields::createFields(), nearWallFields::execute(), fieldCoordinateSystemTransform::fieldCoordinateSystemTransform(), readFields::loadField(), NamedEnum< compressibleField, 8 >::names(), nearWallFields::read(), fieldAverage::read(), forces::read(), fieldAverage::readAveragingProperties(), fieldAverage::restart(), XiReactionRate::write(), writeCellVolumes::write(), writeCellCentres::write(), turbulenceIntensity::write(), yPlus::write(), wallHeatFlux::write(), histogram::write(), fieldValue::write(), wallShearStress::write(), wallHeatTransferCoeff::write(), writeObjects::write(), fieldValueDelta::write(), nearWallFields::write(), forceCoeffs::write(), forces::write(), volFieldValue::write(), surfaceFieldValue::write(), fieldAverage::writeAverages(), fieldAverage::writeAveragingProperties(), forces::writeForces(), regionFunctionObject::writeObject(), volFieldValue::writeValues(), and surfaceFieldValue::writeValues().
#define IOInfoIn | ( | functionName, | |
ios | |||
) | ::Foam::Info((functionName), __FILE__, __LINE__, (ios)) |
Report an IO information message using Foam::Info.
for functionName in file __FILE__ at line __LINE__ for a particular IOstream
Definition at line 287 of file messageStream.H.
#define IOInfoInFunction | ( | ios | ) | IOInfoIn(FUNCTION_NAME, ios) |
Report an IO information message using Foam::Info.
for FUNCTION_NAME in file __FILE__ at line __LINE__ for a particular IOstream
Definition at line 293 of file messageStream.H.
Referenced by dictionary::lookupOrAddDefault(), dictionary::lookupOrDefault(), and dictionary::readIfPresent().
#define DebugInfo if (debug) Info |
Report an information message using Foam::Info.
if the local debug switch is true
Definition at line 298 of file messageStream.H.
Referenced by rigidBodyModel::applyRestraints(), rigidBodyModel::forwardDynamics(), rigidBodyModel::forwardDynamicsCorrection(), readFields::loadField(), probes::mapMesh(), probes::movePoints(), probes::topoChange(), and fieldCoordinateSystemTransform::transform().
#define DebugInFunction if (debug) InfoInFunction |
Report an information message using Foam::Info.
for FUNCTION_NAME in file __FILE__ at line __LINE__ if the local debug switch is true
Definition at line 304 of file messageStream.H.
Referenced by thermoSingleLayer::addSources(), kinematicSingleLayer::addSources(), nearWallFields::calcAddressing(), kinematicSingleLayer::constrainFilmField(), thermoSingleLayer::evolveRegion(), kinematicSingleLayer::evolveRegion(), nearWallFields::execute(), rigidBodyModel::forwardDynamics(), rigidBodyModel::forwardDynamicsCorrection(), kinematicSingleLayer::predictDelta(), thermoSingleLayer::preEvolveRegion(), kinematicSingleLayer::preEvolveRegion(), thermoSingleLayer::resetPrimaryRegionSourceTerms(), kinematicSingleLayer::resetPrimaryRegionSourceTerms(), kinematicSingleLayer::solveAlpha(), thermalBaffle::solveEnergy(), thermoSingleLayer::solveEnergy(), kinematicSingleLayer::solveMomentum(), thermoSingleLayer::transferPrimaryRegionSourceFields(), kinematicSingleLayer::transferPrimaryRegionSourceFields(), thermoSingleLayer::transferPrimaryRegionThermoFields(), kinematicSingleLayer::transferPrimaryRegionThermoFields(), multiMotion::transformation(), linearMotion::transformation(), oscillatingLinearMotion::transformation(), axisRotationMotion::transformation(), oscillatingRotatingMotion::transformation(), rotatingMotion::transformation(), sixDoFMotion::transformation(), SDA::transformation(), thermoSingleLayer::updateSubmodels(), kinematicSingleLayer::updateSubmodels(), nearWallFields::write(), and nearWallFields::~nearWallFields().
#define DebugVar | ( | var | ) |
Report a variable name and value.
using Foam::Pout in file __FILE__ at line __LINE__
Definition at line 309 of file messageStream.H.