| Type: | Package | 
| Title: | Maximum Likelihood Estimation of a Log-Concave Density Based on Censored Data | 
| Version: | 0.17-4 | 
| Date: | 2024-10-06 | 
| Maintainer: | Dominic Schuhmacher <dominic.schuhmacher@mathematik.uni-goettingen.de> | 
| Depends: | R (≥ 2.15.0) | 
| Imports: | grDevices, graphics, stats, utils | 
| Suggests: | logcondens | 
| Description: | Based on right or interval censored data, compute the maximum likelihood estimator of a (sub)probability density under the assumption that it is log-concave. For further information see Duembgen, Rufibach and Schuhmacher (2014) <doi:10.1214/14-EJS930>. | 
| License: | GPL-2 | GPL-3 [expanded from: GPL (≥ 2)] | 
| Encoding: | UTF-8 | 
| LazyLoad: | yes | 
| NeedsCompilation: | yes | 
| Packaged: | 2024-10-06 09:45:58 UTC; schumi | 
| Author: | Dominic Schuhmacher [aut, cre], Kaspar Rufibach [aut], Lutz Dümbgen [aut] | 
| Repository: | CRAN | 
| Date/Publication: | 2024-10-06 10:30:05 UTC | 
Maximum Likelihood Estimation of a Log-Concave Density Based on Censored Data
Description
Based on independent intervals X_i = [L_i,R_i], where -\infty < L_i \leq R_i \leq \infty, compute the maximum likelihood estimator of a (sub)probability density under the assumption that it is log-concave. For further information see Duembgen, Rufibach, and Schuhmacher (2013).
Details
The main function is logcon, which offers computation of the MLE for many types of censored and also exact data. Various parameters can be set that allow for fine control of the underlying EM algorithm in “difficult” situations. An object of type lcdensity is returned, for which plot, print, and summary methods are available. There is also a function loglike for computing the log-likelihood of a lcdensity object.  
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
Maintainer: Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
References
Duembgen, L., Rufibach, K., and Schuhmacher, D. (2014). Maximum-likelihood estimation of a log-concave density based on censored data. Electronic Journal of Statistics, 8(1), 1405-1437. doi:10.1214/14-EJS930
Examples
## Simple examples with simulated data.
## For more detailed examples see the help for the function logcon.
## exact data
set.seed(10)
x <- rnorm(100)
res <- logcon(x)
## Not run: 
plot(res)
xi <- seq(-3,3,0.05)
lines(xi,log(dnorm(xi)))
## End(Not run)
## interval censored data
x <- rgamma(50,3,1)
x <- cbind(x,x+rexp(50,1))
plotint(x)
res <- logcon(x)
## Not run: plot(res, type="CDF")
## right censored data with mass at infinity
set.seed(11)
x <- rgamma(50,3,1)
x <- cbind(x,ifelse(rexp(50,1/3) < x,Inf,x))
plotint(x)
res <- logcon(x,adapt.p0=TRUE)
## Not run: plot(res, type="survival")
## rounded/binned data
set.seed(12)
x <- round(rnorm(100))
x <- cbind(x-0.5,x+0.5)
plotint(x)
res <- logcon(x)
## Not run: 
plot(res)
xi <- seq(-3,3,0.05)
lines(xi,log(dnorm(xi)))
## End(Not run)
Evaluate the Profile Log-Likelihood on a Grid of p_0-Values
Description
For each of a series of values for the cure parameter p_0 run the function logcon and evaluate the (normalized) log-likelihood at (\phi,p_0), where \phi is the log subprobability density returned by logcon. This serves for (approximate) joint likelihood maximization in (\phi,p_0).
Usage
cure.profile(x, p0grid=seq(0,0.95,0.05), knot.prec=IQR(x[x<Inf])/75,
                  reduce=TRUE, control=lc.control())
