#ifndef HMDCSIZESCELLS_H
#define HMDCSIZESCELLS_H
#include "TObject.h"
#include "TClonesArray.h"
#include "TMath.h"
#include "hmdcgeomobj.h"
#include "hgeomtransform.h"
class HMdcGetContainers;
class HMdcLayerGeomPar;
class HMdcGeomPar;
class HMdcDetector;
class HMdcTrap;
class HMdcGeomStruct;
class HMdcRawStruct;
class HMdcLookupRaw;
class HSpecGeomPar;
class HMdcLayerGeomParLay;
class HMdcLayerCorrPar;
class HGeomVolume;
class HMdcSizesCellsCell : public TObject {
  protected:
    Short_t     cell;        
    HGeomVector wirePnt1;    
    HGeomVector wirePnt2;    
    Bool_t      status;      
    Char_t      readOutSide; 
                             
                             
                             
    Float_t     xReadout;    
                             
    Float_t     length;      
  public:
    HMdcSizesCellsCell(Int_t c) {clear(); cell=c;}
    ~HMdcSizesCellsCell(void)   {}
    const HGeomVector* getWirePoint(Int_t n) const {
        if(n<0||n>1) return 0;
        return n==0 ? &wirePnt1 : &wirePnt2; }
        
    void    setStatus(Bool_t stat)         {status=stat;}
    Short_t getCell(void) const            {return cell;}
    Bool_t  getStatus(void) const          {return status;}
    Float_t getWireLength(void) const      {return length;}
    Char_t  getReadoutSide(void) const     {return readOutSide;}
    Float_t getXReadout(void) const        {return xReadout;}
    void    clear(void);
    
    
    Float_t getSignPath(Float_t x) const   {return readOutSide=='L' ?
                                            xReadout-x : x-xReadout;}
    HGeomVector& getWirePnt1(void)         {return wirePnt1;}
    HGeomVector& getWirePnt2(void)         {return wirePnt2;}
    void         setReadoutSide(Char_t rs) {readOutSide = rs;}
    void         setWireLength(Float_t wl) {length = wl;}
    void         setXReadout(Float_t xr)   {xReadout = xr;}
        
  ClassDef(HMdcSizesCellsCell,0)
};
class HMdcSizesCellsMod;
class HMdcSizesCells;
class HMdcSizesCellsLayer : public HMdcPlane {
  protected:
    Short_t              sector;            
    Short_t              module;
    Short_t              layer;
    HMdcLayerGeomParLay* pLayerGeomParLay;  
    HGeomVolume*         pGeomVol;          
    Short_t              nCells;            
    Double_t             halfCatDist;       
    Double_t             pitch;             
    Double_t             halfPitch;         
    Double_t             wireOr;            
    Double_t             cosWireOr;         
    Double_t             sinWireOr;         
    Double_t             wireOffSet;        
    HGeomTransform       sysRSec;           
    Double_t             tSysRSec[12];      
    HGeomTransform       rotLaySysRMod;     
                                            
    HGeomTransform       rotLaySysRSec;     
    Double_t             tRLaySysRSec[12];  
    HGeomTransform       sysRMod;           
    TClonesArray*        array;             
    HMdcSizesCellsMod*   pToMod;            
    
    Int_t                fCellSecondPart;   
    Double_t             shiftSecondPart;   
    
    
    
