Fermi-Pasta-Ulam problem

Size: px
Start display at page:

Download "Fermi-Pasta-Ulam problem"

Transcription

1 Fermi-Pasta-Ulam problem Tristan Koskamp Supervisors: J.S. Caux, D. Fioretto, M. Brockmann ITFA July 18, 2013 Abstract The aim of this paper is to get more insight in the behaviour of the Fermi- Past-Ulam problem. We studied the behaviour of the FPU-chain and its thermalization. To obtain the results we wrote a program in C++ to simulate the chain for the α-model. Different initial conditions were used. The results for the α = 0, 25 model are in accordance with the findings of Fermi, Pasta and Ulam. For the α = 1 model we saw that there was chaotic behaviour as predicted with the KAM-theorem. For the model with the high initial energy, we saw a strong tendency towards equipartion of energy.

2 Contents 1 Introduction 1 2 The Fermi-Pasta-Ulam problem Mechanics of N oscilators Equipartition of Energy Numerical Techniques Verlet Integration Runge-Kutta Fast Fourier Transform Results 18 5 Conclusion 27

3 1 Introduction In this paper we try to reproduce the numerical results from Fermi, Pasta and Ulam and investigate the (quasi-)periodicity and equipartition of energy of the Fermi-Pasta-Ulam problem 1. In order to reproduce their results a code in C++ was written. In the following sections the origin of the FPU will be discussed. Later the mechanics of a string of oscillators with a little perturbation will be explained and also the principals of equitation of energy were Fermi, Pasta and Ulam based their predictions on. The numerical techniques that are implemented in the C++ code will also be discussed. Examples of these techniques are the Runge-Kutta algorithm and the fast Fourier transform 2. The goal of this research is the get more insight in the FPU-problem and its sometimes weird behaviour. 1 From now on referred as FPU problem 2 From now on referred as FFT

4 2 The Fermi-Pasta-Ulam problem After the war Enrico Fermi becomes interested in the potential of the electronic computing machines. He thought that computer could contribute to the understanding of physics problems, especially when problem are not analytically solvable. In this case a computer model could give insight in the properties and perhaps solutions of the problem. Fermi also thought that future fundamental theories may involve nonlinear equations and operators. He wanted to study a simple model with non-linear terms and look at its long time behaviour. The model that Fermi started with was a 1-D lattice, you could imagine it as a long chain of oscillators coupled by springs. In this model the springs had also a little perturbation in the form of a quadratic term, so the springs arent linear. Enrico Fermi, John Pasta and Stanislaw Ulam ran numerical simulations of this model and looked at the thermalization of this lattice. They expected that the energy of the initial state would slowly drift to other states and eventually the system would reach equipartion of energy. On one night they left the experiment running by accident. The next morning they found something quite astonishing happens when the simulations runs for a long period of time. As opposed to their expectations equipartion of energy was not reached. They observed a quasi-periodic behavior, first the energy disperse into different models but comes back later in the initial mode for almost about 97%. When the simulation runs longer the energy in the initial comes back in the initial mode with an even higher accuracy, this is known as super recurrence. The results of the simulations were astonishing because there are strong arguments that equipartion also will be reached when there is a nonlinear interaction between particles. This paradoxical observations is known as the FPU problem[4].

5 2.1 Mechanics of N oscilators In the FPU problem we study coupled oscillators. In the normal case when the springs only have linear terms we can use Hook s law. If we set the constants k and m equal too 1 Hook s law is F(x) = ẍ = x (1) Fermi, Pasta and Ulam added a little perturbation to Hook s law to in the form of a nonlinear term, αx 2, and obtained F(x) = ẍ = x αx 2 (2) Figure 1: Chain of N oscillators The displacement from the equilibrium position, x, of the n th oscillator will be denoted by u n. The equilibrium position of the oscillator is declared with the dashed line in figure (1). If we now apply formula (2) to oscillator n as shown in figure (1) and only take into account its nearest neighbour left and right, we get the following equation for the unperturbated case after some rewriting. For the pertubated case we get ü n = u n 1 2u n + u n+1 (3) ü n = u n 1 2u n + u n+1 + α[(u n u n 1 ) 2 + (u n+1 u n ) 2 ] (4) This is the acceleration we will use for the numerical experiment. Fermi, Pasta and Ulam also used a cubic perturbation, βx 3, but in this paper we won t discuss it further. We will only use the squared perturbation.

6 2.2 Equipartition of Energy The equipartition theorem is an important theorem in statistical mechanics and was used by Fermi, Pasta and Ulam to predict the outcome of their experiment. It states that at temperature T, the average energy of any quadratic degree of freedom is 1 kt. This means that every enery mode should be equally occupied after 2 a long period of time. The theorem also states that all forms of energy for which the formula is a quadratic function of a coordinate or velocity component, the equipartition theorem holds. Degrees of freedom are for example the translational motion in the x, y and z directions. Other examples of degrees of freedom are vibration motion and elastic potential energy such as energy stored in a spring. The equipartition theorem applies only to systems whose energy is in the form of quadratic degrees of freedom. This means it needs to be in the following form E(q) = cq 2 (5) In this equation c is a constant and q is for example any coordinate or momentum variable like x or p x. Examples of energy in the form of a quadratic degrees of freedom are 1 2 mv2 x, the speed in the x-direction or 1 2 kx2, the energy stored in a spring. When we consider a system with on single degree of freedom and assume that it s in equilibrium with a reservoir at temperature T. Further let the values for q be discretely spaced, separated by small intervals q and we assume that q is very small. Then the partition function for this system is Z = e βe(q) = e βcq2 (6) q If we now multiply by q inside the summation and divide by q outside the summation we get q Z = 1 e βcq2 (7) q Because q is very small we can change the summation for an integral Z = 1 q We now make the substitution x = βcq and dq = dx/ βc e βcq2 dq (8) Z = 1 q 1 e x2 dx = 1 βc q π βc (9)

7 We now can calculate the average energy E with the following function when we put (9) into it E = 1 Z Z β = 1 kt (10) 2 So every quadratic degree of freedom will eventually have an averaged energy of 1 kt. This is known as the equipartition theorem.[7] 2 In our model we start off with the simple configuration of an sine wave of wavelength N/2 and we want to see how this simple configuration changes over time. Due to the nonlinear forces the configuration will slowly change and the chain of oscillators will get into other states that are also described by sine waves. To make this visual the shape of the chain is analyzed with Fourier series. In our case the end points are fixed, so u 0 = u N = 0. So only the complex part of the Fourier series apply. The idea is to write the energy in terms of Fourier coefficients so we can see in which modes the energy is stored. The Fourier coefficients are N 1 a k = u n (t) sin( πkn N ) (11) The sum of the kinetic and the potential enery for the α-model is E kin + E pot = N u2 n (u n+1 u n ) 2 + α 3 (u n+1 u n ) 3 (12) When we neglect the contribution of the perturbation to the potential, this is only a small amount of the total energy, we can express the energy of the energy stored in every mode with the following equation.[4] E k = 1 2ȧk + 2a k 2 sin 2 ( πk N ) (13) Fermi, Pasta and Ulam believed that also their system, with a small α, would reach equipartition. So all the energy modes E k would have the same time averaged energy. When α is small we can treat the nonlinearity as a small perturbation and due the nonlinearity the different energy modes exchange energy. Also some analytical arguments predicted equipartion of energy for a nonlinear system. But when they actually run the experiment they didn t encounter equipartion of energy, as told before[2].

8 Almost at the same time as Fermi, Pasta and Ulam did their experiment, A.N. Kolmogorov made the first formulation of the KAM theorem. This could explain the results of the FPU experiment. The theorem states that all regular features of the dynamics are kept by integrable Hamiltonian systems subject to a small enough perturbation. This might be a solution to the FPU paradox. Probably the perturbation that Fermi, Pasta and Ulam used was to small in order to get the system to behave like they predicted and didn t get equipartion of energy[5]. Another important discovery is the discovery of a stochasticity threshold. When the initial energy is large enough and the energy exceeds the stochasticity threshold the FPU-paradox will disappear and there will be equipartiton of energy. This discovery is done by Izrailev and Chirikov. For the explanation of this threshold Izrailev and Chirikov used the KAM theorem[1].