Arguments
| x | a two-column matrix of  | 
| p0grid | a vector of values  | 
| knot.prec,reduce,control | arguments passed to the function  | 
Value
A list containing the following values:
| p0hat | the element in  | 
| status | the vector of (normalized) profile log-likelihood values for the elements of  | 
Note
For a large p0grid-vector (fine grid) computations may take a long time. Consider using the option adapt.p0 in the function logcon for a much faster method of joint likelihood maximization in (\phi,p_0).
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
See Also
Examples
## The example from the logconcens-package help page:
set.seed(11)
x <- rgamma(50,3,1)
x <- cbind(x,ifelse(rexp(50,1/3) < x,Inf,x))
## Not run: 
plotint(x)
progrid <- seq(0.1,0.6,0.025)
prores <- cure.profile(x, progrid)
plot(progrid, prores$loglike)
prores$p0hat
res <- logcon(x, p0=prores$p0hat)
plot(res, type="survival")
## End(Not run)
Set the Control Parameters for logcon
Description
Allows to set the control parameters for the more technical aspects of the function logcon and provides default values for any parameters that are not set.
Usage
lc.control(maxiter=49, move.prec=1e-5, domind1l=1, domind2r=1, force.inf=FALSE,
                red.thresh=NULL, check.red=TRUE, addpoints=FALSE, addeps=NULL,
                preweights=NULL, minw=0, show=FALSE, verbose=FALSE)
Arguments
| maxiter | the maximal number of iterations in the main EM algorithm. Default is  | 
| move.prec | a real number giving the threshold for the  | 
| domind1l,domind2r | index numbers in the vector of sorted interval endpoints that specify the left and right boundary of the maximal domain to be considered by the algorithm; see the details section of the help for  | 
| force.inf | 
 | 
| red.thresh | a real number indicating the threshold below which the boundary integrals are considered too small; see the details section of the help for  | 
| check.red | 
 | 
| addpoints | 
 | 
| addeps | a positive real number. If  | 
| preweights | a vector of weights for the observation intervals. Defaults to  | 
| minw | a positive real number. This gives another way for preventing domain reduction. Instead of adding observations the weights for the internal active set algorithm are kept at or above minw at the boundary of the domain. | 
| show | 
 | 
| verbose | 
 | 
Details
For further explanations about the algorithm see the help for logcon. In summary:
maxiter and move.prec provide stopping criteria for the EM algorithm.
domind1l, domind2r, force.inf, red.thresh, and check.red control aspects related to domain reduction.
addpoints, addeps, preweights, winw allow for reweighing of data interval, mainly for increasing numerical stability by preventing domain reduction.
show and verbose give illustrations and background information of the run of the algorithm.   
Value
A list with all of the above components set to their (specified or default) value.
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
See Also
Examples
## See the examples for logcon
Methods for Objects of Class lcdensity
Description
Plot, print, and summary methods for objects of class lcdensity.
Usage
## S3 method for class 'lcdensity'
plot(x, type = c("log-density", "density", "CDF", "survival"), sloperange = TRUE,
                      kinklines=TRUE, kinkpoints=FALSE, xlim=NULL, ylim=NULL, ...)
## S3 method for class 'lcdensity'
print(x, ...)
## S3 method for class 'lcdensity'
summary(object, ...)
Arguments
| x,object | objects of class  | 
| type | the type of plot to be produced. | 
| sloperange | 
 | 
| kinklines | 
 | 
| kinkpoints | 
 | 
| xlim,ylim | numeric vectors of length 2, giving the x and y coordinates ranges. | 
| ... | further arguments passed to  | 
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
See Also
Examples
## See the examples for logcon
Compute Log-Concave MLE Based on Censored or Exact Data
Description
Based on independent intervals X_i = [L_i,R_i], where -\infty < L_i \leq R_i \leq \infty, compute the maximum likelihood estimator of a (sub)probability density \phi and the remaining mass p_0 at infinity (also known as cure parameter) under the assumption that the former is log-concave. Computation is based on an EM algorithm. For further information see Duembgen, Rufibach, and Schuhmacher (2013, preprint).
Usage
logcon(x, adapt.p0=FALSE, p0=0, knot.prec=IQR(x[x<Inf])/75, reduce=TRUE,
            control=lc.control())
logConCens(x, adapt.p0=FALSE, p0=0, knot.prec=IQR(x[x<Inf])/75, reduce=TRUE,
                control=lc.control())
