Physics Computer Lab II Approach to Thermal Equilibrium

Size: px
Start display at page:

Download "Physics Computer Lab II Approach to Thermal Equilibrium"

Transcription

1 Physics Computer Lab II Approach to Thermal Equilibrium Developed by É. Flanagan; Version 3 modified by Prof. G. Dugan Fall Introduction Your goal in this project is simulate the approach of a system of particles to thermodynamic equilibrium, for classical particles, fermions, and bosons. For each type of particle, your code will plot the energy distribution of the particles, and you will see the distribution evolve with time from some random initial state to a thermal final state, which will correspond to a Maxwell-Boltzmann distribution, a Fermi-Dirac distribution, or a Bose-Einstein distribution. You will calculate the theoretical distributions at thermal equilibrium, and compare with your simulations. This comparison will allow you to see the fluctuations of a system about the thermal equilibrium state. You will also be able to explore what happens if energy is lost from the system, that is, if its temperature is reduced. As for the first computer project, you will develop several versions of the computer code, each more complicated than the last. This allows code development and testing in stages. A description of what is required of each version is given below. Also there are several exercises to be completed with each version of the code. These should be written up and handed in. You should demonstrate each version of the code to Prof. Flanagan as soon as you have developed it (and before going on to the next version). The first version demonstration is due on Friday Nov 2. The second version demonstration is due on Friday, Nov. 16. The third version demonstration is due due on Friday, Dec Code Version 1: Classical Particles To model the approach to thermal equilibrium, we pick a very simple physical system, consisting of N tot particles, where N tot will be a large integer. The single-particle (non-degenerate) states have energy E equal to any non-negative integer, so the allowed energies are E = 0, 1, 2,.... (1) 1

2 In our code, we will allow any energy up to some maximum energy E max. Exercise 1: For the case of E max, what kind of physical system has these single-particle energy states? To start our simulation, we give each particle the same initial energy E = E i, where E i = 3 (say). This is just some choice of initial state. Our exact choice of initial state is unimportant, you may choose any other initial state you like, as long as the initial average energy per particle is not small compared to 1. To model interactions in our system, we pick any pair of particles at random. We decrease the energy of one of the pair by one unit, and increase the energy of the other (unless the first particle had zero energy, in which case we do nothing). We then repeat this process over and over. This simple energy exchange conserves energy, and has just enough realism in terms of redistributing energy between all the particles to make the system approach thermal equilibrium. To code this simulation in C++, we first need to define some data structures and constants. One possible header file called thermal.h looks like this // header file thermal.h const int Np = 9999; // total number of particles -1 const int Emax = 50; // maximum allowed energy per particle struct state // data type representing a microstate int energy[np+1]; // energy[i] is energy of i th particle ; struct energy_distrib // data type representing energy distribution int n[emax+1]; // n[j] is # of particles with energy j ;... The data type state contains the specification of the system s microstate, the specification of the energy eigenstate of each particle. The data type energy distrib contains the energy distribution of the system, that is, the specification of the number of particles that have energy j for each possible value of j. This is the set of occupation numbers for the system, that is, the configuration. Next, we need to code some functions. We need to be able to compute an energy distribution for a given microstate. To do this, we simply go through all the particles one by one, and for each particle, we add one to the number 2

3 of particles with that energy. computation: Here is a piece of a function to perform this void translate(energy_distrib& ee, state& psi) int i,j; for(;j<=emax;j++) ee.n[j]=0; for(i=0;i<=np;i++) int en = psi.energy[i]; // next check that en >=0 and en <= Emax, otherwise give an error. // Then need to increment the appropriate element of ee.n... The core of the code will be the routine to exchange the energy between a randomly chosen pair of particles. Here is one way of coding this as a routine called shuffle: int shuffle(state& psi) int i1,i2; i1 = (int)((ran2(&random_var)*((float)(np)))); i2 = (int)((ran2(&random_var)*((float)(np)))); if( (i1==i2) (psi.energy[i1]==0)) return(failure); else psi.energy[i1]--; psi.energy[i2]++; return(success); Here we need to define the constants SUCCESS and FAILURE in the header file, just as for the Hartree project. The function shuffle calls a function named ran2, which is random number generator from the Numerical Recipes software package by Press, Teukolsky, Vetterling and Flannery. In order for you to be able to compile your code with calls to ran2, you need to type the Unix command 3

4 cp ~eanna/ran2.o ran2.o You will need to issue this command only once; it copies the object file ran2.o into your directory. Then you will need to issue a compile command like g++ thermal.c GPlot.C ran2.o -o thermal -lm (assuming that you call your program file thermal.c) in order that everything function correctly. You will also need to add the statement float ran2(long *idum); to your header file. In the function shuffle above, the quantity random var is an variable of type long (ie long format integer) which must be input early in the program. It acts as a storage space and also as a seed for the random number generator. See below for the code initializing this variable in the main() routine. If you run the program several times with different input values of random var, you will get different results every time, while if you use the same input value of random var, you will get the same answer every time. Next, we need a routine to print out on the screen the current energy distribution. This is fairly easy, here is such a routine: void show(energy_distrib& ee) cout << endl; cout << "----- Energy distribution " << endl; for(int ;j<=emax;j++) if(ee.n[j]!=0) cout << ee.n[j] << " particles have energy " << j << endl; cout << endl; Finally, we need a routine to make a plot of the log of the number of particles versus energy, say void show plot(energy distrib& ee);, which you can write. The main program should input the value of the seed for the random number generator, initialize the state, then input the number of iterations in the simulation. It should then iterate that many times, print out the energy distribution, and make a plot of the energy distribution. Then, it should once again ask for a number of iterations, and repeat the process over and over. Here is one possible coding. // file thermal.c 4

5 #include <iostream.h> // for input and output #include <math.h> // needed for sqrt() #include <stdlib.h> // for abs() #include "thermal.h" #include "GPlot.h" const int energy_per_particle =3; long random_var; GPlot lnn_vs_e = newgplot(); // plot window int main() state psi; energy_distrib ee; cout << " Enter random seed : "; cin >> random_var; for(int i=0;i<=np;i++) // set up initial state psi.energy[i] = energy_per_particle; // all particles have same energy int nit; for(cout << "Enter number of iterations: "; cin >> nit && nit > 0; cout << "Enter number of " << "additional iterations (or 0): ") int count=0; do if(shuffle(psi)==success) count++; // count only successful shuffles while(count < nit); translate(ee,psi); show(ee); show_plot(ee); 5

6 Finally, let us consider the theoretical Maxwell-Boltzmann distribution that should be achieved in thermal equilibrium. The number of particles n j with energy E j should be given by n j = Ae βe j (2) where β = 1/(k B T ), A is a normalization constant, and E j = j. We can compute the constants β and A in terms of the total number of particles N tot and the total energy of the system E tot using the following equations. (The sums are extended to infinity to simplify the equations; this assumes that the population of the energy levels close to E max is very small). and N tot = E tot = E max n j n j = A e βj = E max = A β E j n j E j n j = A e β A 1 e β (3) je βj e βj = A 1 β 1 e β = A (1 e β ) 2. (4) We can solve Eqs. (3) and (4) for A and β to obtain and A = N 2 tot E tot + N tot (5) [ ] Ntot β = log + 1. (6) E tot Your routine show plot should plot the theoretical distribution (2) as well as the distribution obtained from the simulation. You should also print out the quantities N tot, E tot, A and β. Exercise 2: Run your code in steps of iterations. Watch the initial distribution spread out and then approach a straight line. When you have reached thermal equilibrium, print out a graph, showing both the simulation and the theoretical distribution. How many steps of iterations did it take to reach equilibrium? Why is the right hand side of the graph more jagged than the left? What can you conclude from this about the relative fluctuations of the occupation numbers? 6

