MCMC MCMC R[26] MCMCpack[22] JAGS[25] MCMCpack Stan[29] * MCMC? MCMC x θ π(θ x) π(θ x) = f(x θ)π(θ) f(x θ)π(θ)dθ (1) f(x θ) π(θ) θ

Size: px
Start display at page:

Download "MCMC MCMC R[26] MCMCpack[22] JAGS[25] MCMCpack Stan[29] * MCMC? MCMC x θ π(θ x) π(θ x) = f(x θ)π(θ) f(x θ)π(θ)dθ (1) f(x θ) π(θ) θ"

Transcription

1 MCMC MCMC R[26] MCMCpack[22] JAGS[25] MCMCpack Stan[29] * MCMC? MCMC x θ π(θ x) π(θ x) = f(x θ)π(θ) f(x θ)π(θ)dθ (1) f(x θ) π(θ) θ π(θ x) f(x θ)π(θ) (2) MCMC hiroki@affrc.go.jp *1 R 3.2.2, MCMCpack 1.3-3, JAGS 3.4.0, Stan 2.8.0

2 MCMC=MC+MC MCMC? MCMC MC (Markov Chain) MC (Monte Carlo) Markov chain x t+1 x t : x t 1 Monte Carlo MCMC

3 1.2 MCMC MCMC Metropolis-Hastings Gibbs sampler [1, 10, 34, 37] Hamiltonian Monte Carlo Hybrid Monte Carlo [1, 7, 35, 37] 2 MCMC R : MCMCpack : WinBUGS, OpenBUGS, JAGS, Stan Stan BUGS (Bayesian inference Using Gibbs Sampling) [21, 32] Stan BUGS R Python PyMC C MCMCpack : : R CRAN Metropolis sampler MCMClogit() MCMCpoisson() MCMC MCMChregress() MCMChlogit() MCMChpoisson() 30 MCMCmetrop1R() [22] 2.2 WinBUGS :

4 : Windows Wine *2 OS X Linux BSD GUI R2WinBUGS R WinBUGS key key Windows WinBUGS14.exe Windows Vista C:\Program Files C:\Program Files *3 64 Windows OS X Mac Wine WinBUGS OS X WinBUGS *4 OS X Wine.app *5 MacPors *6 Wine Windows (WinBUGS14.exe) Wine WinBUGS ~/.wine/drive_c/program Files Linux Wine Ubuntu Wine (WinBUGS14.exe) WinBUGS *2 Wine Is Not Emulator Wine 1.2 WinBUGS Wine Windows Windows ( ) Windows *3 * *5 *6

5 BSD UNIX Linux 2.3 OpenBUGS : GPL Black Box Component Builder *7 Windows Linux OS X Wine BRUGS R2OpenBUGS R [33] CRAN Windows Windows 64 Windows Windows XP 8 OS X Linux WinBUGS Wine Windows Linux 2.4 JAGS : : : GPL C C++ *8 BLAS LAPACK rjags R2jags runjags R CRAN WinBUGS *9 WinBUGS * 10 *7 * *9 *10

6 OpenBUGS * 11 Windows OS X Linux 2.5 Stan : : BSD GPL3 RStan R CRAN Pyhton PyStan CmdStan Stan C++ OS X, Windows, Linux Hamiltonian Monte Carlo [1, 7, 35] MCMC BUGS RStan CRAN CmdStan C++ *11

7 3 MCMC 3.1 : MCMC x = (3, 1, 4, 3, 3, 6, 4, 1, 6, 4, 1, 7, 4, 4, 1, 4, 0, 3, 9, 4) λ MCMCpoisson() R MCMCpack MCMCpoisson() R example1.r MCMCpack > + 1 > library ( MCMCpack ) post1 3 1 > post1 <- vector (" list ", 3) MCMCpoisson() MCMCpoisson() log(λ) MCMC 1 > post1 [[1]] <- MCMCpoisson (x ~ 1, beta. start = 1, 2 + burnin = 0, mcmc = 400, 3 + thin = 1, 4 + tune = 0.8, seed = 1117, 5 + verbose = 20) x 1 glm() 1 X Poisson(λ) log λ = C

8 C * 12 improper beta.start log λ burnin burn-in 0 mcmc thin 1 * 13 tune seed verbose 20 Markov chain 2 1 > plot ( post1 [[1]], density = FALSE, col = 1, las = 1) Trace of (Intercept) Iterations 2 MCMCpoissonR() Markov chain 50 burn-in tune [27] *12 b0 B0 : *13 thinning [19]

9 1 > post1 [[2]] <- MCMCpoisson (x ~ 1, beta. start = 5, 2 + burnin = 0, mcmc = 400, thin = 1, 3 + tune = 0.8, seed = 1123, 4 + verbose = 20) 5 > post1 [[3]] <- MCMCpoisson (x ~ 1, beta. start = 10, 6 + burnin = 0, mcmc = 400, thin = 1, 7 + tune = 0.8, seed = 1129, 8 + verbose = 20) mcmc.list 3 1 > post1. mcmc <- mcmc. list ( post1 ) 2 > plot ( post1. mcmc, density = FALSE, ylim = c(0, 10), las = 1) Trace of (Intercept) Iterations 3 Markov chain 3 burn-in 500 burn-in Markov chain = > post2 <- vector (" list ", 3) 2 > burnin < > mcmc < > thin <- 1 5 > tune <- 2 6 > verbose = 0 7 > post2 [[1]] <- MCMCpoisson (x ~ 1, beta. start = 1,

10 8 + burnin = burnin, mcmc = mcmc, 9 + thin = thin, 10 + tune = tune, seed = 1117, 11 + verbose = verbose ) 12 > post2 [[2]] <- MCMCpoisson (x ~ 1, beta. start = 5, 13 + burnin = burnin, mcmc = mcmc, 14 + thin = thin, 15 + tune = tune, seed = 1123, 16 + verbose = verbose ) 17 > post2 [[3]] <- MCMCpoisson (x ~ 1, beta. start = 10, 18 + burnin = burnin, mcmc = mcmc, 19 + thin = thin, 20 + tune = tune, seed = 1129, 21 + verbose = verbose ) 22 > post2. mcmc <- mcmc. list ( post2 ) 23 > 24 > plot ( post2. mcmc ) 4 1 > plot ( post2. mcmc ) Trace of (Intercept) Density of (Intercept) Iterations N = 1000 Bandwidth = Markov chain λ 1 > summary ( post2. mcmc ) 2 3 Iterations = 501: Thinning interval = 1

