Appendix 1: Atomic Units

Size: px
Start display at page:

Download "Appendix 1: Atomic Units"

Transcription

1 Appendix 1: Atomic Units Quantity Atomic Unit SI Equivalent mass mass of electron kg charge charge of proton C angular momentum h J s length (bohr) Bohr orbit radius in H atom m energy (hartree) 1/2 ionization energy of H atom J time period of ground state Bohr orbit in H s velocity velocity of electron in lowest Bohr orbit m/s 1 hartree = 315,775 K = 219,475 cm 1 = ev. 389

2 Appendix 2: Example QTM Program PROGRAM QTM Implicit none! ! This code integrates the POTENTIAL FORM of the quantum! hydrodynamic equations of motion (see equations 4.5 through 4.7! in Chapter 4). Note that the equation of motion for the action! function is integrated, but the quantum force is not used.!! An Eckart potential is used as an example in this code.!! !! For time integration, this code uses the first-order Euler! time-integrator.!! For spatial derivatives, there are calls to a generic! subroutine deriv.! This can be one of many function approximation routines! (such as moving least squares)! Generally, these s require the following specification! and arrays:!! deriv(np,x,f,d1x,d2x)! where...! np (input) the total number of particles (grid points)! x (input) an array of length np containing the grid! point locations! f (input) an array of length np containing the! function values at the grid points! d1x (output) an array of length np containing the first! spatial derivative of function f! d2x (output) an array of length np containing the second! spatial derivative of function f!

3 Appendix 2. Example QTM Program 391 integer(kind=4), parameter :: np = 63, ntime = ! ntime = total time-steps. integer(kind=4) i,j,k real(kind=8) delv(np),c(np),d1x(np),d2x(np),quantum(np),pot(np), x(np),rho(np) real(kind=8) vx(np),phase(np) real(kind=8) dt,x0,beta,energy,conv,am,vb,xb,wx,xmin,xmax,h,pi, anorm,total density real(kind=8) kinetic energy,lagrange! Initial Wave Packet Parameters ! Time-step in au dt = 0.5d0! Center of Gaussian function x0 = 0.d0! Width parameter for Gaussian wave packet beta = 9.d0! Initial translational energy in cm 1 energy = 8000.d0! Conversion factor from cm 1 to a.u. conv = d0! Translational energy in a.u. energy = energy/conv! Mass in a.u. am = 2000.d0! Eckart potential parameters ! Barrier height in cm 1 vb=8000d.0! Barrier height in a.u. vb=vb/conv! Center of barrier in a.u. xb=6.d0! Width parameter in a.u. wx=5.d0! Build a Uniform Initial Spatial Grid ! Minimum grid point xmin = -0.6d0! Maximum grid point xmax = 0.6d0! Particle spacings h = (xmax - xmin)/dble(np-1)! Particle positions do i = 0,np-1 x(i+1) = xmin + i h

4 392 Appendix 2. Example QTM Program! Initialize Wave Packet and Hydrodynamic Fields ! Normalization for an initial Gaussian wave function pi = 4.d0 atan(1.d0) anorm = (2.d0 beta/pi) (1.d0/4.d0)! Build initial wave packet amplitude and density do i =1,np R(i) = anorm exp(-beta ((x(i) - x0) 2)) c(i) =log(r(i)) rho(i) = R(i) 2! Initial particle velocities (all particles are initially the same velocity and 0 divergence)! These velocities are obtained from the equation Etrans = 1/2mv 2. do i = 1,np vx(i) = sqrt(2.d0 energy/am) delv(i) = 0.d0! Initial phase (action function) for each particle do i = 1,np phase(i)= sqrt(2.d0 am energy) x(i)! ! Time Propagation Loop do k = 1,ntime time = dble(k) dt! conversion from au to fs tfs = time d0! Call subroutine for spatial derivatives of the C-amplitude call deriv(np,x,c,d1x,d2x)! Calculate quantum and classical potentials do i = 1,np! Quantum Potential. quantum(i) = -1.d0/(2.d0 am) (d2x(i) + d1x(i) 2)! Classical Eckart Potential. pot(i) = vb sech(wx (x-x0)) 2! Calculate phase (S) using potentials (Quantum Lagrangian: T-(V+Q)) do i = 1,np kinetic energy = 0.5d0 am vx(i) 2 lagrange = kinetic-(pot(i)+quantum(i)) phase(i) = phase(i) + lagrange dt

5 Appendix 2. Example QTM Program 393! Update particle positions do i = 1,np x(i) = x(i) + vx(i) dt! Call subroutine for spatial derivatives of phase call deriv(np,x,phase,d1x,d2x)! Update velocities and probability density do i = 1,np vx(i) = (1.d0/am) d1x(i) delv(i) = (1.d0/am) d2x(i) rho(i) = rho(i) exp(-delv(i) dt)! End Time Propagation end

6 Index Action function; see also Quantum hydrodynamic equations of motion classical, 50 51, 98 complex-valued, 43 44, 46, for decay of metastable state, 201 for decoherence model, 198 quantum, 8, 43, 46, 150, 198, 339, 379 reduced, see Hamilton s characteristic function Adaptive grid; see Grid, adaptive Adaptive s, ; see also Arbitrary Lagrangian Eulerian, Moving path transforms, Equidistribution principle, Artificial viscosity, Hybrid s Adiabatic electronic representation, ; see also Diabatic electronic representation ALE; see Arbitrary Lagrangian Eulerian ALE grid speeds, 170 Analytic approach to quantum trajectories, 1 2, , , Approximate quantum potential, 228 Approximations to quantum force, 21 22, statistical approach; see also Statistical analysis, application to methyl iodide, determination of parameters, 21, expansion of density in Gaussians, 21, 219 fit density using least squares, 21 22, applications, expansion of density in Gaussians, 225 least squares functional, 225 fit log-derivative of density, 22, applications, , global fit, local fit, AQP; see Approximate quantum potential Arbitrary Lagrangian Eulerian, 3, 19, , , 371 Artificial viscosity, 19 20, 167, , 188, 370; see also Adaptive s Atomic units, 389 Attractors in flux maps, 196 Back-reaction problem in mixed quantum-classical dynamics, 300 Back-reaction through Bohmian particle, ; see also Mixed quantum classical dynamics, Configuration space, Phase space Bell, John, 40 Bohm, David, 40 42, 98 Boltzmann distribution, 64 Born Oppenheimer approximation, 204, 308 Brownian motion, 258; see also Osmotic velocity 395

7 396 Index C-amplitude, 43, 150, 201, C-density, 271 Caldeira Leggett equation, 25 26, 254, 266, 268, Carrier phase, 373, 380; see also Counterpropagating wave Car Parrinello technique, CFM; see Covering function Chaos; see also Lyapunov exponent, Power spectrum of trajectory classical, diagnostics, 111 examples, Lagrangian chaos, 111 relationship to wave function nodes, quantum, 63, , 119 Characteristic function; see Hamilton s characteristic function Circulation integral; see Vortices, circulation integral, Stokes s theorem CL equation; see Caldeira Leggett equation Collocation matrix, 131 Complex amplitude, 35, 371, ; see also Problems with propagation of quantum trajectories form for wave function, 35, 377 equations of motion, 377 Compressibility and trajectory dynamics, 100 Compression of trajectories, 14, 105, 162, 164, 292; see also Inflation of trajectories Complete positivity for density operator, 268; see also Lindblad form, Density operator Complex-valued velocity, 327 Computer code for QTM, 93, 95, 188, Configuration space ; see also Mixed quantum classical dynamics, Phase space applications coupled harmonic oscillators, diffractive surface scattering, light particle heavy particle scattering, comparison with phase space, equations of motion, 29, introduction to, 29 Contextuality, 55, 270 Continuity equation classical, 26, 44 quantum, 32, 47, 52, 78, 94, 203, 236, 377 phase space, stationary states, 355 Control theory, 191 Convective term in equations of motion, 79, 81 Coordinates, physical and computational, 192 Copenhagen interpretation, 40, 41, 111 Correlation function force autocorrelation, 257 spatial, 68 quantum cross-correlation, 102, 226, density correlation, 233 decay of metastable state, Counterpropagating wave, 8, 34 35, 355, application to stationary states, carrier wave, 373, 378, 380 example of decomposition, form for wave function, 373 Covering function, 35 36, 161, 371, applications Eckart barrier scattering, two-dimensional scattering, covering functions, 376, 382, 386 total wave function, 35, 375 Cross-validation, 158 C-space transform, 149; see also C-amplitude DAF; see Distributed approximating functionals Damping term, 223 de Broglie Bohm interpretation, 1 2, 41, 42, 59, 111 de Broglie wavelength, 138 Decay of metastable state, 190, , ,