logconcure(x, p0=0, knot.prec=IQR(x[x<Inf])/75, reduce=TRUE, control=lc.control())
Arguments
| x | a two-column matrix of  | 
| adapt.p0 | 
 | 
| p0 | a number from 0 to 1 specifying the mass at infinity. 
If the algorithm is allowed to adapt  | 
| knot.prec | the maximal distance between two consecutive grid points, where knots (points at which the resulting
log-subdensity  | 
| reduce | 
 | 
| control | a list of control parameters for the more technical aspects of the algorithm; usually the result of a call
to  | 
Details
Based on the data intervals X_i = [L_i,R_i] described above, function logcon computes a concave, piecewise linear function \phi and a probability p_0 which satisfy \int \exp \phi(x) \, dx = 1-p_0 and jointly maximize the (normalized) log-likelihood.
\ell(\phi, p_0) = \frac{1}{n} \sum_{i=1}^n \biggl[ 1\{L_i = R_i\} \phi(X_i) + 1\{L_i < R_i\}
   \log \biggl( \int_{L_i}^{R_i} \exp \phi(x) \; dx + 1\{R_i = \infty\} p_0 \biggr) \ \biggr],
If x is a two-column matrix, it is assumed to contain the left and right interval endpoints in the correct order. Intervals may have length zero (both endpoints equal) or be unbounded to the right (right endpoint is Inf). Computation is based on an EM algorithm, where the M-step uses an active set algorithm for computing the log-concave MLE for exact data with weights. The active set algorithm was described in Duembgen, Huesler, and Rufibach (2007) and Duembgen and Rufibach (2011) and is available in the R package logcondens. It has been re-implemented in C for the current package because of speed requirements. The whole algorithm for censored data has been indicated in Duembgen, Huesler, and Rufibach (2007) and was elaborated in Duembgen, Schuhmacher, and Rufibach (2013, preprint).
If x is a vector argument, it is assumed to contain the exact data points. In this case the active set algorithm is accessed directly.
In order to obtain a finite dimensional optimization problem the (supposed) domain of \phi is subdivided by a grid. Stretches between interval endpoints where for theoretical reasons no knots (points where the slope of \phi changes) can lie are left out. The argument kink.prec gives the maximal distance we allow between consecutive grid points in stretches where knots can lie. Say plotint(x) to see the grid.
The EM algorithm works only for fixed dimensionality of the problem, but the domain of the function \phi is not a priori known. Therefore there is an outer loop starting with the largest possible domain, given by the minimal and maximal endpoints of all the intervals, and decreasing the domain as soon as the EM steps let \phi become very small towards the boundary. “Very small” means that the integral of \exp \circ \, \phi over the first or last stretch between interval endpoints within the current domain falls below a certain threshold red.thresh, which can be controlled via lc.control.
Domain reduction tends to be rather conservative. If the computed solution has a suspiciously steep slope at any of the domain boundaries, the recommended strategy is to enforce a smaller domain by increasing the parameters domind1l and/or domind2r via lc.control. The function loglike may be used to compare the (normalized) log-likelihoods of the results.
logConCens is  an alias for logcon. It is introduced to provide unified naming with the main functions in the packages logcondens and logcondiscr. 
logconcure is the same as logcon with adapt.p0 = TRUE fixed. 
Value
An object of class lcdensity for which reasonable plot, print, and summary methods are available.
If the argument x is a two-column matrix (censored data case), such an object has the following components. 
| basedOn | the string  | 
| status | currently only  | 
| x | the data entered. | 
| tau | the ordered vector of different interval endpoints. | 
| domind1,domind2 | the indices of the  | 
| tplus | the grid vector.  | 
| isKnot | 
 | 
| phi | the vector of  | 
| phislr | if  | 
| phislr.range | a vector of length 2 specifying a range of possible values for  | 
| cure | the cure parameter. Either the original argument  | 
| cure.range | a vector of length 2 specifying a range of possible values for  | 
| Fhat | the vector of values of the distribution function  | 
| Fhatfin | the computed value of  | 
Note
If x is a vector, this function does the same as the function logConDens in the package
logcondens. The latter package offers additional features such as grid-based computation with weights
(for high numerical stability) and
smoothing of the estimator, as well as nicer plotting. For exact data we recommend using
logConDens for
everyday data analysis. logcon with a vector argument is to be preferred if time is of the essence (for
data sets with several thousands of points or repeated optimization in iterative algorithms) or
if an additional slope functionality is required. 
Two other helpful packages for log-concave density estimation based on exact data are logcondiscr for estimating a discrete distribution and LogConcDEAD for estimating a multivariate continuous distribution.
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
References
Duembgen, L., Huesler, A., and Rufibach, K. (2007). Active set and EM algorithms for log-concave densities based on complete and censored data. Technical Report 61. IMSV, University of Bern. https://arxiv.org/abs/0707.4643
Duembgen, L. and Rufibach, K., (2011). logcondens: Computations Related to Univariate Log-Concave Density Estimation. Journal of Statistical Software, 39(6), 1-28. doi:10.18637/jss.v039.i06
Duembgen, L., Rufibach, K., and Schuhmacher, D. (2014). Maximum-likelihood estimation of a log-concave density based on censored data. Electronic Journal of Statistics, 8(1), 1405-1437. doi:10.1214/14-EJS930
See Also
lc.control, lcdensity-methods, loglike
Examples
# A function for artificially censoring exact data
censor <- function(y, timemat) {
  tm <- cbind(0,timemat,Inf)
  n <- length(y)
  res <- sapply(1:n, function(i){
            return( c( max(tm[i,][tm[i,] < y[i]]), min(tm[i,][tm[i,] >= y[i]]) ) ) } )
  return(t(res))
}
# ------------------------
#  interval censored data
# ------------------------
set.seed(20)
n <- 100
# generate exact data:
y <- rgamma(n,3)
# generate matrix of inspection times:
itimes <- matrix(rexp(10*n),n,10)
itimes <- t(apply(itimes,1,cumsum))
# transform exact data to interval data
x <- censor(y, itimes)
# plot both
plotint(x, imarks=y)
# Compute censored log-concave MLE
# (assuming only the censored data is available to us)
res <- logcon(x)
plot(res)
# Compare it to the log-concave MLE for the exact data
# and to the true Gamma(3,1) log-density
res.ex <- logcon(y)
lines(res.ex$x, res.ex$phi, lwd=2.5, lty=2)
xi <- seq(0,14,0.05)
lines(xi,log(dgamma(xi,3,1)), col=3, lwd=2)
# -------------------------
#  censored data with cure
# -------------------------
## Not run: 
set.seed(21)
n <- 100
# generate exact data:
y <- rgamma(n,3)
cured <- as.logical(rbinom(n,1,0.3))
y[cured] <- Inf
# generate matrix of inspection times:
itimes <- matrix(rexp(6*n),n,6)
itimes <- t(apply(itimes,1,cumsum))
# transform exact data to interval data
x <- censor(y, itimes)
# plot both
plotint(x, imarks=y)
# Compute censored log-concave MLE including cure parameter
# (assuming only the censored data is available to us)
res <- logcon(x, adapt.p0=TRUE)
plot(res)
# There is a trade-off between right-hand slope and cure parameter here
# (seen by the grey area on the right), but the margin is very small:
res$cure.range
# Compare the corresponding CDF to the true CDF
plot(res, type="CDF")
xi <- seq(0,14,0.05)
lines(xi,0.7*pgamma(xi,3,1), col=3, lwd=2)
# Note that the trade-off for the right-hand slope is not visible anymore 
# (in terms of the CDF the effect is too small)
## End(Not run)
# ------------------------------------
#  real right censored data with cure
# ------------------------------------
# Look at data set ovarian from package survival
# Gives survival times in days for 26 patients with advanced ovarian carcinoma,
# ignoring the covariates
# Bring data to right format and plot it
## Not run: 
library(survival)
data(ovarian)
sobj <- Surv(ovarian$futime, ovarian$fustat)
x <- cbind(sobj[,1], ifelse(as.logical(sobj[,2]),sobj[,1],Inf))
plotint(x)
# Compute censored log-concave MLE including cure parameter
res <- logcon(x, adapt.p0=TRUE)
# Compare the corresponding survival function to the Kaplan-Meier estimator
plot(res, type="survival")
res.km <- survfit(sobj ~ 1)
lines(res.km, lwd=1.5)
## End(Not run)
# ----------------------
#  current status data
# ----------------------
## Not run: 
set.seed(22)
n <- 200
# generate exact data
y <- rweibull(n,2,1)
# generate vector of inspection times
itime <- matrix(rexp(n),n,1)
# transform exact data to interval data
x <- censor(y, itime)
# plot both
plotint(x, imarks=y)
# Compute censored log-concave MLE
# (assuming only the censored data is available to us)
res <- logcon(x)
plot(res, type="CDF")
# Compare it to the true Weibull(2,1) c.d.f.
xi <- seq(0,3,0.05)
lines(xi,pweibull(xi,2,1), col=3, lwd=2)
## End(Not run)
# ----------------------
#  rounded/binned data
# ----------------------
## Not run: 
set.seed(23)
n <- 100
# generate data in [0,1] rounded to one digit
y <- round(rbeta(n,2,3),1)
# bring data to right format and plot it
x <- cbind(y-0.05,y+0.05)
plotint(x)
# Compute censored log-concave MLE
res <- logcon(x)
plot(res, type="density", xlim=c(0,1))
# Compare it to the true Beta(2,3) density
xi <- seq(0,1,0.005)
lines(xi,dbeta(xi,2,3), col=3, lwd=2)
# The peaks in the estimated density are often considered unsatisfactory
# However, they are barely noticeable in the c.d.f.
plot(res, type="CDF", xlim=c(0,1))
lines(xi,pbeta(xi,2,3), col=3, lwd=2)
# To get rid of them in the density apply the smoothing
# proposed in the package logcondens (to be implemented here)
## End(Not run)
Internal logconcens Functions
Description
Internal logconcens functions, usually not to be called by the user.
Usage
GetWeights(preweights,tplus, p0, xindex, rightinf, phi, phislr, needsl)
J00(x, y, v = 1)
J10(x, y)
clc.fixdom(x, preweights=rep(1,dim(x)[1]), minw=0,
   p0, adapt.p0 = FALSE, reduce=TRUE, red.thresh=NULL,
   check.red=TRUE, force.inf=FALSE, tau, subdivide, domind1, 
   domind2, maxiter=60, knot.prec=IQR(x[x<Inf])/75,
   move.prec=1e-5, show=TRUE, verbose=FALSE)
subdivisor(j, tau, eps = 0.01)
phidivisor(j, tau, phi, eps=0.01)
Details
These functions are not exported any more and this overview remains in place purely for information.
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
Compute Log-Likelihood for an Object of Class lcdensity
Description
Compute the (normalized) log-likelihood for an object of class lcdensity as described in the details section for the function logcon. The main use of this function is for comparing different results from logcon based on different (starting) domains.
Usage
loglike(lcd)
Arguments
| lcd | an object of class  | 
Value
A single numeric value, the (normalized) log-likelihood.
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
See Also
Examples
  x <- matrix(c(0,0.5,0.5,1,1,2,3,3),4,2)
  res <- logcon(x)
  loglike(res)
Plot Censored Data
Description
Plot a graphical representation of censored data specified by a two-column matrix of left and right interval endpoints. The grid of potential knots used by logcon is also shown.
Usage
plotint(x, knot.prec = IQR(x[x<Inf])/75, imarks = NULL) 
Arguments
| x | a two-column matrix of left and right endpoints of data intervals. | 
| knot.prec | the maximal distance between two consecutive grid points in the depiction of the grid used by
 | 
| imarks | an optional vector of “spots” to be marked by ‘x’ for the intervals. | 
Value
Used for the side effect.
Author(s)
Dominic Schuhmacher dominic.schuhmacher@mathematik.uni-goettingen.de
Kaspar Rufibach kaspar.rufibach@gmail.com
Lutz Duembgen duembgen@stat.unibe.ch
See Also
Examples
## See the examples for logcon