7 Exercise 3: Recompile your code with 100 rather than 10,000 particles. Run the code in steps of 100 iterations. Watch the initial distribution spread out and then approach a straight line. Why is the evolution more noisy than before? Why does it not settle down to thermal equilibrium as neatly as before? Does the concept of thermal equilibrium make sense for 100 particles? How about for 10 particles? Exercise 4: Now go back to 10,000 particles, increase E max to 100, and start the simulation with all particles having energy 30 instead of 3. Does is take more or less time to reach equilibrium in this case? Why do you think this is? Why is the graph at equilibrium more jagged than in the first simulation? We can easily modify the code to allow for the possibility of cooling, that is, a loss of energy in the system. In the routine shuffle, if we do not increment psi.energy[i2], then the energy of the system will decrease by one unit every iteration. We wish to be able to turn the cooling on and off; to do this, we can install a switch. In the main program, we add the code cout << Set cooling switch (0=no cooling, 1=cooling) << endl; cin >> cool ; Then, we must pass cool to shuffle, and, if cool =1, do not increment psi.energy[i2]. Exercise 5: Start with 10,000 particles, and an energy per particle of 3. Allow the system to reach thermal equilibrium, with the cooling off. Then, cool for 15,000 iterations, which will reduce the energy by 15,000. Is the system still in thermal equilibrium? Why or why not? How many iterations, with the cooling off, are required to reach thermal equilibrium again? Exercise 6: Start again with 10,000 particles, and an energy per particle of 3. Turn on cooling, and, in steps of 5000 iterations, reduce the energy. Record the values of A and β at each energy. Plot A and β vs. energy. (Note that you are essentially plotting Eqs. (5) and (6)). Is this dependence what you would expect for the physical system identified in Exercise 1? 1.2 Code Version 2: Fermions The essential difference between classical and quantum mechanical particle systems is the nature of the microstates. In the classical state, we had a number of particles, each of which had a well defined energy (the variable psi of type data structure state). The energy distribution giving the number of particles in each energy bin (the variable ee of type data structure energy distrib) was a derived quantity. Specifying the information in ee is not enough to specify the microstate. By contrast, for identical bosons or fermions, the information in the variable ee specifying the number of particles in each energy bin (that is, the configuration) is the complete information determining the microstate. Since the particles 7

8 are identical, there is no meaning to saying which particular particles are in a given energy state. Hence, we will need to delete everything involving the data structure state and the variable psi from the code. For the fermion code, I started by modifying the data type energy distrib to be as follows: struct energy_distrib // data type representing energy distribution double Etot; // total energy of system double Ntot; // total number of particles int n[emax+1]; // n[j] is # of particles with energy j // double n_avg[emax+1]; // averaged distrib // double theory[emax+1]; // theoretical Fermi Dirac distribution // appropriate for Etot and Ntot double B0; // normalization constant double beta; // inverse temperature double Ef; // Fermi energy; This data structure now includes the information about the total energy and total number of particles. The additional entries are discussed below. The first routine to be changed is the routine shuffle. Now, it should act directly on the variable ee rather than psi, since we will not have a variable psi in our fermion code. The interaction process now is as follows. We pick two energy states (not particles) at random, say E i1 = i 1 and E i2 = i 2. If both these states have a non-zero occupation number (ie there are some particles with these energies), then we can reduce the energy of one of the particles with energy i 1 by an amount, and increase the energy of one of the particles with energy i 2 by the same amount. This process will then conserve the total energy. Previously we always took = 1; here we pick it randomly to increase the efficiency of the approach to equilibrium. The way this process changes the occupation numbers is as follows: (i) The number of particles in (or occupation number of) state i 1 is reduced by 1. (ii) The number of particles in state i 1 is increased by 1. This takes care of the particle whose energy is reduced. (iii) The number of particles in state i 2 is reduced by 1, and (iv) the number of particles in state i 2 + is increased by 1. Since the particles are fermions, we must obey the Pauli exclusion principle. Hence, no more than 2 particles can occupy any state (since there are 2 spin states). Thus, we should allow our energy exchange process to occur only if it does not generate any states whose occupation numbers are greater than 2 (or less than 0). The resulting code looks like this (remember that means or in C++): 8

9 int shuffle(energy_distrib& ee) int i1,i2,i1p,i2p,e_exchg; const int Eexchange_max = 100; i1 = (int)((ran2(&random_var)*((float)(emax)))); i2 = (int)((ran2(&random_var)*((float)(emax)))); E_exchg = 1 + (int)((ran2(&random_var)*((float)(eexchange_max)))); i1p = i1 - E_exchg; i2p = i2 + E_exchg; int fermion_disallow = ( (i1p <0 ) (i2p > Emax) (ee.n[i1]<=0) (ee.n[i1p]>=2) (ee.n[i2]<=0) (ee.n[i2p]>=2) (i1 == i2) (i1p == i2p) ); if( fermion_disallow) return(failure); else // perform appropriate operations on the occupation numbers // ee.n[i1], ee.n[i1p], ee.n[i2], ee.n[i2p]... return(success); Next, we need to initialize ee using some initial distribution. The exact choice does not matter. First, we need to set the variable Emax to an appropriate value in the header file. A good value to use here is const int Emax = 2500;. Here is a function initialize that sets up one initial state that gives an interesting visual evolution to equilibrium. void initialize(energy_distrib& ee) for(int ;j<=emax;j++) ee.n[j]=0; for(int i=100;i<1100;i++) if(ran2(&random_var) > 0.7) 9

10 ee.n[i]=1; else ee.n[i]=2; This sets 70% of the states between j = 100 and j = 1100 to have occupation numbers of 2, 30% of those states to have occupation numbers of 1, and the remaining states to have occupation numbers of zero. The next thing that is different in the fermionic case is the relative size of the fluctuations of the occupation numbers. If we plot the actual distribution ee.n obtained after many calls to the routine shuffle, we see a ragged plot where all the values on the y axis are 0, 1, or 2, and the plot jumps back and forwards repeatedly between these values. We do not see the smooth Fermi Dirac distribution we expect, which is n j = 2 Be βj + 1 for some constants B and β. [The factor 2 is the degeneracy factor for 2 spin states]. In version 1 of our code, all the occupation numbers are large, and if a state has occupation number n, then the size of the statistical fluctuations is n, so the fractional fluctuation is 1/ n, which is small for large n. By contrast, for the Fermi-Dirac distribution, the statistical fluctuations are of order n, that is, of order 1. Nevertheless, we can still show that the Fermi-Dirac distribution is a good description of the average occupation numbers by computing an averaged occupation number of the form n j = 1 j 2 j j 2 (7) k=j 1 n j, (8) where j 1 = max(0, j N) and j 2 = min(emax, j + N) for some suitable choice of N. You should write a function to compute the quantity (8) along the lines of void compute_avg_distrib(energy_distrib& ee) // compute averaged energy distribution 10

11 // and store it in ee.n_avg // for(int ;j<=emax;j++) // set ee.n_avg[j] to an average of, for example, 50 // successive values of ee.n[j]... You should modify the routine show plot to plot both the exact and average distributions. An appropriate version of the subroutine main could look something like this int main() energy_distrib ee; initialize(ee); cout << " Fermions - Enter random seed : "; cin >> random_var; int nit; for(cout << "Enter number of iterations: "; cin >> nit && nit > 0; cout << "Enter number of " << "additional iterations (or 0): ") int count=0; do if(shuffle(ee)==success) count++; while(count < nit); show(ee); compute_avg_distrib(ee); show_plot(ee); 11

