CMS 3D CMS Logo

Public Member Functions | Private Types | Private Member Functions | Private Attributes

ConvBremSeedProducer Class Reference

#include <ConvBremSeedProducer.h>

Inheritance diagram for ConvBremSeedProducer:
edm::EDProducer edm::ProducerBase edm::ProductRegistryHelper

List of all members.

Public Member Functions

 ConvBremSeedProducer (const edm::ParameterSet &)
 ~ConvBremSeedProducer ()

Private Types

typedef
GeometricSearchDet::DetWithState 
DetWithState
typedef
SiStripMatchedRecHit2DCollection::const_iterator 
MatDetMatch
typedef
SiStripMatchedRecHit2DCollection::DetSet 
MatDetSet
typedef
SiPixelRecHitCollection::const_iterator 
PiDetMatch
typedef
SiPixelRecHitCollection::DetSet 
PiDetSet
typedef
SiStripRecHit2DCollection::const_iterator 
StDetMatch
typedef
SiStripRecHit2DCollection::DetSet 
StDetSet

Private Member Functions

virtual void beginRun (edm::Run &, const edm::EventSetup &)
const DetLayerdetLayer (const TrackerLayer &layer, float zpos) const
virtual void endRun ()
int GoodCluster (BaseParticlePropagator bpg, const reco::PFClusterCollection &pfc, float minep, bool sec=false)
void initializeLayerMap ()
bool isGsfTrack (TrackingRecHitRefVector, const TrackingRecHit *)
TrajectoryStateOnSurface makeTrajectoryState (const DetLayer *layer, const ParticlePropagator &pp, const MagneticField *field) const
virtual void produce (edm::Event &, const edm::EventSetup &)
std::vector< bool > sharedHits (std::vector< std::pair< TrajectorySeed, std::pair< GlobalVector, float > > >)

Private Attributes

math::XYZVector B_
 B field.
edm::ParameterSet conf_
const MagneticFieldMapfieldMap_
const TrackerInteractionGeometrygeometry_
const GeometricSearchTrackergeomSearchTracker_
const
TransientTrackingRecHitBuilder
hitBuilder_
const KFUpdatorkfUpdator_
std::vector< const DetLayer * > layerMap_
const MagneticFieldmagfield_
int negLayerOffset_
const PropagatorWithMaterialpropagator_
std::vector< const DetLayer * > theLayerMap
const TrackerGeometrytracker_
const TrajectoryStateTransformtransformer_

Detailed Description

Definition at line 41 of file ConvBremSeedProducer.h.


Member Typedef Documentation

Definition at line 48 of file ConvBremSeedProducer.h.

Definition at line 44 of file ConvBremSeedProducer.h.

Definition at line 47 of file ConvBremSeedProducer.h.

Definition at line 43 of file ConvBremSeedProducer.h.

Definition at line 46 of file ConvBremSeedProducer.h.

Definition at line 42 of file ConvBremSeedProducer.h.

Definition at line 45 of file ConvBremSeedProducer.h.


Constructor & Destructor Documentation

ConvBremSeedProducer::ConvBremSeedProducer ( const edm::ParameterSet iConfig) [explicit]

Definition at line 51 of file ConvBremSeedProducer.cc.

                                                                     :
  conf_(iConfig),
  fieldMap_(0),
  layerMap_(56, static_cast<const DetLayer*>(0)),
  negLayerOffset_(27)
{
  produces<ConvBremSeedCollection>();
}
ConvBremSeedProducer::~ConvBremSeedProducer ( )

Definition at line 61 of file ConvBremSeedProducer.cc.

{
 

}

Member Function Documentation

void ConvBremSeedProducer::beginRun ( edm::Run run,
const edm::EventSetup iSetup 
) [private, virtual]
const DetLayer * ConvBremSeedProducer::detLayer ( const TrackerLayer layer,
float  zpos 
) const [private]