9 3 Numerical Techniques There are a lot of numerical techniques to solve the differential equation stated in equation (4). In this section we will discuss the two techniques that are used to simulate the FPU problem. First the Verlet integration is derived and come with an algorithm that is implemented in the C++ code. Also the more accurate Runge Kutta algorithm will be discussed. This algorithm is an order more accurate than the Verlet integration. At the end the Fast Fourier Transform will be discussed. This is an algorithm to reduce the calculation time of the Fourier transform when you have to deal with large arrays. 3.1 Verlet Integration One way to simulate the FPU problem is with use of Verlet integeration. This technique is pretty straight forward and has a fourth order error. In this section we will derive the technique step by step and at the end we have an algorithm to simulate the N coupled oscillators. First we start with a simple Taylor expansion of a function u n (t) around the point t. Were u denotes the displacement of the spring form its equilibrium position, t the time and n the n th oscillator of the chain. If t 0 is the variable the expression becomes u n (t 0 ) = u n (t) + u n(t) 1! (t 0 t) + ün(t... 0 ) (t 0 t) 2 u n (t 0 ) + (t 0 t) (14) 2! 3! If we now plug in t + dt for t 0 into equation (14) we get the following result u n (t + dt) = u n (t) + u... n(t) ün(t) u n (t) dt + 1! 2! dt2 + dt 3 + O(dt 4 ) (15) 3! We also plug in t dt for t 0 into expression (14) and then we get u n (t dt) = u n (t) u... n(t) ün(t) u n (t) dt + 1! 2! dt2 dt 3 + O(dt 4 ) (16) 3! The next step is to add the last two equations and we get the following expression after rearranging u n (t + dt) = 2u n (t) u n (t dt) + ü n (t)dt 2 + O(dt 4 ) (17) We now have an expression to calculate the displacement of the oscillators at time t + dt and we only have to know the deflection at time t and time t dt. Also the acceleration at time t needs to be known, but this only depends on the displacement at time t, see equation (4). To implement this algorithm into the FPU simulation we assume that at t = 0 the acceleration is also zero (ü n (t) = 0). This means that u n (t) = u n (t + dt) at the start. With this initial condition we can calculate what happens over time.

10 3.2 Runge-Kutta Besides the method of Verlet integration you have a lot more methods to evaluate the problem numerical. One of these methods is Runge-Kutta method. This method is al little more complex to implement but is one order more accurate than the Verlet integration method. The standard Runge-Kutta method is simple to implement for first order differential equations but it also useful for second order differential equations although a little bit more work to implement. In the next section it is discussed how to the Runge-Kutta method is implemented for the FPU problem. The standard Runge-Kutta method for first order differential equations is as follow. If we have the first order differential equations and it s initial conditions defined x t = f (t, x) x(t 0) = x 0 (18) We can calculate the next value for x, x(t + dt), with the Runge-Kutta algorithm. In order to do this we need to calculate four variable - k 1, k 2, k 3 and k 4. They are defined as follow k 1 = f (t, x) (19) k 2 = f (t + dt 2, x + k 1 2 ) (20) k 3 = f (t + dt 2, x + k 2 2 ) (21) k 4 = f (t + dt, x + k 3 ) (22) When all these k s are calculated you can calculate x(t + dt) with the following function: x(t + dt) = x(t) + dt 2 (k 1 + 2k 2 + 2k 3 + k 4 ) (23) In our case we have to modify the algorithm a bit, because we are dealing with second order differential equations. The formula for the acceleration is 2 u n 2 t = u n 1 2u n + u n+1 + α[(u n u n 1 ) 2 + (u n+1 u n ) 2 ] (24)

11 Now we are going to make a substitution v n t v n t u n t = v n (25) = F(t, u(t)) (26) = u n 1 2u n + u n+1 + α[(u n u n 1 ) 2 + (u n+1 u n ) 2 ] (27) (28) With this we can use the Runge-Kutta method and apply it to second order differential equations. In our case an array of length N for j 1, j 2, j 3 and j 4 needs to be created. This is due the fact that the acceleration depends not only on the displacement of the oscillator at place n but also on its neighbours. Also an array of length N for the variables k 1, k 2, k 3 and k 4 is needed. In our case j 1, j 2, j 3 and j 4 are needed for the calculations of the velocity and the k 1, k 2, k 3 and k 4 are needed for the calculations of the displacement. So the next thing to do is to build the following array for the Runge-Kutta algorithm k 10 = u 0 k 11 = u 1 k 1N 2 = u N 2 k 1N 1 = u N 1 j 10 = ü 0 (29) j 11 = ü 1 j 1N 2 = ü N 2 j 1N 1 = ü N 1 Now we need to recalculate all the displacement u n of the oscillators so we can calculate j 2. This is because the acceleration of oscillator n also depends on the displacement of oscillator n 1 and n + 1. So we recalculate the displacement in

12 the following way u 20 = u 1 + dt 2 k 1 0 u 21 = u 1 + dt 2 k 1 1 (30) u 2N 2 = u 1 + dt 2 k 1 N 2 u 2N 1 = u 1 + dt 2 k 1 N 1 The next step is to calculate al the values for k 2 and j 2. Because neither j 1 nor k 1 depends explicited on t the next step will be k 20 = u 0 + dt 2 j 1 0 k 21 = u 1 + dt 2 j 1 1 k 2N 2 = u N 2 + dt 2 j 1 N 2 k 2N 1 = u N 1 + dt 2 j 1 N 1 (31) ü 2n = u 2n 1 2u 2n + u 2n+1 + α[(u 2n u 2n 1 ) 2 + (u 2n+1 u 2n ) 2 ] (32) j 20 = ü 20 j 21 = ü 21 (33) j 2N 2 = ü 2N 2 j 2N 1 = ü 2N 1 After we calculated all the values of k 2 and j 2 we can recalculated the displacements u 3n. With these displacements it s possible to calculate all the values of j 3 and with the values of k 2 it s possible to calculate all the values of k 3. This process is repeated till k 4 and j 4 are calculated. Once these values are obtained it s possible to calculate u n (t + dt) and v n (t + dt) with the following formulas u n (t + dt) = u n (t) + dt 6 (k 1 n + 2k 2n + 2k 3n + k 4n ) (34) v n (t + dt) = v n (t) + dt 6 ( j 1 n + 2 j 2n + 2 j 3n + j 4n ) (35) Now we have the displacement and the velocity at time t + dt.

13 3.3 Fast Fourier Transform The FFT is a great algorithm to reduce arithmetic operations with respect to the discrete Fourier transform 3. It reduces the number of calculations from an order of N 2 to an order of N log 2 (N). For large N this saves tons of time. The only downside of this algorithm is that we have to use an array that has a length N that obeys the equations N = 2 L were L = 2, 3, 4,... So N has to be a power of two. The basic idea of the algorithm is to split the N-point DFT up into two (N/2)-point DFTs. This can be done a total of L times. Now we are going to discuss the exact way how the FFT works. The DFT coefficient X(k) is defined by X(k) = 1 N N 1 x(n)(e i2π/n ) kn = 1 N N 1 x(n)w kn (36) Where k = 0, 1, 2,..., N 1 and x(n) are the data points. If we have a data sequence that has in total N = 2 L points. Then its possible to apply some manipulations to equation (36). Since N is a power of 2, we know that N/2 is an integer and we can combine samples that are separated by N/2 in the data sequence. So we get X(k) = 1 N X(k) = 1 N [x(n)w kn + x(n + N/2)W kn+n/2 ] (37) N/2 1 [x(n) + x(n + N/2)W N/2 ]W kn (38) N/2 1 This result can be simplified because W kn/2 can only take two values. Namely 1 and 1. This is because of the following W kn/2 = exp( i2π kn N 2 ) = e iπk = ( 1) k (39) When k is even we see W kn/2 = 1. Let define the following functions k = 2l l = 0, 1, 2,..., N/2 1 (40) g(n) = x(n) + x(n + N/2) (41) 3 From now on referred as DFT

