PARI/GP C. Batut, K. Belabas, D. Bernardi, H. Cohen, M. Oliver Laboratoire A2X, U.M.R du C.N.R.S Université Bordeaus I, 351 Cours de la Libérati

Size: px
Start display at page:

Download "PARI/GP C. Batut, K. Belabas, D. Bernardi, H. Cohen, M. Oliver Laboratoire A2X, U.M.R du C.N.R.S Université Bordeaus I, 351 Cours de la Libérati"

Transcription

1 PARI/GP C. Batut, K. Belabas, D. Bernardi, H. Cohen, M. Oliver Laboratoire A2X, U.M.R du C.N.R.S Université Bordeaus I, 351 Cours de la Libération TALENCE Cedex, FRANCE Home Page: Primary ftp site: ftp://pari.math.u-bordeaux.fr/pub/pari/ last updated September 17, 2002 (this document distributed with version 2.2.8) Translation: TOMINAGA Daisuke Computational Biology Research Center, National Institute of Advanced Industrial Science and Technology Aomi , Koto, Tokyo, , JAPAN February 24, 2004

2 Copyright c The PARI Group Permission is granted to make and distribute verbatim copies of this manual provided the copyright notice and this permission notice are preserved on all copies. Permissionis granted to copy and distribute modified version, or translations, of this manual under the conditions for verbatim copying, provided also that the entire resulting derived work is distributed under the terms of a permission notice indentical to this one. PARI/GP is Copyright c The PARI Group PARI/GP is free software; you can redistribute it and/or modify it under the terms of the GNU General Public Licence as published by the Free Software Fundation. It is distributed in the hope that it will be useful, but WITHOUT ANY WARRANTY WHATSOEVER. GNU General Public Licence

3 GP GP 1 - Greetings! gp Enter Macintosh Retern 1 GP? gp > GP Return Newline Macintosh Enter Macsyma Maple Return ; GP GP 27 * 37 * 27*37 GP GP GP quit exit system GP quit \q q q 2 GP 1/7 GP 1 / 7 GP 1/7 Q 1/7 2/14 PARI GP 1 Return 2 ver (development CHANGES-1.907) q 3

4 GP 1./ 7 1 / 7. 1./ 7. 1 / GP GP 12 GP 64bit integer DEC alpha 28 exp(1) e 28 log(exp(1)) 1 pi Pi GP pi stupid garbage GP stupidgarbage 27 * 37 GP GP??Pi?pi??Pi GP readline enabled readline exp(pi * sqrt(163)) 4

5 \p 50 exp(pi * sqrt(163)) 1 9 PARI sqr(log(%) / Pi) % %1 %2... GP sqr sqr(x) = x * x sqrt 163 exp(π n) n GP GP 1) PARI ver xx ell default(compatible, 3) break next return whatnow(function) 2) * * 1.4 3) 100! 28 4) 28 \p 28 exp(24 * Pi) GP 28 exp(24 π) 33 GP 33 5

6 5) %n n GP exp(24 * Pi) ) 28 default(format, "e0.50") exp(24 * Pi) log(exp(1)) default(format,) \p 7) default GP default(realprecision) default(realprecision, 38) \p(38) default format realprecision default 8)default GP 2 - Warming up 1/0 28 floor(exp(24 *Pi)) floor truncate floor(-3.4) 4 truncate(-3.4) 3 4 exp(24 * Pi) TEX gp 6

7 log(x) GP log(x) 5 log?log sqrt(-1) GP log(-2) exp(i*pi) I^I I i I^2 i^2 6*zeta(2) / Pi^2 GP log(x) log exp(x) exp(x) GP x = seriesprecision \psn default(seriesprecision, n) n O(x^16) 6 GP Big-O x = 0 0 log(x) log(1+x) 0 x x a x= 2 log log(x+2) serieslength \ps cos(x) cos(x)^2 + sin(x)^2 exp(cos(x)) gamma(1+x) exp(exp(x) - 1) 1 / tan(x) (1 + x)^3 O(x) 7 (1 + x)^(-3) -3 1 / 7 1/7 PARI 1/7 (1 + x)^(-3) + O(x^16) (1 + O(x^16)) * (1 + x)^(-3) (1 + x + O(x^16))^(-3),... seriesprecision 5 log is not analytic at 0. 6 O(x^17) 7 7

8 Ser( (1 + x)^(-3) ) (1 + x)^(1/2) PARI PARI (1 + x)^pi (1 + x)^(-3.) -3. PARI taylor((1 + x)^(-3), x) taylor PARI 1) \y 0 n = 3 + I - I 3 type(n) 8 (1+x)^n 1 + 3*x + 3*x^2 + x^3 9 eulerphi arithmetic functions want integer x - x 3 x 3 = 3x 0 10 simplify GP \y 2) x=0 x=a x z + a subst p = 1 / (x^4 + 3*x^3 + 5*x^2-6*x + 7) subst(p, x, z+a) x z + a subst p = 1 + x + x^2 + O(x^10) subst(p, x, z+1) 8 t INT t COMPLEX 9 10 type(3 + x - x) t POL 8

9 3 - The Remaining PARI Types PARI p = x * exp(-x) 16 pr = serreverse(p) x 1 subst(p, x, pr) subst(pr, x, p) x + O(x^17) 11 pr x^n n! PARI serlaplace ps = serlaplace(pr) x n n n 1 pr = n 1 n n 1 X n n! PARI [1,2,3,4] [1,2,3,4]~ ~ \b \b m = [a,b,c; d,e,f] ; \a default(output, 1) default(output, 0) m[1,2] m[1,] m[,2] m[j,k] j k 1 0 m[1,2] = 5; m m[1,] = [15,-17,8] m[,2] = [j,k] m[,2] m[,2] = [j,k]~ h = mathilbert(20) i j (i + j 1) 1 h ; h = mathildert(20); PARI precomputed 11 p 17 +O(x^18) x + O(x^18) default seriesprecision = 16 significant terms 9

10 PARI d = matdet(h) * d sizedigit(1/d) hr = 1. * h; dr = matdet(hr) * d 2 norml2(1/h - 1/hr) norml2 L 2 1/h matdet(h) /hr i i 2 10 vector(10, i, i^2) matrix(5,5,i,j, 1/(i+j-1)) mathilbert i j I 1 vector(10, I, I^2) GP I Pi Euler i pi euler if() if if matrix(8,8, i,j, if ((i-j)%2, x, 0)) x :1 mathilbert(50) 2 :30 10

11 for (i = 1, 5, v[i] = 1/i) v v = vector(5,j,0) PARI n = 10^ PARI factor factor(n, ) factor n PARI factor n n a a n 1 1 (mod n) a = 2 2 n a = Mod(2,n) R = Z/nZ 2 R n R a n 1 =Mod(1,n) a^(n-1) n Mod(1,n) Mod(1,n) n fa = factor(n) factor isprime(fa[,1]) isprime fa 1 p p p n p O(p^n) n= 1 O(p) n = O(7^8) s = sqrt(n) n s^2-n l = log(n) e = exp(l) p e n (n/e)^6 e 11

12 n 1 p 1 p n 569 lift(n) truncate(n) Q quadgen d w (d + a)/2 a d 0 1 quadgen w w w w = quadgen(d) w1 w = quadgen(-163) charpoly(w) w x charpoly(w, y) subst w 1.*w Q( 163) w^10 norm(3 + 4*w) 1 / (4+w) a = Mod(1,23) * w b = a^ lift(b) p = x^2 + w*x + 5*w + 7 norm(p) Q(w) p Q wr = sqrt(w^2) w sqrt algdep(wr,2) w w algdep(sqrt(3*w + 5), 4) algdep Q p Z/pZ w = quadgen(-163) w = Mod(x, x^2 - x + 41) w^10 norm(3 + 4*w) 1 / (4+w) a = Mod(1,23)*w b = a^264 lift(...) x^2 - x + 41 w 1.*w sqrt(w) 2 C w w n n 12

13 a = Mod(x, x^3 - x -1) b = a^5 a b b modreverse(b) b a 4 - Elementary Arithmetic Functions PARI factor factor factor(x^15-1) p factormod factorff GCD gcd GCD bezout chinese isprime ispseudoprime precprime nextprime ispseudoprime isprime µ moebius φ eulerphi ω Ω omega bigomega k σ k sigma \p 1000 contfrac(exp(1)) GP isprime issquare isfundamental 1 forprime fordiv sumdiv n p=1; fordiv(n,d, p *= d); p p *= d p = p * d p forprime(p=3,1000, if (znprimroot(p) == 2, print(p))) znprimroot forprime(p=3,1000, if (znorder(mod(2,p)) == p-1, print(p))) Z/pZ 13

14 5 - Performing Linear Algebra Z lattice PARI PARI p Z Using Transcendental Functions K polylogarithm GP e = exp(1) e = \p 50 e exp(1) e 50 e length(e) ln(2 32 )/ ln(10) \p 28 exp(1.) 28 f = exp( ^(-30)) ^(-30) PARI ^(-30) 59 = f cos(10.^(-15)) length(%) words = 96 bits = 12 bytes 14

