library: libVMC
#include "TGeoMCGeometry.h"

TGeoMCGeometry


class description - header file - source file - inheritance tree (.pdf)

class TGeoMCGeometry : public TVirtualMCGeometry

Inheritance Chart:
TObject
<-
TNamed
<-
TVirtualMCGeometry
<-
TGeoMCGeometry
    private:
TGeoMCGeometry(const TGeoMCGeometry& rhs) Double_t* CreateDoubleArray(Float_t* array, Int_t size) const TGeoMCGeometry& operator=(const TGeoMCGeometry&) void Vname(const char* name, char* vname) const public:
TGeoMCGeometry(const char* name, const char* title, Bool_t g3CompatibleVolumeNames = false) TGeoMCGeometry() virtual ~TGeoMCGeometry() static TClass* Class() virtual Bool_t GetMaterial(const TString& volumeName, TString& name, Int_t& imat, Double_t& a, Double_t& z, Double_t& density, Double_t& radl, Double_t& inter, TArrayD& par) virtual Bool_t GetMedium(const TString& volumeName, TString& name, Int_t& imed, Int_t& nmat, Int_t& isvol, Int_t& ifield, Double_t& fieldm, Double_t& tmaxfd, Double_t& stemax, Double_t& deemax, Double_t& epsil, Double_t& stmin, TArrayD& par) virtual Bool_t GetShape(const TString& volumePath, TString& shapeType, TArrayD& par) virtual Bool_t GetTransformation(const TString& volumePath, TGeoHMatrix& matrix) virtual void Gsbool(const char*, const char*) virtual void Gsdvn(const char* name, const char* mother, Int_t ndiv, Int_t iaxis) virtual void Gsdvn2(const char* name, const char* mother, Int_t ndiv, Int_t iaxis, Double_t c0i, Int_t numed) virtual void Gsdvt(const char* name, const char* mother, Double_t step, Int_t iaxis, Int_t numed, Int_t ndvmx) virtual void Gsdvt2(const char* name, const char* mother, Double_t step, Int_t iaxis, Double_t c0, Int_t numed, Int_t ndvmx) virtual void Gsord(const char* name, Int_t iax) virtual void Gspos(const char* name, Int_t nr, const char* mother, Double_t x, Double_t y, Double_t z, Int_t irot, const char* konly) virtual void Gsposp(const char* name, Int_t nr, const char* mother, Double_t x, Double_t y, Double_t z, Int_t irot, const char* konly, Float_t* upar, Int_t np) virtual void Gsposp(const char* name, Int_t nr, const char* mother, Double_t x, Double_t y, Double_t z, Int_t irot, const char* konly, Double_t* upar, Int_t np) virtual Int_t Gsvolu(const char* name, const char* shape, Int_t nmed, Float_t* upar, Int_t np) virtual Int_t Gsvolu(const char* name, const char* shape, Int_t nmed, Double_t* upar, Int_t np) virtual TClass* IsA() const virtual void Material(Int_t& kmat, const char* name, Double_t a, Double_t z, Double_t dens, Double_t radl, Double_t absl, Float_t* buf, Int_t nwbuf) virtual void Material(Int_t& kmat, const char* name, Double_t a, Double_t z, Double_t dens, Double_t radl, Double_t absl, Double_t* buf, Int_t nwbuf) virtual void Matrix(Int_t& krot, Double_t thetaX, Double_t phiX, Double_t thetaY, Double_t phiY, Double_t thetaZ, Double_t phiZ) virtual void Medium(Int_t& kmed, const char* name, Int_t nmat, Int_t isvol, Int_t ifield, Double_t fieldm, Double_t tmaxfd, Double_t stemax, Double_t deemax, Double_t epsil, Double_t stmin, Float_t* ubuf, Int_t nbuf) virtual void Medium(Int_t& kmed, const char* name, Int_t nmat, Int_t isvol, Int_t ifield, Double_t fieldm, Double_t tmaxfd, Double_t stemax, Double_t deemax, Double_t epsil, Double_t stmin, Double_t* ubuf, Int_t nbuf) virtual void Mixture(Int_t& kmat, const char* name, Float_t* a, Float_t* z, Double_t dens, Int_t nlmat, Float_t* wmat) virtual void Mixture(Int_t& kmat, const char* name, Double_t* a, Double_t* z, Double_t dens, Int_t nlmat, Double_t* wmat) virtual Int_t NofVolDaughters(const char* volName) const virtual Int_t NofVolumes() const virtual void ShowMembers(TMemberInspector& insp, char* parent) virtual void Streamer(TBuffer& b) void StreamerNVirtual(TBuffer& b) virtual Int_t VolDaughterCopyNo(const char* volName, Int_t i) const virtual const char* VolDaughterName(const char* volName, Int_t i) const virtual Int_t VolId(const Text_t* volName) const virtual Int_t VolId2Mate(Int_t id) const virtual const char* VolName(Int_t id) const

