LArSoft  v07_13_02
Liquid Argon Software toolkit - http://larsoft.org/
plot.C File Reference

Go to the source code of this file.

Functions

gStyle SetPalette (1)
 
gROOT SetStyle ("Plain")
 
gStyle SetOptStat (00000)
 
 if (fp)
 
c1 cd (1)
 
ntuple Draw ("y>>hfy","","")
 
hfy Scale (1./(hfy->GetEntries()*hfy->GetBinWidth(1)))
 
hfy SetTitle ("f(y) (um/keV)")
 
hfy GetXaxis () -> SetTitle("y (keV/um)")
 
hfy SetFillColor (1)
 
hfy Draw ("")
 
 for (Int_t j=0;j< hfy->GetNbinsX();j++) norm =normLogfy+(log(10)/B)*hlogyfy->GetBinContent(j)
 
cout<< endl;cout<< "**** I - Results from lin-lin histograms ****"<< endl;cout<< endl;cout<< "---> sum of f (hdy->SetTitle("d() (um/keV)") y)
 
axis Set (bins, new_bins)
 
ntuple SetBranchAddress ("radius",&radius)
 
ntuple SetBranchAddress ("y",&y)
 
ntuple SetBranchAddress ("z",&z)
 
 for (Int_t i=0;i< nentries;i++)
 
hlogyfy Scale (1./(hlogyfy->GetEntries()))
 
hlogy2fy Scale (1./(hlogy2fy->GetEntries()))
 
hlogydy Scale (1./(hlogydy->GetEntries()))
 
hlogy3fy Scale (1./(hlogy3fy->GetEntries()))
 
gPad SetLogx ()
 
hlogyfy SetLineColor (2)
 
hlogyfy SetFillColor (2)
 
hlogyfy SetTitle ("y*f(y)")
 
cout<< "---> sum of Log f (y)
 

Variables

Int_t B =1000
 
Int_t min =-2
 
Int_t max =2
 
FILE * fp = fopen("yz.root","r")
 
 else
 
cout<< "*** it will be created from merged ROOT files ***"<< endl;system("rm -rf yz.root");system("hadd yz.root yz_*.root");}c1=new TCanvas("c1","", 60, 60, 800, 600);c1.Divide(3, 2);TFile f("yz.root");TNtuple *ntuple;ntuple=(TNtuple *) f-> Get ("yz")
 
Double_t norm =0
 
delete new_bins
 
Double_t radius
 
Double_t y
 
Double_t z
 
Int_t nentries = (Int_t)ntuple->GetEntries()
 
Double_t normLogfy =0
 
Double_t logyF =0
 

Function Documentation

c1 cd ( )
ntuple Draw ( "y>>hfy"  ,
""  ,
""   
)
hfy Draw ( ""  )
cout<< endl;cout << "**** I - Results from lin-lin histograms ****" << endl;cout << endl;cout << "---> sum of f ( hdy->SetTitle("d() (um/keV)")  y)

Definition at line 91 of file plot.C.

202 {
203  new_bins[i] = TMath::Power(10, from + i * width);
204 }
delete new_bins
Definition: plot.C:211
cout<< "---> sum of Log f ( y  )

Definition at line 286 of file plot.C.

292 {
293  hlogy2fy->SetBinContent(i,
294 //(log(10)/B)*
295 hlogy2fy->GetBinCenter(i)
296 *hlogy2fy->GetBinCenter(i)
297 *hlogy2fy->GetBinContent(i)
298 /(TMath::Power(10, from + (i+1) * width)-TMath::Power(10, from + i * width))
299 );
300 }
for ( Int_t  j = 0;j< hfy->GetNbinsX();j++) =normLogfy+(log(10)/B)*hlogyfy->GetBinContent(j)

Definition at line 263 of file plot.C.

264 {
265  hlogyfy->SetBinContent(i,
266 //(log(10)/B)*
267 hlogyfy->GetBinCenter(i)
268 *hlogyfy->GetBinContent(i)
269 /(TMath::Power(10, from + (i+1) * width)-TMath::Power(10, from + i * width))
270 );
271 }
for ( )

Definition at line 241 of file plot.C.

242 {
243  ntuple->GetEntry(i);
244  hlogyfy->Fill(y);
245  hlogy2fy->Fill(y);
246  hlogydy->Fill(y);
247  hlogy3fy->Fill(y);
248 
249 }
Double_t y
Definition: plot.C:279
TNtuple * ntuple
Definition: plot.C:20
hfy GetXaxis ( ) -> SetTitle("y (keV/um)")
if ( fp  )

Definition at line 31 of file plot.C.

References fclose().

