Calculus of variations - Lecture 11

Size: px
Start display at page:

Download "Calculus of variations - Lecture 11"

Transcription

1 Calculus of variations - Lecture 11 1 Introduction It is easiest to formulate the calculus of variations problem with a specific example. The classical problem of the brachistochrone (1696 Johann Bernoulli) is the search to find the path which a falling object must take to travel between two points in minimum time. Figure 1 shows the geometry. The path we seek is given by y(x) in the 2-D plane. The arc length of an element on this path is; (x 1, y ) 1 Path1 M Path2 (x, y ) 2 2 Figure 1: The geometry, showing various paths in order to find the one where a falling object moves in minimum time between the points dl = dx 2 + dy 2 = dx 1 + (y ) 2 The time to travel over the element is, dt = dl/v (x), where V (x) is the velocity. The total time between the points is; x (y ) t = dx 2 x 1 V (x) We are to find the function, y(x), which results in a minimum of t. The particle moves in a gravitational field which determines V (x). This particular problem may be reduced by using conservation of energy. Assume that the gravitational field is constant which produces a constant acceleration, g. Thus the potential energy due to the gravitational field increases linearly proportional to vertical height. The total energy(potential plus kinetic energies) is conserved. Therefore; 1

2 (1/2)MV 2 + Mgy = constant The mass of the object, M, starts from rest where the initial potential energy is Mgy 1 = constant. (1/2)V 2 = g(y 1 y) Substitution for V into the equation for the time gives; t = 1 x 2 dx 1 + (y ) 2 2g x y1 1 y 2 General Statement of the problem Before we address the solution of the problem in the last, section use this example to write a general statement of the problem. Suppose a function of the form, L(x, y(x), y (x)). This is inserted in the integral; x 2 I = dx L x 1 Now find the function, y (x), which causes I to have an extremum, ie either a maximum, minimum, or inflection point. Suppose the solution has the form, y (x), and provide the variation in the path, y (x) by another function, η(x). Write this as; y(x) = y (x) + λ η(x) The constant, λ, determines the amount of the arbitrary function η(x) added to the correct function we seek. Note that η(x 1 ) = η(x 2 ) = as the path has fixed end points, which are the boundary conditions. In general, I, is a function of λ so dλ di =. x2 di dλ = = dx [ L y x 1 y λ + y L y λ ] Then y y = η(x) and λ λ = η (x). Put this back in the equation for dλ di and integrate the second term by parts. x 2 dx L y x 1 y λ = [ L y η(x)] x 2 x 1 x 2 dx d x 1 dx ( L y ) η(x) The surface term vanishes using the boundary conditions, so the final result for the integral is; 2

3 x2 di dλ = = dx [ L x 1 y dx d ( L y )]η(x) The function η(x) is arbitrary, so the integrand itself must vanish. [ L y d dx ( L y )] = This is the Euler-Lagrange equation. It is a differential equation whose solution is the function, y(x). There are several forms of this equation which can be obtained for special cases. In the case where L = L(x, y) L y = L = f(x) any function of x In the case where L = L(x, y ) d dx [ L y ] = L y = constant L = cy + f(x) In the case where L = L(y, y ) Use the identity; d f dx [y y f] = y [ f y dx d ( f y )] f x Then if f x = and y d L [y dx y L] = [y y L L] = constant 3 Brachistochrone Return to the original problem, 3

4 L = 1 + y 2 y1 y L is independent of x. Thus from the last section; [y L y L] = constant Substitution where the constant is defined by c; y 2 (1 + y 2 ) 1 + y 2 y 1 y = c y 2 = 1 c2 (y 1 y) c 2 (y 1 y) The equation may be solved by integration using a constant a; x = y1 y dy a (y1 y) Let (y 1 y) = a sin 2 (θ/2). Then after integration; y = y 1 a sin 2 (θ/2) = y 1 (a/2)(1 cos(θ)) This is the parametric equation of a cycloid which is produced by a point on a circle rolling on a flat surface. 4 Geodesics Suppose we want the arc of minimum length connecting 2 points on a surface in 3-D. In this case we suppose two parameters to obtain the parametric equations; x = x(u, v) y = y(u, v) z = z(u, v) As an example, the spherical surface has r = constant, with variables, θ and φ. A surface is defined by the function. g(x, y, z) = and the arc length is; dl 2 = dx 2 + dy 2 + dz 2 4

5 As the surface depends on the variables, (u, v), we can expand dx to be; dx = u x du + x v dv There are similar expressions for dy and dz. These are substituted into the expression for the square of the elemental length; dl 2 = P du 2 + 2Q du dv + R dv 2 P = ( x u )2 + ( y u )2 + ( u z )2 Q = x u x v + y y u v + u z z v R = ( x v )2 + ( y v )2 + ( v z )2 The length of the arc is then; u 2 I = du P + 2Q v + R v 2 u 1 Derive the Euler-Lagrange equations with the integrand defined by; L = P + 2Q v + R v 2 It is useful here to focus the example on spherical coordinates. In this case; x = a sin(v) cos(u) y = a sin(v) sin(u) x = a cos(v) P = a 2 sin 2 (v) Q = R = a 2 L = a sin 2 (v) + v 2 L is independent of u ( x u in the previous development and y v ). The Euler- Lagrange equation is; 5

6 v L v L = constant Use the above value for L, differentiate, and collect terms. v 2 = a sin 4 (v) sin 2 (v) Solve the ode by integration. v 2 u = dv v 1 1 a sin4 (v) sin 2 (v) sin(u B) = A cot(v) In this equation, A and B are constants. The expression can be shown to represent an arc in a plane which passes through the center of the sphere ie a great circle. 5 Lagrange Multipliers Suppose a function, f(x, y, z). For f to be an extrememum; df = f f f dx + dy + x y z dz = f d s = and f must not change in any of the 3 directions. Thus; f x = f y = f z = Suppose the variables are subject to a constraint, g(x, y, z) = z h(x, y) =. That is solve g for one of the variables, which could be substituted into f reducing the degrees of freedom. However, using g as a constraint, consider H = f + λg. dh = df + λdg dh = [ f x + λ g ]dx + [ f x y + λ g ]dy + [ f y z + λ g z ]dz Because of the constraint, f x f y f z Choose the constraint parameter λ so that g = z z(x, y). [ f z + λ g z ] = [ f z + λ] = 6

7 y = yo y. A B. Figure 2: Constraining the search for a maximum in f by the function y = y. Contours represnet the lines of equal magnitude x [ f x + λ g ]dx + [ f x y + λ g y ]dy = Since x and y are independent; [ f x + λ g x ] = f y + λ g y = The choice of λ provides dh =. Thus we have the equations; [ f x + λ g x ] = [ f y + λ g y ] = [ f z ] + λ = For a set of N constraints, we expect the equations; f + N x i k=1 λ k g k x i = The λ k are the Lagrange multipliers and these do not have to be explicitedly determined. Figure 2 shows the result of constraining the function, f, by the equation y = y when looking for a maximum. The maximum at A shifts to the maximum at B along the constraint curve. 7

8 x y d Figure 3: An example of a hanging cable 6 Example A cable of length L hangs between two points at the same height on walls a distance, d, apart. This is illustrated in Figure 3. Note that the gravitational potential energy (PE) must minimize in the equilibrium position. Let λ be the mass per unit length of the cable. PE = g(λ dl) y(x) = gλ dl 2 = dx 2 [1 + ( dy dx )2 ] PE = gλ d dxy[ 1 + y 2 ] d dx( dl dx ) y L = y[ 1 + y 2 ] The length of the cable is the constraint. L = dl = d dx 1 + y 2. Let G = 1 + y 2, and employ a Lagrange multipier to include the constraint. H = L + ηg Note that L = y G and H is independent of x. The Euler-Lagrange equation is then; y H y H = constant Substitute for H, write the constant as c, and collect terms. 8