12 Finally, we want to compare our simulation to the theoretical Fermi-Dirac distribution. This requires that we compute the parameters B and β that enter into the equation (7). For any given value of β, an approximate expression for B can be obtained by approximating the sum over j as an integral. Thus the total number of particles is N tot = E max Emax Hence we can solve for B to obtain 2 Be βj dj 0 Be βj + 1 = 2E max + 2 [ β ln 1 + B 1 + Be βemax ]. (9) B = 1 eβ(n tot/2 E max ). (10) e βn tot/2 1 To obtain the value of β, we need to solve the equation E tot = E max 2j Be βj + 1. (11) This we can do numerically. First, we need to calculate N tot and E tot. Sample code for this is given below: // compute total energy and total number of particles // these will be needed later in the code. ee.etot = 0.0; ee.ntot = 0.0; for(int ;j<=emax;j++) ee.etot += double(j)* double(ee.n[j]); ee.ntot += double( ee.n[j]); Then, we define a function to compute a value of total energy for a given β: double Etotfn(energy_distrib& ee, double beta) // Theoretical total energy as fn of beta, used to find beta. 12

13 ee.beta = beta; ee.b0 = (1.0-exp(beta*(ee.Ntot/2-Emax)))/ ( exp(beta * ee.ntot / 2.0) -1.0); for(int ;j<emax;j++) ee.theory[j] = 2.0 / (1.0 + ee.b0 * exp( ee.beta * (double)(j))); double temp =0.0; for(int ;j<emax;j++) temp += (double)(j) * ee.theory[j]; return(temp); Finally, we need to find the value of β that gives the right total energy. To do this we adopt the shooting code from our Hartree lab that solves for the correct eigenvalue by successive bisection of an interval. To help in initially bracketing the zero of the function, we use the following approximate analytical result for β, which results from a power series expansion of equation (11) in powers of 1 βn tot : β N tot E tot N 2 tot/8 The beginning of a routine to do this is: int findbeta(energy_distrib& ee) double beta1, beta2, beta0; // try to bracket the zero of the function beta0 = ee.ntot/(ee.etot-ee.ntot*ee.ntot/8); beta1 = 0.3 * beta0; beta2 = 10.0 * beta0; double val1 = Etotfn(ee,beta1) - ee.etot; double val2 = Etotfn(ee,beta2) - ee.etot; (12) // check if val1 and val2 have opposite signs. // if not, return FAILURE -- we have failed. // if so, successively chop the interval in two to zero in on the // correct value of beta.... We also need to insert a call to findbeta into the main routine, and in the show plot routine we need to plot the theoretical curve ee.theory as well as the other curves. After plotting the theoretical curve, you should print out the quantities N tot,e tot, B, and β. You should also calculate and print out the 13

14 value of the Fermi energy, given by E F = log(b). (13) β Exercise 7: Run your code in steps of 5000 iterations. Watch the initial distribution approach the theoretical curve. When you have reached thermal equilibrium, print out a graph, showing both the simulation and the theoretical distribution. How many steps of 5000 iterations did it take to reach equilibrium? Exercise 8: Can you suggest another type of averaging, other than averaging over successive energy bins, that would enable us to recover the smooth Fermi Dirac curve from the jagged energy distribution ee.n? Exercise 9: Can you find an initial distribution for which the equilibrium state is to a good approximation a Maxwell-Boltzmann distribution, ie, the classical regime? We can again easily modify the code to allow for the possibility of cooling, that is, a loss of energy in the system. Following the same general procedure as described above for the Maxwell-Boltzmann distribution, modify your code for the Fermi-Dirac distribution to allow for cooling Exercise 10: Start with the initial distribution given at the beginning of this section. Allow the system to reach thermal equilibrium, with the cooling off. Then, cool for a sufficient number of iterations to reduce the energy by 10%. Is the system still in thermal equilibrium? Why or why not? How many iterations, with the cooling off, are required to reach thermal equilibrium again? What happens if you turn the cooling on and try to reduce the energy by half? Exercise 11: Start with the initial distribution given at the beginning of this section. Turn on cooling, and reduce the energy to its minimum in steps. Why is there a minimum energy, and what is it? Record the values of B, E f, and β at each energy. Plot E f and β vs. energy. Do these parameters have the dependence on the total energy you that you would qualitatively expect for a Fermi-Dirac distribution? 1.3 Code Version 3: Bosons Much of the code that you have written for fermions can simply be copied over for bosons. Since, of course, bosons do not obey the exclusion principle, you will have to modify the code in the routine shuffle to allow more than two particles per quantum state. For the initial distribution, you have more freedom than in the fermion case, as any number of particles can occupy a given quantum state. To start, use Emax = 2500, and the same initial distribution as given in version 2 (fermions). Although larger numbers of particles are possible for the initial distribution, the time it takes to reach thermal equilibrium gets progressively longer with more particles. 14

15 For the bosonic case, as for fermions, the relative size of the fluctuations of the occupation numbers is different from the classical case. If we plot the actual distribution ee.n obtained after many calls to the routine shuffle, we see a ragged plot as in the fermionic case, not the smooth Bose-Einstein distribution we expect, which is 1 n j = Be βj (14) 1 for some constants B and β. By contrast with the classical case, for the Bose- Einstein distribution, (as for the Fermi-Dirac distribution), the statistical fluctuations are of order n. Thus, you will still need to compute an averaged energy distribution from the exact distribution; the same code you wrote for fermions will suffice. An appropriate version of the subroutine main could look something like this int main() energy_distrib ee; initialize(ee); cout << " Bosons - Enter random seed : "; cin >> random_var; int nit; for(cout << "Enter number of iterations: "; cin >> nit && nit > 0; cout << "Enter number of " << "additional iterations (or 0): ") int count=0; do if(shuffle(ee)==success) count++; while(count < nit); show(ee); compute_avg_distrib(ee); show_plot(ee); 15

16 Finally, we want to compare our simulation to the theoretical Bose-Einstein distribution. This requires that we compute the parameters B and β that enter into the equation (14). In the Fermi-Dirac case, we used an approximate analytical expression for B, and then found β numerically. For the Bose-Einstein case, the precision of this method will not be adequate. We will want to use this simulation to investigate the phenomenon of Bose-Einstein condensation, in which the distribution function collapses so that almost all the particles are in the lowest quantum state. For this case, we have N tot = E max 1 Be βj 1 1 B 1. (15) We will need to calculate B very precisely, since it is the difference between B and 1 which determines the number of particles in the lowest energy level. We can do this by solving the two equations N tot (B, β) = E max 1 Be βj 1 (16) E tot (B, β) = E max j Be βj 1 (17) numerically, without making any approximations, for B and β. An efficient way to do this is the Newton-Raphson method. This scheme relies on having good starting values for the parameters to be found; let us call the starting values B 0 and β 0. We Taylor expand equations (16) and (17) to first order about B 0 and β 0 : N tot (B, β) = N tot (B 0, β 0 ) + N tot B E tot (B, β) = E tot (B 0, β 0 ) + E tot B These equations can be written in matrix form as ( ) ( ) ( ) δntot M11 M = 12 δb δe tot M 21 M 22 δβ in which δn tot = N tot N tot (B 0, β 0 ) (B B 0) + N tot β (β β 0) (18) (B B 0) + E tot β (β β 0) (19) δe tot = E tot E tot (B 0, β 0 ) 16

17 δb = B B 0 δβ = β β 0 Here N tot and E tot are the numbers we compute from the simulation. The matrix elements are M 11 = N tot B Emax = e β 0j (B 0 e β 0j 1) 2 M 12 = N E tot β = B max 0 je β 0j (B 0 e β 0j 1) 2 M 21 = E tot B Emax = je β 0j (B 0 e β0j 1) 2. M 22 = E E tot β = B max 0 j 2 e β0j (B 0 e β 0j 1) 2 Solving the matrix equations gives the first-order changes in B and β: δb = M 22δN M 12 δe M 11 M 22 M 12 M 21 δβ = M 21δN + M 11 δe M 11 M 22 M 12 M 21 This process can then be iterated, in principle, to any desired level of precision. As mentioned above, the success of this method relies on having good starting values. To obtain these starting values, we can use the technique and code already developed in version 2 of this computer lab. As for the Fermi-Dirac case, for any given value of β, an approximate expression for B can be obtained by approximating the sum over j as an integral. Thus the total number of particles is N tot = E max Emax 0 1 Be βj 1 1 dj Be βj 1 = 1 β ln [ Be βe max 1 B 1 ] E max. (20) 17