8 Index 397 Decoherence, 18, 190, 251 definition, description of model, quantum trajectory results, stress tensor components, Density functional theory, 36, 134 Density matrix, 6, 26 27, 64, , 255, definition, 64 trajectory equations of motion, polar form, 289 examples of trajectory evolution decay from Eckart barrier, displaced coherent state, Density operator, 64, , 289; see also Lindblad form for density operator Derivative evaluation problem, 14 17, ; see also Problems with propagation of quantum trajectories Derivative propagation, see also Derivative propagation, Trajectory stability Derivative propagation, 22 23, 235, 370, 237, 240, 296, derivation of equations, equations of motion, 23, 239 evolutionary differential equation, 272 examples decay of metastable state, Eckart barrier transmission, form of wave function, 373 hierarchy of equations, implementation, multidimensional extension, phase space dynamics, , problems with, 25, 236, 250, 252, 271 Descriptor for trajectories, 92, 292 Designer grids, 5, 18, 368; see also Grid, adaptive Diabatic electronic representation, ; see also Adiabatic electronic representation Diffuse elements, 125 Diffusion coefficient, 31, 228 Diosi equation, 26, 255, 270, 275 Discrete variable representation, 223 Dissipation, 11, 63, 266, 269, 271, 371 Distributed approximating functionals, 16, 126, 135 application to Eckart barrier scattering, derivative evaluation, 136 discrete convolution, 135 Hermite DAF function, 136 Divergence of velocity field, 96 DLS; see Dynamic least squares fitting Domain functions, 22, 219, Double slit scattering, 164 Dynamic least squares fitting, 16, 125, Dynamical diagonalization of density matrix, 192, 199, 291 Dynamical grid; see Arbitrary Lagrangian Eulerian Dynamical tunneling, quantum trajectory evolution, two-dimensional model system, Dynamic viscosity, 324 Eckart potential, 63, 105, 136, 139, 161, 175, 179, , 225, 229, 231, 243, 249, 294, 377, 382 Ehrenfest force, 302 Ehrenfest mean field ; see Mean field Ehrenfest, Paul, 302 Eikonal equation, 45 Einstein Podolsky Rosen experiment, 40 Electronic nonadiabatic dynamics, 191, , 370; see also Trajectory surface hopping adiabatic and diabiatic representations, hydrodynamic equations of motion, 203, initial conditions on wave function, 208 matrix elements, , 213 model system, quantum trajectory results, Entangled trajectories, 255, 262, EPR experiment; see Einstein Podolsky Rosen experiment

9 398 Index Equidistribution principle, 20, , , 183, 188; see also Monitor function Equivalence principle; see Quantum equivalence principle Ermakov Pinney differential equation, 45 Euler for integration of differential equations, 149, 240 Eulerian frame, 3, 9, 48, 137, 157, , 183, 186, 256 Eulerian picture; see Eulerian frame Expectation maximization, 21, 218, Faraggi and Matone approach to stationary states; see Equivalence principle Feynman, Richard, 98 Feynman path integral, Field equations, 52 53, 58 Finite difference s, 125, Finite element, 17, 126, Fitting of functions; see also Least squares fitting s, Function approximation Fitting density to Gaussians, 21 22, , 225 Fixed lattice; see Eulerian frame Floyd trajectory, 7, 32 33, 375; see also Quantum equivalence principle application to harmonic oscillator, , form for wave function, 357 hidden variables, introduction to, 354 microstates, 358 modified potential, , quantization condition for eigenstates, 360 trajectory equations, 361 Floydian trajectory; see Floyd trajectory Flow compressible, 90, 100 incompressible, 100 kinetic energy, 8 9, 48 momentum, 48, 56 velocity, 47, 78 Fluid elements, 11 Fluctuation-dissipation theorem, 257 Flux-gate, 278 Flux vector maps; see Probability flux Force approximate quantum force, , 370 classical, 2, 9, 56, 90, 195 classical-quantum comparison, 82 hydrodynamic, 28, 78 80, 82, 286, 306 nonlocal in phase space, 274 quantum, 2, 9, 56, 62, 80, 86, 90, 107, 151, 154, 180, 195, 229; see also Quantum potential random, 257 stochastic, 257 total, 9, 57 Frictional effects, 256 Function approximation, ; see also Least squares fitting s, Dynamic least squares, Distributed approximating functionals, Tessellation-fitting, Finite element, Interpolation Gaussian wave packet, 3, 105, 136, 148, 151, 153, 161, 169, 175, 193, 212, 220, 229, 243, 377, 382 Geometric phase, 36 Ginsburg Landau equation, 36 Grid; see also Arbitrary Lagrangian Eulerian adaptive, 161, , 194, 212, 369, Cartesian, 93 computational, 141 correlation, 129 designer, 18 Eulerian; see Eulerian frame Lagrangian; see Lagrangian frame non-lagrangian, 5, moving, 5, 90, physical, 141 phase space, 280 structured, 371 unstructured, 94, 125 Grid paths, , 185 Grid point concentration, 174

10 Index 399 Grid velocity, 168, 170 Guidance equation in pilot wave interpretation, 59 H+H 2 reaction, 226, , 233, Hamilton s principle, 51, Hamilton Jacobi equation classical, 42, 44, 48 52, 210 stationary, 32, , quantum, 7 8, 42, 48, 56 57, 236, 377 Hamilton s characteristic function, , Herman Kluck propagator, 226 Hidden variables, 2, 59 60, , 365 Huisimi distribution, 234, 265 Huisimi equation of motion, 254, 265 Hybrid hydrodynamical Liouville phase space ; see Phase space Hybrid quantum trajectory s, 20 21, 167, , 370 applications double well potential, Eckart barrier scattering, Hydrodynamic force; see Force, hydrodynamic quantum equations of motion; see also Quantum hydrodynamic equations of motion Madelung Bohm derivation, 8, phase space derivation, 62, density matrix evolution, formulation of quantum mechanics, 1 7, wave function propagator, 13, 97 Hydrogen atom, chaos in quantum trajectories, Implicit time integrator, 5, 149 Inflation of trajectories, 14, 105, 162, 292; see also Compression of trajectories Initial value representation for quantum trajectories, 14, Instabilities; see Problems with quantum trajectories Interpolation, 15, 123, 131, 142, 158; see also Function approximation Jacobi, Carl, 100 Jacobi s theorem, 361 Jacobian equation of motion, 100 relation to wave function propagation, 13, trajectory stability matrix, 247 transported volume elements, 13, 99 Kinetic energy, 8 9, 48, 50, 54, 231 Kramers, Hendrick, Kramers equation, 25, 254, 259, 279, 282 Lagrange, Joseph-Louis, 50 Lagrangian Car Parrinello, 134 classical, 50, 52, 98 quantum, 57, 90, 92 Lagrangian frame, 3, 9, 49, 56, 168, 256 Lagrangian manifold, 356, Lagrangian picture; see Lagrangian frame Landau Zener approximation, 209 Langevin, Paul, 258 Langevin equation, 258 Least squares fitting s, 12, 15 16, 21 22, 125, , 200, 212, 225, 228, 231, 237 dynamic ; see Dynamic least squares local rational approximation, 132 moving least squares, 15 normal equations, 15, 130 polynomial consistency, 127 polynomial basis sets, 15, 128, 200 shape functions, 131 shape matrix, 130 summary of features, variational criterion, 15, 129 weighted functions, 15, 129 Lee Scully Wigner trajectories; see Wigner trajectories Leggett, Anthony, ; see also Caldeira-Leggett equation Leibniz theorem, 238, 272 Lindblad form for density operator, 268; see also Density operator Lindblad operators, 269 Liouville, Joseph, 257

