Title: | MM Algorithm Based on the Assembly-Decomposition Technology |
---|---|
Description: | The Minorize-Maximization(MM) algorithm based on Assembly-Decomposition(AD) technology can be used for model estimation of parametric models, semi-parametric models and non-parametric models. We selected parametric models including left truncated normal distribution, type I multivariate zero-inflated generalized poisson distribution and multivariate compound zero-inflated generalized poisson distribution; semiparametric models include Cox model and gamma frailty model; nonparametric model is estimated for type II interval-censored data. These general methods are proposed based on the following papers, Tian, Huang and Xu (2019) <doi:10.5705/SS.202016.0488>, Huang, Xu and Tian (2019) <doi:10.5705/ss.202016.0516>, Zhang and Huang (2022) <doi:10.1117/12.2642737>. |
Authors: | Xifen Huang [aut], Dengge Liu [aut, cre], Yunpeng Zhou [ctb] |
Maintainer: | Dengge Liu <[email protected]> |
License: | GPL (>= 3) |
Version: | 1.0.0 |
Built: | 2024-11-06 06:15:08 UTC |
Source: | CRAN |
The often used data set for interval censored data, described and given in full in Finkelstein and Wolfe (1985).
bcos
bcos
An object of class data.frame
with 94 rows and 3 columns.
Breast cosmesis data contains the following fields:
left |
a numeric vector |
right |
a numeric vector |
treatment |
a factor with levels Rad and RadChem |
Finkelstein D.M. and Wolfe R.A.(1985). "A semiparametric model for regression analysis of interval-censored failure time data." Biometrics 41, 933-945.
data = data(bcos)
data = data(bcos)
In a survey of Indonesian family life conducted by Strauss et al. the participants included 7000 households sampled from 321 communities randomly selected from 13 of the nation’s 26 Provinces, in which 83% of the Indonesian population lived. Among those households with one child per household, 437 household heads were asked questions about the health of their children.
cadi
cadi
An object of class data.frame
with 437 rows and 2 columns.
The children’s absenteeism data in Indonesia contains the following fields:
y1 |
The number of days the children missed their primary activities due to illness in the last four weeks |
y2 |
The number of days the children spent in bed due to illness in the last four weeks |
Huang X.F., Tian G.L., Zhang, C. and Jiang, X.(2017). "Type I multivariate zero-inflated generalized Poisson distribution with applications." Statistics and its Interface 10(2), 291-311.
Strauss J., Beegle K., Sikoki B., Dawiyanto A., Herawati Y. and Witoelar Y.(2004). "The Third Wave of the Indonesia Family Life Survey (IFLS): Overview and Field Report, WR-144/1-NIA/NICHD, RAND Corporation, Santa Monica, CA."
data = data(cadi)
data = data(cadi)
Let and
denote the,
survival time, the censoring time and a
dimension vector of coefficients for the
-th individual, respectively. And assume the censoring time
is independent of the survival time
are mutually independent, and
is the censoring indicator.
Then the instantaneous hazard rate function of
is
where is a baseline hazard rate and
is a vector of regression parameters.
We denote
as the accumulative hazard rate. Then the observed data likelihood function is
where . The
CoxMM
function is used to calculate the Cox model.
CoxMM(formula, data, beta = NULL, Maxiter = 2000, convergence = 1e-06, ...)
CoxMM(formula, data, beta = NULL, Maxiter = 2000, convergence = 1e-06, ...)
formula |
A formula object, which contains on the left hand side an object of the type |
data |
A |
beta |
A vector of unknown regression parameters, default is |
Maxiter |
The maximum number of iterations is specified by default as 2000. |
convergence |
Specify the convergence criterion, the default is 1e-6. |
... |
Additional arguments |
The CoxMM
function is used to calculate the Cox model using MM algorithms
based on AD technology. EM algorithms rely on the fact that, after profiling out the nonparametric component ,
the resulting function is concave. However, when this assumption does not hold, maximizing the resulting function using Newton’s method becomes difficult,
especially when there are a large number of covariates. MM algorithms can avoid the
concavity requirement and bypass the need for Newton method and matrix inversion.
An object of class CoxMM
that contains the following fields: the Time, total amount of observations,
total number of failure events, the variable name, the , the
, the
, convergence result,
the log likelihood value, the standard deviation of the estimated
, the likelihood-based 95% confidence interval for the
.
D.R. Cox.(1972). 'Regression models and life tables.' Journal of the Royal Statistical Society(Series B) 34(2), 187-220.
Zhang L.L. and Huang X.F.(2022). 'On MM algorithms for Cox model with right-censored data.' In International Conference on Cloud Computing, Internet of Things, and Computer Applications (CICA 2022) 12303, 29-38.
library(survival) CoxMM(Surv(time, status) ~ age + sex, lung)
library(survival) CoxMM(Surv(time, status) ~ age + sex, lung)
Let ,
,
, for
, and
be mutually independent. A random vector
follows a multivariate compound zero-inflated generalized poisson distribution if
where ,
,
,
.
The
CZIGPMM
function is used to calculate the multivariate compound ZIGP model.
CZIGPMM(data, phi0, phi, la, th, Maxiter = 2000, convergence = 1e-06, ...)
CZIGPMM(data, phi0, phi, la, th, Maxiter = 2000, convergence = 1e-06, ...)
data |
Data.frame or Matrix that contains corresponding covariates. |
phi0 |
Probability value for the zero-inflated parameter for CZIGP model. |
phi |
Probability value for the zero-inflated parameter for ZIGP model. |
la |
The scale parameter for ZIGP model. |
th |
The discrete parameter for ZIGP model. |
Maxiter |
The maximum number of iterations is specified by default as 2000. |
convergence |
Specify the convergence criterion, the default is 1e-6. |
... |
Additional arguments |
The CZIGPMM
function is used to calculate multivariate compound zero-inflated generalized poisson distribution model using MM algorithms
based on AD technology. data
is provided by user by default, it can be a data frame or a matrix. In addition, unknown parameters require users to give appropriate initial values,
where 0<=phi0<1
, each phi
should 0<=phi<1
, th
should 0<=th<1
, and each la
should be greater than 0.
An object of class CZIGPMM
that contains the following fields: total amount of observations,
the number of iterations, convergence rate, the log likelihood value, estimated results for the unknown parameters,
the standard deviation of estimate for the unknown parameters, the likelihood-based 95% confidence interval for the unknown parameters,
information criterion: AIC value and BIC value.
Tian G.L., Huang X.F. and Xu, J.(2019). 'An assembly and decomposition approach for constructing separable minorizing functions in a class of MM algorithms.' Statistica Sinica 29(2), 961-982.
Huang X.F., Tian G.L., Zhang, C. and Jiang, X.(2017). 'Type I multivariate zero-inflated generalized Poisson distribution with applications.' Statistics and its Interface 10(2), 291-311.
x1 <- c(0,35,23,34,8,19,0,0,0,0) x2 <- c(38,15,0,25,34,0,0,0,0,0) y <- cbind(x1, x2) phi0 = 0.5; phi = rep(0.5,2); la = rep(1,2); th = rep(0.1,2) CZIGPMM(y, phi0, phi, la, th)
x1 <- c(0,35,23,34,8,19,0,0,0,0) x2 <- c(38,15,0,25,34,0,0,0,0,0) y <- cbind(x1, x2) phi0 = 0.5; phi = rep(0.5,2); la = rep(1,2); th = rep(0.1,2) CZIGPMM(y, phi0, phi, la, th)
Let and
denote the
survival time, the censoring time and a vector of covariates, respectively. For the
-th individual in the
-th cluster, for
and
. And assume the censoring time
is independent of the survival time
given
, and
is the censoring indicator.
Conditional on a cluster-specific frailty
, then the frailty model postulates that the instantaneous hazard rate function of
is
where is a baseline hazard rate and
is a vector of regression parameters. We assume that the frailty
has a gamma distribution
with mean 1, variance
and density
and we denote as the accumulative hazard rate. The
GaFrailtyMM
function is used to calculate the gamma frailty model.
GaFrailtyMM( formula, data, beta = NULL, theta = NULL, lambda = NULL, Maxiter = 2000, convergence = 1e-06, ... )
GaFrailtyMM( formula, data, beta = NULL, theta = NULL, lambda = NULL, Maxiter = 2000, convergence = 1e-06, ... )
formula |
A formula object, which contains on the left hand side an object of the type |
data |
A |
beta |
A vector of unknown regression parameters, default is |
theta |
The variance of frailty factors subject to gamma distribution, default is |
lambda |
Baseline hazard rate, default set to |
Maxiter |
The maximum number of iterations is specified by default as 2000. |
convergence |
Specify the convergence criterion, the default is 1e-6. |
... |
Additional arguments |
The GaFrailtyMM
function is used to calculate gamma frailty survival model using MM algorithms
based on AD technology. EM algorithms relies on the fact that, after profiling out the nonparametric component ,
the resulting function is concave. When it does not hold, using Newton method to maximize the resulting function is
difficult especially when there exist a large number of covariates. MM algorithms that can avoid the
concavity requirement and bypass Newton method and matrix inversion.
An object of class GaFrailtyMM
that contains the following fields: total amount of observations,
the Time, the , the
, total number of failure events, total number of iterations, convergence result, the log likelihood value,
the
, the standard deviation of the estimated
,
the likelihood-based 95% confidence interval for the
,
,
the standard deviation of the estimated
, the likelihood-based 95% confidence interval for the
,
the variable name.
Huang X.F., Xu J.F. and Tian G.L.(2019). 'On profile MM algorithms for gamma frailty survival models.' Statistica Sinica 29(2), 895-916.
library(survival) GaFrailtyMM(Surv(time, status) ~ age + sex + cluster(id), data=kidney)
library(survival) GaFrailtyMM(Surv(time, status) ~ age + sex + cluster(id), data=kidney)
Control IC2Pro object
IC2Control(Maxiter = 2000, convergence = 1e-06, Idigits = 4, Pdigits = 4)
IC2Control(Maxiter = 2000, convergence = 1e-06, Idigits = 4, Pdigits = 4)
Maxiter |
The maximum number of iterations is specified by default as 2000. |
convergence |
Specify the convergence criterion, the default is 1e-6. |
Idigits |
The number of decimal places for the survival interval values. |
Pdigits |
The number of decimal places for the survival probability values. |
list of Maxiter, convergence, Idigits, Pdigits.
IC2Control()
IC2Control()
The IC2MM
function is used to calculate the case II interval-censored data model. A failure time study that consists of independent subjects from a
homogeneous population with survival function
. Let
denote the survival time, and
. Suppose that interval-censored data on the
are observed and given by
where . Let
denote the unique ordered elements of
.
Take
and
. The log-likelihood function is
where and
.
IC2MM(formula, data, ...)
IC2MM(formula, data, ...)
formula |
A formula object, which contains on the left hand side an object of type = 'interval2' of the type |
data |
A |
... |
Additional arguments, e.g. |
The IC2MM
function allows the distributions for multiple strata of dataset to be stored as one IC2
object, e.g. data=bcos
.
An object of class IC2MM
that contains the following fields: error
: convergence result; strata
: dimensions of each df_tab
;
s
: unique ordered elements of , if more than one strata, elements are concatenated;
S
: the survival function, if more than one strata, values are concatenated;
df_tab
: the dataframe of survival intervals and survival probabilities for each interval, if more than one strata, dataframes are concatenated.
Tian G.L., Huang X.F. and Xu, J.(2019). 'An assembly and decomposition approach for constructing separable minorizing functions in a class of MM algorithms.' Statistica Sinica 29(2), 961-982.
library(survival) L <- c(1.5, 0.1, 1.5, 0.5, 0.4, 0.2, 0.9, 0.2, 0.08, 1.9) R <- c(2.1, 2.9, 2.7, 1.9, 1.3, 1.4, 2.3, 0.5, 1.5, 4.6 ) data <- data.frame(L, R) IC2MM(Surv(L,R, type = 'interval2') ~ 1, data ) IC2MM(Surv(L,R, type = 'interval2') ~ 1, data, control=IC2Control(Pdigits=2) )
library(survival) L <- c(1.5, 0.1, 1.5, 0.5, 0.4, 0.2, 0.9, 0.2, 0.08, 1.9) R <- c(2.1, 2.9, 2.7, 1.9, 1.3, 1.4, 2.3, 0.5, 1.5, 4.6 ) data <- data.frame(L, R) IC2MM(Surv(L,R, type = 'interval2') ~ 1, data ) IC2MM(Surv(L,R, type = 'interval2') ~ 1, data, control=IC2Control(Pdigits=2) )
Calculate non-parametric estimate for case II interval censored survival function
IC2Pro(L, R, control = IC2Control(), ...)
IC2Pro(L, R, control = IC2Control(), ...)
L |
The numeric vector of left endpoints of censoring interval, the first element of Surv when type=’interval2’. |
R |
The numeric vector of right endpoints of censoring interval, the second element of Surv function when type=’interval2’. |
control |
An object as created by |
... |
Additional arguments |
An object of class IC2Pro
that contains the following fields: error
: convergence result; strata
: dimensions of df_tab
;
s
: unique ordered elements of ;
S
: the survival function;
df_tab
: the data frame of survival intervals and survival probabilities for each interval.
Tian G.L., Huang X.F. and Xu, J.(2019). 'An assembly and decomposition approach for constructing separable minorizing functions in a class of MM algorithms.' Statistica Sinica 29(2), 961-982.
L <- c(1.4, 1.5, 1.3, 0.9, 0.4, 0.2, 0.5, 0.03, 1.7, 0.2) R <- c(2.2, 3, 2.4, 1.2, 2.8, 0.3, 1.6, 2.5, 2.6, 3.4) IC2Pro(L, R, control=IC2Control())
L <- c(1.4, 1.5, 1.3, 0.9, 0.4, 0.2, 0.5, 0.03, 1.7, 0.2) R <- c(2.2, 3, 2.4, 1.2, 2.8, 0.3, 1.6, 2.5, 2.6, 3.4) IC2Pro(L, R, control=IC2Control())
The data consisted of the time to first and second infection relapse in 38 kidney disease patients using a portable dialysis machine. Infection may occur where the catheter was inserted. Catheters are subsequently removed if infection develops and may be removed for other reasons, in which case observations are censored.
kidney
kidney
An object of class data.frame
with 76 rows and 7 columns.
Kidney infection data contains the following fields:
patient |
id |
time |
time |
status |
event status |
age |
in years |
sex |
1=male, 2=female |
disease |
disease type (0=GN, 1=AN, 2=PKD, 3=Other) |
frail |
frailty estimate from original paper |
McGilchrist C.A. and Aisbett C.W.(1991). "Regression with frailty in survival analysis." Biometrics 47, 461-466.
data = data(Kidney)
data = data(Kidney)
The LTNMM
function is used to calculate a left-truncated normal distribution model. A has the density function
where are two unknown parameters,
is a known constant,
, and
is the cdf of the standard normal distribution.
LTNMM( formula, a, mu = NULL, sigma = NULL, data = sys.frame(sys.parent()), Maxiter = 2000, convergence = 1e-06, ... )
LTNMM( formula, a, mu = NULL, sigma = NULL, data = sys.frame(sys.parent()), Maxiter = 2000, convergence = 1e-06, ... )
formula |
A formula object which symbolically describes the model to calculated. |
a |
A numeric scalar of the known left truncation value. |
mu |
The mean of the normal distribution is set to NULL by default. If the distribution is truncated, we use estimates from OLS. |
sigma |
The variance of the normal distribution is set to NULL by default. If the distribution is truncated, we use estimates from OLS. |
data |
List that contains corresponding covariates. If none is provided then assumes objects are in user’s environment. |
Maxiter |
The maximum number of iterations is specified by default as 2000. |
convergence |
Specify the convergence criterion, the default is 1e-6. |
... |
Additional arguments |
The LTNMM
function is used to calculate a left-truncated normal distribution model using MM algorithms based on AD technology.
The formula
parameter can be used to provide the data that needs to be calculated, such as formula=y~1
. By default, the
data
is provided by the user’s environment. The initial values of the mean and variance of the normal distribution are estimated using OLS.
An object of class LTNMM
that contains the following fields: total amount of observations,
the number of iterations, convergence rate, the log likelihood value, estimated results for the unknown parameters,
the standard deviation of estimate for the unknown parameters, the likelihood-based 95% confidence interval for the unknown parameters,
information criterion: AIC value and BIC value.
Tian G.L., Huang X.F., and Xu, J.(2019). 'An assembly and decomposition approach for constructing separable minorizing functions in a class of MM algorithms.' Statistica Sinica 29(2), 961-982.
y=c(8.7, 5.4, 8.9, 5.8, 6.2, 9.9, 7.5, 9.5, 6.5, 6.3); a=5 LTNMM(y~1, a=5)
y=c(8.7, 5.4, 8.9, 5.8, 6.2, 9.9, 7.5, 9.5, 6.5, 6.3); a=5 LTNMM(y~1, a=5)
Survival in patients with advanced lung cancer from the North Central Cancer Treatment Group. Performance scores rate how well the patient can perform usual daily activities.
lung
lung
An object of class data.frame
with 228 rows and 10 columns.
Kidney infection data contains the following fields:
inst |
Institution code |
time |
Survival time in days |
status |
censoring status 1=censored, 2=dead |
age |
Age in years |
sex |
Male=1 Female=2 |
ph.ecog |
ECOG performance score as rated by the physician. 0=asymptomatic, 1= symptomatic but completely ambulatory |
ph.karno |
Karnofsky performance score (bad=0-good=100) rated by physician |
pat.karno |
Karnofsky performance score as rated by patient |
meal.cal |
Calories consumed at meals |
wt.loss |
Weight loss in last six months (pounds) |
Finkelstein D.M. and Wolfe R.A.(1985). "A semiparametric model for regression analysis of interval-censored failure time data." Biometrics 41, 933-945.
data = data(lung)
data = data(lung)
Plot the Cox object
## S3 method for class 'Cox' plot( x, xlab = "Time", ylab = "Cumulative hazard", type = "s", lty = 1, lwd = 1, col = gray(0), digits = 4, ... )
## S3 method for class 'Cox' plot( x, xlab = "Time", ylab = "Cumulative hazard", type = "s", lty = 1, lwd = 1, col = gray(0), digits = 4, ... )
x |
The Cox object, see |
xlab |
x label, default is 'Time'. |
ylab |
y label, default is 'Cumulative hazard'. |
type |
type value, default is 's'. |
lty |
lty value for line, default is 1. |
lwd |
line width, default is 1. |
col |
color parameter, default is gray(0). |
digits |
The digits after the decimal point, default = 4. |
... |
Additional arguments |
the dataframe of 'Time' and accumulative hazard .
library(survival) result <- CoxMM(Surv(time, status) ~ age + sex, lung) plot(result)
library(survival) result <- CoxMM(Surv(time, status) ~ age + sex, lung) plot(result)
Plot the GaF object
## S3 method for class 'GaF' plot( x, xlab = "Time", ylab = "Cumulative hazard", type = "s", lty = 1, lwd = 1, col = gray(0), digits = 4, ... )
## S3 method for class 'GaF' plot( x, xlab = "Time", ylab = "Cumulative hazard", type = "s", lty = 1, lwd = 1, col = gray(0), digits = 4, ... )
x |
The GaF object, see |
xlab |
x label, default is 'Time'. |
ylab |
y label, default is 'Cumulative hazard'. |
type |
type value, default is 's'. |
lty |
lty value for line, default is 1. |
lwd |
line width, default is 1. |
col |
color parameter, default is gray(0). |
digits |
The digits after the decimal point, default = 4. |
... |
Additional arguments |
the dataframe of 'Time' and accumulative hazard .
library(survival) result <- GaFrailtyMM(Surv(time, status) ~ age + sex + cluster(id), data=kidney) plot(result)
library(survival) result <- GaFrailtyMM(Surv(time, status) ~ age + sex + cluster(id), data=kidney) plot(result)
Plot the IC2 object
## S3 method for class 'IC2' plot( x, xlab = "Time", ylab = "Survival", legend = NULL, main = "Survival Function", lty = 1:9, lwd = 1, xleg = 0, yleg = 0.15, col = gray(0), ... )
## S3 method for class 'IC2' plot( x, xlab = "Time", ylab = "Survival", legend = NULL, main = "Survival Function", lty = 1:9, lwd = 1, xleg = 0, yleg = 0.15, col = gray(0), ... )
x |
The IC2 object, see |
xlab |
x label, default is 'Time'. |
ylab |
y label, default is 'Survival'. |
legend |
legend, default=NULL. |
main |
figure title, default is 'Survival Function' |
lty |
lty value for line, default is 1:9. |
lwd |
line width, default is 1. |
xleg |
positional parameters of the legend, default=0. |
yleg |
positional parameters of the legend, default=0.15 . |
col |
the color of the drawing, default=gray(0) |
... |
Additional arguments |
A list of arguments for the legend. Values are x, y, legend, fill, lty, bty, col.
library(survival) result = IC2MM(Surv(left, right, type = 'interval2') ~ treatment, bcos) plot(result, col=c('red', 'blue'))
library(survival) result = IC2MM(Surv(left, right, type = 'interval2') ~ treatment, bcos) plot(result, col=c('red', 'blue'))
This function returns the result of the CoxMM
function
## S3 method for class 'Cox' summary(object, digits = 4, ...)
## S3 method for class 'Cox' summary(object, digits = 4, ...)
object |
Output from a call to Cox. |
digits |
The desired number of digits after the decimal point. Default of 4 digits is used. |
... |
Additional arguments |
Summary for CoxMM
objects.
library(survival) result <- CoxMM(Surv(time, status) ~ age + sex, lung) summary(result,digits=4)
library(survival) result <- CoxMM(Surv(time, status) ~ age + sex, lung) summary(result,digits=4)
This function returns the result of the CZIGPMM
function
## S3 method for class 'CZIGP' summary(object, digits = 4, ...)
## S3 method for class 'CZIGP' summary(object, digits = 4, ...)
object |
Output from a call to CZIGP. |
digits |
The desired number of digits after the decimal point. Default of 4 digits is used. |
... |
Additional arguments |
Summary for CZIGPMM
objects.
x1 <- c(0,35,23,34,8,19,0,0,0,0) x2 <- c(38,15,0,25,34,0,0,0,0,0) y <- cbind(x1, x2) phi0 = 0.5; phi = rep(0.5,2); la = rep(1,2); th = rep(0.1,2) result <- CZIGPMM(y, phi0, phi, la, th) summary(result,digits=4)
x1 <- c(0,35,23,34,8,19,0,0,0,0) x2 <- c(38,15,0,25,34,0,0,0,0,0) y <- cbind(x1, x2) phi0 = 0.5; phi = rep(0.5,2); la = rep(1,2); th = rep(0.1,2) result <- CZIGPMM(y, phi0, phi, la, th) summary(result,digits=4)
This function returns the result of the GaFrailtyMM
function
## S3 method for class 'GaF' summary(object, digits = 4, ...)
## S3 method for class 'GaF' summary(object, digits = 4, ...)
object |
Output from a call to GaF. |
digits |
The desired number of digits after the decimal point. Default of 4 digits is used. |
... |
Additional arguments |
Summary for GaFrailtyMM
objects.
library(survival) result <- GaFrailtyMM(Surv(time, status) ~ age + sex + cluster(id), data=kidney) summary(result,digits=4)
library(survival) result <- GaFrailtyMM(Surv(time, status) ~ age + sex + cluster(id), data=kidney) summary(result,digits=4)
This function returns the result of the IC2MM
function
## S3 method for class 'IC2' summary(object, ...)
## S3 method for class 'IC2' summary(object, ...)
object |
Output from a call to IC2. |
... |
Additional arguments |
Summary for IC2MM
objects.
library(survival) result <- IC2MM(Surv(left, right, type = 'interval2') ~ treatment, bcos) summary(result)
library(survival) result <- IC2MM(Surv(left, right, type = 'interval2') ~ treatment, bcos) summary(result)
This function returns the result of the LTNMM
function
## S3 method for class 'LTN' summary(object, digits = 4, ...)
## S3 method for class 'LTN' summary(object, digits = 4, ...)
object |
Output from a call to LTN. |
digits |
The desired number of digits after the decimal point. Default of 4 digits is used. |
... |
Additional arguments |
Summary for LTNMM
objects.
y=c(8.7, 5.4, 8.9, 5.8, 6.2, 9.9, 7.5, 9.5, 6.5, 6.3); a=5 result <- LTNMM(y~1, a=5) summary(result,digits=4)
y=c(8.7, 5.4, 8.9, 5.8, 6.2, 9.9, 7.5, 9.5, 6.5, 6.3); a=5 result <- LTNMM(y~1, a=5) summary(result,digits=4)
This function returns the result of the ZIGPMM
function
## S3 method for class 'ZIGP' summary(object, digits = 4, ...)
## S3 method for class 'ZIGP' summary(object, digits = 4, ...)
object |
Output from a call to ZIGP. |
digits |
The desired number of digits after the decimal point. Default of 4 digits is used. |
... |
Additional arguments |
Summary for ZIGPMM
objects.
x1 <- c(0, 0, 0,38, 0,19,25, 0,25, 0) x2 <- c(0, 0, 0,23, 0,51,24, 0,10, 0) y <- cbind(x1, x2) phi0 = 0.5; la = rep(1,2); th = rep(0.1,2) result <- ZIGPMM(y, phi0, la, th) summary(result,digits=4)
x1 <- c(0, 0, 0,38, 0,19,25, 0,25, 0) x2 <- c(0, 0, 0,23, 0,51,24, 0,10, 0) y <- cbind(x1, x2) phi0 = 0.5; la = rep(1,2); th = rep(0.1,2) result <- ZIGPMM(y, phi0, la, th) summary(result,digits=4)
Jung and Winkelmann(1993) provided data on both the numbers of voluntary and involuntary job changes of males during ten period 1974–1984. The samples contain 2124 males who started their working career before or in 1974 and did not retire before 1984.
vijc
vijc
An object of class data.frame
with 2124 rows and 2 columns.
Voluntary and involuntary job changes data contains the following fields:
y1 |
Job changes after experiencing an unemployment spell(assumed to be involuntary) |
y2 |
Direct job to job changes(which are assumed to be voluntary) |
Huang X.F., Tian G.L., Zhang, C. and Jiang, X.(2017). "Type I multivariate zero-inflated generalized Poisson distribution with applications." Statistics and its Interface 10(2), 291-311.
Jung R.C. and Winkelmann R.(1993). "Two aspects of labor mobility: A bivariate Poisson regression approach." Empirical Economics 18(3), 543–556.
data = data(vijc)
data = data(vijc)
Let ,
,
, for
, and
are mutually independent. An
dimensional discrete random vector
is said to have a Type I
multivariate zero-inflated generalized Poisson distribution(ZIGP) distribution if
where ,
,
,
and
is the largest positive integer for each
when
.
The
ZIGPMM
function is used to calculate the Type I multivariate ZIGP model.
ZIGPMM(data, phi0, la, th, Maxiter = 2000, convergence = 1e-06, ...)
ZIGPMM(data, phi0, la, th, Maxiter = 2000, convergence = 1e-06, ...)
data |
Data.frame or Matrix that contains corresponding covariates. |
phi0 |
Probability value for the zero-inflated parameter for ZIGP model. |
la |
The scale parameter for Generalized Poisson distribution model. |
th |
The discrete parameter for Generalized Poisson distribution model. |
Maxiter |
The maximum number of iterations is specified by default as 2000. |
convergence |
Specify the convergence criterion, the default is 1e-6. |
... |
Additional arguments |
The ZIGPMM
function is used to calculate Type I multivariate zero-inflated generalized Poisson distribution model using MM algorithms
based on AD technology. data
is provided by user by default, it can be a data frame or a matrix. In addition, the unknown parameters require users to give appropriate initial values,
where 0<=phi0<1
, each th
should satisfy 0<=th<1
, and each la
should be greater than 0.
An object of class ZIGPMM
that contains the following fields: total amount of observations,
the number of iterations, convergence rate, the log likelihood value, estimated results for the unknown parameters,
the standard deviation of estimate for the unknown parameters, the likelihood-based 95% confidence interval for the unknown parameters,
information criterion: AIC value and BIC value.
Tian G.L., Huang X.F. and Xu, J.(2019). 'An assembly and decomposition approach for constructing separable minorizing functions in a class of MM algorithms.' Statistica Sinica 29(2), 961-982.
Huang X.F., Tian G.L., Zhang, C. and Jiang, X.(2017). 'Type I multivariate zero-inflated generalized Poisson distribution with applications.' Statistics and its Interface 10(2), 291-311.
x1 <- c(0, 0, 0,38, 0,19,25, 0,25, 0) x2 <- c(0, 0, 0,23, 0,51,24, 0,10, 0) y <- cbind(x1, x2) phi0 = 0.5; la = rep(1,2); th = rep(0.1,2) ZIGPMM(y, phi0, la, th)
x1 <- c(0, 0, 0,38, 0,19,25, 0,25, 0) x2 <- c(0, 0, 0,23, 0,51,24, 0,10, 0) y <- cbind(x1, x2) phi0 = 0.5; la = rep(1,2); th = rep(0.1,2) ZIGPMM(y, phi0, la, th)