1 kawaguchi p.1/81

Size: px
Start display at page:

Download "1 kawaguchi p.1/81"

Transcription

1 1 kawaguchi p.1/81

2 AUC 4.4 p.2/81

3 X Z X = α + βz + e α : Z = 0 X ( ) β : Z X ( ) e : 0 σ 2 p.3/81

4 2.1 Z X Z : X : Beckmann p.4/81

5 R ( ) z<-c(1, 2, 4, 6, 7, 8, 10, 15) x<-c(0.045, 0.114, 0.215, 0.346, 0.410, 0.520, 0.670, 0.942) z, x plot(z,x) p.5/81

6 x z p.6/81

7 n (Z 1,X 1 ),...,(Z n,x n ) S 2 = n (X i α βz i ) 2 i=1 a b b = (Zi Z)(X i X) (Zi Z) 2 a = X b Z p.7/81

8 R ( ) lm(x z) Call: lm(formula = x z) Coefficients: (Intercept) z p.8/81

9 SAS ( ) data beckmann; input z datalines; run; proc reg data=beckmann; model x=z ; run; p.9/81

10 SAS ( ) SAS p.10/81

11 X = α + β(z Z) + e α β a = X, b = (Zi Z)(X i X) (Zi Z) 2 Z X a b p.11/81

12 s ZX Z X s ZX = (Zi Z)(X i X) n 1 b = s ZX s X Z X r ( 1 r 1) r = s ZX s Z s X b = r s X s Z s Z = 1 n 1 (Zi Z) 2 s X = 1 n 1 (Xi X) 2 p.12/81

13 R 2 = S2 1 S 2 2 S 2 1 S 2 1 = (X i X) 2, S 2 2 = [X i X b(z i Z)] 2 R 2 = r 2 p.13/81

14 b β U,T R Z X = U +f, Z = T +e, e f R Z = σ2 T σ 2 T + σ2 e, R X = σ2 U σ 2 U + σ2 f β U,T U V Z Z p.14/81

15 e σ 2 s 2 = = (Xi a bz i ) 2 n 2 (Xi X a b(z i Z)) 2 n 2 (E[s 2 ] = σ 2 ) n 2 p.15/81

16 (1) β 100(1 α)% b t n 2,α/2 se(b) β b + t n 2,α/2 se(b) se(b) = s (Zi Z) 2 s t ν,p ν t p% p.16/81

17 (2) H 0 : β = 0 ( α%) t = b se(b) ( ) t > t n 2,α/2 = H 0 reject (H 0 reject 0 ) p.17/81

18 t t = b se(b) = r n 2 1 r 2 H 0 : β = 0 H 0 : ρ = 0 ρ p.18/81

19 (1) α 100(1 α)% a t n 2,α/2 se(a ) α a + t n 2,α/2 se(a ) se(a ) = s 1 n + Z2 (Zi Z) 2 p.19/81

20 (2) H 0 : α = 0 ( α%) t = a se(a ) t > t n 2,α/2 = H 0 reject p.20/81

21 R ( ) coefficients(summary(lm(x z))) Estimate Std.Error t value Pr(> t ) (Intercept) z e p.21/81

22 R ( ) confint(lm(x z)) 2.5 % 97.5 % (Intercept) z p.22/81

23 SAS ( ) (CLB) proc reg data=beckmann; model x=z / CLB; run; p.23/81

24 (1) X = βz + e β ˆβ = Zi X i Z 2 i p.24/81

25 (2) β 100(1 α)% ˆβ t n 2,α/2 se(ˆβ) β ˆβ + t n 2,α/2 se(ˆβ) se(β) = v Z 2 i v = 1 n 1 (Xi ˆβZ i ) 2 p.25/81

26 R ( ) summary(lm(x z-1)) confint(lm(x z-1)) Estimate Std.Error t value Pr(> t ) z < β p.26/81

27 SAS ( ) (NOINT) proc reg data=beckmann; model x=z /NOINT CLB; run; p.27/81

28 Z = Z 0 α + βz 0 100(1 α)% a + bz 0 ± t n 2,α/2 s 1 n + (Z 0 Z) 2 (Zi Z) 2 Z 0 = 0 p.28/81

29 ( 1) Z = Z i (i = 1, 2,... ) = (Bonferroni ) P {a + bz (α + βz)} ( ) 2 M s 2 1 (Z Z) 2 α, Z = 1 α n + (Zi Z) 2 M α p.29/81

30 ( 2) P max Z {a + bz (α + βz)} ( ) 2 s 2 1 n + (Z Z) 2 (Zi Z) 2 M α = 1 α M α = ( X E[ X]) 2 σ 2 /n + (b β)2 σ 2 / (Z i Z) 2 s 2 /σ 2 2F 2,n 2 p.30/81

31 α + βz 100(1 α)% L(Z ) < α + βz < U(Z ) Z Z L(Z ) = X + b(z Z) A(Z ) U(Z ) = X + b(z Z) + A(Z ) ( 1 A(Z ) = 2F 2,n 2,α s 2 n + (Z Z) ) 2 (Zi Z) 2 p.31/81

32 R ( 2.8) 1 n<-length(z) new.z<- seq(2, 12, by=0.02) ones<-rep(1, length(new.z)) pre.z<-rbind(ones, new.z) a<-lm(x z)$coefficients plot(new.z, a%*%pre.z, ylim=c(0,1), type="l", lwd=2, xlab="z", ylab="x") p.32/81

33 R ( 2.8) 2 sz<-sum((z-mean(z))ˆ2) s2<-sum((lm(x z)$residuals)ˆ2)/(n-2) s1<-1/n+(new.z-mean(z))ˆ2/sz U<-a%*%pre.z+sqrt(2*qf(0.95,2,6)*s2*s1) L<-a%*%pre.z-sqrt(2*qf(0.95,2,6)*s2*s1) points(new.z, U, type="l") points(new.z, L, type="l") points(z, x) p.33/81

34 2.8 x z p.34/81

35 R ( ) p.u<-a%*%pre.z+sqrt(qt(0.95,2,6)*s2*s1) p.l<-a%*%pre.z-sqrt(qt(0.95,2,6)*s2*s1) points(new.z, p.u, type="l",lty=3) points(new.z, p.l, type="l",lty=3) p.35/81

36 x z p.36/81

37 ( ) ( 2.1 ) X( ) Z( ) Ẑ = Z + X X b Z = Fieller p.37/81

38 Fieller U N(µ,sa 1 ), V N(ν,sa 2 ), s : g = t2 m,α/2 s2 a 2 2 V 2 g < 1 (V 0 ) µ/ν 100(1 α)% ( 1 U 1 g V ± t ) m,α/2s (1 g)a 2 1 V + U2 a 2 2 V 2 p.38/81

39 Fieller θ = µ/ν E[U θv ] = 0, ˆV [U θv ] = s 2 (a θ 2 a 2 2) θ 100(1 α)% { (U θv ) 2 } θ : s 2 (a θ2 a 2 2 ) t2 m,α/2 t m,α/2 s 2 a 2 2 /V 2 < 1 p.39/81

40 Z (Fieller ) U = X X V = b n+1 s se(u) = s n se(v ) = (Zi Z) 2 = a 2 1 = (n + 1)/n a 2 2 = 1/ (Z i Z) 2 g = t2 m,α/2 s2 a 2 2 V 2 = t2 n 2,α/2 s2 b 2 (Z i Z) 2 p.40/81