18 Hence we can solve for B to obtain B = eβntot e βemax. (21) e βntot 1 For B close to 1, this approximation will often give a value for B which is impossibly small. We know that the minimum value of B will occur when all the particles are in the ground state, i.e., when Eq. (2) is exactly satisfied. Thus, the minimum value of B is known to be B min = N tot. (22) You can thus improve your approximation for B by using equation (21) for B, only if it gives a result greater than B min. Otherwise, use (22) for B. To obtain the value of β, we need to solve the equation E tot = E max j Be βj 1. (23) This we must do numerically. First, we need to calculate N tot and E tot, as we did for the fermion case. Then, we define a function to compute a value of total energy for a given β, and we need to find the value of β that gives the right total energy. This can all be done by simple modifications to the code you developed in version 2. In addition to changing the code to accommodate the Bose-Einstein distribution, the approximate analytical result for β, used for the initial bracketing in findbeta, needs to be changed to: β N tot E tot + N 2 tot/4 (24) The values of B and β returned from findbeta are then input, as starting values, to a new routine refine, which uses the Newton-Raphson method, as described above, to find exact numerical solutions to equations (16) and (17) for B and β. An outline of the code for such a routine is given below: int refine (energy_distrib& ee) double m11,m12,m21,m22,denom1,e0,n0,dn,de,db0,dbeta; int i,j; const int nref=20; // number of refinement steps const double nconv = 0.001; // convergence criterion const double econv=0.001; // convergence criterion 18

19 // calculate theoretical total number of particles (n0) and energy // (e0) n0=0; e0=0; for(i=0; i<=emax; i++) denom1=ee.b0*exp(ee.beta*i)-1; n0 += 1/denom1; e0 += i/denom1; // calculate differences dn and de dn=ee.ntot-n0; de=ee.etot-e0; // begin iteration loop ; while (((dn*dn >= nconv*nconv) (de*de >= econv*econv)) && (j < nref)) m11=0; m12=0; m21=0; m22=0; j++; for(i=0; i<=emax; i++) // calculate m11, m12, m21, m22... // calculate changes db0, dbeta... // update B and beta ee.b0 += db0; ee.beta += dbeta; // calculate new theoretical total number of particles (n0) and energy (e0)... // calculate new values of differences dn and de dn = ee.ntot-n0; de = ee.etot-e0; // success if convergence in less than nref loops if(j < nref) return(success); else return(failure); 19

20 We need to insert a call to findbeta, and then a call to refine, into the main routine. In the show plot routine we need to plot the theoretical curve ee.theory as well as the other curves. Since the distribution will be rapidly varying at low energies, for proper comparison of theory with the averaged distribution, you should calculate and plot an averaged theoretical distribution. You can calculate this from the exact theoretical distribution in the same way that you calculate the averaged simulated distribution from the exact simulated distribution. After plotting the theoretical curves, you should print out the quantities N tot,e tot, B, and β. Exercise 12: Run your code in steps of iterations. Watch the initial (averaged) distribution approach the (averaged) theoretical curve. When you have reached thermal equilibrium, print out a graph, showing both the simulation and the theoretical distribution. How many steps of iterations did it take to reach equilibrium? Exercise 13: Can you find an initial distribution for which the equilibrium state is to a good approximation a Maxwell-Boltzmann distribution, i. e., the classical regime? Is it the same as you found for the Fermi-Dirac case? We can again easily modify the code to allow for the possibility of cooling, that is, a loss of energy in the system. Following the same general procedure as described above for the Maxwell-Boltzmann distribution, modify your code for the Bose-Einstein distribution to allow for cooling. Exercise 14: Start with the initial distribution given at the beginning of this section. Cool for a sufficient number of iterations to reduce the energy by 10%. How many iterations, with the cooling off, are required to reach thermal equilibrium? Reduce the energy by an additional 50%. Is the system still in thermal equilibrium? How many iterations are required to reach equilibrium? Exercise 15: Modify your program to plot the exact, not the averaged, simulated and theoretical distributions, over a small energy range of say Start with the initial distribution given at the beginning of this section. Turn on cooling, and reduce the energy in approximate steps of 10% (You do not need to allow the system to reach equilibrium at each step). Note how the number of particles in the ground state increases dramatically as the energy is reduced. At each energy, record the values of B, β, and the number of particles in the ground state N 0 (which you can read off the graph). Keep reducing the energy in small steps until most of the particles are in the ground state, according to the theoretical distribution. This is the phenomenon called Bose-Einstein condensation. Plot B 1, β, and N 0 vs. energy. If you are very patient, you can turn off cooling at the lowest energy you reach, and run the simulation until it all condenses into the ground state (this will take quite a while). 20

Lecture 8. The Second Law of Thermodynamics; Energy Exchange

Lecture 8. The Second Law of Thermodynamics; Energy Exchange Lecture 8 The Second Law of Thermodynamics; Energy Exchange The second law of thermodynamics Statistics of energy exchange General definition of temperature Why heat flows from hot to cold Reading for

More information

ε1 ε2 ε3 ε4 ε

ε1 ε2 ε3 ε4 ε Que : 1 a.) The total number of macro states are listed below, ε1 ε2 ε3 ε4 ε5 But all the macro states will not be possible because of given degeneracy levels. Therefore only possible macro states will

More information

Lecture 8. The Second Law of Thermodynamics; Energy Exchange

Lecture 8. The Second Law of Thermodynamics; Energy Exchange Lecture 8 The Second Law of Thermodynamics; Energy Exchange The second law of thermodynamics Statistics of energy exchange General definition of temperature Why heat flows from hot to cold Reading for

More information

6.730 Physics for Solid State Applications

6.730 Physics for Solid State Applications 6.730 Physics for Solid State Applications Lecture 25: Chemical Potential and Equilibrium Outline Microstates and Counting System and Reservoir Microstates Constants in Equilibrium Temperature & Chemical

More information

Derivation of the Boltzmann Distribution

Derivation of the Boltzmann Distribution CLASSICAL CONCEPT REVIEW 7 Derivation of the Boltzmann Distribution Consider an isolated system, whose total energy is therefore constant, consisting of an ensemble of identical particles 1 that can exchange

More information

L11.P1 Lecture 11. Quantum statistical mechanics: summary

L11.P1 Lecture 11. Quantum statistical mechanics: summary Lecture 11 Page 1 L11.P1 Lecture 11 Quantum statistical mechanics: summary At absolute zero temperature, a physical system occupies the lowest possible energy configuration. When the temperature increases,

More information

AST1100 Lecture Notes

AST1100 Lecture Notes AST11 Lecture Notes Part 1G Quantum gases Questions to ponder before the lecture 1. If hydrostatic equilibrium in a star is lost and gravitational forces are stronger than pressure, what will happen with

More information

Quantum Statistics (2)

Quantum Statistics (2) Quantum Statistics Our final application of quantum mechanics deals with statistical physics in the quantum domain. We ll start by considering the combined wavefunction of two identical particles, 1 and

More information

Statistical Mechanics Victor Naden Robinson vlnr500 3 rd Year MPhys 17/2/12 Lectured by Rex Godby

Statistical Mechanics Victor Naden Robinson vlnr500 3 rd Year MPhys 17/2/12 Lectured by Rex Godby Statistical Mechanics Victor Naden Robinson vlnr500 3 rd Year MPhys 17/2/12 Lectured by Rex Godby Lecture 1: Probabilities Lecture 2: Microstates for system of N harmonic oscillators Lecture 3: More Thermodynamics,