14 If we use this to rewrite (37) we get X(2l) = 1 N N/2 1 g(n)w 2ln = 1 2 N/2 1 1 g(n)(w 2 ) ln (42) N/2 When we look more closely to equation (42), we see that this is one-half times an (N/2)-point DFT because W 2 = exp[ i2π/(n/2)] and the input is {g(0), g(1), g(2),..., g(n/2 1)}. We can conclude that for even values of k we can reduce the DFT in an (N/2)-point DFT. Now we are going to look at the case when k is odd, so W kn/2 case we define = 1. In this k = 2l + 1 l = 0, 1, 2,..., N/2 1 (43) If we use this to rewrite (37) we get y(n) = x(n) x(n + N/2) (44) X(2l + 1) = 1 N N/2 1 y(n)w (2l+1)n = 1 2 N/2 1 1 h(n)(w 2 ) ln (45) N/2 In this case h(n) = y(n)w n. We can see now just as in the case of k is even, that equation (45) is one-half times an (N/2)-point DFT with the input {h(0), h(1), h(2),..., h(n/2 1)}. The parameter W n in y(n)w n is often referred as the twillde factor. As an example we apply this method discussed above for an 8-point DFT. So in this case N = 8, we have eight inputs namely {x(0), x(1), x(2),..., x(7)}. To reduces the input by a factor two we need to add x(0) and x(4), x(1) and x(5), x(2) and x(6) and x(3) and x(7). For the odd values of k we need to subtract x(4) from x(0), x(5) from x(1), x(6) from x(2), x(7) from x(1) and multiply by the right twiddlefactor W 0, W 1, W 2 and W 3. The inputs and outputs of the first stage described above are shown in table (1) and in figure (2) we can see how the outputs are build up. We also split the 4-point DFT s up into four 2-point DFT. How this is done is shown in table (2) and figure (3). The last step is to calculate the 2-point DFT s outputs, the inputs and outputs are shown in table (3) and figure (4). In the tables the normalization factor of 1/2 for every stage is left away in order to get a more organized table. At the end all the outputs in table (3) need to be multiplied with 1/8.

15 Figure 2: Reduction of an 8-point DFT to two 4-point DFT s Input Output x(0) x(0) + x(4) x(1) x(1) + x(5) x(2) x(2) + x(6) x(3) x(3) + x(7) x(4) x(0) x(4)w 0 x(5) x(1) x(5)w 1 x(6) x(2) x(6)w 2 x(7) x(3) x(7)w 3 Table 1: 8-point DFT to two 4-point DFT s

16 Figure 3: Reduction of an 8-point DFt to two 4-point DFT s Input Output x(0) + x(4) x(0) + x(4) + x(2) + x(6) x(1) + x(5) x(1) + x(5) + x(3) + x(7) x(2) + x(6) x(0) + x(4) [x(2) + x(6)] x(3) + x(7) x(1) + x(5) [x(3) + x(7)] x(0) x(4)w 0 x(0) x(4)w 0 + [x(2) x(6)w 2 ] x(1) x(5)w 1 x(1) x(5)w 1 + [x(3) x(7)w 3 ] x(2) x(6)w 2 x(0) x(4)w 0 [x(2) x(6)w 2 ] x(3) x(7)w 3 x(1) x(5)w 1 [x(3) x(7)w 3 ]W 2 Table 2: Two 4-point DFT s to four 2-point DFT s Figure 4: Reduction of an 8-point DFt to two 4-point DFT s

17 Input x(0) + x(4) + x(2) + x(6) = g(0) x(1) + x(5) + x(3) + x(7) = g(1) x(0) + x(4) [x(2) + x(6)] = g(2) x(1) + x(5) [x(3) + x(7)] = g(3) x(0) x(4)w 0 + [x(2) x(6)w 2 ] = g(4) x(1) x(5)w 1 + [x(3) x(7)w 3 ] = g(5) x(0) x(4)w 0 [x(2) x(6)w 2 ] = g(6) x(1) x(5)w 1 [x(3) x(7)w 3 ] = g(7) Output g(0) + g(1) = X(0) g(0) g(1) = X(4) g(2) + g(3) = X(2) g(2) g(3) = X(6) g(4) + g(5) = X(1) g(4) g(5) = X(5) g(6) + g(7) = X(3) g(6) g(7) = X(7) Table 3: Four 2-point DFT s to final output The FFT for an 8-point DFT is now ready. It s pretty straight forward to extend this algorithm to larger N, if N is a power of two. The only problem we have now is that the output is in bit-reversed order (and we didn t normalize the output by a factor 1/8). In order to get the output in the right order we need to bit-reverse the output. For the 8-point DFT this is done in table (4). The way to do it is to write your output in bit notations, mirror it and write it back to decimal notation. Bit-reversed index Bit-reversed Bits Linear index Table 4: Bit reversing Now we are done with the FFT algorithm[3]. The C++ code for the FFT is taken from Numerical Recipes: The Art of Scientific Computing[6]. There is only one problem left, in our case the end points are fixed (u 0 = u N = 0), so there are no cosines. In this case we want to use the fast sine transform. It is a little more complex to implement then the FFT. We are now going to discuss the theoretical background of this algorithm.

18 We want to calculate the sine transform and it is given by F(k) = N 1 x(n) sin( πnk N ) (46) Where x(0), x(1),..., x(n 1) are the data points and x(0) = 0. At the first glance it looks like the complex part of the FFT, but the term inside the sine differs by a factor of two in comparison with the FFT. We can use the FFT algorithm to calculate the sine transform, but we need to modify the input first. The idea is to expand the data set into an odd function with x(n) = 0 x(2n n) = x(n) n = 0, 1,..., N 1 (47) The FFT of this doubled data set is F(k) = 2N 1 x(n)e 2πink/(2N) (48) Now we make an substitution to rewrite half of this sum. This substitution is n = 2N n. We can rewrite the summation of equation (48) 2N 1 n=n x(n)e 2πink/(2N) = N x(n n )e 2πi(2N n )k/(2n) n =1 N 1 = x(n )e 2πn k/(2n) n =0 Now rewrite equation (48) with equation (50) and we obtain F(k) = N 1 N 1 = 2i (49) (50) x(n)[e 2πink/(2N) e 2πink/(2N) ] (51) x(n) sin( πnk N ) (52) Except for the factor 2i we get the sine transform from the FFT for the extended function. The only problem is that we need to double the array length which reduces the efficiency of the program. With another trick we can correct this. We need to create an extra array y j that has the following entries y(0) = 0 (53) y(n) = sin(nπ/n)[x(n) + x(n j)] + 1 [x(n) x(n n)] (54) 2

19 This array has also length N, n is ranging from 1 till N 1. If we use the FFT on this array we will get the following transform for the real part of the transform (R(k)) and the imaginary part of the transform (I(k)) N 1 R(k) = y(x) cos(2πnk/n) (55) I(k) = N 1 = [x(n) + x(n n)] sin(nπ/n) cos(2πnk/n) (56) n=1 N 1 = 2x(n) sin(nπ/n) cos(2πnk/n) (57) N 1 = x(n)[sin (2k + 1)nπ N sin (2k 1)nπ ] (58) N = F(2k + 1) F(2k 1) (59) N 1 x(x) sin(2πnk/n) (60) N 1 = [x(n) x(n n)] 1 sin(2πnk/n) (61) 2 n=1 = F(2k) (62) From these equations we can determine F(k) F(2k) = I(k) F(2k + 1) = F(2k 1) + R(k) k = 0,..., (N/2 1) (63) We see that the even terms are determined directly, but for the odd terms we also need another term. For k = 0 we use the fact that F(1) = F( 1) and then F(1) can be calculated, in this case F(1) = 1 R(0). Now we can caluclate all the values of 2 F(k). In the book Numerical Recipes they use a clever trick to store a real array into a complex array so the FFT only need to calculate a complex array of length N/2 instead of an complex array of length N with all zeroes for the complex parts. We won t further discuss the detail of this clever way of calculating the FFT, but the resulting code is used in the program to simulate the FPU-problem.[6]

20 4 Results In the next section the result of different intial conditions are analyzed. There are three initial conditions that are used to generate the plots. The first one is the famous sine wave of wavelength N/2, amplitude of 1 and α = 0, 25 were Fermi, Pasta and Ulam discovered that the energy would go back into the original mode after some time. The second initial condition is an sine wave of wavelength N/2, amplitude of 1 but α = 1. The final inital condition is an sine wave of wavelength N/2 with an amplitude of 8 and and α = 0, 25. The main goal is to look at the recurrence of the of the initial state and look if there is any form of equipartion of energy Energy (arb. unit) Time ( 10 3 sec) Energymode 1 Energymode 2 Energymode 3 Energymode 4 Energymode 5 Energymode 6 Figure 5: Wavelength N/2, amplitude of 1, N = 32, α = 0.25 and dt = 0.01 In figure (5) the first six energy modes are plotted for the initial condition of a sine wave of wavelength N/2. We see that all the energy is in the first mode at t = 0 because this is the initial conditions. We see that after some time approximately t = all the first six modes picked up energy and it s looking like all the enrgy modes are coming closer and closer and the equipartion theorem holds. But then at t = almost all the energy is in the second mode and at t = almost all th energy is back into the first mode.