11 400 Index Liouville equation, 25, 63, 71, 81, 254, 256, 305 Liouville von Neumann equation, 269 Liouville s theorem, 256 Local data representation, 124 Local modes of vibration, Local rational approximation; see Least squares fitting s Log derivative of density, 22, 219, 228, Log-likelihood in statistical estimation theory, 221; see also Expectation-maximization Lyapunov exponent, 109, , 119 Madelung, Erwin, 43 Madelung Bohm derivation of hydrodynamic equations, 8 10, 40, MARS; see Multivariate adaptive regression splines Multivariate adaptive regression splines, 128 Mean field, 300, 302; see also Mixed quantum-classical dynamics Mean interaction potential, 301 Measurement, quantum, 36, 40 Mesh compression, 194 Meshless s, 124; see also Arbitrary Lagrangian Eulerian Methyl-iodide, bending states, 21, 218, , 234 Metastable state classical phase space, 66 67, 73 74, 77 one-dimensional model, multidimensional model, phase space dynamics, Microstates; see Floyd trajectory Milne s, 45 Mixed quantum classical Bohmian ; see Configuration space Mixed quantum classical dynamics, 27 30, 300, 370; see also Mean field, Configuration space, Phase space, Backreaction through the Bohmian particle Mixed quantum-classical Bohmian ; see Configuration space MLS; see Least squares fitting s Modified Caldeira Leggett equation; see Diosi equation Moment hierarchy, 63, 80, 240 Moments; see also Phase space classical, dissipative dynamics, for probability density, 228 dissipative phase space dynamics, partial moments, 303 pure states, quantum definition, 10 derivation of equations of motion, Eckart barrier scattering, metastable oscillator, properties, Momentum density, 76, 326 Momentum fluctuation (variance), 76, 306 Momentum moments; see Moments Momentum operator, Monitor function, , , 372; see also Equidistribution principle Monte Carlo sampling, 103 Moving path transforms, 5, , 372; see also Equidistribution principle hydrodynamic equations of motion, 19, 168 time-dependent Schrödinger equation, 20, 175 MQCB; see Mixed quantum classical Multiquadric radial basis function, 158 Navier Stokes equations, 30, 76, 326, 328 Negative basins; see Phase space, negative basins Node in wave function; see also Quasi-node, Prenode, Postnode, Node problem, Voritces classification of types, 54

12 Index 401 dynamical tunneling, , 350 noncrossing rules, 104 phase of wave function, 46 quantum chaos, trajectory dynamics, 5, 104, 106, , 179, 182, Node-free wave functions; see Wave function, node-free Node problem; see Problems with propagation of quantum trajectories Noncrossing rules, 13, 90, 104, 155 Nonlocality, 9, 55, 97, 250, 270, 273, 296, 370 Ontological theory, 2, 60 Open quantum system, 254, 256, 259, 266, , Oppenheimer, J. Robert, 42 Osmotic velocity, 30 31, 228, Outer product, 64 Parallel computers, 95 Particle in cell, 120 Particle, 2, 120 Partition of unity, 131, 230 Path integral; see Feynman path integral Phase integral, 45, 356 Phase space; see also Moments, Phase space introduction, classical distribution, 65, 80 83, derivative propagation, dissipative dynamics, ensembles, 41, 66 67, Eulerian grid, 280 hydrodynamic, 65, Lagrangian trajectories, Liouville, negative basins, 70, normalization of density, 47, 256 propagator for density, 274 trajectories classical, 25 26, 65 67, 262 Eckart barrier scattering, metastable well potential, non-lagrangian, Phase space ; see also Mixed quantum-classical dynamics, application to coupled harmonic oscillators, comparison with configuration space, derivation of equations of motion, hydrodynamic force, 306 hydrodynamic subspace, 304 introduction, 28 Liouville subspace, 304 phase space concepts, partial moments, 303 reduced phase space, 303 Photoabsorption spectra, 52 Photodissociation, 17, 126, 142, 158 Pilot wave, 2, 59, 367 PIM; see Point interpolation Point interpolation, 131 Polar form for wave function; see Wave function, polar form Polynomial basis sets, , 200 Polynomial consistency, 127 Polypeptide chain, Postnode, ; see also Prenode and Node Potential energy coupled harmonic oscillators, 307 decoherence model, delta-function, 216 double well, 175 downhill ramp, 148, 156, 211 Eckart; see Eckart barrier harmonic oscillator, 65, 148 Lennard-Jones, 340 metastable well; see Metastable state Morse oscillator, 340, 375 quantum; see Quantum potential square barrier, 164 uphill ramp, Power spectrum of trajectory, , Principle of extreme action; see Hamilton s principle Prenode, ; see also Postnode, Quasi-node, Node Probability current; see Probability flux

13 402 Index Probability density classical, 66, 83, 279, 282 quantum, 83, 385, , 176, 178, , , Probability flux, 47, 75, , 337, , 347, 356, 374 Problems with propagation of quantum trajectories derivative evaluation, 5, 33 34, 171, instabilities and singularities, 148, 166, 372 nodes, 5, 34 35, , , 169, 179, 182, 187, sampling, 14 stiff equations of motion, 5, 149, 163, 166, 376 Propagator wave function, 13, 97 phase space density, 274 QFD; see Quantum fluid dynamics QHEM; see Quantum hydrodynamic equations of motion QSHJE; see Quantum stationary Hamilton Jacobi equation QTM; see Quantum trajectory Quantization rule for eigenstates, 360, 374 Quantized mean field, 317 Quantum equivalence principle, 7, 32 33, ; see also Floyd trajectory coordinate mapping, 363 equivalence postulate, 363 quantum gravity, 366 hidden variables, 365 quantum potential, 364 Schwartzian derivative, 365 Quantum fluid dynamics, 3, 89, 120, Quantum force; see Force, quantum Quantum hydrodynamic equations of motion; see also Hydrodynamic, equations of motion, quantum equations, 2, 18 19, 42, 135, 148, 163, , 236, 372 derivation, 8 10, 42, electronic nonadiabiatic dynamics, force version, 12, 90, 92 potential energy version, 12, 92, 150 Quantum Liouville equation; see Wigner Moyal equation Quantum optics, 63 Quantum potential, 8, 41, 42, 48, 56, 90, , 149, 180, 236, 310, 338, 348, 364, 367, 377; see also Force, quantum approximate, 231 decoherence model, 194 downhill ramp potential, 160 dynamical tunneling, 348 features, 55 free wave packet, 151, 154 interpretation, shape kinetic energy, 54 Quantum stationary Hamilton Jacobi equation; see Hamilton Jacobi equation Quantum trajectory; see Trajectory, quantum Quantum trajectory, 3, 11 13, 89, 90, 92 94, 120; see also Derivative propagation applications, 17 18, anisotropic harmonic oscillator, decay of metastable state, 19, , 216 decoherence model, downhill ramp, Eckart barrier scattering, 17, 105, 106, , electronic nonadiabatic dynamics, free wave packet, 17, reactive scattering, 164 computer code, 93, 95, equations of motion, 8 10, 12, features of, 94 introduction, phase space equations of motion,

14 Index 403 phase space trajectories, wave function synthesis, 12, Quantum vortices; see Vortices Quasi-node, 105, , 163, 187, 348; see also Node, Prenode, Postnode Quenching technique, 134 R-amplitude, 8, 12, 43, 46, 94, , , Radial basis function interpolation, , 161 Reactive scattering, 164, 188, , Reading guide, Reflection, above barrier, 159 Regression analysis, 124 Repellers in flux maps, 197 Resonant tunneling diode, 62 Runge Kutta for integration of differential equation, 149, 161 S; see Action function Sampling problem, 14 Schrödinger equation; see time-dependent Schrödinger equation Schwarzian derivative and quantum potential, 358, 364 Semiclassical quantum mechanics, 4, 14, 36 Separatrix for phase space trajectories, 66 Shape; see also Stress, shape component component of stress tensor, 76, 327 kinetic energy, 9, 54 parameter, 158 simulated annealing, 134 single value decomposition, 130, 132 Smoothed particle hydrodynamics, 124 Space-fixed grid; see Eulerian grid Spatial derivative evaluation problem; see Problems, derivative evaluation Spin, 36 SPH; see Smoothed particle hydrodynamics Spreading of wave packet, 151, 153 Spring constants for adaptive grid, 174 Square billiard problem, 112; see also Chaos, examples Stability matrix, 247; see also Trajectory stability States mixed, 11, 63 64, 86, 269 pure, 11, 62, 64, 86 stationary, 32 33, 45, Stationary states; see also States, stationary, Floydian trajectory, Equivalence principle, Counterpropagating wave Statistical analysis; see also Approximations to quantum force, Expectation- maximization Bayesian statistics, 221 conditional probabilities, 219 forward probability, 220 joint probabilities, 219 posterior probability, Stiff differential equations; see Problems with propagation of quantum trajectories Stochastic quantum mechanics, 327 Stokes s theorem and circulation integral, 334 Streamline, 92 Stress classical hydrodynamics, classical and quantum components, 326, 328 flow component, 327 introduction, quantum, 9, 55, quantum pressure term, shape component, 76, 327 shear component, 323 stress tensor, 324, 328 tensor components for decoherence model, Superposition of wave functions, 191, 357 Superposition principle, 372, 383; see also Counterpropagating wave, Covering function Surface of section in phase space, 114, 116 Surreal Bohm trajectories, 36 SVD; see Single value decomposition