Definition at line 527 of file ConvBremSeedProducer.cc.

References TrackerLayer::forward(), layerMap_, TrackerLayer::layerNumber(), and negLayerOffset_.

Referenced by produce().

{
  if (zpos > 0 || !layer.forward() ) return layerMap_[layer.layerNumber()];
  else return layerMap_[layer.layerNumber()+negLayerOffset_];
}
void ConvBremSeedProducer::endRun ( void  ) [private, virtual]

Definition at line 422 of file ConvBremSeedProducer.cc.

References kfUpdator_, and propagator_.

                             {
  delete propagator_;
  delete kfUpdator_;
}
int ConvBremSeedProducer::GoodCluster ( BaseParticlePropagator  bpg,
const reco::PFClusterCollection pfc,
float  minep,
bool  sec = false 
) [private]

Definition at line 610 of file ConvBremSeedProducer.cc.

References eta(), BaseParticlePropagator::getSuccess(), i, RawParticle::momentum(), phi, position, funct::pow(), BaseParticlePropagator::propagateToEcalEntrance(), mathSSE::sqrt(), TwoPi, and RawParticle::vertex().

Referenced by produce().

                                                                                                                      {

  bpg.propagateToEcalEntrance(false);
  float dr=1000;
  float de=1000;
  float df=1000;
  int ibest=-1;

  if(bpg.getSuccess()!=0){

    for (unsigned int i =0; i<pfc.size();i++ ){
      float tmp_ep=pfc[i].energy()/bpg.momentum().e();
      float tmp_phi=fabs(pfc[i].position().phi()-bpg.vertex().phi());
      if (tmp_phi>TMath::TwoPi()) tmp_phi-= TMath::TwoPi(); 
      float tmp_eta=fabs(pfc[i].position().eta()-bpg.vertex().eta());
      float tmp_dr=sqrt(pow(tmp_phi,2)+pow(tmp_eta,2));
      bool isBet=(tmp_dr<dr);
      if (sec) isBet=(tmp_phi<df);
      if ((isBet)&&(tmp_ep>minep)&&(tmp_ep<10)){
        dr=tmp_dr;
        de=tmp_eta;
        df=tmp_phi; 
        ibest=i;
      }
    }
    bool isBad=(dr>0.1);
    if (sec) isBad= ((df>0.25) || (de>0.5));

    if (isBad) ibest=-1;

  }
  return ibest;
}
void ConvBremSeedProducer::initializeLayerMap ( ) [private]

ATTENTION: HARD CODED LOGIC! If Famos layer numbering changes this logic needs to be adapted to the new numbering!

Definition at line 428 of file ConvBremSeedProducer.cc.

References GeometricSearchTracker::barrelLayers(), TrackerInteractionGeometry::cylinderBegin(), TrackerInteractionGeometry::cylinderEnd(), newFWLiteAna::found, geometry_, geomSearchTracker_, i, BoundDisk::innerRadius(), layerMap_, LogDebug, BoundDisk::outerRadius(), GeometricSearchTracker::posForwardLayers(), GloballyPositioned< T >::position(), and Cylinder::radius().

Referenced by produce().