More information

We already came across a form of indistinguishably in the canonical partition function: V N Q =

We already came across a form of indistinguishably in the canonical partition function: V N Q = Bosons en fermions Indistinguishability We already came across a form of indistinguishably in the canonical partition function: for distinguishable particles Q = Λ 3N βe p r, r 2,..., r N ))dτ dτ 2...

More information

Chapter 14. Ideal Bose gas Equation of state

Chapter 14. Ideal Bose gas Equation of state Chapter 14 Ideal Bose gas In this chapter, we shall study the thermodynamic properties of a gas of non-interacting bosons. We will show that the symmetrization of the wavefunction due to the indistinguishability

More information

Elements of Statistical Mechanics

Elements of Statistical Mechanics Elements of Statistical Mechanics Thermodynamics describes the properties of macroscopic bodies. Statistical mechanics allows us to obtain the laws of thermodynamics from the laws of mechanics, classical

More information

Fractional exclusion statistics: A generalised Pauli principle

Fractional exclusion statistics: A generalised Pauli principle Fractional exclusion statistics: A generalised Pauli principle M.V.N. Murthy Institute of Mathematical Sciences, Chennai (murthy@imsc.res.in) work done with R. Shankar Indian Academy of Sciences, 27 Nov.

More information

International Physics Course Entrance Examination Questions

International Physics Course Entrance Examination Questions International Physics Course Entrance Examination Questions (May 2010) Please answer the four questions from Problem 1 to Problem 4. You can use as many answer sheets you need. Your name, question numbers

More information

Introduction. Chapter The Purpose of Statistical Mechanics

Introduction. Chapter The Purpose of Statistical Mechanics Chapter 1 Introduction 1.1 The Purpose of Statistical Mechanics Statistical Mechanics is the mechanics developed to treat a collection of a large number of atoms or particles. Such a collection is, for

More information

Summary Part Thermodynamic laws Thermodynamic processes. Fys2160,

Summary Part Thermodynamic laws Thermodynamic processes. Fys2160, ! Summary Part 2 21.11.2018 Thermodynamic laws Thermodynamic processes Fys2160, 2018 1 1 U is fixed ) *,,, -(/,,), *,, -(/,,) N, 3 *,, - /,,, 2(3) Summary Part 1 Equilibrium statistical systems CONTINUE...

More information

Statistical. mechanics

Statistical. mechanics CHAPTER 15 Statistical Thermodynamics 1: The Concepts I. Introduction. A. Statistical mechanics is the bridge between microscopic and macroscopic world descriptions of nature. Statistical mechanics macroscopic

More information

CHAPTER 9 Statistical Physics

CHAPTER 9 Statistical Physics CHAPTER 9 Statistical Physics 9.1 9.2 9.3 9.4 9.5 9.6 9.7 Historical Overview Maxwell Velocity Distribution Equipartition Theorem Maxwell Speed Distribution Classical and Quantum Statistics Fermi-Dirac

More information

Numerical solution of the time-independent 1-D Schrödinger equation. Matthias E. Möbius. September 24, 2010

Numerical solution of the time-independent 1-D Schrödinger equation. Matthias E. Möbius. September 24, 2010 Numerical solution of the time-independent 1-D Schrödinger equation Matthias E. Möbius September 24, 2010 1 Aim of the computational lab Numerical solution of the one-dimensional stationary Schrödinger

More information

Physics 2203, Fall 2011 Modern Physics

Physics 2203, Fall 2011 Modern Physics Physics 2203, Fall 2011 Modern Physics. Friday, Nov. 2 nd, 2012. Energy levels in Nitrogen molecule Sta@s@cal Physics: Quantum sta@s@cs: Ch. 15 in our book. Notes from Ch. 10 in Serway Announcements Second

More information

The non-interacting Bose gas

The non-interacting Bose gas Chapter The non-interacting Bose gas Learning goals What is a Bose-Einstein condensate and why does it form? What determines the critical temperature and the condensate fraction? What changes for trapped

More information

3.024 Electrical, Optical, and Magnetic Properties of Materials Spring 2012 Recitation 8 Notes

3.024 Electrical, Optical, and Magnetic Properties of Materials Spring 2012 Recitation 8 Notes Overview 1. Electronic Band Diagram Review 2. Spin Review 3. Density of States 4. Fermi-Dirac Distribution 1. Electronic Band Diagram Review Considering 1D crystals with periodic potentials of the form:

More information

Next topic: Quantum Field Theories for Quantum Many-Particle Systems; or "Second Quantization"