    Double_t             sensWiresThick;   
    Double_t             zGeantHit;        
    HGeomTransform       geantSysRMod;     
    HGeomTransform       geantSysRSec;     
    HMdcPlane            geantPlane;       
  public:
    HMdcSizesCellsLayer(HMdcSizesCellsMod* pMod, Int_t lay);
    ~HMdcSizesCellsLayer(void);
    HMdcSizesCellsCell& operator[](Int_t i) const {
        return *static_cast<HMdcSizesCellsCell*>((*array)[i]);}
    Bool_t setSecTrans(Double_t corZ=0.);
    Bool_t fillLayerCont(const HMdcLayerCorrPar* fLayCorrPar,
                         const Double_t* corr=0);
    HMdcLayerGeomParLay* getLayerGeomParLay(void) {return pLayerGeomParLay;}
    HGeomVolume*         getGeomVolume(void)      {return pGeomVol;}
    HMdcSizesCells* getSizesCells(void);
    Int_t    getSize(void) const;
    Short_t  getSec(void) const         {return sector;} 
    Short_t  getMod(void) const         {return module;} 
    Short_t  getLayer(void) const       {return layer;}  
    Double_t getCatDist(void) const     {return 2.*halfCatDist;}
    Double_t getHalfCatDist(void) const {return halfCatDist;}
    Double_t getPitch(void) const       {return pitch;}
    Double_t getHalfPitch(void) const   {return halfPitch;}
    Double_t getCosWireOr(void) const   {return cosWireOr;}
    Double_t getSinWireOr(void) const   {return sinWireOr;}
    Double_t getTanWireOr(void) const   {return sinWireOr/cosWireOr;}
    Double_t getWireOffSet(void) const  {return wireOffSet;}
    Short_t  getNCells(void) const      {return nCells;}
    const HGeomTransform* getSecTrans(void) const      {return &sysRSec;}
    const HGeomTransform* getModTrans(void) const      {return &sysRMod;}
    const HGeomTransform* getRotLaySysRMod(void) const {return &rotLaySysRMod;}
    const HGeomTransform* getRotLaySysRSec(void) const {return &rotLaySysRSec;}
    const Double_t* getRLSysRSec(void) const           {return tRLaySysRSec;}
    void            transSecToRotLayer(HGeomVector& point) const;
    Int_t           calcCellNum(Double_t x, Double_t y) const;
    Bool_t          calcCrossedCells(Double_t x1,Double_t y1,Double_t z1,
                                     Double_t x2,Double_t y2,Double_t z2,
                                     Float_t& cell1,Float_t& cell2) const;
    Double_t        getAlpha(const HGeomVector& p1,const HGeomVector& p2) const;
    Double_t        getDist(const HGeomVector& p1,const HGeomVector& p2,
                            Int_t cell);
    inline Double_t getDist(Double_t x1,Double_t y1,Double_t z1,
                          Double_t x2,Double_t y2,Double_t z2,Int_t cell) const;
    inline void     getYZinWireSys(Double_t x,Double_t y,Double_t z,Int_t cell,
                                   Double_t& yw, Double_t& zw) const;
    inline Double_t getDistToZero(Double_t y1,Double_t z1,
                                  Double_t y2, Double_t z2) const;
    inline Double_t getImpactToZero(Double_t y1,Double_t z1,
                              Double_t y2,Double_t z2,Double_t &alpha) const;
    Double_t        getImpact(Double_t x1,Double_t y1,Double_t z1,
                              Double_t x2,Double_t y2,Double_t z2,
                              Int_t cell,Double_t &alphaPerp) const;
    inline Double_t getImpact(const HMdcLineParam& ln, Int_t cell,
                              Double_t &alpha) const;
    inline Double_t getImpact(const HMdcLineParam& ln, Int_t cell,
                              Double_t &alpha, Double_t &y,Double_t &z,
                              Double_t &dy,Double_t &dz) const;
    void            getImpact(const HGeomVector& p1, const HGeomVector& p2,
                              Int_t cell,Double_t &alpha, Double_t &per) const;
    Double_t        getImpactLSys(const HGeomVector& p1l,const HGeomVector& p2l,
                                  Int_t cell, Double_t &alpha) const;
    Bool_t          getImpact(Double_t x1,Double_t y1,Double_t z1,
                              Double_t x2,Double_t y2,Double_t z2,Int_t cell,
                              Double_t &alphaDrDist, Double_t &driftDist) const;
    inline Bool_t   getImpact(const HMdcLineParam& ln, Int_t cell,
                              Double_t &alpha, Double_t &minDist) const;
    inline Bool_t   getImpact(const HMdcLineParam& ln, Int_t cell,
                              Double_t &alpha,Double_t &minDist,Double_t &y,
                              Double_t &z,Double_t &dy,Double_t &dz) const;
    Int_t           distanceSign(const HMdcLineParam& ln, Int_t cell) const;
    Bool_t          getDriftDist(Double_t xP1,Double_t yP1,Double_t zP1,
                                 Double_t xP2,Double_t yP2,Double_t zP2,
                                 Int_t cell, Double_t &alphaDrDist,
                                 Double_t &driftDist) const;
    Double_t        getXSign(Double_t x1, Double_t y1, Double_t z1, 
                             Double_t x2, Double_t y2, Double_t z2,
                             Int_t cell) const;
    Double_t        getXSign(const HMdcLineParam& ln, Int_t cell) const;
    Float_t         getSignPath(Double_t x1,Double_t y1,Double_t z1,
                                Double_t x2,Double_t y2,Double_t z2, 
                                Int_t cell) const;
    Double_t        getSignPath(const HMdcLineParam& ln, Int_t cell) const;
    Float_t         getSignPath(Double_t x1,Double_t y1,Double_t z1,
                                Double_t x2,Double_t y2,Double_t z2,
                                Int_t cell, Float_t& outside) const;
    inline void     transTo(Double_t& x, Double_t& y, Double_t& z) const;
    inline void     transFrom(Double_t& x, Double_t& y, Double_t& z) const;
    