9 y = ±[(1/c 2 )(y + ǫ) 2 1] 1/2 The slope changes direction as the position varies x d. Integrate the equation to find the position, x. x = c[cosh 1 ( y + η c ) cosh 1 (η/c)] x d/2 Invert this equation to obtain; y = c cosh[(x/c) + cosh 1 (η/c)] η/c At the midpoint the slope is zero, so d/2c = cosh 1 (η/c). Then let c = γ so that η = γ cosh(d/2γ) Find the value of γ using the constraint on the length. L/2 = d/2 dx 1 + y 2 = The above is integrated to give; d/2 dx [1 + sin 2 (d/2 x)2 ( γ )] 1/2 L/2 = γ sinh(d/2γ) Substitute in the above equation for y to obtain the solution to the problem. 7 Electrostatics - Minimizing energy The electric field is obtained from the potential function, φ(x, y, z), by partial differentiation, E = φ. The energy density contained in the field is; dw d(v olume) = ǫ 2 E E The field is obtained by the charge densities as they arrange themselves on a conducting surface to obtain an equi-potential. This produces an energy minimum subject to constraints of the electrostatic problem. Thus; W = (ǫ/2) dτ φ 2 Look for an extrememum of this integral. The integrand is L = L(φ x, φ y, φ z ). Now introduce a constraint η(x, y, z) and define; 9

