Advertisement
phystota

e-n collisions(v10) e-e collisions added

Apr 2nd, 2025
508
0
Never
Not a member of Pastebin yet? Sign Up, it unlocks many cool features!
C++ 26.21 KB | None | 0 0
  1. #include <iostream>
  2. #include <random>
  3. #include <fstream>
  4.  
  5. #include <math.h>
  6. #include <time.h>
  7. #include <iomanip>  // For std::fixed and std::setprecision
  8.  
  9. #include <algorithm>  // For std::shuffle
  10. #include <numeric>    // For std::iota
  11.  
  12. //physical constants
  13.  
  14. #define m_e 9.1E-31 // electron mass in kg
  15. #define M_n 6.6464731E-27 // Helium atom mass
  16. #define k_b 1.38E-23 // Boltzmann constant
  17. #define q 1.602176634E-19 // elementary charge    - eV -> J transfer param
  18. #define Coulomb_log 10 // Coulomb logarithm
  19. #define epsilon_0 8.854188E-12 // Vacuum permittivity
  20. #define Coulomb_const pow(q,4)/(pow(4.0*M_PI*epsilon_0,2)) // e^4/(4*pi*eps0)^2
  21.  
  22. // simulation parameters
  23.  
  24. #define n_e 500000
  25. #define N_He 1000000 // Helium neutrals number
  26. #define T_n 10.0 // Helium neutral temperature in eV
  27. #define T_e 50.0    // electron Maxwell initial distribution
  28. #define Emin 0.0
  29. #define Emax 450.0
  30. #define Volume 1.0E-12 // Volume to calculate netral density and collision frequency
  31. #define time 6.0E-4 // 500 microsec time to equalibrate the system
  32.  
  33. #define bin_width 0.1 // keep energy step ~ this to maintain cross-section clarity (Ramsauer minimum etc)
  34. #define N ( (int)((Emax-Emin)/bin_width) ) // add 1 to include E_max if needed?
  35.  
  36. // handling final energy bin
  37.  
  38. #define bin_width_smooth 1.0 // energy bin for smooth final distribution
  39. #define N_smooth ( (int)((Emax-Emin)/bin_width_smooth) )
  40.  
  41. struct Electron {
  42.  
  43.     //velocity components
  44.     double vx = 0.0;
  45.     double vy = 0.0;
  46.     double vz = 0.0;
  47.     //energy in eV
  48.     double energy = 0.0;
  49.     //Collision flag
  50.     bool collided_en = false;
  51.     bool collided_ee = false;
  52.  
  53.     // initializing Maxwell-Boltzmann distribution with T_e
  54.     void initialize(std::mt19937& gen, std::uniform_real_distribution<double>& dis, std::gamma_distribution<double>& maxwell) {
  55.  
  56.         double R = dis(gen);
  57.  
  58.         // velocity angles in spherical coordinates
  59.         double phi = 2*M_PI*dis(gen);
  60.         double cosTheta = 2.0*dis(gen) - 1.0;
  61.         double sinTheta = sqrt(1.0 - cosTheta*cosTheta);
  62.  
  63.            
  64.         energy = maxwell(gen); // neutrals energies sampled as Maxwell distribution in eV
  65.            
  66.         double speed = sqrt(2*energy*q/m_e);
  67.  
  68.         //velocity components of neutrals in m/s
  69.         vx = speed * sinTheta * cos(phi);
  70.         vy = speed * sinTheta * sin(phi);
  71.         vz = speed * cosTheta;
  72.     }
  73.  
  74.  
  75. };
  76.  
  77.  
  78. struct CrossSection {
  79.     double energy;
  80.     double sigma;
  81. };
  82.  
  83. double interpolate (double energy, const std::vector<CrossSection>& CS) {
  84.  
  85.  
  86.     if (energy < CS.front().energy) {
  87.         std::cout << " required energy value lower than range of cross-section data at energy: " << energy << "\n";
  88.         return 0.0;
  89.     }
  90.     if (energy > CS.back().energy) {
  91.         std::cout << " required energy value higher than range of cross-section data" << "\n";
  92.         return 0.0;        
  93.     }
  94.  
  95.     int step = 0;  
  96.         while (step < CS.size() && energy > CS[step].energy) {
  97.             step++;
  98.         }
  99.  
  100.     double k = (CS[step].sigma - CS[step-1].sigma)/(CS[step].energy - CS[step-1].energy);
  101.     double m = CS[step].sigma - k*CS[step].energy;
  102.    
  103.     return k*energy + m;
  104. }
  105.  
  106.  
  107. struct NeutralParticle {
  108.  
  109.     double energy = 0.0;
  110.     double vx = 0.0;
  111.     double vy = 0.0;
  112.     double vz = 0.0;
  113.  
  114.     void initialize(std::mt19937& gen, std::uniform_real_distribution<double>& dis, std::gamma_distribution<double>& maxwell) {
  115.  
  116.         double R = dis(gen);
  117.  
  118.         // velocity angles in spherical coordinates
  119.         double phi = 2*M_PI*dis(gen);
  120.         double cosTheta = 2.0*dis(gen) - 1.0;
  121.         double sinTheta = sqrt(1.0 - cosTheta*cosTheta);
  122.  
  123.            
  124.         energy = maxwell(gen); // neutrals energies sampled as Maxwell distribution in eV
  125.            
  126.         double speed = sqrt(2*energy*q/M_n);
  127.  
  128.         //velocity components of neutrals in m/s
  129.         vx = speed * sinTheta * cos(phi);
  130.         vy = speed * sinTheta * sin(phi);
  131.         vz = speed * cosTheta;
  132.     }
  133.    
  134. };
  135.  
  136.  
  137.  
  138.  
  139. int main() {
  140.  
  141.     clock_t start = clock();
  142.  
  143.     std::vector<Electron> electrons(n_e); // better to use vector instead of simple array as it's dynamically allocated (beneficial for ionization)
  144.     std::vector<NeutralParticle> neutrals(N_He);
  145.  
  146.  
  147.     std::vector<int> histo_random(N, 0); // initialize N size zero-vector for random (initial) histogram
  148.     std::vector<int> histo_maxwell(N_smooth, 0); // initialize N size zero-vector for maxwellian histogram
  149.     std::vector<int> histo_neutral(N, 0); // initialize N size zero-vector for neutral distribution histogram
  150.  
  151.     std::vector<double> elastic_vec(N, 0); // precompiled elastic cross-section-energy vector
  152.     std::vector<double> inelastic1_vec(N, 0); // precompiled inelastic(triplet excitation) cross-section-energy vector
  153.  
  154.     std::random_device rd;
  155.     std::mt19937 gen(rd());
  156.     std::uniform_real_distribution<double> dis(0.0, 1.0);
  157.     std::gamma_distribution<double> maxwell_neutral(1.5, T_n);
  158.     std::gamma_distribution<double> maxwell_electron(1.5, T_e);
  159.  
  160.     std::uniform_int_distribution<int> pair(0, n_e-1);
  161.     std::uniform_int_distribution<int> neutral_pair(0, N_He-1);    
  162.  
  163.  
  164.     std::ifstream elastic_cs_dat("cross_sections/elastic.dat");
  165.     if (!elastic_cs_dat.is_open()) {
  166.         std::cerr << "Error opening elastic cross-sections file!" << std::endl;
  167.         return 1;
  168.     }    
  169.  
  170.     std::ifstream excitation1_cs_dat("cross_sections/inelastic_triplet.dat");
  171.     if (!excitation1_cs_dat.is_open()) {
  172.         std::cerr << "Error opening inelastic triplet cross-sections file!" << std::endl;
  173.         return 1;
  174.     }  
  175.  
  176.     // --- starts reading cross section datafiles
  177.  
  178.     std::vector<CrossSection> elastic_CS_temp;
  179.  
  180.     double energy, sigma;
  181.  
  182.     while (elastic_cs_dat >> energy >> sigma) {
  183.         elastic_CS_temp.push_back({energy, sigma});
  184.     }    
  185.     elastic_cs_dat.close();
  186.  
  187.     energy = 0.0;
  188.     sigma = 0.0;
  189.  
  190.     std::vector<CrossSection> inelastic1_CS_temp;
  191.  
  192.     while (excitation1_cs_dat >> energy >> sigma) {
  193.         inelastic1_CS_temp.push_back({energy, sigma});
  194.     }    
  195.     excitation1_cs_dat.close();    
  196.  
  197.     // --- finish reading cross-section datafiles  
  198.  
  199.     std::ofstream file0("output_files/velocities.dat");    
  200.     std::ofstream file1("output_files/energies.dat");        
  201.     std::ofstream file2("output_files/energies_final.dat");    
  202.     std::ofstream file3("output_files/histo_random.dat");    
  203.     file3 << std::fixed << std::setprecision(10);
  204.    
  205.     std::ofstream file4("output_files/histo_maxwell.dat");
  206.     file4 << std::fixed << std::setprecision(10);          
  207.    
  208.     std::ofstream file5("output_files/neutral_distribution.dat");    
  209.     std::ofstream file6("output_files/E*f(E).dat");    
  210.     std::ofstream file7("output_files/nu_max.dat");
  211.     std::ofstream file8("output_files/electron_mean_energy.dat");
  212.     std::ofstream file9("output_files/nu_elastic_average_initial.dat");
  213.     std::ofstream file10("output_files/nu_inelastic1_average_initial.dat");
  214.     std::ofstream file11("output_files/nu_elastic_average_final.dat");
  215.     std::ofstream file12("output_files/nu_inelastic1_average_final.dat");                    
  216.  
  217.     // Initialize all electrons
  218.     for (auto& e : electrons) {
  219.         e.initialize(gen, dis, maxwell_electron);
  220.     }
  221.     // initialize all nenutrals
  222.     for (auto&n : neutrals) {
  223.         n.initialize(gen, dis, maxwell_neutral);
  224.     }
  225.     // precalculate elastic cross-section for each energy bin
  226.     for (int i = 0; i < N; i++){
  227.         elastic_vec[i] = interpolate(bin_width*(i+0.5), elastic_CS_temp);
  228.     }
  229.     // precalculate inelastic cross-section (triplet) for each energy bin
  230.     for (int i = 0; i < N; i++){
  231.         inelastic1_vec[i] = interpolate(bin_width*(i+0.5), inelastic1_CS_temp);
  232.     }
  233.  
  234.     for (int i = 0; i < n_e; i++){
  235.         file1 << i << " " << electrons.at(i).energy << "\n";
  236.         file0 << i << " " << electrons[i].vx << " " << electrons[i].vy << " " << electrons[i].vz << "\n";
  237.     }
  238.  
  239.     // -----initial electrons energy distribution starts------------////
  240.     for (int i = 0; i < n_e; i++){
  241.         int bin = (int)( (electrons[i].energy - Emin)/bin_width );
  242.         if (bin >=0 && bin < histo_random.size())
  243.             histo_random[bin]++;
  244.     }
  245.  
  246.     for (int i = 0; i < histo_random.size(); i++){
  247.         double bin_center = Emin + (i + 0.5) * bin_width;
  248.         file3 << bin_center << " " <<  static_cast<double>(histo_random[i])/(electrons.size()*bin_width) << "\n"; // this is electron normalized distribution function
  249.     }
  250.     // -----initial electrons energy distribution ends------------////    
  251.  
  252.     // -----neutrals Maxwell-Boltzmann distribution starts------------////
  253.     for (int i = 0; i < N_He; i++){
  254.         int bin = (int)( (neutrals[i].energy - Emin)/bin_width );
  255.         if (bin >=0 && bin < histo_neutral.size())
  256.             histo_neutral[bin]++;
  257.     }    
  258.  
  259.     for (int i = 0; i < histo_neutral.size(); i++){
  260.         double bin_center = Emin + (i + 0.5) * bin_width;
  261.         file5 << bin_center << " " << static_cast<double>(histo_neutral[i])/(neutrals.size()*bin_width) << "\n"; // this is real f(E) - normalized distribution
  262.         file6 << bin_center << " " << bin_center*static_cast<double>(histo_neutral[i])/(neutrals.size()*bin_width) << "\n"; // this should be E*f(E)
  263.  
  264.     }
  265.     // -----neutrals Maxwell-Boltzmann distribution starts------------////      
  266.  
  267.     // -----calculating nu-max for null-collision method starts ------------////
  268.     double nu_max = 0.0;
  269.     double nu_max_temp = 0.0;
  270.     double sigma_total = 0.0;
  271.    
  272.     for (int i = 0; i < N; i++){
  273.         sigma_total = elastic_vec[i] + inelastic1_vec[i];
  274.         nu_max_temp = (N_He/Volume)*sigma_total * sqrt(2.0*(i*bin_width + bin_width/2.0)*q/m_e);
  275.         file7 << i << " " << nu_max_temp << "\n";
  276.         if (nu_max_temp > nu_max)
  277.             nu_max = nu_max_temp;
  278.     }
  279.     // -----calculating nu-max for null-collision method ends ------------////
  280.  
  281.     //----- calculating number to calculate nu-average (both elastic/inelastic )from our electron distribution starts---------///
  282.     // --- calculating nu(E)*f(E) for later external integration, using initial f(E)
  283.     for (int i = 0; i < N; i++){
  284.         double bin_center = Emin + (i + 0.5) * bin_width;
  285.         file9 << bin_center << " " << (N_He/Volume)*elastic_vec[i] * sqrt(2.0*bin_center*q/m_e)*static_cast<double>(histo_random[i])/(electrons.size()*bin_width) << "\n";
  286.         file10 << bin_center << " " << (N_He/Volume)*inelastic1_vec[i] * sqrt(2.0*bin_center*q/m_e)*static_cast<double>(histo_random[i])/(electrons.size()*bin_width) << "\n";
  287.     }
  288.     //----- calculating nu-average from our electron distribution ends ---------///    
  289.  
  290.     double dt = 0.1/nu_max;   // minimum should be 0.1/nu_max to get acceptable numerical error range see Vahedi Surrendra 1995
  291.     double steps = static_cast<int>(time/dt);
  292.  
  293.     std::cout << dt << "\n";
  294.  
  295.     // ---- e-e Coulomb collisions variables starts ---/////
  296.     double nu_ee = 0.0;
  297.     // // calculating initial mean energy
  298.     // double sum = 0.0;
  299.     // for (const auto& e : electrons) sum += e.energy;
  300.     // double mean_energy = sum / n_e;
  301.     // nu_ee = (Coulomb_const*(n_e/Volume)*Coulomb_log)/(sqrt(m_e)*pow(mean_energy*q,1.5));
  302.  
  303.     //using  null-collision technique, getting the number of particles colliding each step: P_collision = 1 - exp(-nu_max*dt)
  304.     int Ne_collided = (1.0-exp(-1.0*dt*nu_max))*n_e;
  305. //    int Ne_collided = n_e*0.98;  // in case I want to check smth
  306.  
  307.  
  308.     // Generate shuffled list of electron indices
  309.     std::vector<int> electron_indices(n_e);
  310.     std::iota(electron_indices.begin(), electron_indices.end(), 0); // fill with index
  311.     std::shuffle(electron_indices.begin(), electron_indices.end(), gen); // shuffle the indexes    
  312.     int reshuffle_interval = 1;
  313.     int print_interval = 100;
  314.     int el_coll_counter = 0; // track all elastic collisions
  315.     int exc1_coll_counter = 0; // track all excitation collisions
  316.     int null_coll_counter = 0; // track null-collisions
  317.     int ee_coll_counter = 0; //track e-e Coulomb collisions
  318.  
  319.     for (int t = 0; t < steps; t++){
  320.  
  321.         std::cout << "timestep remains: " << steps - t << "\n";
  322.  
  323.         // calculating mean energy
  324.         double total_energy = 0.0;
  325.         for (const auto& e : electrons) total_energy += e.energy;
  326.         double mean_energy = total_energy / n_e;
  327.         file8 << t*dt << " " << mean_energy << "\n";            
  328.  
  329.         // calculating e-e Coulomb collisions frequency and number of collised electrons
  330.  
  331.         double nu_ee = (Coulomb_const*(n_e/Volume)*Coulomb_log)/(sqrt(m_e)*pow(mean_energy*q,1.5));
  332.         int EE_collided_pairs = static_cast<int>(0.5 * nu_ee * n_e * dt); // maximum number of electron pairs collided through e-e collisions
  333.  
  334.         //reshuffle the indices
  335.         if (t % reshuffle_interval == 0) {
  336.             std::shuffle(electron_indices.begin(), electron_indices.end(), gen);
  337.         }
  338.  
  339.         // setting flags to false each timestep
  340.         for (auto& e : electrons) e.collided_en = false;
  341.         for (auto& e : electrons) e.collided_ee = false;        
  342.  
  343.         int collision_counter_en = 0; // electron-neutral collision counter
  344.         int collision_counter_ee = 0; // e-e collisoin counter
  345.  
  346.  
  347.         for (int idx : electron_indices) {
  348.  
  349.             if (collision_counter_en >= Ne_collided) break; // quit if reached all collisions
  350.  
  351.             Electron& e = electrons[idx];
  352.             if (e.collided_en) continue;  // Skip already collided electrons
  353.  
  354.             double electron_energy = e.energy;
  355.             int bin_energy = static_cast<int>(electron_energy / bin_width);
  356.             double nu_elastic = (N_He/Volume) * elastic_vec[bin_energy] * sqrt(2.0*electron_energy*q/m_e);
  357.             double nu_inelastic1 = (N_He/Volume) * inelastic1_vec[bin_energy] * sqrt(2.0*electron_energy*q/m_e);
  358.  
  359.             double r = dis(gen);
  360.  
  361.             if (r < nu_elastic/nu_max) {
  362.  
  363.                 // elastic collision happens
  364.  
  365.                 // ----   Collision energy redistribution module
  366.  
  367.                 // electron particle X Y Z initial velocities and energy
  368.                 double V0_x_1 = e.vx;
  369.                 double V0_y_1 = e.vy;
  370.                 double V0_z_1 = e.vz;
  371.  
  372.                 // neutral particle X Y Z initial velocities
  373.  
  374.                 // int k = neutral_pair(gen);
  375.  
  376.                 // double V0_x_2 = neutrals[k].vx;
  377.                 // double V0_y_2 = neutrals[k].vy;
  378.                 // double V0_z_2 = neutrals[k].vz;
  379.  
  380.                 // randomize particles each collision
  381.                 NeutralParticle tmp_neutral;
  382.                 tmp_neutral.initialize(gen, dis, maxwell_neutral);
  383.                 double V0_x_2 = tmp_neutral.vx;
  384.                 double V0_y_2 = tmp_neutral.vy;
  385.                 double V0_z_2 = tmp_neutral.vz;
  386.  
  387.                 // initial relative velocity X Y Z (must be equal to final relative velocity in center-of-mass frame)
  388.  
  389.                 double V0_rel_x = (V0_x_1 - V0_x_2);
  390.                 double V0_rel_y = (V0_y_1 - V0_y_2);
  391.                 double V0_rel_z = (V0_z_1 - V0_z_2);
  392.  
  393.                 double V0_rel = sqrt(V0_rel_x*V0_rel_x + V0_rel_y*V0_rel_y + V0_rel_z*V0_rel_z);
  394.  
  395.                 // center-of-mass frame initial velocity (magnitude of it must be equal to the counterpart in this frame)
  396.  
  397.                 double V_cm_x = (m_e*V0_x_1 + M_n*V0_x_2)/(m_e + M_n);
  398.                 double V_cm_y = (m_e*V0_y_1 + M_n*V0_y_2)/(m_e + M_n);
  399.                 double V_cm_z = (m_e*V0_z_1 + M_n*V0_z_2)/(m_e + M_n);                    
  400.  
  401.                 // generating random variables to calculate random direction of center-of-mass after the collision
  402.  
  403.                 double R1 = dis(gen);
  404.                 double R2 = dis(gen);
  405.  
  406.                 // calculating spherical angles for center-of-mass random direction
  407.                 double theta = acos(1.0- 2.0*R1);
  408.                 double phi = 2*M_PI*R2;
  409.  
  410.                 //calculating final relative velocity with random direction
  411.  
  412.                 double V_rel_x = V0_rel*sin(theta)*cos(phi);
  413.                 double V_rel_y = V0_rel*sin(theta)*sin(phi);
  414.                 double V_rel_z = V0_rel*cos(theta);
  415.  
  416.                 double V_rel = sqrt(V_rel_x*V_rel_x + V_rel_y*V_rel_y + V_rel_z*V_rel_z);
  417.  
  418.                 //calculating final velocity of electron
  419.  
  420.                 double V_x_1 = V_cm_x + V_rel_x * (M_n/(m_e + M_n));
  421.                 double V_y_1 = V_cm_y + V_rel_y * (M_n/(m_e + M_n));
  422.                 double V_z_1 = V_cm_z + V_rel_z * (M_n/(m_e + M_n));
  423.  
  424.                 double V_1 = sqrt(V_x_1*V_x_1 + V_y_1*V_y_1 + V_z_1*V_z_1);
  425.  
  426.                 //updating electron energy and velocities
  427.                
  428.                 e.energy = m_e*V_1*V_1/(2.0*q);
  429.                 e.vx = V_x_1;
  430.                 e.vy = V_y_1;
  431.                 e.vz = V_z_1;
  432.  
  433.                 collision_counter_en++;
  434.                 el_coll_counter++;
  435.  
  436.                 e.collided_en = true;
  437.             }        
  438.  
  439.             else if (r < (nu_elastic + nu_inelastic1)/nu_max) {
  440.  
  441.                 //inelastic 1(triplet) collision happens
  442.  
  443.                 // ----   Collision energy redistribution module
  444.  
  445.                 // electron particle X Y Z initial velocities and energy
  446.                 double V0_x = e.vx;
  447.                 double V0_y = e.vy;
  448.                 double V0_z = e.vz;
  449.                 double E_0 = e.energy;
  450.  
  451.                 double V0 = sqrt(V0_x*V0_x + V0_y*V0_y + V0_z*V0_z);
  452.                
  453.                 // generating random variables to calculate random direction of center-of-mass after the collision
  454.  
  455.                 double R1 = dis(gen);
  456.                 double R2 = dis(gen);
  457.  
  458.                 //// calculating spherical angles for center-of-mass random direction
  459.                 // double theta = acos(1.0- 2.0*R1);
  460.                 // double phi = 2*M_PI*R2;
  461.                 double cos_khi = (2.0 + E_0 - 2.0*pow((1+E_0), R1))/E_0;
  462.                 double sin_khi = sqrt(1.0 - cos_khi*cos_khi);
  463.  
  464.                 double phi = 2.0*M_PI*R2;
  465.                 double cos_theta = V0_x/V0;
  466.                 double sin_theta = sqrt(1.0 - cos_theta*cos_theta);
  467.                 // //calculating final relative velocity with random direction
  468.  
  469.                 //calculating final velocity of electron
  470.  
  471.                 double i_scat = (V0_x/V0)*cos_khi + (1.0 - (V0_x/V0)*(V0_x/V0))*(sin_khi*cos(phi)/sin_theta);
  472.                 double j_scat = (V0_y/V0)*cos_khi +  (V0_z/V0)*sin_khi*sin(phi)/sin_theta - (V0_x/V0)*(V0_y/V0)*sin_khi*cos(phi)/sin_theta;
  473.                 double k_scat = (V0_z/V0)*cos_khi - (V0_y/V0)*sin_khi*sin(phi)/sin_theta - (V0_x/V0)*(V0_z/V0)*sin_khi*cos(phi)/sin_theta;
  474.  
  475.                 //updating electron energy and velocities
  476.  
  477.                 double delta_E = 19.82; //triplet excitation energy              
  478.                
  479.                 if (e.energy < delta_E) {
  480.                     null_coll_counter++;
  481.                     collision_counter_en++;
  482.                     e.collided_en = true;
  483.                     continue;
  484.                 }
  485.                 else {
  486.                     e.energy = E_0 - delta_E;
  487.  
  488.                     double speed = sqrt(2*e.energy*q/m_e);
  489.  
  490.                     e.vx = speed*i_scat;
  491.                     e.vy = speed*j_scat;
  492.                     e.vz = speed*k_scat;
  493.  
  494.                     collision_counter_en++;  
  495.                     exc1_coll_counter++;
  496.  
  497.                     e.collided_en = true;
  498.                 }
  499.             }    
  500.  
  501.             else {
  502.                 collision_counter_en++;
  503.                 null_coll_counter++;
  504.                 e.collided_en = true;
  505.             }
  506.         }
  507.  
  508.         // ----- -------now begin e-e collisions ------ /////
  509.  
  510.         // Reshuffle electron indices for random pairing for e-e collisions
  511.         std::shuffle(electron_indices.begin(), electron_indices.end(), gen);
  512.  
  513.         int max_pairs = std::min(EE_collided_pairs, n_e/2); // handling the case when # of collided pairs ~ ne/2
  514.        
  515.         for (int i = 0; i < max_pairs; i++){
  516.  
  517.             int id1 = electron_indices[2 * i];
  518.             int id2 = electron_indices[2 * i + 1];
  519.             if (id1 >= n_e || id2 >= n_e) continue; // Handle edge case
  520.  
  521.             Electron& e1 = electrons[id1];
  522.             Electron& e2 = electrons[id2];
  523.  
  524.             if (e1.collided_ee || e2.collided_ee) continue; //handle already collided cases
  525.  
  526.             double E_initial = e1.energy + e2.energy; // total initial energy of pair to check the energy conservation
  527.  
  528.             // ----   Collision energy redistribution module
  529.  
  530.             // first particle X Y Z initial velocities
  531.             double V0_x_1 = e1.vx;
  532.             double V0_y_1 = e1.vy;
  533.             double V0_z_1 = e1.vz;
  534.  
  535.             // second particle X Y Z initial velocities
  536.             double V0_x_2 = e2.vx;
  537.             double V0_y_2 = e2.vy;
  538.             double V0_z_2 = e2.vz;
  539.  
  540.             // initial relative velocity X Y Z (must be equal to final relative velocity in center-of-mass frame)
  541.  
  542.             double V0_rel_x = (V0_x_1 - V0_x_2);
  543.             double V0_rel_y = (V0_y_1 - V0_y_2);
  544.             double V0_rel_z = (V0_z_1 - V0_z_2);
  545.  
  546.             double V0_rel = sqrt(V0_rel_x*V0_rel_x + V0_rel_y*V0_rel_y + V0_rel_z*V0_rel_z);
  547.  
  548.             // center-of-mass frame initial velocity (magnitude of it must be equal to the counterpart in this frame)
  549.  
  550.             double V_cm_x = (V0_x_1 + V0_x_2)/2.0;
  551.             double V_cm_y = (V0_y_1 + V0_y_2)/2.0;
  552.             double V_cm_z = (V0_z_1 + V0_z_2)/2.0;
  553.  
  554.             double V_cm = sqrt(V_cm_x*V_cm_x + V_cm_y*V_cm_y + V_cm_z*V_cm_z);
  555.  
  556.             // generating random variables to calculate random direction of center-of-mass after the collision
  557.  
  558.             double R1 = dis(gen);
  559.             double R2 = dis(gen);
  560.  
  561.             // calculating spherical angles for center-of-mass random direction
  562.             double theta = acos(1.0- 2.0*R1);
  563.             double phi = 2*M_PI*R2;
  564.  
  565.             //calculating final relative velocity with random direction
  566.  
  567.             double V_rel_x = V0_rel*sin(theta)*cos(phi);
  568.             double V_rel_y = V0_rel*sin(theta)*sin(phi);
  569.             double V_rel_z = V0_rel*cos(theta);
  570.  
  571.             double V_rel = sqrt(V_rel_x*V_rel_x + V_rel_y*V_rel_y + V_rel_z*V_rel_z);
  572.  
  573.             //calculating final velocity of first particle
  574.  
  575.             double V_x_1 = V_cm_x + V_rel_x/2.0;
  576.             double V_y_1 = V_cm_y + V_rel_y/2.0;
  577.             double V_z_1 = V_cm_z + V_rel_z/2.0;
  578.  
  579.             double V_1 = sqrt(V_x_1*V_x_1 + V_y_1*V_y_1 + V_z_1*V_z_1);
  580.  
  581.             //calculating final velocity of second particle
  582.  
  583.             double V_x_2 = V_cm_x - V_rel_x/2.0;
  584.             double V_y_2 = V_cm_y - V_rel_y/2.0;
  585.             double V_z_2 = V_cm_z - V_rel_z/2.0;
  586.  
  587.             double V_2 = sqrt(V_x_2*V_x_2 + V_y_2*V_y_2 + V_z_2*V_z_2);
  588.  
  589.             // updating velocities
  590.  
  591.             e1.vx = V_x_1;
  592.             e1.vy = V_y_1;
  593.             e1.vz = V_z_1;
  594.  
  595.             e2.vx = V_x_2; // Update velocity components
  596.             e2.vy = V_y_2;
  597.             e2.vz = V_z_2;
  598.  
  599.             // calculating final energies of first and second colliding particles
  600.  
  601.             e1.energy = V_1*V_1*m_e/(2.0*q);
  602.             e2.energy = V_2*V_2*m_e/(2.0*q);          
  603.  
  604.             double E_final = e1.energy + e2.energy;
  605.  
  606.             if(fabs(E_final - E_initial) > 1e-6) {
  607.                 std::cerr << "Energy conservation violation: " << E_final - E_initial << " eV\n";
  608.             }
  609.  
  610.             // --- collision energy redistrubution module ends  
  611.  
  612.             // collision counters handling
  613.  
  614.             collision_counter_ee++;
  615.             ee_coll_counter++;
  616.             e1.collided_ee = true;
  617.             e2.collided_ee = true;
  618.  
  619.         }
  620.         //////----------------------e-e coulomb collision ends --------------/////////////////
  621.  
  622.     }
  623.  
  624.     // ----- final electron energies distribution begins
  625.     for (int i = 0; i < n_e; i++){
  626.  
  627.         file2 << i << " " << electrons[i].energy << "\n";
  628.  
  629.         int bin = (int)( (electrons[i].energy - Emin)/bin_width_smooth );
  630.         if (bin >=0 && bin < histo_maxwell.size())
  631.             histo_maxwell[bin]++;
  632.     }
  633.  
  634.     int check = 0;
  635.     for (int i = 0; i < histo_maxwell.size(); i++){
  636.         check += histo_maxwell[i];
  637.         double bin_center = Emin + (i + 0.5) * bin_width_smooth;
  638.         file4 << bin_center << " " <<  static_cast<double>(histo_maxwell[i])/(electrons.size()*bin_width_smooth) << "\n"; // getting f(E)
  639.     }
  640.  
  641.         std::cout << "Total # of electrons in a final histogram: " << check << "\n";
  642.  
  643.     // ----- final electron energies distribution ends
  644.  
  645.         //recalculating average frequencies to adjust validation constants later
  646.     for (int i = 0; i < histo_maxwell.size(); i++){
  647.         double bin_center = Emin + (i + 0.5) * bin_width;
  648.         file11 << bin_center << " " << (N_He/Volume)*elastic_vec[i] * sqrt(2.0*bin_center*q/m_e)*static_cast<double>(histo_maxwell[i])/(electrons.size()*bin_width) << "\n";
  649.         file12 << bin_center << " " << (N_He/Volume)*inelastic1_vec[i] * sqrt(2.0*bin_center*q/m_e)*static_cast<double>(histo_maxwell[i])/(electrons.size()*bin_width) << "\n";
  650.     }
  651.     //----- calculating nu-average from our electron distribution ends ---------///            
  652.  
  653.  
  654.     file0.close();
  655.     file1.close();
  656.     file2.close();
  657.     file3.close();
  658.     file4.close();
  659.     file5.close();
  660.     file6.close();
  661.     file7.close();
  662.     file8.close();
  663.     file9.close();
  664.     file10.close();
  665.     file11.close();
  666.     file12.close();
  667.  
  668.     clock_t end = clock();
  669.  
  670.     double elapsed = (double)(end - start) / CLOCKS_PER_SEC;
  671.  
  672.     std::cout << "# of steps: " << steps << "\n";
  673.     std::cout << "# of electrons collided each timesteps:" << Ne_collided << "\n";
  674.  
  675.     std::cout << "Average triplet excitation collisions per timestep: " << static_cast<int>(exc1_coll_counter/steps) << "\n";
  676.     std::cout << "Average elastic collisions per timestep: " << static_cast<int>(el_coll_counter/steps) << "\n";
  677.     std::cout << "Average null collisions per timestep: " << static_cast<int>(null_coll_counter/steps) << "\n";
  678.     std::cout << "Average e-e collisions per timestep: " << static_cast<int>(ee_coll_counter/steps) << "\n";
  679.  
  680.     std::cout << "Elapsed time: %f seconds " << elapsed << "\n";
  681.  
  682.  
  683.     return 0;
  684.  
  685. }
Advertisement
Add Comment
Please, Sign In to add comment
Advertisement