    inline void     rotVectToLay(Double_t xi,Double_t yi,Double_t zi,
                                 Double_t& xo,Double_t& yo,Double_t& zo) const;
    inline void     rotVectToRotLay(Double_t xi,Double_t yi,Double_t zi,
                                 Double_t& xo,Double_t& yo,Double_t& zo) const;
    inline void     rotYZtoRotLay(Double_t xi,Double_t yi,Double_t zi,
                                  Double_t& yo, Double_t& zo) const;
    inline void     rotYZtoRotLay(const HGeomVector& dir,
                                  Double_t& yo, Double_t& zo) const;
    inline void     rotVectToRotLay(const HGeomVector& dir,
                                  Double_t& xo,Double_t& yo,Double_t& zo) const;
    inline Double_t transXinRotLay(Double_t xi, Double_t yi) const;
    inline Double_t transYinRotLay(Double_t xi, Double_t yi) const;
    inline void     transXYinRotLay(Double_t& x, Double_t& y) const;
    void            print(void) const;
    
    
    
    Double_t        getSensWiresThickness(void) const   {return sensWiresThick;}
    Double_t        getZGeantHits(void) const           {return zGeantHit;}
    const HGeomTransform& getSecTransGeant(void) const  {return geantSysRSec;}
    const HGeomTransform& getModTransGeant(void) const  {return geantSysRMod;}
    const HMdcPlane&      getGeantHitsPlane(void) const {return geantPlane;}
    void            getRotLSysForOtherSecSys(Int_t othSec,
                                             HGeomTransform& trans) const;
    
    inline Double_t calcWireY(Int_t cell) const;
  private:
    Bool_t          getParamCont(void);
    Double_t        calcWire(Double_t x, Double_t y) const;
    void            calcInOtherSecSys(const HMdcLineParam& ln,Int_t cell,
                       Double_t &y,Double_t &z,Double_t &dy,Double_t &dz) const;
  ClassDef(HMdcSizesCellsLayer,0)
};
class HMdcSizesCellsSec;
class HMdcSizesCells;
class HMdcSizesCellsMod : public HMdcPlane {
  protected:
    Short_t            sector;       
    Short_t            module;       
    HGeomTransform     sysRSec;      
    Double_t           tSysRSec[12]; 
    Double_t           ct[6];        
    TObjArray*         array;        
    HMdcSizesCellsSec* pToSec;       
  public:
    HMdcSizesCellsMod(HMdcSizesCellsSec* pSec, Int_t mod);
    ~HMdcSizesCellsMod(void);
    HMdcSizesCellsLayer& operator[](Int_t i) const {
        return *static_cast<HMdcSizesCellsLayer*>((*array)[i]);}
    Bool_t setSecTrans(const HGeomTransform * alignTrans=0,
        Int_t sysOfAlignTrans=0);
    
