glmでロジスティック回帰に適合するデフォルトの開始値


10

で指定されているデフォルトの開始値はどのようになっているのでしょうかglm

この投稿は、デフォルト値がゼロとして設定されることを示唆しています。この1は、その背後にあるアルゴリズムは、しかし、関連するリンクが壊れているがあることを述べています。

単純なロジスティック回帰モデルをアルゴリズムトレースで近似しようとしました:

set.seed(123)

x <- rnorm(100)
p <- 1/(1 + exp(-x))
y <- rbinom(100, size = 1, prob = p)

# to see parameter estimates in each step
trace(glm.fit, quote(print(coefold)), at = list(c(22, 4, 8, 4, 19, 3)))

まず、初期値の指定なし:

glm(y ~ x, family = "binomial")

Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
NULL
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.386379 1.106234
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3991135 1.1653971
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3995188 1.1669508

最初のステップでは、初期値はNULLです。

次に、開始値をゼロに設定します。

glm(y ~ x, family = "binomial", start = c(0, 0))

Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0 0
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3177530 0.9097521
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3909975 1.1397163
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3994147 1.1666173
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3995191 1.1669518

また、最初のアプローチと2番目のアプローチの繰り返しは異なることがわかります。

glm私が指定した初期値を確認するには、1回の反復でモデルを近似しようとしました。

glm(y ~ x, family = "binomial", control = list(maxit = 1))

Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
NULL

Call:  glm(formula = y ~ x, family = "binomial", control = list(maxit = 1))

Coefficients:
(Intercept)            x  
     0.3864       1.1062  

Degrees of Freedom: 99 Total (i.e. Null);  98 Residual
Null Deviance:      134.6 
Residual Deviance: 115  AIC: 119

パラメータの推定値は(当然のことながら)2番目の反復における最初のアプローチの推定値に対応します。つまり、[1] 0.386379 1.106234 これらの値を初期値として設定すると、最初のアプローチと同じ反復シーケンスになります。