10 V i = L i + λ η i The potential is constant (boundary condition), η i = on the conducting surfaces, i = x, y, z. The extrememum is obtained by dw =. This results in the Euler-Lagrange dη equation which in this case is Laplace s equation. 2 V i x 2 i = Then as a simple example, choose a set of functions, V = V (r/b) p with p < so that the potential converges as r. We are to minimize W with respect to p. Substitute; W = V 2 1 ǫ 2b 2p W = 2πV 2 1 p 2 b 2(2p + 1) b r 2 dr(p r p 1 ) 2 dω dw = (2πV 2 + 1) dp 1 b)p(p 2p + 1 = The solutions are p =, 1 so V = V 1 (r/b) 1. In this case we have an exact solution since the function is a solution to Laplace s equation. W = V 2 1 b/2 However suppose we had chosen a function of the form, V = V 1 e α(r b)/b. This does not satisfy Laplace s equation but does satisfy the boundary condition. Put this form into the integral to find the value of W. W = πv 2 1 ǫb α [1 + (1/2α2 )(2α + 1)] dw dα = (πǫv 2 1 b) [ln(α) 1/α 1/4α 2 ] = α 1.85 W 1.23(V 2 1 b/2) Compare this to the exact answer above. This technique provides an approximation method which will be explored later. 1

11 s L ε h Figure 4: The geometry of the capacitor problem 8 Example A capacitor is charged, then dipped into a dielectric fluid. The fluid is drawn up into the capacitor. No dissipation is assumed, so energy is conserved. A cross section of the geometry is shown in Figure 4. The width of the capacitor out of the page is a. Assume the separation of the plates, s is the length of the plates, L, and a simple parallel plate capacitor is assumed (ie the fringe fields are neglected). The fluid density is ρ, and has dielectric constant, ǫ = ǫ r ǫ. The capacitor is disconnected from the charging voltage before dipping into the fluid. The charge on the capacitor plates does not change, but redistributes as the voltage on the plates changes as the fluid rises between the plates. Energy then is drawn from the capacitor to raise the fluid against gravity. First find the potential energy of the fluid raised to height, h. Potential Energy (PE) = dm = ρ as dy PE = asρgh 2 /2 h dm g y The capacitance of a simple parallel plate capacitor is C = A ǫ/s where A is the plate area, s their separation, and ǫ the dielectric constant. The energy stored in the capacitor is 11

12 W C = (1/2)CV 2 = (1/2)Q 2 T /C, where V is the voltage, and Q T the stored charge. In this problem the capacitor is charged and disconnected from the voltage. The total charge on the plates remains on the plates but redistributes as the fluid is drawn up into the plates. However, the voltage between the plates changes. Use the energy W = (1/2)Q 2 /C. The capacitor is viewed as 2 capacitors in parallel - one with dielectric, ǫ = ǫ r ǫ, and one with dielectric, ǫ. The energy stored in this final capacitor system is; W fc = (1/2)[ Q2 1 C 1 + Q2 2 C 2 ] C 1 = ahǫ s C 2 = a(l h)ǫ s There is a constraint that Q T = Q 1 +Q 2. Write the equation for the conservation of system energy as; W = (1/2) Q2 Ts alǫ asρgh2 2 + (1/2) aǫ s [ Q2 1 + Q2 2 hǫ r (L h) ] Solve for the equilibrium height, h, subject to the constraint Q T = Q 1 + Q 2. One could use this constraint with the definitions of the capacitance and conservation of energy to reduce the above equation into a variable of h alone, and then set the derivative of the energy to zero to find h. We solve the problem here using Lagrange multipliers. Define the constraint condition as f = Q T Q 1 Q 2 =, multiply this by a Lagrange multiplier λ and subtract from the energy equation above. Then take the 4 partial derivatives; W = asρgh + (1/2) s h aǫ [ Q2 1 ǫ r h 2 W Q T = Q Ts alǫ λ = W = sq 1 + λ = Q 1 ahǫ ǫ r W sq = 1 + λ = Q 2 a(l h)ǫ ǫ r Q 2 1 (L h) 2 ] = Solve these equations. The partials with respect to the Q s introduce the conservation of charge. The final result is; h = W C ǫ ρ(volume)g [ǫ r 1] 9 Least Action Suppose the motion of a body between two points, A and B. The motion can be along any path which keeps the energy conserved, see Figure 5. In general the time required to travel 12

13 B Path 2 A Path1 Figure 5: Possible paths for a particle to travel in space-time between A and B the different paths is not the same. From Newton s laws; d dt [m i d r i dt ] = F i The index i represents the i th particle, with m i the mass, r i its displacement, and F i the force. Now let δ r i be a displacement of the particle from its path. Then; i d dt [m i d r i dt ] δ r i = i F i δ r i This can be manipulated into the form below. Use; dδr i dt = δ dr i dt + dr i dt dδt dt Then; d dt [ i m i d r i dt δ r i] δ i (1/2) m i v 2 i i m i v 2 i d(δt) dt = i F i δ r i The change in potential energy is, δv = i 1/2 m i vi 2. The final result is; i d dt [ i m i d r i dt δ r i] = δ(t V ) + 2T d dt δt F i δ r i, and the kinetic energy is T = T + V = constant so δt = δv. Integrate the power over time ; 13

14 t 2 t 1 dt d dt [ i m i d r i dt r i] = t 2 t 1 dt [δ(2t) + 2T d dt (δt)] Require all paths to arrive at the same time; t2 δ dt (2T) = t 1 This is the principle of least action. It states that among all paths between 2 points in space, the path which is chosen is the one in which the time is an extrememum. 1 An alternative development of least action Suppose a system of particles moving with time, t i, subject to a potential energy field, V (q i, ). Here i labels the particle, and V in general depends on all q i. The system is conservative, ie energy is conserved. K.E. + P.E. = Constant. The Kinetic energy, T(q i,, q i,...) changes with position. Now suppose all paths between two points such that energy is conserved. The travel time for such paths is not the same, in general. Thus consider the inegral; t 2 A = dt T t 1 Assume the all paths begin at time, t 1, but because we wish to vary the transit time, they do not arrive at the same point at the same time. Thus make a variable change u = u(t) so that the values of u(t 1 ) and u(t 2 ) are the same for all paths. Then remove the explicit time dependence from the energy terms. dt = du u dq i dt = q i = dq i du u = q iw w = u T = (1/2)m i v 2 i = (1/2)m i q 2 i w 2 = w 2 T A = 2 u(t 2 ) u(t 1 ) du T w 2 14

15 T = T(q i,, q i, ) Energy conservation is; w 2 T + V = E The potential, V, is a function only of position, and the explicit time dependence in the kinetic energy has been removed. Now find the extremum in the time for various paths, ie with respect to the functions, q, w, with the conservation of energy as a constraint. Use Lagrange multipliers for the constraint to write the function; L = 2wT + λ[w 2 T + V E] L is independent of ẇ so L w = 2T + λ2wt = 2w T q i + λw 2 T q i + V q i = d du [(2w + λw2 ) T q i ] This gives a set of equations for all i. Solve and remove the dependence on the Lagrange multiplier. Use the definition of w. (T V ) q i = d dt [ q i (T V )] Note that T V is the Lagrangian, L. Thus the principle of least action leads to the Lagrange equations for the motion of a system of particles. 11 Example Suppose a particle moves subject to no applied forces. There will then be no potential energy, and the kinetic energy enerqy is constant. δt = δv = The position as a function of time is x(t). Therefore using the form for the velocity u = dx dt, the Euler-Lagrange equation is; T x d dt ( T u ) = 15

16 T = (1/2)µ 2 m d u dt = t u = µ u = constant 12 Example - Fermat s principle Suppose the path of light in a medium has a velocity, u(y). The time for a ray to travel from (x 1, y 1 ) to (x 2, y 2 ) is; t = (x 2,y 2 ) (x 1,y 1 ) dl/u = (x 2,y 2 ) (x 1,y 1 ) dx (1 + y,2 ) u This is the brachistochrone problem with Euler-Lagrange equation; y f y f = c with c a constant. Substitution for the value of f gives; 1 u 1 + y 2 = c Here, rays of equal time have the same phase. If we think about all possible paths, there is a large number with nearly the same phase around the stationary point. Thus in the formulation of Quantum Theory, the probability of the stationary path is the largest. 13 Hamilton s principle Consider a system of particles subject to constaints. Develop the equations of motion using least action. ddt [m i d r i dt δ r i] = Fi δ r i In the above δ r i is an arbitrary displacement subject to constraints. The equation of least action is obtained. ddt [m i d r i dt δ r i] = δ(t V ) + 2T d dt (δt) If paths are traced which have equal times then the last term on the right vanishes. 16

17 m d r i i dt δ r i t t t = δ dt (T V ) t t However, if all times are the same then δ dt(t V ) =. This is Hamilton s principle, t and L = T V is the Lagrangian. In general the Lagrangian is a function of the coordinates, q i and the time derivatives, q i. The Euler Lagrange equations for the Lagrangian, L, is; L g i d dt [ L q i ] = Now L is independent of the parameter, t. Thus we obtain; d dt [ q L q L] = The potential is only a function of the coordinates so V q = ; qi T qi = 2T Then look at L = q i T qi L = 2T T + V = T + V = Total Energy. Now define; H = p i q i L In the above p i = T q i. The function H is the Hamiltonian of the system. Then; H pj = q j + p i q i p j L qi q i p j = q i H = T qi q i L = T + V H is the system energy. Then look for the extrememum of the integral; t 2 I = dt L = dt [ p i q i H] t 1 Here p i and q i are considered independent variables. Introduce the constraint; q i H p i =. This is included by Lagrange multipliers, λ k. We obtain the modified Lagrangian; f = p i q i H + λ k [ q k H p k ] This produces a set of Euler Lagrange equations; 17

18 f p d f = i dt ṗ i f q i d dt f q i = Which give the following equations; q i H λ 2 H p k = i p i p k H λ 2 H q k i q i p d k dt [p i + λ i ] = We find that 2 H = so choose the solution, λ p i p k =. This produces the relation k between conjugate variables. ṗi = H q i q i = H pi This system of equations constitute Hamilton s formulation of the laws of motion. It is now useful to compare Hamilton s principle to the principle of least action. In Hamilton s principle, all paths are traveled in the same time. In the principle of least action the energy is kept constant over the given path. 14 Example A particle is constrained to move in a vertical circle under the gravitational force. The potential energy, PE, is; PE = mgr[1 + sin(θ)] The kinetic energy, KE, is; KE = (1/2)mv 2 = (1/2)m[ṙ 2 + r 2 θ] The constraint is that r = R a constant. Construct the Lagrangian, L = T V. L = (1/2)m[ṙ 2 + r 2 θ] mgr[1 + sin(θ)] The Lagrangian has variables, L(r, θ, ṙ, θ). Introduce the constraint using the Lagrange multiplier. The equations of motion are; 18

19 L = L + λ(r R ) L r d dt [ L ṙ ] = L θ d dt [ L θ ] = This produces the equations; mg[1 + sin(θ)] + λ d dt [mṙ] = mgr cos(θ) d dt [m θr 2 ] = r = r = ṙ = R θ + t cos(θ) = λ = mg[1 + sin(θ)] On the other hand, since L is independent of the parameter t; L ṙ L ṙ = constant This just results in the conservation of energy. The total energy is then; W = (1/2)mr 2 θ2 mgr [1 + sin(θ)] As this now results in a first order ode, the equation can be easily integrated. 15 Example A box on mass,m, slides down an incline plane of length, L, and mass, M, which is itself is able to slide horizontally. Choose the coordinates along the sloping edge of the slide to be s, and the horizontal direction of its motion to be, x. The kinetic energy of the slide is (1/2)Mẋ 2. The velocity of the box is; v = ( dx dt ds cos(θ))ˆx ds dt dt sin(θ) ŷ The total kinetic energy is then; KE = (1/2)M[ dx dt ]2 + (1/2)m[( dx dt ds dt cos(θ))2 + ( ds dt sin(θ))2 ] 19

20 s m θ M x Figure 6: The geometry of a block sliding of a moveable wedge The potential energy is, PE = mgs sin(θ) The Lagrangian is L = T V = (1/2)(M + m)( dx dt )2 m dx dt ds cos(θ) + (1/2)m(ds dt dt )2 + mgs sin(θ) Apply the Euler Lagrange formulation for the minimization to obtain the two equations; d [(M + m)(dx dt dt ) mds dt cos(θ)] = d dt [ mdx dt cos(θ) + mgds] mg sin(θ) = dt Integrate the first equation above which represents conservation of momentum. (M + m)( dx dt ) mds dt = C 1 Assume the system starts at rest and C 1 = then a second integration gives; (M + m)x ms cos(θ) = C 2 Choose x = s = when t = so that C 2 =. Then integrate the second equation above using the initial conditions. ( dx dt Eliminate dx dt cos(θ) + ds ) gt sin(θ) = dt and integrate again to obtain; s = [ M + m M = m sin 2 (θ) ]gt2 2 sin(θ) 2

21 The position, x, can be obtained by substitution in an above equation. The time for the box to slide to the bottom when s = L is; t = 2L g sin(θ) [(M + m) sin2 (θ) ] M + m 16 Relativistic Lagrangian formulation We wish a Lagrangian which reproduces the relativistic equations of motion. We choose; L = mc 2 [1 1 β 2 ] V ( r) In the above β is the particle velocity in units of the velocity of light, c, and the potential is V ( r). The potential itself is a scalar function and the argument r simply means it depends on all 3 coordinates. Apply the Euler Lagrange equations; d dt [ ẋ L ] L = i x i Note that ẋ i = v i and r = x i ˆx i. Substitute into the Euler Lagrange equations to obtain; d dt [γmc β] = V + F The relativistic momentum is γmc β, and the time change of the momentum is the force. 17 Eigenfunction problem Consider finding the extrememum of an integral,i, by varying the function f(x). x 2 I = dx [τf 2 µf 2 ] + a 1 f 2 + a 2 f 2 x 1 The function, f, must satisfy the condition, dxσ f 2 (x) = 1. This is a normalization x 1 condition. the other functions, τ(x) and σ(x) satisfy normal differentiable conditions, and a i are non-negative constants. The above can be written; x 2 I = dx [τf 2 µf 2 + d x 1 dx (af2 )] The function f is changed to include the constraint by f f + λ σf 2, where λ are the Lagrange multipliers. Apply the Euler Lagrange equation to obtain; x 2 21

22 d dx [τf + (µ + λσ)f] = This results in a Sturm-Liouville equation in self adjoint form. Suppose we choose τ = x, µ = n 2 /x, and σ = x. Make the substitution, z = λx and x 1 =. The result is Bessel s equation with solution, J n (z); z 2 d 2 f dz 2 + z df dz + (z2 n 2 )f = < z < x 2 λ 18 Ritz method Assume an eigenvalue problem and arrange the eigenvalues, λ 1 < λ 2 <. Note that the eigenfunction, f n, is associated with eigenvalue, λ n. The eigenfunction, f n, minimizes the integral, I, subject to a normalization constraint. Suppose we expand the function, φ(x), which will be taken as a trial solution, in terms of f n. φ = c n f n c n = x 2 dxσ f n φ Require, c 1 = c 2 = = c k 1 =. The normalization requirement is; x 2 dxσf 2 = x 2 c n dxσφf = c 2 n = 1 Substitute into I without the normalization constraint. I = x 2 c n dx [τφ f n µφf n ] Integration by parts and ignoring the surface terms; I = x 2 c n dxφ[ d dx (τf n ) + µf n] Now f n satisfies the ode of the eigenvalue problem. Thus I = x 2 I = c 2 n λ n dxφλ n σf n 22

23 However, c n = for n < k and λ n > λ k so that I is a minimum when λ = λ k. Thus the minimization of I yields an eigenvalue λ k 19 Example Suppose the equation; y + λy = the solution is y = A sin( λx) + B cos( λx). The boundary conditions are chosen to be y() = 1 and y(1) =. Thus A =, and λ = π/2. For the lowest eigenvalue; y 1 = cos(πx/2) Then take a trial function, y = 1 x a, as a potential solution. This function satisfies the boundary conditions. We want to choose the best value for a. The normalization condition requires that; 1 dxy n = 1 Put this back into the value of I and integrate. I = 1 1 dxy[ d dx y ] dxy 2 dx The term in the denominator is the normalization integral. The result is; I = Then take I a (2a + 1)(a + 1) 2(2a 1) = which gives; a = 1 ± 1 + (4)5/4 2 [ ].7247 a =

24 The negative value cannot satisfy the boundary condition. Thus I = Note that the true value is (π/2) 2 =

Calculus of variations - Lecture 11

Calculus of variations - Lecture 11 Calculus of variations - Lecture 11 1 Introuction It is easiest to formulate the problem with a specific example. The classical problem of the brachistochrone (1696 Johann Bernoulli) is the search to fin

More information

Lecture Notes for PHY 405 Classical Mechanics

Lecture Notes for PHY 405 Classical Mechanics Lecture Notes for PHY 45 Classical Mechanics From Thorton & Marion s Classical Mechanics Prepared by Dr. Joseph M. Hahn Saint Mary s University Department of Astronomy & Physics October 11, 25 Chapter

More information

Classical Mechanics Review (Louisiana State University Qualifier Exam)

Classical Mechanics Review (Louisiana State University Qualifier Exam) Review Louisiana State University Qualifier Exam Jeff Kissel October 22, 2006 A particle of mass m. at rest initially, slides without friction on a wedge of angle θ and and mass M that can move without

More information

CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS. Prof. N. Harnew University of Oxford TT 2017

CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS. Prof. N. Harnew University of Oxford TT 2017 CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS Prof. N. Harnew University of Oxford TT 2017 1 OUTLINE : CP1 REVISION LECTURE 3 : INTRODUCTION TO CLASSICAL MECHANICS 1. Angular velocity and

More information

The Principle of Least Action

The Principle of Least Action The Principle of Least Action In their never-ending search for general principles, from which various laws of Physics could be derived, physicists, and most notably theoretical physicists, have often made

More information

Solution Set Two. 1 Problem #1: Projectile Motion Cartesian Coordinates Polar Coordinates... 3

Solution Set Two. 1 Problem #1: Projectile Motion Cartesian Coordinates Polar Coordinates... 3 : Solution Set Two Northwestern University, Classical Mechanics Classical Mechanics, Third Ed.- Goldstein October 7, 2015 Contents 1 Problem #1: Projectile Motion. 2 1.1 Cartesian Coordinates....................................

More information

Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction

Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction D. S. Stutts, Ph.D. Associate Professor of Mechanical Engineering Missouri University of Science and Technology Rolla,

More information

Lecture 6, September 1, 2017

Lecture 6, September 1, 2017 Engineering Mathematics Fall 07 Lecture 6, September, 07 Escape Velocity Suppose we have a planet (or any large near to spherical heavenly body) of radius R and acceleration of gravity at the surface of

More information

28. Pendulum phase portrait Draw the phase portrait for the pendulum (supported by an inextensible rod)

28. Pendulum phase portrait Draw the phase portrait for the pendulum (supported by an inextensible rod) 28. Pendulum phase portrait Draw the phase portrait for the pendulum (supported by an inextensible rod) θ + ω 2 sin θ = 0. Indicate the stable equilibrium points as well as the unstable equilibrium points.

More information

Chapter 10 Notes: Lagrangian Mechanics

Chapter 10 Notes: Lagrangian Mechanics Chapter 10 Notes: Lagrangian Mechanics Thus far we have solved problems by using Newton s Laws (a vector approach) or energy conservation (a scalar approach.) In this chapter we approach the subject in

More information

N mg N Mg N Figure : Forces acting on particle m and inclined plane M. (b) The equations of motion are obtained by applying the momentum principles to

N mg N Mg N Figure : Forces acting on particle m and inclined plane M. (b) The equations of motion are obtained by applying the momentum principles to .004 MDEING DNMIS ND NTR I I Spring 00 Solutions for Problem Set 5 Problem. Particle slides down movable inclined plane. The inclined plane of mass M is constrained to move parallel to the -axis, and the

More information

Physics 200 Lecture 4. Integration. Lecture 4. Physics 200 Laboratory

Physics 200 Lecture 4. Integration. Lecture 4. Physics 200 Laboratory Physics 2 Lecture 4 Integration Lecture 4 Physics 2 Laboratory Monday, February 21st, 211 Integration is the flip-side of differentiation in fact, it is often possible to write a differential equation

More information

VARIATIONAL PRINCIPLES

VARIATIONAL PRINCIPLES CHAPTER - II VARIATIONAL PRINCIPLES Unit : Euler-Lagranges s Differential Equations: Introduction: We have seen that co-ordinates are the tools in the hands of a mathematician. With the help of these co-ordinates

More information

Hamiltonian. March 30, 2013

Hamiltonian. March 30, 2013 Hamiltonian March 3, 213 Contents 1 Variational problem as a constrained problem 1 1.1 Differential constaint......................... 1 1.2 Canonic form............................. 2 1.3 Hamiltonian..............................

More information

Lecture Notes for PHY 405 Classical Mechanics

Lecture Notes for PHY 405 Classical Mechanics Lecture Notes for PHY 405 Classical Mechanics From Thorton & Marion s Classical Mechanics Prepared by Dr. Joseph M. Hahn Saint Mary s University Department of Astronomy & Physics September 1, 2005 Chapter

More information

The Brachistochrone Curve

The Brachistochrone Curve The Brachistochrone Curve Paige R MacDonald May 16, 2014 Paige R MacDonald The Brachistochrone Curve May 16, 2014 1 / 1 The Problem In 1696, Johann Bernoulli posed the following problem to the scientific

More information

Physics 235 Chapter 7. Chapter 7 Hamilton's Principle - Lagrangian and Hamiltonian Dynamics

Physics 235 Chapter 7. Chapter 7 Hamilton's Principle - Lagrangian and Hamiltonian Dynamics Chapter 7 Hamilton's Principle - Lagrangian and Hamiltonian Dynamics Many interesting physics systems describe systems of particles on which many forces are acting. Some of these forces are immediately

More information

Lecture 5. Alexey Boyarsky. October 21, Legendre transformation and the Hamilton equations of motion

Lecture 5. Alexey Boyarsky. October 21, Legendre transformation and the Hamilton equations of motion Lecture 5 Alexey Boyarsky October 1, 015 1 The Hamilton equations of motion 1.1 Legendre transformation and the Hamilton equations of motion First-order equations of motion. In the Lagrangian formulation,

More information

YET ANOTHER ELEMENTARY SOLUTION OF THE BRACHISTOCHRONE PROBLEM

YET ANOTHER ELEMENTARY SOLUTION OF THE BRACHISTOCHRONE PROBLEM YET ANOTHER ELEMENTARY SOLUTION OF THE BRACHISTOCHRONE PROBLEM GARY BROOKFIELD In 1696 Johann Bernoulli issued a famous challenge to his fellow mathematicians: Given two points A and B in a vertical plane,

More information

Marion and Thornton. Tyler Shendruk October 1, Hamilton s Principle - Lagrangian and Hamiltonian dynamics.

Marion and Thornton. Tyler Shendruk October 1, Hamilton s Principle - Lagrangian and Hamiltonian dynamics. Marion and Thornton Tyler Shendruk October 1, 2010 1 Marion and Thornton Chapter 7 Hamilton s Principle - Lagrangian and Hamiltonian dynamics. 1.1 Problem 6.4 s r z θ Figure 1: Geodesic on circular cylinder

More information

06. Lagrangian Mechanics II

06. Lagrangian Mechanics II University of Rhode Island DigitalCommons@URI Classical Dynamics Physics Course Materials 2015 06. Lagrangian Mechanics II Gerhard Müller University of Rhode Island, gmuller@uri.edu Creative Commons License

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

Forces of Constraint & Lagrange Multipliers

Forces of Constraint & Lagrange Multipliers Lectures 30 April 21, 2006 Written or last updated: April 21, 2006 P442 Analytical Mechanics - II Forces of Constraint & Lagrange Multipliers c Alex R. Dzierba Generalized Coordinates Revisited Consider

More information

Physics 5A Final Review Solutions

Physics 5A Final Review Solutions Physics A Final Review Solutions Eric Reichwein Department of Physics University of California, Santa Cruz November 6, 0. A stone is dropped into the water from a tower 44.m above the ground. Another stone

More information

Mathematical Methods of Physics I ChaosBook.org/ predrag/courses/phys Homework 1

Mathematical Methods of Physics I ChaosBook.org/ predrag/courses/phys Homework 1 PHYS 6124 Handout 6 23 August 2012 Mathematical Methods of Physics I ChaosBook.org/ predrag/courses/phys-6124-12 Homework 1 Prof. P. Goldbart School of Physics Georgia Tech Homework assignments are posted

More information

Physics 6010, Fall 2016 Constraints and Lagrange Multipliers. Relevant Sections in Text:

Physics 6010, Fall 2016 Constraints and Lagrange Multipliers. Relevant Sections in Text: Physics 6010, Fall 2016 Constraints and Lagrange Multipliers. Relevant Sections in Text: 1.3 1.6 Constraints Often times we consider dynamical systems which are defined using some kind of restrictions

More information

Physics 351, Spring 2017, Homework #4. Due at start of class, Friday, February 10, 2017

Physics 351, Spring 2017, Homework #4. Due at start of class, Friday, February 10, 2017 Physics 351, Spring 2017, Homework #4. Due at start of class, Friday, February 10, 2017 Course info is at positron.hep.upenn.edu/p351 When you finish this homework, remember to visit the feedback page

More information

THE BRACHISTOCHRONE CURVE: THE PROBLEM OF QUICKEST DESCENT

THE BRACHISTOCHRONE CURVE: THE PROBLEM OF QUICKEST DESCENT International Journal of Pure and Applied Mathematics Volume 82 No. 3 2013, 409-419 ISSN: 1311-8080 (printed version) url: http://www.ijpam.eu PA ijpam.eu THE BRACHISTOCHRONE CURVE: THE PROBLEM OF QUICKEST

More information

(Most of the material presented in this chapter is taken from Thornton and Marion, Chap. 6)

(Most of the material presented in this chapter is taken from Thornton and Marion, Chap. 6) Chapter 3. Calculus of Variations Most of the material presented in this chapter is taken from Thornton and Marion, Chap. 6 In preparation for our study of Lagrangian and Hamiltonian dynamics in later

More information

Classical Mechanics Comprehensive Exam Solution

Classical Mechanics Comprehensive Exam Solution Classical Mechanics Comprehensive Exam Solution January 31, 011, 1:00 pm 5:pm Solve the following six problems. In the following problems, e x, e y, and e z are unit vectors in the x, y, and z directions,

More information

4.1 Important Notes on Notation

4.1 Important Notes on Notation Chapter 4. Lagrangian Dynamics (Most of the material presented in this chapter is taken from Thornton and Marion, Chap. 7) 4.1 Important Notes on Notation In this chapter, unless otherwise stated, the

More information

Lecture 4. Alexey Boyarsky. October 6, 2015

Lecture 4. Alexey Boyarsky. October 6, 2015 Lecture 4 Alexey Boyarsky October 6, 2015 1 Conservation laws and symmetries 1.1 Ignorable Coordinates During the motion of a mechanical system, the 2s quantities q i and q i, (i = 1, 2,..., s) which specify

More information

CANONICAL EQUATIONS. Application to the study of the equilibrium of flexible filaments and brachistochrone curves. By A.

CANONICAL EQUATIONS. Application to the study of the equilibrium of flexible filaments and brachistochrone curves. By A. Équations canoniques. Application a la recherche de l équilibre des fils flexibles et des courbes brachystochrones, Mem. Acad. Sci de Toulouse (8) 7 (885), 545-570. CANONICAL EQUATIONS Application to the

More information

Question 1: A particle starts at rest and moves along a cycloid whose equation is. 2ay y a

Question 1: A particle starts at rest and moves along a cycloid whose equation is. 2ay y a Stephen Martin PHYS 10 Homework #1 Question 1: A particle starts at rest and moves along a cycloid whose equation is [ ( ) a y x = ± a cos 1 + ] ay y a There is a gravitational field of strength g in the

More information

Problem Set 2 Solution

Problem Set 2 Solution Problem Set Solution Friday, 1 September 1 Physics 111 Problem 1 Tautochrone given by A particle slides without friction on a cycloidal track x = a(θ sin θ) y = a(1 cos θ) where y is oriented vertically

More information

Transduction Based on Changes in the Energy Stored in an Electrical Field

Transduction Based on Changes in the Energy Stored in an Electrical Field Lecture 6-1 Transduction Based on Changes in the Energy Stored in an Electrical Field Electric Field and Forces Suppose a charged fixed q 1 in a space, an exploring charge q is moving toward the fixed

More information

M2A2 Problem Sheet 3 - Hamiltonian Mechanics

M2A2 Problem Sheet 3 - Hamiltonian Mechanics MA Problem Sheet 3 - Hamiltonian Mechanics. The particle in a cone. A particle slides under gravity, inside a smooth circular cone with a vertical axis, z = k x + y. Write down its Lagrangian in a) Cartesian,