11 5 Number of chains = 3 6 Sample size per chain = Empirical mean and standard deviation for each variable, 9 plus standard error of the mean : Mean SD Naive SE Time - series SE Quantiles for each variable : % 25% 50% 75% 97. 5% % * 14 log λ % λ exp(1.33) = MCMCmetrop1R() MCMCmetrop1R() MCMCpoisson() MCMCmetrop1R() MCMCmetrop1R() 1 > LogPoisFun <- function ( lambda, x) { 2 + # Poisson distribution : p(x) = lambda ^x exp (- lambda )/x! 3 + if ( lambda >= 0) { # lambda must be non - negative 4 + # prior : dunif (0, 10^4) 5 + log ( ifelse ( lambda >= 0 & lambda < 10^4, 10^ -4, 0)) # log likelihood 7 + sum ( log ( lambda ^x * exp (- lambda ) / factorial (x ))) 8 + } else { 9 + -Inf 10 + } 11 + } λ λ Uniform(0, 10 4 ) *14

12 Pr(λ) = { λ < (, ) improper prior f(x) = λ x e λ /x! λ X L(X λ) 3 N λ X i e λ L(X λ) = X i! i=1 (3) Pr(λ X) L(X λ)pr(λ) (4) { N i=1 λx i e λ L(X λ)pr(λ) = X i! λ < (5) R LogPoisFun() 5 MCMCmetrop1R() fun help(mcmcmetrop1r) LogPoisFun MCMCpoisoon() 3 Markov chain lapply() 1 > chains <- 1:3 2 > inits <- c(1, 10, 20) 3 > seeds <- c (1117, 1123, 1129) 4 > post3 <- lapply ( chains, 5 + function ( chain ) { 6 + MCMCmetrop1R ( fun = LogPoisFun, 7 + theta. init = inits [ chain ], 8 + burnin = 1000, mcmc = 1000, 9 + thin = 1, 10 + tune = 2, seed = seeds [ chain ], 11 + verbose = 0, logfun = TRUE, 12 + x = x) 13 + }) 14 15

13 16 17 The Metropolis acceptance rate was The Metropolis acceptance rate was The Metropolis acceptance rate was > summary ( post3. mcmc ) 2 3 Iterations = 1001: Thinning interval = 1 5 Number of chains = 3 6 Sample size per chain = Empirical mean and standard deviation for each variable, 9 plus standard error of the mean : Mean SD Naive SE Time - series SE Quantiles for each variable : % 25% 50% 75% 97. 5% Gelman-Rubin ( ˆR; Rhat) R coda gelman.diag() 1 chain help(gelman.diag) ˆR 1.1

14 Iterations N = 1000 Bandwidth = > gelman. diag ( post3. mcmc ) 2 Potential scale reduction factors : 3 4 Point est. Upper C.I. 5 [1,] Geweke coda geweke.diag() Z Z > % help(geweke.diag) 1 > geweke. diag ( post3. mcmc ) 2 [[1]] 3 4 Fraction in 1 st window = Fraction in 2 nd window = var [[2]] Fraction in 1 st window = Fraction in 2 nd window = var1

15 [[3]] Fraction in 1 st window = Fraction in 2 nd window = var coda boa (Bayesian Output Analysis) 3.2 MCMC N(=11) (x = (0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10) ) K(=10) x 10 y = (1, 2, 2, 6, 4, 5, 8, 9, 9, 9, 10) x y x y y x 6 3.2

16 3.2.1 MCMCpack MCMCpack R example2.r MCMCpackage 1 > library ( MCMCpack ) data y =0, =1 1 > x <- c(0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10) 2 > y <- c(1, 2, 2, 6, 4, 5, 8, 9, 9, 9, 10) 3 > k < > data <- data. frame (x = rep (x, each = k), 5 + y = c( sapply (y, function (i) 6 + c( rep (0, k - i), rep (1, i ))))) y x MCMClogit() MCMClogit() MCMCpack chain 3 burn-in 2000 burn-in > chains <- 1:3 2 > inits <- c(1, 10, 20) 3 > seeds <- c(12, 123, 1234) 4 > post <- lapply ( chains, 5 + function ( chain ) { 6 + MCMClogit ( y ~ x, 7 + data = data, 8 + burnin = 2000, mcmc = 2000, 9 + thin = 2, 10 + tune = 1.1, verbose = 500, 11 + seed = seeds [ chain ]) 12 + }) MCMClogit iteration 1 of beta = Metropolis acceptance rate for beta = : 22 :

17 23 24 MCMClogit iteration 3501 of beta = Metropolis acceptance rate for beta = The Metropolis acceptance rate for beta was mcmc.list ( 7) 1 > post. mcmc <- mcmc. list ( post ) 2 > plot ( post. mcmc ) Trace of (Intercept) Density of (Intercept) Iterations N = 1000 Bandwidth = Trace of x Density of x Iterations N = 1000 Bandwidth = coda plot (MCMCpack)

18 Gelman-Rubin (ˆR) 1 > gelman. diag ( post. mcmc ) 2 Potential scale reduction factors : 3 4 Point est. Upper C.I. 5 ( Intercept ) x Multivariate psrf > summary ( post. mcmc ) 2 3 Iterations = 2001: Thinning interval = 2 5 Number of chains = 3 6 Sample size per chain = Empirical mean and standard deviation for each variable, 9 plus standard error of the mean : Mean SD Naive SE Time - series SE 12 ( Intercept ) x Quantiles for each variable : % 25% 50% 75% 97. 5% 18 ( Intercept ) x % x % JAGS JAGS R example2_jags.r R JAGS rjags 1 > library ( rjags )

19 R 1 > k < > x <- c(0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10) 3 > y <- c(1, 2, 2, 6, 4, 5, 8, 9, 9, 9, 10) 4 > n <- length (x) BUGS example2_model.txt MCMCpack MCMClogit() 1 model { 2 for (i in 1:N) { 3 Y[i] ~ dbin (p[i], K) 4 logit (p[i]) <- beta + beta.x * X[i] 5 } 6 beta ~ dnorm (0, 1.0 E -6) 7 beta.x ~ dnorm (0, 1.0E -6) 8 } 2 5 for for X[i], Y[i], p[i] i i 1, 2,..., N dbin(p, n) Binomial(n, p) p n ~ ( ) logit(p) logit(p) = log(p/(1 p)) Y K p p X 6 7 beta beta.x beta beta.x Normal(0, 10 6 ) BUGS dnorm() 1 2 ( ~ ) ( <- ) Pr(β, β x X, Y ) L(X, Y β, β x ) Pr(β) Pr(β x ) (6) N L(X, Y β, β x ) = Binomial(Y i K, p(x i )) = i=1 N i=1 K! Y i!(k Y i )! p(x i) Y i (1 p(x i )) K Y i (7)

20 p(x i ) = logit 1 (β + β x X i )) = exp(β + β xx i ) 1 + exp(β + β x X i ) Pr(β) = Normal(0, 10 6 ) (9) Pr(β x ) = Normal(0, 10 6 ) (10) (8) chain 1 > ## Number of chains 2 > n. chains <- 3 3 > 4 > ## Initial values 5 > inits <- vector (" list ", n. chains ) 6 > inits [[1]] <- list ( beta = -10, beta.x = 0, 7 +. RNG. seed = 314, 8 +. RNG. name = " base :: Mersenne - Twister ") 9 > inits [[2]] <- list ( beta = -5, beta.x = 2, RNG. seed = 3141, RNG. name = " base :: Mersenne - Twister ") 12 > inits [[3]] <- list ( beta = 0, beta.x = 4, RNG. seed = 31415, RNG. name = " base :: Mersenne - Twister ") 15 > 16 > ## Model file 17 > model. file <- " example2_model. txt " 18 > 19 > ## Parameters 20 > pars <- c(" beta ", " beta.x") n.chains inits rjags chain 3 beta beta.x chain (.RNG.seed) (.RNG.name) (model.file) (pars) beta beta.x jags.mode() JAGS chain MCMC (adaptation) adapt

21 R 100% 1 > model <- jags. model ( file = model. file, 2 + data = list (N = n, K = k, 3 + X = x, Y = y), 4 + inits = inits, n. chains = n. chains, 5 + n. adapt = 1000) % update() burn-in n.adapt n.iter MCMCpack burn-in 1 > update ( model, n. iter = 1000) 2 ************************************************** 100% coda.samples() MCMC coda.samples() coda jags jags.samples() chain > post. samp <- coda. samples ( model, n. iter = 3000, thin = 3, 2 + variable. names = pars ) 3 ************************************************** 100% 8 1 > plot ( post. samp ) chain chain gelman.diag() Gelman-Rubin > gelman. diag ( post. samp ) 2 Potential scale reduction factors : 3 4 Point est. Upper C.I. 5 beta beta. x Multivariate psrf

22 Trace of beta Density of beta Iterations N = 1000 Bandwidth = Trace of beta.x Density of beta.x Iterations N = 1000 Bandwidth = coda plot (JAGS) 1 > summary ( post. samp ) 2 3 Iterations = 2003: Thinning interval = 3 5 Number of chains = 3 6 Sample size per chain = Empirical mean and standard deviation for each variable, 9 plus standard error of the mean : Mean SD Naive SE Time - series SE 12 beta beta. x Quantiles for each variable : 16

23 17 2.5% 25% 50% 75% 97. 5% 18 beta beta. x beta % beta.x % X Y Y 1 > beta <- unlist ( post. samp [, " beta "]) 2 > beta.x <- unlist ( post. samp [, " beta.x "]) 3 > 4 > new. x <- seq (0, 10, len = 100) 5 > logit.p <- beta + beta.x %o% new.x 6 > exp.y <- k * exp ( logit.p) / (1 + exp ( logit.p)) 7 > y. mean <- apply ( exp.y, 2, mean ) 8 > y.975 <- apply ( exp.y, 2, quantile, probs = 0.975) 9 > y.025 <- apply ( exp.y, 2, quantile, probs = 0.025) 10 > y.995 <- apply ( exp.y, 2, quantile, probs = 0.995) 11 > y.005 <- apply ( exp.y, 2, quantile, probs = 0.005) 12 > 13 > plot (x, y, type = "p", ylim = c(0, 10), las = 1) 14 > lines ( new.x, y.mean, lty = 1) 15 > lines ( new.x, y.975, lty = 2) 16 > lines ( new.x, y.025, lty = 2) 17 > lines ( new.x, y.995, lty = 3) 18 > lines ( new.x, y.005, lty = 3) 19 > legend (" bottomright ", 20 + legend = c(" mean ", "95% interval ", "99% interval "), 21 + lty = c(1, 2, 3)) post.samp chain 1 2 unlist() X MCMC Y 9

24 y mean 95% 99% x Y Stan Stan R example2_stan.r RStan 1 > library ( rstan ) example2_code 1 > example2_ code <- " 2 + data { 3 + int < lower =0 > N; 4 + int < lower =0 > K; 5 + int < lower =0 > X[N]; 6 + int < lower =0 > Y[N]; 7 + } 8 + parameters { 9 + real beta ; 10 + real beta_ x ; 11 + } 12 + transformed parameters { 13 + real < lower =0, upper =1 > p[n]; 14 +

25 15 + for (i in 1:N) { 16 + p[i] <- inv_logit ( beta + beta_x * X[i ]); 17 + } 18 + } 19 + model { 20 + Y ~ binomial (K, p); # priors 23 + beta ~ normal (0.0, 1.0 e +3); 24 + beta_ x ~ normal (0.0, 1.0 e +3); 25 + } 26 + " Stan data parameters transformed parameters model. _ (;) chain 1 > n. chains <- 3 2 > inits <- vector (" list ", 3) 3 > inits [[1]] <- list ( beta = -10, beta_x = 0) 4 > inits [[2]] <- list ( beta = -5, beta_x = 2) 5 > inits [[3]] <- list ( beta = 0, beta_x = -2) 6 > pars <- c(" beta ", " beta_x ") stan() Stan fit 1 > fit <- stan ( model_ code = example2_ code, 2 + data = list (X = x, Y = y, N = n, K = k), 3 + pars = pars, init = inits, seed = 123, 4 + chains = n. chains, 5 + iter = 2500, warmup = 500, thin = 2) warmup burn-in [7] 1 > print ( fit ) 2 Inference for Stan model : b08b951f11fe4269ab8d08c9ec. 3 3 chains, each with iter =2500; warmup =500; thin =2; 4 post - warmup draws per chain =1000, total post - warmup draws = mean se_mean sd 2.5% 25% 50% 75% 97.5% n_eff Rhat 7 beta beta_x

26 9 lp Samples were drawn using NUTS ( diag_e ) at Wed Oct 7 14:10: For each parameter, n_eff is a crude measure of effective sample size, 13 and Rhat is the potential scale reduction factor on split chains ( at 14 convergence, Rhat =1). lp MCMC R MCMC WinBUGS OpenBUGS? ~ <-? ( () {} )? typo??? :? 2 : MCMC MCMC??? Markov chain

27 X 1, X 2, Y Y X 1 X 2 ( ) example3.csv 1 > data <- read. csv (" example3. csv ") 10 1 > head (data, 10) 2 block x1 x2 y > pairs ( data ) JAGS R example3.r BUGS 1 > n. block <- max ( data$block ) # number of blocks 2 > n. data <- nrow ( data ) / n. block # number of data in a block 3 >

28 block x1 x y > x1 <- t( matrix ( data$x1, nrow = n.data, ncol = n. block )) 5 > x2 <- t( matrix ( data$x2, nrow = n.data, ncol = n. block )) 6 > y <- t( matrix ( data$y, nrow = n.data, ncol = n. block )) x1 1 > print (x1) 2 [,1] [,2] [,3] [,4] [,5] 3 [1,] [2,] [3,] [4,] [5,] [6,] [7,] [8,]

29 ϵ Bi i σ B Y ij Normal(µ ij, σ 2 ) µ ij = β + β 1 X 1ij + β 2 X 2ij + ϵ Bi ϵ Bi Normal(0, σb) 2 µ ij i j σ β β 1 β 2 X 1 X 2 BUGS example3_model.txt 1 var 2 M, # Number of blocks 3 N, # Number of observations 4 X1[N], X2[N], # Data 5 Y[N], 6 B[N], # Block 7 e.b[m], # Random effect 8 beta, beta.1, beta.2, # Parameters 9 tau, sigma, 10 tau. B, sigma. B; # Hyperparameters model { 13 for (i in 1:N) { 14 Y[i] ~ dnorm (mu[i], tau ) 15 mu[i] <- beta + beta.1 * X1[i] + 16 beta.2 * X2[i] + e.b[b[i]] 17 } 18 for (i in 1:M) { 19 e.b[i] ~ dnorm (0, tau.b) 20 } ## Priors 23 beta ~ dnorm (0, 1.0 E -6) 24 beta.1 ~ dnorm (0, 1.0E -6) 25 beta.2 ~ dnorm (0, 1.0E -6) 26 tau <- 1 / ( sigma * sigma ) 27 tau.b <- 1 / ( sigma.b * sigma.b) 28 sigma ~ dunif (0, 1.0 E +4) 29 sigma.b ~ dunif (0, 1.0 E +4) 30 } BUGS

30 e.b[] 0 1/tau.B (tau.b = 1/sigma.B 2 ) 18 sigma.b [0, 10000] 28 tau.b(sigma.b) e.b[] (hyperparameter) 11 data X 1 X 2 Y process Pr(X 1, X 2,Y β,β 1,β 2,τ,e) parameter β β 1 β 2 τ e hyperparameter τ e 11 rjags JAGS bugs 2 1 > library ( rjags ) 2 > load. module (" glm ") 3 > 4 > ## Model file 5 > model. file <- " example3_model. txt " 6 > 7 > ## Number of chains

31 8 > n. chains <- 3 9 > 10 > ## Initial values 11 > inits <- vector (" list ", n. chains ) 12 > inits [[1]] <- list ( beta = 5, beta.1 = 0, beta.2 = 0, 13 + sigma = 1, sigma. B = 1, RNG. seed = 123, RNG. name = " base :: Mersenne - Twister ") 16 > inits [[2]] <- list ( beta = -5, beta.1 = 10, beta.2 = 10, 17 + sigma = 10, sigma. B = 10, RNG. seed = 1234, RNG. name = " base :: Mersenne - Twister ") 20 > inits [[3]] <- list ( beta = 0, beta.1 = -10, beta.2 = -10, 21 + sigma = 5, sigma. B = 5, RNG. seed = 12345, RNG. name = " base :: Mersenne - Twister ") 24 > 25 > ## Parameters 26 > pars <- c(" beta ", " beta.1", " beta.2", 27 + " sigma ", " sigma.b", "e.b") 28 > 29 > ## MCMC 30 > model <- jags. model ( file = model. file, 31 + data = list (M = n. block, N = n.data, 32 + X1 = x1, X2 = x2, Y = y), 33 + inits = inits, n. chains = n. chains, 34 + n. adapt = 1000) % 36 > 37 > ## Burn -in 38 > update ( model, n. iter = 1000) 39 ************************************************** 100% 40 > 41 > ## Sampling 42 > post. samp <- coda. samples ( model, n. iter = 5000, thin = 5, 43 + variable. names = pars ) 44 ************************************************** 100% 1 > gelman. diag ( post. samp ) 2 Potential scale reduction factors : 3 4 Point est. Upper C.I. 5 beta

32 6 beta beta e.b [1] e.b [2] e.b [3] e.b [4] e.b [5] e.b [6] e.b [7] e.b [8] sigma sigma.b Multivariate psrf > summary ( post. samp ) Iterations = 2005: Thinning interval = 5 26 Number of chains = 3 27 Sample size per chain = Empirical mean and standard deviation for each variable, 30 plus standard error of the mean : Mean SD Naive SE Time - series SE 33 beta beta beta e. B [1] e. B [2] e. B [3] e. B [4] e. B [5] e. B [6] e. B [7] e. B [8] sigma sigma. B Quantiles for each variable : % 25% 50% 75% 97. 5% 50 beta

33 51 beta beta e. B [1] e. B [2] e. B [3] e. B [4] e. B [5] e.b [6] e. B [7] e. B [8] sigma sigma. B e.b[] 12 Posterior distribution of e.b[] density value 12 e.b[] Nested Indexing 2 Nested Indexing BUGS example3-1_model.txt

34 1 > data <- read. csv (" example3. csv ") 2 > n. block <- 8 # number of blocks 3 > n. row <- nrow ( data ) # number of observations data$block 1 > data$block 2 [1] [27] X1 X2 Y B 6 e.b B 16 1 var 2 M, # Number of blocks 3 N, # Number of observations 4 X1[N], X2[N], # Data 5 Y[N], 6 B[N], # Block 7 e.b[m], # Random effect 8 beta, beta.1, beta.2, # Parameters 9 tau, sigma, 10 tau. B, sigma. B; # Hyperparameters model { 13 for (i in 1:N) { 14 Y[i] ~ dnorm (mu[i], tau ) 15 mu[i] <- beta + beta.1 * X1[i] + 16 beta.2 * X2[i] + e.b[b[i]] 17 } 18 for (i in 1:M) { 19 e.b[i] ~ dnorm (0, tau.b) 20 } ## Priors 23 beta ~ dnorm (0, 1.0 E -6) 24 beta.1 ~ dnorm (0, 1.0E -6) 25 beta.2 ~ dnorm (0, 1.0E -6) 26 tau <- 1 / ( sigma * sigma ) 27 tau.b <- 1 / ( sigma.b * sigma.b) 28 sigma ~ dunif (0, 1.0 E +4) 29 sigma.b ~ dunif (0, 1.0 E +4)

35 30 } jags.model() data 1 model <- jags. model ( file = model.file, 2 data = list (M = n. block, N = n.data, 3 X1 = data$x1, X2 = data$x2, 4 Y = data$y, B = data$block ), 5 inits = inits, n. chains = n. chains, 6 n. adapt = 1000) (centering) (centering) [23] Box beta.1 * X1[i] beta.1 * (X1[i] - X1.bar) (X1.bar X1 ) JAGS glm (JAGS User s Manual[25] 4.6 ) m 1m 36 example4.csv 1 " Plot "," Num "," Light " 2 1,0, ,0, ,3, : 6 36,1,0.412 Plot Num Light (%) 13 log GLM

36 5 4 3 Num Light 13 1 > summary ( glm ( Num ~ Light, family = poisson, data = data )) 2 3 Call : 4 glm ( formula = Num ~ Light, family = poisson, data = data ) 5 6 Deviance Residuals : 7 Min 1 Q Median 3 Q Max Coefficients : 11 Estimate Std. Error z value Pr ( > z ) 12 ( Intercept ) Light ( Dispersion parameter for poisson family taken to be 1) Null deviance : on 35 degrees of freedom 18 Residual deviance : on 34 degrees of freedom 19 AIC : Number of Fisher Scoring iterations : 6 (Residual deviance) (degree of freedom) 2

37 (overdispersion) 0 14 (Zero-inflated) 0 (Zero-Inflated Poisson model; ZIP model) Frequency Number of seedlings 14 ZIP BUGS 1 var 2 N, # Number of observations 3 Y[N], # Number of new seedlings 4 X[N], # Proportion of open canopy 5 lambda [N], # Poisson mean 6 z[ N], # 0: absent, 1: at least latently present 7 p, # Probability of the presence ( at least latently ) 8 beta, # Intercept in the linear model 9 beta. x; # Coefficient of X in the linear model 10 model { 11 for (i in 1:N) { 12 Y[i] ~ dpois ( lambda [i]) 13 lambda [i] <- z[i] * exp ( beta + beta.x * X[i]) 14 z[i] ~ dbern (p) 15 }

38 16 ## Priors 17 p ~ dunif (0, 1) 18 beta ~ dnorm (0, 1.0 E -4) 19 beta.x ~ dnorm (0, 1.0E -4) 20 } z = 0 2. z = 1 0 Poisson(0 λ) z 0 1 p λ log λ = β + β x X rjags burn-in > summary ( post. samp ) 2 3 Iterations = 2010: Thinning interval = 10 5 Number of chains = 3 6 Sample size per chain = Empirical mean and standard deviation for each variable, 9 plus standard error of the mean : Mean SD Naive SE Time - series SE 12 beta beta. x p Quantiles for each variable : % 25% 50% 75% 97. 5% 19 beta beta. x p p % beta beta.x % GLM 0.177

39 4 Models for Ecological Data [3], Hierarchical modelling for the environmental sciences [4], Introduction to WinBUGS for ecologists [12], Bayesian population analysis using WinBUGS [13], Bayesian methods for ccology [23] [17] GLM GLMM 2009 [15] [5] [34] [35] Hamiltonian Monte Carlo Vol.1 [11] JAGS Stan * 15 MCMC [1] Bishop C.M. (2006) Pattern recognition and machine learning. Springer-Verlag, New York. : (2012) /, [2] Brooks S., Gelman A., Jones G.L., Meng X.-L. (2011) Handbook of Markov chain Monte Carlo. Chapman & Hall/CRC, Boca Raton. [3] Clark J.S. (2007) Models for ecological data. Princeton University Press, Princeton. [4] Clark J.S., Gelfand A.E. (2006) Hierarchical modelling for the environmental sciences. Oxford University Press, New York. [5] (2009). 59: [6] (2008) R & WinBUGS.,. [7] Gelman A, Carlin J.B., Stern H.S., Dunson D.B., Vehtari A., Rubin D.B. (2014) Bayesian data analysis, 3rd ed. Chapman & Hall/CRC, Boca Raton. *15

40 [8] Gilks W.R., Richardson S.R., Spiegelhalter D.J. (eds.) (1996) Markov chain Monte Carlo in practice. Chapman & Hall/CRC, Boca Raton. [9] (2003).,. [10] (2005). ( ( ) II, ): [11] ( ) (2015) Vol.1.,. [12] Kéry M. (2010) Introduction to WinBUGS for ecologists: a Bayesian approach to regression, ANOVA, mixed models and related analyais. Academic Press, Waltham. [13] Kéry M, Schaub M. (2011) Bayesian population analysis using WinBUGS. Academic Press, Waltham. [14] Kruschke J. (2014) Doing Bayesian data analysis, 2nd ed.: a tutorial with R, JAGS, and Stan. Academic Press, Waltham. [15] (2009). 59: [16] (2009) [I]. 92: [17] (2012) MCMC.,. [18] (2010).,. [19] Link, W.A., Eaton, M.J. (2012) On thinning of chains in MCMC. Methods in Ecology and Evolution 3: doi: /j X x [20] Lunn D., Spiegelhalter D., Thomas A., Best N. (2009) The BUGS project: Evolution, critique, and future directions. Statistics in Medicine 28: [21] Lunn D., Jackson C, Besk N., Thomas A., Spiegelhalter D. (2012) The BUGS Book. Chapman & Hall/CRC, Boca Raton. [22] Martin A.D., Quinn, K.M. (2006) Applied Bayesian inference in R using MCMCpack. R News 6(1): [23] McCarthy M.A. (2007) Bayesian methods for ecology. Cambridge University Press, New York. : (2009),. [24] Ntzoufras I. (2009) Bayesian modeling using WinBUGS. Wiley, Hoboken. [25] Plummer M. (2015) JAGS version user manual. [26] R Core Team (2015) R: A Language and Environment for Statistical Computing. R Foundation for Statistical Computing, Vienna.

41 [27] Robert C.P., Casella G. (2010) Introducing Monte Carlo Methods with R. Springer, New York. : (2012) R,. [28] Spiegelhalter D., Tomas A., Best N., Lunn D. (2003) WinBUGS user manual version [29] Stan Development Team (2015) Stan Modeling Language: User s Guide and Reference Manual, Version [30] (2000).,. [31] (2010) R.,. [32] Thomas A. (2006) The BUGS language. R News 6(1): [33] Thomas A., O Hara B., Ligges U., Sturtz S. (2006) Making BUGS open. R News 6(1): [34] (2008).,. [35] ( ) (2015).,. [36] (2005). ( ( ), ): [37] (2012).,.

Vol. 15 No. 1 JOURNAL OF HARBIN UNIVERSITY OF SCIENCE AND TECHNOLOGY Feb O21 A

Vol. 15 No. 1 JOURNAL OF HARBIN UNIVERSITY OF SCIENCE AND TECHNOLOGY Feb O21 A 5 200 2 Vol 5 No JOURNAL OF HARBIN UNIVERSITY OF SCIENCE AND TECHNOLOGY Feb 200 2 2 50080 2 30024 O2 A 007-2683 200 0-0087- 05 A Goodness-of-fit Test Based on Empirical Likelihood and Application ZHOU

More information

(baking powder) 1 ( ) ( ) 1 10g g (two level design, D-optimal) 32 1/2 fraction Two Level Fractional Factorial Design D-Optimal D

(baking powder) 1 ( ) ( ) 1 10g g (two level design, D-optimal) 32 1/2 fraction Two Level Fractional Factorial Design D-Optimal D ( ) 4 1 1 1 145 1 110 1 (baking powder) 1 ( ) ( ) 1 10g 1 1 2.5g 1 1 1 1 60 10 (two level design, D-optimal) 32 1/2 fraction Two Level Fractional Factorial Design D-Optimal Design 1. 60 120 2. 3. 40 10

More information

Microsoft Word - p11.doc

Microsoft Word - p11.doc () 11-1 ()Classification Analysis( ) m() p.d.f prior (decision) (loss function) Bayes Risk for any decision d( ) posterior risk posterior risk Posterior prob. j (uniform prior) where Mahalanobis Distance(M-distance)

More information

统 计 说 编 辑 天 津 财 经 大 学 统 计 系 研 究 生 地 址 天 津 市 河 西 区 珠 江 道 25 号 邮 编 300222 名 誉 主 编 刘 乐 平 编 委 会 委 员 刘 旭 谢 惊 时 梁 明 峰 逯 敏 蔡 玉

统 计 说 编 辑 天 津 财 经 大 学 统 计 系 研 究 生 地 址 天 津 市 河 西 区 珠 江 道 25 号 邮 编 300222  名 誉 主 编 刘 乐 平 编 委 会 委 员 刘 旭 谢 惊 时 梁 明 峰 逯 敏 蔡 玉 统 计 说 编 辑 天 津 财 经 大 学 统 计 系 研 究 生 地 址 天 津 市 河 西 区 珠 江 道 25 号 邮 编 300222 E-mail statistics_say@163.com 名 誉 主 编 刘 乐 平 编 委 会 委 员 刘 旭 谢 惊 时 梁 明 峰 逯 敏 蔡 玉 兰 曲 辰 闫 超 高 磊 杨 娜 石 作 苗 郎 卫 宇 金 莉 田 静 王 洋 袁 远 孙 丹 丹

More information

: 29 : n ( ),,. T, T +,. y ij i =, 2,, n, j =, 2,, T, y ij y ij = β + jβ 2 + α i + ɛ ij i =, 2,, n, j =, 2,, T, (.) β, β 2,. jβ 2,. β, β 2, α i i, ɛ i

: 29 : n ( ),,. T, T +,. y ij i =, 2,, n, j =, 2,, T, y ij y ij = β + jβ 2 + α i + ɛ ij i =, 2,, n, j =, 2,, T, (.) β, β 2,. jβ 2,. β, β 2, α i i, ɛ i 2009 6 Chinese Journal of Applied Probability and Statistics Vol.25 No.3 Jun. 2009 (,, 20024;,, 54004).,,., P,. :,,. : O22... (Credibility Theory) 20 20, 80. ( []).,.,,,.,,,,.,. Buhlmann Buhlmann-Straub

More information

Chinese Journal of Applied Probability and Statistics Vol.25 No.4 Aug (,, ;,, ) (,, ) 应用概率统计 版权所有, Zhang (2002). λ q(t)

Chinese Journal of Applied Probability and Statistics Vol.25 No.4 Aug (,, ;,, ) (,, ) 应用概率统计 版权所有, Zhang (2002). λ q(t) 2009 8 Chinese Journal of Applied Probability and Statistics Vol.25 No.4 Aug. 2009,, 541004;,, 100124),, 100190), Zhang 2002). λ qt), Kolmogorov-Smirov, Berk and Jones 1979). λ qt).,,, λ qt),. λ qt) 1,.

