Title: | Tensor Regression with Envelope Structure |
---|---|
Description: | Provides three estimators for tensor response regression (TRR) and tensor predictor regression (TPR) models with tensor envelope structure. The three types of estimation approaches are generic and can be applied to any envelope estimation problems. The full Grassmannian (FG) optimization is often associated with likelihood-based estimation but requires heavy computation and good initialization; the one-directional optimization approaches (1D and ECD algorithms) are faster, stable and does not require carefully chosen initial values; the SIMPLS-type is motivated by the partial least squares regression and is computationally the least expensive. For details of TRR, see Li L, Zhang X (2017) <doi:10.1080/01621459.2016.1193022>. For details of TPR, see Zhang X, Li L (2017) <doi:10.1080/00401706.2016.1272495>. For details of 1D algorithm, see Cook RD, Zhang X (2016) <doi:10.1080/10618600.2015.1029577>. For details of ECD algorithm, see Cook RD, Zhang X (2018) <doi:10.5705/ss.202016.0037>. For more details of the package, see Zeng J, Wang W, Zhang X (2021) <doi:10.18637/jss.v099.i12>. |
Authors: | Wenjing Wang [aut], Jing Zeng [aut, cre], Xin Zhang [aut] |
Maintainer: | Jing Zeng <[email protected]> |
License: | GPL-3 |
Version: | 1.1.5 |
Built: | 2025-04-01 04:18:22 UTC |
Source: | https://github.com/jingzzeng/tres |
Provides the ordinary least squares estimator and the three types of tensor envelope structured estimators for tensor response regression (TRR) and tensor predictor regression (TPR) models. The three types of tensor envelope structured approaches are generic and can be applied to any envelope estimation problems. The full Grassmannian (FG) optimization is often associated with likelihood-based estimation but requires heavy computation and good initialization; the one-directional optimization approaches (1D and ECD algorithms) are faster, stable and does not require carefully chosen initial values; the SIMPLS-type is motivated by the partial least squares regression and is computationally the least expensive.
Wenjing Wang, Jing Zeng and Xin Zhang
Zeng J., Wang W., Zhang X. (2021) TRES: An R Package for Tensor Regression and Envelope Algorithms. Journal of Statistical Software, 99(12), 1-31. doi:10.18637/jss.v099.i12.
Cook, R.D. and Zhang, X. (2016). Algorithms for envelope estimation. Journal of Computational and Graphical Statistics, 25(1), pp.284-300.
Li, L. and Zhang, X. (2017). Parsimonious tensor response regression. Journal of the American Statistical Association, 112(519), pp.1131-1146.
Zhang, X. and Li, L. (2017). Tensor envelope partial least-squares regression. Technometrics, 59(4), pp.426-436.
Cook, R.D. and Zhang, X. (2018). Fast envelope algorithms. Statistica Sinica, 28(3), pp.1179-1197.
Useful links:
library(TRES) ## Load data "bat" data("bat") x <- bat$x y <- bat$y ## 1. Fitting with OLS method. fit_ols <- TRR.fit(x, y, method="standard") ## Print cofficient coef(fit_ols) ## Print the summary summary(fit_ols) ## Extract the mean squared error, p-value and standard error from summary summary(fit_ols)$mse summary(fit_ols)$p_val summary(fit_ols)$se ## Make the prediction on the original dataset predict(fit_ols, x) ## Draw the plots of two-way coefficient tensor (i.e., matrix) and p-value tensor. plot(fit_ols) ## 2. Fitting with 1D envelope algorithm. (time-consuming) fit_1D <- TRR.fit(x, y, u = c(14,14), method="1D") # pass envelope rank (14,14) coef(fit_1D) summary(fit_1D) predict(fit_1D, x) plot(fit_1D)
library(TRES) ## Load data "bat" data("bat") x <- bat$x y <- bat$y ## 1. Fitting with OLS method. fit_ols <- TRR.fit(x, y, method="standard") ## Print cofficient coef(fit_ols) ## Print the summary summary(fit_ols) ## Extract the mean squared error, p-value and standard error from summary summary(fit_ols)$mse summary(fit_ols)$p_val summary(fit_ols)$se ## Make the prediction on the original dataset predict(fit_ols, x) ## Draw the plots of two-way coefficient tensor (i.e., matrix) and p-value tensor. plot(fit_ols) ## 2. Fitting with 1D envelope algorithm. (time-consuming) fit_1D <- TRR.fit(x, y, u = c(14,14), method="1D") # pass envelope rank (14,14) coef(fit_1D) summary(fit_1D) predict(fit_1D, x) plot(fit_1D)
Synthetic data generated from tensor response regression (TRR) model. Each response observation is a two-dimensional image, and each binary predictor observation takes values 0 and 1, representing two groups.
data("bat")
data("bat")
A list consisting of four components:
A matrix, each entry takes values 0 and 1, representing two groups.
A tensor, each matrix
y@data[,,i]
represents an image.
A tensor with the bat pattern.
A list consisting of two envelope basis.
The dataset is generated from the tensor response regression (TRR) model:
where and the regression coefficient
is a given image with rank 14, representing the mean difference of the response
between two groups. To make the model conform to the envelope structure, we construct the envelope basis
and the covariance matrices
, of error term as following. With the singular value decomposition of
, namely
, we choose the envelope basis as
. Then the envelope dimensions are
. We generate another two matrices
and
, where
and
are randomly generated from Uniform(0,1) elementwise. Then we set the covariance matrices
, followed by normalization with their Frobenius norms. We set the first 10 predictors
as 1 and the rest as 0. The error term is then generated from two-way tensor (matrix) normal distribution
.
Li, L. and Zhang, X., 2017. Parsimonious tensor response regression. Journal of the American Statistical Association, 112(519), pp.1131-1146.
## Fit bat dataset with the tensor response regression model data("bat") x <- bat$x y <- bat$y # Model fitting with ordinary least square. fit_std <- TRR.fit(x, y, method="standard") # Draw the coefficient and p-value plots plot(fit_std)
## Fit bat dataset with the tensor response regression model data("bat") x <- bat$x y <- bat$y # Model fitting with ordinary least square. fit_std <- TRR.fit(x, y, method="standard") # Draw the coefficient and p-value plots plot(fit_std)
Estimate the envelope subspace with specified dimension based on ECD algorithm proposed by Cook, R. D., & Zhang, X. (2018).
ECD(M, U, u, ...)
ECD(M, U, u, ...)
M |
The |
U |
The |
u |
An integer between 0 and |
... |
Additional user-defined arguments:
The default values are: |
Estimate M
-envelope of span(U)
. The dimension of the envelope is u
.
See FGfun
for the generic objective function.
The ECD algorithm is similar to 1D algorithm proposed by Cook, R. D., & Zhang, X. (2016). A fast and stable algorithm is used for solving each individual objective function.
Return the orthogonal basis of the envelope subspace with each column represent the sequential direction. For example, the first column is the most informative direction.
Cook, R.D. and Zhang, X., 2018. Fast envelope algorithms. Statistica Sinica, 28(3), pp.1179-1197.
##simulate two matrices M and U with an envelope structure# data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_ECD <- ECD(M, U, u=5) subspace(Gamma_ECD, G)
##simulate two matrices M and U with an envelope structure# data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_ECD <- ECD(M, U, u=5) subspace(Gamma_ECD, G)
EEG images data of subjects in alcoholic and control groups.
data("EEG")
data("EEG")
A list consisting of two components:
A binary vector with length of 61.
A tensor, consisting of 61 channels by time EEG images.
The original EEG data contains 77 alcoholic individuals and 45 controls. To reduce the size, we randomly select 61 samples and obtain 39 alcoholic individuals and 22 controls. Each individual was measured with 64 electrodes placed on the scalp sampled at 256 Hz for 1 sec, resulting an EEG image of 64 channels by 256 time points. More information about data collection and some analysis can be found in Zhang et al. (1995) and Li, Kim, and Altman (2010). To facilitate the analysis, the data is downsized along the time domain by averaging every four consecutive time points, yielding a 64 × 64 matrix response.
URL: https://archive.ics.uci.edu/ml/datasets/EEG+Database.
Li, L. and Zhang, X., 2017. Parsimonious tensor response regression. Journal of the American Statistical Association, 112(519), pp.1131-1146.
Zhang, X.L., Begleiter, H., Porjesz, B., Wang, W. and Litke, A., 1995. Event related potentials during object recognition tasks. Brain research bulletin, 38(6), pp.531-538.
Li, B., Kim, M.K. and Altman, N., 2010. On dimension folding of matrix-or array-valued statistical objects. The Annals of Statistics, 38(2), pp.1094-1121.
data("EEG") x <- EEG$x y <- EEG$y ## Estimate the envelope dimension, the output should be c(1,1). u <- TRRdim(x, y)$u u <- c(1,1) ## Fit the dataset with TRR.fit and draw the coefficient plot and p-value plot fit_1D <- TRR.fit(x, y, u, method = "1D") plot(fit_1D, xlab = "Time", ylab = "Channels") ## Uncomment display the plots from different methods. # fit_ols <- TRR.fit(x, y, method = "standard") # fit_pls <- TRR.fit(x, y, u, method = "PLS") # plot(fit_ols, xlab = "Time", ylab = "Channels") # plot(fit_pls, xlab = "Time", ylab = "Channels")
data("EEG") x <- EEG$x y <- EEG$y ## Estimate the envelope dimension, the output should be c(1,1). u <- TRRdim(x, y)$u u <- c(1,1) ## Fit the dataset with TRR.fit and draw the coefficient plot and p-value plot fit_1D <- TRR.fit(x, y, u, method = "1D") plot(fit_1D, xlab = "Time", ylab = "Channels") ## Uncomment display the plots from different methods. # fit_ols <- TRR.fit(x, y, method = "standard") # fit_pls <- TRR.fit(x, y, u, method = "PLS") # plot(fit_ols, xlab = "Time", ylab = "Channels") # plot(fit_pls, xlab = "Time", ylab = "Channels")
Calculates the objective function and its gradient for estimating the -envelope of span(
), where
is positive definite and
is positive semi-definite.
FGfun(Gamma, M, U)
FGfun(Gamma, M, U)
Gamma |
|
M |
The |
U |
The |
The generic objective function and its gradient
are listed below for estimating
-envelope of span(
). For the detailed description, see Cook, R. D., & Zhang, X. (2016).
F |
The value of the objective function at |
G |
The value of the gradient function at |
Cook, R.D. and Zhang, X., 2016. Algorithms for envelope estimation. Journal of Computational and Graphical Statistics, 25(1), pp.284-300.
This function provides the MLE of the covariance matrix of tensor normal distribution, where the covariance has a separable Kronecker structure, i.e. . The algorithm is a generalization of the MLE algorithm in Manceur, A. M., & Dutilleul, P. (2013).
kroncov(Tn, tol = 1e-06, maxiter = 10)
kroncov(Tn, tol = 1e-06, maxiter = 10)
Tn |
A |
tol |
The convergence tolerance with default value |
maxiter |
The maximal number of iterations. The default value is 10. |
The individual component covariance matrices are not identifiable. To overcome the identifiability issue, each matrix
is normalized at the end of the iteration such that
. And an overall normalizing constant
is extracted so that the overall covariance matrix
is defined as
If Tn
is a design matrix for a multivariate random variable, then
lambda = 1
and S
is a length-one list containing the sample covariance matrix.
lambda |
The normalizing constant. |
S |
A matrix list, consisting of each normalized covariance matrix |
Manceur, A.M. and Dutilleul, P., 2013. Maximum likelihood estimation for the tensor normal distribution: Algorithm, minimum sample size, and empirical bias and dispersion. Journal of Computational and Applied Mathematics, 239, pp.37-49.
The 1D algorithm (Cook and Zhang 2016) implemented with Riemannian manifold optimization from R package ManifoldOptim.
manifold1D(M, U, u, ...)
manifold1D(M, U, u, ...)
M |
The |
U |
The |
u |
An integer between 0 and |
... |
Additional user-defined arguments:
The default values are: |
Estimate M
-envelope of span(U)
. The dimension of the envelope is u
.
Return the estimated orthogonal basis of the envelope subspace.
Cook, R.D. and Zhang, X., 2016. Algorithms for envelope estimation. Journal of Computational and Graphical Statistics, 25(1), pp.284-300.
Huang, W., Absil, P.A., Gallivan, K.A. and Hand, P., 2018. ROPTLIB: an object-oriented C++ library for optimization on Riemannian manifolds. ACM Transactions on Mathematical Software (TOMS), 44(4), pp.1-21.
## Simulate two matrices M and U with an envelope structure data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_1D <- manifold1D(M, U, u = 5) subspace(Gamma_1D, G)
## Simulate two matrices M and U with an envelope structure data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_1D <- manifold1D(M, U, u = 5) subspace(Gamma_1D, G)
The FG algorithm (Cook and Zhang 2016) implemented with Riemannian manifold optimization from R package ManifoldOptim.
manifoldFG(M, U, u, Gamma_init = NULL, ...)
manifoldFG(M, U, u, Gamma_init = NULL, ...)
M |
The |
U |
The |
u |
An integer between 0 and |
Gamma_init |
Initial envelope subspace basis. The default value is the estimator from |
... |
Additional user-defined arguments:
The default values are: |
Estimate M
-envelope of span(U)
. The dimension of the envelope is u
.
Return the estimated orthogonal basis of the envelope subspace.
Cook, R.D. and Zhang, X., 2016. Algorithms for envelope estimation. Journal of Computational and Graphical Statistics, 25(1), pp.284-300.
Huang, W., Absil, P.A., Gallivan, K.A. and Hand, P., 2018. ROPTLIB: an object-oriented C++ library for optimization on Riemannian manifolds. ACM Transactions on Mathematical Software (TOMS), 44(4), pp.1-21.
##simulate two matrices M and U with an envelope structure data <- MenvU_sim(p=20, u=5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_FG <- manifoldFG(M, U, u=5) subspace(Gamma_FG, G)
##simulate two matrices M and U with an envelope structure data <- MenvU_sim(p=20, u=5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_FG <- manifoldFG(M, U, u=5) subspace(Gamma_FG, G)
and
This function generates the matrices and
with envelope structure.
MenvU_sim( p, u, Omega = NULL, Omega0 = NULL, Phi = NULL, jitter = FALSE, wishart = FALSE, n = NULL )
MenvU_sim( p, u, Omega = NULL, Omega0 = NULL, Phi = NULL, jitter = FALSE, wishart = FALSE, n = NULL )
p |
Dimension of |
u |
The envelope dimension. An integer between 0 and |
Omega |
The positive definite matrix |
Omega0 |
The positive definite matrix |
Phi |
The positive definite matrix |
jitter |
Logical or numeric. If it is numeric, the diagonal matrix |
wishart |
Logical. If it is |
n |
The sample size. If |
The matrices and
are in forms of
The envelope basis is randomly generated from the Uniform (0, 1) distribution elementwise and then transformed to a semi-orthogonal matrix.
is the orthogonal completion of
.
In some cases, to guarantee that is positive definite which is required by the definition of envelope, a
jitter
should be added to .
If wishart
is TRUE
, after the matrices and
are generated, the samples from Wishart distribution
and
are output as matrices
and
. If so,
n
is required.
M |
The |
U |
The |
Gamma |
The |
Cook, R.D. and Zhang, X., 2018. Fast envelope algorithms. Statistica Sinica, 28(3), pp.1179-1197.
data1 <- MenvU_sim(p = 20, u = 5) M1 <- data1$M U1 <- data1$U # Sample version from Wishart distribution data2 <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M2 <- data2$M U2 <- data2$U
data1 <- MenvU_sim(p = 20, u = 5) M1 <- data1$M U1 <- data1$U # Sample version from Wishart distribution data2 <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M2 <- data2$M U2 <- data2$U
This function selects envelope subspace dimension using 1D-BIC proposed by Zhang, X., & Mai, Q. (2018). The constrained optimization in the 1D algorithm is based on the line search algorithm for optimization on manifold. The algorithm is developed by Wen and Yin (2013) and the Matlab version is in the Matlab package OptM.
oneD_bic(M, U, n, C = 1, maxdim = 10, ...)
oneD_bic(M, U, n, C = 1, maxdim = 10, ...)
M |
The |
U |
The |
n |
The sample size. |
C |
The constant defined in 1D-BIC criterion, the default value is 1. |
maxdim |
The maximum dimension to consider, |
... |
Additional user-defined arguments for the line search algorithm:
The default values are: |
The objective function and its gradient
in line search algorithm are:
See Cook, R. D., & Zhang, X. (2016) for more details of the 1D algorithm.
The 1D-BIC criterion is defined as
where is a constant,
is the 1D solver, the function
is the individual objective function solved by 1D algorithm,
is the sample size. Then the selected dimension
is the one yielding the smallest 1D-BIC
. See Zhang, X., & Mai, Q. (2018) for more details.
As suggested by Zhang, X., & Mai, Q. (2018), the number should be set to its default value
when there is no additional model assumption or prior information. However, if additional model assumption or prior information are known, C should be set such that
best matches the degree-of-freedom or total number of free parameters of the model or estimation procedure. For example, in TRR model where the predictor design matrix is of dimension
,
should be set as
. See Zhang, X., & Mai, Q. (2018) for more details.
bicval |
The BIC values for different envelope dimensions. |
u |
The dimension selected which corresponds to the smallest BIC values. |
Gamma |
The estimation of envelope subspace basis. |
Zhang, X. and Mai, Q., 2018. Model-free envelope dimension selection. Electronic Journal of Statistics, 12(2), pp.2193-2216.
Wen, Z. and Yin, W., 2013. A feasible method for optimization with orthogonality constraints. Mathematical Programming, 142(1-2), pp.397-434.
##simulate two matrices M and U with an envelope structure data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U bic <- oneD_bic(M, U, n = 200) ## visualization plot(1:10, bic$bicval, type="o", xlab="Envelope Dimension", ylab="BIC values", main="Envelope Dimension Selection")
##simulate two matrices M and U with an envelope structure data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U bic <- oneD_bic(M, U, n = 200) ## visualization plot(1:10, bic$bicval, type="o", xlab="Envelope Dimension", ylab="BIC values", main="Envelope Dimension Selection")
The 1D algorithm to estimate the envelope subspace based on the line search algorithm for optimization on manifold. The line search algorithm is developed by Wen and Yin (2013) and the Matlab version is implemented in the Matlab package OptM.
OptM1D(M, U, u, ...)
OptM1D(M, U, u, ...)
M |
The |
U |
The |
u |
An integer between 0 and |
... |
Additional user-defined arguments for the line search algorithm:
The default values are: |
The objective function and its gradient
in line search algorithm are:
See Cook, R. D., & Zhang, X. (2016) for more details of the 1D algorithm.
Return the estimated orthogonal basis of the envelope subspace.
Cook, R.D. and Zhang, X., 2016. Algorithms for envelope estimation. Journal of Computational and Graphical Statistics, 25(1), pp.284-300.
Wen, Z. and Yin, W., 2013. A feasible method for optimization with orthogonality constraints. Mathematical Programming, 142(1-2), pp.397-434.
## Simulate two matrices M and U with an envelope structure data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_1D <- OptM1D(M, U, u = 5) subspace(Gamma_1D, G)
## Simulate two matrices M and U with an envelope structure data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_1D <- OptM1D(M, U, u = 5) subspace(Gamma_1D, G)
The FG algorithm to estimate the envelope subspace based on the curvilinear search algorithm for optimization on Stiefel manifold. The curvilinear algorithm is developed by Wen and Yin (2013) and the Matlab version is implemented in the Matlab package OptM.
OptMFG(M, U, u, Gamma_init = NULL, ...)
OptMFG(M, U, u, Gamma_init = NULL, ...)
M |
The |
U |
The |
u |
An integer between 0 and |
Gamma_init |
Initial envelope subspace basis. The default value is the estimator from |
... |
Additional user-defined arguments for the curvilinear search algorithm:
The default values are: |
If Gamma_init
is provided, then the envelope dimension u = ncol(Gamma_init)
.
The function OptMFG
calls the function OptStiefelGBB
internally which implements the curvilinear search algorithm.
The objective function and its gradient
in curvilinear search algorithm are:
Return the estimated orthogonal basis of the envelope subspace.
Wen, Z. and Yin, W., 2013. A feasible method for optimization with orthogonality constraints. Mathematical Programming, 142(1-2), pp.397-434.
##simulate two matrices M and U with an envelope structure data <- MenvU_sim(p=20, u=5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_FG <- OptMFG(M, U, u=5) subspace(Gamma_FG, G)
##simulate two matrices M and U with an envelope structure data <- MenvU_sim(p=20, u=5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_FG <- OptMFG(M, U, u=5) subspace(Gamma_FG, G)
Curvilinear search algorithm for optimization on Stiefel manifold developed by Wen and Yin (2013).
OptStiefelGBB(X, fun, opts = NULL, ...)
OptStiefelGBB(X, fun, opts = NULL, ...)
X |
Initial value to start the optimization. A |
fun |
The function that returns the objective function value and its gradient. The syntax for |
opts |
A list specifying additional user-defined arguments for the curvilinear search algorithm. Some important ones are listed in the following:
The default values are: |
... |
Additional input passed to |
The calling syntax is OptStiefelGBB(X, fun, opts, data1, data2)
, where fun(X, data1, data2)
returns the objective function value and its gradient.
For example, for by
matrix
, the optimization problem is
The objective function and its gradient are
Then we need to provide the function fun(X, W)
which returns and
. See Examples for details.
For more details of the termination rules and the tolerances, we refer the interested readers to Section 5.1 of Wen and Yin (2013).
X |
The converged solution of the optimization problem. |
out |
Output information, including estimation error, function value, iteration times etc.
|
Wen, Z. and Yin, W., 2013. A feasible method for optimization with orthogonality constraints. Mathematical Programming, 142(1-2), pp.397-434.
n <- 1000 k <- 6 # Randomly generated matrix M W <- matrix(rnorm(n^2), n, n) W <- t(W) %*% W # Randomly generated orthonormal initial matrix X0 <- matrix(rnorm(n*k), n, k) X0 <- qr.Q(qr(X0)) # The objective function and its gradient fun <- function(X, W){ F <- - sum(diag(t(X) %*% W %*% X)) G <- - 2*(W %*% X) return(list(F = F, G = G)) } # Options list opts<-list(record = 0, maxiter = 1000, xtol = 1e-5, gtol = 1e-5, ftol = 1e-8) # Main part output <- OptStiefelGBB(X0, fun, opts, W) X <- output$X out <- output$out
n <- 1000 k <- 6 # Randomly generated matrix M W <- matrix(rnorm(n^2), n, n) W <- t(W) %*% W # Randomly generated orthonormal initial matrix X0 <- matrix(rnorm(n*k), n, k) X0 <- qr.Q(qr(X0)) # The objective function and its gradient fun <- function(X, W){ F <- - sum(diag(t(X) %*% W %*% X)) G <- - 2*(W %*% X) return(list(F = F, G = G)) } # Options list opts<-list(record = 0, maxiter = 1000, xtol = 1e-5, gtol = 1e-5, ftol = 1e-8) # Main part output <- OptStiefelGBB(X0, fun, opts, W) X <- output$X out <- output$out
Plot method for object returned from TRR.fit
and TPR.fit
functions.
## S3 method for class 'Tenv' plot( x, level = 0.05, main = paste0("Coefficient plot ", "(", x$method, ")"), main_p = paste0("P value plot ", "(", x$method, ")"), xlab = "", ylab = "", axes = TRUE, ask = TRUE, ... )
## S3 method for class 'Tenv' plot( x, level = 0.05, main = paste0("Coefficient plot ", "(", x$method, ")"), main_p = paste0("P value plot ", "(", x$method, ")"), xlab = "", ylab = "", axes = TRUE, ask = TRUE, ... )
x |
An object of class |
level |
The significant level of p-value. Default is 0.05. |
main |
The title of coefficient plot. |
main_p |
The title of |
xlab |
The title of x-axis. |
ylab |
The title of y-axis. |
axes |
A logical value specifying whether the axes should be drawn. |
ask |
A logical value. If it is TRUE (default), user is prompted before the second plot is shown (if exists). |
... |
Other parameters to be passed to the plotting functions. |
coef(x)
must be a two-way tensor or a matrix.
Since -value depend on
which is unavailable for the ultra-high dimensional
in tensor predictor regression (TPR), the
-value plot is not provided for the object returned from
TPR.fit
.
Therefore, for the object return from TPR.fit
, only the coefficients plot is displayed. And for the object return from TRR.fit
, both the coefficients plot and -value plot are displayed.
main
and main_p
control the titles of coefficient plot and -value plot separately. Some other arguments used in function
graphics::image
, e.g., xlim, ylim, zlim, col, xaxs, yaxs, etc.,
can be passed to ...
ask
can be set as FALSE
if the pause before the second plot is not preferred. If x
is an object from TPR.fit
, no pause is enabled.
No return value.
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") plot(fit) ## Change the significant level to 0.1 plot(fit, level = 0.1)
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") plot(fit) ## Change the significant level to 0.1 plot(fit, level = 0.1)
Evaluate the tensor response regression (TRR) or tensor predictor regression (TPR) model through the mean squared error.
PMSE(x, y, B)
PMSE(x, y, B)
x |
A predictor tensor, array, matrix or vector. |
y |
A response tensor, array, matrix or vector. |
B |
An coefficient tensor tensor, array, matrix or vector. |
There are three situations:
TRR model: If y
is an -way tensor (array),
x
should be matrix or vector and B
should be tensor or array.
TPR model: If x
is an -way tensor (array),
y
should be matrix or vector and B
should be tensor or array.
Other: If x
and y
are both matrix or vector, B
should be matrix. In this case, the prediction is calculated as pred = B*X
.
In any cases, users are asked to ensure the dimensions of x
, y
and B
match. See TRRsim
and TPRsim
for more details of the TRR and TPR models.
Let denote each prediction, then the mean squared error is defined as
, where
denotes the Frobenius norm.
mse |
The mean squared error. |
pred |
The predictions. |
## Dataset in TRR model r <- c(10, 10, 10) u <- c(2, 2, 2) p <- 5 n <- 100 dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y # Fit data with TRR.fit fit_std <- TRR.fit(x, y, method="standard") result <- PMSE(x, y, fit_std$coefficients) ## Dataset in TPR model p <- c(10, 10, 10) u <- c(1, 1, 1) r <- 5 n <- 200 dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y # Fit data with TPR.fit fit_std <- TPR.fit(x, y, u, method="standard") result <- PMSE(x, y, fit_std$coefficients)
## Dataset in TRR model r <- c(10, 10, 10) u <- c(2, 2, 2) p <- 5 n <- 100 dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y # Fit data with TRR.fit fit_std <- TRR.fit(x, y, method="standard") result <- PMSE(x, y, fit_std$coefficients) ## Dataset in TPR model p <- c(10, 10, 10) u <- c(1, 1, 1) r <- 5 n <- 200 dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y # Fit data with TPR.fit fit_std <- TPR.fit(x, y, u, method="standard") result <- PMSE(x, y, fit_std$coefficients)
Predict response for the object returned from TRR.fit
and TPR.fit
functions.
## S3 method for class 'Tenv' predict(object, newdata, ...)
## S3 method for class 'Tenv' predict(object, newdata, ...)
object |
An object of class |
newdata |
The data to be used for prediction. It can be a vector, a matrix or a tensor if |
... |
Additional arguments. No available arguments exist in this version. |
Return the predicted response.
If newdata
is missing, the fitted response from object
is returned.
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") predict(fit, x)
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") predict(fit, x)
This algorithm is a generalization of the SIMPLS algorithm in De Jong, S. (1993). See Cook (2018) Section 6.5 for more details of this generalized moment-based envelope algorithm; see Cook, Helland, and Su (2013) for a connection between SIMPLS and the predictor envelope in linear model.
simplsMU(M, U, u)
simplsMU(M, U, u)
M |
The |
U |
The |
u |
An integer between 0 and |
Returns the estimated orthogonal basis of the envelope subspace.
De Jong, S., 1993. SIMPLS: an alternative approach to partial least squares regression. Chemometrics and intelligent laboratory systems, 18(3), pp.251-263.
Cook, R.D., Helland, I.S. and Su, Z., 2013. Envelopes and partial least squares regression. Journal of the Royal Statistical Society: Series B (Statistical Methodology), 75(5), pp.851-877.
Cook, R.D., 2018. An introduction to envelopes: dimension reduction for efficient estimation in multivariate statistics (Vol. 401). John Wiley & Sons.
##simulate two matrices M and U with an envelope structure# data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_pls <- simplsMU(M, U, u=5) subspace(Gamma_pls, G)
##simulate two matrices M and U with an envelope structure# data <- MenvU_sim(p = 20, u = 5, wishart = TRUE, n = 200) M <- data$M U <- data$U G <- data$Gamma Gamma_pls <- simplsMU(M, U, u=5) subspace(Gamma_pls, G)
Synthetic data generated from tensor predictor regression (TPR) model. Each response observation is univariate, and each predictor observation is a matrix.
data("square")
data("square")
A list consisting of four components:
A tensor, each matrix
x@data[,,i]
represents a predictor observation.
A matrix, each entry represents a response observation.
A tensor with a square pattern.
A list consisting of two envelope basis.
The dataset is generated from the tensor predictor regression (TPR) model:
where and the regression coefficient
is a given image with rank 2, which has a square pattern. All the elements of the coefficient matrix
are either 0.1 or 1. To make the model conform to the envelope structure, we construct the envelope basis
and the covariance matrices
, of predictor
as following. With the singular value decomposition of
, namely
, we choose the envelope basis as
. Then the envelope dimensions are
. We set matrices
and
,
. Then we generate the covariance matrices
, followed by normalization with their Frobenius norms. The predictor
is then generated from two-way tensor (matrix) normal distribution
. And the error term
is generated from standard normal distribution.
Zhang, X. and Li, L., 2017. Tensor envelope partial least-squares regression. Technometrics, 59(4), pp.426-436.
## Fit square dataset with the tensor predictor regression model data("square") x <- square$x y <- square$y # Model fitting with ordinary least square. fit_std <- TPR.fit(x, y, method="standard") # Draw the coefficient plot. plot(fit_std)
## Fit square dataset with the tensor predictor regression model data("square") x <- square$x y <- square$y # Model fitting with ordinary least square. fit_std <- TPR.fit(x, y, method="standard") # Draw the coefficient plot. plot(fit_std)
Calculates the elementwise standard error for the object returned from TRR.fit
. The standard error for the object returned from TPR.fit
is unavailable.
std_err(object)
std_err(object)
object |
an object of class |
The standard error tensor is returned.
The function only supports the object returned from TRR.fit
since there is no standard error for the object returned from TPR.fit
.
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") std_err(fit)
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") std_err(fit)
This function calculates the distance between the two subspaces with equal dimensions span and span
, where
and
are the basis matrices of two subspaces. The distance is defined as
where is the projection matrix onto the given subspace with the standard inner product, and
is the common dimension.
subspace(A, B)
subspace(A, B)
A |
A |
B |
A |
Returns a distance metric that is between 0 and 1
Summary method for object returned from TRR.fit
and TPR.fit
functions.
## S3 method for class 'Tenv' summary(object, ...) ## S3 method for class 'summary.Tenv' print(x, ...)
## S3 method for class 'Tenv' summary(object, ...) ## S3 method for class 'summary.Tenv' print(x, ...)
object |
An object of class |
... |
Additional arguments. No available arguments exist in this version. |
x |
An object of class |
Extract call
, method
, coefficients
, residuals
, Gamma
from object
. And append mse
, -value and the standard error of estimated coefficient.
The mean squared error mse
is defined as , where
is the prediction and
is the Frobenius norm of tensor.
Since the -value and standard error depend on the estimation of cov
(vec
) which is unavailable for the ultra-high dimensional
in tensor predictor regression (TPR), the two statistics are only provided for the object returned from
TRR.fit
.
print.summary.Tenv
provides a more readable form of the statistics contained in summary.Tenv
. If object
is returned from TRR.fit
, then p-val
and se
are also returned.
Return object
with additional components
call |
The matched call. |
method |
The implemented method. |
n |
The sample size. |
xdim |
The dimension of predictor. |
ydim |
The dimension of response. |
coefficients |
The tensor coefficients estimated from |
residuals |
The residuals, which equals to the response minus the fitted values. |
Gamma |
A list of envelope subspace basis. |
mse |
The mean squared error. The mean squared Frobenius norm of the difference between each response |
p_val |
The p-value for coefficients. Only for the object returned from |
se |
The standard error for coefficients. Only for the object returned from |
Fitting functions TRR.fit
, TPR.fit
.
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") ##print summary summary(fit) ##Extract the p-value and standard error from summary summary(fit)$p_val summary(fit)$se
data("bat") x <- bat$x y <- bat$y fit <- TRR.fit(x, y, method="standard") ##print summary summary(fit) ##Extract the p-value and standard error from summary summary(fit)$p_val summary(fit)$se
-value and standard error of coefficient in tensor response regression (TRR) model.Obtain -value of each element in the tensor regression coefficient estimator. Two-sided t-tests are implemented on the coefficient estimator, where asymptotic covariance of the OLS estimator is used.
Tenv_Pval(x, y, Bhat)
Tenv_Pval(x, y, Bhat)
x |
The response tensor instance |
y |
A vector predictor of dimension |
Bhat |
The estimator of tensor regression coefficient. The |
p_ols |
The p-value tensor of OLS estimator. |
p_val |
The p-value tensor of |
se |
The standard error tensor of |
## Use dataset bat data("bat") x <- bat$x y <- bat$y fit_std <- TRR.fit(x, y, method="standard") Tenv_Pval(x, y, fit_std$coefficients)
## Use dataset bat data("bat") x <- bat$x y <- bat$y fit_std <- TRR.fit(x, y, method="standard") Tenv_Pval(x, y, fit_std$coefficients)
This function is used for estimation of tensor predictor regression. The available method including standard OLS type estimation, PLS type of estimation as well as envelope estimation with FG, 1D and ECD approaches.
TPR.fit(x, y, u, method=c('standard', 'FG', '1D', 'ECD', 'PLS'), Gamma_init = NULL)
TPR.fit(x, y, u, method=c('standard', 'FG', '1D', 'ECD', 'PLS'), Gamma_init = NULL)
x |
The predictor tensor instance of dimension |
y |
The response matrix of dimension |
u |
The dimension of envelope subspace. |
method |
The method used for estimation of tensor response regression. There are four possible choices.
|
Gamma_init |
A list specifying the initial envelope subspace basis for "FG" method. By default, the estimators given by "1D" algorithm is used. |
Please refer to Details part of TPRsim
for the description of the tensor predictor regression model.
TPR.fit
returns an object of class "Tenv".
The function summary
(i.e., summary.Tenv
) is used to print the summary of the results, including additional information, e.g., the p-value and the standard error for coefficients, and the prediction mean squared error.
The functions coefficients
, fitted.values
and residuals
can be used to extract different features returned from TPR.fit
.
The function plot
(i.e., plot.Tenv
) plots the two-dimensional coefficients and p-value for object of class "Tenv".
The function predict
(i.e., predict.Tenv
) predicts response for the object returned from TPR.fit
function.
x |
The original predictor dataset. |
y |
The original response dataset. |
call |
The matched call. |
method |
The implemented method. |
coefficients |
The estimation of regression coefficient tensor. |
Gamma |
The estimation of envelope subspace basis. |
Sigma |
A lists of estimated covariance matrices at each mode for the tensor predictors. |
fitted.values |
The fitted response matrix. |
residuals |
The residuals matrix. |
Zhang, X. and Li, L., 2017. Tensor envelope partial least-squares regression. Technometrics, 59(4), pp.426-436.
summary.Tenv
for summaries, calculating mean squared error from the prediction.
plot.Tenv
(via graphics::image
) for drawing the two-dimensional coefficient plot.
predict.Tenv
for prediction.
The generic functions coef, residuals, fitted
.
TPRdim
for selecting the dimension of envelope by cross-validation.
TPRsim
for generating the simulated data used in tensor prediction regression.
The simulated data square
used in tensor predictor regression.
# The dimension of predictor p <- c(10, 10, 10) # The envelope dimensions u. u <- c(1, 1, 1) # The dimension of response r <- 5 # The sample size n <- 200 # Simulate the data with TPRsim. dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y B <- dat$coefficients fit_std <- TPR.fit(x, y, method="standard") fit_FG <- TPR.fit(x, y, u, method="FG") fit_pls <- TPR.fit(x, y, u, method="PLS") rTensor::fnorm(B-stats::coef(fit_std)) rTensor::fnorm(B-stats::coef(fit_FG)) rTensor::fnorm(B-stats::coef(fit_pls)) ## ----------- Pass a list or an environment to x also works ------------- ## # Pass a list to x l <- dat[c("x", "y")] fit_std_l <- TPR.fit(l, method="standard") # Pass an environment to x e <- new.env() e$x <- dat$x e$y <- dat$y fit_std_e <- TPR.fit(e, method="standard") ## ----------- Use dataset "square" included in the package ------------- ## data("square") x <- square$x y <- square$y fit_std <- TPR.fit(x, y, method="standard")
# The dimension of predictor p <- c(10, 10, 10) # The envelope dimensions u. u <- c(1, 1, 1) # The dimension of response r <- 5 # The sample size n <- 200 # Simulate the data with TPRsim. dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y B <- dat$coefficients fit_std <- TPR.fit(x, y, method="standard") fit_FG <- TPR.fit(x, y, u, method="FG") fit_pls <- TPR.fit(x, y, u, method="PLS") rTensor::fnorm(B-stats::coef(fit_std)) rTensor::fnorm(B-stats::coef(fit_FG)) rTensor::fnorm(B-stats::coef(fit_pls)) ## ----------- Pass a list or an environment to x also works ------------- ## # Pass a list to x l <- dat[c("x", "y")] fit_std_l <- TPR.fit(l, method="standard") # Pass an environment to x e <- new.env() e$x <- dat$x e$y <- dat$y fit_std_e <- TPR.fit(e, method="standard") ## ----------- Use dataset "square" included in the package ------------- ## data("square") x <- square$x y <- square$y fit_std <- TPR.fit(x, y, method="standard")
Select the envelope dimension by cross-validation for tensor predictor regression.
TPRdim(x, y, maxdim = 10, nfolds = 5)
TPRdim(x, y, maxdim = 10, nfolds = 5)
x |
The predictor tensor instance of dimension |
y |
The response matrix of dimension |
maxdim |
The largest dimension to be considered for selection. |
nfolds |
Number of folds for cross-validation. |
According to Zhang and Li (2017), the dimensions of envelopes at each mode are assumed to be equal, so the u
returned is a single value representing the equal envelope dimension.
For each dimension u
in 1:maxdim
, we obtain the prediction
for each predictor in the
-th testing dataset,
nfolds
, where is the estimated coefficient based on the
-th training dataset. And the mean squared error for the
-th testing dataset is defined as
where is the sample size of the
-th testing dataset and
denotes the Frobenius norm. Then, the average of
nfolds
mean squared error is recorded as cross-validation mean squared error for the dimension u
.
mincv |
The minimal cross-validation mean squared error. |
u |
The envelope subspace dimension selected. |
Zhang, X. and Li, L., 2017. Tensor envelope partial least-squares regression. Technometrics, 59(4), pp.426-436.
# The dimension of predictor p <- c(10, 10, 10) # The envelope dimensions u. u <- c(1, 1, 1) # The dimension of response r <- 5 # The sample size n <- 200 dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y TPRdim(x, y, maxdim = 5) ## Use dataset square. (time-consuming) data("square") x <- square$x y <- square$y # check the dimension of x dim(x) # use 32 as the maximal envelope dimension TPRdim(x, y, maxdim=32)
# The dimension of predictor p <- c(10, 10, 10) # The envelope dimensions u. u <- c(1, 1, 1) # The dimension of response r <- 5 # The sample size n <- 200 dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y TPRdim(x, y, maxdim = 5) ## Use dataset square. (time-consuming) data("square") x <- square$x y <- square$y # check the dimension of x dim(x) # use 32 as the maximal envelope dimension TPRdim(x, y, maxdim=32)
This function is used to generate simulation data used in tensor prediction regression.
TPRsim(p, r, u, n)
TPRsim(p, r, u, n)
p |
The dimension of predictor, a vector in the form of |
r |
The dimension of response, a scale. |
u |
The structural dimension of envelopes at each mode, a vector with the same length as p. |
n |
The sample size. |
The tensor predictor regression model is of the form,
where response , predictor
,
and the error term is multivariate normal distributed. The predictor is tensor normal distributed,
According to the tensor envelope structure, we have
for some ,
and
,
.
x |
The predictor of dimension |
y |
The response of dimension |
Gamma |
A list of envelope subspace basis of dimension |
coefficients |
The tensor coefficients of dimension |
Sigma |
A lists of estimated covariance matrices at each mode for the tensor predictors, i.e., |
p , r , u
|
The input |
The length of p
must match that of u
, and each element of u
must be less than the corresponding element in p
.
Zhang, X. and Li, L., 2017. Tensor envelope partial least-squares regression. Technometrics, 59(4), pp.426-436.
p <- c(10, 10, 10) u <- c(1, 1, 1) r <- 5 n <- 200 dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y fit_std <- TPR.fit(x, y, method="standard")
p <- c(10, 10, 10) u <- c(1, 1, 1) r <- 5 n <- 200 dat <- TPRsim(p = p, r = r, u = u, n = n) x <- dat$x y <- dat$y fit_std <- TPR.fit(x, y, method="standard")
This function is used for estimation of tensor response regression. The available method including standard OLS type estimation, PLS type of estimation as well as envelope estimation with FG, 1D and ECD approaches.
TRR.fit(x, y, u, method=c('standard', 'FG', '1D', 'ECD', 'PLS'), Gamma_init = NULL)
TRR.fit(x, y, u, method=c('standard', 'FG', '1D', 'ECD', 'PLS'), Gamma_init = NULL)
x |
The predictor matrix of dimension |
y |
The response tensor instance with dimension |
u |
The dimension of envelope subspace. |
method |
The method used for estimation of tensor response regression. There are four possible choices.
|
Gamma_init |
A list specifying the initial envelope subspace basis for "FG" method. By default, the estimators given by "1D" algorithm is used. |
Please refer to Details part of TRRsim
for the description of the tensor response regression model.
When samples are insufficient, it is possible that the estimation of error covariance matrix Sigma
is not available. However, if using ordinary least square method (method = "standard"
), as long as sample covariance matrix of predictor x
is nonsingular, coefficients
, fitted.values
, residuals
are still returned.
TRR.fit
returns an object of class "Tenv".
The function summary
(i.e., summary.Tenv
) is used to print the summary of the results, including additional information, e.g., the p-value and the standard error for coefficients, and the prediction mean squared error.
The functions coefficients
, fitted.values
and residuals
can be used to extract different features returned from TRR.fit
.
The function plot
(i.e., plot.Tenv
) plots the two-dimensional coefficients and p-value for object of class "Tenv".
The function predict
(i.e., predict.Tenv
) predicts response for the object returned from TRR.fit
function.
x |
The original predictor dataset. |
y |
The original response dataset. |
call |
The matched call. |
method |
The implemented method. |
coefficients |
The estimation of regression coefficient tensor. |
Gamma |
The estimation of envelope subspace basis. |
Sigma |
A lists of estimated covariance matrices at each mode for the error term. |
fitted.values |
The fitted response tensor. |
residuals |
The residuals tensor. |
Li, L. and Zhang, X., 2017. Parsimonious tensor response regression. Journal of the American Statistical Association, 112(519), pp.1131-1146.
summary.Tenv
for summaries, calculating mean squared error from the prediction.
plot.Tenv
(via graphics::image
) for drawing the two-dimensional coefficient plot and -value plot.
predict.Tenv
for prediction.
The generic functions coef, residuals, fitted
.
TRRdim
for selecting the dimension of envelope by information criteria.
TRRsim
for generating the simulated data used in tensor response regression.
The simulated data bat
used in tensor response regression.
# The dimension of response r <- c(10, 10, 10) # The envelope dimensions u. u <- c(2, 2, 2) # The dimension of predictor p <- 5 # The sample size n <- 100 # Simulate the data with TRRsim. dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y B <- dat$coefficients fit_std <- TRR.fit(x, y, method="standard") fit_fg <- TRR.fit(x, y, u, method="FG") fit_1D <- TRR.fit(x, y, u, method="1D") fit_pls <- TRR.fit(x, y, u, method="PLS") fit_ECD <- TRR.fit(x, y, u, method="ECD") rTensor::fnorm(B-stats::coef(fit_std)) rTensor::fnorm(B-stats::coef(fit_fg)) rTensor::fnorm(B-stats::coef(fit_1D)) rTensor::fnorm(B-stats::coef(fit_pls)) rTensor::fnorm(B-stats::coef(fit_ECD)) # Extract the mean squared error, p-value and standard error from summary summary(fit_std)$mse summary(fit_std)$p_val summary(fit_std)$se ## ----------- Pass a list or an environment to x also works ------------- ## # Pass a list to x l <- dat[c("x", "y")] fit_std_l <- TRR.fit(l, method="standard") # Pass an environment to x e <- new.env() e$x <- dat$x e$y <- dat$y fit_std_e <- TRR.fit(e, method="standard") ## ----------- Use dataset "bat" included in the package ------------- ## data("bat") x <- bat$x y <- bat$y fit_std <- TRR.fit(x, y, method="standard")
# The dimension of response r <- c(10, 10, 10) # The envelope dimensions u. u <- c(2, 2, 2) # The dimension of predictor p <- 5 # The sample size n <- 100 # Simulate the data with TRRsim. dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y B <- dat$coefficients fit_std <- TRR.fit(x, y, method="standard") fit_fg <- TRR.fit(x, y, u, method="FG") fit_1D <- TRR.fit(x, y, u, method="1D") fit_pls <- TRR.fit(x, y, u, method="PLS") fit_ECD <- TRR.fit(x, y, u, method="ECD") rTensor::fnorm(B-stats::coef(fit_std)) rTensor::fnorm(B-stats::coef(fit_fg)) rTensor::fnorm(B-stats::coef(fit_1D)) rTensor::fnorm(B-stats::coef(fit_pls)) rTensor::fnorm(B-stats::coef(fit_ECD)) # Extract the mean squared error, p-value and standard error from summary summary(fit_std)$mse summary(fit_std)$p_val summary(fit_std)$se ## ----------- Pass a list or an environment to x also works ------------- ## # Pass a list to x l <- dat[c("x", "y")] fit_std_l <- TRR.fit(l, method="standard") # Pass an environment to x e <- new.env() e$x <- dat$x e$y <- dat$y fit_std_e <- TRR.fit(e, method="standard") ## ----------- Use dataset "bat" included in the package ------------- ## data("bat") x <- bat$x y <- bat$y fit_std <- TRR.fit(x, y, method="standard")
This function uses the 1D-BIC criterion proposed by Zhang, X., & Mai, Q. (2018) to select envelope dimensions in tensor response regression. Refer to oneD_bic
for more details.
TRRdim(x, y, C = NULL, maxdim = 10, ...)
TRRdim(x, y, C = NULL, maxdim = 10, ...)
x |
The predictor matrix of dimension |
y |
The response tensor instance with dimension |
C |
The parameter passed to |
maxdim |
The maximum envelope dimension to be considered. Default is 10. |
... |
Additional arguments passed to |
See oneD_bic
for more details on the definition of 1D-BIC criterion and on the arguments and the additional arguments.
Let denote the estimated envelope with the selected dimension
u
, then the prediction is for each observation. And the mean squared error is defined as
, where
denotes the Frobenius norm.
bicval |
The minimal BIC values for each mode. |
u |
The optimal envelope subspace dimension |
mse |
The prediction mean squared error using the selected envelope basis. |
Li, L. and Zhang, X., 2017. Parsimonious tensor response regression. Journal of the American Statistical Association, 112(519), pp.1131-1146.
Zhang, X. and Mai, Q., 2018. Model-free envelope dimension selection. Electronic Journal of Statistics, 12(2), pp.2193-2216.
# The dimension of response r <- c(10, 10, 10) # The envelope dimensions u. u <- c(2, 2, 2) # The dimension of predictor p <- 5 # The sample size n <- 100 # Simulate the data with TRRsim. dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y TRRdim(x, y) # The estimated envelope dimensions are the same as u. ## Use dataset bat. (time-consuming) data("bat") x <- bat$x y <- bat$y # check the dimension of y dim(y) # use 32 as the maximal envelope dimension TRRdim(x, y, maxdim=32)
# The dimension of response r <- c(10, 10, 10) # The envelope dimensions u. u <- c(2, 2, 2) # The dimension of predictor p <- 5 # The sample size n <- 100 # Simulate the data with TRRsim. dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y TRRdim(x, y) # The estimated envelope dimensions are the same as u. ## Use dataset bat. (time-consuming) data("bat") x <- bat$x y <- bat$y # check the dimension of y dim(y) # use 32 as the maximal envelope dimension TRRdim(x, y, maxdim=32)
This function is used to generate simulation data used in tensor response regression.
TRRsim(r, p, u, n)
TRRsim(r, p, u, n)
r |
The dimension of response, a vector with length larger than 2. |
p |
The dimension of predictor, a scale. |
u |
The structural dimension of envelopes at each mode, a vector with the same length as |
n |
The sample size. |
The tensor response regression model is of the form,
where predictor , response
,
and the error term is tensor normal distributed as follows,
According to the tensor envelope structure, we have
for some ,
and
,
.
x |
The predictor of dimension |
y |
The response of dimension |
Gamma |
The envelope subspace basis of dimension |
coefficients |
The tensor coefficients of dimension |
Sigma |
A lists of estimated covariance matrices at each mode for the error term, i.e., |
p , r , u
|
The input |
The length of r
must match that of u
, and each element of u
must be less than the corresponding element in r
.
Li, L. and Zhang, X., 2017. Parsimonious tensor response regression. Journal of the American Statistical Association, 112(519), pp.1131-1146.
r <- c(10, 10, 10) u <- c(2, 2, 2) p <- 5 n <- 100 dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y fit_std <- TRR.fit(x, y, method="standard")
r <- c(10, 10, 10) u <- c(2, 2, 2) p <- 5 n <- 100 dat <- TRRsim(r = r, p = p, u = u, n = n) x <- dat$x y <- dat$y fit_std <- TRR.fit(x, y, method="standard")
Matrix product of two tensors unfolded on the specified modes.
ttt(x, y, ms)
ttt(x, y, ms)
x |
A tensor instance. |
y |
A tensor instance. |
ms |
The indices of the modes to compute on. A single value or a vector. |
Suppose x
is a -way tensor with dimension
and
y
is a t-way tensor with dimension .
ms
specifies the indices on which the tensors x
and y
are unfolded as columns. Thus, ms
must be a subset of 1:min{s,t}
. Meanwhile, the sizes of the dimensions specified by ms
must match, e.g., if ms = 1:k
where k <= min{s,t}
, then . Let
and
denote the unfolded matrices, the matrix
is returned. See Examples for a better illustration.
Return the matrix product of tensors x
and y
.
x <- rTensor::as.tensor(array(runif(24), c(3, 4, 2))) y <- rTensor::as.tensor(array(runif(24), c(3, 4, 2))) z <- ttt(x, y, 1:2)
x <- rTensor::as.tensor(array(runif(24), c(3, 4, 2))) y <- rTensor::as.tensor(array(runif(24), c(3, 4, 2))) z <- ttt(x, y, 1:2)