]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - STEER/AliAlignObj.cxx
First V0 MC Analysis from H.Ricaud
[u/mrichter/AliRoot.git] / STEER / AliAlignObj.cxx
index d33331b714e044639d3b7b5d01e1d556b87b7b6f..cee2c2bd86c9c8c54f949ec25188799524c37e9f 100644 (file)
  * provided "as is" without express or implied warranty.                  *
  **************************************************************************/
 
+/* $Id$ */
+
 //-----------------------------------------------------------------
-//   Implementation of the alignment object class through
-//   1) the abstract class AliAlignObj
-//   2) two derived concrete representation of alignment object class:
-//      - AliAlignObjAngles
-//      - AliAlignObjMatrix
+//  Implementation of the alignment object class, holding the alignment
+//  constants for a single volume, through the abstract class AliAlignObj.
+//  From it two derived concrete representation of alignment object class
+//  (AliAlignObjParams, AliAlignObjMatrix) are derived in separate files.
 //-----------------------------------------------------------------
-/*****************************************************************************
- * AliAlignObjAngles: derived alignment class storing alignment information  *
- *   for a single volume in form of three doubles for the translation        *
- *   and three doubles for the rotation expressed with the euler angles      *
- *   in the xyz-convention (http://mathworld.wolfram.com/EulerAngles.html),  *
- *   also known as roll, pitch, yaw. PLEASE NOTE THE ANGLES SIGNS ARE        *
- *   INVERSE WITH RESPECT TO THIS REFERENCE!!! In this way the representation*
- *   is fully consistent with the TGeo Rotation methods.                     *
- *****************************************************************************/
 
-#include "AliAlignObj.h"
-//#include "AliLog.h"
+#include <TGeoManager.h>
+#include <TGeoPhysicalNode.h>
+#include <TMath.h>
+#include <TMatrixDSym.h>
 
+#include "AliAlignObj.h"
+#include "AliTrackPointArray.h"
+#include "AliLog.h"
 ClassImp(AliAlignObj)
 
 //_____________________________________________________________________________
 AliAlignObj::AliAlignObj():
+  fVolPath(),
   fVolUID(0)
 {
-  // dummy constructor
+  // default constructor
+  for(Int_t i=0; i<6; i++) fDiag[i]=-999.;
+  for(Int_t i=0; i<15; i++) fODia[i]=-999.;
+}
+
+//_____________________________________________________________________________
+AliAlignObj::AliAlignObj(const char* symname, UShort_t voluid) :
+  TObject(),
+  fVolPath(symname),
+  fVolUID(voluid)
+{
+  // standard constructor
+  //
+  for(Int_t i=0; i<6; i++) fDiag[i]=-999.;
+  for(Int_t i=0; i<15; i++) fODia[i]=-999.;
+}
+
+//_____________________________________________________________________________
+AliAlignObj::AliAlignObj(const char* symname, UShort_t voluid, Double_t* cmat) :
+  TObject(),
+  fVolPath(symname),
+  fVolUID(voluid)
+{
+  // standard constructor
+  //
+  SetCorrMatrix(cmat);
 }
 
 //_____________________________________________________________________________
 AliAlignObj::AliAlignObj(const AliAlignObj& theAlignObj) :
-  TObject(theAlignObj)
+  TObject(theAlignObj),
+  fVolPath(theAlignObj.GetSymName()),
+  fVolUID(theAlignObj.GetVolUID())
 {
   //copy constructor
-  fVolPath = theAlignObj.GetVolPath();
-  fVolUID = theAlignObj.GetVolUID();
+  for(Int_t i=0; i<6; i++) fDiag[i]=theAlignObj.fDiag[i];
+  for(Int_t i=0; i<15; i++) fODia[i]=theAlignObj.fODia[i];
 }
 
 //_____________________________________________________________________________
@@ -56,8 +82,30 @@ AliAlignObj &AliAlignObj::operator =(const AliAlignObj& theAlignObj)
 {
   // assignment operator
   if(this==&theAlignObj) return *this;
-  fVolPath = theAlignObj.GetVolPath();
+  fVolPath = theAlignObj.GetSymName();
   fVolUID = theAlignObj.GetVolUID();
+  for(Int_t i=0; i<6; i++) fDiag[i]=theAlignObj.fDiag[i];
+  for(Int_t i=0; i<15; i++) fODia[i]=theAlignObj.fODia[i];
+  return *this;
+}
+
+//_____________________________________________________________________________
+AliAlignObj &AliAlignObj::operator*=(const AliAlignObj& theAlignObj)
+{
+  // multiplication operator
+  // The operator can be used to 'combine'
+  // two alignment objects
+  TGeoHMatrix m1;
+  GetMatrix(m1);
+  TGeoHMatrix m2;
+  theAlignObj.GetMatrix(m2);
+  m1.MultiplyLeft(&m2);
+  SetMatrix(m1);
+  // temporary solution: the covariance matrix of the resulting combined object
+  // is set equal to the covariance matrix of the right operand
+  // (not to be used for combining alignment objects for different levels)
+  for(Int_t i=0; i<6; i++)  fDiag[i] = theAlignObj.fDiag[i];
+  for(Int_t i=0; i<15; i++)  fODia[i] = theAlignObj.fODia[i];  
   return *this;
 }
 