41 Z (Fieller ) Fieller = (Z Z) 100(1 α)% E[U] E[V ] = β(z Z) β X X b(1 g) ±t n 2,α/2s b(1 g) (1 g)(n + 1) n + (X X) 2 b 2 (Z i Z) 2 Z Z 100(1 α)% p.41/81

42 R (Z ) new.x< hat.z<-mean(z)+(new.x-mean(x))/a[2] g1<-s2*(qt(0.975, (length(z)-2)))ˆ2 g2<-a[2]ˆ2*sum((z-mean(z))ˆ2) g<-g1/g2 m1<-mean(z)+(new.x-mean(x))/(a[2]*(1-g)) m2<-qt(0.975, (n-2))*sqrt(s2)/(a[2]*(1-g)) m31<-((1-g)*(n+1))/(n) m32<-(new.x-mean(x))ˆ2/(a[2]ˆ2*sz) m1+m2*sqrt(m31+m32) m1-m2*sqrt(m31+m32) p.42/81

43 Z ( ) Z > hat.z Z 95% > m1+m2*sqrt(m31+m32) > m1-m2*sqrt(m31+m32) Z p.43/81

44 AUC AUC(Area Under the bood - level Curve) concentrations concentrations concentrations time time time Subject 1 Subject 2 Subject 3 p.44/81

45 SAS NLMIXED Example (Pinheiro and Bates, 1995) time( ) conc( ) dose( ) AUC R PK AUC p.45/81

46 R (AUC ) data<-read.table("auc_data.txt", header=true) library(pk) auc<-matrix(0, 12, 3) for(i in 1:12) {auc[i,]<- AUC(conc=data$CONC[data$SUBJECT==i], time=data$time[data$subject==i])$auc} colnames(auc) <- c("obs","inter","inf") auc<-data.frame(auc) p.46/81

