26 std::vector<spr::propagatedTrackID> vdets;
29 reco::TrackCollection::const_iterator trkItr;
30 for (trkItr = trkCollection->begin(),indx=0; trkItr != trkCollection->end(); ++trkItr,indx++) {
35 (pTrack->
quality(trackQuality_)) :
true;
40 if (debug)
std::cout <<
"Propagate track " << indx <<
" p " << trkItr->p() <<
" eta " << trkItr->eta() <<
" phi " << trkItr->phi() <<
" Flag " << vdet.
ok << std::endl;
62 if (debug)
std::cout <<
"Track charge " <<
charge <<
" p " << momentum <<
" position " << vertex << std::endl;
64 std::pair<math::XYZPoint,bool>
info =
67 if (debug)
std::cout <<
"Propagate to ECAL " << info.second <<
" at (" << info.first.x() <<
", "<< info.first.y() <<
", " << info.first.z() <<
")\n";
97 if (debug)
std::cout <<
"Propagate to HCAL " << info.second <<
" at (" << info.first.x() <<
", "<< info.first.y() <<
", " << info.first.z() <<
")\n";
108 std::cout <<
"Track [" << indx <<
"] Flag: " << vdet.
ok <<
" ECAL (" 117 vdets.push_back(vdet);
122 std::cout <<
"propagateCALO:: for " << vdets.size() <<
" tracks" << std::endl;
123 for (
unsigned int i=0;
i<vdets.size(); ++
i) {
124 std::cout <<
"Track [" <<
i <<
"] Flag: " << vdets[
i].ok <<
" ECAL (" << vdets[
i].okECAL <<
") ";
139 std::vector<spr::propagatedTrackID> vdets;
152 reco::TrackCollection::const_iterator trkItr;
153 for (trkItr = trkCollection->begin(),indx=0; trkItr != trkCollection->end(); ++trkItr,indx++) {
158 (pTrack->
quality(trackQuality_)) :
true;
163 if (debug)
std::cout <<
"Propagate track " << indx <<
" p " << trkItr->p() <<
" eta " << trkItr->eta() <<
" phi " << trkItr->phi() <<
" Flag " << vdet.
ok << std::endl;
166 vdet.
okECAL = info.second;
182 vdet.
okHCAL = info.second;
191 std::cout <<
"Track [" << indx <<
"] Flag: " << vdet.
ok <<
" ECAL (" 200 vdets.push_back(vdet);
204 std::cout <<
"propagateCALO:: for " << vdets.size() <<
" tracks" << std::endl;
205 for (
unsigned int i=0;
i<vdets.size(); ++
i) {
206 std::cout <<
"Track [" <<
i <<
"] Flag: " << vdets[
i].ok <<
" ECAL (" << vdets[
i].okECAL <<
") ";
226 reco::TrackCollection::const_iterator trkItr;
227 for (trkItr = trkCollection->begin(),indx=0; trkItr != trkCollection->end(); ++trkItr,indx++) {
232 (pTrack->
quality(trackQuality_)) :
true;
237 if (debug)
std::cout <<
"Propagate track " << indx <<
" p " << trkItr->p() <<
" eta " << trkItr->eta() <<
" phi " << trkItr->phi() <<
" Flag " << trkD.
ok << std::endl;
263 trkDir.push_back(trkD);
267 std::cout <<
"propagateCALO:: for " << trkDir.size() <<
" tracks" << std::endl;
268 for (
unsigned int i=0;
i<trkDir.size(); ++
i) {
269 std::cout <<
"Track [" <<
i <<
"] Flag: " << trkDir[
i].ok <<
" ECAL (" << trkDir[
i].okECAL <<
")";
270 if (trkDir[
i].okECAL) {
271 std::cout <<
" point " << trkDir[
i].pointECAL <<
" direction " 272 << trkDir[
i].directionECAL <<
" ";
273 if (trkDir[
i].detIdECAL.subdetId() ==
EcalBarrel) {
279 std::cout <<
" HCAL (" << trkDir[
i].okHCAL <<
")";
280 if (trkDir[
i].okHCAL) {
281 std::cout <<
" point " << trkDir[
i].pointHCAL <<
" direction " 282 << trkDir[
i].directionHCAL <<
" " 303 if (debug)
std::cout <<
"Propagate track: p " << pTrack->
p() <<
" eta " << pTrack->
eta() <<
" phi " << pTrack->
phi() <<
" Flag " << vdet.
ok << std::endl;
306 vdet.
okECAL = info.second;
322 vdet.
okHCAL = info.second;
331 std::cout <<
"propagateCALO:: for 1 track" << std::endl;
350 std::vector<spr::propagatedGenTrackID> trkDir;
352 HepMC::GenEvent::particle_const_iterator
p;
353 for (p=genEvent->particles_begin(),indx=0; p != genEvent->particles_end(); ++
p,++indx) {
359 trkD.
pdgId = ((*p)->pdg_id());
360 trkD.
charge = ((pdt->particle(trkD.
pdgId))->
ID().threeCharge())/3;
363 if (debug)
std::cout <<
"Propagate track " << indx <<
" pdg " << trkD.
pdgId <<
" charge " << trkD.
charge <<
" p " << momentum << std::endl;
366 if ( (*p)->status()==1 &&
std::abs((*p)->momentum().eta()) < etaMax ) {
368 0.1*(*p)->production_vertex()->position().y(),
369 0.1*(*p)->production_vertex()->position().z());
397 trkDir.push_back(trkD);
401 std::cout <<
"propagateCALO:: for " << trkDir.size() <<
" tracks" << std::endl;
402 for (
unsigned int i=0;
i<trkDir.size(); ++
i) {
403 if (trkDir[
i].okECAL)
std::cout <<
"Track [" <<
i <<
"] Flag: " << trkDir[
i].ok <<
" ECAL (" << trkDir[
i].okECAL <<
")";
404 if (trkDir[
i].okECAL) {
405 std::cout <<
" point " << trkDir[
i].pointECAL <<
" direction " 406 << trkDir[
i].directionECAL <<
" ";
407 if (trkDir[
i].detIdECAL.subdetId() ==
EcalBarrel) {
413 if (trkDir[
i].okECAL)
std::cout <<
" HCAL (" << trkDir[
i].okHCAL <<
")";
414 if (trkDir[
i].okHCAL) {
415 std::cout <<
" point " << trkDir[
i].pointHCAL <<
" direction " 416 << trkDir[
i].directionHCAL <<
" " 432 std::vector<spr::propagatedGenParticleID> trkDir;
434 reco::GenParticleCollection::const_iterator
p;
435 for (p=genParticles->begin(),indx=0; p != genParticles->end(); ++
p,++indx) {
441 trkD.
pdgId = (p->pdgId());
442 trkD.
charge = p->charge();
445 if (debug)
std::cout <<
"Propagate track " << indx <<
" pdg " << trkD.
pdgId <<
" charge " << trkD.
charge <<
" p " << momentum << std::endl;
448 if ( p->status()==1 &&
std::abs(momentum.
eta()) < etaMax ) {
477 trkDir.push_back(trkD);
481 std::cout <<
"propagateCALO:: for " << trkDir.size() <<
" tracks" << std::endl;
482 for (
unsigned int i=0;
i<trkDir.size(); ++
i) {
483 if (trkDir[
i].okECAL)
std::cout <<
"Track [" <<
i <<
"] Flag: " << trkDir[
i].ok <<
" ECAL (" << trkDir[
i].okECAL <<
")";
484 if (trkDir[
i].okECAL) {
485 std::cout <<
" point " << trkDir[
i].pointECAL <<
" direction " 486 << trkDir[
i].directionECAL <<
" ";
487 if (trkDir[
i].detIdECAL.subdetId() ==
EcalBarrel) {
493 if (trkDir[
i].okECAL)
std::cout <<
" HCAL (" << trkDir[
i].okHCAL <<
")";
494 if (trkDir[
i].okHCAL) {
495 std::cout <<
" point " << trkDir[
i].pointHCAL <<
" direction " 496 << trkDir[
i].directionHCAL <<
" " 519 if (debug)
std::cout <<
"Propagate track " << thisTrk <<
" charge " << trk.
charge <<
" position " << trk.
position <<
" p " << trk.
momentum <<
" Flag " << trkD.
ok << std::endl;
550 std::cout <<
"propagateCALO:: for track [" << thisTrk <<
"] Flag: " << trkD.
ok <<
" ECAL (" << trkD.
okECAL <<
") HCAL (" << trkD.
okHCAL <<
")" << std::endl;
581 if (debug)
std::cout <<
"Propagate track " << thisTrk <<
" charge " << trk.
charge <<
" position " << trk.
position <<
" p " << trk.
momentum <<
" Flag " << trkD.
ok << std::endl;
595 std::cout <<
"propagateCALO:: for track [" << thisTrk <<
"] Flag: " << trkD.
ok <<
" ECAL (" << trkD.
okECAL <<
") HCAL (" << trkD.
okHCAL <<
")" << std::endl;
616 return std::pair<bool,HcalDetId>(
false,
HcalDetId());
649 std::pair<math::XYZPoint,bool>
info =
propagateECAL(vertex,momentum,0,bField,debug);
664 return std::pair<DetId,bool>(eId,info.second);
669 return std::pair<math::XYZPoint,bool>(track.
point,track.
ok);
696 return std::pair<math::XYZPoint,bool>(track.
point,track.
ok);
704 return std::pair<math::XYZPoint,bool>(track1.point,track1.ok);
720 if (
debug)
std::cout <<
"propagateTrackerEnd:: Vertex " << vertex <<
" Momentum " << momentum <<
" Charge " <<
charge <<
" Radius " << radius <<
" Z " << zdist << std::endl;
746 math::XYZPoint vDiff(point.x()-vertex.x(), point.y()-vertex.y(), point.z()-vertex.z());
747 double dphi = direction.
phi()-momentum.
phi();
748 double rdist =
std::sqrt(vDiff.x()*vDiff.x()+vDiff.y()*vDiff.y());
749 double rat = 0.5*dphi/
std::sin(0.5*dphi);
750 double dZ = vDiff.z();
751 double dS = rdist*rat;
755 std::cout <<
"propagateTracker:: Barrel " << tsosb.
isValid() <<
" Endcap " << tsose.
isValid() <<
" OverAll " << ok <<
" Point " << point <<
" RDist " << rdist <<
" dS " << dS <<
" dS/pt " << rdist*rat/momentum.perp() <<
" zdist " << dZ <<
" dz/pz " << dZ/momentum.z() <<
" Length " << length << std::endl;
759 return std::pair<math::XYZPoint,double>(
point,length);
773 if (
debug)
std::cout <<
"propagateCalo:: Vertex " << tpVertex <<
" Momentum " << tpMomentum <<
" Charge " << tpCharge <<
" Radius " << radius <<
" Z " << zdist <<
" Corner " << corner << std::endl;
785 if (tpMomentum.
eta() < 0) {
796 if (absEta < corner) {
810 track.
point.SetXYZ(-999., -999., -999.);
816 std::cout <<
"propagateCalo:: Barrel " << tsosb.
isValid() <<
" Endcap " << tsose.
isValid() <<
" OverAll " << track.
ok <<
" Point " << track.
point <<
" Direction " << track.
direction << std::endl;
820 double rdist =
std::sqrt(vDiff.x()*vDiff.x()+vDiff.y()*vDiff.y());
821 double pt = tpMomentum.
perp();
822 double rat = 0.5*dphi/
std::sin(0.5*dphi);
823 std::cout <<
"RDist " << rdist <<
" pt " << pt <<
" r/pt " << rdist*rat/pt <<
" zdist " << vDiff.z() <<
" pz " << tpMomentum.
z() <<
" z/pz " << vDiff.z()/tpMomentum.
z() << std::endl;
840 edm::SimTrackContainer::const_iterator itr = SimTk->end();
841 for (edm::SimTrackContainer::const_iterator simTrkItr = SimTk->begin(); simTrkItr!= SimTk->end(); simTrkItr++) {
842 if ( simTrkItr->trackId() == thisTrk ) {
844 if (
debug)
std::cout <<
"matched trackId (maximum occurance) " << thisTrk <<
" type " << simTrkItr->type() << std::endl;
851 if (itr != SimTk->end()) {
852 int vertIndex = itr->vertIndex();
853 if (vertIndex != -1 && vertIndex < (
int)SimVtx->size()) {
854 edm::SimVertexContainer::const_iterator simVtxItr= SimVtx->begin();
855 for (
int iv=0; iv<vertIndex; iv++) simVtxItr++;
875 if (debug)
std::cout <<
"Propagate track with charge " <<
charge <<
" position " << vertex <<
" p " << momentum << std::endl;
877 std::pair<HcalDetId,HcalDetId>
ids =
propagateHCAL(geo, bField, vertex, momentum,
charge, typeRZ, rz, debug);
879 (ids.first.ieta() == ids.second.ieta()) &&
880 (ids.first.iphi() == ids.second.iphi()));
888 if (debug)
std::cout <<
"Propagate track " << thisTrk <<
" charge " << trk.
charge <<
" position " << trk.
position <<
" p " << trk.
momentum << std::endl;
892 (ids.first.ieta() == ids.second.ieta()) &&
893 (ids.first.iphi() == ids.second.iphi()));
902 const std::pair<double,double> rz,
bool 909 if (
debug)
std::cout <<
"propagateCalo:: Vertex " << vertex <<
" Momentum " << momentum <<
" Charge " << charge <<
" R/Z " << rz.first <<
" : " << rz.second <<
" Type " << typeRZ << std::endl;
916 for (
int k=0;
k<2; ++
k) {
918 double rzv = (
k == 0) ? rz.first : rz.second;
933 std::cout <<
"Iteration " <<
k <<
" Point " << point <<
" ID ";
942 if (
debug)
std::cout <<
"propagateCalo:: Front " << id1 <<
" Back " << id2 << std::endl;
944 return std::pair<HcalDetId,HcalDetId>(
id1,
id2);
double p() const
momentum vector magnitude
const CaloSubdetectorGeometry * getSubdetectorGeometry(const DetId &id) const
access the subdetector geometry for the given subdetector directly
static const double etaBEEcal
std::vector< spr::propagatedTrackID > propagateCALO(edm::Handle< reco::TrackCollection > &trkCollection, const CaloGeometry *geo, const MagneticField *bField, const std::string &theTrackQuality, bool debug=false)
ROOT::Math::LorentzVector< ROOT::Math::PxPyPzE4D< double > > XYZTLorentzVectorD
Lorentz vector with cylindrical internal representation using pseudorapidity.
static const double zBackTE
static const double etaBEHcal
std::pair< DetId, bool > propagateIdECAL(const HcalDetId &id, const CaloGeometry *geo, const MagneticField *, bool debug=false)
reco::GenParticleCollection::const_iterator trkItr
TrackQuality
track quality
std::pair< math::XYZPoint, bool > propagateHCAL(const reco::Track *, const MagneticField *, bool debug=false)
static const double zFrontHE
Sin< T >::type sin(const T &t)
Geom::Phi< T > phi() const
Global3DPoint GlobalPoint
GlobalPoint globalPosition() const
double phi() const
azimuthal angle of momentum vector
spr::trackAtOrigin simTrackAtOrigin(unsigned int thisTrk, edm::Handle< edm::SimTrackContainer > &SimTk, edm::Handle< edm::SimVertexContainer > &SimVtx, bool debug=false)
static const double zBackHE
GlobalVector directionECAL
spr::propagatedTrack propagateCalo(const GlobalPoint &vertex, const GlobalVector &momentum, int charge, const MagneticField *, float zdist, float radius, float corner, bool debug=false)
double px() const
x coordinate of momentum vector
const math::XYZPoint & outerPosition() const
position of the outermost hit
static const double rFrontHB
HepMC::GenEvent::particle_const_iterator trkItr
const math::XYZPoint & innerPosition() const
position of the innermost hit
static const double rBackHB
static CylinderPointer build(const PositionType &pos, const RotationType &rot, Scalar radius, Bounds *bounds=0)
reco::TrackCollection::const_iterator trkItr
static const double zFrontEE
double eta() const
pseudorapidity of momentum vector
static const double rBackTB
spr::propagatedTrackDirection propagateHCALBack(unsigned int thisTrk, edm::Handle< edm::SimTrackContainer > &SimTk, edm::Handle< edm::SimVertexContainer > &SimVtx, const CaloGeometry *geo, const MagneticField *bField, bool debug=false)
static PlanePointer build(Args &&...args)
static const double rFrontEB
constexpr int subdetId() const
get the contents of the subdetector field (not cast into any detector's numbering enum) ...
Abs< T >::type abs(const T &t)
GlobalVector directionECAL
std::pair< math::XYZPoint, bool > propagateTracker(const reco::Track *, const MagneticField *, bool debug=false)
std::pair< math::XYZPoint, bool > propagateECAL(const reco::Track *, const MagneticField *, bool debug=false)
spr::propagatedTrack propagateTrackToECAL(const reco::Track *, const MagneticField *, bool debug=false)
GlobalPoint getPosition(const DetId &id) const
double pz() const
z coordinate of momentum vector
virtual DetId getClosestCell(const GlobalPoint &r) const
double vz() const
z coordinate of the reference point on track
static TrackQuality qualityByName(const std::string &name)
GlobalVector directionHCAL
const math::XYZVector & outerMomentum() const
momentum vector at the outermost hit position
GlobalVector directionHCAL
static const double zFrontTE
XYZPointD XYZPoint
point in space with cartesian internal representation
std::vector< spr::propagatedTrackID > propagateCosmicCALO(edm::Handle< reco::TrackCollection > &trkCollection, const CaloGeometry *geo, const MagneticField *bField, const std::string &theTrackQuality, bool debug=false)
TrajectoryStateOnSurface propagate(STA const &state, SUR const &surface) const
GlobalVector directionHCAL
bool quality(const TrackQuality) const
Track quality.
double vy() const
y coordinate of the reference point on track
GlobalVector directionECAL
std::pair< math::XYZPoint, double > propagateTrackerEnd(const reco::Track *, const MagneticField *, bool debug=false)
const math::XYZVector & innerMomentum() const
momentum vector at the innermost hit position
reco::TrackCollection::const_iterator trkItr
int charge() const
track electric charge
spr::propagatedTrack propagateTrackToHCAL(const reco::Track *, const MagneticField *, bool debug=false)
static const double etaBETrak
*vegas h *****************************************************used in the default bin number in original ***version of VEGAS is ***a higher bin number might help to derive a more precise ***grade subtle point
double py() const
y coordinate of momentum vector
double vx() const
x coordinate of the reference point on track
Global3DVector GlobalVector
GlobalVector globalDirection() const