Python Programs.pdf. University of California, Berkeley. From the SelectedWorks of David D Nolte. David D Nolte. April 22, 2019

Size: px
Start display at page:

Download "Python Programs.pdf. University of California, Berkeley. From the SelectedWorks of David D Nolte. David D Nolte. April 22, 2019"

Transcription

1 University of California, Berkeley From the SelectedWorks of David D Nolte April 22, 2019 Python Programs.pdf David D Nolte Available at:

2 Python Scripts for 2D, 3D and 4D Flows Flow2D.py Simple flows for 2D autonomous dynamical systems. Options are: Medio, van der Pol, and Fitzhugh-Nagumo models. Flow3D.py Flows for 3D autonomous dynamical systems. Options are: Lorenz, Rössler and Chua s Circuit. DampedDriven.py Driven-damped oscillators. Options are: driven-damped pendulum and drivendamped double well potential. Plots a two-dimensional Poincaré section. Hamilton4D.py Hamiltonian flows for 4D autonomous systems. Options are: Henon-Heiles potential, and the crescent potential. Plots a two-dimensional Poincaré section. Perturbed.py Driven undampded oscillators with a plane-wave perturbation. Options are: pendulum and double-well potential. These are driven nonlinear Hamiltonian systems. When driven at small perturbation amplitude near the separatrix, chaos emerges. These systems do not conserve energy, because there is a constant input and output of energy as the system reacts against the drive force. Plots a two-dimensional Poincaré section. Lozi.py Discrete iterated Lozi map conserves volume. StandMap.py The Chirikov map, also known as the standard map, is a discrete itereated map with winding numbers and islands of stability. WebMap.py The discrete map of a periodically kicked oscillator displays a broad web of dynamics. D. D. Nolte 1

3 Flow2D.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Mon Apr 16 07:38:57 David Nolte import numpy as np from scipy import integrate from matplotlib import pyplot as plt plt.close('all') # model_case 1 = Medio # model_case 2 = vdp # model_case 3 = Fitzhugh-Nagumo model_case = int(input('input Model Case (1-3)')) def solve_flow(param,lim = [-3,3,-3,3],max_time=10.0): if model_case == 1: # Medio 2D flow def flow_deriv(x_y, t0, a,b,c,alpha): #Compute the time-derivative of a Medio system. x, y = x_y return [a*y + b*x*(c - y**2),-x+alpha] model_title = 'Medio Economics' elif model_case == 2: # van der pol 2D flow def flow_deriv(x_y, t0, alpha,beta): #Compute the time-derivative of a Medio system. x, y = x_y return [y,-alpha*x+beta*(1-x**2)*y] model_title = 'van der Pol Oscillator' # Fitzhugh-Nagumo def flow_deriv(x_y, t0, alpha, beta, gamma): #Compute the time-derivative of a Medio system. x, y = x_y return [y-alpha,-gamma*x+beta*(1-y**2)*y] model_title = 'Fitzhugh-Nagumo Neuron' D. D. Nolte 2

4 plt.figure() xmin = lim[0] xmax = lim[1] ymin = lim[2] ymax = lim[3] plt.axis([xmin, xmax, ymin, ymax]) N=144 colors = plt.cm.prism(np.linspace(0, 1, N)) x0 = np.zeros(shape=(n,2)) ind = -1 for i in range(0,12): for j in range(0,12): ind = ind + 1; x0[ind,0] = ymin-1 + (ymax-ymin+2)*i/11 x0[ind,1] = xmin-1 + (xmax-xmin+2)*j/11 # Solve for the trajectories t = np.linspace(0, max_time, int(250*max_time)) x_t = np.asarray([integrate.odeint(flow_deriv, x0i, t, param) for x0i in x0]) for i in range(n): x, y = x_t[i,:,:].t lines = plt.plot(x, y, '-', c=colors[i]) plt.setp(lines, linewidth=1) plt.show() plt.title(model_title) plt.savefig('flow2d') return t, x_t if model_case == 1: param = (0.9,0.7,0.5,0.6) # Medio lim = (-7,7,-5,5) elif model_case == 2: param = (5, 0.5) # van der Pol lim = (-7,7,-10,10) D. D. Nolte 3

5 param = (0.02,0.5,0.2) lim = (-7,7,-4,4) # Fitzhugh-Nagumo t, x_t = solve_flow(param,lim) D. D. Nolte 4

6 Flow3D.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Mon Apr 16 07:38:57 nolte import numpy as np import matplotlib as mpl from mpl_toolkits.mplot3d import Axes3D from scipy import integrate from matplotlib import pyplot as plt plt.close('all') fig = plt.figure() ax = fig.add_axes([0, 0, 1, 1], projection='3d') ax.axis('on') # model_case 1 = Lorenz # model_case 2 = Rossler # model_case 3 = Chua model_case = int(input('enter Model Case (1-3)')); def solve_lorenz(param, max_time=8.0, angle=0.0): if model_case == 1: # Lorenz 3D flow def flow_deriv(x_y_z, t0, sigma, beta, rho): #Compute the time-derivative of a Lorenz system. x, y, z = x_y_z return [sigma * (y - x), x * (rho - z) - y, x * y - beta * z] model_title = 'Lorenz Attractor' elif model_case == 2: # Rossler 3D flow def flow_deriv(x_y_z, t0, sigma, beta, rho): #Compute the time-derivative of a Medio system. x, y, z = x_y_z return [-y-z, x + sigma*y, beta + z*(x - rho)] model_title = 'Rossler Attractor' # Chua 3D flow def flow_deriv(x_y_z, t0, alpha, beta, c, d): D. D. Nolte 5

7 #Compute the time-derivative of a Medio system. x, y, z = x_y_z f = c*x + 0.5*(d-c)*(abs(x+1)-abs(x-1)) return [alpha*(y-x-f), x-y+z, -beta*y] model_title = 'Chua Attractor' N=12 colors = plt.cm.prism(np.linspace(0, 1, N)) # Choose random starting points, uniformly distributed from -15 to 15 np.random.seed(1) x0 = init1 + init2*np.random.random((n, 3)) # Settle-down Solve for the trajectories t = np.linspace(0, max_time/4, int(250*max_time/4)) x_t = np.asarray([integrate.odeint(flow_deriv, x0i, t, param) for x0i in x0]) # Solve for trajectories x0 = x_t[0:n,int(250*max_time/4)-1,0:3] t = np.linspace(0, max_time, int(250*max_time)) x_t = np.asarray([integrate.odeint(flow_deriv, x0i, t, param) for x0i in x0]) # choose a different color for each trajectory # colors = plt.cm.viridis(np.linspace(0, 1, N)) # colors = plt.cm.rainbow(np.linspace(0, 1, N)) # colors = plt.cm.spectral(np.linspace(0, 1, N)) colors = plt.cm.prism(np.linspace(0, 1, N)) for i in range(n): x, y, z = x_t[i,:,:].t lines = ax.plot(x, y, z, '-', c=colors[i]) plt.setp(lines, linewidth=0.5) ax.view_init(30, angle) plt.show() plt.title(model_title) plt.savefig('flow3d') return t, x_t D. D. Nolte 6