Data Members

    private:
Bool_t fG3CompatibleVolumeNames option to convert volumes names to static TGeoMCGeometry* fgInstance singleton instance

Class Description

______________________________________________________________________________

 Implementation of the TVirtualMCGeometry interface
 for building TGeo geometry.
______________________________________________________________________________
TGeoMCGeometry(const char *name, const char *title, Bool_t g3CompatibleVolumeNames)
 Standard constructor

TGeoMCGeometry()
 Default constructor

~TGeoMCGeometry()
 Destructor

TGeoMCGeometry(const TGeoMCGeometry &geom)
 Copy constructor

Double_t* CreateDoubleArray(Float_t* array, Int_t size)
 Converts Float_t* array to Double_t*,
 !! The new array has to be deleted by user.
 ---
void Vname(const char *name, char *vname)
  convert name to upper case. Make vname at least 4 chars

void Material(Int_t& kmat, const char* name, Double_t a, Double_t z, Double_t dens, Double_t radl, Double_t absl, Float_t* buf, Int_t nwbuf)
 Defines a Material

  kmat               number assigned to the material
  name               material name
  a                  atomic mass in au
  z                  atomic number
  dens               density in g/cm3
  absl               absorbtion length in cm
                     if >=0 it is ignored and the program
                     calculates it, if <0. -absl is taken
  radl               radiation length in cm
                     if >=0 it is ignored and the program
                     calculates it, if <0. -radl is taken
  buf                pointer to an array of user words
  nbuf               number of user words

void Material(Int_t& kmat, const char* name, Double_t a, Double_t z, Double_t dens, Double_t radl, Double_t absl, Double_t* /*buf*/, Int_t /*nwbuf*/)
{

 Defines a Material

  kmat               number assigned to the material
  name               material name
  a                  atomic mass in au
  z                  atomic number
  dens               density in g/cm3
  absl               absorbtion length in cm
                     if >=0 it is ignored and the program
                     calculates it, if <0. -absl is taken
  radl               radiation length in cm
                     if >=0 it is ignored and the program
                     calculates it, if <0. -radl is taken
  buf                pointer to an array of user words
  nbuf               number of user words


gGeoManager->Material(name, a, z, dens, kmat, radl, absl);
}

_____________________________________________________________________________
void TGeoMCGeometry::Mixture(Int_t& kmat, const char* name, Float_t* a, Float_t* z,
Double_t dens, Int_t nlmat, Float_t* wmat)
{

 Defines mixture OR COMPOUND IMAT as composed by
 THE BASIC NLMAT materials defined by arrays A,Z and WMAT

 If NLMAT > 0 then wmat contains the proportion by
 weights of each basic material in the mixture.

 If nlmat < 0 then WMAT contains the number of atoms
 of a given kind into the molecule of the COMPOUND
 In this case, WMAT in output is changed to relative
 weigths.


Double_t* da = CreateDoubleArray(a, TMath::Abs(nlmat));
Double_t* dz = CreateDoubleArray(z, TMath::Abs(nlmat));
Double_t* dwmat = CreateDoubleArray(wmat, TMath::Abs(nlmat));

Mixture(kmat, name, da, dz, dens, nlmat, dwmat);
for (Int_t i=0; i<nlmat; i++) {
a[i] = da[i]; z[i] = dz[i]; wmat[i] = dwmat[i];
}

delete [] da;
delete [] dz;
delete [] dwmat;
}

_____________________________________________________________________________
void TGeoMCGeometry::Mixture(Int_t& kmat, const char* name, Double_t* a, Double_t* z,
Double_t dens, Int_t nlmat, Double_t* wmat)
{

 Defines mixture OR COMPOUND IMAT as composed by
 THE BASIC NLMAT materials defined by arrays A,Z and WMAT

 If NLMAT > 0 then wmat contains the proportion by
 weights of each basic material in the mixture.

 If nlmat < 0 then WMAT contains the number of atoms
 of a given kind into the molecule of the COMPOUND
 In this case, WMAT in output is changed to relative
 weigths.


if (nlmat < 0) {
nlmat = - nlmat;
Double_t amol = 0;
Int_t i;
for (i=0;i<nlmat;i++) {
amol += a[i]*wmat[i];
}
for (i=0;i<nlmat;i++) {
wmat[i] *= a[i]/amol;
}
}
gGeoManager->Mixture(name, a, z, dens, nlmat, wmat, kmat);
}