47 log(auc) = α + β log( ) + ε AUC = e α ( ) β e ε { β 1 = AUC β = 1 = AUC p.47/81

48 H 0 : β = 1 log(auc) log( ) log(auc) log( ) = α + β log( ) + ε β H 0 : β = 0 p.48/81

49 R ( ) dose<-numeric(0) for(i in 1:12) {dose[i]<-data$dose[data$subject==i]} ones<-rep(1, length(dose)) predictor<-rbind(ones, log(dose)) plot(log(dose), log(auc$inf), xlab="log(dose)",ylab="log(auc)",ylim=c(4.4, 5.4)) points(log(dose), lm(log(auc$inf) log(dose))$coe%*%predictor,type="l") p.49/81

50 log(auc) log(dose) log(auc) = log( ) p.50/81

51 R (H 0 : β = 1 ) coefficients(summary( lm((log(auc$inf)-log(dose)) log(dose)))) Estimate Std. Error t value Pr(> t ) (Intercept) <0.001 log(dose) p.51/81

52 R (β ) confint(lm((log(auc$inf)) log(dose))) 2.5 % 97.5 % (Intercept) log(dose) p.52/81

53 R ( ) plot(lm(log(auc$inf) log(dose))) Q-Q Cook p.53/81

54 Scale-Location plot Standardized residuals Fitted values 1 Cook s distance plot Obs. number p.54/81 Cook s distance

55 ( ) log(auc) log(dose) log(auc) = log( ) p.55/81

56 H 0 : β = 1 ( ) coefficients(summary( lm((log(auc$inf)[-1]-log(dose)[-1]) log(dose)[-1]))) Estimate Std. Error t value Pr(> t ) (Intercept) <0.001 log(dose)[-1] p.56/81

57 β ( ) confint( lm((log(auc$inf)[-1]) log(dose)[-1])) 2.5 % 97.5 % (Intercept) log(dose)[-1] p.57/81

58 log(auc) = log( ) H 0 : β = β 1.52 AUC (Subject 1 ) log(auc) = log( ) H 0 : β = β 1.44 AUC p.58/81

59 (Subject1 ) Scale-Location plot Cook s distance plot Standardized residuals Cook s distance Fitted values Obs. number p.59/81

60 X: Z: D Z i = log 2 ( /3.5) (Z i ) n i Xi s i 1 3.5(0) (1) (2) s i : X p.60/81

61 Z 2 0 Z 0 p.61/81

62 X i : Z i X (i = 1, 2,...,g) H 0 : 2 F = ni ( X i X i) 2 (g 3)s 2 F > F g 3,ν,α/3 = H 0 reject p.62/81

63 X Z X = α + βz + γz 2 + ε ( ) s s 2 = (ni 1)s 2 i (ni 1) p.63/81

64 a b c a ni Xi b = M 1 ni Xi Z i c ni Xi Zi 2 ni ni Z i ni Zi 2 M = ni Z i ni Zi 2 ni Zi 3 ni Zi 2 ni Zi 3 ni Zi 4 p.64/81

65 R ( ) z<-c(0, 1, 2) n<-c(10, 8, 13) x<-c(1.80, 3.31, 3.42) M<-c(sum(n), sum(n*z), sum(n*zˆ2), sum(n*z), sum(n*zˆ2), sum(n*zˆ3), sum(n*zˆ2), sum(n*zˆ3), sum(n*zˆ4)) M<-matrix(M, ncol=3) M2<-c(sum(n*x), sum(n*x*z), sum(n*x*zˆ2)) a<-solve(m)%*%m2 p.65/81

66 R ( : ) > a [,1] [1,] 1.80 [2,] 2.21 [3,] a = 1.80 b = 2.21 c = 0.70 p.66/81

67 2 H 0 : Z 2 γ = 0 (α/2%) L c = c se(c) se(c) = s m (3,3) m (3,3) M L c > t n 3,α/4 = H 0 reject p.67/81

68 R (2 ) s2<-((n-1)%*%sˆ2)/sum(n-1) se.c<-sqrt(s2*solve(m)[3,3]) L.c<-a[3]/se.c p.c<-1-pt(abs(l.c), 28, )# > p.c H 0 : γ = % p.68/81

69 (1) X Z : Z a X Z = a + bz + cz 2 = Z b c Z = (1,Z,Z 2 ) p.69/81

70 (2) 2 Working-Hotelling ( 100(1 α)%) X Z ± 3F 3,n. g,α se(x z) n. = n i se(x Z) = s Z M 1 Z p.70/81

71 R ( ) new.z<-seq(0, 3, 0.2) ones<-rep(1, length(new.z)) new.z<-cbind(ones, new.z, new.zˆ2) se.x<-sqrt(s2*diag(new.z%*%solve(m)%*%t(new.z))) plot(new.z, new.z%*%a, ylim=c(0,6), type="l", xlab="z", ylab="x") U<-new.Z%*%a+sqrt(3*qf(0.95, 3, sum(n)-3))*se.x L<-new.Z%*%a-sqrt(3*qf(0.95, 3, sum(n)-3))*se.x points(new.z, U, type="l") points(new.z, L, type="l") points(z, x) p.71/81

72 x z p.72/81

73 X = α + βz + ε ˆβ = ni (Z i Z)(X i X) ni (Z i Z) 2 ˆα = ni Xi ˆβ n i Z i ni p.73/81

74 beta<-((sum(n)*sum(n*x*z)-(sum(n*x))*(sum(n*z))) /(sum(n)*sum(n*zˆ2)-sum(n*z)ˆ2)) alpha<-((sum(n*x)-beta*sum(n*z))/(sum(n))) > beta [1] > alpha [1] ˆβ = 0.786, ˆα = p.74/81

75 H 0 : β = 0 ( α/2%) Lˆβ = ˆβ se(ˆβ) se(ˆβ) = s ni ni (Z i Z) 2 Lˆβ > t n 3,α/4 = H 0 reject p.75/81

76 R ( ) se.beta<-(sqrt((s2*sum(n))/ (sum(n)*sum(n*zˆ2)-sum(n*z)ˆ2))) L.beta<-beta/se.beta p.beta<-1-pt(l.beta, 28, ) p.76/81

77 : > L.beta > p.beta H 0 : β = % p.77/81

78 R ( ) a1<-coefficients(lm(x z, weight=n)) ones<-rep(1, length(new.z)) new.z1<-cbind(ones, new.z) points(new.z, new.z1%*%a1, type="l") p.78/81

79 x z p.79/81

80 4.6 Z 2 0 Z 0 Z D p.80/81

81 J.L. (KR ) (2004). RjpWiki Pinheiro, J.C. and Bates, D.M. (1995), "Approximations to the Log-likelihood Function in the Nonlinear Mixed-effects Model," Journal of Computational and Graphical Statistics, 4, p.81/81

(lm) lm AIC 2 / 1

(lm) lm AIC 2 / 1 W707 s-taiji@is.titech.ac.jp 1 / 1 (lm) lm AIC 2 / 1 : y = β 1 x 1 + β 2 x 2 + + β d x d + β d+1 + ϵ (ϵ N(0, σ 2 )) y R: x R d : β i (i = 1,..., d):, β d+1 : ( ) (d = 1) y = β 1 x 1 + β 2 + ϵ (d > 1) y

More information

DAA09

DAA09 > summary(dat.lm1) Call: lm(formula = sales ~ price, data = dat) Residuals: Min 1Q Median 3Q Max -55.719-19.270 4.212 16.143 73.454 Coefficients: Estimate Std. Error t value Pr(> t ) (Intercept) 237.1326

More information

k2 ( :35 ) ( k2) (GLM) web web 1 :

k2 ( :35 ) ( k2) (GLM) web   web   1 : 2012 11 01 k2 (2012-10-26 16:35 ) 1 6 2 (2012 11 01 k2) (GLM) kubo@ees.hokudai.ac.jp web http://goo.gl/wijx2 web http://goo.gl/ufq2 1 : 2 2 4 3 7 4 9 5 : 11 5.1................... 13 6 14 6.1......................

More information

H22 BioS t (i) treat1 treat2 data d1; input patno treat1 treat2; cards; ; run; 1 (i) treat = 1 treat =

H22 BioS t (i) treat1 treat2 data d1; input patno treat1 treat2; cards; ; run; 1 (i) treat = 1 treat = H BioS t (i) treat treat data d; input patno treat treat; cards; 3 8 7 4 8 8 5 5 6 3 ; run; (i) treat treat data d; input group patno period treat y; label group patno period ; cards; 3 8 3 7 4 8 4 8 5

More information

1 15 R Part : website:

1 15 R Part : website: 1 15 R Part 4 2017 7 24 4 : website: email: http://www3.u-toyama.ac.jp/kkarato/ kkarato@eco.u-toyama.ac.jp 1 2 2 3 2.1............................... 3 2.2 2................................. 4 2.3................................

More information

講義のーと : データ解析のための統計モデリング. 第3回

講義のーと :  データ解析のための統計モデリング. 第3回 Title 講義のーと : データ解析のための統計モデリング Author(s) 久保, 拓弥 Issue Date 2008 Doc URL http://hdl.handle.net/2115/49477 Type learningobject Note この講義資料は, 著者のホームページ http://hosho.ees.hokudai.ac.jp/~kub ードできます Note(URL)http://hosho.ees.hokudai.ac.jp/~kubo/ce/EesLecture20

More information

最小2乗法

最小2乗法 2 2012 4 ( ) 2 2012 4 1 / 42 X Y Y = f (X ; Z) linear regression model X Y slope X 1 Y (X, Y ) 1 (X, Y ) ( ) 2 2012 4 2 / 42 1 β = β = β (4.2) = β 0 + β (4.3) ( ) 2 2012 4 3 / 42 = β 0 + β + (4.4) ( )

More information

1 Tokyo Daily Rainfall (mm) Days (mm)

1 Tokyo Daily Rainfall (mm) Days (mm) ( ) r-taka@maritime.kobe-u.ac.jp 1 Tokyo Daily Rainfall (mm) 0 100 200 300 0 10000 20000 30000 40000 50000 Days (mm) 1876 1 1 2013 12 31 Tokyo, 1876 Daily Rainfall (mm) 0 50 100 150 0 100 200 300 Tokyo,

More information

: (EQS) /EQUATIONS V1 = 30*V F1 + E1; V2 = 25*V *F1 + E2; V3 = 16*V *F1 + E3; V4 = 10*V F2 + E4; V5 = 19*V99

: (EQS) /EQUATIONS V1 = 30*V F1 + E1; V2 = 25*V *F1 + E2; V3 = 16*V *F1 + E3; V4 = 10*V F2 + E4; V5 = 19*V99 218 6 219 6.11: (EQS) /EQUATIONS V1 = 30*V999 + 1F1 + E1; V2 = 25*V999 +.54*F1 + E2; V3 = 16*V999 + 1.46*F1 + E3; V4 = 10*V999 + 1F2 + E4; V5 = 19*V999 + 1.29*F2 + E5; V6 = 17*V999 + 2.22*F2 + E6; CALIS.

More information

untitled

untitled 2011/6/22 M2 1*1+2*2 79 2F Y YY 0.0 0.2 0.4 0.6 0.8 0.000 0.002 0.004 0.006 0.008 0.010 0.012 1.0 1.5 2.0 2.5 3.0 3.5 4.0 Y 0 50 100 150 200 250 YY A (Y = X + e A ) B (YY = X + e B ) X 0.00 0.05 0.10

More information

H22 BioS (i) I treat1 II treat2 data d1; input group patno treat1 treat2; cards; ; run; I

H22 BioS (i) I treat1 II treat2 data d1; input group patno treat1 treat2; cards; ; run; I H BioS (i) I treat II treat data d; input group patno treat treat; cards; 8 7 4 8 8 5 5 6 ; run; I II sum data d; set d; sum treat + treat; run; sum proc gplot data d; plot sum * group ; symbol c black

More information

t sex N y y y Diff (1-2)

t sex N y y y Diff (1-2) Armitage 1 1.1 2 t 1.2 SAS Proc GLM 2 2.1 1 1 2.1.1 50 1 1 t sex N y 50 116.45 119.6 122.75 11.071 1.5657 93.906 154.32 y 50 127.27 130.7 134.13 12.072 1.7073 102.68 163.37 y Diff (1-2) -15.7-11.1-6.504

More information

y = x x R = 0. 9, R = σ $ = y x w = x y x x w = x y α ε = + β + x x x y α ε = + β + γ x + x x x x' = / x y' = y/ x y' =

y = x x R = 0. 9, R = σ $ = y x w = x y x x w = x y α ε = + β + x x x y α ε = + β + γ x + x x x x' = / x y' = y/ x y' = y x = α + β + ε =,, ε V( ε) = E( ε ) = σ α $ $ β w ( 0) σ = w σ σ y α x ε = + β + w w w w ε / w ( w y x α β ) = α$ $ W = yw βwxw $β = W ( W) ( W)( W) w x x w x x y y = = x W y W x y x y xw = y W = w w

More information

研修コーナー

研修コーナー 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 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 l l l l l l l l l l l l l l l l l l

More information

renshumondai-kaito.dvi

renshumondai-kaito.dvi 3 1 13 14 1.1 1 44.5 39.5 49.5 2 0.10 2 0.10 54.5 49.5 59.5 5 0.25 7 0.35 64.5 59.5 69.5 8 0.40 15 0.75 74.5 69.5 79.5 3 0.15 18 0.90 84.5 79.5 89.5 2 0.10 20 1.00 20 1.00 2 1.2 1 16.5 20.5 12.5 2 0.10

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

(τ τ ) τ, σ ( ) w = τ iσ, w = τ + iσ (w ) w, w ( ) τ, σ τ = (w + w), σ = i (w w) w, w w = τ w τ + σ w σ = τ + i σ w = τ w τ + σ w σ = τ i σ g ab w, w

(τ τ ) τ, σ ( ) w = τ iσ, w = τ + iσ (w ) w, w ( ) τ, σ τ = (w + w), σ = i (w w) w, w w = τ w τ + σ w σ = τ + i σ w = τ w τ + σ w σ = τ i σ g ab w, w S = 4π dτ dσ gg ij i X µ j X ν η µν η µν g ij g ij = g ij = ( 0 0 ) τ, σ (+, +) τ τ = iτ ds ds = dτ + dσ ds = dτ + dσ δ ij ( ) a =, a = τ b = σ g ij δ ab g g ( +, +,... ) S = 4π S = 4π ( i) = i 4π dτ dσ

More information

2 H23 BioS (i) data d1; input group patno t sex censor; cards;

2 H23 BioS (i) data d1; input group patno t sex censor; cards; H BioS (i) data d1; input group patno t sex censor; cards; 0 1 0 0 0 0 1 0 1 1 0 4 4 0 1 0 5 5 1 1 0 6 5 1 1 0 7 10 1 0 0 8 15 0 1 0 9 15 0 1 0 10 4 1 0 0 11 4 1 0 1 1 5 1 0 1 1 7 0 1 1 14 8 1 0 1 15 8

More information

第11回:線形回帰モデルのOLS推定

第11回:線形回帰モデルのOLS推定 11 OLS 2018 7 13 1 / 45 1. 2. 3. 2 / 45 n 2 ((y 1, x 1 ), (y 2, x 2 ),, (y n, x n )) linear regression model y i = β 0 + β 1 x i + u i, E(u i x i ) = 0, E(u i u j x i ) = 0 (i j), V(u i x i ) = σ 2, i

More information

untitled

untitled WinLD R (16) WinLD https://www.biostat.wisc.edu/content/lan-demets-method-statistical-programs-clinical-trials WinLD.zip 2 2 1 α = 5% Type I error rate 1 5.0 % 2 9.8 % 3 14.3 % 5 22.6 % 10 40.1 % 3 Type

More information

GLM PROC GLM y = Xβ + ε y X β ε ε σ 2 E[ε] = 0 var[ε] = σ 2 I σ 2 0 σ 2 =... 0 σ 2 σ 2 I ε σ 2 y E[y] =Xβ var[y] =σ 2 I PROC GLM

GLM PROC GLM y = Xβ + ε y X β ε ε σ 2 E[ε] = 0 var[ε] = σ 2 I σ 2 0 σ 2 =... 0 σ 2 σ 2 I ε σ 2 y E[y] =Xβ var[y] =σ 2 I PROC GLM PROC MIXED ( ) An Introdunction to PROC MIXED Junji Kishimoto SAS Institute Japan / Keio Univ. SFC / Univ. of Tokyo e-mail address: jpnjak@jpn.sas.com PROC MIXED PROC GLM PROC MIXED,,,, 1 1.1 PROC MIXED

More information

,, Poisson 3 3. t t y,, y n Nµ, σ 2 y i µ + ɛ i ɛ i N0, σ 2 E[y i ] µ * i y i x i y i α + βx i + ɛ i ɛ i N0, σ 2, α, β *3 y i E[y i ] α + βx i

,, Poisson 3 3. t t y,, y n Nµ, σ 2 y i µ + ɛ i ɛ i N0, σ 2 E[y i ] µ * i y i x i y i α + βx i + ɛ i ɛ i N0, σ 2, α, β *3 y i E[y i ] α + βx i Armitage.? SAS.2 µ, µ 2, µ 3 a, a 2, a 3 a µ + a 2 µ 2 + a 3 µ 3 µ, µ 2, µ 3 µ, µ 2, µ 3 log a, a 2, a 3 a µ + a 2 µ 2 + a 3 µ 3 µ, µ 2, µ 3 * 2 2. y t y y y Poisson y * ,, Poisson 3 3. t t y,, y n Nµ,

More information

Isogai, T., Building a dynamic correlation network for fat-tailed financial asset returns, Applied Network Science (7):-24, 206,

Isogai, T., Building a dynamic correlation network for fat-tailed financial asset returns, Applied Network Science (7):-24, 206, H28. (TMU) 206 8 29 / 34 2 3 4 5 6 Isogai, T., Building a dynamic correlation network for fat-tailed financial asset returns, Applied Network Science (7):-24, 206, http://link.springer.com/article/0.007/s409-06-0008-x

More information

chap9.dvi

chap9.dvi 9 AR (i) (ii) MA (iii) (iv) (v) 9.1 2 1 AR 1 9.1.1 S S y j = (α i + β i j) D ij + η j, η j = ρ S η j S + ε j (j =1,,T) (1) i=1 {ε j } i.i.d(,σ 2 ) η j (j ) D ij j i S 1 S =1 D ij =1 S>1 S =4 (1) y j =

More information

5 Armitage x 1,, x n y i = 10x i + 3 y i = log x i {x i } {y i } 1.2 n i i x ij i j y ij, z ij i j 2 1 y = a x + b ( cm) x ij (i j )

5 Armitage x 1,, x n y i = 10x i + 3 y i = log x i {x i } {y i } 1.2 n i i x ij i j y ij, z ij i j 2 1 y = a x + b ( cm) x ij (i j ) 5 Armitage. x,, x n y i = 0x i + 3 y i = log x i x i y i.2 n i i x ij i j y ij, z ij i j 2 y = a x + b 2 2. ( cm) x ij (i j ) (i) x, x 2 σ 2 x,, σ 2 x,2 σ x,, σ x,2 t t x * (ii) (i) m y ij = x ij /00 y

More information

II 2 II

II 2 II II 2 II 2005 yugami@cc.utsunomiya-u.ac.jp 2005 4 1 1 2 5 2.1.................................... 5 2.2................................. 6 2.3............................. 6 2.4.................................

More information

4.9 Hausman Test Time Fixed Effects Model vs Time Random Effects Model Two-way Fixed Effects Model

4.9 Hausman Test Time Fixed Effects Model vs Time Random Effects Model Two-way Fixed Effects Model 1 EViews 5 2007 7 11 2010 5 17 1 ( ) 3 1.1........................................... 4 1.2................................... 9 2 11 3 14 3.1 Pooled OLS.............................................. 14

More information

s = 1.15 (s = 1.07), R = 0.786, R = 0.679, DW =.03 5 Y = 0.3 (0.095) (.708) X, R = 0.786, R = 0.679, s = 1.07, DW =.03, t û Y = 0.3 (3.163) + 0

s = 1.15 (s = 1.07), R = 0.786, R = 0.679, DW =.03 5 Y = 0.3 (0.095) (.708) X, R = 0.786, R = 0.679, s = 1.07, DW =.03, t û Y = 0.3 (3.163) + 0 7 DW 7.1 DW u 1, u,, u (DW ) u u 1 = u 1, u,, u + + + - - - - + + - - - + + u 1, u,, u + - + - + - + - + u 1, u,, u u 1, u,, u u +1 = u 1, u,, u Y = α + βx + u, u = ρu 1 + ɛ, H 0 : ρ = 0, H 1 : ρ 0 ɛ 1,

More information

kubostat2018d p.2 :? bod size x and fertilization f change seed number? : a statistical model for this example? i response variable seed number : { i

kubostat2018d p.2 :? bod size x and fertilization f change seed number? : a statistical model for this example? i response variable seed number : { i kubostat2018d p.1 I 2018 (d) model selection and kubo@ees.hokudai.ac.jp http://goo.gl/76c4i 2018 06 25 : 2018 06 21 17:45 1 2 3 4 :? AIC : deviance model selection misunderstanding kubostat2018d (http://goo.gl/76c4i)

More information

第13回:交差項を含む回帰・弾力性の推定

第13回:交差項を含む回帰・弾力性の推定 13 2018 7 27 1 / 31 1. 2. 2 / 31 y i = β 0 + β X x i + β Z z i + β XZ x i z i + u i, E(u i x i, z i ) = 0, E(u i u j x i, z i ) = 0 (i j), V(u i x i, z i ) = σ 2, i = 1, 2,, n x i z i 1 3 / 31 y i = β

More information

インターネットを活用した経済分析 - フリーソフト Rを使おう

インターネットを活用した経済分析 - フリーソフト Rを使おう R 1 1 1 2017 2 15 2017 2 15 1/64 2 R 3 R R RESAS 2017 2 15 2/64 2 R 3 R R RESAS 2017 2 15 3/64 2-4 ( ) ( (80%) (20%) 2017 2 15 4/64 PC LAN R 2017 2 15 5/64 R R 2017 2 15 6/64 3-4 R 15 + 2017 2 15 7/64

More information

kubostat2015e p.2 how to specify Poisson regression model, a GLM GLM how to specify model, a GLM GLM logistic probability distribution Poisson distrib

kubostat2015e p.2 how to specify Poisson regression model, a GLM GLM how to specify model, a GLM GLM logistic probability distribution Poisson distrib kubostat2015e p.1 I 2015 (e) GLM kubo@ees.hokudai.ac.jp http://goo.gl/76c4i 2015 07 22 2015 07 21 16:26 kubostat2015e (http://goo.gl/76c4i) 2015 (e) 2015 07 22 1 / 42 1 N k 2 binomial distribution logit

More information

α β *2 α α β β α = α 1 β = 1 β 2.2 α 0 β *3 2.3 * *2 *3 *4 (µ A ) (µ P ) (µ A > µ P ) 10 (µ A = µ P + 10) 15 (µ A = µ P +

α β *2 α α β β α = α 1 β = 1 β 2.2 α 0 β *3 2.3 * *2 *3 *4 (µ A ) (µ P ) (µ A > µ P ) 10 (µ A = µ P + 10) 15 (µ A = µ P + Armitage 1 1.1 2 t *1 α β 1.2 µ x µ 2 2 2 α β 2.1 1 α β α ( ) β *1 t t 1 α β *2 α α β β α = α 1 β = 1 β 2.2 α 0 β 1 0 0 1 1 5 2.5 *3 2.3 *4 3 3.1 1 1 1 *2 *3 *4 (µ A ) (µ P ) (µ A > µ P ) 10 (µ A = µ P

More information

kubostat2017e p.1 I 2017 (e) GLM logistic regression : : :02 1 N y count data or

kubostat2017e p.1 I 2017 (e) GLM logistic regression : : :02 1 N y count data or kubostat207e p. I 207 (e) GLM kubo@ees.hokudai.ac.jp https://goo.gl/z9ycjy 207 4 207 6:02 N y 2 binomial distribution logit link function 3 4! offset kubostat207e (https://goo.gl/z9ycjy) 207 (e) 207 4

More information

JMP V4 による生存時間分析

JMP V4 による生存時間分析 V4 1 SAS 2000.11.18 4 ( ) (Survival Time) 1 (Event) Start of Study Start of Observation Died Died Died Lost End Time Censor Died Died Censor Died Time Start of Study End Start of Observation Censor

More information

一般化線形 (混合) モデル (2) - ロジスティック回帰と GLMM

一般化線形 (混合) モデル (2) - ロジスティック回帰と GLMM .. ( ) (2) GLMM kubo@ees.hokudai.ac.jp I http://goo.gl/rrhzey 2013 08 27 : 2013 08 27 08:29 kubostat2013ou2 (http://goo.gl/rrhzey) ( ) (2) 2013 08 27 1 / 74 I.1 N k.2 binomial distribution logit link function.3.4!

More information

Use R

Use R Use R! 2008/05/23( ) Index Introduction (GLM) ( ) R. Introduction R,, PLS,,, etc. 2. Correlation coefficient (Pearson s product moment correlation) r = Sxy Sxx Syy :, Sxy, Sxx= X, Syy Y 1.96 95% R cor(x,

More information

σ t σ t σt nikkei HP nikkei4csv H R nikkei4<-readcsv("h:=y=ynikkei4csv",header=t) (1) nikkei header=t nikkei4csv 4 4 nikkei nikkei4<-dataframe(n

σ t σ t σt nikkei HP nikkei4csv H R nikkei4<-readcsv(h:=y=ynikkei4csv,header=t) (1) nikkei header=t nikkei4csv 4 4 nikkei nikkei4<-dataframe(n R 1 R R R tseries fseries 1 tseries fseries R Japan(Tokyo) R library(tseries) library(fseries) 2 t r t t 1 Ω t 1 E[r t Ω t 1 ] ɛ t r t = E[r t Ω t 1 ] + ɛ t ɛ t 2 iid (independently, identically distributed)

More information

st.dvi

st.dvi 9 3 5................................... 5............................. 5....................................... 5.................................. 7.........................................................................

More information

2 / 39

2 / 39 W707 s-taiji@is.titech.ac.jp 1 / 39 2 / 39 1 2 3 3 / 39 q f (x; α) = α j B j (x). j=1 min α R n+2 n ( d (Y i f (X i ; α)) 2 2 ) 2 f (x; α) + λ dx 2 dx. i=1 f B j 4 / 39 : q f (x) = α j B j (x). j=1 : x

More information

10

10 z c j = N 1 N t= j1 [ ( z t z ) ( )] z t j z q 2 1 2 r j /N j=1 1/ N J Q = N(N 2) 1 N j j=1 r j 2 2 χ J B d z t = z t d (1 B) 2 z t = (z t z t 1 ) (z t 1 z t 2 ) (1 B s )z t = z t z t s _ARIMA CONSUME

More information

4 Mindlin -Reissner 4 δ T T T εσdω= δ ubdω+ δ utd Γ Ω Ω Γ T εσ (1.1) ε σ u b t 3 σ ε. u T T T = = = { σx σ y σ z τxy τ yz τzx} { εx εy εz γ xy γ yz γ

4 Mindlin -Reissner 4 δ T T T εσdω= δ ubdω+ δ utd Γ Ω Ω Γ T εσ (1.1) ε σ u b t 3 σ ε. u T T T = = = { σx σ y σ z τxy τ yz τzx} { εx εy εz γ xy γ yz γ Mindlin -Rissnr δ εσd δ ubd+ δ utd Γ Γ εσ (.) ε σ u b t σ ε. u { σ σ σ z τ τ z τz} { ε ε εz γ γ z γ z} { u u uz} { b b bz} b t { t t tz}. ε u u u u z u u u z u u z ε + + + (.) z z z (.) u u NU (.) N U

More information

変 位 変位とは 物体中のある点が変形後に 別の点に異動したときの位置の変化で あり ベクトル量である 変位には 物体の変形の他に剛体運動 剛体変位 が含まれている 剛体変位 P(x, y, z) 平行移動と回転 P! (x + u, y + v, z + w) Q(x + d x, y + dy,

変 位 変位とは 物体中のある点が変形後に 別の点に異動したときの位置の変化で あり ベクトル量である 変位には 物体の変形の他に剛体運動 剛体変位 が含まれている 剛体変位 P(x, y, z) 平行移動と回転 P! (x + u, y + v, z + w) Q(x + d x, y + dy, 変 位 変位とは 物体中のある点が変形後に 別の点に異動したときの位置の変化で あり ベクトル量である 変位には 物体の変形の他に剛体運動 剛体変位 が含まれている 剛体変位 P(x, y, z) 平行移動と回転 P! (x + u, y + v, z + w) Q(x + d x, y + dy, z + dz) Q! (x + d x + u + du, y + dy + v + dv, z +

More information

基礎数学I

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

More information

kubostat2017c p (c) Poisson regression, a generalized linear model (GLM) : :

kubostat2017c p (c) Poisson regression, a generalized linear model (GLM) : : kubostat2017c p.1 2017 (c), a generalized linear model (GLM) : kubo@ees.hokudai.ac.jp http://goo.gl/76c4i 2017 11 14 : 2017 11 07 15:43 kubostat2017c (http://goo.gl/76c4i) 2017 (c) 2017 11 14 1 / 47 agenda

More information

O1-1 O1-2 O1-3 O1-4 O1-5 O1-6

O1-1 O1-2 O1-3 O1-4 O1-5 O1-6 O1-1 O1-2 O1-3 O1-4 O1-5 O1-6 O1-7 O1-8 O1-9 O1-10 O1-11 O1-12 O1-13 O1-14 O1-15 O1-16 O1-17 O1-18 O1-19 O1-20 O1-21 O1-22 O1-23 O1-24 O1-25 O1-26 O1-27 O1-28 O1-29 O1-30 O1-31 O1-32 O1-33 O1-34 O1-35

More information

1 911 9001030 9:00 A B C D E F G H I J K L M 1A0900 1B0900 1C0900 1D0900 1E0900 1F0900 1G0900 1H0900 1I0900 1J0900 1K0900 1L0900 1M0900 9:15 1A0915 1B0915 1C0915 1D0915 1E0915 1F0915 1G0915 1H0915 1I0915

More information

,,..,. 1

,,..,. 1 016 9 3 6 0 016 1 0 1 10 1 1 17 1..,,..,. 1 1 c = h = G = ε 0 = 1. 1.1 L L T V 1.1. T, V. d dt L q i L q i = 0 1.. q i t L q i, q i, t L ϕ, ϕ, x µ x µ 1.3. ϕ x µ, L. S, L, L S = Ld 4 x 1.4 = Ld 3 xdt 1.5

More information

1 (1) () (3) I 0 3 I I d θ = L () dt θ L L θ I d θ = L = κθ (3) dt κ T I T = π κ (4) T I κ κ κ L l a θ L r δr δl L θ ϕ ϕ = rθ (5) l

1 (1) () (3) I 0 3 I I d θ = L () dt θ L L θ I d θ = L = κθ (3) dt κ T I T = π κ (4) T I κ κ κ L l a θ L r δr δl L θ ϕ ϕ = rθ (5) l 1 1 ϕ ϕ ϕ S F F = ϕ (1) S 1: F 1 1 (1) () (3) I 0 3 I I d θ = L () dt θ L L θ I d θ = L = κθ (3) dt κ T I T = π κ (4) T I κ κ κ L l a θ L r δr δl L θ ϕ ϕ = rθ (5) l : l r δr θ πrδr δf (1) (5) δf = ϕ πrδr

More information

通信容量制約を考慮したフィードバック制御 - 電子情報通信学会 情報理論研究会(IT) 若手研究者のための講演会

通信容量制約を考慮したフィードバック制御 -  電子情報通信学会 情報理論研究会(IT)  若手研究者のための講演会 IT 1 2 1 2 27 11 24 15:20 16:05 ( ) 27 11 24 1 / 49 1 1940 Witsenhausen 2 3 ( ) 27 11 24 2 / 49 1940 2 gun director Warren Weaver, NDRC (National Defence Research Committee) Final report D-2 project #2,

More information

chap10.dvi

chap10.dvi . q {y j } I( ( L y j =Δy j = u j = C l ε j l = C(L ε j, {ε j } i.i.d.(,i q ( l= y O p ( {u j } q {C l } A l C l

More information

第86回日本感染症学会総会学術集会後抄録(I)

第86回日本感染症学会総会学術集会後抄録(I) κ κ κ κ κ κ μ μ β β β γ α α β β γ α β α α α γ α β β γ μ β β μ μ α ββ β β β β β β β β β β β β β β β β β β γ β μ μ μ μμ μ μ μ μ β β μ μ μ μ μ μ μ μ μ μ μ μ μ μ β

More information

arxiv: v1(astro-ph.co)

arxiv: v1(astro-ph.co) arxiv:1311.0281v1(astro-ph.co) R µν 1 2 Rg µν + Λg µν = 8πG c 4 T µν Λ f(r) R f(r) Galileon φ(t) Massive Gravity etc... Action S = d 4 x g (L GG + L m ) L GG = K(φ,X) G 3 (φ,x)φ + G 4 (φ,x)r + G 4X (φ)

More information

% 10%, 35%( 1029 ) p (a) 1 p 95% (b) 1 Std. Err. (c) p 40% 5% (d) p 1: STATA (1). prtesti One-sample test of pr

% 10%, 35%( 1029 ) p (a) 1 p 95% (b) 1 Std. Err. (c) p 40% 5% (d) p 1: STATA (1). prtesti One-sample test of pr 1 1. 2014 6 2014 6 10 10% 10%, 35%( 1029 ) p (a) 1 p 95% (b) 1 Std. Err. (c) p 40% 5% (d) p 1: STATA (1). prtesti 1029 0.35 0.40 One-sample test of proportion x: Number of obs = 1029 Variable Mean Std.

More information

untitled

untitled 17 5 13 1 2 1.1... 2 1.2... 2 1.3... 3 2 3 2.1... 3 2.2... 5 3 6 3.1... 6 3.2... 7 3.3 t... 7 3.4 BC a... 9 3.5... 10 4 11 1 1 θ n ˆθ. ˆθ, ˆθ, ˆθ.,, ˆθ.,.,,,. 1.1 ˆθ σ 2 = E(ˆθ E ˆθ) 2 b = E(ˆθ θ). Y 1,,Y

More information

『共形場理論』

『共形場理論』 T (z) SL(2, C) T (z) SU(2) S 1 /Z 2 SU(2) (ŜU(2) k ŜU(2) 1)/ŜU(2) k+1 ŜU(2)/Û(1) G H N =1 N =1 N =1 N =1 N =2 N =2 N =2 N =2 ĉ>1 N =2 N =2 N =4 N =4 1 2 2 z=x 1 +ix 2 z f(z) f(z) 1 1 4 4 N =4 1 = = 1.3

More information

「スウェーデン企業におけるワーク・ライフ・バランス調査 」報告書

「スウェーデン企業におけるワーク・ライフ・バランス調査 」報告書 1 2004 12 2005 4 5 100 25 3 1 76 2 Demoskop 2 2004 11 24 30 7 2 10 1 2005 1 31 2 4 5 2 3-1-1 3-1-1 Micromediabanken 2005 1 507 1000 55.0 2 77 50 50 /CEO 36.3 37.4 18.1 3-2-1 43.0 34.4 / 17.6 3-2-2 78 79.4

More information

80 X 1, X 2,, X n ( λ ) λ P(X = x) = f (x; λ) = λx e λ, x = 0, 1, 2, x! l(λ) = n f (x i ; λ) = i=1 i=1 n λ x i e λ i=1 x i! = λ n i=1 x i e nλ n i=1 x

80 X 1, X 2,, X n ( λ ) λ P(X = x) = f (x; λ) = λx e λ, x = 0, 1, 2, x! l(λ) = n f (x i ; λ) = i=1 i=1 n λ x i e λ i=1 x i! = λ n i=1 x i e nλ n i=1 x 80 X 1, X 2,, X n ( λ ) λ P(X = x) = f (x; λ) = λx e λ, x = 0, 1, 2, x! l(λ) = n f (x i ; λ) = n λ x i e λ x i! = λ n x i e nλ n x i! n n log l(λ) = log(λ) x i nλ log( x i!) log l(λ) λ = 1 λ n x i n =

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

研究シリーズ第40号

研究シリーズ第40号 165 PEN WPI CPI WAGE IIP Feige and Pearce 166 167 168 169 Vector Autoregression n (z) z z p p p zt = φ1zt 1 + φ2zt 2 + + φ pzt p + t Cov( 0 ε t, ε t j )= Σ for for j 0 j = 0 Cov( ε t, zt j ) = 0 j = >

More information

Microsoft Word - 表紙.docx

Microsoft Word - 表紙.docx 黒住英司 [ 著 ] サピエンティア 計量経済学 訂正および練習問題解答 (206/2/2 版 ) 訂正 練習問題解答 3 .69, 3.8 4 (X i X)U i i i (X i μ x )U i ( X μx ) U i. i E [ ] (X i μ x )U i i E[(X i μ x )]E[U i ]0. i V [ ] (X i μ x )U i i 2 i j E [(X i

More information

R R 16 ( 3 )

R R 16   ( 3 ) (017 ) 9 4 7 ( ) ( 3 ) ( 010 ) 1 (P3) 1 11 (P4) 1 1 (P4) 1 (P15) 1 (P16) (P0) 3 (P18) 3 4 (P3) 4 3 4 31 1 5 3 5 4 6 5 9 51 9 5 9 6 9 61 9 6 α β 9 63 û 11 64 R 1 65 13 66 14 7 14 71 15 7 R R 16 http://wwwecoosaka-uacjp/~tazak/class/017

More information

V(x) m e V 0 cos x π x π V(x) = x < π, x > π V 0 (i) x = 0 (V(x) V 0 (1 x 2 /2)) n n d 2 f dξ 2ξ d f 2 dξ + 2n f = 0 H n (ξ) (ii) H

V(x) m e V 0 cos x π x π V(x) = x < π, x > π V 0 (i) x = 0 (V(x) V 0 (1 x 2 /2)) n n d 2 f dξ 2ξ d f 2 dξ + 2n f = 0 H n (ξ) (ii) H 199 1 1 199 1 1. Vx) m e V cos x π x π Vx) = x < π, x > π V i) x = Vx) V 1 x /)) n n d f dξ ξ d f dξ + n f = H n ξ) ii) H n ξ) = 1) n expξ ) dn dξ n exp ξ )) H n ξ)h m ξ) exp ξ )dξ = π n n!δ n,m x = Vx)

More information

総合薬学講座 生物統計の基礎

総合薬学講座 生物統計の基礎 2013 10 22 ( ) 2013 10 22 1 / 40 p.682 1. 2. 3 2 t Mann Whitney U ). 4 χ 2. 5. 6 Dunnett Tukey. 7. 8 Kaplan Meier.. U. ( ) 2013 10 22 2 / 40 1 93 ( 20 ) 230. a t b c χ 2 d 1.0 +1.0 e, b ( ) e ( ) ( ) 2013

More information

10:30 12:00 P.G. vs vs vs 2

10:30 12:00 P.G. vs vs vs 2 1 10:30 12:00 P.G. vs vs vs 2 LOGIT PROBIT TOBIT mean median mode CV 3 4 5 0.5 1000 6 45 7 P(A B) = P(A) + P(B) - P(A B) P(B A)=P(A B)/P(A) P(A B)=P(B A) P(A) P(A B) P(A) P(B A) P(B) P(A B) P(A) P(B) P(B

More information

( 30 ) 30 4 5 1 4 1.1............................................... 4 1.............................................. 4 1..1.................................. 4 1.......................................

More information

Vol. 36, Special Issue, S 3 S 18 (2015) PK Phase I Introduction to Pharmacokinetic Analysis Focus on Phase I Study 1 2 Kazuro Ikawa 1 and Jun Tanaka 2

Vol. 36, Special Issue, S 3 S 18 (2015) PK Phase I Introduction to Pharmacokinetic Analysis Focus on Phase I Study 1 2 Kazuro Ikawa 1 and Jun Tanaka 2 Vol. 36, Special Issue, S 3 S 18 (2015) PK Phase I Introduction to Pharmacokinetic Analysis Focus on Phase I Study 1 2 Kazuro Ikawa 1 and Jun Tanaka 2 1 2 1 Department of Clinical Pharmacotherapy, Hiroshima

More information

Stata11 whitepapers mwp-037 regress - regress regress. regress mpg weight foreign Source SS df MS Number of obs = 74 F(

Stata11 whitepapers mwp-037 regress - regress regress. regress mpg weight foreign Source SS df MS Number of obs = 74 F( mwp-037 regress - regress 1. 1.1 1.2 1.3 2. 3. 4. 5. 1. regress. regress mpg weight foreign Source SS df MS Number of obs = 74 F( 2, 71) = 69.75 Model 1619.2877 2 809.643849 Prob > F = 0.0000 Residual

More information

1.2 R R Windows, Macintosh, Linux(Unix) Windows Mac R Linux redhat, debian, vinelinux ( ) RjpWiki ( RjpWiki Wiki

1.2 R R Windows, Macintosh, Linux(Unix) Windows Mac R Linux redhat, debian, vinelinux ( ) RjpWiki (  RjpWiki Wiki R 2005 9 12 ( ) 1 R 1.1 R R R S-PLUS( ) S version 4( ) S (AT&T Richard A. Becker, John M. Chambers, and Allan R. Wilks ) S S R R S ( ) S GUI( ) ( ) R R R R http://stat.sm.u-tokai.ac.jp/ yama/r/ R yamamoto@sm.u-tokai.ac.jp

More information

solutionJIS.dvi

solutionJIS.dvi May 0, 006 6 morimune@econ.kyoto-u.ac.jp /9/005 (7 0/5/006 1 1.1 (a) (b) (c) c + c + + c = nc (x 1 x)+(x x)+ +(x n x) =(x 1 + x + + x n ) nx = nx nx =0 c(x 1 x)+c(x x)+ + c(x n x) =c (x i x) =0 y i (x

More information

ohpmain.dvi

ohpmain.dvi fujisawa@ism.ac.jp 1 Contents 1. 2. 3. 4. γ- 2 1. 3 10 5.6, 5.7, 5.4, 5.5, 5.8, 5.5, 5.3, 5.6, 5.4, 5.2. 5.5 5.6 +5.7 +5.4 +5.5 +5.8 +5.5 +5.3 +5.6 +5.4 +5.2 =5.5. 10 outlier 5 5.6, 5.7, 5.4, 5.5, 5.8,

More information

DVIOUT-ar

DVIOUT-ar 1 4 μ=0, σ=1 5 μ=2, σ=1 5 μ=0, σ=2 3 2 1 0-1 -2-3 0 10 20 30 40 50 60 70 80 90 4 3 2 1 0-1 0 10 20 30 40 50 60 70 80 90 4 3 2 1 0-1 -2-3 -4-5 0 10 20 30 40 50 60 70 80 90 8 μ=2, σ=2 5 μ=1, θ 1 =0.5, σ=1

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

N cos s s cos ψ e e e e 3 3 e e 3 e 3 e

N cos s s cos ψ e e e e 3 3 e e 3 e 3 e 3 3 5 5 5 3 3 7 5 33 5 33 9 5 8 > e > f U f U u u > u ue u e u ue u ue u e u e u u e u u e u N cos s s cos ψ e e e e 3 3 e e 3 e 3 e 3 > A A > A E A f A A f A [ ] f A A e > > A e[ ] > f A E A < < f ; >

More information

( ) Note (e ) (µ ) (τ ) ( (ν e,e ) e- (ν µ, µ ) µ- (ν τ,τ ) τ- ) ( ) ( ) (SU(2) ) (W +,Z 0,W ) * 1) 3 * 2) [ ] [ ] [ ] ν e ν µ ν τ e

( ) Note (e ) (µ ) (τ ) ( (ν e,e ) e- (ν µ, µ ) µ- (ν τ,τ ) τ- ) ( ) ( ) (SU(2) ) (W +,Z 0,W ) * 1) 3 * 2) [ ] [ ] [ ] ν e ν µ ν τ e ( ) Note 3 19 12 13 8 8.1 (e ) (µ ) (τ ) ( (ν e,e ) e- (ν µ, µ ) µ- (ν τ,τ ) τ- ) ( ) ( ) (SU(2) ) (W +,Z 0,W ) * 1) 3 * 2) [ ] [ ] [ ] ν e ν µ ν τ e µ τ, e R, µ R, τ R (1a) L ( ) ) * 3) W Z 1/2 ( - )

More information

鉄鋼協会プレゼン

鉄鋼協会プレゼン NN :~:, 8 Nov., Adaptive H Control for Linear Slider with Friction Compensation positioning mechanism moving table stand manipulator Point to Point Control [G] Continuous Path Control ground Fig. Positoining

More information

untitled

untitled IT (1, horiike@ml.me.titech.ac.jp) (1, jun-jun@ms.kagu.tus.ac.jp) 1. 1-1 19802000 2000ITIT IT IT TOPIX (%) 1TOPIX 2 1-2. 80 80 ( ) 2004/11/26 S-PLUS 2 1-3. IT IT IT IT 2. 2-1. a. b. (Size) c. B/M(Book

More information

O x y z O ( O ) O (O ) 3 x y z O O x v t = t = 0 ( 1 ) O t = 0 c t r = ct P (x, y, z) r 2 = x 2 + y 2 + z 2 (t, x, y, z) (ct) 2 x 2 y 2 z 2 = 0

O x y z O ( O ) O (O ) 3 x y z O O x v t = t = 0 ( 1 ) O t = 0 c t r = ct P (x, y, z) r 2 = x 2 + y 2 + z 2 (t, x, y, z) (ct) 2 x 2 y 2 z 2 = 0 9 O y O ( O ) O (O ) 3 y O O v t = t = 0 ( ) O t = 0 t r = t P (, y, ) r = + y + (t,, y, ) (t) y = 0 () ( )O O t (t ) y = 0 () (t) y = (t ) y = 0 (3) O O v O O v O O O y y O O v P(, y,, t) t (, y,, t )

More information

2 1 1 α = a + bi(a, b R) α (conjugate) α = a bi α (absolute value) α = a 2 + b 2 α (norm) N(α) = a 2 + b 2 = αα = α 2 α (spure) (trace) 1 1. a R aα =

2 1 1 α = a + bi(a, b R) α (conjugate) α = a bi α (absolute value) α = a 2 + b 2 α (norm) N(α) = a 2 + b 2 = αα = α 2 α (spure) (trace) 1 1. a R aα = 1 1 α = a + bi(a, b R) α (conjugate) α = a bi α (absolute value) α = a + b α (norm) N(α) = a + b = αα = α α (spure) (trace) 1 1. a R aα = aα. α = α 3. α + β = α + β 4. αβ = αβ 5. β 0 6. α = α ( ) α = α

More information

2 G(k) e ikx = (ik) n x n n! n=0 (k ) ( ) X n = ( i) n n k n G(k) k=0 F (k) ln G(k) = ln e ikx n κ n F (k) = F (k) (ik) n n= n! κ n κ n = ( i) n n k n

2 G(k) e ikx = (ik) n x n n! n=0 (k ) ( ) X n = ( i) n n k n G(k) k=0 F (k) ln G(k) = ln e ikx n κ n F (k) = F (k) (ik) n n= n! κ n κ n = ( i) n n k n . X {x, x 2, x 3,... x n } X X {, 2, 3, 4, 5, 6} X x i P i. 0 P i 2. n P i = 3. P (i ω) = i ω P i P 3 {x, x 2, x 3,... x n } ω P i = 6 X f(x) f(x) X n n f(x i )P i n x n i P i X n 2 G(k) e ikx = (ik) n

More information

I L01( Wed) : Time-stamp: Wed 07:38 JST hig e, ( ) L01 I(2017) 1 / 19

I L01( Wed) : Time-stamp: Wed 07:38 JST hig e,   ( ) L01 I(2017) 1 / 19 I L01(2017-09-20 Wed) : Time-stamp: 2017-09-20 Wed 07:38 JST hig e, http://hig3.net ( ) L01 I(2017) 1 / 19 ? 1? 2? ( ) L01 I(2017) 2 / 19 ?,,.,., 1..,. 1,2,.,.,. ( ) L01 I(2017) 3 / 19 ? I. M (3 ) II,

More information

R = Ar l B r l. A, B A, B.. r 2 R r = r2 [lar r l B r l2 ]=larl l B r l.2 r 2 R = [lar l l Br ] r r r = ll Ar l ll B = ll R rl.3 sin θ Θ = ll.4 Θsinθ

R = Ar l B r l. A, B A, B.. r 2 R r = r2 [lar r l B r l2 ]=larl l B r l.2 r 2 R = [lar l l Br ] r r r = ll Ar l ll B = ll R rl.3 sin θ Θ = ll.4 Θsinθ .3.2 3.3.2 Spherical Coorinates.5: Laplace 2 V = r 2 r 2 x = r cos φ sin θ, y = r sin φ sin θ, z = r cos θ.93 r 2 sin θ sin θ θ θ r 2 sin 2 θ 2 V =.94 2.94 z V φ Laplace r 2 r 2 r 2 sin θ.96.95 V r 2 R

More information