Next topic: Quantum Field Theories for Quantum Many-Particle Systems; or Second Quantization Next topic: Quantum Field Theories for Quantum Many-Particle Systems; or "Second Quantization" Outline 1 Bosons and Fermions 2 N-particle wave functions ("first quantization" 3 The method of quantized

More information

1 Quantum field theory and Green s function

1 Quantum field theory and Green s function 1 Quantum field theory and Green s function Condensed matter physics studies systems with large numbers of identical particles (e.g. electrons, phonons, photons) at finite temperature. Quantum field theory

More information

Mon Jan Improved acceleration models: linear and quadratic drag forces. Announcements: Warm-up Exercise:

Mon Jan Improved acceleration models: linear and quadratic drag forces. Announcements: Warm-up Exercise: Math 2250-004 Week 4 notes We will not necessarily finish the material from a given day's notes on that day. We may also add or subtract some material as the week progresses, but these notes represent

More information

10 Supercondcutor Experimental phenomena zero resistivity Meissner effect. Phys463.nb 101

10 Supercondcutor Experimental phenomena zero resistivity Meissner effect. Phys463.nb 101 Phys463.nb 101 10 Supercondcutor 10.1. Experimental phenomena 10.1.1. zero resistivity The resistivity of some metals drops down to zero when the temperature is reduced below some critical value T C. Such

More information

Physics 202 Laboratory 5. Linear Algebra 1. Laboratory 5. Physics 202 Laboratory

Physics 202 Laboratory 5. Linear Algebra 1. Laboratory 5. Physics 202 Laboratory Physics 202 Laboratory 5 Linear Algebra Laboratory 5 Physics 202 Laboratory We close our whirlwind tour of numerical methods by advertising some elements of (numerical) linear algebra. There are three

More information

Mechanics, Heat, Oscillations and Waves Prof. V. Balakrishnan Department of Physics Indian Institute of Technology, Madras

Mechanics, Heat, Oscillations and Waves Prof. V. Balakrishnan Department of Physics Indian Institute of Technology, Madras Mechanics, Heat, Oscillations and Waves Prof. V. Balakrishnan Department of Physics Indian Institute of Technology, Madras Lecture - 21 Central Potential and Central Force Ready now to take up the idea

More information

Atoms, Molecules and Solids. From Last Time Superposition of quantum states Philosophy of quantum mechanics Interpretation of the wave function:

Atoms, Molecules and Solids. From Last Time Superposition of quantum states Philosophy of quantum mechanics Interpretation of the wave function: Essay outline and Ref to main article due next Wed. HW 9: M Chap 5: Exercise 4 M Chap 7: Question A M Chap 8: Question A From Last Time Superposition of quantum states Philosophy of quantum mechanics Interpretation

More information

The perfect quantal gas

The perfect quantal gas The perfect quantal gas Asaf Pe er 1 March 27, 2013 1. Background So far in this course we have been discussing ideal classical gases. We saw that the conditions for gases to be treated classically are

More information

Universal theory of complex SYK models and extremal charged black holes

Universal theory of complex SYK models and extremal charged black holes HARVARD Universal theory of complex SYK models and extremal charged black holes Subir Sachdev Jerusalem Winter School, December 31, 2018 HARVARD Wenbo Fu Yingfei Gu Grigory Tarnopolsky 1. Quantum matter

More information

Part II: Statistical Physics

Part II: Statistical Physics Chapter 6: Boltzmann Statistics SDSMT, Physics Fall Semester: Oct. - Dec., 2013 1 Introduction: Very brief 2 Boltzmann Factor Isolated System and System of Interest Boltzmann Factor The Partition Function

More information

Imperial College London BSc/MSci EXAMINATION May 2008 THERMODYNAMICS & STATISTICAL PHYSICS

Imperial College London BSc/MSci EXAMINATION May 2008 THERMODYNAMICS & STATISTICAL PHYSICS Imperial College London BSc/MSci EXAMINATION May 2008 This paper is also taken for the relevant Examination for the Associateship THERMODYNAMICS & STATISTICAL PHYSICS For Second-Year Physics Students Wednesday,

More information

Quantum Grand Canonical Ensemble

Quantum Grand Canonical Ensemble Chapter 16 Quantum Grand Canonical Ensemble How do we proceed quantum mechanically? For fermions the wavefunction is antisymmetric. An N particle basis function can be constructed in terms of single-particle

More information

A Few Concepts from Numerical Analysis

A Few Concepts from Numerical Analysis 2 A Few Concepts from Numerical Analysis A systematic treatment of numerical methods is provided in conventional courses and textbooks on numerical analysis. But a few very common issues, that emerge in

More information

5. Systems in contact with a thermal bath

5. Systems in contact with a thermal bath 5. Systems in contact with a thermal bath So far, isolated systems (micro-canonical methods) 5.1 Constant number of particles:kittel&kroemer Chap. 3 Boltzmann factor Partition function (canonical methods)

More information

Chapter 4: Going from microcanonical to canonical ensemble, from energy to temperature.

Chapter 4: Going from microcanonical to canonical ensemble, from energy to temperature. Chapter 4: Going from microcanonical to canonical ensemble, from energy to temperature. All calculations in statistical mechanics can be done in the microcanonical ensemble, where all copies of the system

More information

Introduction to cold atoms and Bose-Einstein condensation (II)

Introduction to cold atoms and Bose-Einstein condensation (II) Introduction to cold atoms and Bose-Einstein condensation (II) Wolfgang Ketterle Massachusetts Institute of Technology MIT-Harvard Center for Ultracold Atoms 7/7/04 Boulder Summer School * 1925 History

More information

Brief review of Quantum Mechanics (QM)

Brief review of Quantum Mechanics (QM) Brief review of Quantum Mechanics (QM) Note: This is a collection of several formulae and facts that we will use throughout the course. It is by no means a complete discussion of QM, nor will I attempt

More information

Boltzmann Distribution Law (adapted from Nash)

Boltzmann Distribution Law (adapted from Nash) Introduction Statistical mechanics provides a bridge between the macroscopic realm of classical thermodynamics and the microscopic realm of atoms and molecules. We are able to use computational methods

More information

Quantum field theory and Green s function

Quantum field theory and Green s function 1 Quantum field theory and Green s function Condensed matter physics studies systems with large numbers of identical particles (e.g. electrons, phonons, photons) at finite temperature. Quantum field theory

More information

Insigh,ul Example. E i = n i E, n i =0, 1, 2,..., 8. N(n 0,n 1,n 2,..., n 8 )= n 1!n 2!...n 8!

Insigh,ul Example. E i = n i E, n i =0, 1, 2,..., 8. N(n 0,n 1,n 2,..., n 8 )= n 1!n 2!...n 8! STATISTICS Often the number of particles in a system is prohibitively large to solve detailed state (from Schrodinger equation) or predict exact motion (using Newton s laws). Bulk properties (pressure,

More information

Sommerfeld-Drude model. Ground state of ideal electron gas

Sommerfeld-Drude model. Ground state of ideal electron gas Sommerfeld-Drude model Recap of Drude model: 1. Treated electrons as free particles moving in a constant potential background. 2. Treated electrons as identical and distinguishable. 3. Applied classical

More information

A.1 Homogeneity of the fundamental relation

A.1 Homogeneity of the fundamental relation Appendix A The Gibbs-Duhem Relation A.1 Homogeneity of the fundamental relation The Gibbs Duhem relation follows from the fact that entropy is an extensive quantity and that it is a function of the other

More information

Basic Concepts and Tools in Statistical Physics

Basic Concepts and Tools in Statistical Physics Chapter 1 Basic Concepts and Tools in Statistical Physics 1.1 Introduction Statistical mechanics provides general methods to study properties of systems composed of a large number of particles. It establishes

More information

21 Lecture 21: Ideal quantum gases II

21 Lecture 21: Ideal quantum gases II 2. LECTURE 2: IDEAL QUANTUM GASES II 25 2 Lecture 2: Ideal quantum gases II Summary Elementary low temperature behaviors of non-interacting particle systems are discussed. We will guess low temperature

More information

Unit III Free Electron Theory Engineering Physics

Unit III Free Electron Theory Engineering Physics . Introduction The electron theory of metals aims to explain the structure and properties of solids through their electronic structure. The electron theory is applicable to all solids i.e., both metals

More information

Also: Question: what is the nature of radiation emitted by an object in equilibrium

Also: Question: what is the nature of radiation emitted by an object in equilibrium They already knew: Total power/surface area Also: But what is B ν (T)? Question: what is the nature of radiation emitted by an object in equilibrium Body in thermodynamic equilibrium: i.e. in chemical,

More information

Thermodynamics and Statistical Physics. Preliminary Ph.D. Qualifying Exam. Summer 2009

Thermodynamics and Statistical Physics. Preliminary Ph.D. Qualifying Exam. Summer 2009 Thermodynamics and Statistical Physics Preliminary Ph.D. Qualifying Exam Summer 2009 (Choose 4 of the following 6 problems) -----------------------------------------------------------------------------------------------------------

More information

(i) T, p, N Gibbs free energy G (ii) T, p, µ no thermodynamic potential, since T, p, µ are not independent of each other (iii) S, p, N Enthalpy H

(i) T, p, N Gibbs free energy G (ii) T, p, µ no thermodynamic potential, since T, p, µ are not independent of each other (iii) S, p, N Enthalpy H Solutions exam 2 roblem 1 a Which of those quantities defines a thermodynamic potential Why? 2 points i T, p, N Gibbs free energy G ii T, p, µ no thermodynamic potential, since T, p, µ are not independent

More information

Lecture 2. The Semi Empirical Mass Formula SEMF. 2.0 Overview

Lecture 2. The Semi Empirical Mass Formula SEMF. 2.0 Overview Lecture The Semi Empirical Mass Formula SEMF Nov 6, Lecture Nuclear Physics Lectures, Dr. Armin Reichold 1. Overview.1 The liquid drop model. The Coulomb Term.3 Mirror nuclei, charge asymmetry and independence.4

More information

Condensed matter theory Lecture notes and problem sets 2012/2013

Condensed matter theory Lecture notes and problem sets 2012/2013 Condensed matter theory Lecture notes and problem sets 2012/2013 Dmitri Ivanov Recommended books and lecture notes: [AM] N. W. Ashcroft and N. D. Mermin, Solid State Physics. [Mar] M. P. Marder, Condensed

More information

Part II: Statistical Physics

Part II: Statistical Physics Chapter 7: Quantum Statistics SDSMT, Physics 2013 Fall 1 Introduction 2 The Gibbs Factor Gibbs Factor Several examples 3 Quantum Statistics From high T to low T From Particle States to Occupation Numbers

More information

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

Monte Carlo. Lecture 15 4/9/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky Monte Carlo Lecture 15 4/9/18 1 Sampling with dynamics In Molecular Dynamics we simulate evolution of a system over time according to Newton s equations, conserving energy Averages (thermodynamic properties)

More information

Appendix 1: Normal Modes, Phase Space and Statistical Physics

Appendix 1: Normal Modes, Phase Space and Statistical Physics Appendix : Normal Modes, Phase Space and Statistical Physics The last line of the introduction to the first edition states that it is the wide validity of relatively few principles which this book seeks

More information

Fermi gas model. Introduction to Nuclear Science. Simon Fraser University Spring NUCS 342 February 2, 2011

Fermi gas model. Introduction to Nuclear Science. Simon Fraser University Spring NUCS 342 February 2, 2011 Fermi gas model Introduction to Nuclear Science Simon Fraser University Spring 2011 NUCS 342 February 2, 2011 NUCS 342 (Lecture 9) February 2, 2011 1 / 34 Outline 1 Bosons and fermions NUCS 342 (Lecture

More information

Part II: Statistical Physics

Part II: Statistical Physics Chapter 6: Boltzmann Statistics SDSMT, Physics Fall Semester: Oct. - Dec., 2014 1 Introduction: Very brief 2 Boltzmann Factor Isolated System and System of Interest Boltzmann Factor The Partition Function

More information

Phonon II Thermal Properties

Phonon II Thermal Properties Phonon II Thermal Properties Physics, UCF OUTLINES Phonon heat capacity Planck distribution Normal mode enumeration Density of states in one dimension Density of states in three dimension Debye Model for

More information

d 3 r d 3 vf( r, v) = N (2) = CV C = n where n N/V is the total number of molecules per unit volume. Hence e βmv2 /2 d 3 rd 3 v (5)

d 3 r d 3 vf( r, v) = N (2) = CV C = n where n N/V is the total number of molecules per unit volume. Hence e βmv2 /2 d 3 rd 3 v (5) LECTURE 12 Maxwell Velocity Distribution Suppose we have a dilute gas of molecules, each with mass m. If the gas is dilute enough, we can ignore the interactions between the molecules and the energy will

More information

HW posted on web page HW10: Chap 14 Concept 8,20,24,26 Prob. 4,8. From Last Time

HW posted on web page HW10: Chap 14 Concept 8,20,24,26 Prob. 4,8. From Last Time HW posted on web page HW10: Chap 14 Concept 8,20,24,26 Prob. 4,8 From Last Time Philosophical effects in quantum mechanics Interpretation of the wave function: Calculation using the basic premises of quantum

More information

Chapter 2: Equation of State

Chapter 2: Equation of State Introduction Chapter 2: Equation of State The Local Thermodynamic Equilibrium The Distribution Function Black Body Radiation Fermi-Dirac EoS The Complete Degenerate Gas Application to White Dwarfs Temperature

More information

Phase Transitions and Critical Behavior:

Phase Transitions and Critical Behavior: II Phase Transitions and Critical Behavior: A. Phenomenology (ibid., Chapter 10) B. mean field theory (ibid., Chapter 11) C. Failure of MFT D. Phenomenology Again (ibid., Chapter 12) // Windsor Lectures

More information

Modeling the Motion of a Projectile in Air

Modeling the Motion of a Projectile in Air In this lab, you will do the following: Modeling the Motion of a Projectile in Air analyze the motion of an object fired from a cannon using two different fundamental physics principles: the momentum principle

More information

Grand Canonical Formalism

Grand Canonical Formalism Grand Canonical Formalism Grand Canonical Ensebmle For the gases of ideal Bosons and Fermions each single-particle mode behaves almost like an independent subsystem, with the only reservation that the

More information

v(r i r j ) = h(r i )+ 1 N

v(r i r j ) = h(r i )+ 1 N Chapter 1 Hartree-Fock Theory 1.1 Formalism For N electrons in an external potential V ext (r), the many-electron Hamiltonian can be written as follows: N H = [ p i i=1 m +V ext(r i )]+ 1 N N v(r i r j

More information

The general solution of Schrödinger equation in three dimensions (if V does not depend on time) are solutions of time-independent Schrödinger equation

The general solution of Schrödinger equation in three dimensions (if V does not depend on time) are solutions of time-independent Schrödinger equation Lecture 17 Page 1 Lecture 17 L17.P1 Review Schrödinger equation The general solution of Schrödinger equation in three dimensions (if V does not depend on time) is where functions are solutions of time-independent

More information

Advanced Thermodynamics. Jussi Eloranta (Updated: January 22, 2018)

Advanced Thermodynamics. Jussi Eloranta (Updated: January 22, 2018) Advanced Thermodynamics Jussi Eloranta (jmeloranta@gmail.com) (Updated: January 22, 2018) Chapter 1: The machinery of statistical thermodynamics A statistical model that can be derived exactly from the

More information

Introduction to Special Relativity

Introduction to Special Relativity 1 Introduction to Special Relativity PHYS 1301 F99 Prof. T.E. Coan version: 20 Oct 98 Introduction This lab introduces you to special relativity and, hopefully, gives you some intuitive understanding of

More information

CHAPTER 9 Statistical Physics

CHAPTER 9 Statistical Physics CHAPTER 9 Statistical Physics 9.1 Historical Overview 9.2 Maxwell Velocity Distribution 9.3 Equipartition Theorem 9.4 Maxwell Speed Distribution 9.5 Classical and Quantum Statistics 9.6 Fermi-Dirac Statistics

More information

1. Thomas-Fermi method

1. Thomas-Fermi method 1. Thomas-Fermi method We consider a system of N electrons in a stationary state, that would obey the stationary Schrödinger equation: h i m + 1 v(r i,r j ) Ψ(r 1,...,r N ) = E i Ψ(r 1,...,r N ). (1.1)

More information

Quantum Field Theories for Quantum Many-Particle Systems; or "Second Quantization"

Quantum Field Theories for Quantum Many-Particle Systems; or Second Quantization Quantum Field Theories for Quantum Many-Particle Systems; or "Second Quantization" Outline 1) Bosons and Fermions 2) N-particle wave functions ("first quantization") 3) The method of quantized fields ("second

More information

Physics 472 Final Computational Project

Physics 472 Final Computational Project Physics 472 Final Computational Project Goal: The goal of this project is to numerically integrate the Time Independent Schrodinger Equation (TISE) (Griffiths, 2005) and reproduce the energy band structure

More information

Lecture 9 Examples and Problems

Lecture 9 Examples and Problems Lecture 9 Examples and Problems Counting microstates of combined systems Volume exchange between systems Definition of Entropy and its role in equilibrium The second law of thermodynamics Statistics of

More information

Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras

Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras Condensed Matter Physics Prof. G. Rangarajan Department of Physics Indian Institute of Technology, Madras Lecture - 10 The Free Electron Theory of Metals - Electrical Conductivity (Refer Slide Time: 00:20)

More information

5. Systems in contact with a thermal bath

5. Systems in contact with a thermal bath 5. Systems in contact with a thermal bath So far, isolated systems (micro-canonical methods) 5.1 Constant number of particles:kittel&kroemer Chap. 3 Boltzmann factor Partition function (canonical methods)

More information

Exploring the energy landscape

Exploring the energy landscape Exploring the energy landscape ChE210D Today's lecture: what are general features of the potential energy surface and how can we locate and characterize minima on it Derivatives of the potential energy

More information

N independent electrons in a volume V (assuming periodic boundary conditions) I] The system 3 V = ( ) k ( ) i k k k 1/2

N independent electrons in a volume V (assuming periodic boundary conditions) I] The system 3 V = ( ) k ( ) i k k k 1/2 Lecture #6. Understanding the properties of metals: the free electron model and the role of Pauli s exclusion principle.. Counting the states in the E model.. ermi energy, and momentum. 4. DOS 5. ermi-dirac