More information

ENGI Partial Differentiation Page y f x

ENGI Partial Differentiation Page y f x ENGI 3424 4 Partial Differentiation Page 4-01 4. Partial Differentiation For functions of one variable, be found unambiguously by differentiation: y f x, the rate of change of the dependent variable can

More information

ESM 3124 Intermediate Dynamics 2012, HW6 Solutions. (1 + f (x) 2 ) We can first write the constraint y = f(x) in the form of a constraint

ESM 3124 Intermediate Dynamics 2012, HW6 Solutions. (1 + f (x) 2 ) We can first write the constraint y = f(x) in the form of a constraint ESM 314 Intermediate Dynamics 01, HW6 Solutions Roller coaster. A bead of mass m can slide without friction, under the action of gravity, on a smooth rigid wire which has the form y = f(x). (a) Find the

More information

Assignment 2. Goldstein 2.3 Prove that the shortest distance between two points in space is a straight line.

Assignment 2. Goldstein 2.3 Prove that the shortest distance between two points in space is a straight line. Assignment Goldstein.3 Prove that the shortest distance between two points in space is a straight line. The distance between two points is given by the integral of the infinitesimal arclength: s = = =

More information

MAT 211 Final Exam. Spring Jennings. Show your work!

MAT 211 Final Exam. Spring Jennings. Show your work! MAT 211 Final Exam. pring 215. Jennings. how your work! Hessian D = f xx f yy (f xy ) 2 (for optimization). Polar coordinates x = r cos(θ), y = r sin(θ), da = r dr dθ. ylindrical coordinates x = r cos(θ),