21 In figure (6) we see how the chain of oscillators looks like at different times. The red dots show how the chain looks like at the initial condition. At t = 2000 we see in figure (5) that the chain is a superposition of several Fourier modes. For t = 4364 the only mode occupied is the second mode and at t = 8650 all the energy almost returned in the first mode. All the findings in figure (6) are in accordance with figure (5) Displacement (arb. unit) t = 0 t = 2000 t = 4364 t = Oscillator n Figure 6: Wavelength N/2, amplitude of 1, N = 32, α = 0.25 and dt = 0.01

22 The next thing to look at is if the recurrence in figure (5) is coming back multiple times. In figure (7) and figure (8) we plotted the energymodes for the same initial conditions only with a longer timescale. If we look at figure (7) we see that the energy comes back into the first mode, but each time less energy goes back into the first mode. It seems that equipartition of energy will be reached eventually. But when we take a glance at figure (8) we see that there is another recurrence. Eventually all the energy is back in the first mode and this recurrence repeats many times. This recurrence is known as super recurrence. 1.4 Energy (arb. unit) Energymode 1 Energymode 2 Energymode Time ( 104 sec) Energymode 4 Energymode 5 Energymode 6 Figure 7: Wavelength N/2, amplitude of 1, N = 32, α = 0.25 and dt = Energy (arb. unit) Energymode 1 Energymode 2 Energymode Time ( 105 sec) Energymode 4 Energymode 5 Energymode 6 Figure 8: Wavelength N/2, amplitude of 1, N = 32, α = 0.25 and dt = 0.01

23 Let s take a look at the time averaged energy for every mode. For the first twenty modes the time averaged energy is plotted in figure (9). The time averaged energy of the energy modes first diverge to each other, but at some point it stops and equipartion of energy is not reached. In figure (10) all the energy modes are plotted at the x-axis and the time averaged energy at the y-axis at t = It is clear that equipartition is not reached for the model with 32 oscillators, α = 0, 25 and initial condition of a sine wave with wavelength N/ Time averaged energy (arb. unit) Time (sec) Figure 9: Wavelength N/2, amplitude of 1, N = 32, α = 0.25 and dt = Time averaged energy (arb. unit) E k Figure 10: Wavelength N/2, amplitude of 1, N = 32, α = 0.25 and dt = 0.01

24 When α is set equal to 1 we see that the energy also comes back into the first mode as shown in figure (11). Also a second recursion is observed in figure (11) although this looks already more chaotic then for α equal to 0,25. When we plot the energy modes for a longer period of time, there isn t such a nice pattern as for the α = 0, 25 model. Although there is a little bit of recurrence the pattern is also for longer timescales more chaotic and this might indicate that the time averaged energy for each mode lies closer together. Energy (arb. unit) Time ( 10 3 sec) Energymode 1 Energymode 2 Energymode 3 Energymode 4 Energymode 5 Energymode 6 Figure 11: Wavelength N/2, amplitude of 1, N = 32, α = 1 and dt = 0.01 Energy (arb. unit) Time ( 10 4 sec) Energymode 1 Energymode 2 Energymode 3 Energymode 4 Energymode 5 Energymode 6 Figure 12: Wavelength N/2, amplitude of 1, N = 32, α = 1 and dt = 0.01

25 When we look at figure (13) we see indeed that the time averaged energies lay closer together if we compare it with the model were α is equal to 0,25. In figure (14) the time averaged energy for each mode is plotted at t = 10 5 seconds. In this figure it is clear that the time averaged energies for all the energies modes lie closer together. The perturbation is probably too big to obey the KAM-theorem Time averaged energy (arb. unit) Time (sec) Figure 13: Wavelength N/2, amplitude of 1, N = 32, α = 1 and dt = Time averaged energy (arb. unit) E k Figure 14: Wavelength N/2, amplitude of 1, N = 32, α = 1 and dt = 0.01

26 For the last couple of plots the initial condition was again a sine wave with wavelength N/2, but this time the amplitude was 8 instead of 1 and α was set back to 0,25. If we look at figure (15) it is clear that the pattern is more chaotic then in the previous plots. When we look at (16) we see that there isn t really recurrence. The energy is not going back in the first mode for more than 65%. This might indicate that there is equipartition after a long time. Energy (arb. unit) Time ( 10 3 sec) Energymode 1 Energymode 2 Energymode 3 Energymode 4 Energymode 5 Energymode 6 Figure 15: Wavelength N/2, amplitude of 8, N = 32, α = 0.25 and dt = 0.01 Energy (arb. unit) Time ( 10 4 sec) Energymode 1 Energymode 2 Energymode 3 Energymode 4 Energymode 5 Energymode 6 Figure 16: Wavelength N/2, amplitude of 8, N = 32, α = 0.25 and dt = 0.01

27 In figure (17) and (18) we see that the time averaged energy of the energy modes lies closer together than the for the α = 0.25 and α = 1 models. This is something you might expect after seeing figure (15) and (16). The stochasticity threshold is exceeded because the initial energy was big enough[1] and therefore a tendency towards equipartion is reached Time averaged Energy (arb. unit) Time (sec) Figure 17: Wavelength N/2, amplitude of 8, N = 32, α = 0.25 and dt = Time averaged energy (arb. unit) E k Figure 18: Wavelength N/2, amplitude of 8, N = 32, α = 0.25 and dt = 0.01

28 10 2 Time averaged energy (arb. unit) A = 1, α = 0.25 A = 1, α = 1 A = 8, α = E k Figure 19: The time averaged energy for each energymode compared with the different initail conditions In figure (19) all the time averaged energy of the different modes from the three models are plotted. We can clearly see that the model with the big initial amplitude is the closest to equipartiton of energy. The model with amplitude 1 and α equal to 0.25 is far from equipartiton. Also the model with amplitude 1 and α equal to 1 doesn t really shows equipartiton but is defenitly more closer to it. The model with the most tendecy towerads equipartion of energy is the model with the big amplitude. The stochasticity threshold is exceeded in this model and equipartition of energy will be reached eventually.

29 5 Conclusion The results for the α = 0.25 model are in accordance with the results that are obtained by Fermi, Pasta and Ulam. The energy is of the first model slowly flows away to other modes and comes back later in the first mode. For a long timescale (10 6 sec) the pattern looks like a periodic pattern and doesnt look like chaos at all. If we look at the time averaged energy of the different modes we see that there is no equipartiton of energy and that the energy is mainly stored in the first few modes. This is also in accordance with the observations of Fermi, Pasta and ulam. For the α = 1 model we see already for a rather small timescale less recurrence and a less orderd pattern in comparison with the α = 0.25 model. It seems that it is much more chaotic. When we look at the time averaged energy per mode we see that they lie closer together. But there isnt really equipartion of energy. In this model α is probably big enough to violate the KAM-theorem and thats why we see more chaotic behaviour. The last model, with high initial energy, shows the most chaotic behaviour. For a relative short timescale of 10 4 seconds the behaviour seems to be completely chaotic. When plotted for a timescale of 10 5 we dont see any pattern. If we look at the time averaged energy we see that the energy modes dont differ more than a factor 10 and this model shows the most tendency to equipartition. The stochasticity threshold is exceeded and it looks like equipartition of energy will eventually be reached. This is in accordance with the observation of Izrailev and Chirikov.

30 References [1] G. Benettin, A. Carati, L. Galgani, A. Giorgilli, The Fermi-Pasta-Ulam Problem and the Metastability Perspective, Lecture Notes in Physics, 728, pp , (2008) [2] G. P. Berman, F. M. Izrailev, The Fermi-Pasta-Ulam problem: 50 years of progress, Choas 15, pp , (2005) [3] D. F. Elliot, K. R. Raoi, FAST TRRANSFORMS: Algorithms, Analyses, Applications (Academic press, 1982), pp [4] E. Fermi, J. Pasta, S. Ulam, Studies of Nonlinear Problems, (Tech. Rep. LA-1940, Los Alamos National Laboratory, Los Almos, New Mexico, 1955) [5] R. Livi, A. Vulpiani, The Kolmogorov Legacy in Physics (Springer, 2003), pp [6] W. H. Press, S. A. Teukolsky, W. T. Vetterling, B. P. Flannery, Numerical Recipes: The Art of Scientific Computing, Third Edition in C++ (Cambridge university press, 2007), pp [7] D. V. Schroeder, An Introduction to Thermal Physics (Addison Wesley Longman, 1991), pp ,