More information

Astronomy Using scientific calculators

Astronomy Using scientific calculators Astronomy 113 - Using scientific calculators 0. Introduction For some of the exercises in this lab you will need to use a scientific calculator. You can bring your own, use the few calculators available

More information

Quantum Mechanics- I Prof. Dr. S. Lakshmi Bala Department of Physics Indian Institute of Technology, Madras

Quantum Mechanics- I Prof. Dr. S. Lakshmi Bala Department of Physics Indian Institute of Technology, Madras Quantum Mechanics- I Prof. Dr. S. Lakshmi Bala Department of Physics Indian Institute of Technology, Madras Lecture - 6 Postulates of Quantum Mechanics II (Refer Slide Time: 00:07) In my last lecture,

More information

Physics Nov Bose-Einstein Gases

Physics Nov Bose-Einstein Gases Physics 3 3-Nov-24 8- Bose-Einstein Gases An amazing thing happens if we consider a gas of non-interacting bosons. For sufficiently low temperatures, essentially all the particles are in the same state

More information

PHYS 3313 Section 001 Lecture # 24

PHYS 3313 Section 001 Lecture # 24 PHYS 3313 Section 001 Lecture # 24 Wednesday, April 29, Dr. Alden Stradling Equipartition Theorem Quantum Distributions Fermi-Dirac and Bose-Einstein Statistics Liquid Helium Laser PHYS 3313-001, Spring