{


  // These are the BoundSurface&, the BoundDisk* and the BoundCylinder* for that layer
  //   const BoundSurface& theSurface = layer.surface();
  //   BoundDisk* theDisk = layer.disk();  // non zero for endcaps
  //   BoundCylinder* theCylinder = layer.cylinder(); // non zero for barrel
  //   int theLayer = layer.layerNumber(); // 1->3 PixB, 4->5 PixD, 
  //                                       // 6->9 TIB, 10->12 TID, 
  //                                       // 13->18 TOB, 19->27 TEC
  
    
    std::vector< BarrelDetLayer*>   barrelLayers = 
      geomSearchTracker_->barrelLayers();
    LogDebug("FastTracker") << "Barrel DetLayer dump: ";
    for (std::vector< BarrelDetLayer*>::const_iterator bl=barrelLayers.begin();
         bl != barrelLayers.end(); ++bl) {
      LogDebug("FastTracker")<< "radius " << (**bl).specificSurface().radius(); 
    }

  std::vector< ForwardDetLayer*>  posForwardLayers = 
    geomSearchTracker_->posForwardLayers();
  LogDebug("FastTracker") << "Positive Forward DetLayer dump: ";
  for (std::vector< ForwardDetLayer*>::const_iterator fl=posForwardLayers.begin();
       fl != posForwardLayers.end(); ++fl) {
    LogDebug("FastTracker") << "Z pos "
                            << (**fl).surface().position().z()
                            << " radii " 
                            << (**fl).specificSurface().innerRadius() 
                            << ", " 
                            << (**fl).specificSurface().outerRadius(); 
  }

  const float rTolerance = 1.5;
  const float zTolerance = 3.;

  LogDebug("FastTracker")<< "Dump of TrackerInteractionGeometry cylinders:";
  for( std::list<TrackerLayer>::const_iterator i=geometry_->cylinderBegin();
       i!=geometry_->cylinderEnd(); ++i) {
    const BoundCylinder* cyl = i->cylinder();
    const BoundDisk* disk = i->disk();

    LogDebug("FastTracker") << "Famos Layer no " << i->layerNumber()
                            << " is sensitive? " << i->sensitive()
                            << " pos " << i->surface().position();
    if (!i->sensitive()) continue;

    if (cyl != 0) {

      LogDebug("FastTracker") << " cylinder radius " << cyl->radius();
      bool found = false;

      for (std::vector< BarrelDetLayer*>::const_iterator 
             bl=barrelLayers.begin(); bl != barrelLayers.end(); ++bl) {

        if (fabs( cyl->radius() - (**bl).specificSurface().radius()) < rTolerance) {

          layerMap_[i->layerNumber()] = *bl;
          found = true;
          LogDebug("FastTracker")<< "Corresponding DetLayer found with radius "
                                 << (**bl).specificSurface().radius();
                  
          break;
        }
      }
      if (!found) {
        LogError("FastTracker") << "FAILED to find a corresponding DetLayer!";
      }
    }
    else {
      LogDebug("FastTracker") << " disk radii " << disk->innerRadius() 
                 << ", " << disk->outerRadius();

      bool found = false;

      for (std::vector< ForwardDetLayer*>::const_iterator fl=posForwardLayers.begin();
           fl != posForwardLayers.end(); ++fl) {
        if (fabs( disk->position().z() - (**fl).surface().position().z()) < zTolerance) {
          layerMap_[i->layerNumber()] = *fl;
          found = true;
          LogDebug("FastTracker") << "Corresponding DetLayer found with Z pos "
                                  << (**fl).surface().position().z()
                                  << " and radii " 
                                  << (**fl).specificSurface().innerRadius() 
                                  << ", " 
                                  << (**fl).specificSurface().outerRadius(); 
          break;
        }
      }
      if (!found) {
        LogError("FastTracker") << "FAILED to find a corresponding DetLayer!";
      }
    }
  }

}
bool ConvBremSeedProducer::isGsfTrack ( TrackingRecHitRefVector  tkv,
const TrackingRecHit h 
) [private]

Definition at line 547 of file ConvBremSeedProducer.cc.

References TrackingRecHit::all, edm::RefVector< C, T, F >::begin(), and edm::RefVector< C, T, F >::end().