8 if model_case == 1: param = (10, 8/3, 28) # Lorenz ax.set_xlim((-25, 25)) ax.set_ylim((-35, 35)) ax.set_zlim((5, 55)) max_time = 50.0 init1 = -15 init2 = 30 elif model_case == 2: param = (0.2, 0.2, 5.7) # Rossler ax.set_xlim((-15, 15)) ax.set_ylim((-15, 15)) ax.set_zlim((0, 20)) max_time = 200 init1 = -15 init2 = 30 param = (15.6, 28.0, -0.7, ) ax.set_xlim((-3, 3)) ax.set_ylim((-1, 1)) ax.set_zlim((-3, 3)) max_time = 100 init1 = 0 init2 = 0.1 # Chua t, x_t = solve_lorenz(param, max_time,angle=30) plt.figure(2) lines = plt.plot(t,x_t[1,:,0],t,x_t[1,:,1],t,x_t[1,:,2]) plt.setp(lines, linewidth=1) for i in range(4): plt.figure(3) lines = plt.plot(x_t[i,:,0],x_t[i,:,1]) plt.setp(lines,linewidth=0.5) plt.figure(4) lines = plt.plot(x_t[i,:,1],x_t[i,:,2]) plt.setp(lines,linewidth=0.5) plt.figure(5) lines = plt.plot(x_t[i,:,0],x_t[i,:,2]) plt.setp(lines,linewidth=0.5) D. D. Nolte 7

9 D. D. Nolte 8

10 DampedDriven.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Wed May 21 06:03:32 nolte import numpy as np import matplotlib as mpl from mpl_toolkits.mplot3d import Axes3D from scipy import integrate from matplotlib import pyplot as plt from matplotlib import cm import time import os plt.close('all') # model_case 1 = Pendulum # model_case 2 = Double Well model_case = int(input('enter the Model Case (1-2)')) if model_case == 1: F = 1.2 # 0.6 delt = 0.5 # 0.1 w = 2/3 # 0.7 def flow_deriv(x_y_z,tspan): x, y, z = x_y_z a = y b = F*np.cos(w*tspan) - np.sin(x) - delt*y c = w return[a,b,c] alpha = -1 # -1 beta = 1 # 1 gam = 0.3 # 0.3 delta = 0.15 # 0.15 w = 1 def flow_deriv(x_y_z,tspan): x, y, z = x_y_z a = y b = gam*np.cos(w*tspan) - alpha*x - beta*x**3 - delta*y c = w D. D. Nolte 9

11 return[a,b,c] T = 2*np.pi/w px1 =.1 xp1 =.1 w1 = 0 x_y_z = [xp1, px1, w1] # Settle-down Solve for the trajectories t = np.linspace(0, 1000, 10000) x_t = integrate.odeint(flow_deriv, x_y_z, t) x0 = x_t[9999,0:3] tspan = np.linspace(1,40000,400000) x_t = integrate.odeint(flow_deriv, x0, tspan) siztmp = np.shape(x_t) siz = siztmp[0] if model_case == 1: y1 = np.mod(x_t[:,0]-np.pi,2*np.pi)-np.pi y2 = x_t[:,1] y3 = x_t[:,2] y1 = x_t[:,0] y2 = x_t[:,1] y3 = x_t[:,2] plt.figure(2) lines = plt.plot(y1,y2,'ko',ms=1) plt.setp(lines, linewidth=0.5) plt.show() repnum = 5000 px = np.zeros(shape=(2*repnum,)) xvar = np.zeros(shape=(2*repnum,)) cnt = -1 testwt = np.mod(tspan,t)-0.5*t; last = testwt[1] for loop in range(2,siz): if (last < 0)and(testwt[loop] > 0): D. D. Nolte 10

12 cnt = cnt+1 del1 = -testwt[loop-1]/(testwt[loop] - testwt[loop-1]) px[cnt] = (y2[loop]-y2[loop-1])*del1 + y2[loop-1] xvar[cnt] = (y1[loop]-y1[loop-1])*del1 + y1[loop-1] last = testwt[loop] last = testwt[loop] plt.figure(3) lines = plt.plot(xvar,px,'ko',ms=1) plt.show() if model_case == 1: plt.savefig(pendulum) plt.savefig(doublewell) Fig. Driven damped pendulum D. D. Nolte 11

13 Fig. Driven damped double-well potential. D. D. Nolte 12

14 Hamilton4D.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Wed Apr 18 06:03:32 nolte import numpy as np import matplotlib as mpl from mpl_toolkits.mplot3d import Axes3D from scipy import integrate from matplotlib import pyplot as plt from matplotlib import cm import time import os plt.close('all') # model_case 1 = Heiles # model_case 2 = Crescent model_case = int(input('enter the Model Case (1-3)')) if model_case == 1: E = 1 # Heiles: 1, Crescent: 0.05, 1 epse = # 3411 def flow_deriv(x_y_z_w,tspan): x, y, z, w = x_y_z_w a = z b = w c = -x - epse*(2*x*y) d = -y - epse*(x**2 - y**2) return[a,b,c,d] E =.05 # Heiles: 1, Crescent: 0.05, 1 epse = 1 # 3411 def flow_deriv(x_y_z_w,tspan): x, y, z, w = x_y_z_w a = z b = w c = -(epse*(y-2*x**2)*(-4*x) + x) D. D. Nolte 13

15 d = -(y-epse*2*x**2) return[a,b,c,d] prms = np.sqrt(e) pmax = np.sqrt(2*e) # Potential Function if model_case == 1: V = np.zeros(shape=(100,100)) for xloop in range(100): x = *xloop/100 for yloop in range(100): y = *yloop/100 V[yloop,xloop] = 0.5*x** *y**2 + epse*(x**2*y *y**3) V = np.zeros(shape=(100,100)) for xloop in range(100): x = *xloop/100 for yloop in range(100): y = *yloop/100 V[yloop,xloop] = 0.5*x** *y**2 + epse*(2*x**4-2*x**2*y) fig = plt.figure(1) contr = plt.contourf(v,100, cmap=cm.coolwarm, vmin = 0, vmax = 10) fig.colorbar(contr, shrink=0.5, aspect=5) fig = plt.show() repnum = 250 mulnum = 64/repnum np.random.seed(1) for reploop in range(repnum): px1 = 2*(np.random.random((1))-0.499)*pmax py1 = np.sign(np.random.random((1))-0.499)*np.real(np.sqrt(2*(e-px1**2/2))) xp1 = 0 yp1 = 0 x_y_z_w0 = [xp1, yp1, px1, py1] tspan = np.linspace(1,1000,10000) x_t = integrate.odeint(flow_deriv, x_y_z_w0, tspan) siztmp = np.shape(x_t) siz = siztmp[0] D. D. Nolte 14

16 if reploop % 50 == 0: plt.figure(2) lines = plt.plot(x_t[:,0],x_t[:,1]) plt.setp(lines, linewidth=0.5) plt.show() time.sleep(0.1) #os.system("pause") y1 = x_t[:,0] y2 = x_t[:,1] y3 = x_t[:,2] y4 = x_t[:,3] py = np.zeros(shape=(2*repnum,)) yvar = np.zeros(shape=(2*repnum,)) cnt = -1 last = y1[1] for loop in range(2,siz): if (last < 0)and(y1[loop] > 0): cnt = cnt+1 del1 = -y1[loop-1]/(y1[loop] - y1[loop-1]) py[cnt] = y4[loop-1] + del1*(y4[loop]-y4[loop-1]) yvar[cnt] = y2[loop-1] + del1*(y2[loop]-y2[loop-1]) last = y1[loop] last = y1[loop] plt.figure(3) lines = plt.plot(yvar,py,'o',ms=1) plt.show() if model_case == 1: plt.savefig('heiles') plt.savefig('crescent') D. D. Nolte 15