More information

1

1 015 年 ( 第 四 届 ) 全 国 大 学 生 统 计 建 模 大 赛 参 赛 论 文 论 文 名 称 : 打 车 软 件 影 响 下 的 西 安 市 出 租 车 运 营 市 场 研 究 和 统 计 分 析 参 赛 学 校 : 西 安 理 工 大 学 参 赛 队 员 : 刘 二 嫚 余 菲 王 赵 汉 指 导 教 师 : 王 金 霞 肖 燕 婷 提 交 日 期 :015 年 6 月 9 日 1

More information

建築工程品質管理案例研討

建築工程品質管理案例研討 1.1...2-1 1.2...2-2 1.3...2-2 2.1...2-3 2.2...2-3 2.3...2-8 3.1...2-11 3.2...2-12 3.3...2-15 3.4...2-16 3.5...2-17 4.1...2-19 4.2...2-19 4.3...2-22 4.4...2-24 4.5...2-26 4.6...2-28 5.1...2-29 5.2...2-32

More information

11第十一章階層線性模式.DOC

11第十一章階層線性模式.DOC 11.1 11.1.1 (student-level) (personal-level) ( ) (school-level) (organization-level) ( ) 1. (disaggregation) (estimated standard errors) (type one error). (aggregation) (within-group) (1997) (hierarchical

More information

)

) .. 1. 2. ) () () Pilot test () 1. 2. 3. 4. Scale (1). (nominal scale) 1. 2. 3. (1,2,3) (scale value) (arithmetic mean) (median) (mode) (chi-square test) (2). (ordinal scale) 5 1 A>B>C>D>E A B C D (non-parametric

More information

untitled

untitled TFT-LCD Mura & Y.H. Tseng 2006.12.4 Outline Mura Mura Mura 類 度 Mura Mura JND Mura Convolution filter (Filter design) Statistical method (ANOVA,EWMA) Backgroup estimation (LSD) 2 What is Mura- Mura Mura

More information

1208 Chin J Dis Control Prev 2018 Dec2212 gross domestic β 2 β 3 β 4 β 5 product GDP GTWPR geographically and temporally weighted poisson regression G

1208 Chin J Dis Control Prev 2018 Dec2212 gross domestic β 2 β 3 β 4 β 5 product GDP GTWPR geographically and temporally weighted poisson regression G 2018 12 22 12 1207 2011-2016 2011-2016 31 gross do mestic productgdp R 2 AIC MSE R 512. 91 A 1674-3679201812-1207-05 DOI10. 16462 /j. cnki. zhjbkz. 2018. 12. 002 Temporal-spatial characteristic analysis

More information

[9] R Ã : (1) x 0 R A(x 0 ) = 1; (2) α [0 1] Ã α = {x A(x) α} = [A α A α ]. A(x) Ã. R R. Ã 1 m x m α x m α > 0; α A(x) = 1 x m m x m +

[9] R Ã : (1) x 0 R A(x 0 ) = 1; (2) α [0 1] Ã α = {x A(x) α} = [A α A α ]. A(x) Ã. R R. Ã 1 m x m α x m α > 0; α A(x) = 1 x m m x m + 2012 12 Chinese Journal of Applied Probability and Statistics Vol.28 No.6 Dec. 2012 ( 224002) Euclidean Lebesgue... :. : O212.2 O159. 1.. Zadeh [1 2]. Tanaa (1982) ; Diamond (1988) (FLS) FLS LS ; Savic

More information

ii

ii i 概 率 统 计 讲 义 原 著 : 何 书 元 课 件 制 作 : 李 东 风 2015 年 秋 季 学 期 ii 目 录 第 一 章 古 典 概 型 和 概 率 空 间 3 1.1 试 验 与 事 件............................ 3 1.2 古 典 概 型 与 几 何 概 型....................... 7 1.2.1 古 典 概 型.........................

More information

1970 Roulac (1996) (shock) (structure change) Barras and Ferguson (1985) Barras (1994) (1990) (1996) (1997) 1

1970 Roulac (1996) (shock) (structure change) Barras and Ferguson (1985) Barras (1994) (1990) (1996) (1997) 1 1970 Roulac (1996) (shock) (structure change) Barras and Ferguson (1985) Barras (1994) (1990) (1996) (1997) 1 (1998) 1990 (Unit Root Test) (Cointegration) (Error Correction Model) 1 (1996) 2 (1990) 2 Barras

More information

经 济 与 管 理 耿 庆 峰 : 我 国 创 业 板 市 场 与 中 小 板 市 场 动 态 相 关 性 实 证 研 究 基 于 方 法 比 较 视 角 87 Copula 模 型 均 能 较 好 地 刻 画 金 融 市 场 间 的 动 态 关 系, 但 Copula 模 型 效 果 要 好 于

经 济 与 管 理 耿 庆 峰 : 我 国 创 业 板 市 场 与 中 小 板 市 场 动 态 相 关 性 实 证 研 究 基 于 方 法 比 较 视 角 87 Copula 模 型 均 能 较 好 地 刻 画 金 融 市 场 间 的 动 态 关 系, 但 Copula 模 型 效 果 要 好 于 第 19 卷 第 6 期 中 南 大 学 学 报 ( 社 会 科 学 版 ) Vol.19 No.6 013 年 1 月 J. CENT. SOUTH UNIV. (SOCIAL SCIENCE) Dec. 013 我 国 创 业 板 市 场 与 中 小 板 市 场 动 态 相 关 性 实 证 研 究 基 于 方 法 比 较 视 角 耿 庆 峰 ( 闽 江 学 院 公 共 经 济 学 与 金 融 学

More information

( ) ( ) ( NSC M )

( ) ( ) ( NSC M ) ( ) ( ) ( NSC 84-2121-M004-009) 2 ( 1) Minitab SPlus ( 1): 3 1.1 1.2 4 2 (1980) ( 1952 ) (Significant difference (Two sample) (Change-point problem (1980) ( t-test) (Chi-square test) 5 ( 2 P187 2.1 2.1.1

More information

untitled

untitled 01 1-1 1-2 1-3 Chapter 1-1 (statistics) (uncertainty) 1. (1) (descriptive statistics) (2) (inferential statistics) (statistical inference) (inductive statistics) (parametric statistics) (nonparametric

More information

* UNDP Volunteering Australia * 10 94

* UNDP Volunteering Australia * 10 94 * UNDP 2011 2002 2008 Volunteering Australia 2009 2005 * 10 94 10 20 60 2009 Schwartz 1973 1. 2. 3. Banks 1997 Rochon 1999 Wilson & Musick 1997 Herzog et al. 1989 McAdam 1989 Smith 95 2012. 5 1994 Wilson

More information

第一章合成.ppt

第一章合成.ppt plsun@mail.neu.edu.cn 1. 2. 3. 4. 5. 1. Mathematical Statistics R.V.Hogg ( 1979) 2. Statistics -The Conceptual Approach G. R. Iversen, ed ( - 2000) 3. Mathematical Statistics and Data Analysis J. A. Rice

More information

Stochastic Processes (XI) Hanjun Zhang School of Mathematics and Computational Science, Xiangtan University 508 YiFu Lou talk 06/

Stochastic Processes (XI) Hanjun Zhang School of Mathematics and Computational Science, Xiangtan University 508 YiFu Lou talk 06/ Stochastic Processes (XI) Hanjun Zhang School of Mathematics and Computational Science, Xiangtan University hjzhang001@gmail.com 508 YiFu Lou talk 06/04/2010 - Page 1 Outline 508 YiFu Lou talk 06/04/2010

More information

( ) t ( ) ( ) ( ) ( ) ( ) t-

( ) t ( ) ( ) ( ) ( ) ( ) t- (Statistics). (Descriptive Statistics). (Inferential Statistics) (Inductive Statistics) ( ) t ( ) ( ) ( ) ( ) ( ) t- ( ) ( ) ( )? ( ) ( )? ( ) )?( t ) ( )? ( ) ( ) ( ) ( ) ( ) ( )? ( ) ( ) ( )? ( )?( t

More information

國立屏東教育大學碩士班研究生共同修業要點

國立屏東教育大學碩士班研究生共同修業要點 目 錄 壹 國 立 屏 東 大 學 碩 士 班 研 究 生 共 同 修 業 辦 法...1 貳 國 立 屏 東 大 學 應 用 數 學 系 碩 士 班 研 究 生 修 業 要 點...5 參 應 用 數 學 系 碩 士 班 課 程 結 構...9 肆 應 用 數 學 系 專 任 師 資 簡 介...15 伍 應 用 數 學 系 碩 士 班 歷 屆 研 究 生 論 文 資 料...17 附 錄 一 國

More information

% 5 CPI CPI PPI Benjamin et al Taylor 1993 Cukierman and Gerlach 2003 Ikeda 2013 Jonas and Mishkin

% 5 CPI CPI PPI Benjamin et al Taylor 1993 Cukierman and Gerlach 2003 Ikeda 2013 Jonas and Mishkin 2016 9 435 No. 9 2016 General No. 435 130012 1996 1-2016 6 LT - TVP - VAR LT - TVP - VAR JEL E0 F40 A 1002-7246201609 - 0001-17 2016-03 - 20 Emailjinquan. edu. cn. Email1737918817@ qq. com. * 15ZDC008

More information

C/C++语言 - 运算符、表达式和语句

C/C++语言 - 运算符、表达式和语句 C/C++ Table of contents 1. 2. 3. 4. C C++ 5. 6. 7. 1 i // shoe1.c: # include # define ADJUST 7. 64 # define SCALE 0. 325 int main ( void ) { double shoe, foot ; shoe = 9. 0; foot = SCALE * shoe

More information

untitled

untitled SC 93246H327032 (EWMA) 3 EWMA (defects) (Poisson distribution) (compound Poisson process) Brook and Evans EWMA (ARL) EWMA (geometric Poisson EWMA control schemes) The Study on Detecting Small Shifts in

More information

Microsoft PowerPoint - Lecture7II.ppt

Microsoft PowerPoint - Lecture7II.ppt Lecture 8II SUDOKU PUZZLE SUDOKU New Play Check 軟體實作與計算實驗 1 4x4 Sudoku row column 3 2 } 4 } block 1 4 軟體實作與計算實驗 2 Sudoku Puzzle Numbers in the puzzle belong {1,2,3,4} Constraints Each column must contain

More information

Microsoft Word - Probability.doc

Microsoft Word - Probability.doc 十 一 機 率 (Probability).... 分 立 變 值 (discrete variate) 及 連 續 變 值 (continuous variate)..... 連 續 變 質 (Continuous variate)/ 連 續 變 數 (Continuous variable)..... 分 立 變 值 (Discrete variate)/ 間 斷 變 數 (Discrete variable)....

More information

% % 34

% % 34 * 2000 2005 1% 1% 1% 1% * VZDA2010-15 33 2011. 3 2009 2009 2004 2008 1982 1990 2000 2005 1% 1 1 2005 1% 34 2000 2005 1% 35 2011. 3 2000 0. 95 20-30 209592 70982 33. 9% 2005 1% 258 20-30 372301 115483 31.

More information

統計課程目錄95

統計課程目錄95 統 計 課 程 10.0.1 起 統 計 學 上 課 講 義 : 上 課 內 容 老 師 自 訂 講 義 參 考 書 籍 : 統 計 學 3 版 劉 明 德 著 全 華 出 版 實 用 統 計 學 ( 第 二 版 ) 東 華 書 局 林 真 真 著 上 課 內 容 : 基 本 統 計 理 論 概 念, 由 老 師 授 課 學 生 需 配 合 練 習 成 績 計 算 : 平 時 ( 含 出 席 尚 可

More information

Previous Next First Last Ba

Previous Next First Last Ba zwp@ustc.edu.cn Office: 1006 Phone: 63600565 http://staff.ustc.edu.cn/~zwp/ http://fisher.stat.ustc.edu.cn 1.1............... 1 1.2............... 9 1.2.1.......... 16 1.2.2....... 22 1.2.3......... 23

More information

θ 1 = φ n -n 2 2 n AR n φ i = 0 1 = a t - θ θ m a t-m 3 3 m MA m 1. 2 ρ k = R k /R 0 5 Akaike ρ k 1 AIC = n ln δ 2

θ 1 = φ n -n 2 2 n AR n φ i = 0 1 = a t - θ θ m a t-m 3 3 m MA m 1. 2 ρ k = R k /R 0 5 Akaike ρ k 1 AIC = n ln δ 2 35 2 2012 2 GEOMATICS & SPATIAL INFORMATION TECHNOLOGY Vol. 35 No. 2 Feb. 2012 1 2 3 4 1. 450008 2. 450005 3. 450008 4. 572000 20 J 101 20 ARMA TU196 B 1672-5867 2012 02-0213 - 04 Application of Time Series

More information

歯WP02-12-부속물.PDF

歯WP02-12-부속물.PDF KIEP Working Paper 02-12 Has Trade Intensity in ASEAN+3 Really Increased? Evidence from a Gravity Analysis Has Trade Intensity in ASEAN+3 Really Increased? Evidence from a Gravity Analysis Heungchong KIM

More information

( 413 1), (2003) ,,,,

( 413 1), (2003) ,,,, : 3 ( 510632) ( ) :,,,,,, Mahalanobis,, : : ;, (,2002), - (Dow Jones Sustainability Index),, (2001Π394ΠS ),, 2003 1300, 50 %,,, 1 1990 2003 ST, 2004 3 1,1283 200, 514 1 2000 257,2000 1026, 3 2004 4 2004

More information

2014 EduG 6 4 1 subject effect the effect of object of measurement 2 item effect 3 4 random error error confounding 3 universe of admissible observati

2014 EduG 6 4 1 subject effect the effect of object of measurement 2 item effect 3 4 random error error confounding 3 universe of admissible observati * EduG 2014 6 181 FOREIGN LANGUAGE RESEARCH 2014 No. 6 Serial No. 181 200083 3 EduG H319. 5 A 1000-0100 2014 06-0113 - 9 A Brief Introduction to English Teaching Application of the New Generalizability

More information

Experimental design: 實驗設計:

Experimental design: 實驗設計: 2000...2...2...2...3...3...4...6...6...6...6...7...7...7...8...8 RANDOMIZATION...8 CONTROL VARIABLE...9 TRUE EXPERIMENTAL DESIGN...9 PRETEST-POSTTEST CONTROL GROUP DESIGN..9 POST-ONLY CONTROL DESIGN...10

More information

投影片 1

投影片 1 Coherence ( ) Temporal Coherence Michelson Interferometer Spatial Coherence Young s Interference Spatiotemporal Coherence 參 料 [1] Eugene Hecht, Optics, Addison Wesley Co., New York 2001 [2] W. Lauterborn,

More information

untitled

untitled Co-integration and VECM Yi-Nung Yang CYCU, Taiwan May, 2012 不 列 1 Learning objectives Integrated variables Co-integration Vector Error correction model (VECM) Engle-Granger 2-step co-integration test Johansen

More information

Outline Speech Signals Processing Dual-Tone Multifrequency Signal Detection 云南大学滇池学院课程 : 数字信号处理 Applications of Digital Signal Processing 2

Outline Speech Signals Processing Dual-Tone Multifrequency Signal Detection 云南大学滇池学院课程 : 数字信号处理 Applications of Digital Signal Processing 2 CHAPTER 10 Applications of Digital Signal Processing Wang Weilian wlwang@ynu.edu.cn School of Information Science and Technology Yunnan University Outline Speech Signals Processing Dual-Tone Multifrequency

More information

TA-research-stats.key

TA-research-stats.key Research Analysis MICHAEL BERNSTEIN CS 376 Last time What is a statistical test? Chi-square t-test Paired t-test 2 Today ANOVA Posthoc tests Two-way ANOVA Repeated measures ANOVA 3 Recall: hypothesis testing

More information

技 巧 5: 避 免 除 以 0 的 運 算 在 做 除 的 運 算 時, 先 檢 查 除 數 的 數 值, 避 免 有 除 以 0 的 情 況 若 運 算 中 除 數 為 0,SAS 會 在 LOG 中 註 記 提 醒 並 將 運 算 結 果 設 定 為 遺 漏 值, 減 慢 程 式 的 執 行

技 巧 5: 避 免 除 以 0 的 運 算 在 做 除 的 運 算 時, 先 檢 查 除 數 的 數 值, 避 免 有 除 以 0 的 情 況 若 運 算 中 除 數 為 0,SAS 會 在 LOG 中 註 記 提 醒 並 將 運 算 結 果 設 定 為 遺 漏 值, 減 慢 程 式 的 執 行 提 升 SAS 效 率 的 小 技 巧 ( 二 ) 統 計 分 析 師 嚴 友 君 在 使 用 SAS 的 時 候, 效 率 的 考 量 除 了 程 式 運 行 的 時 間, 還 包 括 資 料 佔 用 的 空 間 暫 存 記 憶 體 的 使 用 量 程 式 的 長 度 與 易 讀 性 等 等 以 下 介 紹 一 些 初 學 者 容 易 應 用, 且 在 討 論 使 用 SAS 處 理 分 析 資

More information

90 36 National Life Table Experience Life Table Generalized Linear Models GLM Miller946 Gompertz825 Makeham 860 Makeham Heligman Pollard980 8 Heligman

90 36 National Life Table Experience Life Table Generalized Linear Models GLM Miller946 Gompertz825 Makeham 860 Makeham Heligman Pollard980 8 Heligman 36 3 202 5 Vol. 36No. 3 May 202 89 Population Research * GLM GLM 0 ~ 89 B - GLM 20 90 B - 30007 The Application of Generalized Linear Model in the Graduation of Life Table Mortality Rates Zhang Lianzeng

More information

202,., IEC1123 (1991), GB8051 (2002) [4, 5],., IEC1123,, : 1) IEC1123 N t ( ). P 0 = 0.9995, P 1 = 0.9993, (α, β) = (0.05, 0.05), N t = 72574 [4]. [6

202,., IEC1123 (1991), GB8051 (2002) [4, 5],., IEC1123,, : 1) IEC1123 N t ( ). P 0 = 0.9995, P 1 = 0.9993, (α, β) = (0.05, 0.05), N t = 72574 [4]. [6 2013 4 Chinese Journal of Applied Probability and Statistics Vol.29 No.2 Apr. 2013 (,, 550004) IEC1123,,,., IEC1123 (SMT),,,. :,,, IEC1123,. : O212.3. 1. P.,,,, [1 5]. P, : H 0 : P = P 0 vs H 1 : P = P

More information

<4D F736F F D20BDD7A4E5A4BAA4E5BB50A5D8BFFD2E646F63>

<4D F736F F D20BDD7A4E5A4BAA4E5BB50A5D8BFFD2E646F63> 附錄一最終模型 SIMPLIS 語法 Title: 建模樣本 Observed Variables: x1-x22 covariance matrix from file final01cov means from file final01means sample size: 2181 latent variables: interest instrument anxiety selfconcept

More information

* 1992.10 43 (91.49%) 4 9.51% 26 60.46% 13 4 30.2% 9.31 % 21 6 16 13 45 6 X1=8.16X=40.6 X2 X1 p 0.01 n =43 n =64 51 13 25 18 X1=6.635 X2=18.6 18.6 6.635 P 0.01 n =64 n =43

More information

08_729.dvi

08_729.dvi 2007 55 1 113 124 c 2007 1 1 2,3 Jung Jin Lee 4 2006 8 2 2007 3 2 Jasp Jasp 1., 2005 Chang, 2006 1 1 769 2193 1314 1 2 106 8569 4 6 7 3 106 8569 4 6 7 4 Department of Statistics, Soong Sil University,

More information

Welch & Bishop, [Kalman60] [Maybeck79] [Sorenson70] [Gelb74, Grewal93, Maybeck79, Lewis86, Brown92, Jacobs93] x R n x k = Ax k 1 + Bu k 1 + w

Welch & Bishop, [Kalman60] [Maybeck79] [Sorenson70] [Gelb74, Grewal93, Maybeck79, Lewis86, Brown92, Jacobs93] x R n x k = Ax k 1 + Bu k 1 + w Greg Welch 1 and Gary Bishop 2 TR 95-041 Department of Computer Science University of North Carolina at Chapel Hill 3 Chapel Hill, NC 27599-3175 : 2006 7 24 2007 1 8 1960 1 welch@cs.unc.edu, http://www.cs.unc.edu/

More information

: 459,. (2011),, Zhu (2008). Y = Xθ + ε, (1.1) Y = (y 1,..., y n ) T, ε = (ε 1,..., ε n ) T, θ = (θ 1,..., θ p ) T, X n p, X i X i, E(ε) = 0, Var (ε)

: 459,. (2011),, Zhu (2008). Y = Xθ + ε, (1.1) Y = (y 1,..., y n ) T, ε = (ε 1,..., ε n ) T, θ = (θ 1,..., θ p ) T, X n p, X i X i, E(ε) = 0, Var (ε) 2013 10 Chinese Journal of Applied Probability and Statistics Vol.29 No.5 Oct. 2013 (,, 213001) (,, 211189). ;, ;. :,,,. : O212.2. 1.,,,,,, Belsley (1980), Christensen (1992), Critchley (2001). Zhu Lee

More information

理 成 可 做 關 聯 分 析 的 格 式, 再 應 用 統 計 統 計 計 算 軟 體 R (R Core Team, 2013) 中 的 延 伸 套 件 arules (Hahsler, Gruen, and Hornik, 2005; Hahsler, Buchta, Gruen, and H

理 成 可 做 關 聯 分 析 的 格 式, 再 應 用 統 計 統 計 計 算 軟 體 R (R Core Team, 2013) 中 的 延 伸 套 件 arules (Hahsler, Gruen, and Hornik, 2005; Hahsler, Buchta, Gruen, and H 連 鎖 輕 食 店 之 產 品 關 聯 分 析 - 以 茗 人 為 例 Association Analysis of Deli Chain Example of MingZen 摘 要 所 謂 關 聯 分 析, 就 是 從 商 店 銷 售 交 易 資 料 庫 中, 找 出 項 目 之 間 的 關 聯 性, 並 探 勘 出 在 資 料 間 具 有 相 關 性 的 隱 藏 規 則 有 趣 的 是, 商

More information

热设计网

热设计网 例 例 Agenda Popular Simulation software in PC industry * CFD software -- Flotherm * Advantage of Flotherm Flotherm apply to Cooler design * How to build up the model * Optimal parameter in cooler design

More information

10384 19020101152519 UDC Rayleigh Quasi-Rayleigh Method for computing eigenvalues of symmetric tensors 2 0 1 3 2 0 1 3 2 0 1 3 2013 , 1. 2. [4], [27].,. [6] E- ; [7], Z-. [15]. Ramara G. kolda [1, 2],

More information

Microsoft PowerPoint - ch1_2.ppt

Microsoft PowerPoint - ch1_2.ppt Chapter Student Lecture Notes - 第 一 二 三 四 节 统 计 中 与 的 数 统 发 据 计 展 的 学 类 型 第 的 一 几 章 个 基 统 本 计 概 学 念 简 介 四 三 二 一 什 么 是 的 统 第 数 分 计 一 学 科 节 的 关 统 系 计 与 统 计 学 五 统 计 学 与 其 他 学 科 的 关 系 第 二 三 四 节 统 计 与 的 数 统

More information

employment. The balance between work and life has an important influence on the working time factors. To career development the employment qual

employment. The balance between work and life has an important influence on the working time factors. To career development the employment qual 2015 4 211 POPULATION & ECONOMICS No. 4 2015 Tot. No. 211 100029 Logit Logit F241. 4 A 1000-4149 2015 04-0107 - 12 DOI 10. 3969 /j. issn. 1000-4149. 2015. 04. 012 A Study on Affect Mechanism of Employment

More information

國家圖書館典藏電子全文

國家圖書館典藏電子全文 昰 1 2 3 4 5 6 Logit Logit Logit 7 昰 Logit 1968 Washington, D.C. 8 9 巣 10 11 巣 巣 巣 巣 12 13 S U j f ( Z, S ) j j U j Z j S U j > U, j j, k C.. (2-2) k i Ci i 14 15 S Z ), ( S Z U ),, ( Pr ) ( C k j j U U

More information

Corporate Social Responsibility CSR CSR CSR 1 2 ~ CSR 6 CSR 7 CSR 8 CSR 9 10 ~ CSR 14 CSR CSR 2013 A A 23.

Corporate Social Responsibility CSR CSR CSR 1 2 ~ CSR 6 CSR 7 CSR 8 CSR 9 10 ~ CSR 14 CSR CSR 2013 A A 23. 24 3 Vol. 24 No. 3 2015 6 OPERATIONS RESEARCH AND MANAGEMENT SCIENCE Jun. 2015 1 2 2 1. 300071 2. 300071 Markowitz 10 F830. 59 A 1007-3221 2015 03-0275-13 Improvement of Portfolio Models Research An Empirical

More information

講義ノート 物性研究 電子版 Vol. 7, No. 2, (2018 年 11 月号 ) Metropolis [1] Buffon Neumann 20 importance Importance (Markov-chain Monte Carlo

講義ノート 物性研究 電子版 Vol. 7, No. 2, (2018 年 11 月号 ) Metropolis [1] Buffon Neumann 20 importance Importance (Markov-chain Monte Carlo 953 Metropolis [] 980 8 Buffon Neumann 20 importance Importance (Markov-chain Monte Carlo : MCMC) (PMC) E-mail: hukusima@phys.c.u-tokyo.ac.jp : ( ) Importance ( ) MCMC PMC ( ( )) MCMC X MC MCMC 2 MCMC

More information

C35N32.dvi

C35N32.dvi 數 學 傳 播 35 卷 3 期, pp. 11-21 數 學 的 詩 篇 一 一 Fourier 分 析 林 琦 焜 深 入 研 究 大 自 然 是 所 有 數 學 發 現 最 富 饒 的 來 源, 不 僅 對 於 決 定 良 好 的 目 標 有 好 處, 也 有 助 於 排 除 含 糊 的 問 題 無 用 的 計 算 這 是 建 立 分 析 學 本 身 的 手 段, 也 協 助 我 們 發 現

More information

1

1 1 heterogeneity (multivariate analysis) (homogeneous) ( ) ( ) (group) (multiple group analysis) (class) (latent class analysis LCA) Bartholomew Knott(1999) ( 1) (common factor analysis FA) (LCA) (latent

More information

-2 4 - cr 5 - 15 3 5 ph 6.5-8.5 () 450 mg/l 0.3 mg/l 0.1 mg/l 1.0 mg/l 1.0 mg/l () 0.002 mg/l 0.3 mg/l 250 mg/l 250 mg/l 1000 mg/l 1.0 mg/l 0.05 mg/l 0.05 mg/l 0.01 mg/l 0.001 mg/l 0.01 mg/l () 0.05 mg/l

More information

Improved Preimage Attacks on AES-like Hash Functions: Applications to Whirlpool and Grøstl

Improved Preimage Attacks on AES-like Hash Functions: Applications to Whirlpool and Grøstl SKLOIS (Pseudo) Preimage Attack on Reduced-Round Grøstl Hash Function and Others Shuang Wu, Dengguo Feng, Wenling Wu, Jian Guo, Le Dong, Jian Zou March 20, 2012 Institute. of Software, Chinese Academy

More information

6CO2 6H 2O C6H 2O6 6O2 = = n i= P X i n H X - P X logp X i= i n X X X P i P 0 i l n i n n P i= i H X = - p log P n i= i i i + H X - P X logp X dx - 2 2 2 2 3 2 4 2 d( Q) d( Q) > 0 = 0 di di d(

More information

1 背 景 介 紹 許 多 應 用 科 學 牽 涉 到 從 資 料 (data) 中 分 析 出 所 需 要 ( 含 ) 的 資 訊 (information) 希 望 從 已 知 的 資 料 中 瞭 解 問 題 的 本 質, 進 而 能 控 制 或 做 出 預 測 這 些 資 料 通 常 有 兩

1 背 景 介 紹 許 多 應 用 科 學 牽 涉 到 從 資 料 (data) 中 分 析 出 所 需 要 ( 含 ) 的 資 訊 (information) 希 望 從 已 知 的 資 料 中 瞭 解 問 題 的 本 質, 進 而 能 控 制 或 做 出 預 測 這 些 資 料 通 常 有 兩 群 組 分 類 線 性 迴 歸 與 最 小 平 方 法 last modified July 22, 2008 本 單 元 討 論 Supervised Learning 中 屬 於 類 別 ( 即 輸 出 變 數 Y 是 類 別 型 的 資 料 ) 資 料 的 群 組 分 辨, 並 且 著 重 在 最 簡 單 的 兩 群 組 (two classes) 資 料 判 別 透 過 幾 個 簡 單 典

More information

46 數 學 傳 播 26 卷 3 期 民 91 年 9 月 表 演, 有 些 賭 場 還 每 小 時 發 遊 客 1 美 元, 可 連 發 7 小 時 一 個 目 的, 都 是 吸 引 遊 客 流 連 忘 返, 持 續 地 賭 開 賭 場 當 然 是 為 了 賺 錢, 利 用 機 率 來 設 計

46 數 學 傳 播 26 卷 3 期 民 91 年 9 月 表 演, 有 些 賭 場 還 每 小 時 發 遊 客 1 美 元, 可 連 發 7 小 時 一 個 目 的, 都 是 吸 引 遊 客 流 連 忘 返, 持 續 地 賭 開 賭 場 當 然 是 為 了 賺 錢, 利 用 機 率 來 設 計 賭 國 風 雲 黃 文 璋 1. 天 性 好 賭 ùö ùö 考 古 的 證 據 顯 示, 賭 博 的 歷 史 源 遠 流 長, 幾 乎 自 人 類 文 明 之 始 就 有 了 中 外 歷 史 小 說 及 電 影 裡, 也 常 有 賭 的 情 節, 賭 似 乎 是 與 生 活 分 不 開 的 賭 還 不 一 定 是 賭 錢 如 金 庸 (1996a) 射 鵰 英 雄 傳 中 ( 第 十 九 二 十

More information

Chemcad.doc

Chemcad.doc Chemcad 00-4 Chemcad Chemcad Chemstations Chemcad CHEMCAD Chemstations 1.1 CHEMCAD A. B. / C. / D. 1.2CHEMCAD CHEMCAD ChemCAD 50 1.3 CHEMCAD 39 K 13 K UNIFAC UPLM (UNIFAC for Polymers)Wilson T. K. Wilson

More information

Microsoft Word - P085003

Microsoft Word - P085003 1 編 P08500 文 85.0. 字 8501695 文 台 政 華 月 日 85 字 8501695 主 旨 圖 事 項 詳 圖 長 扁 2 書 台 書 壹 詳 圖 貳 令 依 據 台 條 條 詳 細 緣 起 速 推 展 落 私 投 資 事 業 依 台 並 考 慮 台 行 政 轄 展 時 先 後 衰 敗 程 研 針 對 萬 華 同 正 研 並 將 申 擬 自 受 述 行 政 限 併 檢 討 就

More information

Fuzzy GP

Fuzzy GP : 林 理論 數 論 1 率 2 類,, 金流量 金 利 數 益,, 3 不 異 (Multi- Valued) (Single-Valued) 數 數 數 (Local Optimum) (Global Optimum) 4 (Multi-valued) (Non-linear) (Self-learning) 5 (Genetic Programming, GP) GP 1. 亂數 2. (individuals)

More information

Monetary Policy Regime Shifts under the Zero Lower Bound: An Application of a Stochastic Rational Expectations Equilibrium to a Markov Switching DSGE

Monetary Policy Regime Shifts under the Zero Lower Bound: An Application of a Stochastic Rational Expectations Equilibrium to a Markov Switching DSGE Procedure of Calculating Policy Functions 1 Motivation Previous Works 2 Advantages and Summary 3 Model NK Model with MS Taylor Rule under ZLB Expectations Function Static One-Period Problem of a MS-DSGE

More information

第一章

第一章 課 程 名 稱 : 光 纖 傳 輸 實 務 與 實 習 1. 課 程 概 述 : 光 纖 傳 輸 實 務 與 實 習 為 隔 年 開 授 之 課 程, 此 高 等 課 程 實 習 項 目 之 內 容 較 具 彈 性, 以 教 導 學 生 如 何 使 用 設 計 工 具 與 發 揮 設 計 能 力 為 目 標 新 編 了 光 纖 光 放 大 器 模 擬 設 計 實 習 教 材, 包 含 摻 鉺 光 纖

More information

L L L-1 L-1 L-1 L-1 L-1 L-2 L-1 L-1 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-3 L-3 L-3 L-3 L-2 L-2 L-2 L-2 L-2 15 14 13 12 11 10 9 8 7

L L L-1 L-1 L-1 L-1 L-1 L-2 L-1 L-1 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-3 L-3 L-3 L-3 L-2 L-2 L-2 L-2 L-2 15 14 13 12 11 10 9 8 7 Compensation Design - L L L-1 L-1 L-1 L-1 L-1 L-2 L-1 L-1 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-2 L-3 L-3 L-3 L-3 L-2 L-2 L-2 L-2 L-2 15 14 13 12 11 10 9 8 7 100,000 80,000 $ 60,000 40,000 20,000 80,000

More information

MATLAB 1

MATLAB 1 MATLAB 1 MATLAB 2 MATLAB PCI-1711 / PCI-1712 MATLAB PCI-1711 / PCI-1712 MATLAB The Mathworks......1 1...........2 2.......3 3................4 4. DAQ...............5 4.1. DAQ......5 4.2. DAQ......6 5.

More information

< F63756D656E D2D796E2D31C6DABFAF2D31D6D0D2BDD2A9CFD6B4FABBAF2D C4EA2DB5DA38C6DA2D30362DC3F1D7E5D2BDD2A92E6D6469>

< F63756D656E D2D796E2D31C6DABFAF2D31D6D0D2BDD2A9CFD6B4FABBAF2D C4EA2DB5DA38C6DA2D30362DC3F1D7E5D2BDD2A92E6D6469> 绎 1 2 1. 8300112 援 830000 CNKI 1979-20121989-2013 PubMed/MEDLINE Jadad Cochrane RevMan 5.2.0 Meta 4 360 Meta OS WMD 95%-0.48-0.81-0.160.04-0.150.22 RR 95% 1.671.292.151.220.354.20 doi: 10.11842/wst.2014.08.030

More information

ELISA分析

ELISA分析 http://www.autoprep.jp ELISA ELISA ELISAenzyme-linked immunosorbent assay ELISA ELISA GC-ECD ELISA ELISA ELISA ELISA ELISA ELISA ELISA ELISA ELISA Antibody coated microwells) (Mycotoxin standard ( (non-coated

More information

基于因子分析法对沪深农业类上市公司财务绩效实证分析

基于因子分析法对沪深农业类上市公司财务绩效实证分析 山 东 农 业 大 学 学 报 ( 自 然 科 学 版 ),2014,45(3):449-453 VOL.45 NO.3 2014 Journal of Shandong Agricultural University (Natural Science Edition) doi:10.3969/j.issn.1000-2324.2014.03.024 基 于 因 子 分 析 法 对 沪 深 农 业

More information

(156) / Spurious Regression Unit Root Test Cointergration TestVector Error Correction Model Granger / /

(156) / Spurious Regression Unit Root Test Cointergration TestVector Error Correction Model Granger / / (155) * ** / / / / 1973 ~1974 1979 ~1980 1987 ~1989 * ** (156) 1990 2004 1997 1996 1980 / Spurious Regression Unit Root Test Cointergration TestVector Error Correction Model Granger / / (157) Hedonic Price

More information

Vocabulary Development in Armenian Children Attending Armenian-English Bilingual Preschools

Vocabulary Development in Armenian Children Attending Armenian-English Bilingual Preschools Vocabulary Development in Armenian Children Attending Armenian-English Bilingual Preschools Alice Hovsepian, Ph.D. Candidate Carla J. Johnson, Ph.D. Department of Speech-Language Pathology University of

More information

《分析化学辞典》_数据处理条目_1.DOC

《分析化学辞典》_数据处理条目_1.DOC 3 4 5 6 7 χ χ m.303 B = f log f log C = m f = = m = f m C = + 3( m ) f = f f = m = f f = n n m B χ α χ α,( m ) H µ σ H 0 µ = µ H σ = 0 σ H µ µ H σ σ α H0 H α 0 H0 H0 H H 0 H 0 8 = σ σ σ = ( n ) σ n σ /

More information

國家圖書館典藏電子全文

國家圖書館典藏電子全文 I Abstract II III ... I Abstract...II...III... IV... VI 1...1 2...3 2-1...3 2-2...4 2-3...6 2-4...6 3...8 3-1...8 3-2...10 4...12 5...15 5-1...15 5-2...17 IV 5-3...18 6...21 6-1...21 6-2...22 6-3...22

More information

PowerPoint Presentation

PowerPoint Presentation 13. Linear Regression and Correlation 數 1 Outline Data: two continuous measurements on each subject Goal: study the relationship between the two variables PART I : correlation analysis Study the relationship

More information

WWW PHP

WWW PHP WWW PHP 2003 1 2 function function_name (parameter 1, parameter 2, parameter n ) statement list function_name sin, Sin, SIN parameter 1, parameter 2, parameter n 0 1 1 PHP HTML 3 function strcat ($left,

More information

G(z 0 + "z) = G(z 0 ) + "z dg(z) dz z! # d" λ "G = G(z 0 ) + #cos dg(z) ( & dz ) * nv #., - d+ - - r 2 sin cosds e / r # ddr 4.r 2 #cos! "G = G(z 0 )

G(z 0 + z) = G(z 0 ) + z dg(z) dz z! # d λ G = G(z 0 ) + #cos dg(z) ( & dz ) * nv #., - d+ - - r 2 sin cosds e / r # ddr 4.r 2 #cos! G = G(z 0 ) 2005.7.21 KEK G(z 0 + "z) = G(z 0 ) + "z dg(z) dz z! # d" λ "G = G(z 0 ) + #cos dg(z) ( & dz ) * nv #., - d+ - - r 2 sin cosds e / r # ddr 4.r 2 #cos! "G = G(z 0 ) + #cos dg(z) ( & dz ) * nv 2+ + ds -

More information

C/C++语言 - C/C++数据

C/C++语言 - C/C++数据 C/C++ C/C++ Table of contents 1. 2. 3. 4. char 5. 1 C = 5 (F 32). 9 F C 2 1 // fal2cel. c: Convert Fah temperature to Cel temperature 2 # include < stdio.h> 3 int main ( void ) 4 { 5 float fah, cel ;

More information

Microsoft Word - A200810-897.doc

Microsoft Word - A200810-897.doc 基 于 胜 任 特 征 模 型 的 结 构 化 面 试 信 度 和 效 度 验 证 张 玮 北 京 邮 电 大 学 经 济 管 理 学 院, 北 京 (100876) E-mail: weeo1984@sina.com 摘 要 : 提 高 结 构 化 面 试 信 度 和 效 度 是 面 试 技 术 研 究 的 核 心 内 容 近 年 来 国 内 有 少 数 学 者 探 讨 过 基 于 胜 任 特 征

More information

Chapter 24 DC Battery Sizing

Chapter 24  DC Battery Sizing 26 (Battery Sizing & Discharge Analysis) - 1. 2. 3. ETAP PowerStation IEEE 485 26-1 ETAP PowerStation 4.7 IEEE 485 ETAP PowerStation 26-2 ETAP PowerStation 4.7 26.1 (Study Toolbar) / (Run Battery Sizing

More information

西安讲座-体视学基本问题与注意事项pdf.ppt

西安讲座-体视学基本问题与注意事项pdf.ppt (2012.12. ) 0817 0817-2242778E-mailzwyang@nsmc.edu.cn http:// http://www.nsmc.edu.cn/forum/stereology/ Essential procedures of stereological (morphometric( morphometric) ) study / [.... ] [ ] [ ] [ ] 1

More information

1938 (Ph.D) 1940 (D.Sci) 1940 (Kai-Lai Chung) Lebesgue-Stieltjes [6] ( [22]) 1942 (1941 ) 1945 J. Neyman H. Hotelling ( ) (University of Cali

1938 (Ph.D) 1940 (D.Sci) 1940 (Kai-Lai Chung) Lebesgue-Stieltjes [6] ( [22]) 1942 (1941 ) 1945 J. Neyman H. Hotelling ( ) (University of Cali 1910 9 1 1 () 1925 1928 () (E. A. Poe) 1931 1933 1934 (Osgood, 1864-1943) ( ) A note on the indices and numbers of nondegenerate critical points of biharmonic functions, 1935 1936 (University College London)

More information

Essential procedures of stereological (morphometric( morphometric) ) study / / / / / / /

Essential procedures of stereological (morphometric( morphometric) ) study / / / / / / / 2010 4 0817-2242778 2242778 E-mail zwyang@nsmc.edu.cn http://www.nsmc.edu.cn/forum/stereology www.nsmc.edu.cn/forum/stereology/ Essential procedures of stereological (morphometric( morphometric) ) study

More information

(4) (3) (2) (1) 1 B 2 C 3 A 4 5 A A 6 7 A B 8 B 9 D 1 1 0 1 B A A 1 A 1 2 3 C 1 A 1 A 1 B 1 A 1 B 1 2 2 2 2 2 4 5 6 7 8 9 0 1 2 3 4 A A B B A A D B B C B D A B d n 1 = ( x x ) n ij ik jk k= 1 i, j

More information

PowerPoint Presentation

PowerPoint Presentation Linear Progamming- the Simple method with greater-than-or-equal-to or equality minimization problem Quantitative deciion making technique /5/6 Tableau form- dealing with greaterthan-or-equal-to contraint

More information

104 10055 17 (02)2391-9529 http://www.publichealth.org.tw/ 104 5 28 ... 3... 4... 4... 10... 11... 11... 12 the Association of Schools of Public Health, ASPH 35-40 2007 4 ASPH ASPH - 3 - 100 60-4 - (%)

More information

UDC Empirical Researches on Pricing of Corporate Bonds with Macro Factors 厦门大学博硕士论文摘要库

UDC Empirical Researches on Pricing of Corporate Bonds with Macro Factors 厦门大学博硕士论文摘要库 10384 15620071151397 UDC Empirical Researches on Pricing of Corporate Bonds with Macro Factors 2010 4 Duffee 1999 AAA Vasicek RMSE RMSE Abstract In order to investigate whether adding macro factors

More information

Tel: Fax: TTP-344M/246M /

Tel: Fax: TTP-344M/246M / TTP-344M/246M / True Type font David Turner, Robert Wilhelm Werner Lemberg The Free Type Project 235 16 8 2 i- TTP-344M/246M...1 1.1...1 1.2...1 1.2.1...1 1.2.2 /...2 1.2.3...2 1.2.4...2 1.3...3 1.4...3

More information

M ( ) K F ( ) A M ( ) 1815 (probable error) F W ( ) J ( ) n! M ( ) T ( ) L ( ) T (171

M ( ) K F ( ) A M ( ) 1815 (probable error) F W ( ) J ( ) n! M ( ) T ( ) L ( ) T (171 1 [ ]H L E B ( ) statistics state G (150l--1576) G (1564 1642) 16 17 ( ) C B (1623 1662) P (1601--16S5) O W (1646 1716) (1654 1705) (1667--1748) (1687--H59) (1700 1782) J (1620 1674) W (1623 1687) E (1656

More information

國家圖書館典藏電子全文

國家圖書館典藏電子全文 ...1...5...6...7...9...21...28...31...34...41...46...54...59...74...79...82...86 89 94 1993 1984 33 1993 49 1995 1999 72 liquid egg 1-1 540 1,260 100 300 1986 310 525 835 1 2 1-1 1986 1979 1986 quart 946c.c.

More information

第5章修改稿

第5章修改稿 (Programming Language), ok,, if then else,(), ()() 5.0 5.0.0, (Variable Declaration) var x : T x, T, x,,,, var x : T P = x, x' : T P P, () var x:t P,,, yz, var x : int x:=2. y := x+z = x, x' : int x' =2

More information

3.1 ( ) (Expectation) (Conditional Mean) (Median) Previous Next

3.1 ( ) (Expectation) (Conditional Mean) (Median) Previous Next 3-1: 3.1 ( )........... 2 3.1.1 (Expectation)........ 2 3.1.2............. 12 3.1.3 (Conditional Mean)..... 17 3.1.4 (Median)............ 22 Previous Next First Last Back Forward 1 1.. 2. ( ): ( ), 3.

More information

untitled

untitled 6 20 90 BellCore Ethernet variable bit rate VBR fractal self-similarity 994 IEEE/ACM Transactions on Networking On the self-similarity nature of Ethernet traffic extended version LAN WAN CCSN/SS7 ISDN

More information

國立中山大學學位論文典藏

國立中山大學學位論文典藏 Analysis of Radiation Effect from Fire of Fuel Tank I 2000 Jun. II 1-1... 7 1-2 (1)Tank Fire Point Source Model... 7 1-3 (3)Tank Fire Equivalent Radiator Model... 8 1-4 (2)Pool Fire Solid Flame Model...

More information

2 53 [1] [2] [3-5] [6] [7-8] Fotheringham Geographical Weighted Regression GWR [9] R &D GWR [10] 2009 OLS GWR, [11] [13] 3 GWR [1

2 53 [1] [2] [3-5] [6] [7-8] Fotheringham Geographical Weighted Regression GWR [9] R &D GWR [10] 2009 OLS GWR, [11] [13] 3 GWR [1 32 2 Vol.32 No. 2 2012 2 ECONOMIC GEOGRAPHY Feb. 2012 1 1 2 3 2010 12 1 014 OLS CBD OLS OLS F293.3 A 1000-8462(2012)02-0052 - 07 A GWR- Based Study on Spatial Patter n and Str uctur al Determinants of

More information

( ) Wuhan University

( ) Wuhan University Email: huangzh@whueducn, 47 Wuhan Univesity i L A TEX,, : http://affwhueducn/huangzh/ 8 4 49 7 ii : : 4 ; 8 a b c ; a b c 4 4 8 a b c b c a ; c a b x y x + y y x + y x x + y x y 4 + + 8 8 4 4 + 8 + 6 4

More information