_____________________________________________________________________________
void TGeoMCGeometry::Medium(Int_t& kmed, const char* name, Int_t nmat, Int_t isvol,
Int_t ifield, Double_t fieldm, Double_t tmaxfd,
Double_t stemax, Double_t deemax, Double_t epsil,
Double_t stmin, Float_t* ubuf, Int_t nbuf)
{

  kmed      tracking medium number assigned
  name      tracking medium name
  nmat      material number
  isvol     sensitive volume flag
  ifield    magnetic field
  fieldm    max. field value (kilogauss)
  tmaxfd    max. angle due to field (deg/step)
  stemax    max. step allowed
  deemax    max. fraction of energy lost in a step
  epsil     tracking precision (cm)
  stmin     min. step due to continuous processes (cm)

  ifield = 0 if no magnetic field; ifield = -1 if user decision in guswim;
  ifield = 1 if tracking performed with g3rkuta; ifield = 2 if tracking
  performed with g3helix; ifield = 3 if tracking performed with g3helx3.


printf("Creating mediuma: %s, numed=%d, nmat=%d\n",name,kmed,nmat);
void Medium(Int_t& kmed, const char* name, Int_t nmat, Int_t isvol, Int_t ifield, Double_t fieldm, Double_t tmaxfd, Double_t stemax, Double_t deemax, Double_t epsil, Double_t stmin, Double_t* /*ubuf*/, Int_t /*nbuf*/)
{

  kmed      tracking medium number assigned
  name      tracking medium name
  nmat      material number
  isvol     sensitive volume flag
  ifield    magnetic field
  fieldm    max. field value (kilogauss)
  tmaxfd    max. angle due to field (deg/step)
  stemax    max. step allowed
  deemax    max. fraction of energy lost in a step
  epsil     tracking precision (cm)
  stmin     min. step due to continuos processes (cm)

  ifield = 0 if no magnetic field; ifield = -1 if user decision in guswim;
  ifield = 1 if tracking performed with g3rkuta; ifield = 2 if tracking
  performed with g3helix; ifield = 3 if tracking performed with g3helx3.


gGeoManager->Medium(name,kmed,nmat, isvol, ifield, fieldm, tmaxfd, stemax,deemax, epsil, stmin);
}

_____________________________________________________________________________
void TGeoMCGeometry::Matrix(Int_t& krot, Double_t thex, Double_t phix, Double_t they,
Double_t phiy, Double_t thez, Double_t phiz)
{

  krot     rotation matrix number assigned
  theta1   polar angle for axis i
  phi1     azimuthal angle for axis i
  theta2   polar angle for axis ii
  phi2     azimuthal angle for axis ii
  theta3   polar angle for axis iii
  phi3     azimuthal angle for axis iii

  it defines the rotation matrix number irot.


krot = gGeoManager->GetListOfMatrices()->GetEntriesFast();
gGeoManager->Matrix(krot, thex, phix, they, phiy, thez, phiz);
}

_____________________________________________________________________________
Int_t TGeoMCGeometry::Gsvolu(const char *name, const char *shape, Int_t nmed,
Float_t *upar, Int_t npar)
{

  NAME   Volume name
  SHAPE  Volume type
  NUMED  Tracking medium number
  NPAR   Number of shape parameters
  UPAR   Vector containing shape parameters

  It creates a new volume in the JVOLUM data structure.


Double_t* dupar = CreateDoubleArray(upar, npar);
Int_t id = Gsvolu(name, shape, nmed, dupar, npar);
delete [] dupar;
return id;
}

_____________________________________________________________________________
Int_t TGeoMCGeometry::Gsvolu(const char *name, const char *shape, Int_t nmed,
Double_t *upar, Int_t npar)
{

  NAME   Volume name
  SHAPE  Volume type
  NUMED  Tracking medium number
  NPAR   Number of shape parameters
  UPAR   Vector containing shape parameters

  It creates a new volume in the JVOLUM data structure.


char vname[80];
Vname(name,vname);
char vshape[5];
Vname(shape,vshape);

TGeoVolume* vol = gGeoManager->Volume(vname, vshape, nmed, upar, npar);
return vol->GetNumber();
}

_____________________________________________________________________________
void  TGeoMCGeometry::Gsdvn(const char *name, const char *mother, Int_t ndiv,
Int_t iaxis)
{

 Create a new volume by dividing an existing one

  NAME   Volume name
  MOTHER Mother volume name
  NDIV   Number of divisions
  IAXIS  Axis value

  X,Y,Z of CAXIS will be translated to 1,2,3 for IAXIS.
  It divides a previously defined volume.

char vname[80];
Vname(name,vname);
char vmother[80];
Vname(mother,vmother);

void Gsdvn2(const char *name, const char *mother, Int_t ndiv, Int_t iaxis, Double_t c0i, Int_t numed)
 Create a new volume by dividing an existing one

 Divides mother into ndiv divisions called name
 along axis iaxis starting at coordinate value c0.
 the new volume created will be medium number numed.

void Gsdvt(const char *name, const char *mother, Double_t step, Int_t iaxis, Int_t numed, Int_t /*ndvmx*/)
{

 Create a new volume by dividing an existing one

       Divides MOTHER into divisions called NAME along
       axis IAXIS in steps of STEP. If not exactly divisible
       will make as many as possible and will centre them
       with respect to the mother. Divisions will have medium
       number NUMED. If NUMED is 0, NUMED of MOTHER is taken.
       NDVMX is the expected maximum number of divisions
          (If 0, no protection tests are performed)

char vname[80];
Vname(name,vname);
char vmother[80];
Vname(mother,vmother);

void Gsdvt2(const char *name, const char *mother, Double_t step, Int_t iaxis, Double_t c0, Int_t numed, Int_t /*ndvmx*/)
{

 Create a new volume by dividing an existing one

           Divides MOTHER into divisions called NAME along
            axis IAXIS starting at coordinate value C0 with step
            size STEP.
           The new volume created will have medium number NUMED.
           If NUMED is 0, NUMED of mother is taken.
           NDVMX is the expected maximum number of divisions
             (If 0, no protection tests are performed)

char vname[80];
Vname(name,vname);
char vmother[80];
Vname(mother,vmother);

void Gspos(const char *name, Int_t nr, const char *mother, Double_t x, Double_t y, Double_t z, Int_t irot, const char *konly)
 Position a volume into an existing one

  NAME   Volume name
  NUMBER Copy number of the volume
  MOTHER Mother volume name
  X      X coord. of the volume in mother ref. sys.
  Y      Y coord. of the volume in mother ref. sys.
  Z      Z coord. of the volume in mother ref. sys.
  IROT   Rotation matrix number w.r.t. mother ref. sys.
  ONLY   ONLY/MANY flag

  It positions a previously defined volume in the mother.

void Gsposp(const char *name, Int_t nr, const char *mother, Double_t x, Double_t y, Double_t z, Int_t irot, const char *konly, Float_t *upar, Int_t np )
      Place a copy of generic volume NAME with user number
      NR inside MOTHER, with its parameters UPAR(1..NP)

void Gsposp(const char *name, Int_t nr, const char *mother, Double_t x, Double_t y, Double_t z, Int_t irot, const char *konly, Double_t *upar, Int_t np )
      Place a copy of generic volume NAME with user number
      NR inside MOTHER, with its parameters UPAR(1..NP)

Int_t VolId(const Text_t *name)
 Return the unique numeric identifier for volume name

const char* VolName(Int_t id)
 Return the volume name given the volume identifier

Int_t NofVolumes()
 Return total number of volumes in the geometry

Int_t NofVolDaughters(const char* volName)
 Return number of daughters of the volume specified by volName
 According to A. Morsch' G3toRoot class (by A. Morsch)
 ---
const char* VolDaughterName(const char* volName, Int_t i)
 Return the name of i-th daughters of the volume specified by volName
 According to A. Morsch' G3toRoot class.
 ---
Int_t VolDaughterCopyNo(const char* volName, Int_t i)
 Return the copyNo of i-th daughters of the volume specified by volName
 According to A. Morsch' G3toRoot class.
 ---
Int_t VolId2Mate(Int_t id)
 Return material number for a given volume id

Bool_t GetTransformation(const TString &volumePath,TGeoHMatrix &mat)
 Returns the Transformation matrix between the volume specified
 by the path volumePath and the Top or mater volume. The format
 of the path volumePath is as follows (assuming ALIC is the Top volume)
 "/ALIC_1/DDIP_1/S05I_2/S05H_1/S05G_3". Here ALIC is the top most
 or master volume which has only 1 instance of. Of all of the daughter
 volumes of ALICE, DDIP volume copy #1 is indicated. Similarly for
 the daughter volume of DDIP is S05I copy #2 and so on.
 Inputs:
   TString& volumePath  The volume path to the specific volume
                        for which you want the matrix. Volume name
                        hierarchy is separated by "/" while the
                        copy number is appended using a "_".
 Outputs:
  TGeoHMatrix &mat      A matrix with its values set to those
                        appropriate to the Local to Master transformation
 Return:
   A logical value if kFALSE then an error occurred and no change to
   mat was made.
Bool_t GetShape(const TString &volumePath,TString &shapeType, TArrayD &par)
 Returns the shape and its parameters for the volume specified
 by volumeName.
 Inputs:
   TString& volumeName  The volume name
 Outputs:
   TString &shapeType   Shape type
   TArrayD &par         A TArrayD of parameters with all of the
                        parameters of the specified shape.
 Return:
   A logical indicating whether there was an error in getting this
   information
Bool_t GetMaterial(const TString &volumeName, TString &name,Int_t &imat, Double_t &a,Double_t &z,Double_t &dens, Double_t &radl,Double_t &inter,TArrayD &par)
 Returns the Material and its parameters for the volume specified
 by volumeName.
 Note, Geant3 stores and uses mixtures as an element with an effective
 Z and A. Consequently, if the parameter Z is not integer, then
 this material represents some sort of mixture.
 Inputs:
   TString& volumeName  The volume name
 Outputs:
   TSrting   &name       Material name
   Int_t     &imat       Material index number
   Double_t  &a          Average Atomic mass of material
   Double_t  &z          Average Atomic number of material
   Double_t  &dens       Density of material [g/cm^3]
   Double_t  &radl       Average radiation length of material [cm]
   Double_t  &inter      Average interaction length of material [cm]
   TArrayD   &par        A TArrayD of user defined parameters.
 Return:
   kTRUE if no errors
Bool_t GetMedium(const TString &volumeName,TString &name, Int_t &imed,Int_t &nmat,Int_t &isvol,Int_t &ifield, Double_t &fieldm,Double_t &tmaxfd,Double_t &stemax, Double_t &deemax,Double_t &epsil, Double_t &stmin, TArrayD &par)
 Returns the Medium and its parameters for the volume specified
 by volumeName.
 Inputs:
   TString& volumeName  The volume name.
 Outputs:
   TString  &name       Medium name
   Int_t    &nmat       Material number defined for this medium
   Int_t    &imed       The medium index number
   Int_t    &isvol      volume number defined for this medium
   Int_t    &iflield    Magnetic field flag
   Double_t &fieldm     Magnetic field strength
   Double_t &tmaxfd     Maximum angle of deflection per step
   Double_t &stemax     Maximum step size
   Double_t &deemax     Maximum fraction of energy allowed to be lost
                        to continuous process.
   Double_t &epsil      Boundary crossing precision
   Double_t &stmin      Minimum step size allowed
   TArrayD  &par        A TArrayD of user parameters with all of the
                        parameters of the specified medium.
 Return:
   kTRUE if there where no errors
void Mixture(Int_t& kmat, const char *name, Float_t *a, Float_t *z, Double_t dens, Int_t nlmat, Float_t *wmat)
void Mixture(Int_t& kmat, const char *name, Double_t *a, Double_t *z, Double_t dens, Int_t nlmat, Double_t *wmat)
void Medium(Int_t& kmed, const char *name, Int_t nmat, Int_t isvol, Int_t ifield, Double_t fieldm, Double_t tmaxfd, Double_t stemax, Double_t deemax, Double_t epsil, Double_t stmin, Float_t* ubuf, Int_t nbuf)
void Matrix(Int_t& krot, Double_t thetaX, Double_t phiX, Double_t thetaY, Double_t phiY, Double_t thetaZ, Double_t phiZ)
Int_t Gsvolu(const char *name, const char *shape, Int_t nmed, Float_t *upar, Int_t np)
 functions from GGEOM
Int_t Gsvolu(const char *name, const char *shape, Int_t nmed, Double_t *upar, Int_t np)
void Gsdvn(const char *name, const char *mother, Int_t ndiv, Int_t iaxis)
void Gsord(const char *name, Int_t iax)

Last update: root/mc:$Name: $:$Id: TGeoMCGeometry.cxx,v 1.9 2006/05/13 20:57:20 brun Exp $


ROOT page - Class index - Class Hierarchy - Top of the page

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.