Pasta-Ulam problem. The birth of nonlinear physics and dynamical chaos. Paolo Valentini

Pasta-Ulam problem. The birth of nonlinear physics and dynamical chaos. Paolo Valentini The Fermi-Pasta Pasta-Ulam problem The birth of nonlinear physics and dynamical chaos Paolo Valentini SUMMARY The Fermi-Pasta Pasta-Ulam experiment on MANIAC at LANL in 1955 The ergodic hypothesis The

More information

Partial Differential Equations Summary

Partial Differential Equations Summary Partial Differential Equations Summary 1. The heat equation Many physical processes are governed by partial differential equations. temperature of a rod. In this chapter, we will examine exactly that.

More information

Differential Equations

Differential Equations Electricity and Magnetism I (P331) M. R. Shepherd October 14, 2008 Differential Equations The purpose of this note is to provide some supplementary background on differential equations. The problems discussed

More information

The Fermi-Pasta-Ulam Problem: An Exploration of the One-Dimensional Lattice

The Fermi-Pasta-Ulam Problem: An Exploration of the One-Dimensional Lattice The Fermi-Pasta-Ulam Problem: An Exploration of the One-Dimensional Lattice Gregory Shinault Graduate Group in Applied Mathematics gshinault@math.ucdavis.edu June 9, 2008 Abstract In this paper we examine

More information

Continuum Limit and Fourier Series

Continuum Limit and Fourier Series Chapter 6 Continuum Limit and Fourier Series Continuous is in the eye of the beholder Most systems that we think of as continuous are actually made up of discrete pieces In this chapter, we show that a

More information

Relevant sections from AMATH 351 Course Notes (Wainwright): 1.3 Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls): 1.1.

Relevant sections from AMATH 351 Course Notes (Wainwright): 1.3 Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls): 1.1. Lecture 8 Qualitative Behaviour of Solutions to ODEs Relevant sections from AMATH 351 Course Notes (Wainwright): 1.3 Relevant sections from AMATH 351 Course Notes (Poulin and Ingalls): 1.1.1 The last few

More information

Lecture 1 Notes: 06 / 27. The first part of this class will primarily cover oscillating systems (harmonic oscillators and waves).

Lecture 1 Notes: 06 / 27. The first part of this class will primarily cover oscillating systems (harmonic oscillators and waves). Lecture 1 Notes: 06 / 27 The first part of this class will primarily cover oscillating systems (harmonic oscillators and waves). These systems are very common in nature - a system displaced from equilibrium

More information

x(t+ δt) - x(t) = slope δt t+δt

x(t+ δt) - x(t) = slope δt t+δt Techniques of Physics Worksheet 2 Classical Vibrations and Waves Introduction You will have encountered many different examples of wave phenomena in your courses and should be familiar with most of the

More information

spring mass equilibrium position +v max

spring mass equilibrium position +v max Lecture 20 Oscillations (Chapter 11) Review of Simple Harmonic Motion Parameters Graphical Representation of SHM Review of mass-spring pendulum periods Let s review Simple Harmonic Motion. Recall we used

More information

Resonance and response

Resonance and response Chapter 2 Resonance and response Last updated September 20, 2008 In this section of the course we begin with a very simple system a mass hanging from a spring and see how some remarkable ideas emerge.

More information

Quick Sort Notes , Spring 2010

Quick Sort Notes , Spring 2010 Quick Sort Notes 18.310, Spring 2010 0.1 Randomized Median Finding In a previous lecture, we discussed the problem of finding the median of a list of m elements, or more generally the element of rank m.

More information

Lecture #4: The Classical Wave Equation and Separation of Variables

Lecture #4: The Classical Wave Equation and Separation of Variables 5.61 Fall 013 Lecture #4 page 1 Lecture #4: The Classical Wave Equation and Separation of Variables Last time: Two-slit experiment paths to same point on screen paths differ by nλ-constructive interference

More information

d 1 µ 2 Θ = 0. (4.1) consider first the case of m = 0 where there is no azimuthal dependence on the angle φ.

d 1 µ 2 Θ = 0. (4.1) consider first the case of m = 0 where there is no azimuthal dependence on the angle φ. 4 Legendre Functions In order to investigate the solutions of Legendre s differential equation d ( µ ) dθ ] ] + l(l + ) m dµ dµ µ Θ = 0. (4.) consider first the case of m = 0 where there is no azimuthal

More information

The Harmonic Oscillator

The Harmonic Oscillator The Harmonic Oscillator Math 4: Ordinary Differential Equations Chris Meyer May 3, 008 Introduction The harmonic oscillator is a common model used in physics because of the wide range of problems it can

More information

Discrete Tranformation of Output in Cellular Automata

Discrete Tranformation of Output in Cellular Automata Discrete Tranformation of Output in Cellular Automata Aleksander Lunøe Waage Master of Science in Computer Science Submission date: July 2012 Supervisor: Gunnar Tufte, IDI Norwegian University of Science

More information

23. The Finite Fourier Transform and the Fast Fourier Transform Algorithm

23. The Finite Fourier Transform and the Fast Fourier Transform Algorithm 23. The Finite Fourier Transform and the Fast Fourier Transform Algorithm 23.1 Introduction: Fourier Series Early in the Nineteenth Century, Fourier studied sound and oscillatory motion and conceived of

More information

Vibrations and Waves Physics Year 1. Handout 1: Course Details

Vibrations and Waves Physics Year 1. Handout 1: Course Details Vibrations and Waves Jan-Feb 2011 Handout 1: Course Details Office Hours Vibrations and Waves Physics Year 1 Handout 1: Course Details Dr Carl Paterson (Blackett 621, carl.paterson@imperial.ac.uk Office

More information

Part 1. The simple harmonic oscillator and the wave equation

Part 1. The simple harmonic oscillator and the wave equation Part 1 The simple harmonic oscillator and the wave equation In the first part of the course we revisit the simple harmonic oscillator, previously discussed in di erential equations class. We use the discussion

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Partial differential equations (PDEs) are equations involving functions of more than one variable and their partial derivatives with respect to those variables. Most (but

More information

MITOCW 6. Standing Waves Part I

MITOCW 6. Standing Waves Part I MITOCW 6. Standing Waves Part I The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources for free.

More information

CS1800: Sequences & Sums. Professor Kevin Gold

CS1800: Sequences & Sums. Professor Kevin Gold CS1800: Sequences & Sums Professor Kevin Gold Moving Toward Analysis of Algorithms Today s tools help in the analysis of algorithms. We ll cover tools for deciding what equation best fits a sequence of

More information

E = hν light = hc λ = ( J s)( m/s) m = ev J = ev

E = hν light = hc λ = ( J s)( m/s) m = ev J = ev Problem The ionization potential tells us how much energy we need to use to remove an electron, so we know that any energy left afterwards will be the kinetic energy of the ejected electron. So first we

More information

Seminar 6: COUPLED HARMONIC OSCILLATORS

Seminar 6: COUPLED HARMONIC OSCILLATORS Seminar 6: COUPLED HARMONIC OSCILLATORS 1. Lagrangian Equations of Motion Let consider a system consisting of two harmonic oscillators that are coupled together. As a model, we will use two particles attached

More information

Problem Set Number 01, MIT (Winter-Spring 2018)

Problem Set Number 01, MIT (Winter-Spring 2018) Problem Set Number 01, 18.377 MIT (Winter-Spring 2018) Rodolfo R. Rosales (MIT, Math. Dept., room 2-337, Cambridge, MA 02139) February 28, 2018 Due Thursday, March 8, 2018. Turn it in (by 3PM) at the Math.

More information

Physics I: Oscillations and Waves Prof. S. Bharadwaj Department of Physics and Meteorology. Indian Institute of Technology, Kharagpur

Physics I: Oscillations and Waves Prof. S. Bharadwaj Department of Physics and Meteorology. Indian Institute of Technology, Kharagpur Physics I: Oscillations and Waves Prof. S. Bharadwaj Department of Physics and Meteorology Indian Institute of Technology, Kharagpur Lecture No 03 Damped Oscillator II We were discussing, the damped oscillator

More information

Lecture Notes on the Fermi-Pasta-Ulam-Tsingou Problem

Lecture Notes on the Fermi-Pasta-Ulam-Tsingou Problem Lecture Notes on the Fermi-Pasta-Ulam-Tsingou Problem Andrew Larkoski November 9, 016 Because this is a short week, we re going to just discuss some fun aspects of computational physics. Also, because

More information

numerical analysis 1

numerical analysis 1 numerical analysis 1 1.1 Differential equations In this chapter we are going to study differential equations, with particular emphasis on how to solve them with computers. We assume that the reader has

More information

Physics 486 Discussion 5 Piecewise Potentials

Physics 486 Discussion 5 Piecewise Potentials Physics 486 Discussion 5 Piecewise Potentials Problem 1 : Infinite Potential Well Checkpoints 1 Consider the infinite well potential V(x) = 0 for 0 < x < 1 elsewhere. (a) First, think classically. Potential

More information

Taylor series. Chapter Introduction From geometric series to Taylor polynomials

Taylor series. Chapter Introduction From geometric series to Taylor polynomials Chapter 2 Taylor series 2. Introduction The topic of this chapter is find approximations of functions in terms of power series, also called Taylor series. Such series can be described informally as infinite

More information

3 Algebraic Methods. we can differentiate both sides implicitly to obtain a differential equation involving x and y:

3 Algebraic Methods. we can differentiate both sides implicitly to obtain a differential equation involving x and y: 3 Algebraic Methods b The first appearance of the equation E Mc 2 in Einstein s handwritten notes. So far, the only general class of differential equations that we know how to solve are directly integrable

More information

kg meter ii) Note the dimensions of ρ τ are kg 2 velocity 2 meter = 1 sec 2 We will interpret this velocity in upcoming slides.

kg meter ii) Note the dimensions of ρ τ are kg 2 velocity 2 meter = 1 sec 2 We will interpret this velocity in upcoming slides. II. Generalizing the 1-dimensional wave equation First generalize the notation. i) "q" has meant transverse deflection of the string. Replace q Ψ, where Ψ may indicate other properties of the medium that