More information

Quantum ideal gases: bosons

Quantum ideal gases: bosons Quantum ideal gases: bosons Any particle with integer spin is a boson. In this notes, we will discuss the main features of the statistics of N non-interacting bosons of spin S (S =,,...). We will only

More information

[Disclaimer: This is not a complete list of everything you need to know, just some of the topics that gave people difficulty.]

[Disclaimer: This is not a complete list of everything you need to know, just some of the topics that gave people difficulty.] Math 43 Review Notes [Disclaimer: This is not a complete list of everything you need to know, just some of the topics that gave people difficulty Dot Product If v (v, v, v 3 and w (w, w, w 3, then the

More information

Identical Particles in Quantum Mechanics

Identical Particles in Quantum Mechanics Identical Particles in Quantum Mechanics Chapter 20 P. J. Grandinetti Chem. 4300 Nov 17, 2017 P. J. Grandinetti (Chem. 4300) Identical Particles in Quantum Mechanics Nov 17, 2017 1 / 20 Wolfgang Pauli

More information

In this approach, the ground state of the system is found by modeling a diffusion process.

In this approach, the ground state of the system is found by modeling a diffusion process. The Diffusion Monte Carlo (DMC) Method In this approach, the ground state of the system is found by modeling a diffusion process. Diffusion and random walks Consider a random walk on a lattice with spacing

More information

Markov Chain Monte Carlo The Metropolis-Hastings Algorithm

Markov Chain Monte Carlo The Metropolis-Hastings Algorithm Markov Chain Monte Carlo The Metropolis-Hastings Algorithm Anthony Trubiano April 11th, 2018 1 Introduction Markov Chain Monte Carlo (MCMC) methods are a class of algorithms for sampling from a probability

More information

Numerical Methods. Root Finding

Numerical Methods. Root Finding Numerical Methods Solving Non Linear 1-Dimensional Equations Root Finding Given a real valued function f of one variable (say ), the idea is to find an such that: f() 0 1 Root Finding Eamples Find real

More information

Physics 4230 Set 2 Solutions Fall 1998

Physics 4230 Set 2 Solutions Fall 1998 Fermi 2.1) Basic 1st Law of Thermodynamics: Calculate the energy variation of a system which performs 3.4x10 8 ergs of work and absorbs 32 calories of heat. So, the bottom line in this problem is whether

More information

Physics Oct Reading. K&K chapter 6 and the first half of chapter 7 (the Fermi gas). The Ideal Gas Again

Physics Oct Reading. K&K chapter 6 and the first half of chapter 7 (the Fermi gas). The Ideal Gas Again Physics 301 11-Oct-004 14-1 Reading K&K chapter 6 and the first half of chapter 7 the Fermi gas) The Ideal Gas Again Using the grand partition function we ve discussed the Fermi-Dirac and Bose-Einstein

More information

The Monte Carlo Algorithm

The Monte Carlo Algorithm The Monte Carlo Algorithm This algorithm was invented by N. Metropolis, A.W. Rosenbluth, M.N. Rosenbluth, A.H. Teller, and E. Teller, J. Chem. Phys., 21, 1087 (1953). It was listed as one of the The Top

More information

The Gross-Pitaevskii Equation A Non-Linear Schrödinger Equation

The Gross-Pitaevskii Equation A Non-Linear Schrödinger Equation The Gross-Pitaevskii Equation A Non-Linear Schrödinger Equation Alan Aversa December 29, 2011 Abstract Summary: The Gross-Pitaevskii equation, also called the non-linear Schrödinger equation, describes

More information

UNIVERSITY OF SOUTHAMPTON

UNIVERSITY OF SOUTHAMPTON UNIVERSITY OF SOUTHAMPTON PHYS2024W1 SEMESTER 2 EXAMINATION 2011/12 Quantum Physics of Matter Duration: 120 MINS VERY IMPORTANT NOTE Section A answers MUST BE in a separate blue answer book. If any blue

More information

Thermodynamics & Statistical Mechanics

Thermodynamics & Statistical Mechanics hysics GRE: hermodynamics & Statistical Mechanics G. J. Loges University of Rochester Dept. of hysics & Astronomy xkcd.com/66/ c Gregory Loges, 206 Contents Ensembles 2 Laws of hermodynamics 3 hermodynamic

More information

Topological insulator with time-reversal symmetry

Topological insulator with time-reversal symmetry Phys620.nb 101 7 Topological insulator with time-reversal symmetry Q: Can we get a topological insulator that preserves the time-reversal symmetry? A: Yes, with the help of the spin degree of freedom.

More information

Attempts at relativistic QM

Attempts at relativistic QM Attempts at relativistic QM based on S-1 A proper description of particle physics should incorporate both quantum mechanics and special relativity. However historically combining quantum mechanics and

More information

A computational introduction to quantum statistics using harmonically trapped particles. Abstract

A computational introduction to quantum statistics using harmonically trapped particles. Abstract A computational introduction to quantum statistics using harmonically trapped particles Martin Ligare Department of Physics & Astronomy, Bucknell University, Lewisburg, PA 17837 (Dated: March 15, 2016)

More information

Energy Level Energy Level Diagrams for Diagrams for Simple Hydrogen Model

Energy Level Energy Level Diagrams for Diagrams for Simple Hydrogen Model Quantum Mechanics and Atomic Physics Lecture 20: Real Hydrogen Atom /Identical particles http://www.physics.rutgers.edu/ugrad/361 physics edu/ugrad/361 Prof. Sean Oh Last time Hydrogen atom: electron in

More information

Statistical Mechanics

Statistical Mechanics 42 My God, He Plays Dice! Statistical Mechanics Statistical Mechanics 43 Statistical Mechanics Statistical mechanics and thermodynamics are nineteenthcentury classical physics, but they contain the seeds

More information

1 Fluctuations of the number of particles in a Bose-Einstein condensate

1 Fluctuations of the number of particles in a Bose-Einstein condensate Exam of Quantum Fluids M1 ICFP 217-218 Alice Sinatra and Alexander Evrard The exam consists of two independant exercises. The duration is 3 hours. 1 Fluctuations of the number of particles in a Bose-Einstein

More information

Lectures about Python, useful both for beginners and experts, can be found at (http://scipy-lectures.github.io).

Lectures about Python, useful both for beginners and experts, can be found at  (http://scipy-lectures.github.io). Random Matrix Theory (Sethna, "Entropy, Order Parameters, and Complexity", ex. 1.6, developed with Piet Brouwer) 2016, James Sethna, all rights reserved. This is an ipython notebook. This hints file is

More information