15 404 Index Synthetic approach to quantum trajectories, 2 4, 11; see also Analytic approach to quantum trajectories, Quantum trajectory, Quantum fluid dynamics System bath Hamiltonian, TDSE; see Time-dependent Schrödinger equation Temporal smoother, 175 Tessellation fitting, 16, 126, Thermal distribution; see Boltzmann distribution Thermal energy, 285 Time-dependent Schrödinger equation, 1, 7 8, 20, 43, 46, 52, 119, 301, 311 Trajectory, 92 classical, 4, 49 51, 66 67, 91, 157, density matrix, grid paths, , 185 quantum, 7, 91, , , 118, , , 152, , 159, , , , 243, 314, 347; see also Quantum trajectory, Quantum fluid dynamics phase space, reasons for running quantum trajectories, 3 4 semiclassical, 4 weight for trajectory, 101 TSM; see Trajectory stability Trajectory stability, 24 25, 235, , 370 coordinate sensitivities, 24, 235 derivation of equations, Eckart barrier scattering, problems with, 25, 236, 250, 252 summary of equations, 24, 248 Trajectory surface hopping, ; see also Electronic nonadiabatic dynamics Transition density, 207 Transmission probability energy resolved, 185, 219, 227, , 249, 225 initial value representation, 103 time-dependent, 103, 157, 159, , , 225, 284, 314, 316, 318 Triangulation of grid points, 126, TSH; see Trajectory surface hopping Uncertainty relations, 36 Variance for momentum moments, 75 76, 81, 306 Velocity coupling approximation, 211 Vibrational decoupling for reactive scattering, 188 Vortices, 31 32, 322, circulation integral, 334 quantization of circulation, 335 relationship to wave function nodes, 335 examples H+H 2 reaction, intramolecular electron transfer, right-angled wave guide, scattering from disk, 339, 342 surface scattering, two-dimensional barrier, Wave function adiabatic; see Adiabiatic electronic representation bipolar form, 357, classical, 52 covering function, 373 complex amplitude, 35, 210, counterpropagating components, , 381 diabatic; see Diabatic electronic representation electronic nonadiabatic dynamics, list of forms, momentum space, 69 node-free, 6, polar form, 8, 29, 43, 44, 45, 235 non-polar form, 372 propagation along trajectory, 13, stationary states, 45, 357, 362, trigonometric form, 44, 357 Weight for trajectory; see Trajectory weight Wentzel Kramers Brillouin approximation, 44

16 Index 405 Wheeler DeWitt equation, 105 Wigner, Eugene, Wigner function, 10, 62 63, 65, 68 74, 86, 199, 240, 254 diffraction fringes, 70 equation of motion; see Wigner Moyal equation examples harmonic oscillator, metastable well potential, general properties, introduction, 68 momentum moments, negative basins in phase space, 70, synthesis using trajectory information, Wigner distribution; see Wigner function Wigner energy level spacing statistics, 111 Wigner Moyal equation, 26, 63, 70 71, 254, 260, 305 Wigner trajectories, 260, 262 WKB ; see Wentzel Kramers Brillouin approximation

17

QUANTUM MECHANICS. Franz Schwabl. Translated by Ronald Kates. ff Springer

QUANTUM MECHANICS. Franz Schwabl. Translated by Ronald Kates. ff Springer Franz Schwabl QUANTUM MECHANICS Translated by Ronald Kates Second Revised Edition With 122Figures, 16Tables, Numerous Worked Examples, and 126 Problems ff Springer Contents 1. Historical and Experimental

More information

Quantum Mechanics: Fundamentals

Quantum Mechanics: Fundamentals Kurt Gottfried Tung-Mow Yan Quantum Mechanics: Fundamentals Second Edition With 75 Figures Springer Preface vii Fundamental Concepts 1 1.1 Complementarity and Uncertainty 1 (a) Complementarity 2 (b) The

More information

List of Comprehensive Exams Topics

List of Comprehensive Exams Topics List of Comprehensive Exams Topics Mechanics 1. Basic Mechanics Newton s laws and conservation laws, the virial theorem 2. The Lagrangian and Hamiltonian Formalism The Lagrange formalism and the principle

More information

Lectures on Quantum Mechanics

Lectures on Quantum Mechanics Lectures on Quantum Mechanics Steven Weinberg The University of Texas at Austin CAMBRIDGE UNIVERSITY PRESS Contents PREFACE page xv NOTATION xviii 1 HISTORICAL INTRODUCTION 1 1.1 Photons 1 Black-body radiation

More information

Charge and Energy Transfer Dynamits in Molecular Systems

Charge and Energy Transfer Dynamits in Molecular Systems Volkhard May, Oliver Kühn Charge and Energy Transfer Dynamits in Molecular Systems Second, Revised and Enlarged Edition WILEY- VCH WILEY-VCH Verlag GmbH & Co. KGaA Contents 1 Introduction 19 2 Electronic

More information

Eulerian semiclassical computational methods in quantum dynamics. Shi Jin Department of Mathematics University of Wisconsin-Madison

Eulerian semiclassical computational methods in quantum dynamics. Shi Jin Department of Mathematics University of Wisconsin-Madison Eulerian semiclassical computational methods in quantum dynamics Shi Jin Department of Mathematics University of Wisconsin-Madison outline Classical mechanics: Hamiltonian system, discontinuous Hamiltonian,

More information

Quantum. Mechanics. Y y. A Modern Development. 2nd Edition. Leslie E Ballentine. World Scientific. Simon Fraser University, Canada TAIPEI BEIJING

Quantum. Mechanics. Y y. A Modern Development. 2nd Edition. Leslie E Ballentine. World Scientific. Simon Fraser University, Canada TAIPEI BEIJING BEIJING TAIPEI Quantum Mechanics A Modern Development 2nd Edition Leslie E Ballentine Simon Fraser University, Canada Y y NEW JERSEY LONDON SINGAPORE World Scientific SHANGHAI HONG KONG CHENNAI Contents

More information

Molecular Dynamics. Park City June 2005 Tully

Molecular Dynamics. Park City June 2005 Tully Molecular Dynamics John Lance Natasa Vinod Xiaosong Dufie Priya Sharani Hongzhi Group: August, 2004 Prelude: Classical Mechanics Newton s equations: F = ma = mq = p Force is the gradient of the potential:

More information

COPYRIGHTED MATERIAL. Index

COPYRIGHTED MATERIAL. Index 347 Index a AC fields 81 119 electric 81, 109 116 laser 81, 136 magnetic 112 microwave 107 109 AC field traps see Traps AC Stark effect 82, 84, 90, 96, 97 101, 104 109 Adiabatic approximation 3, 10, 32

More information

Preface. Preface to the Third Edition. Preface to the Second Edition. Preface to the First Edition. 1 Introduction 1

Preface. Preface to the Third Edition. Preface to the Second Edition. Preface to the First Edition. 1 Introduction 1 xi Contents Preface Preface to the Third Edition Preface to the Second Edition Preface to the First Edition v vii viii ix 1 Introduction 1 I GENERAL THEORY OF OPEN QUANTUM SYSTEMS 5 Diverse limited approaches:

More information

424 Index. Eigenvalue in quantum mechanics, 174 eigenvector in quantum mechanics, 174 Einstein equation, 334, 342, 393

424 Index. Eigenvalue in quantum mechanics, 174 eigenvector in quantum mechanics, 174 Einstein equation, 334, 342, 393 Index After-effect function, 368, 369 anthropic principle, 232 assumptions nature of, 242 autocorrelation function, 292 average, 18 definition of, 17 ensemble, see ensemble average ideal,23 operational,

More information

Topics for the Qualifying Examination

