Back to home page

EIC code displayed by LXR

 
 

    


File indexing completed on 2025-04-04 08:05:15

0001 //
0002 // ********************************************************************
0003 // * License and Disclaimer                                           *
0004 // *                                                                  *
0005 // * The  Geant4 software  is  copyright of the Copyright Holders  of *
0006 // * the Geant4 Collaboration.  It is provided  under  the terms  and *
0007 // * conditions of the Geant4 Software License,  included in the file *
0008 // * LICENSE and available at  http://cern.ch/geant4/license .  These *
0009 // * include a list of copyright holders.                             *
0010 // *                                                                  *
0011 // * Neither the authors of this software system, nor their employing *
0012 // * institutes,nor the agencies providing financial support for this *
0013 // * work  make  any representation or  warranty, express or implied, *
0014 // * regarding  this  software system or assume any liability for its *
0015 // * use.  Please see the license in the file  LICENSE  and URL above *
0016 // * for the full disclaimer and the limitation of liability.         *
0017 // *                                                                  *
0018 // * This  code  implementation is the result of  the  scientific and *
0019 // * technical work of the GEANT4 collaboration.                      *
0020 // * By using,  copying,  modifying or  distributing the software (or *
0021 // * any work based  on the software)  you  agree  to acknowledge its *
0022 // * use  in  resulting  scientific  publications,  and indicate your *
0023 // * acceptance of all terms of the Geant4 Software license.          *
0024 // ********************************************************************
0025 //
0026 /// \file DetectorConstruction.cc
0027 /// \brief Implementation of the DetectorConstruction class
0028 //
0029 //
0030 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0031 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0032 
0033 #include "DetectorConstruction.hh"
0034 
0035 #include "DetectorMessenger.hh"
0036 
0037 #include "G4Box.hh"
0038 #include "G4GeometryManager.hh"
0039 #include "G4LogicalVolume.hh"
0040 #include "G4LogicalVolumeStore.hh"
0041 #include "G4Material.hh"
0042 #include "G4NistManager.hh"
0043 #include "G4PVPlacement.hh"
0044 #include "G4PVReplica.hh"
0045 #include "G4PhysicalConstants.hh"
0046 #include "G4PhysicalVolumeStore.hh"
0047 #include "G4RunManager.hh"
0048 #include "G4SolidStore.hh"
0049 #include "G4SystemOfUnits.hh"
0050 #include "G4UnitsTable.hh"
0051 
0052 #include <iomanip>
0053 
0054 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0055 
0056 DetectorConstruction::DetectorConstruction()
0057 {
0058   for (G4int i = 0; i < kMaxAbsor; ++i) {
0059     fAbsorMaterial[i] = nullptr;
0060     fAbsorThickness[i] = 0.0;
0061     fSolidAbsor[i] = nullptr;
0062     fLogicAbsor[i] = nullptr;
0063     fPhysiAbsor[i] = nullptr;
0064   }
0065 
0066   // default parameter values of the calorimeter
0067   fNbOfAbsor = 2;
0068   fAbsorThickness[1] = 36 * mm;
0069   fAbsorThickness[2] = 4 * mm;
0070   fNbOfLayers = 50;
0071   fCalorSizeYZ = 1.5 * m;
0072   ComputeCalorParameters();
0073 
0074   // materials
0075   DefineMaterials();
0076   SetWorldMaterial("Galactic");
0077   SetAbsorMaterial(1, "Iron");
0078   SetAbsorMaterial(2, "Scintillator");
0079 
0080   // create commands for interactive definition of the calorimeter
0081   fDetectorMessenger = new DetectorMessenger(this);
0082 }
0083 
0084 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0085 
0086 DetectorConstruction::~DetectorConstruction()
0087 {
0088   delete fDetectorMessenger;
0089 }
0090 
0091 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0092 
0093 void DetectorConstruction::DefineMaterials()
0094 {
0095   // This function illustrates the possible ways to define materials using
0096   // G4 database on G4Elements
0097   G4NistManager* manager = G4NistManager::Instance();
0098   manager->SetVerbose(0);
0099   //
0100   // define Elements
0101   //
0102   G4Element* H = manager->FindOrBuildElement(1);
0103   G4Element* C = manager->FindOrBuildElement(6);
0104   G4Element* O = manager->FindOrBuildElement(8);
0105   //
0106   // define an Element from isotopes, by relative abundance
0107   //
0108   G4int iz, n;  // iz=number of protons  in an isotope;
0109                 //  n=number of nucleons in an isotope;
0110   G4int ncomponents;
0111   G4double z, a;
0112   G4double abundance;
0113 
0114   G4Isotope* U5 = new G4Isotope("U235", iz = 92, n = 235, a = 235.01 * g / mole);
0115   G4Isotope* U8 = new G4Isotope("U238", iz = 92, n = 238, a = 238.03 * g / mole);
0116 
0117   G4Element* U = new G4Element("enriched Uranium", "U", ncomponents = 2);
0118   U->AddIsotope(U5, abundance = 90. * perCent);
0119   U->AddIsotope(U8, abundance = 10. * perCent);
0120 
0121   //
0122   // define simple materials
0123   //
0124   G4double density;
0125 
0126   new G4Material("liquidH2", z = 1., a = 1.008 * g / mole, density = 70.8 * mg / cm3);
0127   new G4Material("Aluminium", z = 13., a = 26.98 * g / mole, density = 2.700 * g / cm3);
0128   new G4Material("liquidArgon", z = 18, a = 39.948 * g / mole, density = 1.396 * g / cm3);
0129   new G4Material("Titanium", z = 22., a = 47.867 * g / mole, density = 4.54 * g / cm3);
0130   new G4Material("Iron", z = 26., a = 55.85 * g / mole, density = 7.870 * g / cm3);
0131   new G4Material("Copper", z = 29., a = 63.55 * g / mole, density = 8.960 * g / cm3);
0132   new G4Material("Tungsten", z = 74., a = 183.85 * g / mole, density = 19.30 * g / cm3);
0133   new G4Material("Gold", z = 79., a = 196.97 * g / mole, density = 19.32 * g / cm3);
0134   new G4Material("Lead", z = 82., a = 207.20 * g / mole, density = 11.35 * g / cm3);
0135   new G4Material("Uranium", z = 92., a = 238.03 * g / mole, density = 18.95 * g / cm3);
0136 
0137   //
0138   // define a material from elements.   case 1: chemical molecule
0139   //
0140   G4int natoms;
0141 
0142   G4Material* H2O = new G4Material("Water", density = 1.000 * g / cm3, ncomponents = 2);
0143   H2O->AddElement(H, natoms = 2);
0144   H2O->AddElement(O, natoms = 1);
0145   H2O->GetIonisation()->SetMeanExcitationEnergy(78.0 * eV);
0146   H2O->SetChemicalFormula("H_2O");
0147 
0148   G4Material* CH = new G4Material("Polystyrene", density = 1.032 * g / cm3, ncomponents = 2);
0149   CH->AddElement(C, natoms = 1);
0150   CH->AddElement(H, natoms = 1);
0151 
0152   G4Material* Sci = new G4Material("Scintillator", density = 1.032 * g / cm3, ncomponents = 2);
0153   Sci->AddElement(C, natoms = 9);
0154   Sci->AddElement(H, natoms = 10);
0155 
0156   Sci->GetIonisation()->SetBirksConstant(0.126 * mm / MeV);
0157 
0158   //
0159   // examples of gas in non STP conditions
0160   //
0161   G4double temperature, pressure;
0162 
0163   G4Material* CO2 =
0164     new G4Material("CarbonicGas", density = 27. * mg / cm3, ncomponents = 2, kStateGas,
0165                    temperature = 325. * kelvin, pressure = 50. * atmosphere);
0166   CO2->AddElement(C, natoms = 1);
0167   CO2->AddElement(O, natoms = 2);
0168 
0169   new G4Material("ArgonGas", z = 18, a = 39.948 * g / mole, density = 1.782 * mg / cm3, kStateGas,
0170                  273.15 * kelvin, 1 * atmosphere);
0171   //
0172   // example of vacuum
0173   //
0174   density = universe_mean_density;  // from PhysicalConstants.h
0175   pressure = 3.e-18 * pascal;
0176   temperature = 2.73 * kelvin;
0177   new G4Material("Galactic", z = 1., a = 1.008 * g / mole, density, kStateGas, temperature,
0178                  pressure);
0179 
0180   //  G4cout << *(G4Material::GetMaterialTable()) << G4endl;
0181 }
0182 
0183 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0184 
0185 G4Material* DetectorConstruction::MaterialWithSingleIsotope(G4String name, G4String symbol,
0186                                                             G4double density, G4int Z, G4int A)
0187 {
0188   // define a material from an isotope
0189   //
0190   G4int ncomponents;
0191   G4double abundance, massfraction;
0192 
0193   G4Isotope* isotope = new G4Isotope(symbol, Z, A);
0194 
0195   G4Element* element = new G4Element(name, symbol, ncomponents = 1);
0196   element->AddIsotope(isotope, abundance = 100. * perCent);
0197 
0198   G4Material* material = new G4Material(name, density, ncomponents = 1);
0199   material->AddElement(element, massfraction = 100. * perCent);
0200 
0201   return material;
0202 }
0203 
0204 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0205 
0206 void DetectorConstruction::ComputeCalorParameters()
0207 {
0208   // Compute derived parameters of the calorimeter
0209   fLayerThickness = 0.;
0210   for (G4int iAbs = 1; iAbs <= fNbOfAbsor; iAbs++) {
0211     fLayerThickness += fAbsorThickness[iAbs];
0212   }
0213   fCalorThickness = fNbOfLayers * fLayerThickness;
0214   fWorldSizeX = 1.2 * fCalorThickness;
0215   fWorldSizeYZ = 1.2 * fCalorSizeYZ;
0216 }
0217 
0218 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0219 
0220 G4VPhysicalVolume* DetectorConstruction::Construct()
0221 {
0222   if (fPhysiWorld) {
0223     return fPhysiWorld;
0224   }
0225   // complete the Calor parameters definition
0226   ComputeCalorParameters();
0227 
0228   //
0229   // World
0230   //
0231   fSolidWorld = new G4Box("World",  // its name
0232                           fWorldSizeX / 2, fWorldSizeYZ / 2, fWorldSizeYZ / 2);  // its size
0233 
0234   fLogicWorld = new G4LogicalVolume(fSolidWorld,  // its solid
0235                                     fWorldMaterial,  // its material
0236                                     "World");  // its name
0237 
0238   fPhysiWorld = new G4PVPlacement(0,  // no rotation
0239                                   G4ThreeVector(),  // at (0,0,0)
0240                                   fLogicWorld,  // its fLogical volume
0241                                   "World",  // its name
0242                                   0,  // its mother  volume
0243                                   false,  // no boolean operation
0244                                   0);  // copy number
0245   //
0246   // Calorimeter
0247   //
0248 
0249   fSolidCalor = new G4Box("Calorimeter", fCalorThickness / 2, fCalorSizeYZ / 2, fCalorSizeYZ / 2);
0250 
0251   fLogicCalor = new G4LogicalVolume(fSolidCalor, fWorldMaterial, "Calorimeter");
0252 
0253   fPhysiCalor = new G4PVPlacement(0,  // no rotation
0254                                   G4ThreeVector(),  // at (0,0,0)
0255                                   fLogicCalor,  // its fLogical volume
0256                                   "Calorimeter",  // its name
0257                                   fLogicWorld,  // its mother  volume
0258                                   false,  // no boolean operation
0259                                   0);  // copy number
0260 
0261   //
0262   // Layers
0263   //
0264 
0265   fSolidLayer = new G4Box("Layer", fLayerThickness / 2, fCalorSizeYZ / 2, fCalorSizeYZ / 2);
0266 
0267   fLogicLayer = new G4LogicalVolume(fSolidLayer, fWorldMaterial, "Layer");
0268   if (fNbOfLayers > 1) {
0269     fPhysiLayer =
0270       new G4PVReplica("Layer", fLogicLayer, fLogicCalor, kXAxis, fNbOfLayers, fLayerThickness);
0271   }
0272   else {
0273     fPhysiLayer =
0274       new G4PVPlacement(0, G4ThreeVector(), fLogicLayer, "Layer", fLogicCalor, false, 0);
0275   }
0276   //
0277   // Absorbers
0278   //
0279 
0280   G4double xfront = -0.5 * fLayerThickness;
0281   for (G4int k = 1; k <= fNbOfAbsor; ++k) {
0282     fSolidAbsor[k] = new G4Box("Absorber",  // its name
0283                                fAbsorThickness[k] / 2, fCalorSizeYZ / 2, fCalorSizeYZ / 2);
0284 
0285     fLogicAbsor[k] = new G4LogicalVolume(fSolidAbsor[k],  // its solid
0286                                          fAbsorMaterial[k],  // its material
0287                                          fAbsorMaterial[k]->GetName());
0288 
0289     G4double xcenter = xfront + 0.5 * fAbsorThickness[k];
0290     xfront += fAbsorThickness[k];
0291     fPhysiAbsor[k] = new G4PVPlacement(0, G4ThreeVector(xcenter, 0., 0.), fLogicAbsor[k],
0292                                        fAbsorMaterial[k]->GetName(), fLogicLayer, false,
0293                                        k);  // copy number
0294   }
0295 
0296   PrintCalorParameters();
0297 
0298   // always return the fPhysical World
0299   //
0300   return fPhysiWorld;
0301 }
0302 
0303 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0304 
0305 void DetectorConstruction::PrintCalorParameters()
0306 {
0307   G4int prec = 4, wid = prec + 2;
0308   G4int dfprec = G4cout.precision(prec);
0309 
0310   G4double totLength(0.), totRadl(0.), totNuclear(0.);
0311 
0312   G4cout << "\n-------------------------------------------------------------"
0313          << "\n ---> The calorimeter is " << fNbOfLayers << " layers of:";
0314   for (G4int i = 1; i <= fNbOfAbsor; ++i) {
0315     G4Material* material = fAbsorMaterial[i];
0316     G4double radl = material->GetRadlen();
0317     G4double nuclearl = material->GetNuclearInterLength();
0318     G4double sumThickness = fNbOfLayers * fAbsorThickness[i];
0319     G4double nbRadl = sumThickness / radl;
0320     G4double nbNuclearl = sumThickness / nuclearl;
0321     totLength += sumThickness;
0322     totRadl += nbRadl;
0323     totNuclear += nbNuclearl;
0324     G4cout << "\n   " << std::setw(12) << fAbsorMaterial[i]->GetName() << ": " << std::setw(wid)
0325            << G4BestUnit(fAbsorThickness[i], "Length") << "  --->  sum = " << std::setw(wid)
0326            << G4BestUnit(sumThickness, "Length") << " = " << std::setw(wid) << nbRadl << " Radl "
0327            << " = " << std::setw(wid) << nbNuclearl << " NuclearInteractionLength ";
0328   }
0329   G4cout << "\n\n                       total thickness = " << std::setw(wid)
0330          << G4BestUnit(totLength, "Length") << " = " << std::setw(wid) << totRadl << " Radl "
0331          << " = " << std::setw(wid) << totNuclear << " NuclearInteractionLength " << G4endl;
0332 
0333   G4cout << "                     transverse sizeYZ = " << std::setw(wid)
0334          << G4BestUnit(fCalorSizeYZ, "Length") << G4endl;
0335   G4cout << "-------------------------------------------------------------\n";
0336 
0337   G4cout << "\n" << fWorldMaterial << G4endl;
0338   for (G4int j = 1; j <= fNbOfAbsor; ++j) {
0339     G4cout << "\n" << fAbsorMaterial[j] << G4endl;
0340   }
0341   G4cout << "\n-------------------------------------------------------------\n";
0342 
0343   // restore default format
0344   G4cout.precision(dfprec);
0345 }
0346 
0347 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0348 
0349 void DetectorConstruction::SetWorldMaterial(const G4String& material)
0350 {
0351   // search the material by its name
0352   G4Material* pttoMaterial = G4NistManager::Instance()->FindOrBuildMaterial(material);
0353   if (pttoMaterial) {
0354     fWorldMaterial = pttoMaterial;
0355     if (fLogicWorld) {
0356       fLogicWorld->SetMaterial(fWorldMaterial);
0357       fLogicLayer->SetMaterial(fWorldMaterial);
0358       G4RunManager::GetRunManager()->PhysicsHasBeenModified();
0359     }
0360   }
0361 }
0362 
0363 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0364 
0365 void DetectorConstruction::SetNbOfLayers(G4int ival)
0366 {
0367   // set the number of Layers
0368   //
0369   if (ival < 1) {
0370     G4cout << "\n --->warning from SetfNbOfLayers: " << ival
0371            << " must be at least 1. Command refused" << G4endl;
0372     return;
0373   }
0374   fNbOfLayers = ival;
0375 }
0376 
0377 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0378 
0379 void DetectorConstruction::SetNbOfAbsor(G4int ival)
0380 {
0381   // set the number of Absorbers
0382   //
0383   if (ival < 1 || ival > (kMaxAbsor - 1)) {
0384     G4cout << "\n ---> warning from SetfNbOfAbsor: " << ival << " must be at least 1 and and most "
0385            << kMaxAbsor - 1 << ". Command refused" << G4endl;
0386     return;
0387   }
0388   fNbOfAbsor = ival;
0389 }
0390 
0391 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0392 
0393 void DetectorConstruction::SetAbsorMaterial(G4int ival, const G4String& material)
0394 {
0395   // search the material by its name
0396   //
0397   if (ival > fNbOfAbsor || ival <= 0) {
0398     G4cout << "\n --->warning from SetAbsorMaterial: absor number " << ival
0399            << " out of range. Command refused" << G4endl;
0400     return;
0401   }
0402 
0403   G4Material* pttoMaterial = G4NistManager::Instance()->FindOrBuildMaterial(material);
0404   if (pttoMaterial) {
0405     fAbsorMaterial[ival] = pttoMaterial;
0406     if (fLogicAbsor[ival]) {
0407       fLogicAbsor[ival]->SetMaterial(pttoMaterial);
0408       G4RunManager::GetRunManager()->PhysicsHasBeenModified();
0409     }
0410   }
0411 }
0412 
0413 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0414 
0415 void DetectorConstruction::SetAbsorThickness(G4int ival, G4double val)
0416 {
0417   // change Absorber thickness
0418   //
0419   if (ival > fNbOfAbsor || ival <= 0) {
0420     G4cout << "\n --->warning from SetAbsorThickness: absor number " << ival
0421            << " out of range. Command refused" << G4endl;
0422     return;
0423   }
0424   if (val <= DBL_MIN) {
0425     G4cout << "\n --->warning from SetAbsorThickness: thickness " << val
0426            << " out of range. Command refused" << G4endl;
0427     return;
0428   }
0429   fAbsorThickness[ival] = val;
0430 }
0431 
0432 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0433 
0434 void DetectorConstruction::SetCalorSizeYZ(G4double val)
0435 {
0436   // change the transverse size
0437   //
0438   if (val <= DBL_MIN) {
0439     G4cout << "\n --->warning from SetfCalorSizeYZ: thickness " << val
0440            << " out of range. Command refused" << G4endl;
0441     return;
0442   }
0443   fCalorSizeYZ = val;
0444 }
0445 
0446 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......
0447 
0448 #include "G4AutoDelete.hh"
0449 #include "G4GlobalMagFieldMessenger.hh"
0450 
0451 void DetectorConstruction::ConstructSDandField()
0452 {
0453   if (fFieldMessenger.Get() == nullptr) {
0454     // Create global magnetic field messenger.
0455     // Uniform magnetic field is then created automatically if
0456     // the field value is not zero.
0457     G4ThreeVector fieldValue = G4ThreeVector();
0458     G4GlobalMagFieldMessenger* msg = new G4GlobalMagFieldMessenger(fieldValue);
0459     // msg->SetVerboseLevel(1);
0460     G4AutoDelete::Register(msg);
0461     fFieldMessenger.Put(msg);
0462   }
0463 }
0464 
0465 //....oooOO0OOooo........oooOO0OOooo........oooOO0OOooo........oooOO0OOooo......