15 PARI x 1 cos(x) 1 x 2 / = 58 PARI cos(0) GP 1 GP gamma(10) 9! gamma(100) 99! gamma(100) 156 \p 170 gamma(100) \p 28 lngamma(100) log(99!) gamma(1/2 + 10*I) t = 1000; z= gamma(1 + I*t) * t^(-1/2) * exp(pi/2*t)/sqrt(2*pi) norm(z) norm(z) 1 # zeta(2) Pi^2/6 zeta(3) zeta(3.) 14 n PARI zeta(n) zeta(1 + I) zeta 1/2 + i t t zeta.gp GP \r zeta.gp { t1 = 1/2 + 14*I; t2 = 1/2 + 15*I; eps = 10^(-50); z1 = zeta(t1); until (norm(z2) < eps, z2 = zeta(t2); if (norm(z2) < norm(z1), 14 Apple /PowerBook G4(867MHz 640MB) p 500 zeta(3.)

16 } ) t3 = t1; t1 = t2; t2 = t3; z1 = z2 ); t2 = (t1+t2) / 2.; print(t1 ": " z1) GP \ GP.gp GP 15 GP 25 p a = exp(7 + O(7^10)) log(a) b = log(5 + O(7^10)) exp(b) exp(b) * teichmuller(5 + O(7^10)) teichmuller(x) Teichmüller x p p x p 1 agm(1,sqrt(2)) 1 2 arithmeticgeometric mean AGM Pi/2 / intnum(t=0,pi/2, 1 / sqrt(1 + sin(t)^2)) x = sin(t) 1 0 dx 1 x 4 = π 2agm(1, 2) 2 * agm(1,i) / (1+I) agm(1, O(7^10)) p p p p p = 2 a/b agm(a,b)?3 p 7 - Using Numerical Tools PARI 15 zeta.gp zeta 16

17 π = 4( ) atan(x) π \p * sumalt(k=0, (-1)^k/(2*k + 1)) Pi π 100 Pi PARI 1.38 Wijngaarden F. Villegas D. Zagier H. Cohen 16 \p 28 sumpos(k=1, 1 / k^2) Pi^2/6 sumalt zet(s) = sumalt(k=1, (-1)^(k-1) / k^s) / (1-2^(1-s)) s 1 zet(s) zeta(s) sumalt s zet(s) zet(-1) zet(-2) zet(-1.5) zeta zet(-14.5) zet(i) zeta(i) sumalt(n=1, (-1)^n/(n+I)) intnum(t=1,2, 1/t) log(2) PARI h(z) = e z z r 1 h (z) 2iπ h(z) dz C r C r r fun(z) = { } local(u); u = exp(z); (u-1) / (u-z) zero(r) = r/(2*pi) * intnum(t=0, 2*Pi, fun(r*exp(i*t)) * exp(i*t)) u fun GP 0 16 Cohen, Villegas, Zagier. Convergence Acceleration of Alternating Series, Experimental Mathematics, vol. 9, No. 1, (2000) 17 Chapter Sums, product, integrals and similar functions 17

18 u 18 zero(r) z = r exp(i t) \p 9 zero(1) zero(1.5) z x y z = x + iy e z z = 0 e 2x = x 2 + y 2 e x cos(y) = x y = ± e 2x x 2 e x cos( e 2x x 2 ) = x fun(x) = { local(u); u = exp(x); u*cos(sqrt(u^2 - x^2)) - x } fun(0) fun(1) 28 x0 = solve(x=0,1, fun(x)) x z = x0 + I*sqrt(exp(2*x0) - x0^2) exp(z) - z abs(z) solve solve solve(t=14,15, real(zeta(1/2 + I*t))) 19 t=14 t=15 solve(t=14,15, imag(zeta(1/2 + I*t))) solve(t=14,14.2, real(zeta(1/2 + I*t))) 8 - Functions Related to Polynomials and Power Series exact inexact 18 u 19 roots must be bracketed in solve. 18

19 gcd(x^2-1, x^2-3*x + 2) x - 1 gcd(x^2-1., x^2-3.*x + 2.) 3 PARI gcd(x - Pi, x^2-6*zeta(2)) x - Pi PARI π GCD polresultant(x - Pi, x^2-6*zeta(2)) 0 pol = polcyclo(15) 15 ϕ(15) = 8 r = polroots(pol) 8 28 \b polroots pol 15 rc = r^15. rc = r^ rr = round(real(rc)) sqrt(norml2(rc-rr)) rr 1 rc - rr L norml2 L2 pol = x^5 + x^4 + 2*x^3-2*x^2-4*x -3 factor(pol) pol Q Z fun(p) = factorpadic(pol,p,10) 10 Q p pol fun(p) factor(poldisc(pol)) fun(5) fun(11) fun(23) fun(37) lf(p) = lift(factormod(pol,p)) lf(2) lf(11) lf(23) lf(37) F p pol2 = x^3 + x^2 + x - 1 fq = factorff(pol2, 3, t^3 + t^2 + t - 1) centerlift(lift(fq)) θ t^3 + t^2 + t - 1 F 3 (θ) pol2 F 27 Gal(F 27 /F 3 ) u u 3 3 t

20 pol3 = x^4-4*x^ fn = factornf(pol3,t^2+1) pol3 t^2+1 Q(i) lift(fn) t i = 1 fn2 = factornf(pol3, x^2 + 1) 21 PARI lift(fn2) x*x PARI x x lift C R polroots F p factormod F p k factorff Q p factorpadic Q Z factor factornf nffactor factor pol = x^2+1 factor pol pol * 1. pol * (1+0.*I) pol * Mod(1,2) pol * Mod(1,Mod(1,3)*(t^2+1)) padicappr rootsmod polrootspadic polsturm polsym(pol3,20) pol3 k = 20 pol3 k polroots 2 k 8*x + prod(n=1,39, if(n%4, 1 - x^n, 1), 1 + O(x^40))^8 x O(x^40) n=39 x^40 \ps 122 default(seriesprecision, 122) d = x * eta(x)^24 Ramanujan 122 τ 2 d%2 PARI 21 incorrect polynomial in rnf function. 20

21 22 lift(mod(1,2) * d) Antwarp III 23 centerlift(mod(1,3) * d) Antwerp III 9 - Working with Elliptic Curves ellinit e = ellinit([6,-3,9,-16,-14]) y 2 + 6xy + 9y = x 3 3x 2 16x 14?. ell ellinit init clgpinit 24 e.disc r = ellglobalred(e) r[1] 37 4 e = ellchangecurve(e, r[2]) e c p e y 2 + y = x 3 x e q = [0, 0] ellisoncurve(e, q) q torsion point ellheight(e, q) q - canonical Neron-Tate height q for(k = 1, 20, print(ellpow(e, q,k))) ellheight(e, ellpow(e, q,20)) / ellheight(e, q) 400 = forbidden division t SER % t INT. 23 Volume 3 of the Proceedings of the International Summer School on Modular functions of one variable and arithmetial applications 24 clgp class group 21