More information

VII. Discrete Fourier Transform (DFT) Chapter-8. A. Modulo Arithmetic. (n) N is n modulo N, n is an integer variable.

VII. Discrete Fourier Transform (DFT) Chapter-8. A. Modulo Arithmetic. (n) N is n modulo N, n is an integer variable. 1 VII. Discrete Fourier Transform (DFT) Chapter-8 A. Modulo Arithmetic (n) N is n modulo N, n is an integer variable. (n) N = n m N 0 n m N N-1, pick m Ex. (k) 4 W N = e -j2π/n 2 Note that W N k = 0 but

More information

Computer Problems for Taylor Series and Series Convergence

Computer Problems for Taylor Series and Series Convergence Computer Problems for Taylor Series and Series Convergence The two problems below are a set; the first should be done without a computer and the second is a computer-based follow up. 1. The drawing below

More information

MATH 415, WEEKS 7 & 8: Conservative and Hamiltonian Systems, Non-linear Pendulum

MATH 415, WEEKS 7 & 8: Conservative and Hamiltonian Systems, Non-linear Pendulum MATH 415, WEEKS 7 & 8: Conservative and Hamiltonian Systems, Non-linear Pendulum Reconsider the following example from last week: dx dt = x y dy dt = x2 y. We were able to determine many qualitative features

More information

Physically Based Modeling Differential Equation Basics

Physically Based Modeling Differential Equation Basics Physically Based Modeling Differential Equation Basics Andrew Witkin and David Baraff Pixar Animation Studios Please note: This document is 2001 by Andrew Witkin and David Baraff. This chapter may be freely

More information

Mass on a Horizontal Spring

Mass on a Horizontal Spring Course- B.Sc. Applied Physical Science (Computer Science) Year- IInd, Sem- IVth Subject Physics Paper- XIVth, Electromagnetic Theory Lecture No. 22, Simple Harmonic Motion Introduction Hello friends in

More information

MATH 241 Practice Second Midterm Exam - Fall 2012