    Int_t   getSize(void) const;
    Short_t getSec(void) const {return sector;}
    Short_t getMod(void) const {return module;}
    HMdcSizesCells* getSizesCells(void);
    const HGeomTransform* getSecTrans(void) const { return &sysRSec; }
    inline void transTo(Double_t& x, Double_t& y, Double_t& z) const;
    inline void transFrom(Double_t& x, Double_t& y, Double_t& z) const;
    inline void transFromZ0(Double_t& x, Double_t& y, Double_t& z) const;
    inline void transFromZ0(Float_t& x, Float_t& y, Float_t& z) const;
    inline void rotVectTo(Double_t xi,Double_t yi,Double_t zi,
                          Double_t& xo, Double_t& yo, Double_t& zo) const;
    inline void calcInterTrMod(Double_t x1, Double_t y1, Double_t z1,
                               Double_t x2, Double_t y2, Double_t z2,
                               Double_t& x, Double_t& y) const;
    inline void calcMdcHit(Double_t x1, Double_t y1, Double_t z1,
                           Double_t x2, Double_t y2, Double_t z2,
                           Double_t& x, Double_t& y,
                           Double_t& xDir, Double_t& yDir) const;
    void calcMdcHit(Double_t x1, Double_t y1, Double_t z1,
                    Double_t x2, Double_t y2, Double_t z2,
                    Double_t eX1, Double_t eY1, Double_t eZ1,
                    Double_t eX2, Double_t eY2, Double_t dZ1dX1, Double_t dZ1dY1, 
                    Double_t dZ2dX2, Double_t dZ2dY2,
                    Double_t& x, Double_t& eX, Double_t& y, Double_t& eY,
                    Double_t& xDir, Double_t& eXDir,
                    Double_t& yDir, Double_t& eYDir) const;
    const Double_t* getTfSysRSec(void) const      {return tSysRSec;}
    const Double_t* getMdcHitLookupTb(void) const {return ct;}
  ClassDef(HMdcSizesCellsMod,0)
};
class HMdcSizesCellsSec : public TObject {
  protected:
    Short_t         sector;     
    TObjArray*      array;      
    HGeomTransform  sysRLab;    
    Bool_t*         mdcStatSec; 
    Int_t           numTargets; 
    HGeomVector*    targets;    
    HGeomVector     targ3p[3];  
                                
                                
    HMdcSizesCells* pToSC;      
  public:
    HMdcSizesCellsSec(HMdcSizesCells* pSC, Int_t sec);
    ~HMdcSizesCellsSec(void);
    HMdcSizesCellsMod& operator[](Int_t i) const {
      return *static_cast<HMdcSizesCellsMod*>((*array)[i]);}
    Int_t getSize(void) const;
    const HGeomTransform* getLabTrans(void) const       {return &sysRLab;}
    Short_t            getSector(void)                  {return sector;}
    Bool_t             modStatus(Int_t m) const         {return m>=0 && m<4 ?
                                                          mdcStatSec[m]:kFALSE;}
    HMdcSizesCells*    getSizesCells(void);
    const HGeomVector& getTargetFirstPoint(void) const  {return targ3p[0];}
    const HGeomVector& getTargetMiddlePoint(void) const {return targ3p[1];}
    const HGeomVector& getTargetLastPoint(void) const   {return targ3p[2];}
    void               calcRZToTargLine(Double_t x1,Double_t y1,Double_t z1, 
                                        Double_t x2,Double_t y2,Double_t z2,
                                        Double_t &zm,Double_t &r0) const;
    Int_t              getNumOfTargets(void) const      {return numTargets;}
    HGeomVector*       getTargets(void)                 {return targets;}
    HGeomVector*       getTarget(Int_t i) {return i>=0 && i<numTargets ?
                                               &(targets[i]) : 0;}
    
    
    HGeomTransform& getLbTrns(void)                     {return sysRLab;}
    void            setNumOfTargets(HGeomVector* targ3pLab,
                                    Int_t nt, HGeomVector* targetsLab);
  ClassDef(HMdcSizesCellsSec,0)
};
class HMdcSizesCells : public TObject {
  protected:
    static HMdcSizesCells* fMdcSizesCells;
    HMdcGetContainers*     fGetCont;
    HMdcLayerGeomPar*      fLayerGeomPar;
    Int_t             verLayerGeomPar[3];
    HMdcGeomPar*      fGeomPar;
    Int_t             verGeomPar[3];
    HMdcDetector*     fMdcDet;
    Bool_t            mdcStatus[6][4]; 
    Int_t             nModsSeg[6][2];  
    HMdcGeomStruct*   fMdcGeomStruct;
    HMdcLookupRaw*    fMdcLookupRaw;
    Int_t             verLookupRaw[3];
    HMdcRawStruct*    fMdcRawStruct;
    HSpecGeomPar*     fSpecGeomPar;
    HMdcLayerCorrPar* fLayerCorrPar;
    TObjArray*        array;           
    Bool_t            changed;         
    Bool_t            geomModified;    
    Int_t             numTargets;      
    HGeomVector*      targets;         
    HGeomVector       targ3p[3];       
                                       
                                       
  public:
    static HMdcSizesCells* getObject(void);
    static HMdcSizesCells* getExObject(void) {return fMdcSizesCells;}
    static void            deleteCont(void);
    HMdcSizesCellsSec& operator[](Int_t i) const {
      return *static_cast<HMdcSizesCellsSec*>((*array)[i]);}
    Int_t  getSize(void) const;
    
    Bool_t initContainer(void);
    Bool_t hasChanged(void) const {return changed;}
    void   clear(void);
    Bool_t getCellVol(Int_t sec,Int_t mod,Int_t lay,Int_t cell,
                      HMdcTrap& volCell,Double_t sizeFactor=-1.) const;
    Char_t findReadOutSide(Int_t s,Int_t m,Int_t l,Int_t c) const;
    Bool_t modStatus(Int_t s, Int_t m) const   {return secOk(s) && modOk(m) ? 
                                                    mdcStatus[s][m] : kFALSE;}
    Int_t  nModInSeg(Int_t s, Int_t seg) const {return secOk(s) && segOk(seg) ?
                                                    nModsSeg[s][seg] : 0;}
    Bool_t fillModCont(Int_t sec, Int_t mod,
		       HGeomTransform * alignTrans=0, Int_t sysOfAlignTrans=0);
    Bool_t fillModCont(Int_t sec, Int_t mod, Double_t * corr);
    const HGeomVector& getTargetFirstPoint(void) const  {return targ3p[0];}
    const HGeomVector& getTargetMiddlePoint(void) const {return targ3p[1];}
    const HGeomVector& getTargetLastPoint(void) const   {return targ3p[2];}
    void         calcRZToTargLine(Double_t x1,Double_t y1,Double_t z1,
                                  Double_t x2,Double_t y2,Double_t z2,
                                  Double_t &zm,Double_t &r0) const;
    Int_t        getNumOfTargets(void) const            {return numTargets;}
    HGeomVector* getTargets(void)                       {return targets;}
    void         setNotGeomModified(void)               {geomModified=kFALSE;}
    