Topics for the Qualifying Examination Topics for the Qualifying Examination Quantum Mechanics I and II 1. Quantum kinematics and dynamics 1.1 Postulates of Quantum Mechanics. 1.2 Configuration space vs. Hilbert space, wave function vs. state

More information

Study Plan for Ph.D in Physics (2011/2012)

Study Plan for Ph.D in Physics (2011/2012) Plan Study Plan for Ph.D in Physics (2011/2012) Offered Degree: Ph.D in Physics 1. General Rules and Conditions:- This plan conforms to the regulations of the general frame of the higher graduate studies

More information

Quantum Physics in the Nanoworld

Quantum Physics in the Nanoworld Hans Lüth Quantum Physics in the Nanoworld Schrödinger's Cat and the Dwarfs 4) Springer Contents 1 Introduction 1 1.1 General and Historical Remarks 1 1.2 Importance for Science and Technology 3 1.3 Philosophical

More information

Students are required to pass a minimum of 15 AU of PAP courses including the following courses:

Students are required to pass a minimum of 15 AU of PAP courses including the following courses: School of Physical and Mathematical Sciences Division of Physics and Applied Physics Minor in Physics Curriculum - Minor in Physics Requirements for the Minor: Students are required to pass a minimum of

More information

A few principles of classical and quantum mechanics

A few principles of classical and quantum mechanics A few principles of classical and quantum mechanics The classical approach: In classical mechanics, we usually (but not exclusively) solve Newton s nd law of motion relating the acceleration a of the system

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

Chemistry 3502/4502. Final Exam Part I. May 14, 2005

Chemistry 3502/4502. Final Exam Part I. May 14, 2005 Chemistry 3502/4502 Final Exam Part I May 14, 2005 1. For which of the below systems is = where H is the Hamiltonian operator and T is the kinetic-energy operator? (a) The free particle (e) The

More information

Chemistry 3502/4502. Final Exam Part I. May 14, 2005

Chemistry 3502/4502. Final Exam Part I. May 14, 2005 Advocacy chit Chemistry 350/450 Final Exam Part I May 4, 005. For which of the below systems is = where H is the Hamiltonian operator and T is the kinetic-energy operator? (a) The free particle

More information

LECTURES ON QUANTUM MECHANICS

LECTURES ON QUANTUM MECHANICS LECTURES ON QUANTUM MECHANICS GORDON BAYM Unitsersity of Illinois A II I' Advanced Bock Progrant A Member of the Perseus Books Group CONTENTS Preface v Chapter 1 Photon Polarization 1 Transformation of

More information

Ab initio molecular dynamics and nuclear quantum effects

Ab initio molecular dynamics and nuclear quantum effects Ab initio molecular dynamics and nuclear quantum effects Luca M. Ghiringhelli Fritz Haber Institute Hands on workshop density functional theory and beyond: First principles simulations of molecules and

More information

Quantum Mechanics: Foundations and Applications

Quantum Mechanics: Foundations and Applications Arno Böhm Quantum Mechanics: Foundations and Applications Third Edition, Revised and Enlarged Prepared with Mark Loewe With 96 Illustrations Springer-Verlag New York Berlin Heidelberg London Paris Tokyo

More information

The Transition to Chaos

The Transition to Chaos Linda E. Reichl The Transition to Chaos Conservative Classical Systems and Quantum Manifestations Second Edition With 180 Illustrations v I.,,-,,t,...,* ', Springer Dedication Acknowledgements v vii 1

More information

CHAPTER 6 Quantum Mechanics II

CHAPTER 6 Quantum Mechanics II CHAPTER 6 Quantum Mechanics II 6.1 6.2 6.3 6.4 6.5 6.6 6.7 The Schrödinger Wave Equation Expectation Values Infinite Square-Well Potential Finite Square-Well Potential Three-Dimensional Infinite-Potential

More information

510 Subject Index. Hamiltonian 33, 86, 88, 89 Hamilton operator 34, 164, 166

510 Subject Index. Hamiltonian 33, 86, 88, 89 Hamilton operator 34, 164, 166 Subject Index Ab-initio calculation 24, 122, 161. 165 Acentric factor 279, 338 Activity absolute 258, 295 coefficient 7 definition 7 Atom 23 Atomic units 93 Avogadro number 5, 92 Axilrod-Teller-forces

More information

CHAPTER 5 Wave Properties of Matter and Quantum Mechanics I

CHAPTER 5 Wave Properties of Matter and Quantum Mechanics I CHAPTER 5 Wave Properties of Matter and Quantum Mechanics I 5.1 X-Ray Scattering 5. De Broglie Waves 5.3 Electron Scattering 5.4 Wave Motion 5.5 Waves or Particles? 5.6 Uncertainty Principle Many experimental

More information

P. W. Atkins and R. S. Friedman. Molecular Quantum Mechanics THIRD EDITION

P. W. Atkins and R. S. Friedman. Molecular Quantum Mechanics THIRD EDITION P. W. Atkins and R. S. Friedman Molecular Quantum Mechanics THIRD EDITION Oxford New York Tokyo OXFORD UNIVERSITY PRESS 1997 Introduction and orientation 1 Black-body radiation 1 Heat capacities 2 The

More information

Nanoscale Energy Transport and Conversion A Parallel Treatment of Electrons, Molecules, Phonons, and Photons

Nanoscale Energy Transport and Conversion A Parallel Treatment of Electrons, Molecules, Phonons, and Photons Nanoscale Energy Transport and Conversion A Parallel Treatment of Electrons, Molecules, Phonons, and Photons Gang Chen Massachusetts Institute of Technology OXFORD UNIVERSITY PRESS 2005 Contents Foreword,

More information

Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours.

Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours. Quantum Physics III (8.06) Spring 2007 FINAL EXAMINATION Monday May 21, 9:00 am You have 3 hours. There are 10 problems, totalling 180 points. Do all problems. Answer all problems in the white books provided.

More information

NANO/MICROSCALE HEAT TRANSFER

NANO/MICROSCALE HEAT TRANSFER NANO/MICROSCALE HEAT TRANSFER Zhuomin M. Zhang Georgia Institute of Technology Atlanta, Georgia New York Chicago San Francisco Lisbon London Madrid Mexico City Milan New Delhi San Juan Seoul Singapore

More information

Preface Introduction to the electron liquid

Preface Introduction to the electron liquid Table of Preface page xvii 1 Introduction to the electron liquid 1 1.1 A tale of many electrons 1 1.2 Where the electrons roam: physical realizations of the electron liquid 5 1.2.1 Three dimensions 5 1.2.2

More information

Opinions on quantum mechanics. CHAPTER 6 Quantum Mechanics II. 6.1: The Schrödinger Wave Equation. Normalization and Probability

Opinions on quantum mechanics. CHAPTER 6 Quantum Mechanics II. 6.1: The Schrödinger Wave Equation. Normalization and Probability CHAPTER 6 Quantum Mechanics II 6.1 The Schrödinger Wave Equation 6. Expectation Values 6.3 Infinite Square-Well Potential 6.4 Finite Square-Well Potential 6.5 Three-Dimensional Infinite- 6.6 Simple Harmonic

More information

Electrical Transport in Nanoscale Systems

Electrical Transport in Nanoscale Systems Electrical Transport in Nanoscale Systems Description This book provides an in-depth description of transport phenomena relevant to systems of nanoscale dimensions. The different viewpoints and theoretical

More information

Shigeji Fujita and Salvador V Godoy. Mathematical Physics WILEY- VCH. WILEY-VCH Verlag GmbH & Co. KGaA

Shigeji Fujita and Salvador V Godoy. Mathematical Physics WILEY- VCH. WILEY-VCH Verlag GmbH & Co. KGaA Shigeji Fujita and Salvador V Godoy Mathematical Physics WILEY- VCH WILEY-VCH Verlag GmbH & Co. KGaA Contents Preface XIII Table of Contents and Categories XV Constants, Signs, Symbols, and General Remarks

More information

PHYSICS-PH (PH) Courses. Physics-PH (PH) 1

PHYSICS-PH (PH) Courses. Physics-PH (PH) 1 Physics-PH (PH) 1 PHYSICS-PH (PH) Courses PH 110 Physics of Everyday Phenomena (GT-SC2) Credits: 3 (3-0-0) Fundamental concepts of physics and elementary quantitative reasoning applied to phenomena in

More information

Quantum Physics II (8.05) Fall 2002 Outline