Referenced by produce().

                                                                                          {
  trackingRecHit_iterator ib=tkv.begin();
  trackingRecHit_iterator ie=tkv.end();
  bool istaken=false;
  //  for (;ib!=ie-2;++ib){
    for (;ib!=ie;++ib){
    if (istaken) continue;
    if (!((*ib)->isValid())) continue;
 
    istaken = (*ib)->sharesInput(h,TrackingRecHit::all);
  }
  return istaken;
}
TrajectoryStateOnSurface ConvBremSeedProducer::makeTrajectoryState ( const DetLayer layer,
const ParticlePropagator pp,
const MagneticField field 
) const [private]
void ConvBremSeedProducer::produce ( edm::Event iEvent,
const edm::EventSetup iSetup 
) [private, virtual]

INPUT COLLECTIONS

PF CLUSTERS

PIXEL

STRIP

OUTPUT COLLECTION

INITIALIZE

LOOP OVER GSF TRACK COLLECTION

FIND THE CLUSTER ASSOCIATED TO THE GSF TRACK

LOOP OVER BREM PHOTONS

BREM SELECTION

LOOP OVER TRACKER LAYER

TRACKER LAYER SELECTION

FIND COMPATIBLE MODULES

MODULE TRIPLETS SELECTION

SEED CREATION

Implements edm::EDProducer.

Definition at line 69 of file ConvBremSeedProducer.cc.

References alongMomentum, anyDirection, B_, edmNew::DetSet< T >::begin(), TransientTrackingRecHitBuilder::build(), GlobalTrajectoryParameters::charge(), edm::OwnVector< T, P >::clear(), clone(), GeometricSearchDet::compatibleDets(), conf_, TrackerInteractionGeometry::cylinderBegin(), TrackerInteractionGeometry::cylinderEnd(), cond::rpcobgas::detid, detLayer(), edmNew::DetSet< T >::end(), edm::EventID::event(), fieldMap_, spr::find(), first, geometry_, edm::Event::getByLabel(), BaseParticlePropagator::getMagneticField(), edm::ParameterSet::getParameter(), BaseParticlePropagator::getSuccess(), GoodCluster(), hitBuilder_, i, edm::EventBase::id(), TrackerGeometry::idToDet(), initializeLayerMap(), isGsfTrack(), TrajectoryStateOnSurface::isValid(), kfUpdator_, LogDebug, magfield_, makeTrajectoryState(), GlobalTrajectoryParameters::momentum(), convertSQLitetoXML_cfg::output, AlCaHLTBitMon_ParallelJobs::p, FreeTrajectoryState::parameters(), PV3DBase< T, PVType, FrameType >::perp(), trajectoryStateTransform::persistentState(), GeomDetEnumerators::PixelBarrel, GeomDetEnumerators::PixelEndcap, pos, position, GlobalTrajectoryParameters::position(), edm::Handle< T >::product(), PropagatorWithMaterial::propagate(), BaseParticlePropagator::propagate(), propagator_, edm::OwnVector< T, P >::push_back(), edm::Event::put(), edm::EventID::run(), RawParticle::setCharge(), ParticlePropagator::setPropagationConditions(), sharedHits(), mathSSE::sqrt(), FastHelix::stateAtVertex(), DetLayer::subDetector(), GeomDet::surface(), groupFilesInBlocks::temp, tmp, tracker_, KFUpdator::update(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), PV3DBase< T, PVType, FrameType >::z(), and RawParticle::Z().