MATH 241 Practice Second Midterm Exam - Fall 2012 MATH 41 Practice Second Midterm Exam - Fall 1 1. Let f(x = { 1 x for x 1 for 1 x (a Compute the Fourier sine series of f(x. The Fourier sine series is b n sin where b n = f(x sin dx = 1 = (1 x cos = 4

More information

Rolle s Theorem. The theorem states that if f (a) = f (b), then there is at least one number c between a and b at which f ' (c) = 0.

Rolle s Theorem. The theorem states that if f (a) = f (b), then there is at least one number c between a and b at which f ' (c) = 0. Rolle s Theorem Rolle's Theorem guarantees that there will be at least one extreme value in the interior of a closed interval, given that certain conditions are satisfied. As with most of the theorems

More information

Lies My Calculator and Computer Told Me

Lies My Calculator and Computer Told Me Lies My Calculator and Computer Told Me 2 LIES MY CALCULATOR AND COMPUTER TOLD ME Lies My Calculator and Computer Told Me See Section.4 for a discussion of graphing calculators and computers with graphing

More information

Periodic Motion. Periodic motion is motion of an object that. regularly repeats

Periodic Motion. Periodic motion is motion of an object that. regularly repeats Periodic Motion Periodic motion is motion of an object that regularly repeats The object returns to a given position after a fixed time interval A special kind of periodic motion occurs in mechanical systems

More information

Fig. 1: Fourier series Examples

Fig. 1: Fourier series Examples FOURIER SERIES AND ITS SOME APPLICATIONS P. Sathyabama Assistant Professor, Department of Mathematics, Bharath collage of Science and Management, Thanjavur, Tamilnadu Abstract: The Fourier series, the

More information

4. Complex Oscillations

4. Complex Oscillations 4. Complex Oscillations The most common use of complex numbers in physics is for analyzing oscillations and waves. We will illustrate this with a simple but crucially important model, the damped harmonic

More information

A Brief Introduction to Numerical Methods for Differential Equations

A Brief Introduction to Numerical Methods for Differential Equations A Brief Introduction to Numerical Methods for Differential Equations January 10, 2011 This tutorial introduces some basic numerical computation techniques that are useful for the simulation and analysis

More information

a n cos 2πnt L n=1 {1/2, cos2π/l, cos 4π/L, cos6π/l,...,sin 2π/L, sin 4π/L, sin 6π/L,...,} (2)

a n cos 2πnt L n=1 {1/2, cos2π/l, cos 4π/L, cos6π/l,...,sin 2π/L, sin 4π/L, sin 6π/L,...,} (2) Note Fourier. 30 January 2007 (as 23.II..tex) and 20 October 2009 in this form. Fourier Analysis The Fourier series First some terminology: a function f(t) is periodic if f(t + ) = f(t) for all t for some,

More information

Nonlinear Optimization

Nonlinear Optimization Nonlinear Optimization (Com S 477/577 Notes) Yan-Bin Jia Nov 7, 2017 1 Introduction Given a single function f that depends on one or more independent variable, we want to find the values of those variables

More information

2.3 Damping, phases and all that

2.3 Damping, phases and all that 2.3. DAMPING, PHASES AND ALL THAT 107 2.3 Damping, phases and all that If we imagine taking our idealized mass on a spring and dunking it in water or, more dramatically, in molasses), then there will be

More information

MB4018 Differential equations

MB4018 Differential equations MB4018 Differential equations Part II http://www.staff.ul.ie/natalia/mb4018.html Prof. Natalia Kopteva Spring 2015 MB4018 (Spring 2015) Differential equations Part II 0 / 69 Section 1 Second-Order Linear

More information

Physically Based Modeling: Principles and Practice Differential Equation Basics

Physically Based Modeling: Principles and Practice Differential Equation Basics Physically Based Modeling: Principles and Practice Differential Equation Basics Andrew Witkin and David Baraff Robotics Institute Carnegie Mellon University Please note: This document is 1997 by Andrew

More information

Lecture 10: Powers of Matrices, Difference Equations

Lecture 10: Powers of Matrices, Difference Equations Lecture 10: Powers of Matrices, Difference Equations Difference Equations A difference equation, also sometimes called a recurrence equation is an equation that defines a sequence recursively, i.e. each

More information

MITOCW MITRES18_005S10_DiffEqnsMotion_300k_512kb-mp4

MITOCW MITRES18_005S10_DiffEqnsMotion_300k_512kb-mp4 MITOCW MITRES18_005S10_DiffEqnsMotion_300k_512kb-mp4 PROFESSOR: OK, this lecture, this day, is differential equations day. I just feel even though these are not on the BC exams, that we've got everything

More information

natural frequency of the spring/mass system is ω = k/m, and dividing the equation through by m gives

natural frequency of the spring/mass system is ω = k/m, and dividing the equation through by m gives 77 6. More on Fourier series 6.. Harmonic response. One of the main uses of Fourier series is to express periodic system responses to general periodic signals. For example, if we drive an undamped spring

More information

Sketchy Notes on Lagrangian and Hamiltonian Mechanics

Sketchy Notes on Lagrangian and Hamiltonian Mechanics Sketchy Notes on Lagrangian and Hamiltonian Mechanics Robert Jones Generalized Coordinates Suppose we have some physical system, like a free particle, a pendulum suspended from another pendulum, or a field

More information

Figure 1: Doing work on a block by pushing it across the floor.

Figure 1: Doing work on a block by pushing it across the floor. Work Let s imagine I have a block which I m pushing across the floor, shown in Figure 1. If I m moving the block at constant velocity, then I know that I have to apply a force to compensate the effects

More information

INTRODUCTION TO COMPUTER METHODS FOR O.D.E.

INTRODUCTION TO COMPUTER METHODS FOR O.D.E. INTRODUCTION TO COMPUTER METHODS FOR O.D.E. 0. Introduction. The goal of this handout is to introduce some of the ideas behind the basic computer algorithms to approximate solutions to differential equations.

More information

Topic 5 Notes Jeremy Orloff. 5 Homogeneous, linear, constant coefficient differential equations

Topic 5 Notes Jeremy Orloff. 5 Homogeneous, linear, constant coefficient differential equations Topic 5 Notes Jeremy Orloff 5 Homogeneous, linear, constant coefficient differential equations 5.1 Goals 1. Be able to solve homogeneous constant coefficient linear differential equations using the method

More information

MITOCW watch?v=i0yacday-ww

MITOCW watch?v=i0yacday-ww MITOCW watch?v=i0yacday-ww The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high-quality educational resources for free. To

More information

L = 1 2 a(q) q2 V (q).

L = 1 2 a(q) q2 V (q). Physics 3550, Fall 2011 Motion near equilibrium - Small Oscillations Relevant Sections in Text: 5.1 5.6 Motion near equilibrium 1 degree of freedom One of the most important situations in physics is motion

More information

Computer Problems for Fourier Series and Transforms

Computer Problems for Fourier Series and Transforms Computer Problems for Fourier Series and Transforms 1. Square waves are frequently used in electronics and signal processing. An example is shown below. 1 π < x < 0 1 0 < x < π y(x) = 1 π < x < 2π... and

More information

Numerical Methods in Physics and Astrophysics

Numerical Methods in Physics and Astrophysics Kostas Kokkotas 2 October 17, 2017 2 http://www.tat.physik.uni-tuebingen.de/ kokkotas Kostas Kokkotas 3 TOPICS 1. Solving nonlinear equations 2. Solving linear systems of equations 3. Interpolation, approximation

More information

The Fourier transform allows an arbitrary function to be represented in terms of simple sinusoids. The Fourier transform (FT) of a function f(t) is

The Fourier transform allows an arbitrary function to be represented in terms of simple sinusoids. The Fourier transform (FT) of a function f(t) is 1 Introduction Here is something I wrote many years ago while working on the design of anemometers for measuring shear stresses. Part of this work required modelling and compensating for the transfer function

More information

Advanced Partial Differential Equations with Applications

Advanced Partial Differential Equations with Applications MIT OpenCourseWare http://ocw.mit.edu 8.36 Advanced Partial Differential Equations with Applications Fall 9 For information about citing these materials or our Terms of Use, visit: http://ocw.mit.edu/terms.

More information

arxiv:nlin/ v1 [nlin.cd] 27 Mar 2003

arxiv:nlin/ v1 [nlin.cd] 27 Mar 2003 Complex behavior from a simple physical system: A numerical investigation Robert K. Murawski Stevens Institute of Technology arxiv:nlin/0303065v1 [nlin.cd] 27 Mar 2003 Department of Physics and Engineering

More information

Maps and differential equations

Maps and differential equations Maps and differential equations Marc R. Roussel November 8, 2005 Maps are algebraic rules for computing the next state of dynamical systems in discrete time. Differential equations and maps have a number

More information

Fundamentals of the DFT (fft) Algorithms

Fundamentals of the DFT (fft) Algorithms Fundamentals of the DFT (fft) Algorithms D. Sundararajan November 6, 9 Contents 1 The PM DIF DFT Algorithm 1.1 Half-wave symmetry of periodic waveforms.............. 1. The DFT definition and the half-wave

More information

Vibratory Motion -- Conceptual Solutions

Vibratory Motion -- Conceptual Solutions Vibratory Motion Vibratory Motion -- Conceptual Solutions 1.) An ideal spring attached to a mass m =.3 kg provides a force equal to -kx, where k = 47.33 nt/m is the spring's spring constant and x denotes

More information

Partial Fractions. June 27, In this section, we will learn to integrate another class of functions: the rational functions.

Partial Fractions. June 27, In this section, we will learn to integrate another class of functions: the rational functions. Partial Fractions June 7, 04 In this section, we will learn to integrate another class of functions: the rational functions. Definition. A rational function is a fraction of two polynomials. For example,

More information

ELEG 305: Digital Signal Processing

ELEG 305: Digital Signal Processing ELEG 5: Digital Signal Processing Lecture 6: The Fast Fourier Transform; Radix Decimatation in Time Kenneth E. Barner Department of Electrical and Computer Engineering University of Delaware Fall 8 K.

More information

Perturbation theory for anharmonic oscillations

Perturbation theory for anharmonic oscillations Perturbation theory for anharmonic oscillations Lecture notes by Sergei Winitzki June 12, 2006 Contents 1 Introduction 1 2 What is perturbation theory 1 21 A first example 1 22 Limits of applicability

More information

Chapter 11 - Sequences and Series

Chapter 11 - Sequences and Series Calculus and Analytic Geometry II Chapter - Sequences and Series. Sequences Definition. A sequence is a list of numbers written in a definite order, We call a n the general term of the sequence. {a, a

More information

Solutions to Tutorial for Week 4

Solutions to Tutorial for Week 4 The University of Sydney School of Mathematics and Statistics Solutions to Tutorial for Week 4 MATH191/1931: Calculus of One Variable (Advanced) Semester 1, 018 Web Page: sydneyeduau/science/maths/u/ug/jm/math191/

More information

The lecture of 1/23/2013: WHY STURM-LIOUVILLE?

The lecture of 1/23/2013: WHY STURM-LIOUVILLE? The lecture of 1/23/2013: WHY STURM-LIOUVILLE? 1 Separation of variables There are several equations of importance in mathematical physics that have lots of simple solutions. To be a bit more specific,

More information

000=0 001=1 010=2 011=3 100=4 101=5 110=6 111=7 000=0 100=4 010=2 110=6 001=1 101=5 011=3 111=7

000=0 001=1 010=2 011=3 100=4 101=5 110=6 111=7 000=0 100=4 010=2 110=6 001=1 101=5 011=3 111=7 8 CHAPTER : Fourier Series The second idea behind the FFT concerns how to get the correct h k s into the final DFT s of size. If the subscripts to 7 of the h k s are written in binary form, as shown in

More information

MITOCW ocw f99-lec01_300k

MITOCW ocw f99-lec01_300k MITOCW ocw-18.06-f99-lec01_300k Hi. This is the first lecture in MIT's course 18.06, linear algebra, and I'm Gilbert Strang. The text for the course is this book, Introduction to Linear Algebra. And the

More information

Generating Function Notes , Fall 2005, Prof. Peter Shor

Generating Function Notes , Fall 2005, Prof. Peter Shor Counting Change Generating Function Notes 80, Fall 00, Prof Peter Shor In this lecture, I m going to talk about generating functions We ve already seen an example of generating functions Recall when we

More information

1. Introductory Examples

1. Introductory Examples 1. Introductory Examples We introduce the concept of the deterministic and stochastic simulation methods. Two problems are provided to explain the methods: the percolation problem, providing an example

More information

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Positioning Sytems: Trilateration and Correlation

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Positioning Sytems: Trilateration and Correlation EECS 6A Designing Information Devices and Systems I Fall 08 Lecture Notes Note. Positioning Sytems: Trilateration and Correlation In this note, we ll introduce two concepts that are critical in our positioning

More information

Infinite series, improper integrals, and Taylor series

Infinite series, improper integrals, and Taylor series Chapter 2 Infinite series, improper integrals, and Taylor series 2. Introduction to series In studying calculus, we have explored a variety of functions. Among the most basic are polynomials, i.e. functions

More information

Quadratic Equations Part I

Quadratic Equations Part I Quadratic Equations Part I Before proceeding with this section we should note that the topic of solving quadratic equations will be covered in two sections. This is done for the benefit of those viewing

More information

4. Sinusoidal solutions

4. Sinusoidal solutions 16 4. Sinusoidal solutions Many things in nature are periodic, even sinusoidal. We will begin by reviewing terms surrounding periodic functions. If an LTI system is fed a periodic input signal, we have

More information

Chaos in the Hénon-Heiles system

Chaos in the Hénon-Heiles system Chaos in the Hénon-Heiles system University of Karlstad Christian Emanuelsson Analytical Mechanics FYGC04 Abstract This paper briefly describes how the Hénon-Helies system exhibits chaos. First some subjects

More information

Math Final Exam Review

Math Final Exam Review Math - Final Exam Review. Find dx x + 6x +. Name: Solution: We complete the square to see if this function has a nice form. Note we have: x + 6x + (x + + dx x + 6x + dx (x + + Note that this looks a lot

More information

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Positioning Sytems: Trilateration and Correlation

Designing Information Devices and Systems I Fall 2018 Lecture Notes Note Positioning Sytems: Trilateration and Correlation EECS 6A Designing Information Devices and Systems I Fall 08 Lecture Notes Note. Positioning Sytems: Trilateration and Correlation In this note, we ll introduce two concepts that are critical in our positioning

More information

MITOCW R11. Double Pendulum System

MITOCW R11. Double Pendulum System MITOCW R11. Double Pendulum System The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources for

More information

Non-Convex Optimization. CS6787 Lecture 7 Fall 2017

Non-Convex Optimization. CS6787 Lecture 7 Fall 2017 Non-Convex Optimization CS6787 Lecture 7 Fall 2017 First some words about grading I sent out a bunch of grades on the course management system Everyone should have all their grades in Not including paper

More information

single uniform density, but has a step change in density at x = 0, with the string essentially y(x, t) =A sin(!t k 1 x), (5.1)

single uniform density, but has a step change in density at x = 0, with the string essentially y(x, t) =A sin(!t k 1 x), (5.1) Chapter 5 Waves II 5.1 Reflection & Transmission of waves et us now consider what happens to a wave travelling along a string which no longer has a single uniform density, but has a step change in density

More information

Power series and Taylor series

Power series and Taylor series Power series and Taylor series D. DeTurck University of Pennsylvania March 29, 2018 D. DeTurck Math 104 002 2018A: Series 1 / 42 Series First... a review of what we have done so far: 1 We examined series

More information

University Physics 226N/231N Old Dominion University. Chapter 14: Oscillatory Motion

University Physics 226N/231N Old Dominion University. Chapter 14: Oscillatory Motion University Physics 226N/231N Old Dominion University Chapter 14: Oscillatory Motion Dr. Todd Satogata (ODU/Jefferson Lab) satogata@jlab.org http://www.toddsatogata.net/2016-odu Monday, November 5, 2016

More information

8/19/16. Fourier Analysis. Fourier analysis: the dial tone phone. Fourier analysis: the dial tone phone

8/19/16. Fourier Analysis. Fourier analysis: the dial tone phone. Fourier analysis: the dial tone phone Patrice Koehl Department of Biological Sciences National University of Singapore http://www.cs.ucdavis.edu/~koehl/teaching/bl5229 koehl@cs.ucdavis.edu Fourier analysis: the dial tone phone We use Fourier

More information

Structural Dynamics Prof. P. Banerji Department of Civil Engineering Indian Institute of Technology, Bombay. Lecture - 1 Introduction

Structural Dynamics Prof. P. Banerji Department of Civil Engineering Indian Institute of Technology, Bombay. Lecture - 1 Introduction Structural Dynamics Prof. P. Banerji Department of Civil Engineering Indian Institute of Technology, Bombay Lecture - 1 Introduction Hello, I am Pradipta Banerji from the department of civil engineering,

More information

MITOCW MITRES18_006F10_26_0602_300k-mp4

MITOCW MITRES18_006F10_26_0602_300k-mp4 MITOCW MITRES18_006F10_26_0602_300k-mp4 FEMALE VOICE: The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational

More information

MITOCW 5. Quantum Mechanics: Free Particle and Particle in 1D Box

MITOCW 5. Quantum Mechanics: Free Particle and Particle in 1D Box MITOCW 5. Quantum Mechanics: Free Particle and Particle in 1D Box The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high-quality

More information

Math 251 December 14, 2005 Answer Key to Final Exam. 1 18pt 2 16pt 3 12pt 4 14pt 5 12pt 6 14pt 7 14pt 8 16pt 9 20pt 10 14pt Total 150pt

Math 251 December 14, 2005 Answer Key to Final Exam. 1 18pt 2 16pt 3 12pt 4 14pt 5 12pt 6 14pt 7 14pt 8 16pt 9 20pt 10 14pt Total 150pt Name Section Math 51 December 14, 5 Answer Key to Final Exam There are 1 questions on this exam. Many of them have multiple parts. The point value of each question is indicated either at the beginning

More information

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016

Identification Methods for Structural Systems. Prof. Dr. Eleni Chatzi Lecture March, 2016 Prof. Dr. Eleni Chatzi Lecture 4-09. March, 2016 Fundamentals Overview Multiple DOF Systems State-space Formulation Eigenvalue Analysis The Mode Superposition Method The effect of Damping on Structural

More information

A. Time dependence from separation of timescales

A. Time dependence from separation of timescales Lecture 4 Adiabatic Theorem So far we have considered time independent semiclassical problems. What makes these semiclassical is that the gradient term (which is multiplied by 2 ) was small. In other words,

More information

Math Methods for Polymer Physics Lecture 1: Series Representations of Functions

Math Methods for Polymer Physics Lecture 1: Series Representations of Functions Math Methods for Polymer Physics ecture 1: Series Representations of Functions Series analysis is an essential tool in polymer physics and physical sciences, in general. Though other broadly speaking,

More information

CHAPTER 7: TECHNIQUES OF INTEGRATION

CHAPTER 7: TECHNIQUES OF INTEGRATION CHAPTER 7: TECHNIQUES OF INTEGRATION DAVID GLICKENSTEIN. Introduction This semester we will be looking deep into the recesses of calculus. Some of the main topics will be: Integration: we will learn how

More information

Measuring the Universal Gravitational Constant, G

Measuring the Universal Gravitational Constant, G Measuring the Universal Gravitational Constant, G Introduction: The universal law of gravitation states that everything in the universe is attracted to everything else. It seems reasonable that everything

More information

Part 3.3 Differentiation Taylor Polynomials

Part 3.3 Differentiation Taylor Polynomials Part 3.3 Differentiation 3..3.1 Taylor Polynomials Definition 3.3.1 Taylor 1715 and Maclaurin 1742) If a is a fixed number, and f is a function whose first n derivatives exist at a then the Taylor polynomial

More information

If the symmetry axes of a uniform symmetric body coincide with the coordinate axes, the products of inertia (Ixy etc.

If the symmetry axes of a uniform symmetric body coincide with the coordinate axes, the products of inertia (Ixy etc. Prof. O. B. Wright, Autumn 007 Mechanics Lecture 9 More on rigid bodies, coupled vibrations Principal axes of the inertia tensor If the symmetry axes of a uniform symmetric body coincide with the coordinate

More information

DIFFERENTIAL EQUATIONS COURSE NOTES, LECTURE 2: TYPES OF DIFFERENTIAL EQUATIONS, SOLVING SEPARABLE ODES.

DIFFERENTIAL EQUATIONS COURSE NOTES, LECTURE 2: TYPES OF DIFFERENTIAL EQUATIONS, SOLVING SEPARABLE ODES. DIFFERENTIAL EQUATIONS COURSE NOTES, LECTURE 2: TYPES OF DIFFERENTIAL EQUATIONS, SOLVING SEPARABLE ODES. ANDREW SALCH. PDEs and ODEs, order, and linearity. Differential equations come in so many different

More information