Quantum Physics II (8.05) Fall 2002 Outline Quantum Physics II (8.05) Fall 2002 Outline 1. General structure of quantum mechanics. 8.04 was based primarily on wave mechanics. We review that foundation with the intent to build a more formal basis

More information

Quantum optics. Marian O. Scully Texas A&M University and Max-Planck-Institut für Quantenoptik. M. Suhail Zubairy Quaid-i-Azam University

Quantum optics. Marian O. Scully Texas A&M University and Max-Planck-Institut für Quantenoptik. M. Suhail Zubairy Quaid-i-Azam University Quantum optics Marian O. Scully Texas A&M University and Max-Planck-Institut für Quantenoptik M. Suhail Zubairy Quaid-i-Azam University 1 CAMBRIDGE UNIVERSITY PRESS Preface xix 1 Quantum theory of radiation

More information

NPTEL

NPTEL NPTEL Syllabus Nonequilibrium Statistical Mechanics - Video course COURSE OUTLINE Thermal fluctuations, Langevin dynamics, Brownian motion and diffusion, Fokker-Planck equations, linear response theory,

More information

IV. Classical Molecular Dynamics

IV. Classical Molecular Dynamics IV. Classical Molecular Dynamics Basic Assumptions: 1. Born-Oppenheimer Approximation 2. Classical mechanical nuclear motion Unavoidable Additional Approximations: 1. Approximate potential energy surface

More information

CHAPTER 6 Quantum Mechanics II

CHAPTER 6 Quantum Mechanics II CHAPTER 6 Quantum Mechanics II 6.1 The Schrödinger Wave Equation 6.2 Expectation Values 6.3 Infinite Square-Well Potential 6.4 Finite Square-Well Potential 6.5 Three-Dimensional Infinite-Potential Well

More information

PATH INTEGRALS. Vb World Scientific. in Quantum Mechanics, Statistics, Polymer Physics, and Financial Mar.4ets. 4th Edition.

PATH INTEGRALS. Vb World Scientific. in Quantum Mechanics, Statistics, Polymer Physics, and Financial Mar.4ets. 4th Edition. PATH INTEGRALS in Quantum Mechanics, Statistics, Polymer Physics, and Financial Mar.4ets 4th Edition Hagen KLEINERT Freie Universitaet Berlin llllll 111 1,1,041,1, 119516t1PC111 flfl ounun Vb World Scientific

More information

MESOSCOPIC QUANTUM OPTICS

MESOSCOPIC QUANTUM OPTICS MESOSCOPIC QUANTUM OPTICS by Yoshihisa Yamamoto Ata Imamoglu A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York Chichester Weinheim Brisbane Toronto Singapore Preface xi 1 Basic Concepts

More information

PHYSICS OF SEMICONDUCTORS AND THEIR HETEROSTRUCTURES

PHYSICS OF SEMICONDUCTORS AND THEIR HETEROSTRUCTURES PHYSICS OF SEMICONDUCTORS AND THEIR HETEROSTRUCTURES Jasprit Singh University of Michigan McGraw-Hill, Inc. New York St. Louis San Francisco Auckland Bogota Caracas Lisbon London Madrid Mexico Milan Montreal

More information

Statistical Mechanics

Statistical Mechanics Franz Schwabl Statistical Mechanics Translated by William Brewer Second Edition With 202 Figures, 26 Tables, and 195 Problems 4u Springer Table of Contents 1. Basic Principles 1 1.1 Introduction 1 1.2

More information

OPTI 511R: OPTICAL PHYSICS & LASERS

OPTI 511R: OPTICAL PHYSICS & LASERS OPTI 511R: OPTICAL PHYSICS & LASERS Instructor: R. Jason Jones Office Hours: TBD Teaching Assistant: Robert Rockmore Office Hours: Wed. (TBD) h"p://wp.op)cs.arizona.edu/op)511r/ h"p://wp.op)cs.arizona.edu/op)511r/

More information

DEPARTMENT OF PHYSICS

DEPARTMENT OF PHYSICS Department of Physics 1 DEPARTMENT OF PHYSICS Office in Engineering Building, Room 124 (970) 491-6206 physics.colostate.edu (http://www.physics.colostate.edu) Professor Jacob Roberts, Chair Undergraduate

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

Computational Nanoscience

Computational Nanoscience Computational Nanoscience Applications for Molecules, Clusters, and Solids KALMÄN VARGA AND JOSEPH A. DRISCOLL Vanderbilt University, Tennessee Щ CAMBRIDGE HP UNIVERSITY PRESS Preface Part I One-dimensional

More information

Final Exam. Tuesday, May 8, Starting at 8:30 a.m., Hoyt Hall.

Final Exam. Tuesday, May 8, Starting at 8:30 a.m., Hoyt Hall. Final Exam Tuesday, May 8, 2012 Starting at 8:30 a.m., Hoyt Hall. Summary of Chapter 38 In Quantum Mechanics particles are represented by wave functions Ψ. The absolute square of the wave function Ψ 2

More information

FACULTY OF SCIENCES SYLLABUS FOR. B.Sc. (Non-Medical) PHYSICS PART-II. (Semester: III, IV) Session: , MATA GUJRI COLLEGE

FACULTY OF SCIENCES SYLLABUS FOR. B.Sc. (Non-Medical) PHYSICS PART-II. (Semester: III, IV) Session: , MATA GUJRI COLLEGE FACULTY OF SCIENCES SYLLABUS FOR B.Sc. (Non-Medical) PHYSICS PART-II (Semester: III, IV) Session: 2017 2018, 2018-2019 MATA GUJRI COLLEGE FATEHGARH SAHIB-140406, PUNJAB ----------------------------------------------------------

More information

Lecture Notes. Quantum Theory. Prof. Maximilian Kreuzer. Institute for Theoretical Physics Vienna University of Technology. covering the contents of

Lecture Notes. Quantum Theory. Prof. Maximilian Kreuzer. Institute for Theoretical Physics Vienna University of Technology. covering the contents of Lecture Notes Quantum Theory by Prof. Maximilian Kreuzer Institute for Theoretical Physics Vienna University of Technology covering the contents of 136.019 Quantentheorie I and 136.027 Quantentheorie II

More information

Relational Causality and Classical Probability: Grounding Quantum Phenomenology in a Superclassical Theory

Relational Causality and Classical Probability: Grounding Quantum Phenomenology in a Superclassical Theory Relational Causality and Classical Probability: Grounding Quantum Phenomenology in a Superclassical Theory Gerhard Grössing, Siegfried Fussy, Johannes Mesa Pascasio, Herbert Schwabl Austrian Institute

More information

A Hydrodynamic Interpretation of Quantum Mechanics via Turbulence

A Hydrodynamic Interpretation of Quantum Mechanics via Turbulence [arxiv 1804.0095] A Hydrodynamic Interpretation of Quantum Mechanics via Turbulence Roumen Tsekov 1, Eyal Heifetz and Eliahu Cohen 1 Department of Physical Chemistry, University of Sofia, 1164 Sofia, Bulgaria

More information

CHAPTER 5 Wave Properties of Matter and Quantum Mechanics I

CHAPTER 5 Wave Properties of Matter and Quantum Mechanics I CHAPTER 5 Wave Properties of Matter and Quantum Mechanics I 5.1 X-Ray Scattering 5.2 De Broglie Waves 5.3 Electron Scattering 5.4 Wave Motion 5.5 Waves or Particles? 5.6 Uncertainty Principle 5.7 Probability,

More information

Polymer Dynamics and Rheology

Polymer Dynamics and Rheology Polymer Dynamics and Rheology 1 Polymer Dynamics and Rheology Brownian motion Harmonic Oscillator Damped harmonic oscillator Elastic dumbbell model Boltzmann superposition principle Rubber elasticity and

More information

CHAPTER V. Brownian motion. V.1 Langevin dynamics

CHAPTER V. Brownian motion. V.1 Langevin dynamics CHAPTER V Brownian motion In this chapter, we study the very general paradigm provided by Brownian motion. Originally, this motion is that a heavy particle, called Brownian particle, immersed in a fluid

More information

ANALYTICAL MECHANICS. LOUIS N. HAND and JANET D. FINCH CAMBRIDGE UNIVERSITY PRESS

ANALYTICAL MECHANICS. LOUIS N. HAND and JANET D. FINCH CAMBRIDGE UNIVERSITY PRESS ANALYTICAL MECHANICS LOUIS N. HAND and JANET D. FINCH CAMBRIDGE UNIVERSITY PRESS Preface xi 1 LAGRANGIAN MECHANICS l 1.1 Example and Review of Newton's Mechanics: A Block Sliding on an Inclined Plane 1

More information

202 Index. failure, 26 field equation, 122 force, 1

202 Index. failure, 26 field equation, 122 force, 1 Index acceleration, 12, 161 admissible function, 155 admissible stress, 32 Airy's stress function, 122, 124 d'alembert's principle, 165, 167, 177 amplitude, 171 analogy, 76 anisotropic material, 20 aperiodic

More information

Electron in a Box. A wave packet in a square well (an electron in a box) changing with time.

Electron in a Box. A wave packet in a square well (an electron in a box) changing with time. Electron in a Box A wave packet in a square well (an electron in a box) changing with time. Last Time: Light Wave model: Interference pattern is in terms of wave intensity Photon model: Interference in

More information

Cosmology Lecture 2 Mr. Kiledjian

Cosmology Lecture 2 Mr. Kiledjian Cosmology Lecture 2 Mr. Kiledjian Lecture 2: Quantum Mechanics & Its Different Views and Interpretations a) The story of quantum mechanics begins in the 19 th century as the physicists of that day were