    inline static void calcMdcSeg(Double_t x1,Double_t y1,Double_t z1, 
                                  Double_t x2, Double_t y2, Double_t z2,
                                  Double_t &zm, Double_t &r0, Double_t &theta,
                                  Double_t &phi);
    static void  setTransform(Double_t* par, HGeomTransform& trans);
    static void  copyTransfToArr(const HGeomTransform& trans, Double_t* arr);
    static void  calcRZToLineXY(Double_t x1, Double_t y1, Double_t z1, 
                                Double_t x2, Double_t y2, Double_t z2, 
                                Double_t xBeam, Double_t yBeam,
                                Double_t &zm,Double_t &r0);
    static void  calcMdcSeg(Double_t x1, Double_t y1, Double_t z1, 
                            Double_t x2, Double_t y2, Double_t z2,
                            Double_t eX1, Double_t eY1, Double_t eZ1,
                            Double_t eX2, Double_t eY2, Double_t dZ1dX1,
                            Double_t dZ1dY1, Double_t dZ2dX2, Double_t dZ2dY2,
                            Double_t& zm, Double_t& eZm, Double_t& r0,
                            Double_t& eR0, Double_t& theta, Double_t& eTheta,
                            Double_t& phi, Double_t& ePhi);
    static void rotateYZ(const HGeomRotation& rot,
                         Double_t xi,Double_t yi,Double_t zi,
                         Double_t& yo, Double_t& zo);
    static void rotateXYZ(const HGeomRotation& rot,
                         Double_t xi,Double_t yi,Double_t zi,
                         Double_t& xo,Double_t& yo,Double_t& zo);
    static void rotateDir(const HGeomRotation& rot,const HGeomVector& d,
                          Double_t& dy, Double_t& dz);
    static void rotateDir(const HGeomRotation& rot,const HGeomVector& d,
                          Double_t& dx,Double_t& dy, Double_t& dz);
    void        transLineToOtherSec(const HMdcLineParam& ln,Int_t sec,
                                    HGeomVector& p1,HGeomVector& p2);
    void        transLineToAnotherSec(HMdcLineParam& ln,Int_t anotherSec);
    
    
    void         setGeomModifiedFlag(void)       {geomModified = kTRUE;}
    Bool_t*      modStatusArr(Int_t s)           {return mdcStatus[s];}
    Int_t        nCells(Int_t s,Int_t m,Int_t l) const;
    HGeomVector& getTargetP(Int_t p)             {return targ3p[p];}
    