22 ellorder(e, q) 0 q ell ob ob init e = ellinit([0,-1,1,0,0]) y 2 +y = x 3 x 2 11 ellglobalred(e) e q = [0, 0] e ellheight(e, q) q for(k=1,5, print(ellpow(e, q,k))) q 5 [0] ellorder(e, q) e = ellinit([0,0,1,-7,6]) y 2 +y = x 3 7x + 6 ellglobalred(e) 5077 elltors(e) e.roots C Y 2 = X 3 7X + 25/4 (X, Y ) = (x, y + 1/2) 3 (x, y) x x 3 (x, y) (x, y 1) ellordinate point.gp \r points { } v=[]; for (x = -3, 1000, s = ellordinate(e,x); if (#s, if cardinality of \kbd{s} is non-zero v = concat(v, [[x,s[1]]]) ) ); v \\ /*.. */ points.gp 25 /* e * 25 EUC OK 22

23 * e * */ order hv = ellheight(e, v) canonical height iv = vecsort(hv,, 1); hv = vecextract(hv, iv); v = vecextract( v, iv); \\ - 4 m = ellheightmatrix(e, vecextract(v,[1,2,3,4])); matdet(m) 4 m kernel matker(m) elladd(e, v[1],v[3]) v[4] 4 vp = [v[1],v[2],v[3]]~; m = ellheightmatrix(e,vp); matdet(m) e 3 ellbil Q v[1] v[2] v[3] matsolve(m, ellbil(e, vp,q)) matker w = vector(18,k, matsolve(m, ellbil(e, vp,v[k]))) wr = round(w); sqrt(norml2(w - wr)) wr v e v1 = [1,0]; v2 = [2,0]; z1 = ellpointtoz(e, v1) z2 = ellpointtoz(e, v2) 23

24 v1 v2 elladd(e, v1,v2) ellztopoint(e, z1 + z2) C e group law one f = x * Ser(ellan(e, 30)) Γ 0 (5077) 2 e Wiles modul = elltaniyama(e) u=modul[1]; v=modul[2]; (v^2 + v) - (u^3-7*u + 6) x * u / (2*v + 1) f GP u v x = e 2iπτ Γ 0 (5077) q = [0,0] 5 e = ellinit([0,-1,1,0,0]) 11 ellglobalred(e) 26 elllseries(e, 1,-11,1.1) elllseries(e, 1,-11,1) 6 ls = elllseries(e, 1,11,1) elllseries(e, 1,11,1.1) 27 1 e L Birch - (Swinnerton-Dyer ls L(E, 1) = Ω c III E tors 2 Ω E c p c p III - Tate-Shafarevich E tors E torsion group Ω e.omega[1] e.roots 3 Ω 2 * e.omega[1] c ellglobalred(e) 1 E 5 torsell(e) 28 5 ls * 25/e[15] III 1 26 expected character: ) instead of: elllseries(e,1,-11,1.1) elltors(e) 24

25 10 - Working in Quadratic Number Fields Q D isfundamental(d) ω D D/2 (1 + D)/2 a + bω w = quadgen(d) w ω w w w1 = quadgen(-23); w2 = quadgen(-15); w1 w2 w PARI ax 2 +bxy +cy 2 3 (a, b, c) Qfb(a,b,c) PARI qfbred Shanks NUCOMP qfbnumcomp qfbnupow qfbclassno qfbclassno Hurwitz class group quadclassunit qfbclassno(-10007) GP 77 PARI qfbclassno quadclassunit Generalized Riemann Hypothesis GRH (a, b, c) a = 2 f = qfbprimeform(-10007, 2) 77 f^77 1 f 11 7 f sqrt(10007)/pi * prodeuler(p=2,500, 1./(1 - kronecker(-10007,p)/p)) kronecker 1 25

26 1./(1 - \dots) PARI PARI prodeuler D = 3299 qfbclassno 27 f = qfbprimeform(-3299, 3) 2 3 f 9 9 f f = qfbprimeform(-3299, 3) quadclassunit quadclassunit(-3299) GRH GRH quadclassunit(-3299,,[1,6]),, GP GRH bnfinit GPH bnf = bnfinit(x^ ); bnfcertify(bnf) 1 bnf init ellinit \bnfcertify quadclassunit?. bnf.clgp 27 GP %.no bnf.clgp.no bnf.no Q 3299 Hilbert quadhilbert(-3299) 27 D > 0 26

27 quadgen (a, b, c) 4 (a, b, c, d) ax 2 + bxy + cy 2 a b c d Archimedean component d Lenstra Qfb(a,b,c,d) (a, b, c) d 0. qfbred d qfbcompraw qfbpowraw qfbprimeform qfbred qfbclassno quadregulator quadclassunit qfbclassno quadregulator O( D) 10 quadclassunit d = 3 * 3299; qfbclassno(d) 3 d = Sholz 3 f = qfbred(qfbprimeform(d,2), 2) 2 qfbref 2 f g = f; for(i=1,20, g = qfbred(g, 3); print(g)) 3 ±1 f f 3 f^3 αz K α f3 = qfbpowraw(f, 3) f 3 8 = 2 3 α ±8 1 27

28 reach the unit form qfbred(%,1) 6 c = component(%, 4) α σ(α) = ±e2c σ a = sqrt(8 * exp(2*c)) sa = 8 / a α σ(α) α a sa α 8 σ(α) sa p = x^2 - round(a - sa)*x - 8 α d α α = ( d)/2 polred modreverse 2 2 α f3 D = 10^7 + 1 quadclassunit(d,,[1,6]) 5 GRH 1 regulator qfbclass quadregulartor bnfinit bnfcertify 5 bnfcertify fundamental unit bnfinit R/ log(10) 1147 quadunit(d) 500 unit form D 0 u = qfbred(qfb(1,1,(1 - D)/4), 2) 0 qfbred f = qfbred(u, 1) principal cycle f f /4.253 = 621 f^ f / f^517 principal form 28

29 517 PARI 500 u f = qfbred(u, 1) f compact representaion p quadhilbert Working on General Number Fields 12 GP - GP Programming 13 - Plotting PARI X windows system 29 PostScript gnuplot 2 /* */ parametric = 1; no_x_axis = 8; points = 64; recursive = 2; no_y_axis = 16; points_lines = 128; norescale = 4; no_frame = 32; splines = 256; /* */ nw = 0; se = 4; relative = 1; sw = 2; ne = 6; /* */ /* */ bottom = 0; /* */ left = 0; /* */ hgap = 16; vcenter = 4; center = 1; vgap = 32; 29 X window system window s 29

30 top = 8; right = 2; \p ploth(x = -2, 2, sin(x^7)) sin 1 1 PARI sin(x 7 ) ploth(x = -2, 2, sin(x^7),recursive) PARI ploth(x = -2, 2, sin(x*7), recursive) 3 [ 2, 2] PARI ploth(x = -2, 2, sin(x*7), recursive, 16) PARI ploth ζ( it) ploth(t = 100, 110, real(zeta(0.5+i*t)), /*empty*/, 1000)

31 ploth(t = 100, 110, real(zeta(0.5+i*t)), recursive) ploth(t = 100, 110, real(zeta(0.5+i*t)), splines, 100) ζ f(t) = z=zeta(0.5+i*t); [real(z),imag(z)] ploth(t = 100, 110, f(t),, 1000) f(t) t ζ( it) ploth(t = 100, 110, f(t), parametric, 1000) ploth(t = 100, 110, f(t), parametric+splines, 100) PARI ploth(t = 100, 110, f(t), parametric+splines+points_lines, 100) t ploth(t = 10000, 10004, f(t), parametric+splines+points_lines, 50) ploth PARI sin(x 7 ) rectangles rectwindows 0 15 rectangles rectangle plotinit(2) plotscale(2, 0,1, 0,1) x y

32 plotmove(2, 0,0) plotbox(2, 1,1) % plotinit(3, 0.88, 0.88, relative) plotrecth(3, X = -2, 2, sin(x^7), recursive) PARI rectangle 2 3 plotdraw([2, 0,0, 3, 0.1,0.02], relative) ploth gnuplot x y rectangle 2 (0.1, 0.1) (0.1, 0.98) (0.98, 0.1) (0.98, 0.98) x plotmove(2, 0.1,0.1) plotstring(2, "-2.000", left+top+vgap) sin X 7 y plotrecth x y plotinit(3, 0.88, 0.88, relative) lims = plotrecth(3, X = -2, 2, sin(x^7), recursive) \p 3 \\ $3$ limits = vector(4,i, Str(lims[i])) plotinit(2); plotscale(2, 0,1, 0,1) plotmove(2, 0,0); plotbox(2, 1,1) plotmove(2, 0.1,0.1); plotstring(2, limits[1], left+top+vgap) plotstring(2, limits[3], bottom+vgap+right+hgap) plotmove(2, 0.98,0.1); plotstring(2, limits[2], right+top+vgap) plotmove(2, 0.1,0.98); plotstring(2, limits[4], right+hgap+top) plotdraw([2, 0,0, 3, 0.1,0.02], relative) PARI ζ(1/2 + it) 32

33 rectangle 0 rectangle 1 rectangle 0 rectangle 3 rectangle 2 rectangle 3 plotrecth plotinit(0, 0.9,0.9, relative) plotrecth(0, t=100,110, f(t), parametric, 300) plotrecth(0, t=100,110, f(t), parametric+splines+points_lines+norescale, 30); plotrecth(0, t=100,110, f(t), parametric+splines+points_lines+norescale, 20); plotdraw([0, 0.05,0.05], relative) plotrect plotinit(0, 0.9,0.9, relative) plotpointtype(-1, 0) \\ plotpointsize(0, 0.4) \\ plotrecth(0, t=100,110, f(t), parametric+points, 300) plotpointsize(0, 1) \\ plotlinetype(-1, 1) \\ plotpointtype(-1, 1) \\ curve_only = norescale + no_frame + no_x_axis + no_y_axis plotrecth(0, t=100,110,f(t), parametric+splines+points_lines+curve_only, 30); plotlinetype(-1, 2) \\ plotpointtype(-1, 2) \\ plotrecth(0, t=100,110,f(t), parametric+splines+points_lines+curve_only, 20); plotdraw([0, 0.05,0.05], relative) plotoinetype plotpointtype plotpointsize PM OS/2 gnuplot PARI 33

34 gnuplot plotfile("plot.tex") plotterm("texdraw") plot.tex gnuplot texdraw plotfile("-") PARI plotfile("manypl1.gif") \\ plotterm("gif=300,200") wpoints = plothsizes()[1] \\$300 \times 200$ { for( k=1,6, plotfile("manypl" k ".gif"); ploth(x = -1, 3, sin(x^k),, wpoints) ) } sin x k, k = GIF manypl1.gif...manypl6.gif 30 PARI PS plotdraw psdraw ploth psploth default psfile PARI PS ζ(1/2 + it) 16 PARI 16 PARI plotcopy 4 A T 2 A = 2; \\ accumulator T = 3; \\ temporary target plotinit(a); plotscale(a, 0, 1, 0, 1) plotinit(t, 0.42, 0.42, relative); plotrecth(t, x= -5, 5, sin(x), recursive) plotcopy(t, 2, 0.05, 0.05, relative + nw) plotmove(a, /2, /2) plotstring(a,"graph", center + vcenter) 30 gnuplot 34

35 plotinit(t, 0.42, 0.42, relative); plotrecth(t, x= -5, 5, [sin(x),cos(2*x)], 0) plotcopy(t, 2, 0.05, 0.05, relative + ne) plotmove(a, /2, /2) plotstring(a,"multigraph", center + vcenter) plotinit(t, 0.42, 0.42, relative); plotrecth(t, x= -5, 5, [sin(3*x), cos(2*x)], parametric) plotcopy(t, 2, 0.05, 0.05, relative + sw) plotmove(a, /2, 0.5) plotstring(a,"parametric", center + vcenter) plotinit(t, 0.42, 0.42, relative); plotrecth(t, x= -5, 5, [sin(x), cos(x), sin(3*x),cos(2*x)], parametric) plotcopy(t, 2, 0.05, 0.05, relative + se) plotmove(a, /2, 0.5) plotstring(a,"multiparametric", center + vcenter) plotlinetype(a, 3) plotmove(a, 0, 0) plotbox(a, 1, 1) plotdraw([a, 0, 0]) \\ psdraw([a, 0, 0], relative) \\ Rectangle A accumulator rectangle T plotrecth Rectangle T geographic plotcopy 0 sin x 0 xlim = 13; ordlim = 25; f(x) = sin(x); 35

36 default(seriesprecision,ordlim) farray(t) = vector((ordlim+1)/2, k, truncate( f(1.*t + O(t^(2*k+1)) ))) FARRAY = farray( t); \\ t t farray(x) f(x) FARRAY f(x) plotinit(3, 0.9, 0.9/1.2, 1); curve_only = no_x_axis+no_y_axis+no_frame; lims = plotrecth(3, x= -xlim, xlim, f(x), recursive+curve_only,16); h = lims[4] - lims[3]; 31 plotinit(4, 0.9,0.9, relative); plotscale(4, lims[1], lims[2], lims[3] - h/10, lims[4] + h/10) plotrecth(4, x = -xlim, xlim, subst(farray,t,x), norescale); plotclip(4) plotrecth(...norescale) xlim 13 -xlim...xlim plotclip plotinit(2) plotscale(2, 0.0, 1.0, 0.0, 1.0) plotmove(2,0.5,0.975) plotstring(2,"multiple Taylor Approximations",center+vcenter) plotdraw([2, 0, 0, 3, 0.05, /12, 4, 0.05, 0.05], relative) 3 PARI plotscale x y x y x y [0, 1] (0,0) (0,1) 31 3 plotrecth 40 36

37 PARI PARI 6 plotsizes ploth plotstring relative plothsizes gnuplot plotterm("dumb") 14 ponpoko web [1] 14.1 Mac OS X v Apple / PowerBook G4(867MHz, 640MB ) GP/PARI CALCULATOR ver (development CHANGES-1.907) (readline v4.3 enabled, extended help available) gnuplot ptex Version p3.1.2 (sjis) (Web2C 7.4.5) platex2e 2001/09/04 +0 (based on LaTeX2e 2001/06/01 patch level 0) 37

38 dvipdfmx TEX ptex package for Mac OS X PARI/GP PARI/GP CVS Unix Mac OS X xterm kterm rxvt % % cvs -d :pserver:cvs@pari.math.u-bordeaux.fr:/home/cvs login % cvs -z3 -d :pserver:cvs@pari.math.u-bordeaux.fr:/home/cvs checkout pari pari GNUPLOT gnuplot CVS PARI/GP configure make install % % cvs -d:pserver:anonymous@cvs.sourceforge.net:/cvsroot/gnuplot login % cvs -z3 -d:pserver:anonymous@cvs.sourceforge.net:/cvsroot/gnuplot co gnuplot % cd gnuplot %./configure % make % cd src % ar cr libgnuplot.a version.o util.o term.o bitmap.o stdfn.o % sudo cp libgnuplot.a /usr/local/lib PARI/GP Configure & make Configure libgnuplot.a CVS PARI/GP gnuplot ver j

39 [1] [2] 39

2.4.2 if Par

2.4.2 if Par Pari-GP 1 Pari-gp 2 1.1 Pari-gp............... 3 2 gp 4 2.1 gp............................. 5 2.1.1 gp................... 5 2.1.2...................... 6 2.1.3............... 7 2.1.4......................

More information

Pari-gp /7/5 1 Pari-gp 3 pq

Pari-gp /7/5 1 Pari-gp 3 pq Pari-gp 3 2007/7/5 1 Pari-gp 3 pq 3 2007 7 5 Pari-gp 3 2007/7/5 2 1. pq 3 2. Pari-gp 3. p p 4. p Abel 5. 6. 7. Pari-gp 3 2007/7/5 3 pq 3 Pari-gp 3 2007/7/5 4 p q 1 (mod 9) p q 3 (3, 3) Abel 3 Pari-gp 3

More information

Pari-gp 2006/7/12 2 1. Pari-gp 2. Microsoft Windows 3. 4. Pari-gp 5. 2 6. 7. Galois 8.

Pari-gp 2006/7/12 2 1. Pari-gp 2. Microsoft Windows 3. 4. Pari-gp 5. 2 6. 7. Galois 8. Pari-gp 2006/7/12 1 Pari-GP 2006 7 12 Pari-gp 2006/7/12 2 1. Pari-gp 2. Microsoft Windows 3. 4. Pari-gp 5. 2 6. 7. Galois 8. Pari-gp 2006/7/12 2-1 +ε. Pari-gp 2006/7/12 3 Pari-gp Pari C gp GP gp K. Belabas

More information

1 1 Gnuplot gnuplot Windows gnuplot gp443win32.zip gnuplot binary, contrib, demo, docs, license 5 BUGS, Chang

1 1 Gnuplot gnuplot   Windows gnuplot gp443win32.zip gnuplot binary, contrib, demo, docs, license 5 BUGS, Chang Gnuplot で微分積分 2011 年度前期 数学解析 I 講義資料 (2011.6.24) 矢崎成俊 ( 宮崎大学 ) 1 1 Gnuplot gnuplot http://www.gnuplot.info/ Windows gnuplot 2011 6 22 4.4.3 gp443win32.zip gnuplot binary, contrib, demo, docs, license 5

More information

i

i i 3 4 4 7 5 6 3 ( ).. () 3 () (3) (4) /. 3. 4/3 7. /e 8. a > a, a = /, > a >. () a >, a =, > a > () a > b, a = b, a < b. c c n a n + b n + c n 3c n..... () /3 () + (3) / (4) /4 (5) m > n, a b >, m > n,

More information

微分積分 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. このサンプルページの内容は, 初版 1 刷発行時のものです.

微分積分 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます.   このサンプルページの内容は, 初版 1 刷発行時のものです. 微分積分 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. ttp://www.morikita.co.jp/books/mid/00571 このサンプルページの内容は, 初版 1 刷発行時のものです. i ii 014 10 iii [note] 1 3 iv 4 5 3 6 4 x 0 sin x x 1 5 6 z = f(x, y) 1 y = f(x)

More information

I, II 1, A = A 4 : 6 = max{ A, } A A 10 10%

I, II 1, A = A 4 : 6 = max{ A, } A A 10 10% 1 2006.4.17. A 3-312 tel: 092-726-4774, e-mail: hara@math.kyushu-u.ac.jp, http://www.math.kyushu-u.ac.jp/ hara/lectures/lectures-j.html Office hours: B A I ɛ-δ ɛ-δ 1. 2. A 1. 1. 2. 3. 4. 5. 2. ɛ-δ 1. ɛ-n

More information

I A A441 : April 15, 2013 Version : 1.1 I Kawahira, Tomoki TA (Shigehiro, Yoshida )

I A A441 : April 15, 2013 Version : 1.1 I   Kawahira, Tomoki TA (Shigehiro, Yoshida ) I013 00-1 : April 15, 013 Version : 1.1 I Kawahira, Tomoki TA (Shigehiro, Yoshida) http://www.math.nagoya-u.ac.jp/~kawahira/courses/13s-tenbou.html pdf * 4 15 4 5 13 e πi = 1 5 0 5 7 3 4 6 3 6 10 6 17

More information

GNUPLOT 28 3 15 UNIX Microsoft-Windows GNUPLOT 4 GNUPLOT 1 GNUPLOT 2 2 3 2.1 UNIX.......................................... 3 2.2 Windows........................................ 4 2.3..................................

More information

1 = = = (set) (element) a A a A a A a A a A {2, 5, (0, 1)}, [ 1, 1] = {x; 1 x 1}. (proposition) A = {x; P (x)} P (x) x x a A a A Remark. (i) {2, 0, 0,

1 = = = (set) (element) a A a A a A a A a A {2, 5, (0, 1)}, [ 1, 1] = {x; 1 x 1}. (proposition) A = {x; P (x)} P (x) x x a A a A Remark. (i) {2, 0, 0, 2005 4 1 1 2 2 6 3 8 4 11 5 14 6 18 7 20 8 22 9 24 10 26 11 27 http://matcmadison.edu/alehnen/weblogic/logset.htm 1 1 = = = (set) (element) a A a A a A a A a A {2, 5, (0, 1)}, [ 1, 1] = {x; 1 x 1}. (proposition)

More information

No2 4 y =sinx (5) y = p sin(2x +3) (6) y = 1 tan(3x 2) (7) y =cos 2 (4x +5) (8) y = cos x 1+sinx 5 (1) y =sinx cos x 6 f(x) = sin(sin x) f 0 (π) (2) y

No2 4 y =sinx (5) y = p sin(2x +3) (6) y = 1 tan(3x 2) (7) y =cos 2 (4x +5) (8) y = cos x 1+sinx 5 (1) y =sinx cos x 6 f(x) = sin(sin x) f 0 (π) (2) y No1 1 (1) 2 f(x) =1+x + x 2 + + x n, g(x) = 1 (n +1)xn + nx n+1 (1 x) 2 x 6= 1 f 0 (x) =g(x) y = f(x)g(x) y 0 = f 0 (x)g(x)+f(x)g 0 (x) 3 (1) y = x2 x +1 x (2) y = 1 g(x) y0 = g0 (x) {g(x)} 2 (2) y = µ

More information

211 kotaro@math.titech.ac.jp 1 R *1 n n R n *2 R n = {(x 1,..., x n ) x 1,..., x n R}. R R 2 R 3 R n R n R n D D R n *3 ) (x 1,..., x n ) f(x 1,..., x n ) f D *4 n 2 n = 1 ( ) 1 f D R n f : D R 1.1. (x,

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

VQT3B86-4 DMP-HV200 DMP-HV150 μ μ l μ

VQT3B86-4 DMP-HV200 DMP-HV150 μ μ l μ -4 DMP-HV200 DMP-HV150 μ μ l μ [DMP-HV200] l [DMP-HV200] l +- l l j j j[dmp-hv200] l l l [DMP-HV200] l l l l [DMP-HV200] l [DMP-HV200] l l [DMP-HV200] l [DMP-HV200] [DMP-HV150] l l Ë l l l l l l l l l

More information

I

I I 6 4 10 1 1 1.1............... 1 1................ 1 1.3.................... 1.4............... 1.4.1.............. 1.4................. 1.4.3........... 3 1.4.4.. 3 1.5.......... 3 1.5.1..............

More information

untitled

untitled VQT3B82-1 DMP-BDT110 μ μ μ 2 VQT3B82 ÇÕÇ¹Ç Ç +- VQT3B82 3 4 VQT3B82 1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 18 19 20 ij SD 1 2 3 4 5 6 7 8 Í VQT3B82 5 BD DVD CD SD USB 6 VQT3B82 2 ALL 1 2 4 VQT3B82 7

More information

数学の基礎訓練I

数学の基礎訓練I I 9 6 13 1 1 1.1............... 1 1................ 1 1.3.................... 1.4............... 1.4.1.............. 1.4................. 3 1.4.3........... 3 1.4.4.. 3 1.5.......... 3 1.5.1..............

More information

-5 DMP-BV300 μ μ l μ l l +- l l j j j l l l l l l l l l l l l l Ë l l l l l l l l l l l l l l l l l l l l l l l BD DVD CD SD USB 2 ALL 1 2 4 l l DETACH ATTACH RELEASE DETACH ATTACH DETACH ATTACH RELEASE

More information

SAMA- SUKU-RU Contents p-adic families of Eisenstein series (modular form) Hecke Eisenstein Eisenstein p T

SAMA- SUKU-RU Contents p-adic families of Eisenstein series (modular form) Hecke Eisenstein Eisenstein p T SAMA- SUKU-RU Contents 1. 1 2. 7.1. p-adic families of Eisenstein series 3 2.1. modular form Hecke 3 2.2. Eisenstein 5 2.3. Eisenstein p 7 3. 7.2. The projection to the ordinary part 9 3.1. The ordinary

More information

2S III IV K A4 12:00-13:30 Cafe David 1 2 TA 1 appointment Cafe David K2-2S04-00 : C

2S III IV K A4 12:00-13:30 Cafe David 1 2 TA 1  appointment Cafe David K2-2S04-00 : C 2S III IV K200 : April 16, 2004 Version : 1.1 TA M2 TA 1 10 2 n 1 ɛ-δ 5 15 20 20 45 K2-2S04-00 : C 2S III IV K200 60 60 74 75 89 90 1 email 3 4 30 A4 12:00-13:30 Cafe David 1 2 TA 1 email appointment Cafe

More information

num2.dvi

num2.dvi kanenko@mbk.nifty.com http://kanenko.a.la9.jp/ 16 32...... h 0 h = ε () 0 ( ) 0 1 IEEE754 (ieee754.c Kerosoft Ltd.!) 1 2 : OS! : WindowsXP ( ) : X Window xcalc.. (,.) C double 10,??? 3 :, ( ) : BASIC,

More information

t θ, τ, α, β S(, 0 P sin(θ P θ S x cos(θ SP = θ P (cos(θ, sin(θ sin(θ P t tan(θ θ 0 cos(θ tan(θ = sin(θ cos(θ ( 0t tan(θ

t θ, τ, α, β S(, 0 P sin(θ P θ S x cos(θ SP = θ P (cos(θ, sin(θ sin(θ P t tan(θ θ 0 cos(θ tan(θ = sin(θ cos(θ ( 0t tan(θ 4 5 ( 5 3 9 4 0 5 ( 4 6 7 7 ( 0 8 3 9 ( 8 t θ, τ, α, β S(, 0 P sin(θ P θ S x cos(θ SP = θ P (cos(θ, sin(θ sin(θ P t tan(θ θ 0 cos(θ tan(θ = sin(θ cos(θ ( 0t tan(θ S θ > 0 θ < 0 ( P S(, 0 θ > 0 ( 60 θ

More information

gnuplot.dvi

gnuplot.dvi gnuplot gnuplot 1 gnuplot exit 2 10 10 2.1 2 plot x plot sin(x) plot [-20:20] sin(x) plot [-20:20][0.5:1] sin(x), x, cos(x) + - * / ** 5 ** plot 2**x y =2 x sin(x) cos(x) exp(x) e x abs(x) log(x) log10(x)

More information

DS-30

DS-30 NPD4633-00 JA ...6... 6... 6... 6... 6... 7... 7... 7... 7... 8... 8...9...10...11...11...13 Document Capture Pro Windows...13 EPSON Scan Mac OS X...14 SharePoint Windows...16 Windows...16...17 Document

More information

2.2 Sage I 11 factor Sage Sage exit quit 1 sage : exit 2 Exiting Sage ( CPU time 0m0.06s, Wall time 2m8.71 s). 2.2 Sage Python Sage 1. Sage.sage 2. sa

2.2 Sage I 11 factor Sage Sage exit quit 1 sage : exit 2 Exiting Sage ( CPU time 0m0.06s, Wall time 2m8.71 s). 2.2 Sage Python Sage 1. Sage.sage 2. sa I 2017 11 1 SageMath SageMath( Sage ) Sage Python Sage Python Sage Maxima Maxima Sage Sage Sage Linux, Mac, Windows *1 2 Sage Sage 4 1. ( sage CUI) 2. Sage ( sage.sage ) 3. Sage ( notebook() ) 4. Sage

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

2014 S hara/lectures/lectures-j.html r 1 S phone: ,

2014 S hara/lectures/lectures-j.html r 1 S phone: , 14 S1-1+13 http://www.math.kyushu-u.ac.jp/ hara/lectures/lectures-j.html r 1 S1-1+13 14.4.11. 19 phone: 9-8-4441, e-mail: hara@math.kyushu-u.ac.jp Office hours: 1 4/11 web download. I. 1. ϵ-δ 1. 3.1, 3..

More information

13 Student Software TI-Nspire CX CAS TI Web TI-Nspire CX CAS Student Software ( ) 1 Student Software 37 Student Software Nspire Nspire Nspir

13 Student Software TI-Nspire CX CAS TI Web TI-Nspire CX CAS Student Software ( ) 1 Student Software 37 Student Software Nspire Nspire Nspir 13 Student Software TI-Nspire CX CAS TI Web TI-Nspire CX CAS Student Software ( ) 1 Student Software 37 Student Software 37.1 37.1 Nspire Nspire Nspire 37.1: Student Software 13 2 13 Student Software esc

More information

VQT3A26-1 DMR-T2000R μ μ μ ! R ! l l l [HDD] [BD-RE] [BD-R] [BD-V] [RAM] [-R] [-R]DL] [-RW] [DVD-V] [CD] [SD] [USB] [RAM AVCREC ] [-R AVCREC ] [-R]DL AVCREC ] [RAM VR ][-R VR ] [-R]DL VR ] [-RW VR ]

More information

x () g(x) = f(t) dt f(x), F (x) 3x () g(x) g (x) f(x), F (x) (3) h(x) = x 3x tf(t) dt.9 = {(x, y) ; x, y, x + y } f(x, y) = xy( x y). h (x) f(x), F (x

x () g(x) = f(t) dt f(x), F (x) 3x () g(x) g (x) f(x), F (x) (3) h(x) = x 3x tf(t) dt.9 = {(x, y) ; x, y, x + y } f(x, y) = xy( x y). h (x) f(x), F (x [ ] IC. f(x) = e x () f(x) f (x) () lim f(x) lim f(x) x + x (3) lim f(x) lim f(x) x + x (4) y = f(x) ( ) ( s46). < a < () a () lim a log xdx a log xdx ( ) n (3) lim log k log n n n k=.3 z = log(x + y ),

More information

19 Systematization of Problem Solving Strategy in High School Mathematics for Improving Metacognitive Ability

19 Systematization of Problem Solving Strategy in High School Mathematics for Improving Metacognitive Ability 19 Systematization of Problem Solving Strategy in High School Mathematics for Improving Metacognitive Ability 1105402 2008 2 4 2,, i Abstract Systematization of Problem Solving Strategy in High School

More information

VQT2P76 DMR-BWT2000 DMR-BWT1000 μ μ μ ! R ! l l l [HDD] [BD-RE] [BD-R] [BD-V] [RAM] [-R] [-R]DL] [-RW] [DVD-V] [CD] [SD] [USB] [RAM AVCREC ] [-R AVCREC ] [-R]DL AVCREC ] [RAM VR ][-R VR ] [-R]DL VR

More information

EPSON ES-D200 パソコンでのスキャンガイド

EPSON ES-D200 パソコンでのスキャンガイド NPD4271-00 ...4...7 EPSON Scan... 7...11 PDF...12 / EPSON Scan...13 EPSON Scan...13 EPSON Scan...14 EPSON Scan...14 EPSON Scan...15 Epson Event Manager...16 Epson Event Manager...16 Epson Event Manager...16

More information

GNUPLOT GNUPLOT GNUPLOT 1 ( ) GNUPLO

GNUPLOT GNUPLOT GNUPLOT 1 ( ) GNUPLO GNUPLOT 2004 10 6 UNIX Microsoft-Windows GNUPLOT 3.7 GNUPLOT 1 GNUPLOT 2 2 2 3 4 4 7 5 9 6 10 7 12 8 13 9 14 10 17 1 GNUPLOT............................... 3 2 MS-Windows GNUPLOT.................... 3

More information

電気通信大学 コンピュータリテラシー 文書整形 --- LaTeX ---

電気通信大学 コンピュータリテラシー 文書整形 --- LaTeX --- 1 L A TEX B5 1. LaTeX ( ) : 1 3 2. LaTeX ( ) : 4 7 3. LaTeX (,, EPS ) : 8 10 4. LaTeX ( ) : 11 textlatex.pdf : tiny.tex, tiny.pdf : 1 small.tex, small.pdf : 2 normal.tex, normal.pdf : f1.eps : normal.tex

More information

[user@linux tmp]$ tar xzvf utvpn-src-unix-v100-7092-beta-2010.06.25.tar.gz [user@linux tmp]$ cd utvpn-unix-v100-7092-beta [user@linux utvpn-unix-v100-7092-beta]$ ls License-ja.txt configure makefiles src

More information

28 Horizontal angle correction using straight line detection in an equirectangular image

28 Horizontal angle correction using straight line detection in an equirectangular image 28 Horizontal angle correction using straight line detection in an equirectangular image 1170283 2017 3 1 2 i Abstract Horizontal angle correction using straight line detection in an equirectangular image

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 4 1 ( ) ( ) ( ) ( ) () 1 4 2

1 4 1 ( ) ( ) ( ) ( ) () 1 4 2 7 1995, 2017 7 21 1 2 2 3 3 4 4 6 (1).................................... 6 (2)..................................... 6 (3) t................. 9 5 11 (1)......................................... 11 (2)

More information

基礎数学I

基礎数学I I & II ii ii........... 22................. 25 12............... 28.................. 28.................... 31............. 32.................. 34 3 1 9.................... 1....................... 1............

More information

cpall.dvi

cpall.dvi 55 7 gnuplot gnuplot Thomas Williams Colin Kelley Unix Windows MacOS gnuplot ( ) ( ) gnuplot gnuplot 7.1 gnuplot gnuplot () PC(Windows MacOS ) gnuplot http://www.gnuplot.info gnuplot 7.2 7.2.1 gnuplot

More information

Part () () Γ Part ,

Part () () Γ Part , Contents a 6 6 6 6 6 6 6 7 7. 8.. 8.. 8.3. 8 Part. 9. 9.. 9.. 3. 3.. 3.. 3 4. 5 4.. 5 4.. 9 4.3. 3 Part. 6 5. () 6 5.. () 7 5.. 9 5.3. Γ 3 6. 3 6.. 3 6.. 3 6.3. 33 Part 3. 34 7. 34 7.. 34 7.. 34 8. 35

More information

ScanFront300/300P セットアップガイド

ScanFront300/300P セットアップガイド libtiff Copyright (c) 1988-1996 Sam Leffler Copyright (c) 1991-1996 Silicon Graphics, Inc. Permission to use, copy, modify, distribute, and sell this software and its documentation for any purpose is hereby

More information

GT-X830

GT-X830 NPD5108-00 ...5... 5... 6... 8...11 EPSON Scan...11 PDF...16 OCR...16...17...17...20 /...20...20...22...23...23...24...25...25...26...27 PDF...30...31 / EPSON Scan...34 EPSON Scan...34 EPSON Scan...36

More information

1.3 2 gnuplot> set samples gnuplot> plot sin(x) sin gnuplot> plot [0:6.28] [-1.5:1.5] sin(x) gnuplot> plot [-6.28:6.28] [-1.5:1.5] sin(x),co

1.3 2 gnuplot> set samples gnuplot> plot sin(x) sin gnuplot> plot [0:6.28] [-1.5:1.5] sin(x) gnuplot> plot [-6.28:6.28] [-1.5:1.5] sin(x),co gnuplot 8 gnuplot 1 1.1 gnuplot gnuplot 2D 3D gnuplot ( ) gnuplot UNIX Windows Machintosh Excel gnuplot C 1.2 web gnuplot $ gnuplot gnuplot gnuplot> exit 1 1.3 2 gnuplot> set samples 1024 1024 gnuplot>

More information

2 1 Octave Octave Window M m.m Octave Window 1.2 octave:1> a = 1 a = 1 octave:2> b = 1.23 b = octave:3> c = 3; ; % octave:4> x = pi x =

2 1 Octave Octave Window M m.m Octave Window 1.2 octave:1> a = 1 a = 1 octave:2> b = 1.23 b = octave:3> c = 3; ; % octave:4> x = pi x = 1 1 Octave GNU Octave Matlab John W. Eaton 1992 2.0.16 2.1.35 Octave Matlab gnuplot Matlab Octave MATLAB [1] Octave [1] 2.7 Octave Matlab Octave Octave 2.1.35 2.5 2.0.16 Octave 1.1 Octave octave Octave

More information

I A A441 : April 21, 2014 Version : Kawahira, Tomoki TA (Kondo, Hirotaka ) Google

I A A441 : April 21, 2014 Version : Kawahira, Tomoki TA (Kondo, Hirotaka ) Google I4 - : April, 4 Version :. Kwhir, Tomoki TA (Kondo, Hirotk) Google http://www.mth.ngoy-u.c.jp/~kwhir/courses/4s-biseki.html pdf 4 4 4 4 8 e 5 5 9 etc. 5 6 6 6 9 n etc. 6 6 6 3 6 3 7 7 etc 7 4 7 7 8 5 59

More information

1 1 [1] ( 2,625 [2] ( 2, ( ) /

1 1 [1] ( 2,625 [2] ( 2, ( ) / [] (,65 [] (,3 ( ) 67 84 76 7 8 6 7 65 68 7 75 73 68 7 73 7 7 59 67 68 65 75 56 6 58 /=45 /=45 6 65 63 3 4 3/=36 4/=8 66 7 68 7 7/=38 /=5 7 75 73 8 9 8/=364 9/=864 76 8 78 /=45 /=99 8 85 83 /=9 /= ( )

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

no35.dvi

no35.dvi p.16 1 sin x, cos x, tan x a x a, a>0, a 1 log a x a III 2 II 2 III III [3, p.36] [6] 2 [3, p.16] sin x sin x lim =1 ( ) [3, p.42] x 0 x ( ) sin x e [3, p.42] III [3, p.42] 3 3.1 5 8 *1 [5, pp.48 49] sin

More information

2000年度『数学展望 I』講義録

2000年度『数学展望 I』講義録 2000 I I IV I II 2000 I I IV I-IV. i ii 3.10 (http://www.math.nagoya-u.ac.jp/ kanai/) 2000 A....1 B....4 C....10 D....13 E....17 Brouwer A....21 B....26 C....33 D....39 E. Sperner...45 F....48 A....53

More information

医系の統計入門第 2 版 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. このサンプルページの内容は, 第 2 版 1 刷発行時のものです.

医系の統計入門第 2 版 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます.   このサンプルページの内容は, 第 2 版 1 刷発行時のものです. 医系の統計入門第 2 版 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. http://www.morikita.co.jp/books/mid/009192 このサンプルページの内容は, 第 2 版 1 刷発行時のものです. i 2 t 1. 2. 3 2 3. 6 4. 7 5. n 2 ν 6. 2 7. 2003 ii 2 2013 10 iii 1987

More information

DS-70000/DS-60000/DS-50000

DS-70000/DS-60000/DS-50000 NPD4647-02 JA ...5...7...8 ADF...9... 9 ADF...10...11...13...15 Document Capture Pro Windows...15 EPSON Scan Mac OS X...16 SharePoint Windows...18 Windows...18...19 Windows...19 Mac OS X...19...20...23...23

More information

μ μ DMR-BZT700 DMR-BZT600 μ TM VQT3C03-2B ! ! l l l [HDD] [BD-RE] [BD-R] [DVD-V] [BD-V] [RAM] [CD] [SD] [-R] [USB] [-RW] [RAM AVCREC ] [-R AVCREC ] [RAM VR ][-R VR ] [-RW VR ] [-R V ] [-RW V ] [DVD-V]

More information

GT-F740/GT-S640

GT-F740/GT-S640 NPD4743-00 JA ...5 EPSON Scan... 5 Document Capture Pro / Document Capture...11...14 EPSON Scan...14 PDF...18 OCR...18...19...19...21 /...21...22...23 GT-F740...24...24...25...26...26...26...27 PDF...28...30

More information

2 4 BASIC (4) WWW BASIC 1 2 ( ) ( ) 1.2 3B 5 14 ( ) ( ) 3 1 1

2 4 BASIC (4) WWW   BASIC 1 2 ( ) ( ) 1.2 3B 5 14 ( ) ( ) 3 1 1 2 4 BASIC (4 2007 5 8 WWW http://www.math.meiji.ac.jp/~mk/syori2-2007/ BASIC 2 (. (5 5 3.2 3B 5 4 ( 5 5 5 2 ( 3 ( PAINT PAINT ( MAT PLOT AREA.3 : MAT PLOT AREA PAINT ( BASIC (.3. MAT PLOT AREA REM testmatplotarea.bas

More information

GT-X980

GT-X980 NPD5061-00 JA ...6...10...10...11...13...15...20...21...21...22 /...23 PDF...27 PDF...31 /...35...38...43...46 EPSON Scan...49...49...49...50 EPSON Scan...51...51...52...52...53 2 Windows...53 Mac OS X...53...53...53...54...56...56...58...59...60...60...61...62...63

More information

PX-403A

PX-403A NPD4403-00 ...6... 6...10 Mac OS X...11 Mac OS X v10.5.x v10.6.x...11 Mac OS X v10.4.x...15...18...19...19...21...22!ex...22 /...23 P.I.F. PRINT Image Framer...23...24...27...27...28...28...28...32 Web...32...32...35...35...35...37...37...37...39...39...40...43...46

More information

Z: Q: R: C: sin 6 5 ζ a, b

Z: Q: R: C: sin 6 5 ζ a, b Z: Q: R: C: 3 3 7 4 sin 6 5 ζ 9 6 6............................... 6............................... 6.3......................... 4 7 6 8 8 9 3 33 a, b a bc c b a a b 5 3 5 3 5 5 3 a a a a p > p p p, 3,

More information

untitled

untitled TZ-BDT910M TZ-BDT910F TZ-BDT910P μ μ μ μ TM VQT3F51-1 l l l [HDD] [BD-RE] [BD-R] [DVD-V] [BD-V] [RAM] [CD] [SD] [-R] [USB] [-RW] [RAM AVCREC ] [-R AVCREC ] [RAM VR ][-R VR ] [-RW VR ] [-R V ] [-RW

More information

18 ( ) I II III A B C(100 ) 1, 2, 3, 5 I II A B (100 ) 1, 2, 3 I II A B (80 ) 6 8 I II III A B C(80 ) 1 n (1 + x) n (1) n C 1 + n C

18 ( ) I II III A B C(100 ) 1, 2, 3, 5 I II A B (100 ) 1, 2, 3 I II A B (80 ) 6 8 I II III A B C(80 ) 1 n (1 + x) n (1) n C 1 + n C 8 ( ) 8 5 4 I II III A B C( ),,, 5 I II A B ( ),, I II A B (8 ) 6 8 I II III A B C(8 ) n ( + x) n () n C + n C + + n C n = 7 n () 7 9 C : y = x x A(, 6) () A C () C P AP Q () () () 4 A(,, ) B(,, ) C(,,

More information

I. (CREMONA ) : Cremona [C],., modular form f E f. 1., modular X H 1 (X, Q). modular symbol M-symbol, ( ) modular symbol., notation. H = { z = x

I. (CREMONA ) : Cremona [C],., modular form f E f. 1., modular X H 1 (X, Q). modular symbol M-symbol, ( ) modular symbol., notation. H = { z = x I. (CREMONA ) : Cremona [C],., modular form f E f. 1., modular X H 1 (X, Q). modular symbol M-symbol, ( ). 1.1. modular symbol., notation. H = z = x iy C y > 0, cusp H = H Q., Γ = PSL 2 (Z), G Γ [Γ : G]

More information

( )

( ) 18 10 01 ( ) 1 2018 4 1.1 2018............................... 4 1.2 2018......................... 5 2 2017 7 2.1 2017............................... 7 2.2 2017......................... 8 3 2016 9 3.1 2016...............................

More information

2

2 p1 i 2 = 1 i 2 x, y x + iy 2 (x + iy) + (γ + iδ) = (x + γ) + i(y + δ) (x + iy)(γ + iδ) = (xγ yδ) + i(xδ + yγ) i 2 = 1 γ + iδ 0 x + iy γ + iδ xγ + yδ xδ = γ 2 + iyγ + δ2 γ 2 + δ 2 p7 = x 2 +y 2 z z p13

More information

入試の軌跡

入試の軌跡 4 y O x 4 Typed by L A TEX ε ) ) ) 6 4 ) 4 75 ) http://kumamoto.s.xrea.com/plan/.. PDF) Ctrl +L) Ctrl +) Ctrl + Ctrl + ) ) Alt + ) Alt + ) ESC. http://kumamoto.s.xrea.com/nyusi/kumadai kiseki ri i.pdf

More information

PX-673F

PX-673F NPD4385-00 ...6... 6...10 Mac OS X...11 Mac OS X v10.5.x v10.6.x...11 Mac OS X v10.4.x...15...18...19...19...21...22...23!ex...23 /...24 P.I.F. PRINT Image Framer...24...25...28...29...29...30...30...33

More information

VQT3G14-2 DMR-BR585 μ μ μ VQT3G14.book 3 ページ 2010年10月1日 金曜日 午前10時29分 ご案内 3 本書では 本機の操作方法を説明しています 別冊の 取扱説明書 準備編 や かんたん操作ガイド もあわせてご覧ください 連携機器情報などの詳しい情報は 当社ホームページ 本機を使用していただくための サポート情報を掲載しています 接続機器に合わせた 接続方法

More information

: , 2.0, 3.0, 2.0, (%) ( 2.

: , 2.0, 3.0, 2.0, (%) ( 2. 2017 1 2 1.1...................................... 2 1.2......................................... 4 1.3........................................... 10 1.4................................. 14 1.5..........................................

More information

S I. dy fx x fx y fx + C 3 C dy fx 4 x, y dy v C xt y C v e kt k > xt yt gt [ v dt dt v e kt xt v e kt + C k x v + C C k xt v k 3 r r + dr e kt S dt d

S I. dy fx x fx y fx + C 3 C dy fx 4 x, y dy v C xt y C v e kt k > xt yt gt [ v dt dt v e kt xt v e kt + C k x v + C C k xt v k 3 r r + dr e kt S dt d S I.. http://ayapin.film.s.dendai.ac.jp/~matuda /TeX/lecture.html PDF PS.................................... 3.3.................... 9.4................5.............. 3 5. Laplace................. 5....

More information

210 資料 TI 89 (1) TI 89 2nd ON HOME ( ) ( ) HOME =! ENTER ( ) = (10) ENTER ( ) [ ] { } ( )! 2 =! ( ) ( ) 2 3x ( 2y + yz) ( ) 3x ( ( ) 2y + y z)

210 資料 TI 89 (1) TI 89 2nd ON HOME ( ) ( ) HOME =! ENTER ( ) = (10) ENTER ( ) [ ] { } ( )! 2 =! ( ) ( ) 2 3x ( 2y + yz) ( ) 3x ( ( ) 2y + y z) 210 資料 TI 89 (1) TI 89 2nd ON HOME () () HOME =! ENTER () = 3 10 3 (10) ENTER ( ) [ ] { } ( )! 2 =! ( ) () 2 3x ( 2y + yz) ( ) 3x ( ( ) 2y + y z) ENTER () 2nd 9 2nd 9) ENTER ( ) 2nd 7) ENTER 7 7 ) ENTER

More information

S I. dy fx x fx y fx + C 3 C vt dy fx 4 x, y dy yt gt + Ct + C dt v e kt xt v e kt + C k x v k + C C xt v k 3 r r + dr e kt S Sr πr dt d v } dt k e kt

S I. dy fx x fx y fx + C 3 C vt dy fx 4 x, y dy yt gt + Ct + C dt v e kt xt v e kt + C k x v k + C C xt v k 3 r r + dr e kt S Sr πr dt d v } dt k e kt S I. x yx y y, y,. F x, y, y, y,, y n http://ayapin.film.s.dendai.ac.jp/~matuda n /TeX/lecture.html PDF PS yx.................................... 3.3.................... 9.4................5..............

More information

ES-D400/ES-D200

ES-D400/ES-D200 NPD4564-00 ...4...7 EPSON Scan... 7...11 PDF...12 / EPSON Scan...14 EPSON Scan...14 EPSON Scan...15 EPSON Scan...15 EPSON Scan...16 Epson Event Manager...17 Epson Event Manager...17 Epson Event Manager...17

More information

EPSON PX-503A ユーザーズガイド

EPSON PX-503A ユーザーズガイド NPD4296-00 ...6... 6...10 Mac OS X...11 Mac OS X v10.5.x v10.6.x...11 Mac OS X v10.4.x...15...18...19...19...21...22...23!ex...23 /...24 P.I.F. PRINT Image Framer...24...25...28...28...29...29...30...33

More information

December 28, 2018

December 28, 2018 e-mail : kigami@i.kyoto-u.ac.jp December 28, 28 Contents 2............................. 3.2......................... 7.3..................... 9.4................ 4.5............. 2.6.... 22 2 36 2..........................

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 8 BASIC (4) WWW Taylor BASIC 1 2 ( ) 2 ( ) ( ) ( ) (A.2.1 ) 1

2 8 BASIC (4) WWW   Taylor BASIC 1 2 ( ) 2 ( ) ( ) ( ) (A.2.1 ) 1 2 8 BASIC (4) 203 6 5 WWW http://www.math.meiji.ac.jp/~mk/syori2-203/ Taylor BASIC 2 ( ) 2 ( ) ( ) ( ) 2 (A.2. ) 6B 2 2. f a f(x) = f (n) (a) n! (x a) n = f(a)+f (a)(x a)+ f (a) 2 (x a) 2 + + f (n) (a)

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

cikm_field_weights.dvi

cikm_field_weights.dvi 13Simple BM25 Extension to Multiple Weighted Fields Stephen Robertson, Hugo Zaragoza and Michael Taylor Microsoft Research 001 71 7 チ081 7081 7001 71 7 チ001 71 71 7 チ1 7 チ1 70508041 7041 706071 71 71 71

More information

function2.pdf

function2.pdf 2... 1 2009, http://c-faculty.chuo-u.ac.jp/ nishioka/ 2 11 38 : 5) i) [], : 84 85 86 87 88 89 1000 ) 13 22 33 56 92 147 140 120 100 80 60 40 20 1 2 3 4 5 7.1 7 7.1 1. *1 e = 2.7182 ) fx) e x, x R : 7.1)

More information

0. I II I II (1) linear type: GL( ), Sp( ), O( ), (2) loop type: loop current Kac-Moody affine, hyperbolic (3) diffeo t

0. I II I II (1) linear type: GL( ), Sp( ), O( ), (2) loop type: loop current Kac-Moody affine, hyperbolic (3) diffeo t e-mail: koyama@math.keio.ac.jp 0. I II I II (1) linear type: GL( ), Sp( ), O( ), (2) loop type: loop current Kac-Moody affine, hyperbolic (3) diffeo type: diffeo universal Teichmuller modular I. I-. Weyl

More information

EPSON EP-803A/EP-803AW ユーザーズガイド

EPSON EP-803A/EP-803AW ユーザーズガイド NPD4293-00 ...6... 6...10 Mac OS X...11 Mac OS X v10.5.x v10.6.x...11 Mac OS X v10.4.x...15...18...19...19...22...23...24!ex...24 /...25 P.I.F. PRINT Image Framer...25...26...30...30...31...31...31...35

More information

,2,4

,2,4 2005 12 2006 1,2,4 iii 1 Hilbert 14 1 1.............................................. 1 2............................................... 2 3............................................... 3 4.............................................

More information

EPSON EP-703A ユーザーズガイド

EPSON EP-703A ユーザーズガイド NPD4295-00 ...6... 6...10 Mac OS X...11 Mac OS X v10.5.x v10.6.x...11 Mac OS X v10.4.x...15...18...19...19...22...23...24!ex...24 /...25 P.I.F. PRINT Image Framer...25...26...29...30...30...31...31...34

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

PX-504A

PX-504A NPD4537-00 ...6... 6... 9 Mac OS X...10 Mac OS X v10.5.x v10.6.x...10 Mac OS X v10.4.11...13...15...16...16...18...19...20!ex...20 /...21 P.I.F. PRINT Image Framer...21...22...26...26...27...27...27...31

More information

<4D F736F F D B B83578B6594BB2D834A836F815B82D082C88C60202E646F63>

<4D F736F F D B B83578B6594BB2D834A836F815B82D082C88C60202E646F63> 電気電子数学入門 サンプルページ この本の定価 判型などは, 以下の URL からご覧いただけます. http://www.morikita.co.jp/books/mid/073471 このサンプルページの内容は, 初版 1 刷発行当時のものです. i 14 (tool) [ ] IT ( ) PC (EXCEL) HP() 1 1 4 15 3 010 9 ii 1... 1 1.1 1 1.

More information

第5章 偏微分方程式の境界値問題

第5章 偏微分方程式の境界値問題 October 5, 2018 1 / 113 4 ( ) 2 / 113 Poisson 5.1 Poisson ( A.7.1) Poisson Poisson 1 (A.6 ) Γ p p N u D Γ D b 5.1.1: = Γ D Γ N 3 / 113 Poisson 5.1.1 d {2, 3} Lipschitz (A.5 ) Γ D Γ N = \ Γ D Γ p Γ N Γ

More information

20 4 20 i 1 1 1.1............................ 1 1.2............................ 4 2 11 2.1................... 11 2.2......................... 11 2.3....................... 19 3 25 3.1.............................

More information

熊本県数学問題正解

熊本県数学問題正解 00 y O x Typed by L A TEX ε ( ) (00 ) 5 4 4 ( ) http://www.ocn.ne.jp/ oboetene/plan/. ( ) (009 ) ( ).. http://www.ocn.ne.jp/ oboetene/plan/eng.html 8 i i..................................... ( )0... (

More information

IA 2013 : :10722 : 2 : :2 :761 :1 (23-27) : : ( / ) (1 /, ) / e.g. (Taylar ) e x = 1 + x + x xn n! +... sin x = x x3 6 + x5 x2n+1 + (

IA 2013 : :10722 : 2 : :2 :761 :1 (23-27) : : ( / ) (1 /, ) / e.g. (Taylar ) e x = 1 + x + x xn n! +... sin x = x x3 6 + x5 x2n+1 + ( IA 2013 : :10722 : 2 : :2 :761 :1 23-27) : : 1 1.1 / ) 1 /, ) / e.g. Taylar ) e x = 1 + x + x2 2 +... + xn n! +... sin x = x x3 6 + x5 x2n+1 + 1)n 5! 2n + 1)! 2 2.1 = 1 e.g. 0 = 0.00..., π = 3.14..., 1

More information

IA hara@math.kyushu-u.ac.jp Last updated: January,......................................................................................................................................................................................

More information

PX-434A/PX-404A

PX-434A/PX-404A NPD4534-00 ...6... 6...10 Mac OS X...11 Mac OS X v10.5.x v10.6.x...11 Mac OS X v10.4.11...15...18...19...19...21...22!ex...22 /...23 P.I.F. PRINT Image Framer...23...24...26...27...27...28...28...31 Web...31...31...35...35...35...37...37...37...39...39...40...43...48

More information

B [ 0.1 ] x > 0 x 6= 1 f(x) µ 1 1 xn 1 + sin sin x 1 x 1 f(x) := lim. n x n (1) lim inf f(x) (2) lim sup f(x) x 1 0 x 1 0 (

B [ 0.1 ] x > 0 x 6= 1 f(x) µ 1 1 xn 1 + sin sin x 1 x 1 f(x) := lim. n x n (1) lim inf f(x) (2) lim sup f(x) x 1 0 x 1 0 ( . 28 4 14 [.1 ] x > x 6= 1 f(x) µ 1 1 xn 1 + sin + 2 + sin x 1 x 1 f(x) := lim. 1 + x n (1) lim inf f(x) (2) lim sup f(x) x 1 x 1 (3) lim inf x 1+ f(x) (4) lim sup f(x) x 1+ [.2 ] [, 1] Ω æ x (1) (2) nx(1

More information

70 : 20 : A B (20 ) (30 ) 50 1

70 : 20 : A B (20 ) (30 ) 50 1 70 : 0 : A B (0 ) (30 ) 50 1 1 4 1.1................................................ 5 1. A............................................... 6 1.3 B............................................... 7 8.1 A...............................................

More information

ES-D400/ES-D350

ES-D400/ES-D350 NPD4650-00 ...4 EPSON Scan... 4 Document Capture Pro Windows... 7 EPSON Scan...10 EPSON Scan...10...14 PDF...15 / EPSON Scan...17 EPSON Scan...17 EPSON Scan...18 EPSON Scan...18 Document Capture Pro Windows...19

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

1 (1) ( i ) 60 (ii) 75 (iii) 315 (2) π ( i ) (ii) π (iii) 7 12 π ( (3) r, AOB = θ 0 < θ < π ) OAB A 2 OB P ( AB ) < ( AP ) (4) 0 < θ < π 2 sin θ

1 (1) ( i ) 60 (ii) 75 (iii) 315 (2) π ( i ) (ii) π (iii) 7 12 π ( (3) r, AOB = θ 0 < θ < π ) OAB A 2 OB P ( AB ) < ( AP ) (4) 0 < θ < π 2 sin θ 1 (1) ( i ) 60 (ii) 75 (iii) 15 () ( i ) (ii) 4 (iii) 7 1 ( () r, AOB = θ 0 < θ < ) OAB A OB P ( AB ) < ( AP ) (4) 0 < θ < sin θ < θ < tan θ 0 x, 0 y (1) sin x = sin y (x, y) () cos x cos y (x, y) 1 c

More information

i 18 2H 2 + O 2 2H 2 + ( ) 3K

i 18 2H 2 + O 2 2H 2 + ( ) 3K i 18 2H 2 + O 2 2H 2 + ( ) 3K ii 1 1 1.1.................................. 1 1.2........................................ 3 1.3......................................... 3 1.4....................................

More information

1. 2 P 2 (x, y) 2 x y (0, 0) R 2 = {(x, y) x, y R} x, y R P = (x, y) O = (0, 0) OP ( ) OP x x, y y ( ) x v = y ( ) x 2 1 v = P = (x, y) y ( x y ) 2 (x

1. 2 P 2 (x, y) 2 x y (0, 0) R 2 = {(x, y) x, y R} x, y R P = (x, y) O = (0, 0) OP ( ) OP x x, y y ( ) x v = y ( ) x 2 1 v = P = (x, y) y ( x y ) 2 (x . P (, (0, 0 R {(,, R}, R P (, O (0, 0 OP OP, v v P (, ( (, (, { R, R} v (, (, (,, z 3 w z R 3,, z R z n R n.,..., n R n n w, t w ( z z Ke Words:. A P 3 0 B P 0 a. A P b B P 3. A π/90 B a + b c π/ 3. +

More information

1 1 sin cos P (primary) S (secondly) 2 P S A sin(ω2πt + α) A ω 1 ω α V T m T m 1 100Hz m 2 36km 500Hz. 36km 1

1 1 sin cos P (primary) S (secondly) 2 P S A sin(ω2πt + α) A ω 1 ω α V T m T m 1 100Hz m 2 36km 500Hz. 36km 1 sin cos P (primary) S (secondly) 2 P S A sin(ω2πt + α) A ω ω α 3 3 2 2V 3 33+.6T m T 5 34m Hz. 34 3.4m 2 36km 5Hz. 36km m 34 m 5 34 + m 5 33 5 =.66m 34m 34 x =.66 55Hz, 35 5 =.7 485.7Hz 2 V 5Hz.5V.5V V

More information