More information

NUMERICAL METHODS IN ASTROPHYSICS An Introduction

NUMERICAL METHODS IN ASTROPHYSICS An Introduction -1 Series in Astronomy and Astrophysics NUMERICAL METHODS IN ASTROPHYSICS An Introduction Peter Bodenheimer University of California Santa Cruz, USA Gregory P. Laughlin University of California Santa Cruz,

More information

Quantum Chaos as a Practical Tool in Many-Body Physics

Quantum Chaos as a Practical Tool in Many-Body Physics Quantum Chaos as a Practical Tool in Many-Body Physics Vladimir Zelevinsky NSCL/ Michigan State University Supported by NSF Statistical Nuclear Physics SNP2008 Athens, Ohio July 8, 2008 THANKS B. Alex

More information

Physics 227 Exam 2. Rutherford said that if you really understand something you should be able to explain it to your grandmother.

Physics 227 Exam 2. Rutherford said that if you really understand something you should be able to explain it to your grandmother. Physics 227 Exam 2 Rutherford said that if you really understand something you should be able to explain it to your grandmother. For each of the topics on the next two pages, write clear, concise, physical

More information

Static & Dynamic. Analysis of Structures. Edward L.Wilson. University of California, Berkeley. Fourth Edition. Professor Emeritus of Civil Engineering

Static & Dynamic. Analysis of Structures. Edward L.Wilson. University of California, Berkeley. Fourth Edition. Professor Emeritus of Civil Engineering Static & Dynamic Analysis of Structures A Physical Approach With Emphasis on Earthquake Engineering Edward LWilson Professor Emeritus of Civil Engineering University of California, Berkeley Fourth Edition

More information

Elementary Lectures in Statistical Mechanics

Elementary Lectures in Statistical Mechanics George DJ. Phillies Elementary Lectures in Statistical Mechanics With 51 Illustrations Springer Contents Preface References v vii I Fundamentals: Separable Classical Systems 1 Lecture 1. Introduction 3

More information

Outline for Fundamentals of Statistical Physics Leo P. Kadanoff

Outline for Fundamentals of Statistical Physics Leo P. Kadanoff Outline for Fundamentals of Statistical Physics Leo P. Kadanoff text: Statistical Physics, Statics, Dynamics, Renormalization Leo Kadanoff I also referred often to Wikipedia and found it accurate and helpful.

More information

Quantum Mechanics for Scientists and Engineers

Quantum Mechanics for Scientists and Engineers Quantum Mechanics for Scientists and Engineers Syllabus and Textbook references All the main lessons (e.g., 1.1) and units (e.g., 1.1.1) for this class are listed below. Mostly, there are three lessons

More information

1. Electricity and Magnetism (Fall 1995, Part 1) A metal sphere has a radius R and a charge Q.

1. Electricity and Magnetism (Fall 1995, Part 1) A metal sphere has a radius R and a charge Q. 1. Electricity and Magnetism (Fall 1995, Part 1) A metal sphere has a radius R and a charge Q. (a) Compute the electric part of the Maxwell stress tensor T ij (r) = 1 {E i E j 12 } 4π E2 δ ij both inside

More information

Semiclassical computational methods for quantum dynamics with bandcrossings. Shi Jin University of Wisconsin-Madison

Semiclassical computational methods for quantum dynamics with bandcrossings. Shi Jin University of Wisconsin-Madison Semiclassical computational methods for quantum dynamics with bandcrossings and uncertainty Shi Jin University of Wisconsin-Madison collaborators Nicolas Crouseilles, Rennes Mohammed Lemou, Rennes Liu

More information

Quantum Chaos. Dominique Delande. Laboratoire Kastler-Brossel Université Pierre et Marie Curie and Ecole Normale Supérieure Paris (European Union)

Quantum Chaos. Dominique Delande. Laboratoire Kastler-Brossel Université Pierre et Marie Curie and Ecole Normale Supérieure Paris (European Union) Quantum Chaos Dominique Delande Laboratoire Kastler-Brossel Université Pierre et Marie Curie and Ecole Normale Supérieure Paris (European Union) What is chaos? What is quantum chaos? Is it useful? Is quantum

More information

Langevin Methods. Burkhard Dünweg Max Planck Institute for Polymer Research Ackermannweg 10 D Mainz Germany

Langevin Methods. Burkhard Dünweg Max Planck Institute for Polymer Research Ackermannweg 10 D Mainz Germany Langevin Methods Burkhard Dünweg Max Planck Institute for Polymer Research Ackermannweg 1 D 55128 Mainz Germany Motivation Original idea: Fast and slow degrees of freedom Example: Brownian motion Replace

More information

Energy Conserving Approximations to the Quantum Potential: Dynamics with Linearized Quantum Force

Energy Conserving Approximations to the Quantum Potential: Dynamics with Linearized Quantum Force University of South Carolina Scholar Commons Faculty Publications Chemistry and Biochemistry, Department of 1-15-2004 Energy Conserving Approximations to the Quantum Potential: Dynamics with Linearized

More information

Stochastic Mechanics of Particles and Fields

Stochastic Mechanics of Particles and Fields Stochastic Mechanics of Particles and Fields Edward Nelson Department of Mathematics, Princeton University These slides are posted at http://math.princeton.edu/ nelson/papers/xsmpf.pdf A preliminary draft

More information

C.W. Gardiner. P. Zoller. Quantum Nois e. A Handbook of Markovian and Non-Markovia n Quantum Stochastic Method s with Applications to Quantum Optics

C.W. Gardiner. P. Zoller. Quantum Nois e. A Handbook of Markovian and Non-Markovia n Quantum Stochastic Method s with Applications to Quantum Optics C.W. Gardiner P. Zoller Quantum Nois e A Handbook of Markovian and Non-Markovia n Quantum Stochastic Method s with Applications to Quantum Optics 1. A Historical Introduction 1 1.1 Heisenberg's Uncertainty

More information

G : Statistical Mechanics

G : Statistical Mechanics G25.2651: Statistical Mechanics Notes for Lecture 1 Defining statistical mechanics: Statistical Mechanics provies the connection between microscopic motion of individual atoms of matter and macroscopically

More information

PRINCIPLES OF PHYSICS. \Hp. Ni Jun TSINGHUA. Physics. From Quantum Field Theory. to Classical Mechanics. World Scientific. Vol.2. Report and Review in

PRINCIPLES OF PHYSICS. \Hp. Ni Jun TSINGHUA. Physics. From Quantum Field Theory. to Classical Mechanics. World Scientific. Vol.2. Report and Review in LONDON BEIJING HONG TSINGHUA Report and Review in Physics Vol2 PRINCIPLES OF PHYSICS From Quantum Field Theory to Classical Mechanics Ni Jun Tsinghua University, China NEW JERSEY \Hp SINGAPORE World Scientific

More information

Fundamentals of Spectroscopy for Optical Remote Sensing. Course Outline 2009

Fundamentals of Spectroscopy for Optical Remote Sensing. Course Outline 2009 Fundamentals of Spectroscopy for Optical Remote Sensing Course Outline 2009 Part I. Fundamentals of Quantum Mechanics Chapter 1. Concepts of Quantum and Experimental Facts 1.1. Blackbody Radiation and