More information

7 EQUATIONS OF MOTION FOR AN INVISCID FLUID

7 EQUATIONS OF MOTION FOR AN INVISCID FLUID 7 EQUATIONS OF MOTION FOR AN INISCID FLUID iscosity is a measure of the thickness of a fluid, and its resistance to shearing motions. Honey is difficult to stir because of its high viscosity, whereas water

More information

Examples of Dielectric Problems and the Electric Susceptability. 2 A Dielectric Sphere in a Uniform Electric Field

Examples of Dielectric Problems and the Electric Susceptability. 2 A Dielectric Sphere in a Uniform Electric Field Examples of Dielectric Problems and the Electric Susceptability Lecture 10 1 A Dielectric Filled Parallel Plate Capacitor Suppose an infinite, parallel plate capacitor filled with a dielectric of dielectric

More information

The Principle of Least Action

The Principle of Least Action The Principle of Least Action Anders Svensson Abstract In this paper, the principle of least action in classical mechanics is studied. The term is used in several different contexts, mainly for Hamilton

More information

Kinematics (special case) Dynamics gravity, tension, elastic, normal, friction. Energy: kinetic, potential gravity, spring + work (friction)

Kinematics (special case) Dynamics gravity, tension, elastic, normal, friction. Energy: kinetic, potential gravity, spring + work (friction) Kinematics (special case) a = constant 1D motion 2D projectile Uniform circular Dynamics gravity, tension, elastic, normal, friction Motion with a = constant Newton s Laws F = m a F 12 = F 21 Time & Position