  private:
    HMdcSizesCells(void);
    ~HMdcSizesCells(void);
    Bool_t fillCont(Int_t sec);
    Bool_t fillTargetPos(HGeomVector* targetShift=0);
    Bool_t secOk(Int_t s) const  {return s>=0 && s<6;}
    Bool_t segOk(Int_t sg) const {return sg>=0 && sg<2;}
    Bool_t modOk(Int_t m) const  {return m>=0 && m<4;}
  ClassDef(HMdcSizesCells,0)
};
inline void HMdcSizesCellsLayer::transTo(Double_t& x, Double_t& y, Double_t& z) const {
  
  rotVectToLay(x-tSysRSec[9],y-tSysRSec[10],z-tSysRSec[11],x,y,z);
}
inline void HMdcSizesCellsLayer::transFrom(Double_t& x, Double_t& y, Double_t& z) const {
  
  Double_t pmtx = x;
  Double_t pmty = y;
  Double_t pmtz = z;
  x = tSysRSec[0]*pmtx+tSysRSec[1]*pmty+tSysRSec[2]*pmtz+tSysRSec[ 9];
  y = tSysRSec[3]*pmtx+tSysRSec[4]*pmty+tSysRSec[5]*pmtz+tSysRSec[10];
  z = tSysRSec[6]*pmtx+tSysRSec[7]*pmty+tSysRSec[8]*pmtz+tSysRSec[11];
}
inline Double_t HMdcSizesCellsLayer::calcWireY(Int_t cell) const {
  
  Double_t y = cell*pitch - wireOffSet;
  if(cell >= fCellSecondPart) y += shiftSecondPart;
  return y;
}
inline Double_t HMdcSizesCellsLayer::getDist(
    Double_t x1, Double_t y1, Double_t z1,
    Double_t x2, Double_t y2, Double_t z2, Int_t cell) const {
  
  
  Double_t y,z,dy,dz;
  rotYZtoRotLay(x1-tRLaySysRSec[9],y1-tRLaySysRSec[10],z1-tRLaySysRSec[11],y,z);
  y -= calcWireY(cell);
  rotYZtoRotLay(x2-x1,y2-y1,z2-z1,dy,dz);
  return TMath::Abs(y*dz-z*dy) / TMath::Sqrt(dz*dz+dy*dy);
}
inline void HMdcSizesCellsLayer::getYZinWireSys(Double_t x, Double_t y,
      Double_t z, Int_t cell, Double_t& yw, Double_t& zw) const {
  
  
  
  rotYZtoRotLay(x-tRLaySysRSec[9],y-tRLaySysRSec[10],z-tRLaySysRSec[11],yw,zw);
  yw -= calcWireY(cell);
}
inline Double_t HMdcSizesCellsLayer::getDistToZero(Double_t y1,Double_t z1,
    Double_t y2, Double_t z2) const {
  
  
  Double_t dz  = z1-z2;
  Double_t dy  = y1-y2;
  Double_t lng = 1./TMath::Sqrt(dz*dz+dy*dy); 
  return TMath::Abs((z1*y2-z2*y1)*lng);
}
inline Double_t HMdcSizesCellsLayer::getImpactToZero(Double_t y1,Double_t z1,
    Double_t y2, Double_t z2, Double_t &alpha) const {
  
  
  
  Double_t dz  = z1-z2;
  Double_t dy  = y1-y2;
  alpha        = TMath::ATan2(TMath::Abs(dz),TMath::Abs(dy))*TMath::RadToDeg();
  Double_t lng = 1./TMath::Sqrt(dz*dz+dy*dy); 
  return TMath::Abs((z1*y2-z2*y1)*lng);
}
inline void HMdcSizesCellsLayer::rotVectToLay(Double_t xi,Double_t yi,Double_t zi,
    Double_t& xo, Double_t& yo, Double_t& zo) const {
  
  
  xo = tSysRSec[0]*xi+tSysRSec[3]*yi+tSysRSec[6]*zi;
  yo = tSysRSec[1]*xi+tSysRSec[4]*yi+tSysRSec[7]*zi;
  zo = tSysRSec[2]*xi+tSysRSec[5]*yi+tSysRSec[8]*zi;
}
inline void HMdcSizesCellsLayer::rotVectToRotLay(
    Double_t xi,Double_t yi,Double_t zi,
    Double_t& xo, Double_t& yo, Double_t& zo) const {
  
  
  xo = tRLaySysRSec[0]*xi+tRLaySysRSec[3]*yi+tRLaySysRSec[6]*zi;
  yo = tRLaySysRSec[1]*xi+tRLaySysRSec[4]*yi+tRLaySysRSec[7]*zi;
  zo = tRLaySysRSec[2]*xi+tRLaySysRSec[5]*yi+tRLaySysRSec[8]*zi;
}
inline void HMdcSizesCellsLayer::rotVectToRotLay(const HGeomVector& d,
    Double_t& xo, Double_t& yo, Double_t& zo) const {
  
  
  xo = tRLaySysRSec[0]*d.getX()+tRLaySysRSec[3]*d.getY()+tRLaySysRSec[6]*d.getZ();
  yo = tRLaySysRSec[1]*d.getX()+tRLaySysRSec[4]*d.getY()+tRLaySysRSec[7]*d.getZ();
  zo = tRLaySysRSec[2]*d.getX()+tRLaySysRSec[5]*d.getY()+tRLaySysRSec[8]*d.getZ();
}
inline void HMdcSizesCellsLayer::rotYZtoRotLay(
    Double_t xi,Double_t yi,Double_t zi,Double_t& yo, Double_t& zo) const {
  
  
  yo = tRLaySysRSec[1]*xi+tRLaySysRSec[4]*yi+tRLaySysRSec[7]*zi;
  zo = tRLaySysRSec[2]*xi+tRLaySysRSec[5]*yi+tRLaySysRSec[8]*zi;
}
inline void HMdcSizesCellsLayer::rotYZtoRotLay(const HGeomVector& d,
    Double_t& yo, Double_t& zo) const {
  
  
  yo = tRLaySysRSec[1]*d.getX()+tRLaySysRSec[4]*d.getY()+tRLaySysRSec[7]*d.getZ();
  zo = tRLaySysRSec[2]*d.getX()+tRLaySysRSec[5]*d.getY()+tRLaySysRSec[8]*d.getZ();
}
inline Double_t HMdcSizesCellsLayer::transXinRotLay(Double_t xi, Double_t yi)
    const {
  
  
  return xi*cosWireOr+yi*sinWireOr;
}
inline Double_t HMdcSizesCellsLayer::transYinRotLay(Double_t xi, Double_t yi)
    const {
  
  
  return yi*cosWireOr-xi*sinWireOr;
}
inline void HMdcSizesCellsLayer::transXYinRotLay(Double_t& x, Double_t& y)
    const {
  
  
  Double_t xt = x;
  x = xt*cosWireOr+y*sinWireOr;
  y = y*cosWireOr-xt*sinWireOr;
}
inline Double_t HMdcSizesCellsLayer::getImpact(const HMdcLineParam& ln,
    Int_t cell,Double_t &alpha) const {
  
  
  
  
  Double_t y,z,dy,dz;
  return getImpact(ln,cell,alpha,y,z,dy,dz);
}
inline Double_t HMdcSizesCellsLayer::getImpact(const HMdcLineParam& ln,
    Int_t cell,
    Double_t &alpha, Double_t &y,Double_t &z,Double_t &dy,Double_t &dz) const {
  
  
  
  
  Int_t parSec = ln.getSec();
  if(parSec==sector || parSec<0) {
    rotYZtoRotLay(ln.x1()-tRLaySysRSec[9],ln.y1()-tRLaySysRSec[10],
        ln.z1()-tRLaySysRSec[11],y,z);
    y -= calcWireY(cell);
    rotYZtoRotLay(ln.getDir(),dy,dz);
  } else calcInOtherSecSys(ln,cell,y,z,dy,dz);
  alpha = TMath::ATan2(TMath::Abs(dz),TMath::Abs(dy))*TMath::RadToDeg();
  return TMath::Abs((y*dz-z*dy)/TMath::Sqrt(dz*dz+dy*dy));
}
inline Bool_t HMdcSizesCellsLayer::getImpact(const HMdcLineParam& ln,Int_t cell,
    Double_t &alpha, Double_t &minDist) const {
  
  
  
  
  
  
  Double_t y,z,dy,dz;
  return getImpact(ln,cell,alpha,minDist,y,z,dy,dz);
}
inline Bool_t HMdcSizesCellsLayer::getImpact(const HMdcLineParam& ln,Int_t cell,
    Double_t &alpha, Double_t &minDist,
    Double_t &y,Double_t &z,Double_t &dy,Double_t &dz) const {
  
  
  
  
  
  
  Int_t parSec = ln.getSec();
  if(parSec==sector || parSec<0) {
    rotYZtoRotLay(ln.x1()-tRLaySysRSec[9],ln.y1()-tRLaySysRSec[10],
        ln.z1()-tRLaySysRSec[11],y,z);
    y -= calcWireY(cell);
    rotYZtoRotLay(ln.getDir(),dy,dz);
  } else calcInOtherSecSys(ln,cell,y,z,dy,dz);
  
  Double_t lng   = 1./TMath::Sqrt(dz*dz+dy*dy);
  Double_t yDist = TMath::Abs(y*dz-z*dy); 
  minDist        = yDist*lng;
  Double_t dza   = TMath::Abs(dz);
  Double_t dya   = TMath::Abs(dy);
  alpha          = TMath::ATan2(dza,dya)*TMath::RadToDeg();
  if(minDist*dza*lng > halfPitch) {
    if(dya==0.0) return kFALSE;
    if((yDist-halfPitch*dza)/dya > halfCatDist)  return kFALSE;
  } else if(minDist*dya*lng > halfCatDist &&    
      (yDist-halfCatDist*dya)/dza > halfPitch) return kFALSE;
  return kTRUE;
}
inline void HMdcSizesCellsMod::transTo(Double_t& x, Double_t& y, Double_t& z)
    const {
  
  rotVectTo(x-tSysRSec[ 9],y-tSysRSec[10],z-tSysRSec[11],x,y,z);
}
inline void HMdcSizesCellsMod::rotVectTo(Double_t xi,Double_t yi,Double_t zi,
    Double_t& xo, Double_t& yo, Double_t& zo) const {
  
  
  xo = tSysRSec[0]*xi+tSysRSec[3]*yi+tSysRSec[6]*zi;
  yo = tSysRSec[1]*xi+tSysRSec[4]*yi+tSysRSec[7]*zi;
  zo = tSysRSec[2]*xi+tSysRSec[5]*yi+tSysRSec[8]*zi;
}
inline void HMdcSizesCellsMod::transFrom(Double_t& x, Double_t& y, Double_t& z) const {
  
  Double_t pmtx = x;
  Double_t pmty = y;
  Double_t pmtz = z;
  x = tSysRSec[0]*pmtx+tSysRSec[1]*pmty+tSysRSec[2]*pmtz+tSysRSec[ 9];
  y = tSysRSec[3]*pmtx+tSysRSec[4]*pmty+tSysRSec[5]*pmtz+tSysRSec[10];
  z = tSysRSec[6]*pmtx+tSysRSec[7]*pmty+tSysRSec[8]*pmtz+tSysRSec[11];
}
inline void HMdcSizesCellsMod::transFromZ0(Double_t& x,Double_t& y,Double_t& z) const {
  
  
  Double_t pmtx = x;
  Double_t pmty = y;
  x = tSysRSec[0]*pmtx+tSysRSec[1]*pmty+tSysRSec[ 9];
  y = tSysRSec[3]*pmtx+tSysRSec[4]*pmty+tSysRSec[10];
  z = tSysRSec[6]*pmtx+tSysRSec[7]*pmty+tSysRSec[11];
}
inline void HMdcSizesCellsMod::transFromZ0(Float_t& x,Float_t& y,Float_t& z) const {
  
  
  Double_t pmtx = x;
  Double_t pmty = y;
  x = tSysRSec[0]*pmtx+tSysRSec[1]*pmty+tSysRSec[ 9];
  y = tSysRSec[3]*pmtx+tSysRSec[4]*pmty+tSysRSec[10];
  z = tSysRSec[6]*pmtx+tSysRSec[7]*pmty+tSysRSec[11];
}
inline void HMdcSizesCellsMod::calcInterTrMod(Double_t x1, Double_t y1, Double_t z1,
      Double_t x2, Double_t y2, Double_t z2,
      Double_t& x, Double_t& y) const {
  Double_t dX  = x2-x1;
  Double_t dY  = y2-y1;
  Double_t dZ  = z2-z1;
  Double_t del = 1/(parA*dX+parB*dY+dZ);
  Double_t xt  = (dX*(parD-z1-parB*y1)+x1*(parB*dY+dZ))*del-tSysRSec[ 9];
  Double_t yt  = (dY*(parD-z1-parA*x1)+y1*(parA*dX+dZ))*del-tSysRSec[10];
  x = ct[0]*xt+ct[1]*yt+ct[2];
  y = ct[3]*xt+ct[4]*yt+ct[5];
}
inline void HMdcSizesCellsMod::calcMdcHit(Double_t x1, Double_t y1, Double_t z1,
      Double_t x2, Double_t y2, Double_t z2,
      Double_t& x, Double_t& y, Double_t& xDir, Double_t& yDir) const {
  
  
  
  Double_t dX  = x2-x1;
  Double_t dY  = y2-y1;
  Double_t dZ  = z2-z1;
  Double_t del = 1/(parA*dX+parB*dY+dZ);
  Double_t xt  = (dX*(parD-z1-parB*y1)+x1*(parB*dY+dZ))*del-tSysRSec[ 9];
  Double_t yt  = (dY*(parD-z1-parA*x1)+y1*(parA*dX+dZ))*del-tSysRSec[10];
  x = ct[0]*xt+ct[1]*yt+ct[2];
  y = ct[3]*xt+ct[4]*yt+ct[5];
  
  Double_t length = 1/TMath::Sqrt(dX*dX+dY*dY+dZ*dZ);
  xDir = (tSysRSec[0]*dX+tSysRSec[3]*dY+tSysRSec[6]*dZ)*length; 
  yDir = (tSysRSec[1]*dX+tSysRSec[4]*dY+tSysRSec[7]*dZ)*length;
}
inline void HMdcSizesCells::calcMdcSeg(Double_t x1, Double_t y1, Double_t z1, 
                                Double_t x2, Double_t y2, Double_t z2, 
    Double_t &zm, Double_t &r0, Double_t &theta, Double_t &phi) {
  
  
  
  
  
  
  Double_t dX    = x2-x1;
  Double_t dY    = y2-y1;
  Double_t dZ    = z2-z1;
  Double_t lenXY = TMath::Sqrt(dX*dX+dY*dY);
  if(lenXY<2.E-5) {
    dX    = x2 * 1.E-5/TMath::Sqrt(x2*x2+y2*y2);
    dY    = y2 * 1.E-5/TMath::Sqrt(x2*x2+y2*y2);
    lenXY = 1.E-5;            
    dZ    = 1.;
  }
  dX   /= lenXY;
  dY   /= lenXY;
  dZ   /= lenXY;
  phi   = TMath::ATan2(dY,dX);
  theta = TMath::ATan2(1.,dZ);
  zm    = z1-dZ*(x1*dX+y1*dY);
  r0    = y1*dX-x1*dY;
}
#endif  /*!HMDCSIZESCELLS_H*/
Last change: Sat May 22 13:03:32 2010
Last generated: 2010-05-22 13:03
This page has been automatically generated. If you have any comments or suggestions about the page layout send a mail to ROOT support, or contact the developers with any questions or problems regarding ROOT.