{
 
  LogDebug("ConvBremSeedProducerProducer")<<"START event: "<<iEvent.id().event()
                                          <<" in run "<<iEvent.id().run();

  float pfmass=  0.0005;


  Handle<PFClusterCollection> PfC;
  iEvent.getByLabel(conf_.getParameter<InputTag>("PFClusters") ,PfC);
  const PFClusterCollection& PPP= *(PfC.product());
 
  Handle<SiPixelRecHitCollection> pixelHits;
  iEvent.getByLabel(conf_.getParameter<InputTag>("pixelRecHits") , pixelHits);

  Handle<SiStripRecHit2DCollection> rphirecHits;
  iEvent.getByLabel(conf_.getParameter<InputTag>("rphirecHits"),rphirecHits);
  Handle<SiStripRecHit2DCollection> stereorecHits;
  iEvent.getByLabel(conf_.getParameter<InputTag>("stereorecHits"), stereorecHits);
  Handle<SiStripMatchedRecHit2DCollection> matchedrecHits;
  iEvent.getByLabel(conf_.getParameter<InputTag>("matchedrecHits"), matchedrecHits);

  //GSFPFRECTRACKS
  Handle<GsfPFRecTrackCollection> thePfRecTrackCollection;
  iEvent.getByLabel(conf_.getParameter<InputTag>("PFRecTrackLabel"),
                    thePfRecTrackCollection);
  const GsfPFRecTrackCollection PfRTkColl = *(thePfRecTrackCollection.product()); 


  std::auto_ptr<ConvBremSeedCollection> output(new ConvBremSeedCollection);


  vector<pair< TrajectorySeed , pair<GlobalVector,float> > > unclean;
  //TRIPLET OF MODULES TO BE USED FOR SEEDING
  vector< vector< long int > > tripl;
  //LAYER MAP
  initializeLayerMap(); 




  for(unsigned int ipft=0;ipft<PfRTkColl.size();ipft++){
    GsfPFRecTrackRef pft(thePfRecTrackCollection,ipft);
    LogDebug("ConvBremSeedProducerProducer")<<"NEW GsfPFRecTRACK ";
    float eta_br=0;
    unclean.clear();
    tripl.clear();
    vector<int> gc;
    TrackingRecHitRefVector gsfRecHits=pft->gsfTrackRef()->extra()->recHits();
    float pfoutenergy=sqrt((pfmass*pfmass)+pft->gsfTrackRef()->outerMomentum().Mag2());
    XYZTLorentzVector mom =XYZTLorentzVector(pft->gsfTrackRef()->outerMomentum().x(),
                                             pft->gsfTrackRef()->outerMomentum().y(),
                                             pft->gsfTrackRef()->outerMomentum().z(),
                                             pfoutenergy);
    XYZTLorentzVector pos =   XYZTLorentzVector(pft->gsfTrackRef()->outerPosition().x(),
                                                pft->gsfTrackRef()->outerPosition().y(),
                                                pft->gsfTrackRef()->outerPosition().z(),
                                                0.);
    BaseParticlePropagator theOutParticle=BaseParticlePropagator( RawParticle(mom,pos),
                                                                  0,0,B_.z());
    theOutParticle.setCharge(pft->gsfTrackRef()->charge());

    gc.push_back(GoodCluster(theOutParticle,PPP,0.5));


    vector<PFBrem> brem =(*pft).PFRecBrem();
    vector<PFBrem>::iterator ib=brem.begin();
    vector<PFBrem>::iterator ib_end=brem.end();
    LogDebug("ConvBremSeedProducerProducer")<<"NUMBER OF BREMS "<<brem.size();

    for (;ib!=ib_end;++ib){
    
      XYZTLorentzVector mom=pft->trajectoryPoint(ib->indTrajPoint()).momentum();
      XYZTLorentzVector pos=
        XYZTLorentzVector(
                          pft->trajectoryPoint(ib->indTrajPoint()).position().x(),
                          pft->trajectoryPoint(ib->indTrajPoint()).position().y(),
                          pft->trajectoryPoint(ib->indTrajPoint()).position().z(),
                          0);
      
      if (pos.Rho()>80) continue;
      if ((pos.Rho()>5)&&(fabs(ib->SigmaDeltaP()/ib->DeltaP())>3)) continue;  
      if (fabs(ib->DeltaP())<3) continue;
      eta_br=mom.eta();
      vector< vector< long int > >Idd;
      


      BaseParticlePropagator p( RawParticle(mom,pos),
                                0,0,B_.z());
      p.setCharge(0);
      gc.push_back(GoodCluster(p,PPP,0.2));

      ParticlePropagator PP(p,fieldMap_);

      list<TrackerLayer>::const_iterator cyliter= geometry_->cylinderBegin();
      for ( ; cyliter != geometry_->cylinderEnd() ; ++cyliter ) {

       if (!(cyliter->sensitive())) continue;
       PP.setPropagationConditions(*cyliter);
       PP.propagate();    
       if (PP.getSuccess()==0) continue;

       LocalMagneticField mf(PP.getMagneticField());
       AnalyticalPropagator alongProp(&mf, anyDirection);
       InsideBoundsMeasurementEstimator est;
       const DetLayer* tkLayer = detLayer(*cyliter,PP.Z());
       if (&(*tkLayer)==0) continue;
       TrajectoryStateOnSurface trajState = makeTrajectoryState( tkLayer, PP, &mf);
            
       std::vector<DetWithState> compat 
         = tkLayer->compatibleDets( trajState, alongProp, est);
       vector <long int> temp;
       if (compat.size()==0) continue;

       for (std::vector<DetWithState>::const_iterator i=compat.begin(); i!=compat.end(); i++) {
              
         long int detid=i->first->geographicalId().rawId();
         
         if ((tkLayer->subDetector()!=GeomDetEnumerators::PixelBarrel)&&
             (tkLayer->subDetector()!=GeomDetEnumerators::PixelEndcap)){
           
            
           StDetMatch DetMatch = (rphirecHits.product())->find((detid));
           MatDetMatch MDetMatch =(matchedrecHits.product())->find((detid));
           
                
           long int DetID=(DetMatch != rphirecHits->end())? detid:0;

           if ((MDetMatch != matchedrecHits->end()) && !MDetMatch->empty()) {
             long int pii = MDetMatch->begin()->monoId();
             StDetMatch CDetMatch = (rphirecHits.product())->find((pii));
             DetID=(CDetMatch != rphirecHits->end())? pii:0;
             
           }

           temp.push_back(DetID);
           
         }
         else{
           PiDetMatch DetMatch = (pixelHits.product())->find((detid));
           long int DetID=(DetMatch != pixelHits->end())? detid:0;
           temp.push_back(DetID);
        
        
         }
       }

       Idd.push_back(temp);

      }//END TRACKER LAYER LOOP
      if(Idd.size()<2)continue;

      for (unsigned int i=0;i<Idd.size()-2;i++){
        for (unsigned int i1=0;i1<Idd[i].size();i1++){
          for (unsigned int i2=0;i2<Idd[i+1].size();i2++){
            for (unsigned int i3=0;i3<Idd[i+2].size();i3++){
              if ((Idd[i][i1]!=0) &&(Idd[i+1][i2]!=0) &&(Idd[i+2][i3]!=0) ){
                vector<long int >tmp;
                tmp.push_back(Idd[i][i1]);  tmp.push_back(Idd[i+1][i2]); tmp.push_back(Idd[i+2][i3]);
                
                bool newTrip=true;
                for (unsigned int iv=0;iv<tripl.size();iv++){
                  if((tripl[iv][0]==tmp[0])&&(tripl[iv][1]==tmp[1])&&(tripl[iv][2]==tmp[2])) newTrip=false;

                }
                if (newTrip){

                  tripl.push_back(tmp);
                }
              }
            }     
          }       
        }
      }
    }//END BREM LOOP

    float sineta_brem =sinh(eta_br);
    

    //OUTPUT COLLECTION

    TransientTrackingRecHit::ConstRecHitContainer glob_hits;
    OwnVector<TrackingRecHit> loc_hits;
    for (unsigned int i=0;i<tripl.size();i++){
      StDetMatch DetMatch1 = (rphirecHits.product())->find(tripl[i][0]);
      StDetMatch DetMatch2 = (rphirecHits.product())->find(tripl[i][1]);
      StDetMatch DetMatch3 = (rphirecHits.product())->find(tripl[i][2]);
      if ((DetMatch1 == rphirecHits->end()) ||
          (DetMatch2 == rphirecHits->end()) ||
          (DetMatch3 == rphirecHits->end()) )  continue;
      StDetSet DetSet1 = *DetMatch1;
      StDetSet DetSet2 = *DetMatch2;
      StDetSet DetSet3 = *DetMatch3;

      for (StDetSet::const_iterator it1=DetSet1.begin();it1!=DetSet1.end();++it1){
        GlobalPoint gp1=tracker_->idToDet(tripl[i][0])->surface().
          toGlobal(it1->localPosition());

        bool tak1=isGsfTrack(gsfRecHits,&(*it1));
        
        for (StDetSet::const_iterator it2=DetSet2.begin();it2!=DetSet2.end();++it2){
          GlobalPoint gp2=tracker_->idToDet(tripl[i][1])->surface().
            toGlobal(it2->localPosition());
          bool tak2=isGsfTrack(gsfRecHits,&(*it2));

          for (StDetSet::const_iterator it3=DetSet3.begin();it3!=DetSet3.end();++it3){
            //  ips++;
            GlobalPoint gp3=tracker_->idToDet(tripl[i][2])->surface().
              toGlobal(it3->localPosition());    
            bool tak3=isGsfTrack(gsfRecHits,&(*it3));  
            

            FastHelix helix(gp3, gp2, gp1,iSetup);
            GlobalVector gv=helix.stateAtVertex().parameters().momentum();
            GlobalVector gv_corr(gv.x(),gv.y(),gv.perp()*sineta_brem);
            float ene= sqrt(gv_corr.mag2()+(pfmass*pfmass));

            GlobalPoint gp=helix.stateAtVertex().parameters().position();
            float ch=helix.stateAtVertex().parameters().charge();




            XYZTLorentzVector mom = XYZTLorentzVector(gv.x(),gv.y(),gv_corr.z(),ene);
            XYZTLorentzVector pos = XYZTLorentzVector(gp.x(),gp.y(),gp.z(),0.);
            BaseParticlePropagator theOutParticle(RawParticle(mom,pos),0,0,B_.z());
            theOutParticle.setCharge(ch);
            int bgc=GoodCluster(theOutParticle,PPP,0.3,true);

            if (gv.perp()<0.5) continue;

            if (tak1+tak2+tak3>2) continue;

            if (bgc==-1) continue;
            bool clTak=false;
            for (unsigned int igcc=0; igcc<gc.size(); igcc++){
              if (clTak) continue;
              if (bgc==gc[igcc]) clTak=true;
            }
            if (clTak) continue;




            GlobalTrajectoryParameters Gtp(gp1,
                                           gv,int(ch), 
                                           &(*magfield_));
            glob_hits.clear(); loc_hits.clear();
            glob_hits.push_back(hitBuilder_->build(it1->clone()));
            glob_hits.push_back(hitBuilder_->build(it2->clone()));
            glob_hits.push_back(hitBuilder_->build(it3->clone()));


            FreeTrajectoryState CSeed(Gtp,
                                      CurvilinearTrajectoryError(AlgebraicSymMatrix55(AlgebraicMatrixID())));
            TrajectoryStateOnSurface updatedState;        
  
            for (int ih=0;ih<3;ih++){

              TrajectoryStateOnSurface state = (ih==0)?
                propagator_->propagate(CSeed,
                                       tracker_->idToDet(tripl[i][ih])->surface()):
                propagator_->propagate(updatedState,
                                       tracker_->idToDet(tripl[i][ih])->surface());
              
              if (!state.isValid()){ 
                ih=3;
                continue;}

              updatedState =  kfUpdator_->update(state, *glob_hits[ih]);
              loc_hits.push_back(glob_hits[ih]->hit()->clone());
              if (ih==2){
                PTrajectoryStateOnDet const & PTraj= 
                  trajectoryStateTransform::persistentState(updatedState,tripl[i][2]);
                //              output->push_back(Trajectoryseed(PTraj,loc_hits,alongMomentum));
                unclean.push_back(make_pair(TrajectorySeed(PTraj,loc_hits,alongMomentum), 
                                            make_pair(gv_corr,ch)));
              }
              //    }

            }
          }    
        }    
      }
    }
    vector<bool> inPhot = sharedHits(unclean);
    for (unsigned int iu=0; iu<unclean.size();iu++){

      if (inPhot[iu])
        output->push_back(ConvBremSeed(unclean[iu].first,pft));

    }

  } //END GSF TRACK COLLECTION LOOP 
  LogDebug("ConvBremSeedProducerProducer")<<"END";
  iEvent.put(output);
    
}
vector< bool > ConvBremSeedProducer::sharedHits ( std::vector< std::pair< TrajectorySeed, std::pair< GlobalVector, float > > >  ) [private]