More information

Curves in the configuration space Q or in the velocity phase space Ω satisfying the Euler-Lagrange (EL) equations,

Curves in the configuration space Q or in the velocity phase space Ω satisfying the Euler-Lagrange (EL) equations, Physics 6010, Fall 2010 Hamiltonian Formalism: Hamilton s equations. Conservation laws. Reduction. Poisson Brackets. Relevant Sections in Text: 8.1 8.3, 9.5 The Hamiltonian Formalism We now return to formal

More information

Calculus of Variations Summer Term 2014

Calculus of Variations Summer Term 2014 Calculus of Variations Summer Term 2014 Lecture 5 7. Mai 2014 c Daria Apushkinskaya 2014 () Calculus of variations lecture 5 7. Mai 2014 1 / 25 Purpose of Lesson Purpose of Lesson: To discuss catenary

More information

Physics 451/551 Theoretical Mechanics. G. A. Krafft Old Dominion University Jefferson Lab Lecture 18

Physics 451/551 Theoretical Mechanics. G. A. Krafft Old Dominion University Jefferson Lab Lecture 18 Physics 451/551 Theoretical Mechanics G. A. Krafft Old Dominion University Jefferson Lab Lecture 18 Theoretical Mechanics Fall 018 Properties of Sound Sound Waves Requires medium for propagation Mainly

More information

From quantum to classical statistical mechanics. Polyatomic ideal gas.

From quantum to classical statistical mechanics. Polyatomic ideal gas. From quantum to classical statistical mechanics. Polyatomic ideal gas. Peter Košovan peter.kosovan@natur.cuni.cz Dept. of Physical and Macromolecular Chemistry Lecture 5, Statistical Thermodynamics, MC260P105,

More information

Physics 5153 Classical Mechanics. Canonical Transformations-1

Physics 5153 Classical Mechanics. Canonical Transformations-1 1 Introduction Physics 5153 Classical Mechanics Canonical Transformations The choice of generalized coordinates used to describe a physical system is completely arbitrary, but the Lagrangian is invariant

More information

Physics 129a Calculus of Variations Frank Porter Revision

Physics 129a Calculus of Variations Frank Porter Revision Physics 129a Calculus of Variations 71113 Frank Porter Revision 171116 1 Introduction Many problems in physics have to do with extrema. When the problem involves finding a function that satisfies some

More information

Arc Length and Surface Area in Parametric Equations

Arc Length and Surface Area in Parametric Equations Arc Length and Surface Area in Parametric Equations MATH 211, Calculus II J. Robert Buchanan Department of Mathematics Spring 2011 Background We have developed definite integral formulas for arc length

More information

Maxima/minima with constraints

Maxima/minima with constraints Maxima/minima with constraints Very often we want to find maxima/minima but subject to some constraint Example: A wire is bent to a shape y = 1 x 2. If a string is stretched from the origin to the wire,

More information

Lecture: Lorentz Invariant Dynamics

Lecture: Lorentz Invariant Dynamics Chapter 5 Lecture: Lorentz Invariant Dynamics In the preceding chapter we introduced the Minkowski metric and covariance with respect to Lorentz transformations between inertial systems. This was shown

More information

ENGI Partial Differentiation Page y f x

ENGI Partial Differentiation Page y f x ENGI 344 4 Partial Differentiation Page 4-0 4. Partial Differentiation For functions of one variable, be found unambiguously by differentiation: y f x, the rate of change of the dependent variable can

More information

l1, l2, l3, ln l1 + l2 + l3 + ln

l1, l2, l3, ln l1 + l2 + l3 + ln Work done by a constant force: Consider an object undergoes a displacement S along a straight line while acted on a force F that makes an angle θ with S as shown The work done W by the agent is the product

More information

Problem Set 2 Solution