17 Fig. Heiles Figl Crescent D. D. Nolte 16

18 Perturbed.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Wed May 21 06:03:32 nolte from IPython import get_ipython get_ipython().magic('reset -f') import numpy as np import matplotlib as mpl from mpl_toolkits.mplot3d import Axes3D from scipy import integrate from matplotlib import pyplot as plt from matplotlib import cm import time import os plt.close('all') # model_case 1 = Pendulum # model_case 2 = Double Well print(' ') print('dampeddriven.py') print('case: 1 = Pendulum 2 = Double Well') model_case = int(input('enter the Model Case (1-2)')) if model_case == 1: F = 0.02 # 0.6 delt = 0.0 # 0.1 w = 3/4 # 0.7 k = 2 phase = 0 px1 = xp1 = 0 w1 = 0 def flow_deriv(x_y_z,tspan): x, y, z = x_y_z a = y b = F*np.cos(-w*tspan + k*x + phase) - np.sin(x) - delt*y c = w D. D. Nolte 17

19 return[a,b,c] alpha = -1 # -1 beta = 1 # 1 F = # 0.3 delta = 0.0 # 0.15 w = 1 k = 1 phase = np.random.random() px1 = 0 xp1 = 0 w1 = 0 def flow_deriv(x_y_z,tspan): x, y, z = x_y_z a = y b = F*np.cos(-w*tspan + k*x + phase) - alpha*x - beta*x**3 - delta*y c = w return[a,b,c] T = 2*np.pi/w x_y_z = [xp1, px1, w1] # Settle-down Solve for the trajectories t = np.linspace(0, 2000, 20000) x_t1 = integrate.odeint(flow_deriv, x_y_z, t) x0 = x_t1[9999,0:3] tlim = # number of points nt = #stop time tspan = np.linspace(1,nt,tlim) x_t = integrate.odeint(flow_deriv, x0, tspan, rtol=1e-8) siztmp = np.shape(x_t) siz = siztmp[0] y1 = np.zeros(shape=(2*tlim,)) y2 = np.zeros(shape=(2*tlim,)) if model_case == 1: y1tmp = np.mod(x_t[:,0]-np.pi,2*np.pi)-np.pi y2tmp = x_t[:,1] y1[0:tlim] = y1tmp y1[tlim:2*tlim] = y1tmp+2*np.pi y2[0:tlim] = y2tmp D. D. Nolte 18

20 y2[tlim:2*tlim] = y2tmp y3 = x_t[:,2] Energy = 0.5*x_t[:,1]** np.cos(x_t[:,0]) y1 = x_t[:,0] y2 = x_t[:,1] y3 = x_t[:,2] Energy = 0.5*x_t[:,1]** *alpha*x_t[:,0]** *beta*x_t[:,0]**4 plt.figure(1) lines = plt.plot(y1,y2,'ko',ms=1) plt.setp(lines, linewidth=0.5) plt.title('phase Portrait') plt.show() plt.figure(2) lines = plt.plot(y3[0:3000],y2[0:3000]) plt.setp(lines, linewidth=0.5) plt.title('velocity') plt.show() plt.figure(3) lines = plt.plot(y3[0:3000],energy[0:3000]) plt.setp(lines, linewidth=0.5) plt.title('energy') plt.show() # First-Return Map repnum = 5000 px = np.zeros(shape=(2*repnum,)) xvartmp = np.zeros(shape=(2*repnum,)) cnt = -1 testwt = np.mod(tspan,t)-0.5*t; last = testwt[0] for loop in range(1,siz): if (last < 0)and(testwt[loop] > 0): cnt = cnt+1 del1 = -testwt[loop-1]/(testwt[loop] - testwt[loop-1]) px[cnt] = (y2[loop]-y2[loop-1])*del1 + y2[loop-1] xvartmp[cnt] = (x_t[loop,0]-x_t[loop-1,0])*del1 + x_t[loop-1,0] #xvar[cnt] = y1[loop] D. D. Nolte 19

21 last = testwt[loop] last = testwt[loop] # Plot First Return Map if model_case == 1: xvar = np.mod(xvartmp-np.pi,2*np.pi)-np.pi pxx = np.zeros(shape=(2*cnt,)) xvarr = np.zeros(shape=(2*cnt,)) xvarr[0:cnt] = xvar[0:cnt] xvarr[cnt:2*cnt] = xvar[0:cnt]+2*np.pi pxx[0:cnt] = px[0:cnt] pxx[cnt:2*cnt] = px[0:cnt] plt.figure(4) lines = plt.plot(xvarr,pxx,'ko',ms=0.5) plt.xlim(xmin=0, xmax=2*np.pi) plt.title('first Return Map') plt.show() plt.savefig('ppendulum') xvar = xvartmp plt.figure(4) lines = plt.plot(xvar,px,'ko',ms=0.5) #mpl.pyplot.xlim(xmin=0, xmax=2*np.pi) plt.title('first Return Map') plt.show() plt.savefig('pdoublewell') D. D. Nolte 20

22 Fig. Perturbed pendulum Fig. Perturbed double well D. D. Nolte 21

23 Lozi.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Wed May 2 16:17:27 nolte import numpy as np from scipy import integrate from matplotlib import pyplot as plt #plt.close('all') B = -1 C = 0.5 np.random.seed(2) plt.figure(1) for eloop in range(0,100): xlast = np.random.normal(0,1,1) ylast = np.random.normal(0,1,1) xnew = np.zeros(shape=(500,)) ynew = np.zeros(shape=(500,)) for loop in range(0,500): xnew[loop] = 1 + ylast - C*abs(xlast) ynew[loop] = B*xlast xlast = xnew[loop] ylast = ynew[loop] plt.plot(np.real(xnew),np.real(ynew),'o',ms=1) plt.xlim(xmin=-1.25,xmax=2) plt.ylim(ymin=-2,ymax=1.25) plt.savefig('lozi') D. D. Nolte 22

24 Fig. Lozi map. B = -1, C = 0.5. D. D. Nolte 23

25 StandMap.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Wed May 2 16:17:27 nolte import numpy as np from scipy import integrate from matplotlib import pyplot as plt plt.close('all') eps = 0.97 np.random.seed(2) plt.figure(1) for eloop in range(0,200): rlast = 2*np.pi*(0.5-np.random.random()) thlast = 2*np.pi*np.random.random() # rold = 2.0*pi*(0.5-rand); # thetold = 2.0*pi*rand; rplot = np.zeros(shape=(200,)) thetaplot = np.zeros(shape=(200,)) for loop in range(0,200): rnew = rlast + eps*np.sin(thlast) thnew = np.mod(thlast+rnew,2*np.pi) thetaplot[loop] = np.mod(thnew-np.pi,2*np.pi) - np.pi if rnew > np.pi: rtemp = rnew-2*np.pi elif rnew < -np.pi: rtemp = 2*np.pi + rnew rtemp = rnew rplot[loop] = np.mod(0.5 + (rtemp + np.pi)/2/np.pi,1) D. D. Nolte 24

