x(t) + t f(t, x) = x(t) + x (t) t x t Tayler x(t + t) = x(t) + x (t) t + 1 2! x (t) t ! x (t) t 3 + (15) Eular x t Teyler 1 Eular 2 Runge-Kutta

Size: px
Start display at page:

Download "x(t) + t f(t, x) = x(t) + x (t) t x t Tayler x(t + t) = x(t) + x (t) t + 1 2! x (t) t ! x (t) t 3 + (15) Eular x t Teyler 1 Eular 2 Runge-Kutta"

Transcription

1 6 Runge-KuttaEular Runge-Kutta Runge-Kutta A( ) f(t, x) dx dt = lim x(t + t) x(t) t 0 t = f(t, x) (14) t x x(t) t + dt x x(t + dt) Euler 7 t 1 f(t, x(t)) x(t) + f(t + dt, x(t + dt))dt t + dt x(t + dt) (14) x(t + t) = x x(t+dt) x(t) t t+dt 7: 1

2 x(t) + t f(t, x) = x(t) + x (t) t x t Tayler x(t + t) = x(t) + x (t) t + 1 2! x (t) t ! x (t) t 3 + (15) Eular x t Teyler 1 Eular 2 Runge-Kutta 8 Euler t+dt x k 1 t t+dt t+dt/2, x(t)+ k 1 /2 x f(t + dt/2, x(t) + k 1 /2) x(t + dt) x x(t+dt) x(t) k 1 t t+dt/2 t+dt 8: 2 Runge-Kutta k 1 = f(t, x(t))dt (16) x(t + dt) = x(t) + f(t + dt/2, x(t) + k 1 /2)dt (17) 2 Runge-Kutta Taylor dt 2 Runge-Kutta 9 4 Runge-Kutta (16) (17) 1. (t, x) dt x k 1 2. k 1 t t + dt f(t + dt, x + k 1 /2) x(t) dt x k 2 3. k 2 t t + dt f(t + dt, x + k 2 /2) x(t) dt x k 3 2

3 4. k 3 t t + dt f(t + dt, x + k 3 /2) x(t) dt x k 4 x k 1 k 2 k 3 k 4 x(dt) k 1 = f(t, x(t))dt (18) k 2 = f(t + dt/2, x(t) + k 1 /2)dt (19) k 3 = f(t + dt/2, x(t) + k 2 /2)dt (20) k 4 = f(t + dt, x(t) + k 3 )dt (21) x(t + dt) = x(t) (k 1 + 2k 2 + 2k 3 + k 4 ) (22) Eular t+dt (1/6)t+dt (1/2) t + dt (5/6) 3 4 Runge-Kutta Taylor 4 dt 5 Runge-Kutta 4 Runge-Kutta x x dt/6 dt/3 dt/3 dt/6 x(t+dt) x(t) k 1 k 2 k 3 k 4 step1 step2 step3 step4 t t+dt/2 t+dt t t+dt/2 t+dt 9: 4 Runge-Kutta dy/dx = y Runge-Kutta Runge-Kutta S_RungK 6 Runge-Kutta // === Runge-Kutta === #include <stdio.h> #include <math.h> #define EPS 1.0e-8 #define N 50 // 3

4 #define X0 0.0 // X #define XN 5.0 // X #define Y0 1.0 // Y // main main // // void S_RungK( double, double *, double, int, double(*)() ); double FUNC( double, double ); // void main(){ FILE *fout; int i; double x, h, y[101]; fout=fopen("rk.csv","w"); h=(xn-x0)/(double)n; x=x0; y[0]=y0; printf(" X0=%f XN=%f Y0=%f h=%f \n",x,xn,y[0],h); S_RungK(x,y,h,N,*FUNC); for(i=0; i<=n; i++) { printf(" i=%f, y=%f \n", h*i, y[i]); fprintf(fout,"%f, %f\n", h*i, y[i]); fclose(fout); /** Function to calculate Runge-Kutta method ** // ; y[0] = y // h = x // N = N // x = x // FUNC = dy/dx // ; y[n+1=n+1 void S_RungK( double x, double y[], double h, int n, double (*FUNC)()){ int i; double k1,k2,k3,k4; for(i=0; i<n; i++){ k1=h*(*func)(x, y[i]); // step1 k2=h*(*func)(x+0.5*h, y[i]+0.5*k1); // step2 k3=h*(*func)(x+0.5*h, y[i]+0.5*k2); // step3 k4=h*(*func)(x+h,y[i]+k3); // step4 x=x+h; y[i+1]=y[i]+(k1+2.0*(k2+k3)+k4)/6.0; 4

5 // dy/dx // dy/dx=y double FUNC( double x, double y ){ return ( y ); y : dy/dx = y 4 Runge-Kutta x Runge-Kutta qx, qy, px, py RungeKutta() 7 Runge-Kutta // === Runge-Kutta === void RungeKutta( double qx, double qy, double px, double py, double *qxk, double *qyk, double *pxk, double *pyk ) { double q, qi3; q = hypot( qx, qy ); qi3 = 1.0/(q*q*q); *qxk = px/m*dt; *qyk = py/m*dt; *pxk = -GM*M*qx*qi3*dT; *pyk = -GM*M*qy*qi3*dT; Runge-Kutta Euler 10 Euler 5

6 7 2 m [kg] q x, q y q y dq 2 x dt = 0, dqy 2 = g (23) 2 dt2 2 x y p x [kg m/s] p y [kg m/s] dq 2 x dt = dp x 2 dt = 0, dq2 y dt = dp y = g, 2 dt (24) dq x dt = p x m, dq y dt = p y m, (25) dt p x p y 1 p x [m]p y [m] 1 Eular 8 Eular // Eular #include <stdio.h> #define G // [m/s/s] #define M 1.0 // [kg] #define N 256 // #define T0 0.0 // [s] #define TN 5.0 // [s] #define QX0 0.0 // X [m] #define QY0 0.0 // Y [m] #define PX0 1.0 // X [kgm/s] #define PY0 2.0 // Y [kgm/s] //---- main function int main(void) { FILE *fout; int i; double qx, qy, px, py, dt; fout = fopen("kekka.csv","w"); // printf(" T0=%4.1f QX0%4.1f QY0=%4.1f PX0=%4.1f PY0=%4.1f N=%5d\n",T0,QX0,QY0,PX0,PY0,N); 6