Definition at line 560 of file ConvBremSeedProducer.cc.

References TrackingRecHit::all, i, and edm::second().

Referenced by produce().

                                                                        {

  vector<bool> goodseed;
  goodseed.clear();
  if (unclean.size()<2){
    for (unsigned int i=0;i<unclean.size();i++)
      goodseed.push_back(true);
  }else{
 
    for (unsigned int i=0;i<unclean.size();i++)
      goodseed.push_back(true);
    
    for (unsigned int iu=0; iu<unclean.size()-1;iu++){   
      if (!goodseed[iu]) continue;
      for (unsigned int iu2=iu+1; iu2<unclean.size();iu2++){
        if (!goodseed[iu]) continue;
        if (!goodseed[iu2]) continue;
      //    if (unclean[iu].second.second *unclean[iu2].second.second >0)continue;
        
        TrajectorySeed::const_iterator sh = unclean[iu].first.recHits().first;
        TrajectorySeed::const_iterator sh_end = unclean[iu].first.recHits().second; 
        
        unsigned int shar =0;
        for (;sh!=sh_end;++sh){ 

          TrajectorySeed::const_iterator sh2 = unclean[iu2].first.recHits().first;
          TrajectorySeed::const_iterator sh2_end = unclean[iu2].first.recHits().second; 
        for (;sh2!=sh2_end;++sh2){

          if ((*sh).sharesInput(&(*sh2),TrackingRecHit::all))

            shar++;

        }
        }
        if (shar>=2){
        if (unclean[iu].second.first.perp()<unclean[iu2].second.first.perp()) goodseed[iu]=false;
        else goodseed[iu2]=false;
        }
      
      } 
 
    }
  }
  return goodseed;
}

Member Data Documentation

B field.

Definition at line 86 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and produce().

Definition at line 73 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and produce().

Definition at line 78 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and produce().

Definition at line 75 of file ConvBremSeedProducer.h.

Referenced by beginRun(), initializeLayerMap(), and produce().

Definition at line 74 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and initializeLayerMap().

Definition at line 81 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and produce().

Definition at line 80 of file ConvBremSeedProducer.h.

Referenced by beginRun(), endRun(), and produce().

std::vector<const DetLayer*> ConvBremSeedProducer::layerMap_ [private]

Definition at line 83 of file ConvBremSeedProducer.h.

Referenced by detLayer(), and initializeLayerMap().

Definition at line 77 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and produce().

Definition at line 84 of file ConvBremSeedProducer.h.

Referenced by detLayer().

Definition at line 79 of file ConvBremSeedProducer.h.

Referenced by beginRun(), endRun(), and produce().

std::vector<const DetLayer*> ConvBremSeedProducer::theLayerMap [private]

Definition at line 59 of file ConvBremSeedProducer.h.

Definition at line 76 of file ConvBremSeedProducer.h.

Referenced by beginRun(), and produce().

Definition at line 82 of file ConvBremSeedProducer.h.