26 rlast = rnew thlast = thnew plt.plot(np.real(thetaplot),np.real(rplot),'o',ms=1) # plt.xlim(xmin=-np.pi,xmax=np.pi) # plt.ylim(ymin=-np.pi,ymax=2*np.pi) plt.savefig('standmap') Fig. Standard map. ε = 0.97 D. D. Nolte 25

27 WebMap.py #!/usr/bin/env python3 # -*- coding: utf-8 -*- Created on Wed May 2 16:17:27 nolte import numpy as np from scipy import integrate from matplotlib import pyplot as plt plt.close('all') phi = (1+np.sqrt(5))/2 K = 1-phi # (0.618, 4) (0.618,5) (0.618,7) (1.2, 4) q = 4 # 4, 5, 6, 7 alpha = 2*np.pi/q np.random.seed(2) plt.figure(1) for eloop in range(0,1000): xlast = 50*np.random.random() ylast = 50*np.random.random() xnew = np.zeros(shape=(300,)) ynew = np.zeros(shape=(300,)) for loop in range(0,300): xnew[loop] = (xlast + K*np.sin(ylast))*np.cos(alpha) + ylast*np.sin(alpha) ynew[loop] = -(xlast + K*np.sin(ylast))*np.sin(alpha) + ylast*np.cos(alpha) xlast = xnew[loop] ylast = ynew[loop] plt.plot(np.real(xnew),np.real(ynew),'o',ms=1) plt.xlim(xmin=-60,xmax=60) plt.ylim(ymin=-60,ymax=60) plt.title('webmap') plt.savefig('webmap') D. D. Nolte 26

28 Fig. Web map. K = φ 1. q = 4 D. D. Nolte 27

APPM 2460 CHAOTIC DYNAMICS

APPM 2460 CHAOTIC DYNAMICS APPM 2460 CHAOTIC DYNAMICS 1. Introduction Today we ll continue our exploration of dynamical systems, focusing in particular upon systems who exhibit a type of strange behavior known as chaos. We will

More information

Lorenz Equations. Lab 1. The Lorenz System

Lorenz Equations. Lab 1. The Lorenz System Lab 1 Lorenz Equations Chaos: When the present determines the future, but the approximate present does not approximately determine the future. Edward Lorenz Lab Objective: Investigate the behavior of a

More information

Exercise_set7_programming_exercises

Exercise_set7_programming_exercises Exercise_set7_programming_exercises May 13, 2018 1 Part 1(d) We start by defining some function that will be useful: The functions defining the system, and the Hamiltonian and angular momentum. In [1]:

More information

Complex Numbers. A complex number z = x + iy can be written in polar coordinates as re i where

Complex Numbers. A complex number z = x + iy can be written in polar coordinates as re i where Lab 20 Complex Numbers Lab Objective: Create visualizations of complex functions. Visually estimate their zeros and poles, and gain intuition about their behavior in the complex plane. Representations

More information

Complex Numbers. Visualize complex functions to estimate their zeros and poles.

Complex Numbers. Visualize complex functions to estimate their zeros and poles. Lab 1 Complex Numbers Lab Objective: Visualize complex functions to estimate their zeros and poles. Polar Representation of Complex Numbers Any complex number z = x + iy can be written in polar coordinates

More information

System Control Engineering 0

System Control Engineering 0 System Control Engineering 0 Koichi Hashimoto Graduate School of Information Sciences Text: Nonlinear Control Systems Analysis and Design, Wiley Author: Horacio J. Marquez Web: http://www.ic.is.tohoku.ac.jp/~koichi/system_control/

More information

Sheet 5 solutions. August 15, 2017

Sheet 5 solutions. August 15, 2017 Sheet 5 solutions August 15, 2017 Exercise 1: Sampling Implement three functions in Python which generate samples of a normal distribution N (µ, σ 2 ). The input parameters of these functions should be

More information

MAS212 Scientific Computing and Simulation

MAS212 Scientific Computing and Simulation MAS212 Scientific Computing and Simulation Dr. Sam Dolan School of Mathematics and Statistics, University of Sheffield Autumn 2017 http://sam-dolan.staff.shef.ac.uk/mas212/ G18 Hicks Building s.dolan@sheffield.ac.uk

More information

Variational Monte Carlo to find Ground State Energy for Helium

Variational Monte Carlo to find Ground State Energy for Helium Variational Monte Carlo to find Ground State Energy for Helium Chris Dopilka December 2, 2011 1 Introduction[1][2] The variational principle from quantum mechanics gives us a way to estimate the ground

More information

Here we consider soliton solutions of the Korteweg-de Vries (KdV) equation. This equation is given by u t + u u x + 3 u

Here we consider soliton solutions of the Korteweg-de Vries (KdV) equation. This equation is given by u t + u u x + 3 u Lab 3 Solitons Lab Objective: We study traveling wave solutions of the Korteweg-de Vries (KdV) equation, using a pseudospectral discretization in space and a Runge-Kutta integration scheme in time. Here

More information

MATH 250 Homework 4: Due May 4, 2017

MATH 250 Homework 4: Due May 4, 2017 Due May 4, 17 Answer the following questions to the best of your ability. Solutions should be typed. Any plots or graphs should be included with the question (please include the questions in your solutions).

More information

The Shooting Method for Boundary Value Problems

The Shooting Method for Boundary Value Problems 1 The Shooting Method for Boundary Value Problems Consider a boundary value problem of the form y = f(x, y, y ), a x b, y(a) = α, y(b) = β. (1.1) One natural way to approach this problem is to study the

More information

vii Contents 7.5 Mathematica Commands in Text Format 7.6 Exercises

vii Contents 7.5 Mathematica Commands in Text Format 7.6 Exercises Preface 0. A Tutorial Introduction to Mathematica 0.1 A Quick Tour of Mathematica 0.2 Tutorial 1: The Basics (One Hour) 0.3 Tutorial 2: Plots and Differential Equations (One Hour) 0.4 Mathematica Programs

More information

lab6 October 25, 2015

lab6 October 25, 2015 lab6 October 25, 2015 Contents 1. Objectives 2. Readings 3. Introduction 3.1 Using the integrator class 4. The Lorenz Equations 4.1 Boundedness of the Solutions 4.2 Steady States 4.3 Linearization of the

More information

Optimization with Scipy (2)

Optimization with Scipy (2) Optimization with Scipy (2) Unconstrained Optimization Cont d & 1D optimization Harry Lee February 5, 2018 CEE 696 Table of contents 1. Unconstrained Optimization 2. 1D Optimization 3. Multi-dimensional

More information

GES 554 PDE MEMO. Memo: GES554-Project-2. REF: Ext:

GES 554 PDE MEMO. Memo: GES554-Project-2. REF: Ext: GES 554 PDE MEMO Subject: Heat Diffusion with Rectified Sine Initial Condition TO: GES 554.1 GES 554.996 CC: Date: 12 Feb 214 Memo: GES554-Project-2 From: REF: Ext: 8-5161 Summary: Charles O Neill This