More information

CONTENTS. vii. CHAPTER 2 Operators 15

CONTENTS. vii. CHAPTER 2 Operators 15 CHAPTER 1 Why Quantum Mechanics? 1 1.1 Newtonian Mechanics and Classical Electromagnetism 1 (a) Newtonian Mechanics 1 (b) Electromagnetism 2 1.2 Black Body Radiation 3 1.3 The Heat Capacity of Solids and

More information

Physics 106b: Lecture 7 25 January, 2018

Physics 106b: Lecture 7 25 January, 2018 Physics 106b: Lecture 7 25 January, 2018 Hamiltonian Chaos: Introduction Integrable Systems We start with systems that do not exhibit chaos, but instead have simple periodic motion (like the SHO) with

More information

Quantum Dissipation: A Primer

Quantum Dissipation: A Primer Quantum Dissipation: A Primer P. Hänggi Institut für Physik Universität Augsburg NOISE-INDUCED ESCAPE Reaction-rate theory: fifty years after Kramers CONTENTS Peter Hanggi Lehrstuhl fur Theoretische

More information

Index. Index. More information. in this web service Cambridge University Press

Index. Index. More information.  in this web service Cambridge University Press A-type elements, 4 7, 18, 31, 168, 198, 202, 219, 220, 222, 225 A-type variables. See Across variable ac current, 172, 251 ac induction motor, 251 Acceleration rotational, 30 translational, 16 Accumulator,

More information

Modern Physics for Scientists and Engineers International Edition, 4th Edition

Modern Physics for Scientists and Engineers International Edition, 4th Edition Modern Physics for Scientists and Engineers International Edition, 4th Edition http://optics.hanyang.ac.kr/~shsong Review: 1. THE BIRTH OF MODERN PHYSICS 2. SPECIAL THEORY OF RELATIVITY 3. THE EXPERIMENTAL

More information

Lagrangian Description for Particle Interpretations of Quantum Mechanics Single-Particle Case

Lagrangian Description for Particle Interpretations of Quantum Mechanics Single-Particle Case Lagrangian Description for Particle Interpretations of Quantum Mechanics Single-Particle Case Roderick I. Sutherland Centre for Time, University of Sydney, NSW 26 Australia rod.sutherland@sydney.edu.au

More information

APPLIED PARTIM DIFFERENTIAL EQUATIONS with Fourier Series and Boundary Value Problems

APPLIED PARTIM DIFFERENTIAL EQUATIONS with Fourier Series and Boundary Value Problems APPLIED PARTIM DIFFERENTIAL EQUATIONS with Fourier Series and Boundary Value Problems Fourth Edition Richard Haberman Department of Mathematics Southern Methodist University PEARSON Prentice Hall PEARSON

More information

Massachusetts Tests for Educator Licensure (MTEL )

Massachusetts Tests for Educator Licensure (MTEL ) Massachusetts Tests for Educator Licensure (MTEL ) FIELD 11: PHYSICS TEST OBJECTIVES Subarea Multiple-Choice Range of Objectives Approximate Test Weighting I. Nature of Science 01 05 12% II. Force and

More information

Is Bohm s interpretation of quantum mechanics consistent?

Is Bohm s interpretation of quantum mechanics consistent? arxiv:1404.6588v1 [physics.gen-ph] 25 Apr 2014 Is Bohm s interpretation of quantum mechanics consistent? Abstract The supposed equivalence of the conventional interpretation of quantum mechanics with Bohm

More information

Lecture contents. A few concepts from Quantum Mechanics. Tight-binding model Solid state physics review

Lecture contents. A few concepts from Quantum Mechanics. Tight-binding model Solid state physics review Lecture contents A few concepts from Quantum Mechanics Particle in a well Two wells: QM perturbation theory Many wells (atoms) BAND formation Tight-binding model Solid state physics review Approximations

More information

Quantum Physics III (8.06) Spring 2016 Assignment 3

Quantum Physics III (8.06) Spring 2016 Assignment 3 Quantum Physics III (8.6) Spring 6 Assignment 3 Readings Griffiths Chapter 9 on time-dependent perturbation theory Shankar Chapter 8 Cohen-Tannoudji, Chapter XIII. Problem Set 3. Semi-classical approximation

More information

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition C. Pozrikidis m Springer Contents Preface v 1 Introduction to Kinematics 1 1.1 Fluids and solids 1 1.2 Fluid parcels and flow

More information

Quantum Mechanics for Scientists and Engineers. David Miller

Quantum Mechanics for Scientists and Engineers. David Miller Quantum Mechanics for Scientists and Engineers David Miller Introduction to quantum mechanics Lilght Black-body spectrum Output power (per unit wavelength) For a black body at 5800K approximately like

More information

CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS

CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS CAM Ph.D. Qualifying Exam in Numerical Analysis CONTENTS Preliminaries Round-off errors and computer arithmetic, algorithms and convergence Solutions of Equations in One Variable Bisection method, fixed-point

More information

II Relationship of Classical Theory to Quantum Theory A Quantum mean occupation number

II Relationship of Classical Theory to Quantum Theory A Quantum mean occupation number Appendix B Some Unifying Concepts Version 04.AppB.11.1K [including mostly Chapters 1 through 11] by Kip [This appendix is in the very early stages of development] I Physics as Geometry A Newtonian Physics

More information

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches

Probability density function (PDF) methods 1,2 belong to the broader family of statistical approaches Joint probability density function modeling of velocity and scalar in turbulence with unstructured grids arxiv:6.59v [physics.flu-dyn] Jun J. Bakosi, P. Franzese and Z. Boybeyi George Mason University,

More information

Excitation Dynamics in Quantum Dots. Oleg Prezhdo U. Washington, Seattle

Excitation Dynamics in Quantum Dots. Oleg Prezhdo U. Washington, Seattle Excitation Dynamics in Quantum Dots Oleg Prezhdo U. Washington, Seattle Warwick August 27, 2009 Outline Time-Domain Density Functional Theory & Nonadiabatic Molecular Dynamics Quantum backreaction, surface

More information

MEASUREMENT THEORY QUANTUM AND ITS APPLICATIONS KURT JACOBS. University of Massachusetts at Boston. fg Cambridge WW UNIVERSITY PRESS

MEASUREMENT THEORY QUANTUM AND ITS APPLICATIONS KURT JACOBS. University of Massachusetts at Boston. fg Cambridge WW UNIVERSITY PRESS QUANTUM MEASUREMENT THEORY AND ITS APPLICATIONS KURT JACOBS University of Massachusetts at Boston fg Cambridge WW UNIVERSITY PRESS Contents Preface page xi 1 Quantum measurement theory 1 1.1 Introduction

More information

1. Introduction, tensors, kinematics

1. Introduction, tensors, kinematics 1. Introduction, tensors, kinematics Content: Introduction to fluids, Cartesian tensors, vector algebra using tensor notation, operators in tensor form, Eulerian and Lagrangian description of scalar and

More information

Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model. David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC

Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model. David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC Lagrangian Data Assimilation and Manifold Detection for a Point-Vortex Model David Darmon, AMSC Kayo Ide, AOSC, IPST, CSCAMM, ESSIC Background Data Assimilation Iterative process Forecast Analysis Background

More information

QUANTUM MECHANICS. Yehuda B. Band. and Yshai Avishai WITH APPLICATIONS TO NANOTECHNOLOGY AND INFORMATION SCIENCE

QUANTUM MECHANICS. Yehuda B. Band. and Yshai Avishai WITH APPLICATIONS TO NANOTECHNOLOGY AND INFORMATION SCIENCE QUANTUM MECHANICS WITH APPLICATIONS TO NANOTECHNOLOGY AND INFORMATION SCIENCE Yehuda B. Band Department of Chemistry, Department of Electro-Optics and Department of Physics, and Use Katz Institute for

More information

A. F. J. Levi 1 EE539: Engineering Quantum Mechanics. Fall 2017.

A. F. J. Levi 1 EE539: Engineering Quantum Mechanics. Fall 2017. A. F. J. Levi 1 Engineering Quantum Mechanics. Fall 2017. TTh 9.00 a.m. 10.50 a.m., VHE 210. Web site: http://alevi.usc.edu Web site: http://classes.usc.edu/term-20173/classes/ee EE539: Abstract and Prerequisites

More information