7 dt = (TN-T0)/(double)N; qx = QX0; qy=qy0; px=px0; py=py0; for(i=0; i<n; i++) { // qy printf("qx=%lf yx=%lf\n",qx,qy); // qx,qy fprintf(fout,"%lf, %lf\n",qx,qy); // qx,qy qx += px/m*dt; // x () qy += py/m*dt; // y () px += M*0*dT; // x () py += -M*G*dT; // x () if(qy<0.0) break; // y 0 fclose(fout); return(0); // 垂直方向 y 水平方向 x 11: () Eular Runge-Kutta

8 (q x, q y ) (p x, p y ) p x = m dq x dt, p y = m dq y dt dp x dt = GMm cos ϕ = GMmq x, q 2 q 3 dp y dt = GMm q 2 (26) cos ϕ = GMmq y q 3, (27) GMm r = mrω 2, r = 1, T = 1, ω = 2π T = 2π (28) G M GM 4π 2 1 dt Runge-Kutta Runge-Kutta q x q y p x p y RungeKutta() 9 Runge-Kutta // Runge-Kutta #include <stdio.h> #include <math.h> // ---- physical setting #define M_PI #define GM 4*M_PI*M_PI #define M 1.0 // #define dt 1.0/256 // #define QX0 1.0 // x #define QY0 0.0 // y #define PX0 0.0 // x #define PY0 sqrt(gm)*m // y // ---- main function int main(void) { FILE *fout; double qx, qy; double px, py; 8

9 double T; double qxk1, qyk1, pxk1, pyk1; double qxk2, qyk2, pxk2, pyk2; double qxk3, qyk3, pxk3, pyk3; double qxk4, qyk4, pxk4, pyk4; double tqx, tqy, tpx, tpy; double q, qi3; fout = fopen("orbit.csv","w"); // qx = QX0; qy = QY0; px = PX0; py = PY0; for( T = 0.0; T < 10.00; T += dt ){ // (qx,qy) (px,py) k1 tqx = qx; tqy = qy; tpx = px; tpy = py; q = hypot( tqx, tqy ); qi3 = 1.0/(q*q*q); qxk1 = tpx / M * dt; qyk1 = tpy / M * dt; pxk1 = -GM * M * tqx * qi3 * dt; pyk1 = -GM * M * tqy * qi3 * dt; // (qx,qy) (px,py) k2 tqx = qx+0.5*qxk1; tqy = qy+0.5*qyk1; tpx = px+0.5*pxk1; tpy = py+0.5*pyk1; q = hypot( tqx, tqy ); qi3 = 1.0/(q*q*q); qxk2 = tpx / M * dt; qyk2 = tpy / M * dt; pxk2 = -GM * M * tqx * qi3 * dt; pyk2 = -GM * M * tqy * qi3 * dt; // (qx,qy) (px,py) k3 tqx = qx+0.5*qxk2; tqy = qy+0.5*qyk2; tpx = px+0.5*pxk2; tpy = py+0.5*pyk2; q = hypot( tqx, tqy ); qi3 = 1.0/(q*q*q); qxk3 = tpx / M * dt; qyk3 = tpy / M * dt; pxk3 = -GM * M * tqx * qi3 * dt; pyk3 = -GM * M * tqy * qi3 * dt; // (qx,qy) (px,py) k4 tqx = qx+qxk3; tqy = qy+qyk3; tpx = px+pxk3; tpy = py+pyk3; q = hypot( tqx, tqy ); qi3 = 1.0/(q*q*q); qxk4 = tpx / M * dt; qyk4 = tpy / M * dt; pxk4 = -GM * M * tqx * qi3 * dt; pyk4 = -GM * M * tqy * qi3 * dt; // k1,k2,k3,k4 qx += (qxk1 + 2*qxk2 + 2*qxk3 + qxk4)*(1.0/6); qy += (qyk1 + 2*qyk2 + 2*qyk3 + qyk4)*(1.0/6); px += (pxk1 + 2*pxk2 + 2*pxk3 + pxk4)*(1.0/6); py += (pyk1 + 2*pyk2 + 2*pyk3 + pyk4)*(1.0/6); printf("qx=%f qy=%f px=%f py=%f \n",qx,qy,px,py); 9

10 fprintf(fout,"%f, %f\n",qx,qy); // qx,qy fclose(fout); return(0); // 12 Runge-Kutta Euler 10 Euler (?) y : Keplar Runge-Kutta x (1) (2) (3) t x t x 10

11 u(x, t) u(x, t) t = κ 2 u(x, t) x 2 (29) κ 9.1 SI CGS T X /T τx/x ξ 1 κ = 1 u(x, t) t = 2 u(x, t) x 2 (30) 9.2 t t > 0 x 0 < x < LL 0 < x < L u(x, 0) = 1 x = 0 x = L 0u(0, t) = 0t > 0 u(x, t) tx t x u(x, t) u(j x, (n + 1) t) u(j x, n t) (31) t t 2 u(x, t) u((j + 1) x, n t) 2u(j x, n t) + u((j 1) x, n t) x 2 x 2 (32) J max = 1/ x j = 0, 1, 2,, J max n = 0, 1, 2, n u(j x, (n + 1) t) u(j x, n t) t (33) u((j + 1) x, n t) 2u(j x, n t) + u((j 1) x, n t) = x 2 (34) 11

12 t u(j x, (n + 1) t) u(j x, n t) (35) = t x {u((j + 1) x, n t) 2u(j x, n t) + u((j 1) x, n t) 2 (36) t/ x 2 r u(j t, (n + 1) x) = r u((j + 1) x, n t) +(1 2r) u(j x, n t) + r u((j 1) x, n t) (37) r = t x 2 (38) 10 // #include <stdio.h> #define JMAX 10 // #define NMAX 250 // #define NINT 25 // void main() { FILE *fout; double u[jmax+1],unew[jmax+1]; // u unew double delx,delt,r; // x t int j,n; // j n delx = 1.0/(double)JMAX; delt = 0.004; r = delt/delx*delx; // x // // r // u[0] = 0.0; for(j=1; j<jmax; j++) u[j]=1.0; u[jmax]=0.0; for(j=0; j<=jmax; j++) unew[j]=u[j]; fout = fopen("diffuse.csv","w"); // for( n=0; n<=nmax; n++) { // // NINT if( (n%nint) == 0) { for(j=0; j<jmax; j++) fprintf(fout, "%lf, ", u[j]); fprintf(fout,"%lf\n",u[jmax]); for(j=1; j<jmax; j++) unew[j] = r*u[j+1]+(1.0-r*2.0)*u[j] +r*u[j-1]; 12

13 // 1 // for(j=0; j<=jmax; j++) u[j] = unew[j]; // fclose(fout); // r < 1 2 (39) x t 13

x h = (b a)/n [x i, x i+1 ] = [a+i h, a+ (i + 1) h] A(x i ) A(x i ) = h 2 {f(x i) + f(x i+1 ) = h {f(a + i h) + f(a + (i + 1) h), (2) 2 a b n A(x i )

x h = (b a)/n [x i, x i+1 ] = [a+i h, a+ (i + 1) h] A(x i ) A(x i ) = h 2 {f(x i) + f(x i+1 ) = h {f(a + i h) + f(a + (i + 1) h), (2) 2 a b n A(x i ) 1 f(x) a b f(x)dx = n A(x i ) (1) ix [a, b] n i A(x i ) x i 1 f(x) [a, b] n h = (b a)/n y h = (b-a)/n y = f (x) h h a a+h a+2h a+(n-1)h b x 1: 1 x h = (b a)/n [x i, x i+1 ] = [a+i h, a+ (i + 1) h] A(x

More information

1 28 6 12 7 1 7.1...................................... 2 7.1.1............................... 2 7.1.2........................... 2 7.2...................................... 3 7.3...................................

More information

#define N1 N+1 double x[n1] =.5, 1., 2.; double hokan[n1] = 1.65, 2.72, 7.39 ; double xx[]=.2,.4,.6,.8,1.2,1.4,1.6,1.8; double lagrng(double xx); main

#define N1 N+1 double x[n1] =.5, 1., 2.; double hokan[n1] = 1.65, 2.72, 7.39 ; double xx[]=.2,.4,.6,.8,1.2,1.4,1.6,1.8; double lagrng(double xx); main =1= (.5, 1.65), (1., 2.72), (2., 7.39).2,.4,.6,.8, 1., 1.2, 1.4, 1.6 1 1: x.2 1.4128.4 1.5372.6 1.796533.8 2.198 1.2 3.384133 1.4 4.1832 1.6 5.1172 8 7 6 5 y 4 3 2 1.5 1 1.5 2 x 1: /* */ #include

More information

C による数値計算法入門 ( 第 2 版 ) 新装版 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. このサンプルページの内容は, 新装版 1 刷発行時のものです.

C による数値計算法入門 ( 第 2 版 ) 新装版 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます.  このサンプルページの内容は, 新装版 1 刷発行時のものです. C による数値計算法入門 ( 第 2 版 ) 新装版 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. http://www.morikita.co.jp/books/mid/009383 このサンプルページの内容は, 新装版 1 刷発行時のものです. i 2 22 2 13 ( ) 2 (1) ANSI (2) 2 (3) Web http://www.morikita.co.jp/books/mid/009383

More information

数値計算:常微分方程式

数値計算:常微分方程式 ( ) 1 / 82 1 2 3 4 5 6 ( ) 2 / 82 ( ) 3 / 82 C θ l y m O x mg λ ( ) 4 / 82 θ t C J = ml 2 C mgl sin θ θ C J θ = mgl sin θ = θ ( ) 5 / 82 ω = θ J ω = mgl sin θ ω J = ml 2 θ = ω, ω = g l sin θ = θ ω ( )

More information

A

A A05-132 2010 2 11 1 1 3 1.1.......................................... 3 1.2..................................... 3 1.3..................................... 3 2 4 2.1............................... 4 2.2

More information

スライド 1

スライド 1 数値解析 2019 年度前期第 13 週 [7 月 11 日 ] 静岡大学創造科学技術大学院情報科学専攻工学部機械工学科計測情報講座 三浦憲二郎 講義アウトライン [7 月 11 日 ] 関数近似と補間 最小 2 乗近似による関数近似 ラグランジュ補間 T.Kanai, U.Tokyo 関数近似 p.116 複雑な関数を簡単な関数で近似する 関数近似 閉区間 [a,b] で定義された関数 f(x)

More information

sim98-8.dvi

sim98-8.dvi 8 12 12.1 12.2 @u @t = @2 u (1) @x 2 u(x; 0) = (x) u(0;t)=u(1;t)=0fort 0 1x, 1t N1x =1 x j = j1x, t n = n1t u(x j ;t n ) Uj n U n+1 j 1t 0 U n j =1t=(1x) 2 = U n j+1 0 2U n j + U n j01 (1x) 2 (2) U n+1

More information

実際の株価データを用いたオプション料の計算

実際の株価データを用いたオプション料の計算 2002 2 20 1 1 3 2 3 2.1 : : : : : : : : : : : : : : : : : : : : : : : : : : : : 5 2.1.1 : : : : : : : : : : : : : : : : : : : : 5 2.1.2 : : : : : : : : : : : : : : : : : : : : 6 2.2 : : : : : : : : : :

More information

/* do-while */ #include <stdio.h> #include <math.h> int main(void) double val1, val2, arith_mean, geo_mean; printf( \n ); do printf( ); scanf( %lf, &v

/* do-while */ #include <stdio.h> #include <math.h> int main(void) double val1, val2, arith_mean, geo_mean; printf( \n ); do printf( ); scanf( %lf, &v 1 http://www7.bpe.es.osaka-u.ac.jp/~kota/classes/jse.html kota@fbs.osaka-u.ac.jp /* do-while */ #include #include int main(void) double val1, val2, arith_mean, geo_mean; printf( \n );

More information

関数のグラフを描こう

関数のグラフを描こう L05(2010-05-07) 1 2 hig3.net ( ) L05(2010-05-07) 1 / 16 #i n c l u d e double f ( double x ) ; i n t main ( void ){ i n t n ; i n t nmax=10; double x ; double s =0.0; } x = 1.0; s=s+x ;

More information

,. Black-Scholes u t t, x c u 0 t, x x u t t, x c u t, x x u t t, x + σ x u t, x + rx ut, x rux, t 0 x x,,.,. Step 3, 7,,, Step 6., Step 4,. Step 5,,.

,. Black-Scholes u t t, x c u 0 t, x x u t t, x c u t, x x u t t, x + σ x u t, x + rx ut, x rux, t 0 x x,,.,. Step 3, 7,,, Step 6., Step 4,. Step 5,,. 9 α ν β Ξ ξ Γ γ o δ Π π ε ρ ζ Σ σ η τ Θ θ Υ υ ι Φ φ κ χ Λ λ Ψ ψ µ Ω ω Def, Prop, Th, Lem, Note, Remark, Ex,, Proof, R, N, Q, C [a, b {x R : a x b} : a, b {x R : a < x < b} : [a, b {x R : a x < b} : a,

More information

スライド 1

スライド 1 数値解析 平成 24 年度前期第 13 週 [7 月 11 日 ] 静岡大学創造科学技術大学院情報科学専攻工学部機械工学科計測情報講座 三浦憲二郎 講義アウトライン [7 月 11 日 ] 関数近似と補間 最小 2 乗近似による関数近似 ラグランジュ補間 形状処理工学の基礎 点列からの曲線の生成 T.Kanai, U.Tokyo 関数近似 p.116 複雑な関数を簡単な関数で近似する関数近似 閉区間

More information

スライド 1

スライド 1 数値解析 平成 29 年度前期第 14 週 [7 月 10 日 ] 静岡大学工学研究科機械工学専攻ロボット 計測情報分野創造科学技術大学院情報科学専攻 三浦憲二郎 期末試験 7 月 31 日 ( 月 ) 9 10 時限 A : 佐鳴会議室 B : 佐鳴ホール 講義アウトライン [7 月 10 日 ] 関数近似と補間 最小 2 乗近似による関数近似 ( 復習 ) ラグランジュ補間 形状処理工学の基礎

More information

f(x) = f(x ) + α(x)(x x ) α(x) x = x. x = f (y), x = f (y ) y = f f (y) = f f (y ) + α(f (y))(f (y) f (y )) f (y) = f (y ) + α(f (y)) (y y ) ( (2) ) f

f(x) = f(x ) + α(x)(x x ) α(x) x = x. x = f (y), x = f (y ) y = f f (y) = f f (y ) + α(f (y))(f (y) f (y )) f (y) = f (y ) + α(f (y)) (y y ) ( (2) ) f 22 A 3,4 No.3 () (2) (3) (4), (5) (6) (7) (8) () n x = (x,, x n ), = (,, n ), x = ( (x i i ) 2 ) /2 f(x) R n f(x) = f() + i α i (x ) i + o( x ) α,, α n g(x) = o( x )) lim x g(x) x = y = f() + i α i(x )

More information

£Ã¥×¥í¥°¥é¥ß¥ó¥°(2018) - Âè11²ó – ½ÉÂꣲ¤Î²òÀ⡤±é½¬£² –

£Ã¥×¥í¥°¥é¥ß¥ó¥°(2018) - Âè11²ó – ½ÉÂꣲ¤Î²òÀ⡤±é½¬£² – (2018) 11 2018 12 13 2 g v dv x dt = bv x, dv y dt = g bv y (1) b v 0 θ x(t) = v 0 cos θ ( 1 e bt) (2) b y(t) = 1 ( v 0 sin θ + g ) ( 1 e bt) g b b b t (3) 11 ( ) p14 2 1 y 4 t m y > 0 y < 0 t m1 h = 0001

More information

資料

資料 PC PC C VMwareをインストールする Tips: VmwareFusion *.vmx vhv.enable = TRUE Tips: Windows Hyper-V -rwxr-xr-x 1 masakazu staff 8552 7 29 13:18 a.out* -rw------- 1 masakazu staff 8552 7 29

More information

simx simxdx, cosxdx, sixdx 6.3 px m m + pxfxdx = pxf x p xf xdx = pxf x p xf x + p xf xdx 7.4 a m.5 fx simxdx 8 fx fx simxdx = πb m 9 a fxdx = πa a =

simx simxdx, cosxdx, sixdx 6.3 px m m + pxfxdx = pxf x p xf xdx = pxf x p xf x + p xf xdx 7.4 a m.5 fx simxdx 8 fx fx simxdx = πb m 9 a fxdx = πa a = II 6 ishimori@phys.titech.ac.jp 6.. 5.4.. f Rx = f Lx = fx fx + lim = lim x x + x x f c = f x + x < c < x x x + lim x x fx fx x x = lim x x f c = f x x < c < x cosmx cosxdx = {cosm x + cosm + x} dx = [

More information

[1] 1.1 x(t) t x(t + n ) = x(t) (n = 1,, 3, ) { x(t) : : 1 [ /, /] 1 x(t) = a + a 1 cos πt + a cos 4πt + + a n cos nπt + + b 1 sin πt + b sin 4πt = a

[1] 1.1 x(t) t x(t + n ) = x(t) (n = 1,, 3, ) { x(t) : : 1 [ /, /] 1 x(t) = a + a 1 cos πt + a cos 4πt + + a n cos nπt + + b 1 sin πt + b sin 4πt = a 13/7/1 II ( / A: ) (1) 1 [] (, ) ( ) ( ) ( ) etc. etc. 1. 1 [1] 1.1 x(t) t x(t + n ) = x(t) (n = 1,, 3, ) { x(t) : : 1 [ /, /] 1 x(t) = a + a 1 cos πt + a cos 4πt + + a n cos nπt + + b 1 sin πt + b sin

More information

C 2 / 21 1 y = x 1.1 lagrange.c 1 / Laglange / 2 #include <stdio.h> 3 #include <math.h> 4 int main() 5 { 6 float x[10], y[10]; 7 float xx, pn, p; 8 in

C 2 / 21 1 y = x 1.1 lagrange.c 1 / Laglange / 2 #include <stdio.h> 3 #include <math.h> 4 int main() 5 { 6 float x[10], y[10]; 7 float xx, pn, p; 8 in C 1 / 21 C 2005 A * 1 2 1.1......................................... 2 1.2 *.......................................... 3 2 4 2.1.............................................. 4 2.2..............................................

More information

joho09.ppt

joho09.ppt s M B e E s: (+ or -) M: B: (=2) e: E: ax 2 + bx + c = 0 y = ax 2 + bx + c x a, b y +/- [a, b] a, b y (a+b) / 2 1-2 1-3 x 1 A a, b y 1. 2. a, b 3. for Loop (b-a)/ 4. y=a*x*x + b*x + c 5. y==0.0 y (y2)

More information

<4D F736F F D B B83578B6594BB2D834A836F815B82D082C88C60202E646F63>

<4D F736F F D B B83578B6594BB2D834A836F815B82D082C88C60202E646F63> 常微分方程式の局所漸近解析 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. http://www.morikita.co.jp/books/mid/007651 このサンプルページの内容は, 初版 1 刷発行当時のものです. i Leibniz ydy = y 2 /2 1675 11 11 [6] 100 Bernoulli Riccati 19 Fuchs

More information

2011 8 26 3 I 5 1 7 1.1 Markov................................ 7 2 Gau 13 2.1.................................. 13 2.2............................... 18 2.3............................ 23 3 Gau (Le vy

More information

Microsoft Word - 信号処理3.doc

Microsoft Word - 信号処理3.doc Junji OHTSUBO 2012 FFT FFT SN sin cos x v ψ(x,t) = f (x vt) (1.1) t=0 (1.1) ψ(x,t) = A 0 cos{k(x vt) + φ} = A 0 cos(kx ωt + φ) (1.2) A 0 v=ω/k φ ω k 1.3 (1.2) (1.2) (1.2) (1.1) 1.1 c c = a + ib, a = Re[c],

More information

II (10 4 ) 1. p (x, y) (a, b) ε(x, y; a, b) 0 f (x, y) f (a, b) A, B (6.5) y = b f (x, b) f (a, b) x a = A + ε(x, b; a, b) x a 2 x a 0 A = f x (

II (10 4 ) 1. p (x, y) (a, b) ε(x, y; a, b) 0 f (x, y) f (a, b) A, B (6.5) y = b f (x, b) f (a, b) x a = A + ε(x, b; a, b) x a 2 x a 0 A = f x ( II (1 4 ) 1. p.13 1 (x, y) (a, b) ε(x, y; a, b) f (x, y) f (a, b) A, B (6.5) y = b f (x, b) f (a, b) x a = A + ε(x, b; a, b) x a x a A = f x (a, b) y x 3 3y 3 (x, y) (, ) f (x, y) = x + y (x, y) = (, )

More information

() Remrk I = [0, ] [x i, x i ]. (x : ) f(x) = 0 (x : ) ξ i, (f) = f(ξ i )(x i x i ) = (x i x i ) = ξ i, (f) = f(ξ i )(x i x i ) = 0 (f) 0.

() Remrk I = [0, ] [x i, x i ]. (x : ) f(x) = 0 (x : ) ξ i, (f) = f(ξ i )(x i x i ) = (x i x i ) = ξ i, (f) = f(ξ i )(x i x i ) = 0 (f) 0. () 6 f(x) [, b] 6. Riemnn [, b] f(x) S f(x) [, b] (Riemnn) = x 0 < x < x < < x n = b. I = [, b] = {x,, x n } mx(x i x i ) =. i [x i, x i ] ξ i n (f) = f(ξ i )(x i x i ) i=. (ξ i ) (f) 0( ), ξ i, S, ε >

More information

2014 3 10 5 1 5 1.1..................................... 5 2 6 2.1.................................... 6 2.2 Z........................................ 6 2.3.................................. 6 2.3.1..................

More information

(3) (2),,. ( 20) ( s200103) 0.7 x C,, x 2 + y 2 + ax = 0 a.. D,. D, y C, C (x, y) (y 0) C m. (2) D y = y(x) (x ± y 0), (x, y) D, m, m = 1., D. (x 2 y

(3) (2),,. ( 20) ( s200103) 0.7 x C,, x 2 + y 2 + ax = 0 a.. D,. D, y C, C (x, y) (y 0) C m. (2) D y = y(x) (x ± y 0), (x, y) D, m, m = 1., D. (x 2 y [ ] 7 0.1 2 2 + y = t sin t IC ( 9) ( s090101) 0.2 y = d2 y 2, y = x 3 y + y 2 = 0 (2) y + 2y 3y = e 2x 0.3 1 ( y ) = f x C u = y x ( 15) ( s150102) [ ] y/x du x = Cexp f(u) u (2) x y = xey/x ( 16) ( s160101)

More information

c-all.dvi

c-all.dvi III(994) (994) from PSL (9947) & (9922) c (99,992,994,996) () () 2 3 4 (2) 2 Euler 22 23 Euler 24 (3) 3 32 33 34 35 Poisson (4) 4 (5) 5 52 ( ) 2 Turbo 2 d 2 y=dx 2 = y y = a sin x + b cos x x = y = Fortran

More information

error_g1.eps

error_g1.eps Runge-Kutta Method Runge-Kutta Method x n+ = x n +hf(t n x n ) dx dt dx x(t+h) x(t) (t) = lim dt h h t = t n h > dx dt (t x(t n +h) x(t n ) n) = lim x(t n+) x(t n ) h h h x = f(tx) x(t n+ ) x(t n ) f(t

More information

5. [1 ] 1 [], u(x, t) t c u(x, t) x (5.3) ξ x + ct, η x ct (5.4),u(x, t) ξ, η u(ξ, η), ξ t,, ( u(ξ,η) ξ η u(x, t) t ) u(x, t) { ( u(ξ, η) c t ξ ξ { (

5. [1 ] 1 [], u(x, t) t c u(x, t) x (5.3) ξ x + ct, η x ct (5.4),u(x, t) ξ, η u(ξ, η), ξ t,, ( u(ξ,η) ξ η u(x, t) t ) u(x, t) { ( u(ξ, η) c t ξ ξ { ( 5 5.1 [ ] ) d f(t) + a d f(t) + bf(t) : f(t) 1 dt dt ) u(x, t) c u(x, t) : u(x, t) t x : ( ) ) 1 : y + ay, : y + ay + by : ( ) 1 ) : y + ay, : yy + ay 3 ( ): ( ) ) : y + ay, : y + ay b [],,, [ ] au xx

More information

pdf

pdf http://www.ns.kogakuin.ac.jp/~ft13389/lecture/physics1a2b/ pdf I 1 1 1.1 ( ) 1. 30 m µm 2. 20 cm km 3. 10 m 2 cm 2 4. 5 cm 3 km 3 5. 1 6. 1 7. 1 1.2 ( ) 1. 1 m + 10 cm 2. 1 hr + 6400 sec 3. 3.0 10 5 kg

More information

DVIOUT

DVIOUT A. A. A-- [ ] f(x) x = f 00 (x) f 0 () =0 f 00 () > 0= f(x) x = f 00 () < 0= f(x) x = A--2 [ ] f(x) D f 00 (x) > 0= y = f(x) f 00 (x) < 0= y = f(x) P (, f()) f 00 () =0 A--3 [ ] y = f(x) [, b] x = f (y)

More information

画像工学特論

画像工学特論 .? (x i, y i )? (x(t), y(t))? (x(t)) (X(ω)) Wiener-Khintchine 35/97 . : x(t) = X(ω)e jωt dω () π X(ω) = x(t)e jωt dt () X(ω) S(ω) = lim (3) ω S(ω)dω X(ω) : F of x : [X] [ = ] [x t] Power spectral density

More information

Chap11.dvi

Chap11.dvi . () x 3 + dx () (x )(x ) dx + sin x sin x( + cos x) dx () x 3 3 x + + 3 x + 3 x x + x 3 + dx 3 x + dx 6 x x x + dx + 3 log x + 6 log x x + + 3 rctn ( ) dx x + 3 4 ( x 3 ) + C x () t x t tn x dx x. t x

More information

C言語によるアルゴリズムとデータ構造

C言語によるアルゴリズムとデータ構造 Algorithms and Data Structures in C 4 algorithm List - /* */ #include List - int main(void) { int a, b, c; int max; /* */ Ÿ 3Ÿ 2Ÿ 3 printf(""); printf(""); printf(""); scanf("%d", &a); scanf("%d",

More information

p = 1, 2, cos 2n + p)πj = cos 2nπj 2n + p)πj, sin = sin 2nπj 7.1) f j = a ) 0 + a p + a n+p cos 2nπj p=1 p=0 1 + ) b n+p p=0 sin 2nπj 1 2 a 0 +

p = 1, 2, cos 2n + p)πj = cos 2nπj 2n + p)πj, sin = sin 2nπj 7.1) f j = a ) 0 + a p + a n+p cos 2nπj p=1 p=0 1 + ) b n+p p=0 sin 2nπj 1 2 a 0 + 7 7.1 sound_wav_files flu00.wav.wav 44.1 khz 1/44100 spwave Text with Time spwave T > 0 t 44.1 khz t = 1 44100 j t f j {f 0, f 1, f 2,, f 1 = T t 7.2 T {f 0, f 1, f 2,, f 1 T ft) f j = fj t) j = 0, 1,

More information

1 4 2 EP) (EP) (EP)

1 4 2 EP) (EP) (EP) 2003 2004 2 27 1 1 4 2 EP) 5 3 6 3.1.............................. 6 3.2.............................. 6 3.3 (EP)............... 7 4 8 4.1 (EP).................... 8 4.1.1.................... 18 5 (EP)

More information

Note.tex 2008/09/19( )

Note.tex 2008/09/19( ) 1 20 9 19 2 1 5 1.1........................ 5 1.2............................. 8 2 9 2.1............................. 9 2.2.............................. 10 3 13 3.1.............................. 13 3.2..................................

More information

x i [, b], (i 0, 1, 2,, n),, [, b], [, b] [x 0, x 1 ] [x 1, x 2 ] [x n 1, x n ] ( 2 ). x 0 x 1 x 2 x 3 x n 1 x n b 2: [, b].,, (1) x 0, x 1, x 2,, x n

x i [, b], (i 0, 1, 2,, n),, [, b], [, b] [x 0, x 1 ] [x 1, x 2 ] [x n 1, x n ] ( 2 ). x 0 x 1 x 2 x 3 x n 1 x n b 2: [, b].,, (1) x 0, x 1, x 2,, x n 1, R f : R R,.,, b R < b, f(x) [, b] f(x)dx,, [, b] f(x) x ( ) ( 1 ). y y f(x) f(x)dx b x 1: f(x)dx, [, b] f(x) x ( ).,,,,,., f(x)dx,,,, f(x)dx. 1.1 Riemnn,, [, b] f(x) x., x 0 < x 1 < x 2 < < x n 1

More information

v er.1/ c /(21)

v er.1/ c /(21) 12 -- 1 1 2009 1 17 1-1 1-2 1-3 1-4 2 2 2 1-5 1 1-6 1 1-7 1-1 1-2 1-3 1-4 1-5 1-6 1-7 c 2011 1/(21) 12 -- 1 -- 1 1--1 1--1--1 1 2009 1 n n α { n } α α { n } lim n = α, n α n n ε n > N n α < ε N {1, 1,

More information

DOPRI5.dvi

DOPRI5.dvi ODE DOPRI5 ( ) 16 3 31 Runge Kutta Dormand Prince 5(4) [1, pp. 178 179] DOPRI5 http://www.unige.ch/math/folks/hairer/software.html Fortran C C++ [3, pp.51 56] DOPRI5 C cprog.tar % tar xvf cprog.tar cprog/

More information

gr09.dvi

gr09.dvi .1, θ, ϕ d = A, t dt + B, t dtd + C, t d + D, t dθ +in θdϕ.1.1 t { = f1,t t = f,t { D, t = B, t =.1. t A, tdt e φ,t dt, C, td e λ,t d.1.3,t, t d = e φ,t dt + e λ,t d + dθ +in θdϕ.1.4 { = f1,t t = f,t {

More information

Gmech08.dvi

Gmech08.dvi 63 6 6.1 6.1.1 v = v 0 =v 0x,v 0y, 0) t =0 x 0,y 0, 0) t x x 0 + v 0x t v x v 0x = y = y 0 + v 0y t, v = v y = v 0y 6.1) z 0 0 v z yv z zv y zv x xv z xv y yv x = 0 0 x 0 v 0y y 0 v 0x 6.) 6.) 6.1) 6.)

More information

θ (t) ω cos θ(t) = ( : θ, θ. ( ) ( ) ( 5) l () θ (t) = ω sin θ(t). ω := g l.. () θ (t) θ (t)θ (t) + ω θ (t) sin θ(t) =. [ ] d dt θ (t) ω cos θ(t

θ (t) ω cos θ(t) = ( : θ, θ. ( ) ( ) ( 5) l () θ (t) = ω sin θ(t). ω := g l.. () θ (t) θ (t)θ (t) + ω θ (t) sin θ(t) =. [ ] d dt θ (t) ω cos θ(t 7 8, /3/, 5// http://nalab.mind.meiji.ac.jp/~mk/labo/text/furiko/ l (, simple pendulum) m g mlθ (t) = mg sin θ(t) () θ (t) + ω sin θ(t) =, ω := ( m ) ( θ ) sin θ θ θ (t) + ω θ(t) = ( ) ( ) g l θ(t) = C

More information

6 6.1 sound_wav_files flu00.wav.wav 44.1 khz 1/44100 spwave Text with Time spwave t T = N t N 44.1 khz t = 1 sec j t f j {f 0, f 1, f 2,, f N 1

6 6.1 sound_wav_files flu00.wav.wav 44.1 khz 1/44100 spwave Text with Time spwave t T = N t N 44.1 khz t = 1 sec j t f j {f 0, f 1, f 2,, f N 1 6 6.1 sound_wav_files flu00.wav.wav 44.1 khz 1/44100 spwave Text with Time spwave t T = t 44.1 khz t = 1 sec 44100 j t f j {f 0, f 1, f 2,, f 1 6.2 T {f 0, f 1, f 2,, f 1 T ft) f j = fj t) j = 0, 1, 2,,

More information

1 5 13 4 1 41 1 411 1 412 2 413 3 414 3 415 4 42 6 43 LU 7 431 LU 10 432 11 433 LU 11 44 12 441 13 442 13 443 SOR ( ) 14 444 14 445 15 446 16 447 SOR 16 448 16 45 17 4 41 n x 1,, x n a 11 x 1 + a 1n x

More information

Trapezoidal Rule θ = 1/ x n x n 1 t = 1 [f(t n 1, x n 1 ) + f(t n, x n )] (6) 1. dx dt = f(t, x), x(t 0) = x 0 (7) t [t 0, t 1 ] f t [t 0, t 1 ], x x

Trapezoidal Rule θ = 1/ x n x n 1 t = 1 [f(t n 1, x n 1 ) + f(t n, x n )] (6) 1. dx dt = f(t, x), x(t 0) = x 0 (7) t [t 0, t 1 ] f t [t 0, t 1 ], x x University of Hyogo 8 8 1 d x(t) =f(t, x(t)), dt (1) x(t 0 ) =x 0 () t n = t 0 + n t x x n n x n x 0 x i i = 0,..., n 1 x n x(t) 1 1.1 1 1 1 0 θ 1 θ x n x n 1 t = θf(t n 1, x n 1 ) + (1 θ)f(t n, x n )

More information

Taro-数値計算の基礎Ⅱ(公開版)

Taro-数値計算の基礎Ⅱ(公開版) 0. 目次 1. 2 分法 2. はさみうち法 3. 割線法 4. 割線法 ( 2 次曲線近似 ) 5. ニュートン法 ( 接線近似 ) - 1 - 1. 2 分法 区間 [x0,x1] にある関数 f(x) の根を求める 区間 [x0,x1] を xm=(x0+x1)/2 で 2 等分し 区間 [x0,xm],[xm,x1] に分割する f(xm) の絶対値が十分小さい値 eps より小さいとき

More information

n=1 1 n 2 = π = π f(z) f(z) 2 f(z) = u(z) + iv(z) *1 f (z) u(x, y), v(x, y) f(z) f (z) = f/ x u x = v y, u y = v x

n=1 1 n 2 = π = π f(z) f(z) 2 f(z) = u(z) + iv(z) *1 f (z) u(x, y), v(x, y) f(z) f (z) = f/ x u x = v y, u y = v x n= n 2 = π2 6 3 2 28 + 4 + 9 + = π2 6 2 f(z) f(z) 2 f(z) = u(z) + iv(z) * f (z) u(x, y), v(x, y) f(z) f (z) = f/ x u x = v y, u y = v x f x = i f y * u, v 3 3. 3 f(t) = u(t) + v(t) [, b] f(t)dt = u(t)dt

More information

スライド 1

スライド 1 数値解析 平成 30 年度前期第 10 週 [6 月 12 日 ] 静岡大学工学研究科機械工学専攻ロボット 計測情報分野創造科学技術大学院情報科学専攻 三浦憲二郎 講義アウトライン [6 月 12 日 ] 連立 1 次方程式の直接解法 ガウス消去法 ( 復習 ) 部分ピボット選択付きガウス消去法 連立 1 次方程式 連立 1 次方程式の重要性 非線形の問題は基本的には解けない. 非線形問題を線形化して解く.

More information

sec13.dvi

sec13.dvi 13 13.1 O r F R = m d 2 r dt 2 m r m = F = m r M M d2 R dt 2 = m d 2 r dt 2 = F = F (13.1) F O L = r p = m r ṙ dl dt = m ṙ ṙ + m r r = r (m r ) = r F N. (13.2) N N = R F 13.2 O ˆn ω L O r u u = ω r 1 1:

More information

d dt A B C = A B C d dt x = Ax, A 0 B 0 C 0 = mm 0 mm 0 mm AP = PΛ P AP = Λ P A = ΛP P d dt x = P Ax d dt (P x) = Λ(P x) d dt P x =

d dt A B C = A B C d dt x = Ax, A 0 B 0 C 0 = mm 0 mm 0 mm AP = PΛ P AP = Λ P A = ΛP P d dt x = P Ax d dt (P x) = Λ(P x) d dt P x = 3 MATLAB Runge-Kutta Butcher 3. Taylor Taylor y(x 0 + h) = y(x 0 ) + h y (x 0 ) + h! y (x 0 ) + Taylor 3. Euler, Runge-Kutta Adams Implicit Euler, Implicit Runge-Kutta Gear y n+ y n (n+ ) y n+ y n+ y n+

More information

PowerPoint Presentation

PowerPoint Presentation p.130 p.198 p.208 2 double weight[num]; double min, max; min = max = weight[0]; for( i= 1; i i < NUM; i++ ) ) if if ( weight[i] > max ) max = weight[i]: if if ( weight[i] < min ) min = weight[i]: weight

More information

Numerical Analysis II, Exam End Term Spring 2017

Numerical Analysis II, Exam End Term Spring 2017 H. Ammari W. Wu S. Yu Spring Term 2017 Numerical Analysis II ETH Zürich D-MATH End Term Spring 2017 Problem 1 Consider dx = f(t, x), t [0, T ] dt x(0) = x 0 R [28 Marks] with f C subject to the Lipschitz

More information

ma22-9 u ( v w) = u v w sin θê = v w sin θ u cos φ = = 2.3 ( a b) ( c d) = ( a c)( b d) ( a d)( b c) ( a b) ( c d) = (a 2 b 3 a 3 b 2 )(c 2 d 3 c 3 d

ma22-9 u ( v w) = u v w sin θê = v w sin θ u cos φ = = 2.3 ( a b) ( c d) = ( a c)( b d) ( a d)( b c) ( a b) ( c d) = (a 2 b 3 a 3 b 2 )(c 2 d 3 c 3 d A 2. x F (t) =f sin ωt x(0) = ẋ(0) = 0 ω θ sin θ θ 3! θ3 v = f mω cos ωt x = f mω (t sin ωt) ω t 0 = f ( cos ωt) mω x ma2-2 t ω x f (t mω ω (ωt ) 6 (ωt)3 = f 6m ωt3 2.2 u ( v w) = v ( w u) = w ( u v) ma22-9

More information

23 7 28 i i 1 1 1.1................................... 2 1.2............................... 3 1.2.1.................................... 3 1.2.2............................... 4 1.2.3 SI..............................

More information

C 言語第 6 回 1 数値シミュレーション :2 階の微分方程式 ( シラバス10 11 回目 ) 1 2 階の微分方程式と差分方程式微分方程式を 2 d x dx + c = f ( x, t) 2 dt dt とする これを 2 つの 1 階の微分方程式に変更する ìdx = y 2 2 d

C 言語第 6 回 1 数値シミュレーション :2 階の微分方程式 ( シラバス10 11 回目 ) 1 2 階の微分方程式と差分方程式微分方程式を 2 d x dx + c = f ( x, t) 2 dt dt とする これを 2 つの 1 階の微分方程式に変更する ìdx = y 2 2 d C 言語第 6 回 1 数値シミュレーション : 階の微分方程式 ( シラバス10 11 回目 ) 1 階の微分方程式と差分方程式微分方程式を d x dx + c = f ( x, t) とする これを つの 1 階の微分方程式に変更する ìdx = y d x dx d x dx ï dt c f ( x, t) c f ( x, t) + = Þ = - + Þ í ï dy = - cy +

More information

y π π O π x 9 s94.5 y dy dx. y = x + 3 y = x logx + 9 s9.6 z z x, z y. z = xy + y 3 z = sinx y 9 s x dx π x cos xdx 9 s93.8 a, fx = e x ax,. a =

y π π O π x 9 s94.5 y dy dx. y = x + 3 y = x logx + 9 s9.6 z z x, z y. z = xy + y 3 z = sinx y 9 s x dx π x cos xdx 9 s93.8 a, fx = e x ax,. a = [ ] 9 IC. dx = 3x 4y dt dy dt = x y u xt = expλt u yt λ u u t = u u u + u = xt yt 6 3. u = x, y, z = x + y + z u u 9 s9 grad u ux, y, z = c c : grad u = u x i + u y j + u k i, j, k z x, y, z grad u v =

More information

1 u t = au (finite difference) u t = au Von Neumann

1 u t = au (finite difference) u t = au Von Neumann 1 u t = au 3 1.1 (finite difference)............................. 3 1.2 u t = au.................................. 3 1.3 Von Neumann............... 5 1.4 Von Neumann............... 6 1.5............................

More information

z f(z) f(z) x, y, u, v, r, θ r > 0 z = x + iy, f = u + iv C γ D f(z) f(z) D f(z) f(z) z, Rm z, z 1.1 z = x + iy = re iθ = r (cos θ + i sin θ) z = x iy

z f(z) f(z) x, y, u, v, r, θ r > 0 z = x + iy, f = u + iv C γ D f(z) f(z) D f(z) f(z) z, Rm z, z 1.1 z = x + iy = re iθ = r (cos θ + i sin θ) z = x iy f f x, y, u, v, r, θ r > = x + iy, f = u + iv C γ D f f D f f, Rm,. = x + iy = re iθ = r cos θ + i sin θ = x iy = re iθ = r cos θ i sin θ x = + = Re, y = = Im i r = = = x + y θ = arg = arctan y x e i =

More information

2 1 κ c(t) = (x(t), y(t)) ( ) det(c (t), c x (t)) = det (t) x (t) y (t) y = x (t)y (t) x (t)y (t), (t) c (t) = (x (t)) 2 + (y (t)) 2. c (t) =

2 1 κ c(t) = (x(t), y(t)) ( ) det(c (t), c x (t)) = det (t) x (t) y (t) y = x (t)y (t) x (t)y (t), (t) c (t) = (x (t)) 2 + (y (t)) 2. c (t) = 1 1 1.1 I R 1.1.1 c : I R 2 (i) c C (ii) t I c (t) (0, 0) c (t) c(i) c c(t) 1.1.2 (1) (2) (3) (1) r > 0 c : R R 2 : t (r cos t, r sin t) (2) C f : I R c : I R 2 : t (t, f(t)) (3) y = x c : R R 2 : t (t,

More information

p12.dvi

p12.dvi 301 12 (2) : 1 (1) dx dt = f(x,t) ( (t 0,t 1,...,t N ) ) h k = t k+1 t k. h k k h. x(t k ) x k. : 2 (2) :1. step. 1 : explicit( ) : ξ k+1 = ξ k +h k Ψ(t k,ξ k,h k ) implicit( ) : ξ k+1 = ξ k +h k Ψ(t k,t

More information

4 4 4 a b c d a b A c d A a da ad bce O E O n A n O ad bc a d n A n O 5 {a n } S n a k n a n + k S n a a n+ S n n S n n log x x {xy } x, y x + y 7 fx

4 4 4 a b c d a b A c d A a da ad bce O E O n A n O ad bc a d n A n O 5 {a n } S n a k n a n + k S n a a n+ S n n S n n log x x {xy } x, y x + y 7 fx 4 4 5 4 I II III A B C, 5 7 I II A B,, 8, 9 I II A B O A,, Bb, b, Cc, c, c b c b b c c c OA BC P BC OP BC P AP BC n f n x xn e x! e n! n f n x f n x f n x f k x k 4 e > f n x dx k k! fx sin x cos x tan

More information

2019 1 5 0 3 1 4 1.1.................... 4 1.1.1......................... 4 1.1.2........................ 5 1.1.3................... 5 1.1.4........................ 6 1.1.5......................... 6 1.2..........................

More information

7. y fx, z gy z gfx dz dx dz dy dy dx. g f a g bf a b fa 7., chain ule Ω, D R n, R m a Ω, f : Ω R m, g : D R l, fω D, b fa, f a g b g f a g f a g bf a

7. y fx, z gy z gfx dz dx dz dy dy dx. g f a g bf a b fa 7., chain ule Ω, D R n, R m a Ω, f : Ω R m, g : D R l, fω D, b fa, f a g b g f a g f a g bf a 9 203 6 7 WWW http://www.math.meiji.ac.jp/~mk/lectue/tahensuu-203/ 2 8 8 7. 7 7. y fx, z gy z gfx dz dx dz dy dy dx. g f a g bf a b fa 7., chain ule Ω, D R n, R m a Ω, f : Ω R m, g : D R l, fω D, b fa,

More information

: 1g99p038-8

: 1g99p038-8 16 17 : 1g99p038-8 1 3 1.1....................................... 4 1................................... 5 1.3.................................. 5 6.1..................................... 7....................................

More information

1. A0 A B A0 A : A1,...,A5 B : B1,...,B12 2. 5 3. 4. 5. A0 (1) A, B A B f K K A ϕ 1, ϕ 2 f ϕ 1 = f ϕ 2 ϕ 1 = ϕ 2 (2) N A 1, A 2, A 3,... N A n X N n X N, A n N n=1 1 A1 d (d 2) A (, k A k = O), A O. f

More information

comment.dvi

comment.dvi ( ) (sample1.c) (sample1.c) 2 2 Nearest Neighbor 1 (2D-class1.dat) 2 (2D-class2.dat) (2D-test.dat) 3 Nearest Neighbor Nearest Neighbor ( 1) 2 1: NN 1 (sample1.c) /* -----------------------------------------------------------------

More information

Untitled

Untitled II 14 14-7-8 8/4 II (http://www.damp.tottori-u.ac.jp/~ooshida/edu/fluid/) [ (3.4)] Navier Stokes [ 6/ ] Navier Stokes 3 [ ] Reynolds [ (4.6), (45.8)] [ p.186] Navier Stokes I 1 balance law t (ρv i )+ j

More information

x = a 1 f (a r, a + r) f(a) r a f f(a) 2 2. (a, b) 2 f (a, b) r f(a, b) r (a, b) f f(a, b)

x = a 1 f (a r, a + r) f(a) r a f f(a) 2 2. (a, b) 2 f (a, b) r f(a, b) r (a, b) f f(a, b) 2011 I 2 II III 17, 18, 19 7 7 1 2 2 2 1 2 1 1 1.1.............................. 2 1.2 : 1.................... 4 1.2.1 2............................... 5 1.3 : 2.................... 5 1.3.1 2.....................................

More information

[1] #include<stdio.h> main() { printf("hello, world."); return 0; } (G1) int long int float ± ±

[1] #include<stdio.h> main() { printf(hello, world.); return 0; } (G1) int long int float ± ± [1] #include printf("hello, world."); (G1) int -32768 32767 long int -2147483648 2147483647 float ±3.4 10 38 ±3.4 10 38 double ±1.7 10 308 ±1.7 10 308 char [2] #include int a, b, c, d,

More information

2014計算機実験1_1

2014計算機実験1_1 H26 1 1 1 seto@ics.nara-wu.ac.jp 数学モデリングのプロセス 問題点の抽出 定義 仮定 数式化 万有引力の法則 m すべての物体は引き合う r mm F =G 2 r M モデルの検証 モデルによる 説明 将来予測 解釈 F: 万有引力 (kg m s-2) G: 万有引力定数 (m s kg ) 解析 数値計算 M: 地球の質量 (kg) により解を得る m: 落下する物質の質量

More information

webkaitou.dvi

webkaitou.dvi ( c Akir KANEKO) ).. m. l s = lθ m d s dt = mg sin θ d θ dt = g l sinθ θ l θ mg. d s dt xy t ( d x dt, d y dt ) t ( mg sin θ cos θ, sin θ sin θ). (.) m t ( d x dt, d y dt ) = t ( mg sin θ cos θ, mg sin

More information

() n C + n C + n C + + n C n n (3) n C + n C + n C 4 + n C + n C 3 + n C 5 + (5) (6 ) n C + nc + 3 nc n nc n (7 ) n C + nc + 3 nc n nc n (

() n C + n C + n C + + n C n n (3) n C + n C + n C 4 + n C + n C 3 + n C 5 + (5) (6 ) n C + nc + 3 nc n nc n (7 ) n C + nc + 3 nc n nc n ( 3 n nc k+ k + 3 () n C r n C n r nc r C r + C r ( r n ) () n C + n C + n C + + n C n n (3) n C + n C + n C 4 + n C + n C 3 + n C 5 + (4) n C n n C + n C + n C + + n C n (5) k k n C k n C k (6) n C + nc

More information

dynamics-solution2.dvi

dynamics-solution2.dvi 1 1. (1) a + b = i +3i + k () a b =5i 5j +3k (3) a b =1 (4) a b = 7i j +1k. a = 14 l =/ 14, m=1/ 14, n=3/ 14 3. 4. 5. df (t) d [a(t)e(t)] =ti +9t j +4k, = d a(t) d[a(t)e(t)] e(t)+ da(t) d f (t) =i +18tj

More information

Ver.2.2 20.07.2 3 200 6 2 4 ) 2) 3) 4) 5) (S45 9 ) ( 4) III 6) 7) 8) 9) ) 2) 3) 4) BASIC 5) 6) 7) 8) 9) ..2 3.2. 3.2.2 4.2.3 5.2.4 6.3 8.3. 8.3.2 8.3.3 9.4 2.5 3.6 5 2.6. 5.6.2 6.6.3 9.6.4 20.6.5 2.6.6

More information

4................................. 4................................. 4 6................................. 6................................. 9.................................................... 3..3..........................

More information

00 3 9 ........................................................................................................................................... 4..3................................. 5.3.......................................

More information

ープのロープ長以下であれば実現可能である ケース 3: 3 本のロープの杭の位置を点 P 1 = (x 1, y 1, 0), 点 P 2 = (x 2, y 2, 0), 点 P 3 = (x 3, y 3, 0) とする 点 P 1 = (x 1, y 1, 0), 点 P 2 = (x 2,

ープのロープ長以下であれば実現可能である ケース 3: 3 本のロープの杭の位置を点 P 1 = (x 1, y 1, 0), 点 P 2 = (x 2, y 2, 0), 点 P 3 = (x 3, y 3, 0) とする 点 P 1 = (x 1, y 1, 0), 点 P 2 = (x 2, ACM ICPC2013 国内予選問題 E つながれた風船 風船が最も高くあがるケースとして 1. 一本のロープが垂直に延びて他の2 本は緩んでいる 2. 二本のロープがピンと張っており残りの1 本は緩んでいる 3. 三本のロープともピンとはっているの三つのケースが考えられる ロープの本数は高々 10 本なので ケース1 は高々 10 9C2=360 通り ケース2も高々 10C2 8=360 通り

More information

untitled

untitled 3 3. (stochastic differential equations) { dx(t) =f(t, X)dt + G(t, X)dW (t), t [,T], (3.) X( )=X X(t) : [,T] R d (d ) f(t, X) : [,T] R d R d (drift term) G(t, X) : [,T] R d R d m (diffusion term) W (t)

More information

I ( ) 1 de Broglie 1 (de Broglie) p λ k h Planck ( Js) p = h λ = k (1) h 2π : Dirac k B Boltzmann ( J/K) T U = 3 2 k BT

I ( ) 1 de Broglie 1 (de Broglie) p λ k h Planck ( Js) p = h λ = k (1) h 2π : Dirac k B Boltzmann ( J/K) T U = 3 2 k BT I (008 4 0 de Broglie (de Broglie p λ k h Planck ( 6.63 0 34 Js p = h λ = k ( h π : Dirac k B Boltzmann (.38 0 3 J/K T U = 3 k BT ( = λ m k B T h m = 0.067m 0 m 0 = 9. 0 3 kg GaAs( a T = 300 K 3 fg 07345

More information

P06.ppt

P06.ppt p.130 p.198 p.208 2 1 double weight[num]; double min, max; min = max = weight[0]; for( i= 1; i < NUM; i++ ) if ( weight[i] > max ) max = weight[i]: if ( weight[i] < min ) min = weight[i]: weight 3 maxof(a,

More information

f(x,y) (x,y) x (x,y), y (x,y) f(x,y) x y f x (x,y),f y (x,y) B p.1/14

f(x,y) (x,y) x (x,y), y (x,y) f(x,y) x y f x (x,y),f y (x,y) B p.1/14 B p.1/14 f(x,y) (x,y) x (x,y), y (x,y) f(x,y) x y f x (x,y),f y (x,y) B p.1/14 f(x,y) (x,y) x (x,y), y (x,y) f(x,y) x y f x (x,y),f y (x,y) f(x 1,...,x n ) (x 1 x 0,...,x n 0), (x 1,...,x n ) i x i f xi

More information

2012 IA 8 I p.3, 2 p.19, 3 p.19, 4 p.22, 5 p.27, 6 p.27, 7 p

2012 IA 8 I p.3, 2 p.19, 3 p.19, 4 p.22, 5 p.27, 6 p.27, 7 p 2012 IA 8 I 1 10 10 29 1. [0, 1] n x = 1 (n = 1, 2, 3,...) 2 f(x) = n 0 [0, 1] 2. 1 x = 1 (n = 1, 2, 3,...) 2 f(x) = n 0 [0, 1] 1 0 f(x)dx 3. < b < c [, c] b [, c] 4. [, b] f(x) 1 f(x) 1 f(x) [, b] 5.

More information

1. (8) (1) (x + y) + (x + y) = 0 () (x + y ) 5xy = 0 (3) (x y + 3y 3 ) (x 3 + xy ) = 0 (4) x tan y x y + x = 0 (5) x = y + x + y (6) = x + y 1 x y 3 (

1. (8) (1) (x + y) + (x + y) = 0 () (x + y ) 5xy = 0 (3) (x y + 3y 3 ) (x 3 + xy ) = 0 (4) x tan y x y + x = 0 (5) x = y + x + y (6) = x + y 1 x y 3 ( 1 1.1 (1) (1 + x) + (1 + y) = 0 () x + y = 0 (3) xy = x (4) x(y + 3) + y(y + 3) = 0 (5) (a + y ) = x ax a (6) x y 1 + y x 1 = 0 (7) cos x + sin x cos y = 0 (8) = tan y tan x (9) = (y 1) tan x (10) (1 +

More information

KENZOU

KENZOU KENZOU 2008 8 2 3 2 3 2 2 4 2 4............................................... 2 4.2............................... 3 4.2........................................... 4 4.3..............................

More information

,,,17,,, ( ),, E Q [S T F t ] < S t, t [, T ],,,,,,,,

,,,17,,, ( ),, E Q [S T F t ] < S t, t [, T ],,,,,,,, 14 5 1 ,,,17,,,194 1 4 ( ),, E Q [S T F t ] < S t, t [, T ],,,,,,,, 1 4 1.1........................................ 4 5.1........................................ 5.........................................

More information

IA September 25, 2017 ( ) I = [a, b], f (x) I = (a 0 = a < a 1 < < a m = b) I ( ) (partition) S (, f (x)) = w (I k ) I k a k a k 1 S (, f (x)) = I k 2

IA September 25, 2017 ( ) I = [a, b], f (x) I = (a 0 = a < a 1 < < a m = b) I ( ) (partition) S (, f (x)) = w (I k ) I k a k a k 1 S (, f (x)) = I k 2 IA September 5, 7 I [, b], f x I < < < m b I prtition S, f x w I k I k k k S, f x I k I k [ k, k ] I I I m I k I j m inf f x w I k x I k k m k sup f x w I k x I k inf f x w I S, f x S, f x sup f x w I

More information

[1][2] [3] *1 Defnton 1.1. W () = σ 2 dt [2] Defnton 1.2. W (t ) Defnton 1.3. W () = E[W (t)] = Cov[W (t), W (s)] = E[W (t)w (s)] = σ 2 mn{s, t} Propo

[1][2] [3] *1 Defnton 1.1. W () = σ 2 dt [2] Defnton 1.2. W (t ) Defnton 1.3. W () = E[W (t)] = Cov[W (t), W (s)] = E[W (t)w (s)] = σ 2 mn{s, t} Propo @phykm 218 7 12 [2] [2] [1] ([4] ) 1 Ω = 2 N {Π n =1 A { 1, 1} N n N, A {{ 1, 1}, { 1}, {1}, }} B : Ω { 1, 1} P (Π n =1 A 2 N ) = 2 #{ A={ 1},{1}} X = j=1 B j B X +k X V[X ] = 1 ( ) 1 1 dt dx W (t) = t/dt

More information

1 1.1 ( ). z = a + bi, a, b R 0 a, b 0 a 2 + b 2 0 z = a + bi = ( ) a 2 + b 2 a a 2 + b + b 2 a 2 + b i 2 r = a 2 + b 2 θ cos θ = a a 2 + b 2, sin θ =

1 1.1 ( ). z = a + bi, a, b R 0 a, b 0 a 2 + b 2 0 z = a + bi = ( ) a 2 + b 2 a a 2 + b + b 2 a 2 + b i 2 r = a 2 + b 2 θ cos θ = a a 2 + b 2, sin θ = 1 1.1 ( ). z = + bi,, b R 0, b 0 2 + b 2 0 z = + bi = ( ) 2 + b 2 2 + b + b 2 2 + b i 2 r = 2 + b 2 θ cos θ = 2 + b 2, sin θ = b 2 + b 2 2π z = r(cos θ + i sin θ) 1.2 (, ). 1. < 2. > 3. ±,, 1.3 ( ). A

More information

‚æ4›ñ

‚æ4›ñ ( ) ( ) ( ) A B C D E F G H I J K L M N O P Q R S T U V W X Y Z a b c d e f g h i j k l m n o p q r s t u v w x y z 0 1 2 3 4 5 6 7 8 9 (OUS) 9 26 1 / 28 ( ) ( ) ( ) A B C D Z a b c d z 0 1 2 9 (OUS) 9

More information

III 1 (X, d) d U d X (X, d). 1. (X, d).. (i) d(x, y) d(z, y) d(x, z) (ii) d(x, y) d(z, w) d(x, z) + d(y, w) 2. (X, d). F X.. (1), X F, (2) F 1, F 2 F

III 1 (X, d) d U d X (X, d). 1. (X, d).. (i) d(x, y) d(z, y) d(x, z) (ii) d(x, y) d(z, w) d(x, z) + d(y, w) 2. (X, d). F X.. (1), X F, (2) F 1, F 2 F III 1 (X, d) d U d X (X, d). 1. (X, d).. (i) d(x, y) d(z, y) d(x, z) (ii) d(x, y) d(z, w) d(x, z) + d(y, w) 2. (X, d). F X.. (1), X F, (2) F 1, F 2 F F 1 F 2 F, (3) F λ F λ F λ F. 3., A λ λ A λ. B λ λ

More information

1 No.1 5 C 1 I III F 1 F 2 F 1 F 2 2 Φ 2 (t) = Φ 1 (t) Φ 1 (t t). = Φ 1(t) t = ( 1.5e 0.5t 2.4e 4t 2e 10t ) τ < 0 t > τ Φ 2 (t) < 0 lim t Φ 2 (t) = 0

1 No.1 5 C 1 I III F 1 F 2 F 1 F 2 2 Φ 2 (t) = Φ 1 (t) Φ 1 (t t). = Φ 1(t) t = ( 1.5e 0.5t 2.4e 4t 2e 10t ) τ < 0 t > τ Φ 2 (t) < 0 lim t Φ 2 (t) = 0 1 No.1 5 C 1 I III F 1 F 2 F 1 F 2 2 Φ 2 (t) = Φ 1 (t) Φ 1 (t t). = Φ 1(t) t = ( 1.5e 0.5t 2.4e 4t 2e 10t ) τ < 0 t > τ Φ 2 (t) < 0 lim t Φ 2 (t) = 0 0 < t < τ I II 0 No.2 2 C x y x y > 0 x 0 x > b a dx

More information

Introduction to Numerical Analysis of Differential Equations Naoya Enomoto (Kyoto.univ.Dept.Science(math))

Introduction to Numerical Analysis of Differential Equations Naoya Enomoto (Kyoto.univ.Dept.Science(math)) Introduction to Numerical Analysis of Differential Equations Naoya Enomoto (Kyoto.univ.Dept.Science(math)) 2001 1 e-mail:s00x0427@ip.media.kyoto-u.ac.jp 1 1 Van der Pol 1 1 2 2 Bergers 2 KdV 2 1 5 1.1........................................

More information

dx dt = f x,t ( ) t

dx dt = f x,t ( ) t MATLAB 1. 2. Runge-Kutta 3. 1. 2. 3. dx dt = f x,t ( ) t dx( t) dt = lim Δt x( t + Δt) x( t) Δt t = nδt n = 0,1,2,3,4,5, x = x( nδt) n Δt dx ( ) dt = f x,t x n +1 x n Δt = f ( x,nδt) n 1 x n = x 0 n =

More information

K E N Z OU

K E N Z OU K E N Z OU 11 1 1 1.1..................................... 1.1.1............................ 1.1..................................................................................... 4 1.........................................

More information

x A Aω ẋ ẋ 2 + ω 2 x 2 = ω 2 A 2. (ẋ, ωx) ζ ẋ + iωx ζ ζ dζ = ẍ + iωẋ = ẍ + iω(ζ iωx) dt dζ dt iωζ = ẍ + ω2 x (2.1) ζ ζ = Aωe iωt = Aω cos ωt + iaω sin

x A Aω ẋ ẋ 2 + ω 2 x 2 = ω 2 A 2. (ẋ, ωx) ζ ẋ + iωx ζ ζ dζ = ẍ + iωẋ = ẍ + iω(ζ iωx) dt dζ dt iωζ = ẍ + ω2 x (2.1) ζ ζ = Aωe iωt = Aω cos ωt + iaω sin 2 2.1 F (t) 2.1.1 mẍ + kx = F (t). m ẍ + ω 2 x = F (t)/m ω = k/m. 1 : (ẋ, x) x = A sin ωt, ẋ = Aω cos ωt 1 2-1 x A Aω ẋ ẋ 2 + ω 2 x 2 = ω 2 A 2. (ẋ, ωx) ζ ẋ + iωx ζ ζ dζ = ẍ + iωẋ = ẍ + iω(ζ iωx) dt dζ

More information

Bessel ( 06/11/21) Bessel 1 ( ) 1.1 0, 1,..., n n J 0 (x), J 1 (x),..., J n (x) I 0 (x), I 1 (x),..., I n (x) Miller (Miller algorithm) Bess

Bessel ( 06/11/21) Bessel 1 ( ) 1.1 0, 1,..., n n J 0 (x), J 1 (x),..., J n (x) I 0 (x), I 1 (x),..., I n (x) Miller (Miller algorithm) Bess Bessel 5 3 11 ( 6/11/1) Bessel 1 ( ) 1.1, 1,..., n n J (x), J 1 (x),..., J n (x) I (x), I 1 (x),..., I n (x) Miller (Miller algorithm) Bessel (6 ) ( ) [1] n n d j J n (x), d j I n (x) Deuflhard j= j=.1

More information

2 P.S.P.T. P.S.P.T. wiki 26

2 P.S.P.T. P.S.P.T. wiki  26 P.S.P.T. C 2011 4 10 2 P.S.P.T. P.S.P.T. wiki p.s.p.t.since1982@gmail.com http://www23.atwiki.jp/pspt 26 3 2 1 C 8 1.1 C................................................ 8 1.1.1...........................................

More information