More information

Stochastic processes and Data mining

Stochastic processes and Data mining Stochastic processes and Data mining Meher Krishna Patel Created on : Octorber, 2017 Last updated : May, 2018 More documents are freely available at PythonDSP Table of contents Table of contents i 1 The

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations 1 An Oscillating Pendulum applying the forward Euler method 2 Celestial Mechanics simulating the n-body problem 3 The Tractrix Problem setting up the differential equations

More information

Dynamical Systems with Applications using Mathematica

Dynamical Systems with Applications using Mathematica Stephen Lynch Dynamical Systems with Applications using Mathematica Birkhäuser Boston Basel Berlin Contents Preface xi 0 A Tutorial Introduction to Mathematica 1 0.1 A Quick Tour of Mathematica 2 0.2 Tutorial

More information

DIFFERENTIAL GEOMETRY APPLIED TO DYNAMICAL SYSTEMS

DIFFERENTIAL GEOMETRY APPLIED TO DYNAMICAL SYSTEMS WORLD SCIENTIFIC SERIES ON NONLINEAR SCIENCE Series Editor: Leon O. Chua Series A Vol. 66 DIFFERENTIAL GEOMETRY APPLIED TO DYNAMICAL SYSTEMS Jean-Marc Ginoux Université du Sud, France World Scientific

More information

DIFFERENTIAL EQUATIONS, DYNAMICAL SYSTEMS, AND AN INTRODUCTION TO CHAOS

DIFFERENTIAL EQUATIONS, DYNAMICAL SYSTEMS, AND AN INTRODUCTION TO CHAOS DIFFERENTIAL EQUATIONS, DYNAMICAL SYSTEMS, AND AN INTRODUCTION TO CHAOS Morris W. Hirsch University of California, Berkeley Stephen Smale University of California, Berkeley Robert L. Devaney Boston University

More information

Solving Linear Systems of ODEs with Matlab

Solving Linear Systems of ODEs with Matlab Solving Linear Systems of ODEs with Matlab James K. Peterson Department of Biological Sciences and Department of Mathematical Sciences Clemson University October 27, 2013 Outline Linear Systems Numerically

More information

Test 2 - Python Edition

Test 2 - Python Edition 'XNH8QLYHUVLW\ (GPXQG7UDWW-U6FKRRORI(QJLQHHULQJ EGR 10L Spring 2018 Test 2 - Python Edition Shaundra B. Daily & Michael R. Gustafson II Name (please print): NetID (please print): In keeping with the Community

More information

Driven, damped, pendulum