31  {
32  // exists
33  cout << "*** Notice: the output file yz.root exists ***"<< endl;
34  fclose(fp);
35 } else {
FILE * fp
Definition: plot.C:36
fclose(fp)
hfy Scale ( 1./  hfy->GetEntries()*hfy->GetBinWidth(1))
hlogyfy Scale ( 1./  hlogyfy->GetEntries())
hlogy2fy Scale ( 1./  hlogy2fy->GetEntries())
hlogydy Scale ( 1./  hlogydy->GetEntries())
hlogy3fy Scale ( 1./  hlogy3fy->GetEntries())
axis4 Set ( bins  ,
new_bins   
)
ntuple SetBranchAddress ( "radius"  ,
radius 
)
ntuple SetBranchAddress ( "y"  ,
y 
)
ntuple SetBranchAddress ( "z"  ,
z 
)
hfy SetFillColor ( )
hlogyfy SetFillColor ( )
hlogyfy SetLineColor ( )
gPad SetLogx ( )
gStyle SetOptStat ( 00000  )
gStyle SetPalette ( )
gROOT SetStyle ( "Plain"  )
hfy SetTitle ( "f(y) (um/keV)"  )
hlogyfy SetTitle ( "y*f(y)"  )

Variable Documentation

else
Initial value:
{
cout << "*** Notice: the output file yz.root does not exist ***"<< endl

Definition at line 35 of file plot.C.

FILE* fp = fopen("yz.root","r")

Definition at line 30 of file plot.C.

cout<< "*** it will be created from merged ROOT files ***"<< endl; system ("rm -rf yz.root"); system ("hadd yz.root yz_*.root");}c1 = new TCanvas ("c1","",60,60,800,600);c1.Divide(3,2);TFile f("yz.root"); TNtuple* ntuple;ntuple = (TNtuple*)f-> Get("yz")

Definition at line 66 of file plot.C.

Double_t logyF =0

Definition at line 302 of file plot.C.

Int_t max =2

Definition at line 27 of file plot.C.

Referenced by geoalgo::GeoAlgo::_Clamp_(), geoalgo::GeoAlgo::_ClosestPt_(), mvapid::MVAAlg::_Var_Shape(), opdet::AddHitToFlash(), lar_content::CheatingNeutrinoCreationAlgorithm::AddNeutrinoVertex(), cluster::HoughTransform::AddPointReturnMax(), geo::details::ActiveAreaCalculator::adjustCorners(), lar_pandora::PFParticleMonitoring::analyze(), caldata::CalWireAna::analyze(), lar::example::AnalysisExample::analyze(), trkf::TrackAna::anaStitch(), lar::util::simple_geo::Area< Point >::Area(), lar::util::simple_geo::AreaBase< Point >::AreaBase(), lar_content::DeltaRayMatchingAlgorithm::AreClustersMatched(), lar_cluster3d::MinSpanTreeAlg::AStar(), lar_content::RPhiFeatureTool::atan2Fast(), evdb::Colors::Background(), geo::PlaneGeo::boundedValue(), trkf::TrajectoryMCSFitter::breakTrajInSegments(), lar_content::DeltaRayIdentificationAlgorithm::BuildAssociationMap(), lar_pandora::LArPandoraOutput::BuildCluster(), lar_cluster3d::ClusterPathFinder::buildConvexHull(), lar_cluster3d::ConvexHullPathFinder::buildConvexHull(), lar_cluster3d::VoronoiPathFinder::buildConvexHull(), lar_content::CosmicRayVertexBuildingAlgorithm::BuildCosmicRayParent(), lar_content::NeutrinoDaughterVerticesAlgorithm::BuildDaughterTrack(), lar_pandora::LArPandoraOutput::BuildDummySlice(), lar_content::OvershootSplittingAlgorithm::BuildIntersectionMap(), lar_content::TwoDSlidingFitResult::CalculateAxes(), lar_content::TracksCrossingGapsTool::CalculateEffectiveOverlapFractions(), lar_content::ParticleRecoveryAlgorithm::CalculateEffectiveOverlapFractions(), lar_content::TracksCrossingGapsTool::CalculateEffectiveOverlapSpan(), lar_content::ParticleRecoveryAlgorithm::CalculateEffectiveSpan(), lar_content::LArGeometryHelper::CalculateGapDeltaZ(), lar_content::ThreeDRemnantsAlgorithm::CalculateOverlapResult(), lar_content::CosmicRayTaggingMonitoringTool::CalculatePfoMetrics(), lar_content::LayerSplittingAlgorithm::CalculateRms(), lar_content::SvmVertexSelectionAlgorithm::CalculateRPhiScores(), lar_content::AdaBoostDecisionTree::CalculateScore(), lar_content::TwoDLinearFitFeatureTool::CalculateVariablesSlidingLinearFit(), lar_content::ThreeDLinearFitFeatureTool::CalculateVariablesSlidingLinearFit(), geo::WireGeo::capLength(), lar::util::simple_geo::AreaBase< Point >::Center(), sim::MCHit::Charge(), voronoi2d::BeachLine::checkBeachLine(), lar_content::EventSlicingTool::CheckClosestApproach(), lar_content::ParticleRecoveryAlgorithm::CheckConsistency(), lar_content::CosmicRayTaggingTool::CheckIfInTime(), lar_content::ThreeDTrackFragmentsAlgorithm::CheckMatchedClusters(), lar_content::CosmicRayShowerMatchingAlgorithm::CheckMatchedClusters3D(), lar_content::CosmicRayTrackMatchingAlgorithm::CheckMatchedClusters3D(), trkf::Track3DKalmanHitAlg::chopHitsOffSeeds(), lar_pandora::SimpleNeutrinoId::ClassifySlices(), lar::util::MinMaxCollector< T >::clear(), recob::Cluster::Cluster(), lar_cluster3d::DBScanAlg::Cluster3DHits(), cluster::ClusterCrawlerAlg::ClusterHitsOK(), CRHitRemoval::collectPFParticleHits(), art::detail::columnWidth(), voronoi2d::EventUtilities::computeArcVal(), voronoi2d::EventUtilities::computeBreak(), voronoi2d::VoronoiDiagram::computeCircleCenter(), voronoi2d::VoronoiDiagram::ComputeFaceArea(), reco_tool::CandHitMorphological::configure(), lar_content::CosmicRaySplittingAlgorithm::ConfirmSplitPosition(), lar_cluster3d::ClusterMergeAlg::consistentClusters(), lar_cluster3d::kdTree::consistentPairs(), evgen::MarleyTimeGen::create_truths_time_fit(), lar_content::DeltaRayShowerHitsTool::CreateDeltaRayShowerHits3D(), lar::example::ShowerCalibrationGaloreFromPID::createInterpolator(), lar_pandora::LArPandoraInput::CreatePandoraDetectorGaps(), lar_pandora::LArPandoraInput::CreatePandoraReadoutGaps(), lar_content::MasterAlgorithm::CreatePfo(), lar_content::StitchingCosmicRayMergingTool::CreatePfoMatches(), lar_content::CutPfoCharacterisationAlgorithm::CutPfoCharacterisationAlgorithm(), cluster::BlurredClusteringAlg::DeadWireCount(), cluster::HoughTransformCounters< KEY, COUNTER, SIZE, ALLOC, SUBCOUNTERS >::decrement(), lar_cluster3d::MinSpanTreeAlg::DepthFirstSearch(), cluster::HoughTransform::DoAddPointReturnMax(), trkf::TrajectoryMCSFitter::doLikelihoodScan(), evd::TQPad::Draw(), evd::TWireProjPad::Draw(), evd::RecoBaseDrawer::DrawPFParticle3D(), sim::DumpMCShowers::DumpMCShower(), sim::DumpMCTracks::DumpMCTrack(), recob::DumpPFParticles::DumpPFParticles(), recob::DumpTracks::DumpTrack(), mf::service::ELdestination::ELdestination(), tca::EndMerge(), hit::MagDriftAna::ensureHists(), lar::example::ShowerCalibrationGaloreFromPID::CalibrationInfo_t::evalError(), lar::example::ShowerCalibrationGaloreFromPID::CalibrationInfo_t::evalFactor(), lar_cluster3d::DBScanAlg::expandCluster(), lar::sparse_vector< T >::expected_vector_size(), lar::sparse_vector< T >::datarange_t::extend(), cluster::HoughBaseAlg::FastTransform(), lar_content::fill_and_bound_2d_kd_tree(), lar_content::fill_and_bound_3d_kd_tree(), lar_content::CosmicRayExtensionAlgorithm::FillClusterAssociationMatrix(), lar_content::DeltaRayExtensionAlgorithm::FillClusterMergeMap(), lar_content::TransverseExtensionAlgorithm::FillClusterMergeMap(), lar_cluster3d::ClusterParamsBuilder::FillClusterParams(), trkf::CCTrackMaker::FillEndMatch(), trkf::CCTrackMaker::FillEndMatch2(), filter::ADCFilter::filter(), lar_content::CosmicRayTaggingTool::FindAmbiguousPfos(), lar_cluster3d::MinSpanTreeAlg::FindBestPathInCluster(), lar_content::LayerSplittingAlgorithm::FindBestSplitLayer(), lar_content::DeltaRaySplittingAlgorithm::FindBestSplitPosition(), lar_content::KinkSplittingAlgorithm::FindBestSplitPosition(), lar_content::CrossedTrackSplittingAlgorithm::FindBestSplitPosition(), cluster::BlurredClusteringAlg::FindBlurringParameters(), lar_content::LArStitchingHelper::FindClosestTPC(), lar_cluster3d::kdTree::FindEntry(), lar_cluster3d::SkeletonAlg::FindFirstAndLastWires(), lar_cluster3d::StandardHit3DBuilder::findGoodTriplets(), reco_tool::CandHitStandard::findHitCandidates(), lar_cluster3d::HoughSeedFinderAlg::findHoughClusters(), lar_content::MatchedEndPointsTool::FindMatchedTracks(), lar_cluster3d::ConvexHull::findNearestEdge(), voronoi2d::VoronoiDiagram::findNearestEdge(), lar_cluster3d::kdTree::FindNearestNeighbors(), lar_content::KDTreeLinkerAlgo< DATA, DIM >::findNearestNeighbour(), reco_tool::PeakFitterGaussian::findPeakParameters(), cluster::MergeClusterAlg::FindProjectedWidth(), geo::AuxDetGeo::FindSensitiveVolume(), hit::DPRawHitFinder::FitExponentials(), lar_content::FitSegment::FitSegment(), lar::sparse_vector< T >::fix_size(), evdb::Colors::Foreground(), cluster::BlurredClusteringAlg::GaussianBlur(), util::GaussianEliminationAlg::GaussianEliminationAlg(), lar::details::bulk_allocator::BulkAllocatorBase< T >::Get(), cluster::HoughTransformCounters< KEY, COUNTER, SIZE, ALLOC, SUBCOUNTERS >::get_max(), lar_content::LArPointingClusterHelper::GetAverageDirection(), lar_content::LArClusterHelper::GetAverageZ(), lar_content::VertexSelectionBaseAlgorithm::GetBeamConstants(), lar_content::VertexSelectionBaseAlgorithm::GetBeamDeweightingScore(), lar_content::ThreeDShowersAlgorithm::GetBestHitOverlapFraction(), lar_content::ThreeDTransverseTracksAlgorithm::GetBestOverlapResult(), lar_content::SvmVertexSelectionAlgorithm::GetBestVertex(), lar_content::CosmicRaySplittingAlgorithm::GetCaloHitListToMove(), lar_content::IsolatedClusterMopUpAlgorithm::GetCaloHitToClusterMap(), lar_content::DeltaRayIdentificationAlgorithm::GetClosestDistance(), lar_content::LArPfoHelper::GetClosestDistance(), geo::CryostatGeo::GetClosestOpDet(), geo::GeometryCore::GetClosestOpDet(), geo::CryostatGeo::GetClosestOpDetPtr(), lar_content::LArClusterHelper::GetClosestPositions(), lar_content::LArPointingClusterHelper::GetClosestVertices(), ems::MergeEMShower3D::getClusterBestId(), lar_content::LArClusterHelper::GetClusterBoundingBox(), lar_content::LArVertexHelper::GetClusterDirectionInZ(), lar_content::LArClusterHelper::GetClusterSpanX(), lar_content::LArClusterHelper::GetClusterSpanZ(), lar_content::DeltaRayMatchingAlgorithm::GetDistanceSquaredToPfo(), pma::PMAlgVertexing::getdQdx(), lar_content::TransverseAssociationAlgorithm::GetExtremalCoordinatesXZ(), lar_content::ThreeDTrackFragmentsAlgorithm::GetFragmentOverlapResult(), lar_content::ThreeDSlidingFitResult::GetGlobalDirection(), lar_content::ThreeDSlidingFitResult::GetGlobalFitDirection(), lar_content::ThreeDSlidingFitResult::GetGlobalFitPosition(), cluster::ClusterCrawlerAlg::GetHitRange(), lar_content::UndershootTracksTool::GetIteratorListModifications(), lar_content::LArClusterHelper::GetLayerSpan(), lar_content::LArClusterHelper::GetLengthSquared(), lar_content::BeamParticleIdTool::Plane::GetLineIntersection(), lar_content::BdtBeamParticleIdTool::Plane::GetLineIntersection(), lar_content::DeltaRayGrowingAlgorithm::GetListOfSeedClusters(), lar_content::TransverseAssociationAlgorithm::GetLongitudinalSpan(), lar_content::ThreeDTrackFragmentsAlgorithm::GetMatchedHits(), lar_content::VertexBasedPfoMopUpAlgorithm::PfoAssociation::GetMaxBoundedFraction(), lar_content::ThreeDSlidingFitResult::GetMaxLayer(), lar_content::TwoDSlidingFitResult::GetMinAndMaxCoordinate(), trkf::SurfYZPlane::getMomentum(), trkf::SurfYZLine::getMomentum(), trkf::SurfXYZPlane::getMomentum(), sim::PhotonVoxelDef::GetNeighboringVoxelIDs(), lar_content::LArPointingClusterHelper::GetProjectedPosition(), lar_content::ThreeDTrackFragmentsAlgorithm::GetProjectedPositions(), lar_content::ThreeDTransverseTracksAlgorithm::GetSegmentOverlap(), lar_content::MissingTrackSegmentTool::GetSegmentOverlapMap(), lar_content::TwoDSlidingShowerFitResult::GetShowerEdges(), lar_content::SplitShowersTool::GetSplitXDetails(), lar_pandora::PFParticleMonitoring::GetStartAndEndPoints(), opdet::OpDigiProperties::GetTimeSlice(), lar_content::TransverseTrackHitsBaseTool::GetTransverseChi2(), lar_content::TwoDSlidingFitResult::GetTransverseSurroundingLayers(), voronoi2d::BeachLine::getTreeDepth(), reco_tool::WaveformTools::getTruncatedMeanRMS(), lar_content::LongitudinalTrackHitsBaseTool::GetVertexAndEndPositions(), evwgh::Weight_t::GetWeight(), lar_content::ThreeDKinkBaseTool::GetXSamplingPoint(), lar_content::BranchGrowingAlgorithm::IdentifyClusterMerges(), lar::util::simple_geo::AreaBase< Point >::IncludePoint(), lar::util::simple_geo::Area< Point >::IncludePoint(), lar::util::simple_geo::Volume< Point >::IncludePoint(), cluster::HoughTransformCounters< KEY, COUNTER, SIZE, ALLOC, SUBCOUNTERS >::increment(), art::detail::info_success(), evd::details::GridAxisClass::Init(), larg4::ISCalculationSeparate::Initialize(), lar_content::CosmicRayTaggingTool::Initialize(), lar_content::BeamParticleIdTool::Initialize(), lar_content::BdtBeamParticleIdTool::SliceFeatureParameters::Initialize(), lar_content::BdtBeamParticleIdTool::Initialize(), lar::util::simple_geo::AreaBase< Point >::Intersect(), lar::util::simple_geo::Area< Point >::Intersect(), lar::util::simple_geo::Volume< Point >::Intersect(), art::ScheduleID::invalid_id_(), art::RangeSet::invalidChecksum(), art::ModuleDescription::invalidID(), lar_content::DeltaRayIdentificationAlgorithm::IsAssociated(), lar_content::TransverseAssociationAlgorithm::IsAssociated(), lar_content::CutClusterCharacterisationAlgorithm::IsClearTrack(), evd::details::GridAxisClass::isEmpty(), lar_content::CrossGapsAssociationAlgorithm::IsNearCluster(), voronoi2d::VoronoiDiagram::isOutsideConvexHull(), lar_content::ParticleRecoveryAlgorithm::IsOverlap(), lar_content::TransverseAssociationAlgorithm::IsOverlapping(), lar_content::MissingTrackSegmentTool::IsPossibleMerge(), lar_content::UndershootTracksTool::IsThreeDKink(), lar_content::OvershootTracksTool::IsThreeDKink(), Iterate(), geo::GeometryCore::IterateROPIDs(), lar_content::TransverseAssociationAlgorithm::LArTransverseCluster::LArTransverseCluster(), lar_cluster3d::MinSpanTreeAlg::LeastCostPath(), lar::util::simple_geo::Range< Data_t >::length(), evd::details::GridAxisClass::Length(), lar_pandora::LArPandoraGeometry::LoadDetectorGaps(), lar_pandora::LArPandoraGeometry::LoadGeometry(), art::TimeTracker::logToDestination_(), main(), lar_content::ClusterMopUpBaseAlgorithm::MakeClusterMerges(), lar_content::MissingTrackSegmentTool::MakeDecisions(), cosmic::HitTagAssociatorAlg::MakeHitTagAssociations(), util::MakeIndex(), util::MakeMap(), trkf::SpacePointAlg::makeSpacePoints(), trkf::BezierTrackerAlgorithm::MakeTracks(), art::RootOutputTree::makeTTree(), cluster::ClusterMatchAlg::Match_RoughTime(), cluster::ClusterMatchAlg::Match_SpacePoint(), pma::PMAlgTracker::matchCluster(), lar_content::CosmicRayShowerMatchingAlgorithm::MatchClusters(), lar_content::CosmicRayTrackMatchingAlgorithm::MatchClusters(), lar_content::CosmicRayTrackRecoveryAlgorithm::MatchClusters(), lar_content::EventSlicingTool::MatchClusterToSlice(), lar::util::simple_geo::AreaBase< Point >::Max(), evd::details::GridAxisClass::Max(), art::debugging_allocator< T >::max_size(), geo::ChannelMapStandardAlg::MaxROPs(), geo::ChannelMapStandardAlg::MaxTPCs(), trkf::TrajectoryMCSFitter::mcsLikelihood(), util::Range< T >::Merge(), sim::AuxDetSimChannel::MergeAuxDetSimChannel(), sim::MergeSimSourcesUtility::MergeAuxDetSimChannels(), sim::MergeSimSourcesUtility::MergeMCParticles(), sim::OpDetBacktrackerRecord::MergeOpDetBacktrackerRecord(), sim::SimChannel::MergeSimChannel(), sim::MergeSimSourcesUtility::MergeSimChannels(), evd::Ortho3DPad::MouseEvent(), lar::util::simple_geo::AreaBase< Point >::operator!=(), lar_cluster3d::HoughSeedFinderAlg::SortHoughClusterList::operator()(), lar_content::operator+(), lar::util::simple_geo::AreaBase< Point >::operator==(), trkf::BezierTrackerAlgorithm::OrganizeSeedsIntoTracks(), pma::PMAlgCosmicTagger::outOfDriftWindow(), lar_content::MissingTrackSegmentTool::Particle::Particle(), lar_content::TrackSplittingTool::PassesChecks(), lar_content::OvershootTracksTool::PassesVertexCuts(), lar_cluster3d::PrincipalComponentsAlg::PCAAnalysis_3D(), lar_content::ThreeDTrackFragmentsAlgorithm::PerformMainLoop(), lar_content::SvmVertexSelectionAlgorithm::PopulateVertexFeatureInfoMap(), geo::AuxDetGeo::PositionToSensitiveVolume(), recob::HitCollectionAssociator::prepare_associations(), recob::HitRefinerAssociator::prepare_associations(), lar::debug::printBacktrace(), lar_content::LArMonitoringHelper::PrintMatchingTable(), lar_pandora::LArPandoraEventDump::PrintProperty(), lar_pandora::LArPandoraEventDump::PrintRule(), lar_content::EventValidationAlgorithm::ProcessOutput(), opdet::FlashClusterMatch::produce(), lar_pandora::LArPandoraTrackCreation::produce(), trkf::TrackCheater::produce(), cosmic::BeamFlashTrackMatchTagger::produce(), calo::TrackCalorimetry::produce(), TrackProducerFromPFParticle::produce(), vertex::HarrisVertexFinder::produce(), calo::Calorimetry::produce(), lar_content::SvmVertexSelectionAlgorithm::ProduceTrainingExamples(), trkf::TrackStatePropagator::propagateToPlane(), lar_content::TwoDSlidingFitSplittingAndSplicingAlgorithm::PruneClusterExtensionList(), lar_content::LArCaloHitFactory::Read(), lar_content::ThreeDHitCreationAlgorithm::RefineHitPositions(), recob::dumper::IndentOptions_t::removeIndentation(), sim::MergeSimSourcesUtility::Reset(), RStarBoundingBox< dimensions >::reset(), art::detail::resolveRangeSetInfo(), lar_content::TestBeamParticleCreationAlgorithm::Run(), lar_content::CosmicRaySplittingAlgorithm::Run(), cosmic::BeamFlashTrackMatchTaggerAlg::RunCompatibilityCheck(), opdet::RunFlashFinder(), tca::SaveCRInfo(), art::Defaults::seconds_max(), lar_content::TrackSplittingTool::SelectElements(), lar_content::MissingTrackSegmentTool::SelectElements(), lar_content::CheatingNeutrinoIdTool::SelectOutputPfos(), lar_content::BeamParticleIdTool::SelectOutputPfos(), lar_content::NeutrinoIdTool::SelectOutputPfos(), lar::range_t< size_type >::set(), voronoi2d::BSTNode::setDepth(), evd::details::GridAxisClass::SetLimits(), evd::details::GridAxisClass::SetMaxCellSize(), evd::details::GridAxisClass::SetMinCellSize(), larg4::LArVoxelReadout::SetOffPlaneChargeRecoveryMargin(), lar_content::OvershootTracksTool::SetSplitPosition(), evdb::ParameterSetEditRow::SetupSlider(), lar_content::TestBeamParticleCreationAlgorithm::SetupTestBeamPfo(), lar_content::NeutrinoIdTool::SliceFeatures::SliceFeatures(), SolvePair(), geo::BoxBoundedGeo::SortCoordinates(), RStarTree< int, 2, 32, 64 >::Split(), tca::SplitHiChgHits(), tss::Cluster2D::tagEM(), lar_content::ThreeDLongitudinalTracksAlgorithm::ThreeDLongitudinalTracksAlgorithm(), trkf::CosmicTrackerAlg::Track3D(), lar_content::TrackConsolidationAlgorithm::TrackConsolidationAlgorithm(), trkf::TrackMomentumCalculator::TrackMomentumCalculator(), cluster::HoughBaseAlg::Transform(), raw::Trigger::Trigger(), evd::TWireProjPad::TWireProjPad(), cluster::HoughTransformCounters< KEY, COUNTER, SIZE, ALLOC, SUBCOUNTERS >::unchecked_add_range_max(), art::Defaults::unsigned_max(), art::detail::RangeSetInfo::update(), lar_content::LongitudinalTrackHitsBaseTool::UpdateBestPosition(), lar_content::LArFormattingHelper::Table::UpdateColumnWidth(), geo::GeometryCore::ValueInRange(), lar::util::StatCollector< T, W >::Variance(), lar::util::simple_geo::Volume< Point >::Volume(), btutil::WireRange_t::WireRange_t(), lar_content::ThreeDShowersAlgorithm::XSampling::XSampling(), geoalgo::AABox::~AABox(), geoalgo::Cylinder::~Cylinder(), and lar_content::HitCreationBaseTool::~HitCreationBaseTool().

Int_t min =-2

Definition at line 26 of file plot.C.

Referenced by geoalgo::GeoAlgo::_Clamp_(), geoalgo::GeoAlgo::_ClosestPt_(), util::SignalShaping::AddFilterFunction(), opdet::AddHitToFlash(), hit::CCHitFinderAlg::FitStats_t::AddMultiGaus(), geo::details::ActiveAreaCalculator::adjustCorners(), lar_pandora::PFParticleMonitoring::analyze(), caldata::CalWireAna::analyze(), shower::TCShowerAnalysis::analyze(), lar::example::AnalysisExample::analyze(), lar::util::simple_geo::Area< Point >::Area(), lar::util::simple_geo::AreaBase< Point >::AreaBase(), lar_content::DeltaRayMatchingAlgorithm::AreClustersMatched(), recob::TrackTrajectory::AtLeastValidTrajectoryPoints(), evdb::Colors::Background(), cmtool::CBAlgoAngleCompat::Bool(), cmtool::CBAlgoAngleIncompat::Bool(), geo::PlaneGeo::boundedValue(), lar_cluster3d::ConvexHullPathFinder::breakClusterByKinks(), lar_cluster3d::ConvexHullPathFinder::breakClusterByKinksTrial(), lar_cluster3d::VoronoiPathFinder::breakIntoTinyBits(), lar_content::CosmicRayVertexBuildingAlgorithm::BuildCosmicRayParent(), lar_content::NeutrinoDaughterVerticesAlgorithm::BuildDaughterTrack(), lar_content::OvershootSplittingAlgorithm::BuildIntersectionMap(), lar_content::TwoDSlidingFitResult::CalculateAxes(), lar_content::VertexSelectionBaseAlgorithm::CalculateClusterSlidingFits(), lar_content::TracksCrossingGapsTool::CalculateEffectiveOverlapFractions(), lar_content::ParticleRecoveryAlgorithm::CalculateEffectiveOverlapFractions(), lar_content::TracksCrossingGapsTool::CalculateEffectiveOverlapSpan(), lar_content::ParticleRecoveryAlgorithm::CalculateEffectiveSpan(), lar_content::LArGeometryHelper::CalculateGapDeltaZ(), lar_content::ThreeDRemnantsAlgorithm::CalculateOverlapResult(), lar_content::LayerSplittingAlgorithm::CalculateRms(), lar_content::TwoDLinearFitFeatureTool::CalculateVariablesSlidingLinearFit(), lar_content::ThreeDLinearFitFeatureTool::CalculateVariablesSlidingLinearFit(), geo::WireGeo::capLength(), lar::util::simple_geo::AreaBase< Point >::Center(), lar_content::ParticleRecoveryAlgorithm::CheckConsistency(), lar_content::CosmicRayTaggingTool::CheckIfInTime(), lar_content::ThreeDTrackFragmentsAlgorithm::CheckMatchedClusters(), lar_content::CosmicRayShowerMatchingAlgorithm::CheckMatchedClusters3D(), trkf::Track3DKalmanHitAlg::chopHitsOffSeeds(), lar::util::MinMaxCollector< T >::clear(), recob::Cluster::Cluster(), cluster::ClusterCrawlerAlg::ClusterHitsOK(), lar_content::NearbyClusterMopUpAlgorithm::ClusterMopUp(), CRHitRemoval::collectPFParticleHits(), voronoi2d::EventUtilities::computeBreak(), voronoi2d::VoronoiDiagram::ComputeFaceArea(), lar_content::VertexBasedPfoMopUpAlgorithm::ConeParameters::ConeParameters(), lar_content::CosmicRaySplittingAlgorithm::ConfirmSplitPosition(), lar_pandora::LArPandoraInput::CreatePandoraReadoutGaps(), lar_content::MasterAlgorithm::CreatePfo(), lar_content::StitchingCosmicRayMergingTool::CreatePfoMatches(), lar_content::CutPfoCharacterisationAlgorithm::CutPfoCharacterisationAlgorithm(), util::LazyVector< T, A >::data_init(), util::LazyVector< T, A >::data_prepare(), cluster::BlurredClusteringAlg::DeadWireCount(), hit::DPRawHitFinder::doBinAverage(), trkf::TrackKalmanFitter::doFitWork(), noisefilteralg::WireCellNoiseFilter::DoNoiseFilter(), evd::TQPad::Draw(), evd::TWireProjPad::Draw(), evd_tool::StandardDrawer::DrawAxes(), evd_tool::StandardDrawer::DrawGrids(), detsim::DumpOpDetWaveforms::DumpWaveform(), tca::EndMerge(), lar::example::ShowerCalibrationGaloreFromPID::CalibrationInfo_t::evalError(), lar::example::ShowerCalibrationGaloreFromPID::CalibrationInfo_t::evalFactor(), lar_content::fill_and_bound_2d_kd_tree(), lar_content::fill_and_bound_3d_kd_tree(), lar_content::LongitudinalExtensionAlgorithm::FillClusterAssociationMatrix(), lar_content::CosmicRayExtensionAlgorithm::FillClusterAssociationMatrix(), lar_cluster3d::ClusterParamsBuilder::FillClusterParams(), lar_pandora::PFParticleCosmicAna::FillRecoTree(), lar_content::CosmicRayTaggingTool::FindAmbiguousPfos(), lar_content::BranchGrowingAlgorithm::FindAssociatedClusters(), lar_cluster3d::MinSpanTreeAlg::FindBestPathInCluster(), lar_content::DeltaRaySplittingAlgorithm::FindBestSplitPosition(), lar_content::VertexSplittingAlgorithm::FindBestSplitPosition(), cluster::MergeClusterAlg::FindClusterOverlap(), cluster::MergeClusterAlg::FindCrossingDistance(), lar_cluster3d::SkeletonAlg::FindFirstAndLastWires(), pma::PMAlgVertexing::findKinksOnTracks(), reco_tool::PeakFitterGaussElimination::findPeakParameters(), reco_tool::PeakFitterGaussian::findPeakParameters(), lar_cluster3d::ParallelHitsSeedFinderAlg::findTrackSeeds(), hit::DPRawHitFinder::FitExponentials(), lar_content::FitSegment::FitSegment(), cluster::ClusterCrawlerAlg::FitVtx(), cmtool::CFAlgoStartPointCompat::Float(), evdb::Colors::Foreground(), cluster::BlurredClusteringAlg::GaussianBlur(), lar_content::LArClusterHelper::GetAverageZ(), lar_content::ThreeDTransverseTracksAlgorithm::GetBestOverlapResult(), evd::details::GridAxisClass::GetCell(), lar_content::LArPointingClusterHelper::GetClosestVertices(), lar_content::LArStitchingHelper::GetClosestVertices(), lar_content::LArClusterHelper::GetClusterBoundingBox(), lar_content::SlidingConePfoMopUpAlgorithm::GetClusterMergeMap(), lar_content::SlidingConeClusterMopUpAlgorithm::GetClusterMergeMap(), lar_content::LArClusterHelper::GetClusterSpanX(), lar_content::LArClusterHelper::GetClusterSpanZ(), lar_content::DeltaRayExtensionAlgorithm::GetExtremalCoordinatesFromCache(), lar_content::ThreeDSlidingFitResult::GetGlobalDirection(), lar_content::ThreeDSlidingFitResult::GetGlobalFitDirection(), lar_content::ThreeDSlidingFitResult::GetGlobalFitPosition(), lar_content::UndershootTracksTool::GetIteratorListModifications(), lar_content::LArClusterHelper::GetLayerSpan(), lar_content::LArClusterHelper::GetLengthSquared(), lar_content::BeamParticleIdTool::Plane::GetLineIntersection(), lar_content::TwoDSlidingFitResult::GetMinAndMaxCoordinate(), lar_content::VertexBasedPfoMopUpAlgorithm::PfoAssociation::GetMinBoundedFraction(), lar_content::ThreeDSlidingFitResult::GetMinLayer(), sim::PhotonVoxelDef::GetNeighboringVoxelIDs(), lar_content::ThreeDTrackFragmentsAlgorithm::GetProjectedPositions(), lar_content::ThreeDSlidingFitResult::GetSeedDirection(), lar_content::ThreeDTransverseTracksAlgorithm::GetSegmentOverlap(), lar_content::MissingTrackSegmentTool::GetSegmentOverlapMap(), lar_content::TwoDSlidingShowerFitResult::GetShowerEdges(), lar_content::SplitShowersTool::GetSplitXDetails(), lar_content::TransverseTrackHitsBaseTool::GetTransverseChi2(), lar_content::TwoDSlidingFitResult::GetTransverseSurroundingLayers(), reco_tool::WaveformTools::getTruncatedMeanRMS(), lar_content::LongitudinalTrackHitsBaseTool::GetVertexAndEndPositions(), evwgh::Weight_t::GetWeight(), lar_content::ThreeDKinkBaseTool::GetXSamplingPoint(), groupByDriftCoordinate(), evd::details::GridAxisClass::hasCoord(), lar::util::simple_geo::AreaBase< Point >::IncludePoint(), lar::util::simple_geo::Area< Point >::IncludePoint(), lar::util::simple_geo::Volume< Point >::IncludePoint(), lar_content::BeamParticleIdTool::Initialize(), lar_content::BdtBeamParticleIdTool::SliceFeatureParameters::Initialize(), lar_content::BdtBeamParticleIdTool::Initialize(), cluster::ClusterParamsAlg::IntegrateFitCharge(), lar::util::simple_geo::AreaBase< Point >::Intersect(), lar::util::simple_geo::Area< Point >::Intersect(), lar::util::simple_geo::Volume< Point >::Intersect(), lar_content::TransverseAssociationAlgorithm::IsAssociated(), lar_content::CutClusterCharacterisationAlgorithm::IsClearTrack(), evd::details::GridAxisClass::isEmpty(), lar_content::ParticleRecoveryAlgorithm::IsOverlap(), geo::GeometryCore::IterateROPIDs(), evd::details::GridAxisClass::Length(), tca::LineLineIntersect(), lar_pandora::LArPandoraGeometry::LoadDetectorGaps(), lar_pandora::LArPandoraGeometry::LoadGeometry(), main(), lar_content::MissingTrackSegmentTool::MakeDecisions(), ClusteringValidation::ClusterAnalyser::MakeHistograms(), trkf::SpacePointAlg::makeSpacePoints(), trkf::BezierTrackerAlgorithm::MakeTracks(), cluster::ClusterMatchAlg::Match_RoughTime(), cluster::ClusterMatchAlg::Match_SpacePoint(), lar_content::CosmicRayShowerMatchingAlgorithm::MatchClusters(), lar_content::CosmicRayTrackMatchingAlgorithm::MatchClusters(), lar_content::CosmicRayTrackRecoveryAlgorithm::MatchClusters(), pma::VtxCandidate::MaxAngle(), evd::SimulationDrawer::MCTruth3D(), util::Range< T >::Merge(), sim::AuxDetSimChannel::MergeAuxDetSimChannel(), sim::MergeSimSourcesUtility::MergeAuxDetSimChannels(), sim::MergeSimSourcesUtility::MergeMCParticles(), sim::OpDetBacktrackerRecord::MergeOpDetBacktrackerRecord(), sim::SimChannel::MergeSimChannel(), sim::MergeSimSourcesUtility::MergeSimChannels(), lar::util::simple_geo::AreaBase< Point >::Min(), art::ScheduleID::min_id_(), lar_cluster3d::ConvexHullPathFinder::ModifyClusters(), lar_cluster3d::VoronoiPathFinder::ModifyClusters(), evd::Ortho3DPad::MouseEvent(), lar::util::simple_geo::AreaBase< Point >::operator!=(), lar_content::operator+(), lar::util::simple_geo::AreaBase< Point >::operator==(), trkf::BezierTrackerAlgorithm::OrganizeSeedsIntoTracks(), pma::PMAlgCosmicTagger::outOfDriftWindow(), lar_content::MissingTrackSegmentTool::Particle::Particle(), lar_content::OvershootTracksTool::PassesVertexCuts(), lar_content::EventSlicingTool::PassShowerCone(), lar_cluster3d::PrincipalComponentsAlg::PCAAnalysis_calc2DDocas(), lar_content::ThreeDTrackFragmentsAlgorithm::PerformMainLoop(), lar_content::SvmVertexSelectionAlgorithm::PopulateKdTree(), print_one_fc_metadata_entry_hr(), lar_content::LArMonitoringHelper::PrintMatchingTable(), detsim::DumpRawDigits::PrintRawDigit(), caldata::DumpWires::PrintWire(), opdet::FlashClusterMatch::produce(), noisefilteralg::WireCellNoiseFilter::produce(), butcher::EventButcher::produce(), vertex::HarrisVertexFinder::produce(), hit::GausHitFinder::produce(), hit::DPRawHitFinder::produce(), vertex::VertexFinder2D::produce(), lar_content::TwoDSlidingFitSplittingAndSplicingAlgorithm::PruneClusterExtensionList(), evd::RawDataDrawer::QueueDrawingBoxes(), proxy::details::BoundaryList< associated_data_iterator_t >::rangeBegin(), larg4::OpFastScintillation::RecordPhotonsProduced(), sim::MergeSimSourcesUtility::Reset(), RStarBoundingBox< dimensions >::reset(), lar_content::BranchAssociatedPfosTool::Run(), evd::RawDataDrawer::RunOperation(), tca::SaveCRInfo(), lar_content::TrackSplittingTool::SelectElements(), lar_content::MissingTrackSegmentTool::SelectElements(), lar_content::BeamParticleIdTool::SelectOutputPfos(), evd::details::GridAxisClass::SetLimits(), lar::standalone::SetupGeometryWithChannelMapping(), evdb::ParameterSetEditRow::SetupSlider(), SolvePair(), geo::BoxBoundedGeo::SortCoordinates(), lar_content::SplitShowersTool::SpecifyClusterMerges(), tca::SplitHiChgHits(), lar_cluster3d::ConvexHullPathFinder::subDivideCluster(), lar_cluster3d::VoronoiPathFinder::subDivideCluster(), sim::LArVoxelCalculator::SuggestedStepSize(), tss::Cluster2D::tagEM(), lar::util::simple_geo::Area< Point >::thinnestSize(), lar::util::simple_geo::Volume< Point >::thinnestSize(), lar_content::ThreeDLongitudinalTracksAlgorithm::ThreeDLongitudinalTracksAlgorithm(), trkf::trace(), trkf::CosmicTrackerAlg::Track3D(), lar_content::TrackConsolidationAlgorithm::TrackConsolidationAlgorithm(), evd::TWireProjPad::TWireProjPad(), cluster::HoughTransformCounters< KEY, COUNTER, SIZE, ALLOC, SUBCOUNTERS >::unchecked_add_range_max(), cluster::HoughTransformCounters< KEY, COUNTER, SIZE, ALLOC, SUBCOUNTERS >::unchecked_set_range(), art::detail::RangeSetInfo::update(), lar::util::simple_geo::Volume< Point >::Volume(), lar_content::ThreeDShowersAlgorithm::XSampling::XSampling(), geoalgo::AABox::~AABox(), and geoalgo::Cylinder::~Cylinder().

Int_t nentries = (Int_t)ntuple->GetEntries()

Definition at line 240 of file plot.C.

delete new_bins

Definition at line 211 of file plot.C.

Double_t norm =0

Definition at line 83 of file plot.C.

Double_t normLogfy =0

Definition at line 281 of file plot.C.

Double_t radius

Definition at line 235 of file plot.C.

Double_t y

Definition at line 235 of file plot.C.

Double_t z

Definition at line 235 of file plot.C.