glm(y ~ x, family = "binomial", start = c(0.386379, 1.106234))

Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.386379 1.106234
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3991135 1.1653971
Tracing glm.fit(x = structure(c(1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, 1,  .... step 22,4,8,4,19,3 
[1] 0.3995188 1.1669508

だから問題は、これらの値はどのように計算されるのですか?


それは複雑です。ユーザーが指定した場合startの値を、彼らはに何が渡されるかの計算に使用されているC_Cdqrlsルーチン。そうしないと、渡される値は計算されますが(呼び出しを含むeval(binomial()$initialize))、glm.fit明示的にの値を計算することはありませんstart。1〜2時間かけてglm.fitコードを調べます。
ローランド

コメントありがとうございます。glm.fitコードを調べようとしましたが、初期値の計算方法がわかりません。
アデラ

回答:


6

TL; DR

  • start=c(b0,b1)etaをb0+x*b1(mu to 1 /(1 + exp(-eta)))に初期化します
  • start=c(0,0) y値またはx値に関係なく、etaを0(muから0.5)に初期化します。
  • start=NULL xの値に関係なく、y = 1の場合、eta = 1.098612(mu = 0.75)を初期化します。
  • start=NULL xの値に関係なく、y = 0の場合、eta = -1.098612(mu = 0.25)を初期化します。

  • ETAと(その結果、ミューおよびVAR(MU))が算出された、wz計算しての精神で、QRソルバに送信されますqr.solve(cbind(1,x) * w, z*w)

長い形式

Rolandのコメントを基glm.fit.truncated()に、私はglm.fitを作成し、C_Cdqrls電話に出てからコメント化しました。 glm.fit.truncated出力zおよびw値(同様に計算するために使用される量の値zw)、その後に渡されるC_Cdqrlsコール。

## call Fortran code via C wrapper
fit <- .Call(C_Cdqrls, x[good, , drop = FALSE] * w, z * w,
             min(1e-7, control$epsilon/1000), check=FALSE) 

詳細については、C_Cdqrls こちらをご覧ください。幸いなことに、qr.solveベースR の関数は、で呼び出されるLINPACKバージョンを直接利用しglm.fit()ます。

したがってglm.fit.truncated、さまざまな開始値の指定を実行してからqr.solve、w値とz値を使用して呼び出しを行い、「開始値」(または最初に表示される反復値)の計算方法を確認します。ローランドが示されているように、指定start=NULLまたはstart=c(0,0))(GLMには、WおよびZの計算に影響を与えないためstart

start = NULLの場合: z要素が2.431946または-2.431946の値をw持つベクトルであり、すべての要素が0.4330127であるベクトルです。

start.is.null <- glm.fit.truncated(x,y,family=binomial(), start=NULL)
start.is.null
w <- start.is.null$w
z <- start.is.null$z
## if start is NULL, the first displayed values are:
qr.solve(cbind(1,x) * w, z*w)  
# > qr.solve(cbind(1,x) * w, z*w)  
#                 x 
# 0.386379 1.106234 

start = c(0,0)の場合: z要素の値が2または-2 wのベクトルであり、すべての要素が0.5のベクトルです。

## if start is c(0,0)    
start.is.00 <- glm.fit.truncated(x,y,family=binomial(), start=0)
start.is.00
w <- start.is.00$w
z <- start.is.00$z
## if start is c(0,0), the first displayed values are:    
qr.solve(cbind(1,x) * w, z*w)  
# > qr.solve(cbind(1,x) * w, z*w)  
#                   x 
# 0.3177530 0.9097521 

これで問題ありませんが、wとをどのように計算すればよいzですか?下の方glm.fit.truncated()

z <- (eta - offset)[good] + (y - mu)[good]/mu.eta.val[good]
w <- sqrt((weights[good] * mu.eta.val[good]^2)/variance(mu)[good])

計算zとに使用される数量の出力値間の次の比較を見てくださいw

cbind(y, start.is.null$mu, start.is.00$mu)
cbind(y, start.is.null$eta, start.is.00$eta)
cbind(start.is.null$var_mu, start.is.00$var_mu)
cbind(start.is.null$mu.eta.val, start.is.00$mu.eta.val)

etaが0に設定され、mu(eta)= 1 /(1 + exp(-0))= 0.5であるため、値は0.5のみのstart.is.00ベクトルmuを持つことに注意してください。 start.is.nully = 1の場合はmu = 0.75(eta = 1.098612に対応)に設定し、y = 0の場合はmu = 0.25(eta = -1.098612に対応)に設定するため、var_mu= 0.75 * 0.25 = 0.1875になります。

ただし、興味深いことに、シードを変更してすべてを再実行し、y = 1の場合はmu = 0.75、y = 0の場合はmu = 0.25でした(したがって、他の量は同じままでした)。これは、NULLが同じに生じさせる=、と言う開始することであるwzにかかわらず、何のyx、Y = 1、ETA = -1.098612(= 0.25ムー)場合は、y = 0の場合、彼らはETA = 1.098612(ムー= 0.75)を初期化するので、あります。

したがって、切片係数とX係数の開始値はstart = NULLに設定されていないようですが、y値に依存し、x値とは無関係にetaに初期値が与えられています。そこから、wz計算され、その後、一緒に送らxqr.solverへ。

上記のチャンクのに実行するコード:

set.seed(123)

x <- rnorm(100)
p <- 1/(1 + exp(-x))
y <- rbinom(100, size = 1, prob = p)


glm.fit.truncated <- function(x, y, weights = rep.int(1, nobs), 
start = 0,etastart = NULL, mustart = NULL, 
offset = rep.int(0, nobs),
family = binomial(), 
control = list(), 
intercept = TRUE,
singular.ok = TRUE
){
control <- do.call("glm.control", control)
x <- as.matrix(x)
xnames <- dimnames(x)[[2L]]
ynames <- if(is.matrix(y)) rownames(y) else names(y)
conv <- FALSE
nobs <- NROW(y)
nvars <- ncol(x)
EMPTY <- nvars == 0
## define weights and offset if needed
if (is.null(weights))
  weights <- rep.int(1, nobs)
if (is.null(offset))
  offset <- rep.int(0, nobs)

## get family functions:
variance <- family$variance
linkinv  <- family$linkinv
if (!is.function(variance) || !is.function(linkinv) )
  stop("'family' argument seems not to be a valid family object", call. = FALSE)
dev.resids <- family$dev.resids
aic <- family$aic
mu.eta <- family$mu.eta
unless.null <- function(x, if.null) if(is.null(x)) if.null else x
valideta <- unless.null(family$valideta, function(eta) TRUE)
validmu  <- unless.null(family$validmu,  function(mu) TRUE)
if(is.null(mustart)) {
  ## calculates mustart and may change y and weights and set n (!)
  eval(family$initialize)
} else {
  mukeep <- mustart
  eval(family$initialize)
  mustart <- mukeep
}
if(EMPTY) {
  eta <- rep.int(0, nobs) + offset
  if (!valideta(eta))
    stop("invalid linear predictor values in empty model", call. = FALSE)
  mu <- linkinv(eta)
  ## calculate initial deviance and coefficient
  if (!validmu(mu))
    stop("invalid fitted means in empty model", call. = FALSE)
  dev <- sum(dev.resids(y, mu, weights))
  w <- sqrt((weights * mu.eta(eta)^2)/variance(mu))
  residuals <- (y - mu)/mu.eta(eta)
  good <- rep_len(TRUE, length(residuals))
  boundary <- conv <- TRUE
  coef <- numeric()
  iter <- 0L
} else {
  coefold <- NULL
  eta <-
    if(!is.null(etastart)) etastart
  else if(!is.null(start))
    if (length(start) != nvars)
      stop(gettextf("length of 'start' should equal %d and correspond to initial coefs for %s", nvars, paste(deparse(xnames), collapse=", ")),
           domain = NA)
  else {
    coefold <- start
    offset + as.vector(if (NCOL(x) == 1L) x * start else x %*% start)
  }
  else family$linkfun(mustart)
  mu <- linkinv(eta)
  if (!(validmu(mu) && valideta(eta)))
    stop("cannot find valid starting values: please specify some", call. = FALSE)
  ## calculate initial deviance and coefficient
  devold <- sum(dev.resids(y, mu, weights))
  boundary <- conv <- FALSE

  ##------------- THE Iteratively Reweighting L.S. iteration -----------
  for (iter in 1L:control$maxit) {
    good <- weights > 0
    varmu <- variance(mu)[good]
    if (anyNA(varmu))
      stop("NAs in V(mu)")
    if (any(varmu == 0))
      stop("0s in V(mu)")
    mu.eta.val <- mu.eta(eta)
    if (any(is.na(mu.eta.val[good])))
      stop("NAs in d(mu)/d(eta)")
    ## drop observations for which w will be zero
    good <- (weights > 0) & (mu.eta.val != 0)

    if (all(!good)) {
      conv <- FALSE
      warning(gettextf("no observations informative at iteration %d",
                       iter), domain = NA)
      break
    }
    z <- (eta - offset)[good] + (y - mu)[good]/mu.eta.val[good]
    w <- sqrt((weights[good] * mu.eta.val[good]^2)/variance(mu)[good])
    # ## call Fortran code via C wrapper
    # fit <- .Call(C_Cdqrls, x[good, , drop = FALSE] * w, z * w,
    #              min(1e-7, control$epsilon/1000), check=FALSE)
    # 

    #print(iter)
    #print(z)
    #print(w)
  }


  }
  return(list(z=z, w=w, mustart=mustart, etastart=etastart, eta=eta, offset=offset, mu=mu, mu.eta.val=mu.eta.val,
              weight=weights, var_mu=variance(mu)))

}

2
あなたの素晴らしい答えをありがとう、これは私が望んでいたことをはるかに超えています:)
Adela
弊社のサイトを使用することにより、あなたは弊社のクッキーポリシーおよびプライバシーポリシーを読み、理解したものとみなされます。
Licensed under cc by-sa 3.0 with attribution required.