Driven, damped, pendulum Driven, damped, pendulum Note: The notation and graphs in this notebook parallel those in Chaotic Dynamics by Baker and Gollub. (There's a copy in the department office.) For the driven, damped, pendulum,

More information

Here we consider soliton solutions of the Korteweg-de Vries (KdV) equation. This equation is given by

Here we consider soliton solutions of the Korteweg-de Vries (KdV) equation. This equation is given by 17 Solitons Lab Objective: We study traveling wave solutions of the Korteweg-de Vries (KdV) equation, using a pseudospectral discretization in space and a Runge-Kutta integration scheme in time. Here we

More information

DM534 - Introduction to Computer Science

DM534 - Introduction to Computer Science Department of Mathematics and Computer Science University of Southern Denmark, Odense October 21, 2016 Marco Chiarandini DM534 - Introduction to Computer Science Training Session, Week 41-43, Autumn 2016

More information

DIFFERENTIAL EQUATIONS, DYNAMICAL SYSTEMS, AND AN INTRODUCTION TO CHAOS

DIFFERENTIAL EQUATIONS, DYNAMICAL SYSTEMS, AND AN INTRODUCTION TO CHAOS DIFFERENTIAL EQUATIONS, DYNAMICAL SYSTEMS, AND AN INTRODUCTION TO CHAOS Morris W. Hirsch University of California, Berkeley Stephen Smale University of California, Berkeley Robert L. Devaney Boston University

More information

Contents Dynamical Systems Stability of Dynamical Systems: Linear Approach

Contents Dynamical Systems Stability of Dynamical Systems: Linear Approach Contents 1 Dynamical Systems... 1 1.1 Introduction... 1 1.2 DynamicalSystems andmathematical Models... 1 1.3 Kinematic Interpretation of a System of Differential Equations... 3 1.4 Definition of a Dynamical

More information

Modelling biological oscillations

Modelling biological oscillations Modelling biological oscillations Shan He School for Computational Science University of Birmingham Module 06-23836: Computational Modelling with MATLAB Outline Outline of Topics Van der Pol equation Van

More information

Image Processing in Numpy

Image Processing in Numpy Version: January 17, 2017 Computer Vision Laboratory, Linköping University 1 Introduction Image Processing in Numpy Exercises During this exercise, you will become familiar with image processing in Python.

More information

STATISTICAL THINKING IN PYTHON I. Probabilistic logic and statistical inference

STATISTICAL THINKING IN PYTHON I. Probabilistic logic and statistical inference STATISTICAL THINKING IN PYTHON I Probabilistic logic and statistical inference 50 measurements of petal length Statistical Thinking in Python I 50 measurements of petal length Statistical Thinking in Python

More information

Dynamical Systems with Applications

Dynamical Systems with Applications Stephen Lynch Dynamical Systems with Applications using MATLAB Birkhauser Boston Basel Berlin Preface xi 0 A Tutorial Introduction to MATLAB and the Symbolic Math Toolbox 1 0.1 Tutorial One: The Basics

More information

Non-linear dynamics Yannis PAPAPHILIPPOU CERN

Non-linear dynamics Yannis PAPAPHILIPPOU CERN Non-linear dynamics Yannis PAPAPHILIPPOU CERN United States Particle Accelerator School, University of California - Santa-Cruz, Santa Rosa, CA 14 th 18 th January 2008 1 Summary Driven oscillators and

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations 1 2 3 MCS 507 Lecture 30 Mathematical, Statistical and Scientific Software Jan Verschelde, 31 October 2011 Ordinary Differential Equations 1 2 3 a simple pendulum Imagine

More information

Test 2 Solutions - Python Edition

Test 2 Solutions - Python Edition 'XNH8QLYHUVLW\ (GPXQG73UDWW-U6FKRRORI(QJLQHHULQJ EGR 103L Fall 2017 Test 2 Solutions - Python Edition Michael R. Gustafson II Name (please print) NET ID (please print): In keeping with the Community Standard,

More information

2 Getting Started with Numerical Computations in Python

2 Getting Started with Numerical Computations in Python 1 Documentation and Resources * Download: o Requirements: Python, IPython, Numpy, Scipy, Matplotlib o Windows: google "windows download (Python,IPython,Numpy,Scipy,Matplotlib" o Debian based: sudo apt-get

More information

MODELING BY NONLINEAR DIFFERENTIAL EQUATIONS

MODELING BY NONLINEAR DIFFERENTIAL EQUATIONS MODELING BY NONLINEAR DIFFERENTIAL EQUATIONS Dissipative and Conservative Processes WORLD SCIENTIFIC SERIES ON NONLINEAR SCIENCE Editor: Leon O. Chua University of California, Berkeley Series A. Volume

More information

Engineering Computation in

Engineering Computation in Engineering Computation in Dr. Kyle Horne Department of Mechanical Engineering Spring, 2018 What is It? 140 Explicit Implicit 120 100 Temperature T [C] Position y [px] 15 10 5 0 5 10 15 24.5 24.0 23.5

More information

Why are Discrete Maps Sufficient?

Why are Discrete Maps Sufficient? Why are Discrete Maps Sufficient? Why do dynamical systems specialists study maps of the form x n+ 1 = f ( xn), (time is discrete) when much of the world around us evolves continuously, and is thus well

More information

Linear Classification

Linear Classification Linear Classification by Prof. Seungchul Lee isystems Design Lab http://isystems.unist.ac.kr/ UNIS able of Contents I.. Supervised Learning II.. Classification III. 3. Perceptron I. 3.. Linear Classifier

More information

Python Analysis. PHYS 224 September 25/26, 2014

Python Analysis. PHYS 224 September 25/26, 2014 Python Analysis PHYS 224 September 25/26, 2014 Goals Two things to teach in this lecture 1. How to use python to fit data 2. How to interpret what python gives you Some references: http://nbviewer.ipython.org/url/media.usm.maine.edu/~pauln/

More information

Computational Methods for Nonlinear Systems

Computational Methods for Nonlinear Systems Computational Methods for Nonlinear Systems Cornell Physics 682 / CIS 629 Chris Myers Computational Methods for Nonlinear Systems Graduate computational science laboratory course developed by Myers & Sethna

More information

Python Analysis. PHYS 224 October 1/2, 2015

Python Analysis. PHYS 224 October 1/2, 2015 Python Analysis PHYS 224 October 1/2, 2015 Goals Two things to teach in this lecture 1. How to use python to fit data 2. How to interpret what python gives you Some references: http://nbviewer.ipython.org/url/media.usm.maine.edu/~pauln/

More information

Lecture 1: A Preliminary to Nonlinear Dynamics and Chaos

Lecture 1: A Preliminary to Nonlinear Dynamics and Chaos Lecture 1: A Preliminary to Nonlinear Dynamics and Chaos Autonomous Systems A set of coupled autonomous 1st-order ODEs. Here "autonomous" means that the right hand side of the equations does not explicitly

More information

TWO DIMENSIONAL FLOWS. Lecture 5: Limit Cycles and Bifurcations

TWO DIMENSIONAL FLOWS. Lecture 5: Limit Cycles and Bifurcations TWO DIMENSIONAL FLOWS Lecture 5: Limit Cycles and Bifurcations 5. Limit cycles A limit cycle is an isolated closed trajectory [ isolated means that neighbouring trajectories are not closed] Fig. 5.1.1

More information

HOMEWORK 3: Phase portraits for Mathmatical Models, Analysis and Simulation, Fall 2010 Report due Mon Oct 4, Maximum score 7.0 pts.

HOMEWORK 3: Phase portraits for Mathmatical Models, Analysis and Simulation, Fall 2010 Report due Mon Oct 4, Maximum score 7.0 pts. HOMEWORK 3: Phase portraits for Mathmatical Models, Analysis and Simulation, Fall 2010 Report due Mon Oct 4, 2010. Maximum score 7.0 pts. Three problems are to be solved in this homework assignment. The

More information

Computational Methods for Nonlinear Systems

Computational Methods for Nonlinear Systems Computational Methods for Nonlinear Systems Cornell Physics 682 / CIS 629 James P. Sethna Christopher R. Myers Computational Methods for Nonlinear Systems Graduate computational science laboratory course

More information

xt+1 = 1 ax 2 t + y t y t+1 = bx t (1)

xt+1 = 1 ax 2 t + y t y t+1 = bx t (1) Exercise 2.2: Hénon map In Numerical study of quadratic area-preserving mappings (Commun. Math. Phys. 50, 69-77, 1976), the French astronomer Michel Hénon proposed the following map as a model of the Poincaré

More information

Conditioning and Stability

Conditioning and Stability Lab 17 Conditioning and Stability Lab Objective: Explore the condition of problems and the stability of algorithms. The condition number of a function measures how sensitive that function is to changes

More information

MAS212 Assignment #2: The damped driven pendulum

MAS212 Assignment #2: The damped driven pendulum MAS Assignment #: The damped driven pendulum Dr. Sam Dolan (s.dolan@sheffield.ac.uk) Introduction: In this assignment you will use Python to investigate a non-linear differential equation which models

More information

CS 237 Fall 2018, Homework 07 Solution

CS 237 Fall 2018, Homework 07 Solution CS 237 Fall 2018, Homework 07 Solution Due date: Thursday November 1st at 11:59 pm (10% off if up to 24 hours late) via Gradescope General Instructions Please complete this notebook by filling in solutions

More information

Linear Transformations

Linear Transformations Lab 4 Linear Transformations Lab Objective: Linear transformations are the most basic and essential operators in vector space theory. In this lab we visually explore how linear transformations alter points

More information

Computational Physics HW2

Computational Physics HW2 Computational Physics HW2 Luke Bouma July 27, 2015 1 Plotting experimental data 1.1 Plotting sunspots.txt in Python: The figure above is the output from from numpy import l o a d t x t data = l o a d t

More information

11 Chaos in Continuous Dynamical Systems.

11 Chaos in Continuous Dynamical Systems. 11 CHAOS IN CONTINUOUS DYNAMICAL SYSTEMS. 47 11 Chaos in Continuous Dynamical Systems. Let s consider a system of differential equations given by where x(t) : R R and f : R R. ẋ = f(x), The linearization

More information

QR 2: Least Squares and Computing Eigenvalues

QR 2: Least Squares and Computing Eigenvalues Lab 8 QR : Least Squares and Computing Eigenvalues Lab Objective: Because of its numerical stability and convenient structure, the QR decomposition is the basis of many important and practical algorithms

More information

The Metropolis Algorithm

The Metropolis Algorithm 16 Metropolis Algorithm Lab Objective: Understand the basic principles of the Metropolis algorithm and apply these ideas to the Ising Model. The Metropolis Algorithm Sampling from a given probability distribution

More information

CHALMERS, GÖTEBORGS UNIVERSITET. EXAM for DYNAMICAL SYSTEMS. COURSE CODES: TIF 155, FIM770GU, PhD

CHALMERS, GÖTEBORGS UNIVERSITET. EXAM for DYNAMICAL SYSTEMS. COURSE CODES: TIF 155, FIM770GU, PhD CHALMERS, GÖTEBORGS UNIVERSITET EXAM for DYNAMICAL SYSTEMS COURSE CODES: TIF 155, FIM770GU, PhD Time: Place: Teachers: Allowed material: Not allowed: August 22, 2018, at 08 30 12 30 Johanneberg Jan Meibohm,

More information

Handout 2: Invariant Sets and Stability

Handout 2: Invariant Sets and Stability Engineering Tripos Part IIB Nonlinear Systems and Control Module 4F2 1 Invariant Sets Handout 2: Invariant Sets and Stability Consider again the autonomous dynamical system ẋ = f(x), x() = x (1) with state

More information

Chaos, Solitons and Fractals

Chaos, Solitons and Fractals Chaos, Solitons and Fractals 41 (2009) 962 969 Contents lists available at ScienceDirect Chaos, Solitons and Fractals journal homepage: www.elsevier.com/locate/chaos A fractional-order hyperchaotic system

More information

Analysis of Dynamical Systems

Analysis of Dynamical Systems 2 YFX1520 Nonlinear phase portrait Mathematical Modelling and Nonlinear Dynamics Coursework Assignments 1 ϕ (t) 0-1 -2-6 -4-2 0 2 4 6 ϕ(t) Dmitri Kartofelev, PhD 2018 Variant 1 Part 1: Liénard type equation

More information

CHALMERS, GÖTEBORGS UNIVERSITET. EXAM for DYNAMICAL SYSTEMS. COURSE CODES: TIF 155, FIM770GU, PhD

CHALMERS, GÖTEBORGS UNIVERSITET. EXAM for DYNAMICAL SYSTEMS. COURSE CODES: TIF 155, FIM770GU, PhD CHALMERS, GÖTEBORGS UNIVERSITET EXAM for DYNAMICAL SYSTEMS COURSE CODES: TIF 155, FIM770GU, PhD Time: Place: Teachers: Allowed material: Not allowed: January 08, 2018, at 08 30 12 30 Johanneberg Kristian

More information

lektion10 1 Lektion 10 January 29, Lineare Algebra II

lektion10 1 Lektion 10 January 29, Lineare Algebra II lektion January 29, 28 Table of Contents Lineare Algebra II. Matrixplots.2 Eigenwerte, Eigenvektoren, Jordannormalform.3 Berechung des Rangs.4 Normen.5 Kreuzprodukt 2 Reihenentwicklung (Taylor) In [2]:

More information

Analysis of Nonlinear Dynamics by Square Matrix Method

Analysis of Nonlinear Dynamics by Square Matrix Method Analysis of Nonlinear Dynamics by Square Matrix Method Li Hua Yu Brookhaven National Laboratory NOCE, Arcidosso, Sep. 2017 Write one turn map of Taylor expansion as square matrix Simplest example of nonlinear

More information

SVD and Image Compression

SVD and Image Compression The SVD and Image Compression Lab Objective: The Singular Value Decomposition (SVD) is an incredibly useful matrix factorization that is widely used in both theoretical and applied mathematics. The SVD

More information

Lecture 08: Poisson and More. Lisa Yan July 13, 2018

Lecture 08: Poisson and More. Lisa Yan July 13, 2018 Lecture 08: Poisson and More Lisa Yan July 13, 2018 Announcements PS1: Grades out later today Solutions out after class today PS2 due today PS3 out today (due next Friday 7/20) 2 Midterm announcement Tuesday,

More information

Uniform and constant electromagnetic fields

Uniform and constant electromagnetic fields Fundamentals of Plasma Physics, Nuclear Fusion and Lasers Single Particle Motion Uniform and constant electromagnetic fields Nuno R. Pinhão 2015, March In this notebook we analyse the movement of individual

More information

Write a simple 1D DFT code in Python

Write a simple 1D DFT code in Python Write a simple 1D DFT code in Python Ask Hjorth Larsen, asklarsen@gmail.com Keenan Lyon, lyon.keenan@gmail.com September 15, 2018 Overview Our goal is to write our own KohnSham (KS) density functional

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations 1 An Oscillating Pendulum applying the forward Euler method 2 Celestial Mechanics simulating the n-body problem 3 The Tractrix Problem setting up the differential equations

More information

Key exercise 1 INF5620

Key exercise 1 INF5620 Key exercise 1 INF5620 Matias Holte kjetimh@student.matnat.uio.no 13. mars 2011 1 Key exercise 1 The task was to implement a python program solving the 2D wave equation with damping, variable wave velocity,

More information

1 Probability Review. 1.1 Sample Spaces

1 Probability Review. 1.1 Sample Spaces 1 Probability Review Probability is a critical tool for modern data analysis. It arises in dealing with uncertainty, in randomized algorithms, and in Bayesian analysis. To understand any of these concepts

More information

LECTURE 8: DYNAMICAL SYSTEMS 7

LECTURE 8: DYNAMICAL SYSTEMS 7 15-382 COLLECTIVE INTELLIGENCE S18 LECTURE 8: DYNAMICAL SYSTEMS 7 INSTRUCTOR: GIANNI A. DI CARO GEOMETRIES IN THE PHASE SPACE Damped pendulum One cp in the region between two separatrix Separatrix Basin

More information

Internal and external synchronization of self-oscillating oscillators with non-identical control parameters

Internal and external synchronization of self-oscillating oscillators with non-identical control parameters Internal and external synchronization of self-oscillating oscillators with non-identical control parameters Emelianova Yu.P., Kuznetsov A.P. Department of Nonlinear Processes, Saratov State University,

More information

TF Mutiple Hidden Layers: Regression on Boston Data Batched, Parameterized, with Dropout

TF Mutiple Hidden Layers: Regression on Boston Data Batched, Parameterized, with Dropout TF Mutiple Hidden Layers: Regression on Boston Data Batched, Parameterized, with Dropout This is adapted from Frossard's tutorial (http://www.cs.toronto.edu/~frossard/post/tensorflow/). This approach is

More information

Lecture 16: Discrete Fourier Transform, Spherical Harmonics

Lecture 16: Discrete Fourier Transform, Spherical Harmonics Lecture 16: Discrete Fourier Transform, Spherical Harmonics Chris Tralie, Duke University 3/8/2016 Announcements Mini Assignment 3 due Sunday 3/13 11:55PM Group Assignment 2 Out around Friday/Saturday,

More information

Chaotic Vibrations. An Introduction for Applied Scientists and Engineers

Chaotic Vibrations. An Introduction for Applied Scientists and Engineers Chaotic Vibrations An Introduction for Applied Scientists and Engineers FRANCIS C. MOON Theoretical and Applied Mechanics Cornell University Ithaca, New York A WILEY-INTERSCIENCE PUBLICATION JOHN WILEY

More information

Ordinary Differential Equations II: Runge-Kutta and Advanced Methods

Ordinary Differential Equations II: Runge-Kutta and Advanced Methods Ordinary Differential Equations II: Runge-Kutta and Advanced Methods Sam Sinayoko Numerical Methods 3 Contents 1 Learning Outcomes 2 2 Introduction 2 2.1 Note................................ 4 2.2 Limitations

More information

The Big, Big Picture (Bifurcations II)

The Big, Big Picture (Bifurcations II) The Big, Big Picture (Bifurcations II) Reading for this lecture: NDAC, Chapter 8 and Sec. 10.0-10.4. 1 Beyond fixed points: Bifurcation: Qualitative change in behavior as a control parameter is (slowly)

More information

n-dimensional LCE code

n-dimensional LCE code n-dimensional LCE code Dale L Peterson Department of Mechanical and Aeronautical Engineering University of California, Davis dlpeterson@ucdavisedu June 10, 2007 Abstract The Lyapunov characteristic exponents

More information

Lecture 20: ODE V - Examples in Physics

Lecture 20: ODE V - Examples in Physics Lecture 20: ODE V - Examples in Physics Helmholtz oscillator The system. A particle of mass is moving in a potential field. Set up the equation of motion. (1.1) (1.2) (1.4) (1.5) Fixed points Linear stability

More information

A Novel Hyperchaotic System and Its Control

A Novel Hyperchaotic System and Its Control 1371371371371378 Journal of Uncertain Systems Vol.3, No., pp.137-144, 009 Online at: www.jus.org.uk A Novel Hyperchaotic System and Its Control Jiang Xu, Gouliang Cai, Song Zheng School of Mathematics

More information

5615 Chapter 3. April 8, Set #3 RP Simulation 3 Working with rp1 in the Notebook Proper Numerical Integration 5

5615 Chapter 3. April 8, Set #3 RP Simulation 3 Working with rp1 in the Notebook Proper Numerical Integration 5 5615 Chapter 3 April 8, 2015 Contents Mixed RV and Moments 2 Simulation............................................... 2 Set #3 RP Simulation 3 Working with rp1 in the Notebook Proper.............................

More information

8 Example 1: The van der Pol oscillator (Strogatz Chapter 7)

8 Example 1: The van der Pol oscillator (Strogatz Chapter 7) 8 Example 1: The van der Pol oscillator (Strogatz Chapter 7) So far we have seen some different possibilities of what can happen in two-dimensional systems (local and global attractors and bifurcations)

More information

Stability of Nonlinear Systems An Introduction

Stability of Nonlinear Systems An Introduction Stability of Nonlinear Systems An Introduction Michael Baldea Department of Chemical Engineering The University of Texas at Austin April 3, 2012 The Concept of Stability Consider the generic nonlinear

More information

Temperature Control Lab E: Semi-Empirical Moving Horizon Estimation

Temperature Control Lab E: Semi-Empirical Moving Horizon Estimation Temperature Control Lab E: Semi-Empirical Moving Horizon Estimation Design a Moving Horizon Estimator (MHE) for the temperature control lab to estimate the two temperatures and any necessary parameters

More information

Conjugate-Gradient. Learn about the Conjugate-Gradient Algorithm and its Uses. Descent Algorithms and the Conjugate-Gradient Method. Qx = b.

Conjugate-Gradient. Learn about the Conjugate-Gradient Algorithm and its Uses. Descent Algorithms and the Conjugate-Gradient Method. Qx = b. Lab 1 Conjugate-Gradient Lab Objective: Learn about the Conjugate-Gradient Algorithm and its Uses Descent Algorithms and the Conjugate-Gradient Method There are many possibilities for solving a linear

More information

A plane autonomous system is a pair of simultaneous first-order differential equations,

A plane autonomous system is a pair of simultaneous first-order differential equations, Chapter 11 Phase-Plane Techniques 11.1 Plane Autonomous Systems A plane autonomous system is a pair of simultaneous first-order differential equations, ẋ = f(x, y), ẏ = g(x, y). This system has an equilibrium

More information

Least squares and Eigenvalues

Least squares and Eigenvalues Lab 1 Least squares and Eigenvalues Lab Objective: Use least squares to fit curves to data and use QR decomposition to find eigenvalues. Least Squares A linear system Ax = b is overdetermined if it has

More information

CS 237 Fall 2018, Homework 06 Solution

CS 237 Fall 2018, Homework 06 Solution 0/9/20 hw06.solution CS 237 Fall 20, Homework 06 Solution Due date: Thursday October th at :59 pm (0% off if up to 24 hours late) via Gradescope General Instructions Please complete this notebook by filling

More information

Computers and Mathematics with Applications. Adaptive anti-synchronization of chaotic systems with fully unknown parameters

Computers and Mathematics with Applications. Adaptive anti-synchronization of chaotic systems with fully unknown parameters Computers and Mathematics with Applications 59 (21) 3234 3244 Contents lists available at ScienceDirect Computers and Mathematics with Applications journal homepage: www.elsevier.com/locate/camwa Adaptive

More information

Chaotic Oscillation via Edge of Chaos Criteria

Chaotic Oscillation via Edge of Chaos Criteria International Journal of Bifurcation and Chaos, Vol. 27, No. 11 (2017) 1730035 (79 pages) c World Scientific Publishing Company DOI: 10.1142/S021812741730035X Chaotic Oscillation via Edge of Chaos Criteria

More information

Numerical Methods for Initial Value Problems; Harmonic Oscillators

Numerical Methods for Initial Value Problems; Harmonic Oscillators 1 Numerical Methods for Initial Value Problems; Harmonic Oscillators Lab Objective: Implement several basic numerical methods for initial value problems (IVPs), and use them to study harmonic oscillators.

More information

Modeling Rare Events

Modeling Rare Events Modeling Rare Events Chapter 4 Lecture 15 Yiren Ding Shanghai Qibao Dwight High School April 24, 2016 Yiren Ding Modeling Rare Events 1 / 48 Outline 1 The Poisson Process Three Properties Stronger Property

More information

The Nonlinear Pendulum

The Nonlinear Pendulum The Nonlinear Pendulum Evan Sheridan 11367741 Feburary 18th 013 Abstract Both the non-linear linear pendulum are investigated compared using the pendulum.c program that utilizes the trapezoid method for

More information

Symbolic computing 1: Proofs with SymPy

Symbolic computing 1: Proofs with SymPy Bachelor of Ecole Polytechnique Computational Mathematics, year 2, semester Lecturer: Lucas Gerin (send mail) (mailto:lucas.gerin@polytechnique.edu) Symbolic computing : Proofs with SymPy π 3072 3 + 2

More information

A Novel Three Dimension Autonomous Chaotic System with a Quadratic Exponential Nonlinear Term

A Novel Three Dimension Autonomous Chaotic System with a Quadratic Exponential Nonlinear Term ETASR - Engineering, Technology & Applied Science Research Vol., o.,, 9-5 9 A Novel Three Dimension Autonomous Chaotic System with a Quadratic Exponential Nonlinear Term Fei Yu College of Information Science

More information

The Big Picture. Python environment? Discuss Examples of unpredictability. Chaos, Scientific American (1986)

The Big Picture. Python environment? Discuss Examples of unpredictability. Chaos, Scientific American (1986) The Big Picture Python environment? Discuss Examples of unpredictability Email homework to me: chaos@cse.ucdavis.edu Chaos, Scientific American (1986) Odds, Stanislaw Lem, The New Yorker (1974) 1 Nonlinear

More information

Chapter 3 - Derivatives

Chapter 3 - Derivatives Chapter 3 - Derivatives Section 3.1: The derivative at a point The derivative of a function f (x) at a point x = a is equal to the rate of change in f (x) at that point or equivalently the slope of the

More information

Gradient Descent Methods

Gradient Descent Methods Lab 18 Gradient Descent Methods Lab Objective: Many optimization methods fall under the umbrella of descent algorithms. The idea is to choose an initial guess, identify a direction from this point along

More information

fidimag Documentation

fidimag Documentation fidimag Documentation Release 0.1 Weiwei Wang Jan 24, 2019 Tutorials 1 Run fidimag inside a Docker Container 3 1.1 Setup Docker............................................... 3 1.2 Setup fidimag docker

More information

Laboratory Instruction-Record Pages

Laboratory Instruction-Record Pages Laboratory Instruction-Record Pages The Driven Pendulum Geology 200 - Evolutionary Systems James Madison University Lynn S. Fichter and Steven J. Baedke Brief History of Swinging Many things in this universe

More information