309 {
310
311
312
313 MsgStream log(
msgSvc(), name());
314 log << MSG::INFO << "in execute()" << endreq;
315
316 SmartDataPtr<Event::EventHeader> eventHeader(eventSvc(),"/Event/EventHeader");
317 int runNo=eventHeader->runNumber();
318 int event=eventHeader->eventNumber();
319 log << MSG::DEBUG <<"run, evtnum = "
321 << event <<endreq;
322 cout<<"event "<<event<<endl;
324
326
327 log << MSG::DEBUG <<"ncharg, nneu, tottks = "
328 << evtRecEvent->totalCharged() << " , "
329 << evtRecEvent->totalNeutral() << " , "
330 << evtRecEvent->totalTracks() <<endreq;
331
333
334
335
336
337 Vint iGood, ipip, ipim;
338 iGood.clear();
339 ipip.clear();
340 ipim.clear();
342 ppip.clear();
343 ppim.clear();
344
345 int nCharge = 0;
346
347 Hep3Vector xorigin(0,0,0);
348
349
350
351
352
353
354
355
356
357
358
359 SmartIF<IVertexDbSvc> m_vtxSvc;
360 m_vtxSvc = serviceLocator()->service("VertexDbSvc");
361 if(m_vtxSvc->isVertexValid()){
362
363 double* dbv = m_vtxSvc->PrimaryVertex();
364 double* vv = m_vtxSvc->SigmaPrimaryVertex();
365 xorigin.setX(dbv[0]);
366 xorigin.setY(dbv[1]);
367 xorigin.setZ(dbv[2]);
368 }
369
370 for(int i = 0; i < evtRecEvent->totalCharged(); i++){
372 if(!(*itTrk)->isMdcTrackValid()) continue;
373 RecMdcTrack *mdcTrk = (*itTrk)->mdcTrack();
374 double pch=mdcTrk->
p();
375 double x0=mdcTrk->
x();
376 double y0=mdcTrk->
y();
377 double z0=mdcTrk->
z();
378 double theta0=mdcTrk->
theta();
379 double phi0=mdcTrk->
helix(1);
380 double xv=xorigin.x();
381 double yv=xorigin.y();
382 double Rxy=(x0-xv)*
cos(phi0)+(y0-yv)*
sin(phi0);
383 m_vx0 = x0;
384 m_vy0 = y0;
385 m_vz0 = z0;
386 m_vr0 = Rxy;
387
388 HepVector a = mdcTrk->
helix();
389 HepSymMatrix Ea = mdcTrk->
err();
391 HepPoint3D IP(xorigin[0],xorigin[1],xorigin[2]);
392 VFHelix helixip(point0,a,Ea);
393 helixip.pivot(IP);
394 HepVector vecipa = helixip.a();
395 double Rvxy0=fabs(vecipa[0]);
396 double Rvz0=vecipa[3];
397 double Rvphi0=vecipa[1];
398 m_rvxy0=Rvxy0;
399 m_rvz0=Rvz0;
400 m_rvphi0=Rvphi0;
401
402 m_tuple1->write();
403
404
405
406 if(fabs(Rvz0) >= 10.0) continue;
407 if(fabs(Rvxy0) >= 1.0) continue;
408 if(fabs(
cos(theta0)) >= 0.93)
continue;
409
410 iGood.push_back(i);
411 nCharge += mdcTrk->
charge();
412 }
413
414
415
416
417 int nGood = iGood.size();
418 log << MSG::DEBUG << "ngood, totcharge = " << nGood << " , " << nCharge << endreq;
419 if((nGood != 2)||(nCharge!=0)){
420 return StatusCode::SUCCESS;
421 }
423
425 iGam.clear();
426 for(int i = evtRecEvent->totalCharged(); i< evtRecEvent->totalTracks(); i++) {
428 if(!(*itTrk)->isEmcShowerValid()) continue;
429 RecEmcShower *emcTrk = (*itTrk)->emcShower();
430 Hep3Vector emcpos(emcTrk->
x(), emcTrk->
y(), emcTrk->
z());
431
432 double dthe = 200.;
433 double dphi = 200.;
434 double dang = 200.;
435 for(int j = 0; j < evtRecEvent->totalCharged(); j++) {
437 if(!(*jtTrk)->isExtTrackValid()) continue;
438 RecExtTrack *extTrk = (*jtTrk)->extTrack();
441
442 double angd = extpos.angle(emcpos);
443 double thed = extpos.theta() - emcpos.theta();
444 double phid = extpos.deltaPhi(emcpos);
445 thed = fmod(thed+CLHEP::twopi+CLHEP::twopi+
pi, CLHEP::twopi) - CLHEP::pi;
446 phid = fmod(phid+CLHEP::twopi+CLHEP::twopi+
pi, CLHEP::twopi) - CLHEP::pi;
447 if(angd < dang){
448 dang = angd;
449 dthe = thed;
450 dphi = phid;
451 }
452 }
453 if(dang>=200) continue;
454 double eraw = emcTrk->
energy();
457 dthe = dthe * 180 / (CLHEP::pi);
458 dphi = dphi * 180 / (CLHEP::pi);
459 dang = dang * 180 / (CLHEP::pi);
460 m_dthe = dthe;
461 m_dphi = dphi;
462 m_dang = dang;
463 m_eraw = eraw;
464 m_tuple2->write();
465
467 {if(eraw <= (m_energyThreshold/2)) continue;}
469 {if(eraw <= m_energyThreshold) continue;}
470 else continue;
471
472
473
474 if(fabs(dang) < m_gammaAngleCut) continue;
475
477
478
479
480
481 iGam.push_back(i);
482 }
483
484
485
486
487 int nGam = iGam.size();
488
489 log << MSG::DEBUG << "num Good Photon " << nGam << " , " <<evtRecEvent->totalNeutral()<<endreq;
490 if(nGam<2){
491 return StatusCode::SUCCESS;
492 }
494
495
496
497
498
499
500
501
502
503 if(m_checkDedx == 1) {
504 for(int i = 0; i < nGood; i++) {
506 if(!(*itTrk)->isMdcTrackValid()) continue;
507 if(!(*itTrk)->isMdcDedxValid())continue;
508 RecMdcTrack* mdcTrk = (*itTrk)->mdcTrack();
509 RecMdcDedx* dedxTrk = (*itTrk)->mdcDedx();
510 m_ptrk = mdcTrk->
p();
511
512 m_chie = dedxTrk->
chiE();
513 m_chimu = dedxTrk->
chiMu();
514 m_chipi = dedxTrk->
chiPi();
515 m_chik = dedxTrk->
chiK();
516 m_chip = dedxTrk->
chiP();
519 m_probPH = dedxTrk->
probPH();
520 m_normPH = dedxTrk->
normPH();
521 m_tuple7->write();
522 }
523 }
524
525
526
527
528
529
530 if(m_checkTof == 1) {
531 for(int i = 0; i < nGood; i++) {
533 if(!(*itTrk)->isMdcTrackValid()) continue;
534 if(!(*itTrk)->isTofTrackValid()) continue;
535
536 RecMdcTrack * mdcTrk = (*itTrk)->mdcTrack();
537 SmartRefVector<RecTofTrack> tofTrkCol = (*itTrk)->tofTrack();
538
539 double ptrk = mdcTrk->
p();
540
541 SmartRefVector<RecTofTrack>::iterator iter_tof = tofTrkCol.begin();
542 for(;iter_tof != tofTrkCol.end(); iter_tof++ ) {
543 TofHitStatus *status = new TofHitStatus;
544 status->
setStatus((*iter_tof)->status());
547 if( status->
layer()!=0 )
continue;
548 double path=(*iter_tof)->path();
549 double tof = (*iter_tof)->tof();
550 double ph = (*iter_tof)->ph();
551 double rhit = (*iter_tof)->zrhit();
552 double qual = 0.0 + (*iter_tof)->quality();
553 double cntr = 0.0 + (*iter_tof)->tofID();
554 double texp[5];
555 for(int j = 0; j < 5; j++) {
557 double beta = gb/sqrt(1+gb*gb);
558 texp[j] = 10 * path /beta/
velc;
559 }
560 m_cntr_etof = cntr;
562 m_ph_etof = ph;
563 m_rhit_etof = rhit;
564 m_qual_etof = qual;
565 m_te_etof = tof - texp[0];
566 m_tmu_etof = tof - texp[1];
567 m_tpi_etof = tof - texp[2];
568 m_tk_etof = tof - texp[3];
569 m_tp_etof = tof - texp[4];
570 m_tuple8->write();
571 }
572 else {
574 if(status->
layer()==1){
575 double path=(*iter_tof)->path();
576 double tof = (*iter_tof)->tof();
577 double ph = (*iter_tof)->ph();
578 double rhit = (*iter_tof)->zrhit();
579 double qual = 0.0 + (*iter_tof)->quality();
580 double cntr = 0.0 + (*iter_tof)->tofID();
581 double texp[5];
582 for(int j = 0; j < 5; j++) {
584 double beta = gb/sqrt(1+gb*gb);
585 texp[j] = 10 * path /beta/
velc;
586 }
587
588 m_cntr_btof1 = cntr;
590 m_ph_btof1 = ph;
591 m_zhit_btof1 = rhit;
592 m_qual_btof1 = qual;
593 m_te_btof1 = tof - texp[0];
594 m_tmu_btof1 = tof - texp[1];
595 m_tpi_btof1 = tof - texp[2];
596 m_tk_btof1 = tof - texp[3];
597 m_tp_btof1 = tof - texp[4];
598 m_tuple9->write();
599 }
600
601 if(status->
layer()==2){
602 double path=(*iter_tof)->path();
603 double tof = (*iter_tof)->tof();
604 double ph = (*iter_tof)->ph();
605 double rhit = (*iter_tof)->zrhit();
606 double qual = 0.0 + (*iter_tof)->quality();
607 double cntr = 0.0 + (*iter_tof)->tofID();
608 double texp[5];
609 for(int j = 0; j < 5; j++) {
611 double beta = gb/sqrt(1+gb*gb);
612 texp[j] = 10 * path /beta/
velc;
613 }
614
615 m_cntr_btof2 = cntr;
617 m_ph_btof2 = ph;
618 m_zhit_btof2 = rhit;
619 m_qual_btof2 = qual;
620 m_te_btof2 = tof - texp[0];
621 m_tmu_btof2 = tof - texp[1];
622 m_tpi_btof2 = tof - texp[2];
623 m_tk_btof2 = tof - texp[3];
624 m_tp_btof2 = tof - texp[4];
625 m_tuple10->write();
626 }
627 }
628
629 delete status;
630 }
631 }
632 }
633
634
635
636
637
638
640 pGam.clear();
641 for(int i = 0; i < nGam; i++) {
643 RecEmcShower* emcTrk = (*itTrk)->emcShower();
644 double eraw = emcTrk->
energy();
645 double phi = emcTrk->
phi();
646 double the = emcTrk->
theta();
647 HepLorentzVector
ptrk;
652
653
654
655 pGam.push_back(
ptrk);
656 }
657
658
659
660
662 for(int i = 0; i < nGood; i++) {
664
667
668
671
674
675
678 RecMdcTrack* mdcTrk = (*itTrk)->mdcTrack();
679 m_ptrk_pid = mdcTrk->
p();
685 m_tuple11->write();
686
688
689
690
691 RecMdcKalTrack* mdcKalTrk = (*itTrk)->mdcKalTrack();
693
694 if(mdcKalTrk->
charge() >0) {
695 ipip.push_back(iGood[i]);
696 HepLorentzVector
ptrk;
697 ptrk.setPx(mdcKalTrk->
px());
698 ptrk.setPy(mdcKalTrk->
py());
699 ptrk.setPz(mdcKalTrk->
pz());
702
703
704
705 ppip.push_back(
ptrk);
706 } else {
707 ipim.push_back(iGood[i]);
708 HepLorentzVector
ptrk;
709 ptrk.setPx(mdcKalTrk->
px());
710 ptrk.setPy(mdcKalTrk->
py());
711 ptrk.setPz(mdcKalTrk->
pz());
714
715
716
717 ppim.push_back(
ptrk);
718 }
719 }
720
721
722
723
724
725
726
727
728
729
730
731
732
733
734
735
736
737
738
739
740
741
742
743
744
745
746
747 int npip = ipip.size();
748 int npim = ipim.size();
749 if(npip*npim != 1) return SUCCESS;
750
752
753
754
755
756
757
758 HepLorentzVector pTot;
759 for(int i = 0; i < nGam - 1; i++){
760 for(int j = i+1; j < nGam; j++) {
761 HepLorentzVector p2g = pGam[i] + pGam[j];
762 pTot = ppip[0] + ppim[0];
763 pTot += p2g;
764 m_m2gg = p2g.m();
765 m_etot = pTot.e();
766 m_tuple3 -> write();
767
768 }
769 }
770
771
772 RecMdcKalTrack *pipTrk = (*(evtRecTrkCol->begin()+ipip[0]))->mdcKalTrack();
773 RecMdcKalTrack *pimTrk = (*(evtRecTrkCol->begin()+ipim[0]))->mdcKalTrack();
774
775 WTrackParameter wvpipTrk, wvpimTrk;
778
779
780
781
782
783
784
785
786
787
788
790 HepSymMatrix Evx(3, 0);
791 double bx = 1E+6;
792 double by = 1E+6;
793 double bz = 1E+6;
794 Evx[0][0] = bx*bx;
795 Evx[1][1] = by*by;
796 Evx[2][2] = bz*bz;
797
798 VertexParameter vxpar;
801
807 if(!vtxfit->
Fit(0))
return SUCCESS;
809
810 WTrackParameter wpip = vtxfit->
wtrk(0);
811 WTrackParameter wpim = vtxfit->
wtrk(1);
812
813
815
816
817
818
819
820 if(m_test4C==1) {
821
822 HepLorentzVector
ecms(0.034,0,0,3.097);
823
824 double chisq = 9999.;
825 int ig1 = -1;
826 int ig2 = -1;
827 for(int i = 0; i < nGam-1; i++) {
828 RecEmcShower *g1Trk = (*(evtRecTrkCol->begin()+iGam[i]))->emcShower();
829 for(int j = i+1; j < nGam; j++) {
830 RecEmcShower *g2Trk = (*(evtRecTrkCol->begin()+iGam[j]))->emcShower();
837 bool oksq = kmfit->
Fit();
838 if(oksq) {
839 double chi2 = kmfit->
chisq();
840 if(chi2 < chisq) {
841 chisq = chi2;
842 ig1 = iGam[i];
843 ig2 = iGam[j];
844 }
845 }
846 }
847 }
848
849 if(chisq < 200) {
850
851 RecEmcShower *g1Trk = (*(evtRecTrkCol->begin()+ig1))->emcShower();
852 RecEmcShower *g2Trk = (*(evtRecTrkCol->begin()+ig2))->emcShower();
859 bool oksq = kmfit->
Fit();
860 if(oksq) {
861 HepLorentzVector ppi0 = kmfit->
pfit(2) + kmfit->
pfit(3);
862 m_mpi0 = ppi0.m();
863 m_chi1 = kmfit->
chisq();
864 m_tuple4->write();
866 }
867 }
868 }
869
870
871
872
873
874
875 if(m_test5C==1) {
876
877 HepLorentzVector
ecms(0.034,0,0,3.097);
878 double chisq = 9999.;
879 int ig1 = -1;
880 int ig2 = -1;
881 for(int i = 0; i < nGam-1; i++) {
882 RecEmcShower *g1Trk = (*(evtRecTrkCol->begin()+iGam[i]))->emcShower();
883 for(int j = i+1; j < nGam; j++) {
884 RecEmcShower *g2Trk = (*(evtRecTrkCol->begin()+iGam[j]))->emcShower();
892 if(!kmfit->
Fit(0))
continue;
893 if(!kmfit->
Fit(1))
continue;
894 bool oksq = kmfit->
Fit();
895 if(oksq) {
896 double chi2 = kmfit->
chisq();
897 if(chi2 < chisq) {
898 chisq = chi2;
899 ig1 = iGam[i];
900 ig2 = iGam[j];
901 }
902 }
903 }
904 }
905
906
907 log << MSG::INFO << " chisq = " << chisq <<endreq;
908
909 if(chisq < 200) {
910 RecEmcShower* g1Trk = (*(evtRecTrkCol->begin()+ig1))->emcShower();
911 RecEmcShower* g2Trk = (*(evtRecTrkCol->begin()+ig2))->emcShower();
912
920 bool oksq = kmfit->
Fit();
921 if(oksq){
922 HepLorentzVector ppi0 = kmfit->
pfit(2) + kmfit->
pfit(3);
923 HepLorentzVector prho0 = kmfit->
pfit(0) + kmfit->
pfit(1);
924 HepLorentzVector prhop = ppi0 + kmfit->
pfit(0);
925 HepLorentzVector prhom = ppi0 + kmfit->
pfit(1);
926
927 m_chi2 = kmfit->
chisq();
928 m_mrh0 = prho0.m();
929 m_mrhp = prhop.m();
930 m_mrhm = prhom.m();
931 double eg1 = (kmfit->
pfit(2)).e();
932 double eg2 = (kmfit->
pfit(3)).e();
933 double fcos =
abs(eg1-eg2)/ppi0.rho();
934 m_tuple5->write();
936
937
938
939
940 if(fabs(prho0.m()-0.770)<0.150) {
941 if(fabs(fcos)<0.99) {
942 m_fcos = (eg1-eg2)/ppi0.rho();
943 m_elow = (eg1 < eg2) ? eg1 : eg2;
944 m_tuple6->write();
946 }
947 }
948 }
949 }
950 }
951 return StatusCode::SUCCESS;
952}
double sin(const BesAngle a)
double cos(const BesAngle a)
EvtRecTrackCol::iterator EvtRecTrackIterator
HepGeom::Point3D< double > HepPoint3D
std::vector< HepLorentzVector > Vp4
const Hep3Vector emcPosition() const
const int emcVolumeNumber() const
static void setPidType(PidType pidType)
const double theta() const
const HepSymMatrix err() const
const HepVector helix() const
......
void AddFourMomentum(int number, HepLorentzVector p4)
HepLorentzVector pfit(int n) const
void AddResonance(int number, double mres, std::vector< int > tlis)
static KalmanKinematicFit * instance()
int methodProbability() const
int onlyPionKaonProton() const
void setChiMinCut(const double chi=4)
void setRecTrack(EvtRecTrack *trk)
void setMethod(const int method)
double chiTof2(int n) const
void identify(const int pidcase)
void usePidSys(const int pidsys)
static ParticleID * instance()
bool IsPidInfoValid() const
double chiTof1(int n) const
double probProton() const
double chiDedx(int n) const
const HepVector & getZHelix() const
const HepSymMatrix & getZError() const
unsigned int layer() const
void setStatus(unsigned int status)
void AddTrack(const int number, const double mass, const RecMdcTrack *trk)
WTrackParameter wtrk(int n) const
void AddVertex(int number, VertexParameter vpar, std::vector< int > lis)
static VertexFit * instance()
void setEvx(const HepSymMatrix &eVx)
void setVx(const HepPoint3D &vx)
_EXTERN_ std::string EvtRecEvent
_EXTERN_ std::string EvtRecTrackCol