@@ -67,11 +115,182 @@ AliAlignObj::~AliAlignObj()
   // dummy destructor
 }
 
+//_____________________________________________________________________________
+void AliAlignObj::SetVolUID(AliGeomManager::ELayerID detId, Int_t modId)
+{
+  // From detector name and module number (according to detector numbering)
+  // build fVolUID, unique numerical identity of that volume inside ALICE
+  // fVolUID is 16 bits, first 5 reserved for detID (32 possible values),
+  // remaining 11 for module ID inside det (2048 possible values).
+  //
+  fVolUID = AliGeomManager::LayerToVolUID(detId,modId);
+}
+
+//_____________________________________________________________________________
+void AliAlignObj::GetVolUID(AliGeomManager::ELayerID &layerId, Int_t &modId) const
+{
+  // From the fVolUID, unique numerical identity of that volume inside ALICE,
+  // (voluid is 16 bits, first 5 reserved for layerID (32 possible values),
+  // remaining 11 for module ID inside det (2048 possible values)), sets
+  // the argument layerId to the identity of the layer to which that volume
+  // belongs and sets the argument modId to the identity of that volume
+  // internally to the layer.
+  //
+  layerId = AliGeomManager::VolUIDToLayer(fVolUID,modId);
+}
+
+//_____________________________________________________________________________
+Bool_t AliAlignObj::GetPars(Double_t tr[], Double_t angles[]) const
+{
+  GetTranslation(tr);
+  return GetAngles(angles);
+}
+
+//_____________________________________________________________________________
+Int_t AliAlignObj::GetLevel() const
+{
+  // Return the geometry level of the alignable volume to which
+  // the alignment object is associated; this is the number of
+  // slashes in the corresponding volume path
+  //
+  if(!gGeoManager){
+    AliWarning("gGeoManager doesn't exist or it is still opened: unable to return meaningful level value.");
+    return (-1);
+  }
+  const char* symname = GetSymName();
+  const char* path;
+  TGeoPNEntry* pne = gGeoManager->GetAlignableEntry(symname);
+  if(pne){
+    path = pne->GetTitle();
+  }else{
+    path = symname;
+  }
+
+  TString pathStr = path;
+  if(pathStr[0]!='/') pathStr.Prepend('/');
+  return pathStr.CountChar('/');
+}
+
+//_____________________________________________________________________________
+Int_t AliAlignObj::Compare(const TObject *obj) const
+{
+  // Compare the levels of two
+  // alignment objects
+  // Used in the sorting during
+  // the application of alignment
+  // objects to the geometry
+  //
+  Int_t level = GetLevel();
+  Int_t level2 = ((AliAlignObj *)obj)->GetLevel();
+  if (level == level2)
+    return 0;
+  else
+    return ((level > level2) ? 1 : -1);
+}
+
+//______________________________________________________________________________
+void AliAlignObj::GetCovMatrix(Double_t *cmat) const
+{
+  // Fills the cmat argument with the coefficients of the external cov matrix (21 elements)
+  // calculating them from the correlation matrix data member
+  //
+
+  for(Int_t i=0; i<6; ++i) {
+    // Off diagonal elements
+    for(Int_t j=0; j<i; ++j) {
+      cmat[i*(i+1)/2+j] = (fDiag[j] >= 0. && fDiag[i] >= 0.) ? fODia[(i-1)*i/2+j]*fDiag[j]*fDiag[i]: -999.;
+    }
+
+    // Diagonal elements
+    cmat[i*(i+1)/2+i] = (fDiag[i] >= 0.) ? fDiag[i]*fDiag[i] : -999.;
+  }
+
+  return;
+}
+
+//______________________________________________________________________________
+void AliAlignObj::GetCovMatrix(TMatrixDSym& mcov) const
+{
+  // Fills the matrix m passed as argument as the covariance matrix calculated
+  // from the coefficients of the reduced covariance matrix data members
+  //
+
+  for(Int_t i=0; i<6; ++i) {
+    // Off diagonal elements
+    for(Int_t j=0; j<i; ++j) {
+      mcov(j,i) = mcov(i,j) = (fDiag[j] >= 0. && fDiag[i] >= 0.) ? fODia[(i-1)*i/2+j]*fDiag[j]*fDiag[i]: -999.;
+    }
+
+    // Diagonal elements
+    mcov(i,i) = (fDiag[i] >= 0.) ? fDiag[i]*fDiag[i] : -999.;
+  }
+
+}
+
+//______________________________________________________________________________
+void AliAlignObj::SetCorrMatrix(Double_t *cmat)
+{
+  // Sets the correlation matrix data member from the coefficients of the external covariance
+  // matrix (21 elements passed as argument). 
+  //
+  if(cmat) {
+
+    // Diagonal elements first
+    for(Int_t i=0; i<6; ++i) {
+      fDiag[i] = (cmat[i*(i+1)/2+i] >= 0.) ? TMath::Sqrt(cmat[i*(i+1)/2+i]) : -999.;
+    }
+
+    // ... then the ones off diagonal
+    for(Int_t i=0; i<6; ++i)
+      // Off diagonal elements
+      for(Int_t j=0; j<i; ++j) {
+       fODia[(i-1)*i/2+j] = (fDiag[i] > 0. && fDiag[j] > 0.) ? cmat[i*(i+1)/2+j]/(fDiag[j]*fDiag[i]) : 0.;       // check for division by zero (due to diagonal element of 0) and for fDiag != -999. (due to negative input diagonal element).
+       if (fODia[(i-1)*i/2+j]>1.)  fODia[(i-1)*i/2+j] =  1.; // check upper boundary
+       if (fODia[(i-1)*i/2+j]<-1.) fODia[(i-1)*i/2+j] = -1.; // check lower boundary
+      }
+  } else {
+    for(Int_t i=0; i< 6; ++i) fDiag[i]=-999.;
+    for(Int_t i=0; i< 6*(6-1)/2; ++i) fODia[i]=0.;
+  }
+
+  return;
+}
+
+//______________________________________________________________________________
+void AliAlignObj::SetCorrMatrix(TMatrixDSym& mcov)
+{
+  // Sets the correlation matrix data member from the covariance matrix mcov passed
+  // passed as argument. 
+  //
+  if(mcov.IsValid()) {
+
+    // Diagonal elements first
+    for(Int_t i=0; i<6; ++i) {
+      fDiag[i] = (mcov(i,i) >= 0.) ? TMath::Sqrt(mcov(i,i)) : -999.;
+    }
+
+    // ... then the ones off diagonal
+    for(Int_t i=0; i<6; ++i)
+      // Off diagonal elements
+      for(Int_t j=0; j<i; ++j) {
+       fODia[(i-1)*i/2+j] = (fDiag[i] > 0. && fDiag[j] > 0.) ? mcov(i,j)/(fDiag[j]*fDiag[i]) : 0.;       // check for division by zero (due to diagonal element of 0) and for fDiag != -999. (due to negative input diagonal element).
+       if (fODia[(i-1)*i/2+j]>1.)  fODia[(i-1)*i/2+j] =  1.; // check upper boundary
+       if (fODia[(i-1)*i/2+j]<-1.) fODia[(i-1)*i/2+j] = -1.; // check lower boundary
+      }
+  } else {
+    for(Int_t i=0; i< 6; ++i) fDiag[i]=-999.;
+    for(Int_t i=0; i< 6*(6-1)/2; ++i) fODia[i]=0.;
+  }
+
+  return;
+}
+
 //_____________________________________________________________________________
 void AliAlignObj::AnglesToMatrix(const Double_t *angles, Double_t *rot) const
 {
   // Calculates the rotation matrix using the 
   // Euler angles in "x y z" notation
+  //
   Double_t degrad = TMath::DegToRad();
   Double_t sinpsi = TMath::Sin(degrad*angles[0]);
   Double_t cospsi = TMath::Cos(degrad*angles[0]);
@@ -96,7 +315,13 @@ Bool_t AliAlignObj::MatrixToAngles(const Double_t *rot, Double_t *angles) const
 {
   // Calculates the Euler angles in "x y z" notation
   // using the rotation matrix
-  if(rot[0]<1e-7 || rot[8]<1e-7) return kFALSE;
+  // Returns false in case the rotation angles can not be
+  // extracted from the matrix
+  //
+  if(TMath::Abs(rot[0])<1e-7 || TMath::Abs(rot[8])<1e-7) {
+    AliError("Failed to extract roll-pitch-yall angles!");
+    return kFALSE;
+  }
   Double_t raddeg = TMath::RadToDeg();
   angles[0]=raddeg*TMath::ATan2(-rot[5],rot[8]);
   angles[1]=raddeg*TMath::ASin(rot[2]);
@@ -104,12 +329,60 @@ Bool_t AliAlignObj::MatrixToAngles(const Double_t *rot, Double_t *angles) const
   return kTRUE;
 }
 
+//______________________________________________________________________________
+void AliAlignObj::Transform(AliTrackPoint &p, Bool_t copycov) const
+{
+  // The method transforms the space-point coordinates using the
+  // transformation matrix provided by the AliAlignObj
+  // In case the copycov flag is set to kTRUE, the covariance matrix 
+  // of the alignment object is copied into the space-point
+  //
+  if (fVolUID != p.GetVolumeID())
+    AliWarning(Form("Alignment object ID is not equal to the space-point ID (%d != %d)",fVolUID,p.GetVolumeID())); 
+
+  TGeoHMatrix m;
+  GetMatrix(m);
+  Double_t *rot = m.GetRotationMatrix();
+  Double_t *tr  = m.GetTranslation();
+
+  Float_t xyzin[3],xyzout[3];
+  p.GetXYZ(xyzin);
+  for (Int_t i = 0; i < 3; i++)
+    xyzout[i] = tr[i]+
+                xyzin[0]*rot[3*i]+
+                xyzin[1]*rot[3*i+1]+
+                xyzin[2]*rot[3*i+2];
+  p.SetXYZ(xyzout);
+
+  if(copycov){
+    TMatrixDSym covmat(6);
+    GetCovMatrix(covmat); 
+    p.SetAlignCovMatrix(covmat);
+  }
+  
+}
+
+//_____________________________________________________________________________
+void AliAlignObj::Transform(AliTrackPointArray &array) const
+{
+  // This method is used to transform all the track points
+  // from the input AliTrackPointArray
+  // 
+  AliTrackPoint p;
+  for (Int_t i = 0; i < array.GetNPoints(); i++) {
+    array.GetPoint(p,i);
+    Transform(p);
+    array.AddPoint(i,&p);
+  }
+}
+
 //_____________________________________________________________________________
 void AliAlignObj::Print(Option_t *) const
 {
   // Print the contents of the
   // alignment object in angles and
   // matrix representations
+  //
   Double_t tr[3];
   GetTranslation(tr);
   Double_t angles[3];
@@ -117,249 +390,319 @@ void AliAlignObj::Print(Option_t *) const
   TGeoHMatrix m;
   GetMatrix(m);
   const Double_t *rot = m.GetRotationMatrix();
-  printf("Volume=%s ID=%u\n", GetVolPath(),GetVolUID());
-  printf("%12.6f%12.6f%12.6f    Tx = %12.6f    Psi   = %12.6f\n", rot[0], rot[1], rot[2], tr[0], angles[0]);
-  printf("%12.6f%12.6f%12.6f    Ty = %12.6f    Theta = %12.6f\n", rot[3], rot[4], rot[5], tr[1], angles[1]);
-  printf("%12.6f%12.6f%12.6f    Tz = %12.6f    Phi   = %12.6f\n", rot[6], rot[7], rot[8], tr[2], angles[2]);
 
-}
-
-
-//=============================================================================
-
-ClassImp(AliAlignObjAngles)
+  printf("Volume=%s\n",GetSymName());
+  if (GetVolUID() != 0) {
+    AliGeomManager::ELayerID layerId;
+    Int_t modId;
+    GetVolUID(layerId,modId);
+    printf("VolumeID=%d LayerID=%d ( %s ) ModuleID=%d\n", GetVolUID(),layerId,AliGeomManager::LayerName(layerId),modId);
+  }
+  printf("%12.8f%12.8f%12.8f    Tx = %12.8f    Psi   = %12.8f\n", rot[0], rot[1], rot[2], tr[0], angles[0]);
+  printf("%12.8f%12.8f%12.8f    Ty = %12.8f    Theta = %12.8f\n", rot[3], rot[4], rot[5], tr[1], angles[1]);
+  printf("%12.8f%12.8f%12.8f    Tz = %12.8f    Phi   = %12.8f\n", rot[6], rot[7], rot[8], tr[2], angles[2]);
 
-//_____________________________________________________________________________
-AliAlignObjAngles::AliAlignObjAngles() //: AliAlignObj()
-{
-  // default constructor
-  fTranslation[0]=fTranslation[1]=fTranslation[2]=0.;
-  fRotation[0]=fRotation[1]=fRotation[2]=0.;
 }
 
 //_____________________________________________________________________________
-AliAlignObjAngles::AliAlignObjAngles(const AliAlignObjAngles& theAlignObj) :
-  AliAlignObj(theAlignObj)
+void AliAlignObj::SetPars(Double_t x, Double_t y, Double_t z,
+                         Double_t psi, Double_t theta, Double_t phi)
 {
-  // copy constructor
-  Double_t tr[3];
-  theAlignObj.GetTranslation(tr);
-  SetTranslation(tr[0],tr[1],tr[2]);
-  Double_t rot[3];
-  theAlignObj.GetAngles(rot);
-  SetRotation(rot[0],rot[1],rot[2]);
+  // Set the global delta transformation by passing 3 angles (expressed in
+  // degrees) and 3 shifts (in centimeters)
+  // 
+  SetTranslation(x,y,z);
+  SetRotation(psi,theta,phi);
 }
 
 //_____________________________________________________________________________
-AliAlignObjAngles &AliAlignObjAngles::operator =(const AliAlignObjAngles& theAlignObj)
+Bool_t AliAlignObj::SetLocalPars(Double_t x, Double_t y, Double_t z,
+                                Double_t psi, Double_t theta, Double_t phi)
 {
-  // assignment operator
-  if(this==&theAlignObj) return *this;
-  ((AliAlignObj *)this)->operator=(theAlignObj);
+  // Set the global delta transformation by passing the parameters
+  // for the local delta transformation (3 shifts and 3 angles).
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  TGeoHMatrix m;
+  Double_t tr[3] = {x, y, z};
+  m.SetTranslation(tr);
+  Double_t angles[3] = {psi, theta, phi};
+  Double_t rot[9];
+  AnglesToMatrix(angles,rot);
+  m.SetRotation(rot);
 
-  Double_t tr[3];
-  theAlignObj.GetTranslation(tr);
-  SetTranslation(tr[0],tr[1],tr[2]);
-  Double_t rot[3];
-  theAlignObj.GetAngles(rot);
-  SetRotation(rot[0],rot[1],rot[2]);
-  return *this;
-}
+  return SetLocalMatrix(m);
 
-//_____________________________________________________________________________
-AliAlignObjAngles::~AliAlignObjAngles()
-{
-  // default destructor
 }
 
 //_____________________________________________________________________________
-void AliAlignObjAngles::SetTranslation(const TGeoMatrix& m)
+Bool_t AliAlignObj::SetLocalTranslation(Double_t x, Double_t y, Double_t z)
 {
-  // Sets the translation parameters from an existing TGeoMatrix
-  if(m.IsTranslation()){
-    const Double_t* tr = m.GetTranslation();
-    fTranslation[0]=tr[0];  fTranslation[1]=tr[1]; fTranslation[2]=tr[2];
-  }else{
-//     AliWarning("Argument matrix is not a translation! Setting zero-translation.");
-    fTranslation[0] = fTranslation[1] = fTranslation[2] = 0.;
-  }
-}
+  // Set the global delta transformation by passing the three shifts giving
+  // the translation in the local reference system of the alignable
+  // volume (known by TGeo geometry).
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  TGeoHMatrix m;
+  Double_t tr[3] = {x, y, z};
+  m.SetTranslation(tr);
 
-//_____________________________________________________________________________
-Bool_t AliAlignObjAngles::SetRotation(const TGeoMatrix& m)
-{
-  // Sets the rotation components from an existing TGeoMatrix
-  if(m.IsRotation()){
-    const Double_t* rot = m.GetRotationMatrix();
-    return MatrixToAngles(rot,fRotation);
-  }else{
-//     AliWarning("Argument matrix is not a rotation! Setting yaw-pitch-roll to zero.");
-    fRotation[0] = fRotation[1] = fRotation[2] = 0.;
-    return kTRUE;
-  }
-}
+  return SetLocalMatrix(m);
 
-//_____________________________________________________________________________
-void AliAlignObjAngles::SetMatrix(const TGeoMatrix& m)
-{
-  // Sets both the rotation and translation components from an
-  // existing TGeoMatrix
-  SetTranslation(m);
-  SetRotation(m);
 }
 
 //_____________________________________________________________________________
-void AliAlignObjAngles::GetPars(Double_t tr[], Double_t angles[]) const
+Bool_t AliAlignObj::SetLocalTranslation(const TGeoMatrix& m)
 {
-  // Returns the translations and the rotation angles
-  GetTranslation(tr);
-  GetAngles(angles);
+  // Set the global delta transformation by passing the matrix of
+  // the local delta transformation and taking its translational part
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  const Double_t* tr = m.GetTranslation();
+  TGeoHMatrix mtr;
+  mtr.SetTranslation(tr);
+
+  return SetLocalMatrix(mtr);
+
 }
 
 //_____________________________________________________________________________
-void AliAlignObjAngles::GetMatrix(TGeoHMatrix& m) const
+Bool_t AliAlignObj::SetLocalRotation(Double_t psi, Double_t theta, Double_t phi)
 {
-  // Extracts the information in an existing TGeoHMatrix using the translations
-  // and the rotation parameters
-  m.SetTranslation(&fTranslation[0]);
+  // Set the global delta transformation by passing the three angles giving
+  // the rotation in the local reference system of the alignable
+  // volume (known by TGeo geometry).
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  TGeoHMatrix m;
+  Double_t angles[3] = {psi, theta, phi};
   Double_t rot[9];
-  AnglesToMatrix(fRotation,rot);
+  AnglesToMatrix(angles,rot);
   m.SetRotation(rot);
-}
 
-//=============================================================================
+  return SetLocalMatrix(m);
 
-ClassImp(AliAlignObjMatrix)
-
-//_____________________________________________________________________________
-AliAlignObjMatrix::AliAlignObjMatrix() : AliAlignObj()
-{
-  // Default constructor
 }
 
-AliAlignObjMatrix::AliAlignObjMatrix(const AliAlignObjMatrix& theAlignObj) :
-  AliAlignObj(theAlignObj)
+//_____________________________________________________________________________
+Bool_t AliAlignObj::SetLocalRotation(const TGeoMatrix& m)
 {
-  //copy constructor
+  // Set the global delta transformation by passing the matrix of
+  // the local delta transformation and taking its rotational part
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
   //
-  Double_t tr[3];
-  theAlignObj.GetTranslation(tr);
-  SetTranslation(tr[0],tr[1],tr[2]);
-  Double_t rot[3];
-  theAlignObj.GetAngles(rot);
-  SetRotation(rot[0],rot[1],rot[2]);
-}
+  TGeoHMatrix rotm;
+  const Double_t* rot = m.GetRotationMatrix();
+  rotm.SetRotation(rot);
 
-AliAlignObjMatrix &AliAlignObjMatrix::operator =(const AliAlignObjMatrix& theAlignObj)
-{  
-  // assignment operator
-  //
-  if(this==&theAlignObj) return *this;
-  ((AliAlignObj *)this)->operator=(theAlignObj);
-  Double_t tr[3];
-  theAlignObj.GetTranslation(tr);
-  SetTranslation(tr[0],tr[1],tr[2]);
-  Double_t rot[3];
-  theAlignObj.GetAngles(rot);
-  SetRotation(rot[0],rot[1],rot[2]);
-  return *this;
-}
+  return SetLocalMatrix(rotm);
 
-AliAlignObjMatrix::~AliAlignObjMatrix()
-{
-  // Destructor
-  //
 }
 
 //_____________________________________________________________________________
-void AliAlignObjMatrix::SetTranslation(Double_t x, Double_t y, Double_t z)
+Bool_t AliAlignObj::SetLocalMatrix(const TGeoMatrix& m)
 {
-  // Sets the translation parameters
-  Double_t tr[3];
-  tr[0]=x; tr[1]=y; tr[2]=z;
-  fMatrix.SetTranslation(tr);
-}
+  // Set the global delta transformation by passing the TGeo matrix
+  // for the local delta transformation.
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  if (!gGeoManager || !gGeoManager->IsClosed()) {
+    AliError("Can't set the alignment object parameters! gGeoManager doesn't exist or it is still opened!");
+    return kFALSE;
+  }
 
-//_____________________________________________________________________________
-void AliAlignObjMatrix::SetTranslation(const TGeoMatrix& m)
-{
-  // Sets the translation parameters from an existing TGeoMatrix
-  const Double_t *tr = m.GetTranslation();
-  fMatrix.SetTranslation(tr);
-}
+  const char* symname = GetSymName();
+  TGeoPhysicalNode* node;
+  TGeoPNEntry* pne = gGeoManager->GetAlignableEntry(symname);
+  if(pne){
+    node = gGeoManager->MakeAlignablePN(pne);
+  }else{
+    AliWarning(Form("The symbolic volume name %s does not correspond to a physical entry. Using it as volume path!",symname));
+    node = (TGeoPhysicalNode*) gGeoManager->MakePhysicalNode(symname);
+  }
 
-//_____________________________________________________________________________
-void AliAlignObjMatrix::SetRotation(Double_t psi, Double_t theta, Double_t phi)
-{
-  // Sets the rotation parameters
-  Double_t angles[3] = {psi, theta, phi};
-  Double_t rot[9];
-  AnglesToMatrix(angles,rot);
-  fMatrix.SetRotation(rot);
-}
+  if (!node) {
+    AliError(Form("Volume name or path %s not valid!",symname));
+    return kFALSE;
+  }
+  if (node->IsAligned())
+    AliWarning(Form("Volume %s has been already misaligned!",symname));
 
-//_____________________________________________________________________________
-Bool_t AliAlignObjMatrix::SetRotation(const TGeoMatrix& m)
-{
-  // Sets the rotation parameters from an existing TGeoMatrix
+  TGeoHMatrix m1;
+  const Double_t *tr = m.GetTranslation();
+  m1.SetTranslation(tr);
   const Double_t* rot = m.GetRotationMatrix();
-  fMatrix.SetRotation(rot);
-  return kTRUE;
+  m1.SetRotation(rot);
+
+  TGeoHMatrix align,gprime,gprimeinv;
+  gprime = *node->GetMatrix();
+  gprimeinv = gprime.Inverse();
+  m1.Multiply(&gprimeinv);
+  m1.MultiplyLeft(&gprime);
+
+  return SetMatrix(m1);
 }
 
 //_____________________________________________________________________________
-void AliAlignObjMatrix::SetMatrix(const TGeoMatrix& m)
+Bool_t AliAlignObj::SetMatrix(const TGeoMatrix& m)
 {
-  // Set rotation matrix and translation
-  // using TGeoMatrix
+  // Set the global delta transformation by passing the TGeoMatrix
+  // for it
+  //
   SetTranslation(m);
-  SetRotation(m);
+  return SetRotation(m);
 }
 
 //_____________________________________________________________________________
-void AliAlignObjMatrix::SetPars(Double_t x, Double_t y, Double_t z,
-                      Double_t psi, Double_t theta, Double_t phi)
+Bool_t AliAlignObj::GetLocalPars(Double_t transl[], Double_t angles[]) const
 {
-  // Set rotation matrix and translation
-  // using 3 angles and 3 translations
-  SetTranslation(x,y,z);
-  SetRotation(psi,theta,phi);
+  // Get the translations and angles (in degrees) expressing the
+  // local delta transformation.
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  if(!GetLocalTranslation(transl)) return kFALSE;
+  return GetLocalAngles(angles);
 }
 
 //_____________________________________________________________________________
-void AliAlignObjMatrix::GetTranslation(Double_t *tr) const
+Bool_t AliAlignObj::GetLocalTranslation(Double_t* tr) const
 {
-  // Get Translation from TGeoMatrix
-  const Double_t* translation = fMatrix.GetTranslation();
-  tr[0] = translation[0];
-  tr[1] = translation[1];
-  tr[2] = translation[2];
+  // Get the 3 shifts giving the translational part of the local
+  // delta transformation.
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  TGeoHMatrix ml;
+  if(!GetLocalMatrix(ml)) return kFALSE;
+  const Double_t* transl;
+  transl = ml.GetTranslation();
+  tr[0]=transl[0];
+  tr[1]=transl[1];
+  tr[2]=transl[2];
+  return kTRUE;
 }
 
 //_____________________________________________________________________________
-Bool_t AliAlignObjMatrix::GetAngles(Double_t *angles) const
+Bool_t AliAlignObj::GetLocalAngles(Double_t* angles) const
 {
-  // Get rotation angles from the TGeoHMatrix
-  const Double_t* rot = fMatrix.GetRotationMatrix();
+  // Get the 3 angles giving the rotational part of the local
+  // delta transformation.
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  TGeoHMatrix ml;
+  if(!GetLocalMatrix(ml)) return kFALSE;
+  const Double_t *rot = ml.GetRotationMatrix();
   return MatrixToAngles(rot,angles);
 }
 
 //_____________________________________________________________________________
-void AliAlignObjMatrix::GetPars(Double_t tr[], Double_t angles[]) const
+Bool_t AliAlignObj::GetLocalMatrix(TGeoHMatrix& m) const
 {
-  // Gets the translations and the rotation angles
-  GetTranslation(tr);
-  GetAngles(angles);
+  // Get the matrix for the local delta transformation.
+  // In case that the TGeo was not initialized or not closed,
+  // returns false and the object parameters are not set.
+  //
+  if (!gGeoManager || !gGeoManager->IsClosed()) {
+    AliError("Can't set the alignment object parameters! gGeoManager doesn't exist or it is still opened!");
+    return kFALSE;
+  }
+
+  const char* symname = GetSymName();
+  TGeoPhysicalNode* node;
+  TGeoPNEntry* pne = gGeoManager->GetAlignableEntry(symname);
+  if(pne){
+    node = gGeoManager->MakeAlignablePN(pne);
+  }else{
+    AliWarning(Form("The symbolic volume name %s does not correspond to a physical entry. Using it as volume path!",symname));
+    node = (TGeoPhysicalNode*) gGeoManager->MakePhysicalNode(symname);
+  }
+
+  if (!node) {
+    AliError(Form("Volume name or path %s not valid!",symname));
+    return kFALSE;
+  }
+  if (node->IsAligned())
+    AliWarning(Form("Volume %s has been already misaligned!",symname));
+
+  GetMatrix(m);
+  TGeoHMatrix gprime,gprimeinv;
+  gprime = *node->GetMatrix();
+  gprimeinv = gprime.Inverse();
+  m.Multiply(&gprime);
+  m.MultiplyLeft(&gprimeinv);
+
+  return kTRUE;
 }
 
 //_____________________________________________________________________________
-void AliAlignObjMatrix::GetMatrix(TGeoHMatrix& m) const
+Bool_t AliAlignObj::ApplyToGeometry(Bool_t ovlpcheck)
 {
-  // Extracts the translations and the rotation parameters
-  // in an existing TGeoHMatrix
-  const Double_t *tr = fMatrix.GetTranslation();
-  m.SetTranslation(tr);
-  const Double_t *rot = fMatrix.GetRotationMatrix();
-  m.SetRotation(rot);
+  // Apply the current alignment object to the TGeo geometry
+  // This method returns FALSE if the symname of the object was not
+  // valid neither to get a TGeoPEntry nor as a volume path
+  //
+  if (!gGeoManager || !gGeoManager->IsClosed()) {
+    AliError("Can't apply the alignment object! gGeoManager doesn't exist or it is still opened!");
+    return kFALSE;
+  }
+  
+  const char* symname = GetSymName();
+  const char* path;
+  TGeoPhysicalNode* node;
+  TGeoPNEntry* pne = gGeoManager->GetAlignableEntry(symname);
+  if(pne){
+    path = pne->GetTitle();
+    node = gGeoManager->MakeAlignablePN(pne);
+  }else{
+    AliDebug(1,Form("The symbolic volume name %s does not correspond to a physical entry. Using it as a volume path!",symname));
+    path=symname;
+    if (!gGeoManager->CheckPath(path)) {
+      AliDebug(1,Form("Volume path %s not valid!",path));
+      return kFALSE;
+    }
+    if (gGeoManager->GetListOfPhysicalNodes()->FindObject(path)) {
+      AliError(Form("Volume %s has already been misaligned!",path));
+      return kFALSE;
+    }
+    node = (TGeoPhysicalNode*) gGeoManager->MakePhysicalNode(path);
+  }
+
+  if (!node) {
+    AliError(Form("Volume path %s not valid!",path));
+    return kFALSE;
+  }
+
+  TGeoHMatrix align,gprime;
+  gprime = *node->GetMatrix();
+  GetMatrix(align);
+  gprime.MultiplyLeft(&align);
+  TGeoHMatrix *ginv = new TGeoHMatrix;
+  TGeoHMatrix *g = node->GetMatrix(node->GetLevel()-1);
+  *ginv = g->Inverse();
+  *ginv *= gprime;
+  AliGeomManager::ELayerID layerId; // unique identity for layer in the alobj
+  Int_t modId; // unique identity for volume inside layer in the alobj
+  GetVolUID(layerId, modId);
+  AliDebug(2,Form("Aligning volume %s of detector layer %d with local ID %d",symname,layerId,modId));
+  node->Align(ginv,0,ovlpcheck);
+  if(ovlpcheck){
+    Int_t novex=((TObjArray*)gGeoManager->GetListOfOverlaps())->GetEntriesFast();
+    if(novex){
+      TString error(Form("The alignment of volume %s introduced %d new overlap",GetSymName(),novex));
+      if(novex>1) error+="s";
+      AliError(error.Data());
+      return kFALSE;
+    }
+  }
+
+  return kTRUE;
 }