453 if(m_debug) std::cout<<
" helixPat "<<helixPat<<std::endl;
454 if(m_debug) std::cout<<
" layer "<<layer<<
" cell "<<cell<<std::endl;
463 std::cout<<
" cellId in "<<cellId_in<<
" out "<<cellId_out <<std::endl;
464 cout <<
"cell = " << cell <<
", cellId_in = " << cellId_in <<
", cellId_out = " << cellId_out << endl;
466 if (passCellRequired &&(cell < cellId_in && cell > cellId_out))
return -999.;
473 int innerOrOuter = 1;
475 double fltTrack = 0.1 * m_mdcGeomSvc -> Layer(layer)->Radius();
477 std::cout<<
" cell_IO "<<cell_IO<<std::endl;
478 std::cout<<
" fltTrack "<<fltTrack<<std::endl;
487 std::cout<<
" sag "<<m_wireTraj->
sag()<<std::endl;
488 std::cout<<
" east -------- "<< start_In->x()<<
","<<start_In->y()<<
","<<start_In->z()<<std::endl;
495 double zWire = cell_IO.z();
498 if(m_debug) std::cout<<
" zWire "<<zWire<<
" zEndDC "<<sWire->
zEndDC()<<std::endl;
501 double fltWire = sqrt( (pos_in.x()-start_In->x())*(pos_in.x()-start_In->x()) +
502 (pos_in.y()-start_In->y())*(pos_in.y()-start_In->y()) +
503 (pos_in.z()-start_In->z())*(pos_in.z()-start_In->z()) );
504 trkPoca =
new TrkPoca(*trajHelix, fltTrack, *trajWire, fltWire);
507 double hitLen = trkPoca->
flt2();
508 double startLen = trajWire->
lowRange() - 5.;
509 double endLen = trajWire->
hiRange() + 5.;
510 if(hitLen < startLen || hitLen > endLen) {
511 if(m_debug) std::cout<<
"WARNING MdcUtilitySvc::docaPatPar() isBeyondEndflange! hitLen="<<hitLen <<
" startLen="<<startLen<<
" endLen "<<endLen<<std::endl;
516 if(m_debug) std::cout<<
" doca "<<
doca<<std::endl;
562 int nCell = m_mdcGeomSvc->Layer(layer)->NCell();
564 double dPhiz = (m_mdcGeomSvc->Wire(layer,0)->Forward().phi() - m_mdcGeomSvc->Wire(layer,0)->Backward().phi())*0.5;
565 double rEnd = m_mdcGeomSvc->Wire(layer,0)->Backward().rho()/10.;
566 double rMid = rEnd *
cos(dPhiz);
569 double fltLenIn = rMid;
570 double phiIn = helixPat[1] + helixPat[2]*fltLenIn;
572 double phiEPOffset = m_mdcGeomSvc->Wire(layer,0)->Backward().phi();
574 if(m_debug) std::cout<<
"cellTrackPassed nCell "<<nCell<<
" layer "<<layer<<
" fltLenIn "<<fltLenIn<<
" phiEPOffset "<<phiEPOffset<<std::endl;
576 int wlow = (int)floor(nCell * tmp.
rad() / twopi );
577 int wbig = (int)ceil(nCell * tmp.
rad() / twopi );
578 if (tmp == 0 ){ wlow = -1; wbig = 1; }
580 if ((wlow%nCell)< 0) wlow += nCell;
583 if ((wbig%nCell)< 0) wbig += nCell;
586 bool passedOneCell = (cellId_in == cellId_out);
588 return passedOneCell;
601 double dr0,phi0,kappa,dz0,tanl;
602 double ALPHA_loc,rho,phi,cosphi0,sinphi0,x_hc,y_hc,z_hc;
603 double dphi0,IO_phi,C_alpha,xx,yy;
604 double inlow,inup,outlow,outup,phi_in,phi_out,phi_bin;
605 double rCize1,rCize2,rLay,length,phioffset,slant,shift;
606 double m_crio[2], phi_io[2], stphi[2],phioff[2],dphi[2];
614 ALPHA_loc = 1000/(2.99792458*Bz());
615 charge = ( kappa >=0 ) ? 1 : -1 ;
616 rho = ALPHA_loc/kappa ;
618 phi = fmod(phi0 + 4*
pi , 2*
pi);
620 sinphi0 = (1.0 - cosphi0 ) * (1.0 + cosphi0 );
621 sinphi0 = sqrt(( sinphi0 > 0.) ? sinphi0 : 0.);
622 if( phi >
pi ) sinphi0 = -sinphi0 ;
624 x_hc = 0. + ( dr0 + rho ) * cosphi0;
625 y_hc = 0. + ( dr0 + rho ) * sinphi0;
632 double m_c_perp(hcenter.perp());
633 Hep3Vector m_c_unit((
HepPoint3D)hcenter.unit());
636 dphi0 = fmod(IO.phi()+4*
pi, 2*
pi) - phi;
637 IO_phi = fmod(IO.phi()+4*
pi, 2*
pi);
639 if(dphi0 >
pi) dphi0 -= 2*
pi;
640 else if(dphi0 < -
pi) dphi0 += 2*
pi;
643 phi_io[1] = phi_io[0]+1.5*
pi;
646 bool outFlag =
false;
648 rCize1 = 0.1 * m_mdcGeomSvc->Layer(lay)->RCSiz1();
649 rCize2 = 0.1 * m_mdcGeomSvc->Layer(lay)->RCSiz2();
650 rLay = 0.1 * m_mdcGeomSvc->Layer(lay)->Radius();
651 length = 0.1 * m_mdcGeomSvc->Layer(lay)->Length();
654 nCell = m_mdcGeomSvc->Layer(lay)->NCell();
655 phioffset = m_mdcGeomSvc->Layer(lay)->Offset();
656 slant = m_mdcGeomSvc->Layer(lay)->Slant();
657 shift = m_mdcGeomSvc->Layer(lay)->Shift();
658 type = m_mdcGeomSvc->Layer(lay)->Sup()->Type();
660 m_crio[0] = rLay - rCize1 ;
661 m_crio[1] = rLay + rCize2 ;
665 Hep3Vector iocand[2];
666 Hep3Vector cell_IO[2];
668 for(
int ii =0; ii<2; ii++){
670 double cos_alpha = (m_c_perp*m_c_perp + m_crio[ii]*m_crio[ii] - rho*rho)
671 / ( 2 * m_c_perp * m_crio[ii] );
672 if(fabs(cos_alpha)>1&&(ii==0)){
676 if(fabs(cos_alpha)>1&&(ii==1)){
677 cos_alpha = (m_c_perp*m_c_perp + m_crio[0]*m_crio[0] - rho*rho)
678 / ( 2 * m_c_perp * m_crio[0] );
679 C_alpha = 2*
pi - acos( cos_alpha);
681 C_alpha = acos( cos_alpha );
684 iocand[ii] = m_c_unit;
685 iocand[ii].rotateZ(
charge*sign*C_alpha );
686 iocand[ii] *= m_crio[ii];
688 xx = iocand[ii].x() - x_hc ;
689 yy = iocand[ii].y() - y_hc ;
691 dphi[ii] = atan2(yy,xx) - phi0 - 0.5*
pi*(1-
charge);
692 dphi[ii] = fmod( dphi[ii] + 8.0*
pi,2*
pi);
695 if( dphi[ii] < phi_io[0] ) {
697 }
else if( dphi[ii] > phi_io[1] ){
701 cell_IO[ii] =
Hel(piv, dr0, phi, ALPHA_loc, kappa,dz0, dphi[ii], tanl);
704 if( (cell_IO[ii].x()==0 ) && (cell_IO[ii].
y()==0) && (cell_IO[ii].z()==0))
continue;
708 cellId_in = cellId_out = -1 ;
709 phi_in = cell_IO[0].phi();
710 phi_in = fmod ( phi_in + 4 *
pi, 2 *
pi );
711 phi_out = cell_IO[1].phi();
712 phi_out = fmod ( phi_out + 4 *
pi, 2 *
pi );
713 phi_bin = 2.0 *
pi / nCell ;
716 stphi[0] = shift * phi_bin * (0.5 - cell_IO[0].z()/length);
717 stphi[1] = shift * phi_bin * (0.5 - cell_IO[1].z()/length);
720 phioff[0] = phioffset + stphi[0];
721 phioff[1] = phioffset + stphi[1];
723 for(
int kk = 0; kk<nCell ; kk++){
725 inlow = phioff[0] + phi_bin*kk - phi_bin*0.5;
726 inlow = fmod( inlow + 4.0 *
pi , 2.0 *
pi);
727 inup = phioff[0] + phi_bin*kk + phi_bin*0.5;
728 inup = fmod( inup + 4.0 *
pi , 2.0 *
pi);
729 outlow = phioff[1] + phi_bin*kk - phi_bin*0.5;
730 outlow = fmod( outlow + 4.0 *
pi ,2.0 *
pi);
731 outup = phioff[1] + phi_bin*kk + phi_bin*0.5;
732 outup = fmod( outup + 4.0 *
pi , 2.0 *
pi);
734 if((phi_in>=inlow && phi_in<=inup)) cellId_in = kk;
735 if((phi_out>=outlow&&phi_out<outup)) cellId_out = kk;
737 if((phi_in>=inlow&&phi_in<2.0*
pi)||(phi_in>=0.0&&phi_in<inup)) cellId_in = kk;
740 if((phi_out>=outlow&&phi_out<=2.0*
pi)||(phi_out>=0.0&&phi_out<outup)) cellId_out = kk;
744 return (cellId_in==cellId_out);
960 std::map<
int,std::map<MdcDigi*,MdcMcHit*> >& mdcMCAssociation){
963 IDataProviderSvc* eventSvc =
NULL;
964 Gaudi::svcLocator()->service(
"EventDataSvc", eventSvc);
965 SmartDataPtr<Event::MdcMcHitCol> mdcMcHitCol(eventSvc,
"/Event/MC/MdcMcHitCol");
967 std::cout<<
"MdcUtilitySvc::getMdcMCAssoiciation() does not find MdcMcHitCol!"<<std::endl;
970 std::map<int,Event::MdcMcHit*> mdcMcHitMap;
971 Event::MdcMcHitCol::iterator iterMdcMcHit=mdcMcHitCol->begin();
972 for(;iterMdcMcHit!=mdcMcHitCol->end();iterMdcMcHit++ )
974 int id=m_mdcGeomSvc->Wire(
MdcID::layer((*iterMdcMcHit)->identify()),
976 mdcMcHitMap.insert(std::pair<int,Event::MdcMcHit*>(
id,*iterMdcMcHit));
980 MdcDigiVec::const_iterator iterMdcDigi=mdcDigiVecInput.begin();
981 for(;iterMdcDigi!=mdcDigiVecInput.end();iterMdcDigi++){
982 int digiTrackIndex=(*iterMdcDigi)->getTrackIndex();
983 std::cout<<__FILE__<<
" "<<__LINE__<<
" "<<digiTrackIndex<<std::endl;
984 if(digiTrackIndex>999) digiTrackIndex-=1000;
985 if(digiTrackIndex!=digiTrackIndex)
continue;
986 int id=m_mdcGeomSvc->Wire(
MdcID::layer((*iterMdcMcHit)->identify()),
988 std::map<MdcDigi*, MdcMcHit*> temp;
989 std::map<int,Event::MdcMcHit*>::iterator itMdcMcHit=mdcMcHitMap.find(
id);
990 if(itMdcMcHit!=mdcMcHitMap.end()){
991 temp.insert(make_pair(*iterMdcDigi,(*itMdcMcHit).second));
992 mdcMCAssociation.insert(make_pair(trackIndex, temp));
const HepLorentzVector & initialPosition() const
Retrieve pointer to the start, end vertex positions.
StdHepId particleProperty() const
Retrieve particle property.