Title: | Gaussian Process Modeling of Multi-Response and Possibly Noisy Datasets |
---|---|
Description: | Provides a general and efficient tool for fitting a response surface to a dataset via Gaussian processes. The dataset can have multiple responses and be noisy (with stationary variance). The fitted GP model can predict the gradient as well. The package is based on the work of Bostanabad, R., Kearney, T., Tao, S. Y., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. International Journal for Numerical Methods in Engineering, 114, 501-516. |
Authors: | Ramin Bostanabad, Tucker Kearney, Siyo Tao, Daniel Apley, and Wei Chen (IDEAL) |
Maintainer: | Ramin Bostanabad <[email protected]> |
License: | GPL-2 |
Version: | 3.0.1 |
Built: | 2024-11-05 06:17:29 UTC |
Source: | CRAN |
Calculates some auxiliary paramters to obtain the negative log-likelehood and its gradient.
Auxil(Omega, X, Y, CorrType, MinEig, Fn, n, dy)
Auxil(Omega, X, Y, CorrType, MinEig, Fn, n, dy)
Omega |
The vector storing all the hyperparameters of the correlation function. The length of |
X |
Matrix containing the training (aka design or input) data points. The rows and columns of |
Y |
Matrix containing the output (aka response) data points. The rows and columns of |
CorrType |
The correlation function of the GP model. Choices include |
MinEig |
The smallest eigen value that the correlation matrix is allowed to have, which in return determines the appraopriate nugget that should be added to the correlation matrix. |
Fn |
A matrix of |
n |
Number of observations, |
dy |
Number of responses, |
Since Auxil
is shared between NLogL
and NLogL_G
during optimization, ideally it should be run only once (e.g., via memoisation). Such an implementation is left for future editions.
ALL A list containing the following components (based on CorrType
, some other parameters are also stored in ALL
):
R
The correlation matrix whose smallest eigen value is >= MinEig
.
L
Cholesky decomposition of R
.
Raw_MinEig
The smallest eigen value of R
before adding Nug_opt
.
Nug_opt
The added nugger to R
.
B
Bostanabad, R., Kearney, T., Tao, S., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. Int J Numer Meth Eng, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
Fit
to see how a GP model can be fitted to a training dataset.Predict
to use the fitted GP model for prediction.Draw
to plot the response via the fitted model.
# see the examples in the fitting function.
# see the examples in the fitting function.
GPM
PackageThe CorrMat_Sym()
function builds the auto-correlation matrix corresponding to dataset X
while the CorrMat_Vec()
function builds the correlation matrix between datasets X1
and X2
.
CorrMat_Sym(X, CorrType, Omega) CorrMat_Vec(X1, X2, CorrType, Omega)
CorrMat_Sym(X, CorrType, Omega) CorrMat_Vec(X1, X2, CorrType, Omega)
X , X1 , X2
|
Matrices containing the numeric data points. The rows and columns of both |
CorrType |
The correlation function of the GP model. Choices include |
Omega |
The vector storing all the scale (aka roughness) parameters of the correlation function. The length of |
R The Correlation matrix with size nrow(X1)
-by-nrow(X2)
. See here.
This function is NOT exported once the GPM package is loaded.
Bostanabad, R., Kearney, T., Tao, S. Y., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. International Journal for Numerical Methods in Engineering, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
Fit
to see how a GP model can be fitted to a training dataset.Predict
to use the fitted GP model for prediction.Draw
to plot the response via the fitted model.
# see the examples in \code{\link[GPM]{Fit}}
# see the examples in \code{\link[GPM]{Fit}}
GPM
PackagePlots the predicted response along with the assocaited uncertainty via the GP model fitted by Fit
. Accepts multi-input and multi-output models. See Arguments
for more details on the options.
Draw(Model, Plot_wrt, LB = NULL, UB = NULL, Values = NULL, Response_ID = NULL, res = 15, X1Label = NULL, X2Label = NULL, YLabel = NULL, Title = NULL, PI95 = NULL)
Draw(Model, Plot_wrt, LB = NULL, UB = NULL, Values = NULL, Response_ID = NULL, res = 15, X1Label = NULL, X2Label = NULL, YLabel = NULL, Title = NULL, PI95 = NULL)
Model |
The GP model fitted by |
Plot_wrt |
A binary vector of length |
LB , UB
|
Vectors of length |
Values |
A vector of length |
Response_ID |
A positive integer indicating the response that should be plotted if |
res |
A positive integer indicating the number of points used in plotting. Higher values will result in smoother plots. |
X1Label |
A string for the label of axis |
X2Label |
A string for the label of axis |
YLabel |
A string for the label of the response axis. |
Title |
A string for the title of the plot. |
PI95 |
Flag (a scalar) indicating whether the |
Bostanabad, R., Kearney, T., Tao, S., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. Int J Numer Meth Eng, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
Fit
to see how a GP model can be fitted to a training dataset.Predict
to use the fitted GP model for prediction.
# See the examples in the fitting function.
# See the examples in the fitting function.
GPM
PackageFits a Gaussian process (GP) to a set of simulation data as described in reference 1
. Both the inputs and outputs can be multi-dimensional. The outputs can be noisy in which case it is assumed that the noise is stationary (i.e., its variance is not a function of x).
Fit(X, Y, CorrType = 'G', Eps = 10^(seq(-1, -12)), AnaGr = NULL, Nopt = 5,TraceIt = 0, MaxIter = 100, Seed = 1, LowerBound = NULL, UpperBound = NULL, StopFlag = 1, Progress = 0, DoParallel = 0, Ncores = NULL)
Fit(X, Y, CorrType = 'G', Eps = 10^(seq(-1, -12)), AnaGr = NULL, Nopt = 5,TraceIt = 0, MaxIter = 100, Seed = 1, LowerBound = NULL, UpperBound = NULL, StopFlag = 1, Progress = 0, DoParallel = 0, Ncores = NULL)
X |
Matrix containing the training (aka design or input) data points. The rows and columns of |
Y |
Matrix containing the output (aka response) data points. The rows and columns of |
CorrType |
The type of the correlation function of the GP model. Choices include |
Eps |
A vector containing the smallest eigen value(s) that the correlation matrix is allowed to have. The elements of Eps must be in [0, 1] and sorted in a descending order. |
AnaGr |
Flag indicating whether the gradient of the log-likelihood should be taken analytically ( |
Nopt |
The number of times the log-likelihood function is optimized when |
TraceIt |
Non-negative integer. If positive, tracing information on the progress of the optimization is printed. There are six levels of tracing (see |
MaxIter |
Maximum number of iterations allowed for each optimization (see |
Seed |
An integer for the random number generator. Use this to make the results reproducible. |
LowerBound , UpperBound
|
To estimate the scale (aka roughness) parameters of the correlation function, the feasible range should be defined. |
StopFlag |
Flag indicating whether the optimization must be stopped if the negative log-likelihood increases with decreasing |
Progress |
Flag indicating if the fitting process should be summarized. Set it to |
DoParallel |
If |
Ncores |
Number of cores to use if |
Model A list containing the following components:
CovFunc
A list containing the type and estimated parameters of the correlation function.
Data
A list storing the original (but scaled) data.
Details
A list of some parameters (used in prediction) as well as some values reporting the total run-time (cost
) and the added nugget (Nug_opt
) for satisfying the constraint on the smallest eigen value of the correlation matrix.
OptimHist
The optimization history.
Setting
The default/provided settings for running the code.
Bostanabad, R., Kearney, T., Tao, S., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. Int J Numer Meth Eng, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
optim
for the details on L-BFGS-B
algorithm used in optimization.Predict
to use the fitted GP model for prediction.Draw
to plot the response via the fitted model.
# 1D example: Fit a model (with default settings) and evaluate the performance # by computing the root mean squared error (RMSE) in prediction. library(lhs) X <- 5*maximinLHS(15, 1) Y <- 2*sin(2*X) + log(X+1) M <- Fit(X, Y) XF <- matrix(seq(0, 5, length.out = 100), 100, 1) YF <- Predict(XF, M) RMSE <- sqrt(mean((YF$YF - (2*sin(2*XF) + log(XF+1)))^2)) ## Not run: # 1D example: Fit a model, evaluate the performance, and plot the response # along with 95% prediction interval X <- 10*maximinLHS(10, 1) - 5 Y <- X*cos(X) M <- Fit(X, Y) XF <- matrix(seq(-5, 5, length.out = 500), 500, 1) YF <- Predict(XF, M) RMSE <- sqrt(mean((YF$YF - (XF*cos(XF)))^2)) Draw(M, 1, res = 20) # 2D example: Fit a model, evaluate the performance, and plot the response # surface along with 95% prediction interval X <- 2*maximinLHS(10, 2) - 1 Y <- X[, 1]^2 + X[, 2]^2 M <- Fit(X, Y, CorrType = "PE") XF <- 2*maximinLHS(100, 2) - 1 YF <- Predict(XF, M) RMSE <- sqrt(mean((YF$YF - (XF[, 1]^2 + XF[, 2]^2))^2)) library(lattice) Draw(M, c(1, 1), res = 15, PI95=1) # 2D example: Plot the previous model wrt X1 in the [-2, 2] # interval with X2=1 Draw(M, c(1, 0), LB = -2, UB = 2, res = 15, PI95=1) # 3D example: Compare the performance of Gaussian ("G") and lifted Browninan # with Gamma=1 ("LBG") X <- 2*maximinLHS(50, 3) - 1 Y <- cos(X[, 1]^2) + 2*sin(X[, 2]^2) + X[, 3]^2 M_G <- Fit(X, Y) M_LBG <- Fit(X, Y, CorrType = "LBG") XF <- 2*maximinLHS(500, 3) - 1 YF_G <- Predict(XF, M_G) YF_LBG <- Predict(XF, M_LBG) RMSE_G <- sqrt(mean((YF_G$YF - (cos(XF[, 1]^2) + 2*sin(XF[, 2]^2) + XF[, 3]^2))^2)) RMSE_LBG <- sqrt(mean((YF_LBG$YF - (cos(XF[, 1]^2) + 2*sin(XF[, 2]^2) + XF[, 3]^2))^2)) # 3D example: Draw the response in 2D using the M_G model when X3=0 Draw(M_G, c(1, 1, 0), PI95 = 0, Values = 0, X1Label = 'Input 1', X2Label = 'Input 2') # 3D example: 2D response X <- 2*maximinLHS(50, 3) - 1 Y <- cbind(cos(X[, 1]^2) + 2*sin(X[, 2]^2) + X[, 3]^2, rowSums(X)) M <- Fit(X, Y) Draw(M, c(0, 1, 1), Response_ID = 2, Values = 0.5) # 2D example with noise X <- 2*maximinLHS(100, 2) - 1 Y <- X[, 1]^2 + X[, 2]^2 + matrix(rnorm(nrow(X), 0, .5), nrow(X), 1) M <- Fit(X, Y) # Estimating the noise variance (should be close to 0.5^2) M$Details$Nug_opt*M$CovFunc$Parameters$Sigma2*M$Data$Yrange^2 ## End(Not run)
# 1D example: Fit a model (with default settings) and evaluate the performance # by computing the root mean squared error (RMSE) in prediction. library(lhs) X <- 5*maximinLHS(15, 1) Y <- 2*sin(2*X) + log(X+1) M <- Fit(X, Y) XF <- matrix(seq(0, 5, length.out = 100), 100, 1) YF <- Predict(XF, M) RMSE <- sqrt(mean((YF$YF - (2*sin(2*XF) + log(XF+1)))^2)) ## Not run: # 1D example: Fit a model, evaluate the performance, and plot the response # along with 95% prediction interval X <- 10*maximinLHS(10, 1) - 5 Y <- X*cos(X) M <- Fit(X, Y) XF <- matrix(seq(-5, 5, length.out = 500), 500, 1) YF <- Predict(XF, M) RMSE <- sqrt(mean((YF$YF - (XF*cos(XF)))^2)) Draw(M, 1, res = 20) # 2D example: Fit a model, evaluate the performance, and plot the response # surface along with 95% prediction interval X <- 2*maximinLHS(10, 2) - 1 Y <- X[, 1]^2 + X[, 2]^2 M <- Fit(X, Y, CorrType = "PE") XF <- 2*maximinLHS(100, 2) - 1 YF <- Predict(XF, M) RMSE <- sqrt(mean((YF$YF - (XF[, 1]^2 + XF[, 2]^2))^2)) library(lattice) Draw(M, c(1, 1), res = 15, PI95=1) # 2D example: Plot the previous model wrt X1 in the [-2, 2] # interval with X2=1 Draw(M, c(1, 0), LB = -2, UB = 2, res = 15, PI95=1) # 3D example: Compare the performance of Gaussian ("G") and lifted Browninan # with Gamma=1 ("LBG") X <- 2*maximinLHS(50, 3) - 1 Y <- cos(X[, 1]^2) + 2*sin(X[, 2]^2) + X[, 3]^2 M_G <- Fit(X, Y) M_LBG <- Fit(X, Y, CorrType = "LBG") XF <- 2*maximinLHS(500, 3) - 1 YF_G <- Predict(XF, M_G) YF_LBG <- Predict(XF, M_LBG) RMSE_G <- sqrt(mean((YF_G$YF - (cos(XF[, 1]^2) + 2*sin(XF[, 2]^2) + XF[, 3]^2))^2)) RMSE_LBG <- sqrt(mean((YF_LBG$YF - (cos(XF[, 1]^2) + 2*sin(XF[, 2]^2) + XF[, 3]^2))^2)) # 3D example: Draw the response in 2D using the M_G model when X3=0 Draw(M_G, c(1, 1, 0), PI95 = 0, Values = 0, X1Label = 'Input 1', X2Label = 'Input 2') # 3D example: 2D response X <- 2*maximinLHS(50, 3) - 1 Y <- cbind(cos(X[, 1]^2) + 2*sin(X[, 2]^2) + X[, 3]^2, rowSums(X)) M <- Fit(X, Y) Draw(M, c(0, 1, 1), Response_ID = 2, Values = 0.5) # 2D example with noise X <- 2*maximinLHS(100, 2) - 1 Y <- X[, 1]^2 + X[, 2]^2 + matrix(rnorm(nrow(X), 0, .5), nrow(X), 1) M <- Fit(X, Y) # Estimating the noise variance (should be close to 0.5^2) M$Details$Nug_opt*M$CovFunc$Parameters$Sigma2*M$Data$Yrange^2 ## End(Not run)
GPM
PackageThese functions perform some matrix algebra to calculate the log-likelihood function.
Eigen(A) CppSolve(A, B) LowerChol(A)
Eigen(A) CppSolve(A, B) LowerChol(A)
A |
Numeric, symmetric, and positive definite matrix. |
B |
Numeric matrix or vector. |
Eigen(A))
returns the smallest eigen value of A.
CppSolve(A, B)
solves for X
in AX=B
.
LowerChol(A)
return the lower triangular Cholesky decomposition of A
.
These functions are NOT exported once the GPM package is loaded.
Fit
to see how a GP model can be fitted to a training dataset.Predict
to use the fitted GP model for prediction.Draw
to plot the response via the fitted model.
# see the examples in \code{\link[GPM]{Fit}}
# see the examples in \code{\link[GPM]{Fit}}
GPM
PackageCalculates the negative log-likelihood (excluding all the constant terms) as described in reference 1
.
NLogL(Omega, X, Y, CorrType, MinEig, Fn, n, dy)
NLogL(Omega, X, Y, CorrType, MinEig, Fn, n, dy)
Omega |
The vector storing all the hyperparameters of the correlation function. The length of |
X |
Matrix containing the training (aka design or input) data points. The rows and columns of |
Y |
Matrix containing the output (aka response) data points. The rows and columns of |
CorrType |
The correlation function of the GP model. Choices include |
MinEig |
The smallest eigen value that the correlation matrix is allowed to have, which in return determines the appraopriate nugget that should be added to the correlation matrix. |
Fn |
A matrix of |
n |
Number of observations, |
dy |
Number of responses, |
Fit
calls this function with scaled X
and Y
. That is, when the user fits a GP model by calling Fit(X, Y)
, X
and Y
are mapped to the [0, 1]
region and then passed to this function.
nlogl The negative log-likelihood (excluding all the constant terms). See the references
.
Bostanabad, R., Kearney, T., Tao, S., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. Int J Numer Meth Eng, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
Fit
to see how a GP model can be fitted to a training dataset.Predict
to use the fitted GP model for prediction.Draw
to plot the response via the fitted model.
# see the examples in the fitting function.
# see the examples in the fitting function.
GPM
PackageCalculates the gradient of negative log-likelihood wrt Omega
.
NLogL_G(Omega, X, Y, CorrType, MinEig, Fn, n, dy)
NLogL_G(Omega, X, Y, CorrType, MinEig, Fn, n, dy)
Omega |
The vector storing all the hyperparameters of the correlation function. The length of |
X |
Matrix containing the training (aka design or input) data points. The rows and columns of |
Y |
Matrix containing the output (aka response) data points. The rows and columns of |
CorrType |
The correlation function of the GP model. Choices include |
MinEig |
The smallest eigen value that the correlation matrix is allowed to have, which in return determines the appraopriate nugget that should be added to the correlation matrix. |
Fn |
A matrix of |
n |
Number of observations, |
dy |
Number of responses, |
This function is used in Fit
if AnaGr != 0
.
NLogL_G The gradient of negative log-likelihood wrt Omega
. See the references
.
Bostanabad, R., Kearney, T., Tao, S., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. Int J Numer Meth Eng, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
Fit
to see how a GP model can be fitted to a training dataset.Predict
to use the fitted GP model for prediction.Draw
to plot the response via the fitted model.
# see the examples in the fitting function.
# see the examples in the fitting function.
GPM
PackagePredicts the reponse(s), associated prediction uncertainties, and gradient(s) of the GP model fitted by Fit
.
Predict(XF, Model, MSE_on = 0, YgF_on = 0, grad_dim = rep(1, ncol(XF)))
Predict(XF, Model, MSE_on = 0, YgF_on = 0, grad_dim = rep(1, ncol(XF)))
XF |
Matrix containing the locations (settings) where the predictions are desired. The rows and columns of |
Model |
The GP model fitted by |
MSE_on |
Flag (a scalar) indicating whether the uncertainty (i.e., mean squared error |
YgF_on |
Flag (a scalar) indicating whether the gradient(s) of the response(s) are desired. Set to a non-zero value to calculate the gradient(s). See |
grad_dim |
A binary vector of length |
Output A list containing the following components:
YF
A matrix with n
rows (the number of prediction points) and dy
columns (the number of responses).
MSE
A matrix with n
rows and dy
columns where each element represents the prediction uncertainty (i.e., the expected value of the squared difference between the prediction and the true response) associated with the corresponding element in YF
.
YgF
An array of size n
by sum{grad_dim}
by dx
.
The gradient(s) can be calculated if CorrType='G'
or CorrType='LBG'
. If CorrType='PE'
or CorrType='LB'
, the gradient(s) can only be calculated if Power = 2
and Gamma = 1
, respectively.
For efficiency, make sure the inputs are vecotrized and then passed to Predict
. Avoid passing inputs individually in a for
loop.
Bostanabad, R., Kearney, T., Tao, S., Apley, D. W. & Chen, W. (2018) Leveraging the nugget parameter for efficient Gaussian process modeling. Int J Numer Meth Eng, 114, 501-516.
Plumlee, M. & Apley, D. W. (2017) Lifted Brownian kriging models. Technometrics, 59, 165-177.
Fit
to see how a GP model can be fitted to a training dataset.Draw
to plot the response via the fitted model.
# See the examples in the fitting function.
# See the examples in the fitting function.