Problem Set 2 Solution Problem Set Solution Friday, September 13 Physics 111 Problem 1 Tautochrone A particle slides without friction on a cycloidal track given by x = a(θ sinθ y = a(1 cosθ where y is oriented vertically downward

More information

PHYS2330 Intermediate Mechanics Fall Final Exam Tuesday, 21 Dec 2010

PHYS2330 Intermediate Mechanics Fall Final Exam Tuesday, 21 Dec 2010 Name: PHYS2330 Intermediate Mechanics Fall 2010 Final Exam Tuesday, 21 Dec 2010 This exam has two parts. Part I has 20 multiple choice questions, worth two points each. Part II consists of six relatively

More information

HW 6 Mathematics 503, Mathematical Modeling, CSUF, June 24, 2007

HW 6 Mathematics 503, Mathematical Modeling, CSUF, June 24, 2007 HW 6 Mathematics 503, Mathematical Modeling, CSUF, June 24, 2007 Nasser M. Abbasi June 15, 2014 Contents 1 Problem 1 (section 3.5,#9, page 197 1 2 Problem 1 (section 3.5,#9, page 197 7 1 Problem 1 (section

More information

Introduction to the Calculus of Variations

Introduction to the Calculus of Variations 236861 Numerical Geometry of Images Tutorial 1 Introduction to the Calculus of Variations Alex Bronstein c 2005 1 Calculus Calculus of variations 1. Function Functional f : R n R Example: f(x, y) =x 2

More information

Hamilton-Jacobi theory

Hamilton-Jacobi theory Hamilton-Jacobi theory November 9, 04 We conclude with the crowning theorem of Hamiltonian dynamics: a proof that for any Hamiltonian dynamical system there exists a canonical transformation to a set of

More information

Legendre Transforms, Calculus of Varations, and Mechanics Principles

Legendre Transforms, Calculus of Varations, and Mechanics Principles page 437 Appendix C Legendre Transforms, Calculus of Varations, and Mechanics Principles C.1 Legendre Transforms Legendre transforms map functions in a vector space to functions in the dual space. From

More information

This is example 3 on page 44 of BGH and example (b) on page 66 of Troutman.

This is example 3 on page 44 of BGH and example (b) on page 66 of Troutman. Chapter 4 The brachistochrone This is example 3 on page 44 of BGH and example (b) on page 66 of Troutman. We seek the shape of a frictionless wire starting at the origin and ending at some point (, d)

More information

Nov : Lecture 22: Differential Operators, Harmonic Oscillators

Nov : Lecture 22: Differential Operators, Harmonic Oscillators 14 Nov. 3 005: Lecture : Differential Operators, Harmonic Oscillators Reading: Kreyszig Sections:.4 (pp:81 83),.5 (pp:83 89),.8 (pp:101 03) Differential Operators The idea of a function as something that

More information

Problem 1: Lagrangians and Conserved Quantities. Consider the following action for a particle of mass m moving in one dimension

Problem 1: Lagrangians and Conserved Quantities. Consider the following action for a particle of mass m moving in one dimension 105A Practice Final Solutions March 13, 01 William Kelly Problem 1: Lagrangians and Conserved Quantities Consider the following action for a particle of mass m moving in one dimension S = dtl = mc dt 1

More information

15. Hamiltonian Mechanics

15. Hamiltonian Mechanics University of Rhode Island DigitalCommons@URI Classical Dynamics Physics Course Materials 2015 15. Hamiltonian Mechanics Gerhard Müller University of Rhode Island, gmuller@uri.edu Creative Commons License

More information

Exercises for Multivariable Differential Calculus XM521

Exercises for Multivariable Differential Calculus XM521 This document lists all the exercises for XM521. The Type I (True/False) exercises will be given, and should be answered, online immediately following each lecture. The Type III exercises are to be done

More information

Tensors, and differential forms - Lecture 2

Tensors, and differential forms - Lecture 2 Tensors, and differential forms - Lecture 2 1 Introduction The concept of a tensor is derived from considering the properties of a function under a transformation of the coordinate system. A description

More information

F1.9AB2 1. r 2 θ2 + sin 2 α. and. p θ = mr 2 θ. p2 θ. (d) In light of the information in part (c) above, we can express the Hamiltonian in the form

F1.9AB2 1. r 2 θ2 + sin 2 α. and. p θ = mr 2 θ. p2 θ. (d) In light of the information in part (c) above, we can express the Hamiltonian in the form F1.9AB2 1 Question 1 (20 Marks) A cone of semi-angle α has its axis vertical and vertex downwards, as in Figure 1 (overleaf). A point mass m slides without friction on the inside of the cone under the

More information

Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction

Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction D. S. Stutts, Ph.D. Associate Professor of Mechanical Engineering Missouri University of Science and Technology Rolla,

More information

Leaving Cert Applied Maths: Some Notes

Leaving Cert Applied Maths: Some Notes Leaving Cert Applied Maths: Some Notes Golden Rule of Applied Maths: Draw Pictures! Numbered equations are in the tables. Proportionality: Figure 1: Note that P = kq y = mx + c except c = 0 the line goes

More information

Math 210, Final Exam, Spring 2012 Problem 1 Solution. (a) Find an equation of the plane passing through the tips of u, v, and w.

Math 210, Final Exam, Spring 2012 Problem 1 Solution. (a) Find an equation of the plane passing through the tips of u, v, and w. Math, Final Exam, Spring Problem Solution. Consider three position vectors (tails are the origin): u,, v 4,, w,, (a) Find an equation of the plane passing through the tips of u, v, and w. (b) Find an equation

More information

for changing independent variables. Most simply for a function f(x) the Legendre transformation f(x) B(s) takes the form B(s) = xs f(x) with s = df

for changing independent variables. Most simply for a function f(x) the Legendre transformation f(x) B(s) takes the form B(s) = xs f(x) with s = df Physics 106a, Caltech 1 November, 2018 Lecture 10: Hamiltonian Mechanics I The Hamiltonian In the Hamiltonian formulation of dynamics each second order ODE given by the Euler- Lagrange equation in terms

More information

Massachusetts Institute of Technology Department of Physics. Final Examination December 17, 2004

Massachusetts Institute of Technology Department of Physics. Final Examination December 17, 2004 Massachusetts Institute of Technology Department of Physics Course: 8.09 Classical Mechanics Term: Fall 004 Final Examination December 17, 004 Instructions Do not start until you are told to do so. Solve

More information

I. HARTLE CHAPTER 8, PROBLEM 2 (8 POINTS) where here an overdot represents d/dλ, must satisfy the geodesic equation (see 3 on problem set 4)

I. HARTLE CHAPTER 8, PROBLEM 2 (8 POINTS) where here an overdot represents d/dλ, must satisfy the geodesic equation (see 3 on problem set 4) Physics 445 Solution for homework 5 Fall 2004 Cornell University 41 points) Steve Drasco 1 NOTE From here on, unless otherwise indicated we will use the same conventions as in the last two solutions: four-vectors

More information

Robotics. Islam S. M. Khalil. November 15, German University in Cairo

Robotics. Islam S. M. Khalil. November 15, German University in Cairo Robotics German University in Cairo November 15, 2016 Fundamental concepts In optimal control problems the objective is to determine a function that minimizes a specified functional, i.e., the performance

More information

Physics 106a, Caltech 16 October, Lecture 5: Hamilton s Principle with Constraints. Examples

Physics 106a, Caltech 16 October, Lecture 5: Hamilton s Principle with Constraints. Examples Physics 106a, Caltech 16 October, 2018 Lecture 5: Hamilton s Principle with Constraints We have been avoiding forces of constraint, because in many cases they are uninteresting, and the constraints can

More information

Energy and Angular Momentum

Energy and Angular Momentum Chapter 3 Energy and Angular Momentum In this chapter, we generalize the discussion of Chapter 2 to the case of motion in two or three dimensions. Throughout this chapter, we shall be concerned with the

More information

The Particle-Field Hamiltonian

The Particle-Field Hamiltonian The Particle-Field Hamiltonian For a fundamental understanding of the interaction of a particle with the electromagnetic field we need to know the total energy of the system consisting of particle and

More information

First Year Physics: Prelims CP1. Classical Mechanics: Prof. Neville Harnew. Problem Set III : Projectiles, rocket motion and motion in E & B fields

First Year Physics: Prelims CP1. Classical Mechanics: Prof. Neville Harnew. Problem Set III : Projectiles, rocket motion and motion in E & B fields HT017 First Year Physics: Prelims CP1 Classical Mechanics: Prof Neville Harnew Problem Set III : Projectiles, rocket motion and motion in E & B fields Questions 1-10 are standard examples Questions 11-1

More information

x + ye z2 + ze y2, y + xe z2 + ze x2, z and where T is the

x + ye z2 + ze y2, y + xe z2 + ze x2, z and where T is the 1.(8pts) Find F ds where F = x + ye z + ze y, y + xe z + ze x, z and where T is the T surface in the pictures. (The two pictures are two views of the same surface.) The boundary of T is the unit circle

More information

Invariant Lagrangian Systems on Lie Groups

Invariant Lagrangian Systems on Lie Groups Invariant Lagrangian Systems on Lie Groups Dennis Barrett Geometry and Geometric Control (GGC) Research Group Department of Mathematics (Pure and Applied) Rhodes University, Grahamstown 6140 Eastern Cape

More information

Johann Bernoulli ( )he established the principle of the so-called virtual work for static systems.

Johann Bernoulli ( )he established the principle of the so-called virtual work for static systems. HISTORICAL SURVEY Wilhelm von Leibniz (1646-1716): Leibniz s approach to mechanics was based on the use of mathematical operations with the scalar quantities of energy, as opposed to the vector quantities

More information

Math Review Night: Work and the Dot Product

Math Review Night: Work and the Dot Product Math Review Night: Work and the Dot Product Dot Product A scalar quantity Magnitude: A B = A B cosθ The dot product can be positive, zero, or negative Two types of projections: the dot product is the parallel

More information

Translational vs Rotational. m x. Connection Δ = = = = = = Δ = = = = = = Δ =Δ = = = = = 2 / 1/2. Work

Translational vs Rotational. m x. Connection Δ = = = = = = Δ = = = = = = Δ =Δ = = = = = 2 / 1/2. Work Translational vs Rotational / / 1/ Δ m x v dx dt a dv dt F ma p mv KE mv Work Fd / / 1/ θ ω θ α ω τ α ω ω τθ Δ I d dt d dt I L I KE I Work / θ ω α τ Δ Δ c t s r v r a v r a r Fr L pr Connection Translational

More information

Rotational Kinematics and Dynamics. UCVTS AIT Physics

Rotational Kinematics and Dynamics. UCVTS AIT Physics Rotational Kinematics and Dynamics UCVTS AIT Physics Angular Position Axis of rotation is the center of the disc Choose a fixed reference line Point P is at a fixed distance r from the origin Angular Position,

More information

Variational Principles

Variational Principles Part IB Variational Principles Year 218 217 216 215 214 213 212 211 21 218 Paper 1, Section I 4B 46 Variational Principles Find, using a Lagrange multiplier, the four stationary points in R 3 of the function

More information

UNIVERSITY OF EAST ANGLIA

UNIVERSITY OF EAST ANGLIA UNIVERSITY OF EAST ANGLIA School of Mathematics May/June UG Examination 2007 2008 FLUIDS DYNAMICS WITH ADVANCED TOPICS Time allowed: 3 hours Attempt question ONE and FOUR other questions. Candidates must

More information

is conserved, calculating E both at θ = 0 and θ = π/2 we find that this happens for a value ω = ω given by: 2g

is conserved, calculating E both at θ = 0 and θ = π/2 we find that this happens for a value ω = ω given by: 2g UNIVERSITETET I STAVANGER Institutt for matematikk og naturvitenskap Suggested solutions, FYS 500 Classical Mechanics Theory 2016 fall Set 5 for 23. September 2016 Problem 27: A string can only support

More information

Taylor Series and stationary points

Taylor Series and stationary points Chapter 5 Taylor Series and stationary points 5.1 Taylor Series The surface z = f(x, y) and its derivatives can give a series approximation for f(x, y) about some point (x 0, y 0 ) as illustrated in Figure

More information

Physics 2514 Lecture 34

Physics 2514 Lecture 34 Physics 2514 Lecture 34 P. Gutierrez Department of Physics & Astronomy University of Oklahoma Physics 2514 p. 1/13 Information Information needed for the exam Exam will be in the same format as the practice

More information

MTH4101 CALCULUS II REVISION NOTES. 1. COMPLEX NUMBERS (Thomas Appendix 7 + lecture notes) ax 2 + bx + c = 0. x = b ± b 2 4ac 2a. i = 1.

MTH4101 CALCULUS II REVISION NOTES. 1. COMPLEX NUMBERS (Thomas Appendix 7 + lecture notes) ax 2 + bx + c = 0. x = b ± b 2 4ac 2a. i = 1. MTH4101 CALCULUS II REVISION NOTES 1. COMPLEX NUMBERS (Thomas Appendix 7 + lecture notes) 1.1 Introduction Types of numbers (natural, integers, rationals, reals) The need to solve quadratic equations:

More information

Physics 106a, Caltech 4 December, Lecture 18: Examples on Rigid Body Dynamics. Rotating rectangle. Heavy symmetric top

Physics 106a, Caltech 4 December, Lecture 18: Examples on Rigid Body Dynamics. Rotating rectangle. Heavy symmetric top Physics 106a, Caltech 4 December, 2018 Lecture 18: Examples on Rigid Body Dynamics I go through a number of examples illustrating the methods of solving rigid body dynamics. In most cases, the problem

More information

Announcements. 1. Do not bring the yellow equation sheets to the miderm. Idential sheets will be attached to the problems.

Announcements. 1. Do not bring the yellow equation sheets to the miderm. Idential sheets will be attached to the problems. Announcements 1. Do not bring the yellow equation sheets to the miderm. Idential sheets will be attached to the problems. 2. Some PRS transmitters are missing. Please, bring them back! 1 Kinematics Displacement

More information

Phys 7221 Homework # 8

Phys 7221 Homework # 8 Phys 71 Homework # 8 Gabriela González November 15, 6 Derivation 5-6: Torque free symmetric top In a torque free, symmetric top, with I x = I y = I, the angular velocity vector ω in body coordinates with

More information

Laplace equation in polar coordinates

Laplace equation in polar coordinates Laplace equation in polar coordinates The Laplace equation is given by 2 F 2 + 2 F 2 = 0 We have x = r cos θ, y = r sin θ, and also r 2 = x 2 + y 2, tan θ = y/x We have for the partials with respect to

More information

Fermat s Principle. Fermat s Principle states that a ray of light in a medium will follow the path which takes the least amount of time.

Fermat s Principle. Fermat s Principle states that a ray of light in a medium will follow the path which takes the least amount of time. Homework Fermat s Principle Fermat s Principle states that a ray of light in a medium will follow the path which takes the least amount of time. Solution: The traversal time for the path is T = where ds

More information

Phys 7221, Fall 2006: Midterm exam

Phys 7221, Fall 2006: Midterm exam Phys 7221, Fall 2006: Midterm exam October 20, 2006 Problem 1 (40 pts) Consider a spherical pendulum, a mass m attached to a rod of length l, as a constrained system with r = l, as shown in the figure.

More information

THE CALCULUS OF VARIATIONS

THE CALCULUS OF VARIATIONS THE CALCULUS OF VARIATIONS LAGRANGIAN MECHANICS AND OPTIMAL CONTROL AARON NELSON Abstract. The calculus of variations addresses the need to optimize certain quantities over sets of functions. We begin

More information

Part IB Variational Principles

Part IB Variational Principles Part IB Variational Principles Based on lectures by P. K. Townsend Notes taken by Dexter Chua Easter 2015 These notes are not endorsed by the lecturers, and I have modified them (often significantly) after

More information