Title: | Tools for the Analysis of Weak ARMA Models |
---|---|
Description: | Numerous time series admit autoregressive moving average (ARMA) representations, in which the errors are uncorrelated but not necessarily independent. These models are called weak ARMA by opposition to the standard ARMA models, also called strong ARMA models, in which the error terms are supposed to be independent and identically distributed (iid). This package allows the study of nonlinear time series models through weak ARMA representations. It determines identification, estimation and validation for ARMA models and for AR and MA models in particular. Functions can also be used in the strong case. This package also works on white noises by omitting arguments 'p', 'q', 'ar' and 'ma'. See Francq, C. and Zakoïan, J. (1998) <doi:10.1016/S0378-3758(97)00139-0> and Boubacar Maïnassara, Y. and Saussereau, B. (2018) <doi:10.1080/01621459.2017.1380030> for more details. |
Authors: | Yacouba Boubacar Maïnassara [aut] , Julien Yves Rolland [aut, cre] , Coraline Parguey [ctb], Vincent Mouillot [ctb] |
Maintainer: | Julien Yves Rolland <[email protected]> |
License: | GPL (>= 3) |
Version: | 1.0.3 |
Built: | 2024-12-03 06:58:58 UTC |
Source: | CRAN |
Computes empirical autocovariances and autocorrelations function for an ARMA process for lag max given.
acf.gamma_m(ar = NULL, ma = NULL, y, h, e = NULL)
acf.gamma_m(ar = NULL, ma = NULL, y, h, e = NULL)
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
y |
Univariate time series. |
h |
Computes autocovariances and autocorrelations from lag 1 to lag h with h an integer. |
e |
Vector of residuals. If |
A list with :
gamma_m
Vector of the autocovariances.
rho_m
Vector of the autocorrelations.
acf.univ
for autocorrelation and autocovariance for only one given lag h.
param.estim <- estimation(p = 1, q = 1, y = CAC40return.sq) acf.gamma_m(ar = param.estim$ar, ma = param.estim$ma, y = CAC40return.sq, h = 20)
param.estim <- estimation(p = 1, q = 1, y = CAC40return.sq) acf.gamma_m(ar = param.estim$ar, ma = param.estim$ma, y = CAC40return.sq, h = 20)
Computes empirical autocovariances and autocorrelations functions for an ARMA process for only one given lag.
acf.univ(ar = NULL, ma = NULL, y, h, e = NULL)
acf.univ(ar = NULL, ma = NULL, y, h, e = NULL)
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
y |
Univariate time series. |
h |
Given lag to compute autocovariance and autocorrelation, with h an integer. |
e |
Vector of residuals of the time series. If |
A list with :
autocov
Value of the autocovariance.
autocor
Value of the autocorrelation.
acf.gamma_m
for autocorrelation and autocovariance for all h lag.
param.estim <- estimation(p = 1, q = 1, y = CAC40return.sq) acf.univ(ar = param.estim$ar, ma = param.estim$ma, y = CAC40return.sq, h = 20)
param.estim <- estimation(p = 1, q = 1, y = CAC40return.sq) acf.univ(ar = param.estim$ar, ma = param.estim$ma, y = CAC40return.sq, h = 20)
Identifies the orders p and q of an ARMA model according to several information criteria.
ARMA.selec(data, P, Q, c = 2)
ARMA.selec(data, P, Q, c = 2)
data |
Univariate time series. |
P |
Integer for the maximum lag order of autoregressive component. |
Q |
Integer for the maximum lag order of moving-average component. |
c |
Real number >1 needed to compute Hannan-Quinn information criterion. |
The fitted model which is favored is the one corresponding to the
minimum value of the criterion. The most popular criterion is the Akaike information
criterion (AIC
). This was designed to be an approximately unbiased
estimator of a fitted model. For small sample or when the number of fitted
parameters is large, it is more appropriate to manipulate a corrected AIC
version (AICc
) which is more nearly unbiased. But these two criteria
are inconsistent for model orders selection. If you want to use a consistent
criterion, it is possible to take the Bayesian information criterion
(BIC
) or the Hannan-Quinn information criteria (HQ
).
For the weak ARMA, i.e under the assumption that the errors are uncorrelated
but not necessarily independant, modified criteria has been adapted :
AICm
, AICcm
, BICm
, HQm
.
The criteria definitions are the following :
A list of the different criteria, each item contains the matrix of the computed value for the different model and the selected order with this criterion (corresponding to the minimum value in the previous matrix).
Boubacar Maïnassara, Y. 2012, Selection of weak VARMA models by modified Akaike's information criteria, Journal of Time Series Analysis, vol. 33, no. 1, pp. 121-130
Boubacar Maïnassara, Y. and Kokonendji, C. C. 2016, Modified Schwarz and Hannan-Quin information criteria for weak VARMA models, Stat Inference Stoch Process, vol. 19, no. 2, pp. 199-217
ARMA.selec (CAC40return.sq, P = 3, Q = 3)
ARMA.selec (CAC40return.sq, P = 3, Q = 3)
This data set considers market index at the closure of the market from March 1, 1990 to June 14, 2021.
CAC40
CAC40
A vector with the variable Close
.
There are 7936 observations. We removed every NULL
values.
Data pulled from Yahoo Finance: ‘https://fr.finance.yahoo.com/quote/%5EFCHI/history?p=%5EFCHI’
CAC40return
and CAC40return.sq
This data set considers CAC40 return at the closure of the market from March 2, 1990 to June 14, 2021.
CAC40return
CAC40return
A numerical vector with 7935 observations.
We computed every value from the dataset CAC40
with the following code:
cac<-CAC40; n<-length(cac); rend<-rep(0,n); rend[2:n]<-(log(cac[2:n]/cac[1:(n-1)])*100); CAC40return<-rend[2:n]
CAC40
and CAC40return.sq
This data set considers CAC40 square return at the closure of the market from March 2, 1990 to June 14, 2021.
CAC40return.sq
CAC40return.sq
A numerical vector with 7935 observations.
We computed every value from the dataset CAC40
with the following code:
cac<-CAC40; n<-length(cac); rend<-rep(0,n); rend[2:n]<-(log(cac[2:n]/cac[1:(n-1)])*100); CAC40return.sq<-rend[2:n]^2
CAC40
and CAC40return
Estimates the parameters of a time series for given orders p
and q
estimation(p = NULL, q = NULL, y, meanparam = FALSE)
estimation(p = NULL, q = NULL, y, meanparam = FALSE)
p |
Order of AR, if |
q |
Order of MA, if |
y |
Univariate time series. |
meanparam |
Logical argument if the mean parameter has to be computed or not. If FALSE |
This function uses the algorithm BFGS in the function optim to minimize our objective function meansq
.
List of estimate coefficients:
mu
Mean parameter
.
ar
Vector of AR coefficients with length is equal to p
.
ma
Vector of MA coefficients with length is equal to q
.
sigma.carre
Mean square residuals.
Francq, C. and Zakoïan, J. 1998, Estimating linear representations of nonlinear processes Journal of Statistical Planning and Inference, vol. 68, no. 1, pp. 145-165.
y<-sim.ARMA(1000,ar = c(0.9,-0.3), ma = 0.2, method = "product") estimation(p = 2, q = 1, y = y) estimation(p = 1, q = 1, y = CAC40return.sq, meanparam = TRUE)
y<-sim.ARMA(1000,ar = c(0.9,-0.3), ma = 0.2, method = "product") estimation(p = 2, q = 1, y = y) estimation(p = 1, q = 1, y = CAC40return.sq, meanparam = TRUE)
Computes the gradient of the residuals of an ARMA model.
gradient(ar = NULL, ma = NULL, y)
gradient(ar = NULL, ma = NULL, y)
ar |
Vector of |
ma |
Vector of |
y |
Univariate time series. |
A list containing:
der.eps
Matrix of the gradient.
esp
Vector of residuals.
est<-estimation(p = 1, q = 1, y = CAC40return.sq) gradient(ar = est$ar, ma = est$ma, y = CAC40return.sq)
est<-estimation(p = 1, q = 1, y = CAC40return.sq) gradient(ar = est$ar, ma = est$ma, y = CAC40return.sq)
Uses a consistent estimator of the matrix I based on an autoregressive spectral estimator.
matXi(data, p = 0, q = 0)
matXi(data, p = 0, q = 0)
data |
Matrix of dimension (p+q,n). |
p |
Dimension of AR estimate coefficients. |
q |
Dimension of MA estimate coefficients. |
Estimate Fisher information matrix where
denotes the gradient of the residuals.
Berk, Kenneth N. 1974, Consistent autoregressive spectral estimates, The Annals of Statistics, vol. 2, pp. 489-502.
Boubacar Maïnassara, Y. and Francq, C. 2011, Estimating structural VARMA models with uncorrelated but non-independent error terms, Journal of Multivariate Analysis, vol. 102, no. 3, pp. 496-505.
Boubacar Mainassara, Y. and Carbon, M. and Francq, C. 2012, Computing and estimating information matrices of weak ARMA models Computational Statistics & Data Analysis, vol. 56, no. 2, pp. 345-361.
Computes the mean square of the time series at the point x
, will be minimize with the optim
function in our function estimation
.
meansq(x, dim.ar = NULL, dim.ma = NULL, y)
meansq(x, dim.ar = NULL, dim.ma = NULL, y)
x |
One point in |
dim.ar |
Length of AR vector. |
dim.ma |
Length of MA vector. |
y |
Vector of a time series. |
ms
Mean square at the point x
.
Plots autocorrelogram for non linear process.
nl.acf( ar = NULL, ma = NULL, y, main = NULL, nlag = NULL, conflevel = 0.05, z = 1.2, aff = "both" )
nl.acf( ar = NULL, ma = NULL, y, main = NULL, nlag = NULL, conflevel = 0.05, z = 1.2, aff = "both" )
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
y |
Univariate time series. |
main |
Character string representing the title for the plot. |
nlag |
Maximum lag at which to calculate the acf. If |
conflevel |
Value of the confidence level, 5% by default. |
z |
Zoom on the graph. |
aff |
Specify the method between SN, M and both (see in Details). |
For the argument aff
you have the choice between:
SN
, M
and both
.
SN
prints the self-normalized method (see Boubacar Maïnassara and Saussereau) in green,
M
prints the modified method introduced by Francq, Roy and Zakoïan (see also Boubacar Maïnassara) in red
and both
prints both of the methods.
An autocorrelogram with every autocorrelations from 1 to a lag max, and with methods you choose to print.
The only value available for the argument conflevel
are
0.1, 0.05, 0.025, 0.01 or 0.005.
Boubacar Maïnassara, Y. 2011, Multivariate portmanteau test for structural VARMA models with uncorrelated but non-independent error terms Journal of Statistical Planning and Inference, vol. 141, no. 8, pp. 2961-2975.
Boubacar Maïnassara, Y.and Saussereau, B. 2018, Diagnostic checking in multivariate ARMA models with dependent errors using normalized residual autocorrelations , Journal of the American Statistical Association, vol. 113, no. 524, pp. 1813-1827.
Francq, C., Roy, R. and Zakoïan, J.M. 2005, Diagnostic Checking in ARMA Models with Uncorrelated Errors, Journal of the American Statistical Association, vol. 100, no. 470, pp. 532-544.
Lobato, I.N. 2001, Testing that a dependant process is uncorrelated. J. Amer. Statist. Assos. 96, vol. 455, pp. 1066-1076.
est<-estimation(p = 1, q = 1, y = CAC40return.sq) nl.acf(ar = est$ar, ma = est$ma, y = CAC40return.sq, main = "Autocorrelation of an ARMA(1,1) residuals of the CAC40 return square", nlag = 20)
est<-estimation(p = 1, q = 1, y = CAC40return.sq) nl.acf(ar = est$ar, ma = est$ma, y = CAC40return.sq, main = "Autocorrelation of an ARMA(1,1) residuals of the CAC40 return square", nlag = 20)
Computes matrices of Fisher information like ,
.
omega(ar = NULL, ma = NULL, y)
omega(ar = NULL, ma = NULL, y)
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
y |
Univariate time series. |
A list of matrix containing:
I
Matrix I
computed in function matXi
.
J
Matrix J
computed as where
is the residuals vector.
J.inv
Inverse of the matrix J
.
matOmega
Matrix variance-covariance in the weak case computed as .
matvar.strong
Matrix variance-covariance in the strong case computed as
.
standard.dev.Omega
Standard deviation of the matrix matOmega
.
standard.dev.strong
Standard deviation of the matrix matvar.strong
.
sig2
Innovation variance estimate.
y <- sim.ARMA(n = 1000, ar = c(0.95,-0.8), ma = -0.6) est<-estimation(p = 2, q = 1, y = y) omega(ar = est$ar, ma = est$ma, y = y) estCAC<-estimation(p = 1, q = 1, y = CAC40return.sq, meanparam = TRUE) omega(ar = estCAC$ar, ma = estCAC$ma, y = CAC40return.sq)
y <- sim.ARMA(n = 1000, ar = c(0.95,-0.8), ma = -0.6) est<-estimation(p = 2, q = 1, y = y) omega(ar = est$ar, ma = est$ma, y = y) estCAC<-estimation(p = 1, q = 1, y = CAC40return.sq, meanparam = TRUE) omega(ar = estCAC$ar, ma = estCAC$ma, y = CAC40return.sq)
Realizes portmanteau tests of the first m lags, this function uses portmanteauTest.h
for h in 1:m.
portmanteauTest(ar = NULL, ma = NULL, y, m = NULL)
portmanteauTest(ar = NULL, ma = NULL, y, m = NULL)
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
y |
Univariate time series. |
m |
Integer for the lag. |
A list of vectors of length m
, corresponding to statistics and p-value for each lag,
for standard, modified and self-normalized Ljung-Box and Box-Pierce methods.
Boubacar Maïnassara, Y. 2011, Multivariate portmanteau test for structural VARMA models with uncorrelated but non-independent error terms Journal of Statistical Planning and Inference, vol. 141, no. 8, pp. 2961-2975.
Boubacar Maïnassara, Y. and Saussereau, B. 2018, Diagnostic checking in multivariate ARMA models with dependent errors using normalized residual autocorrelations , Journal of the American Statistical Association, vol. 113, no. 524, pp. 1813-1827.
Francq, C., Roy, R. and Zakoïan, J.M. 2005, Diagnostic Checking in ARMA Models with Uncorrelated Errors, Journal of the American Statistical Association, vol. 100, no. 470, pp. 532-544.
portmanteauTest.h
to obtain statistics for only one h lag.
est<-estimation(p = 1, q = 1, y = CAC40return.sq) portmanteauTest(ar = est$ar, ma = est$ma, y = CAC40return.sq, m = 20)
est<-estimation(p = 1, q = 1, y = CAC40return.sq) portmanteauTest(ar = est$ar, ma = est$ma, y = CAC40return.sq, m = 20)
Computes Box-Pierce and Ljung-Box statistics for standard, modified and self-normalized test procedures.
portmanteauTest.h(ar = NULL, ma = NULL, y, h, grad = NULL)
portmanteauTest.h(ar = NULL, ma = NULL, y, h, grad = NULL)
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
y |
Univariate time series. |
h |
Integer for the chosen lag. |
grad |
Gradient of the series from the function gradient. If |
Portmanteau statistics are generally used to test the null hypothesis.
H0 : satisfies an ARMA(p,q) representation.
The Box-Pierce (BP) and Ljung-Box (LB) statistics, defined as follows, are based on the residual empirical autocorrelation.
The standard test procedure consists in rejecting the null hypothesis of an
ARMA(p,q) model if the statistic where
denotes the
-quantile of a
chi-squared distribution with m-(p+q) (where m > p + q) degrees of freedom. The
two statistics have the same asymptotic distribution, but the LB statistic
has the reputation of doing better for small or medium sized samples.
But the significance limits of the residual autocorrelation can be very
different for an ARMA models with iid noise and ARMA models with only
uncorrelated noise but dependant. The standard test is obtained under the
stronger assumption that is iid. So we give an another
way to obtain the exact asymptotic distribution of the standard portmanteau
statistics under the weak dependence assumptions.
Under H0, the statistics and
converge in
distribution as
, to
where is the eigenvalues vector of the asymptotic
covariance matrix of the residual autocorrelations vector and
are independent
variables.
So when the error process is a weak white noise, the asymptotic distribution
and
statistics is a weighted sum of
chi-squared. The distribution of the quadratic form
can
be computed using the algorithm by Imhof available here :
imhof
We propose an alternative method where we do not estimate an asymptotic covariance matrix. It is based on a self-normalization based approach to construct a new test-statistic which is asymptotically distribution-free under the null hypothesis.
The sample autocorrelation, at lag h
take the form .
Where
.
With
The vector of the first m sample autocorrelations is written
.
The normalization matrix is defined by where
.
The sample autocorrelations satisfy .
reprensating respectively the version modified of Box-Pierce (BP) and
Ljung-Box (LB) statistics. Where
.
The critical values for
have been tabulated by Lobato.
A list including statistics and p-value:
Pm.BP
Standard portmanteau Box-Pierce statistics.
PvalBP
p-value corresponding at standard test where the asymptotic distribution is approximated by a chi-squared
PvalBP.Imhof
p-value corresponding at the exact asymptotic distribution of the standard portmanteau Box-Pierce statistics.
Pm.LB
Standard portmanteau Box-Pierce statistics.
PvalLB
p-value corresponding at standard test where the asymptotic distribution is approximated by a chi-squared.
PvalLB.Imhof
p-value corresponding at the exact asymptotic distribution of the standard portmanteau Ljung-Box statistics.
LB.modSN
Ljung-Box statistic with the self-normalization method.
BP.modSN
Box-Pierce statistic with the self-normalization method.
Boubacar Maïnassara, Y. 2011, Multivariate portmanteau test for structural VARMA models with uncorrelated but non-independent error terms Journal of Statistical Planning and Inference, vol. 141, no. 8, pp. 2961-2975.
Boubacar Maïnassara, Y. and Saussereau, B. 2018, Diagnostic checking in multivariate ARMA models with dependent errors using normalized residual autocorrelations , Journal of the American Statistical Association, vol. 113, no. 524, pp. 1813-1827.
Francq, C., Roy, R. and Zakoïan, J.M. 2005, Diagnostic Checking in ARMA Models with Uncorrelated Errors, Journal of the American Statistical Association, vol. 100, no. 470 pp. 532-544
Lobato, I.N. 2001, Testing that a dependant process is uncorrelated. J. Amer. Statist. Assos. 96, vol. 455, pp. 1066-1076.
portmanteauTest
to obtain the statistics of all m
lags.
Computes a matrix with estimated coefficient and their significance.
signifparam( ar = NULL, ma = NULL, p = NULL, q = NULL, y, sd.strong = NULL, sd.weak = NULL, meanparam = TRUE, mu = NULL )
signifparam( ar = NULL, ma = NULL, p = NULL, q = NULL, y, sd.strong = NULL, sd.weak = NULL, meanparam = TRUE, mu = NULL )
ar |
Vector of AR coefficients, if |
ma |
Vector of MA coefficients, if |
p |
Order of AR, if |
q |
Order of MA, if |
y |
Univariate time series. |
sd.strong |
Standard error of time series in the strong case computed in |
sd.weak |
Standard error of time series in the weak case computed in |
meanparam |
If |
mu |
Value of |
The function needs at least one pair between: ar and/or ma, or p and/or q to be executed. It will be faster with all the parameters provided.
Matrix of the estimate coefficient with their significance.
coef
Estimation of each coefficient.
sd
Standard deviation in each case.
t-ratio
T-ratio corresponding to each coefficient.
signif
Significance of each parameter. Must be small, if not the parameter is not significant.
signifparam(p = 1, q = 2, y = CAC40return.sq) #The last parameter is not significant. signifparam(p = 1, q = 1, y = CAC40return.sq) #All the parameters are significant.
signifparam(p = 1, q = 2, y = CAC40return.sq) #The last parameter is not significant. signifparam(p = 1, q = 1, y = CAC40return.sq) #All the parameters are significant.
Simulates an ARMA, AR or MA process according to the arguments given.
sim.ARMA( n, ar = NULL, ma = NULL, sigma = 1, eta = NULL, method = "strong", k = 1, mu = 0, ... )
sim.ARMA( n, ar = NULL, ma = NULL, sigma = 1, eta = NULL, method = "strong", k = 1, mu = 0, ... )
n |
Number of observations. |
ar |
Vector of AR coefficients. If |
ma |
Vector of MA coefficients. If |
sigma |
Standard deviation. |
eta |
Vector of white noise sequence. Allows the user to use his own white noise. |
method |
Defines the kind of noise used for the simulation. By default, the noise used is strong. See 'Details'. |
k |
Integer used in the creation of the noise. See 'Details'. |
mu |
Integer for the mean of the series. |
... |
Arguments needed to simulate GARCH noise. See 'Details'. |
ARMA model is of the following form :
where is a sequence of uncorrelated random variables with zero
mean and common variance
.
are
autoregressive coefficients and
are moving
average coefficients. Characteristic polynomials of ar and ma must
constitute a stationary process.
Method "strong
" realise a simulation with gaussian white noise.
Method "product
", "ratio
" and "product.square
"
realise a simulation with a weak white noise. These methods employ
respectively the functions wnPT
, wnRT
and
wnPT_SQ
to simulate nonlinear ARMA model. So, the
paramater k
is an argument of these functions. See wnPT
, wnRT
or wnPT_SQ
.
Method "GARCH
" gives an ARMA process with a GARCH noise. See
simGARCH
.
Returns a vector containing the n
simulated observations of the
time series.
Francq, C. and Zakoïan, J.M. 1998, Estimating linear representations of nonlinear processes, Journal of Statistical Planning and Inference, vol. 68, no. 1, pp. 145-165
y <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "strong" ) y2 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "ratio") y3 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "GARCH", c = 1, A = 0.1, B = 0.88) y4 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "product") y5 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "product.square")
y <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "strong" ) y2 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "ratio") y3 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "GARCH", c = 1, A = 0.1, B = 0.88) y4 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "product") y5 <- sim.ARMA(n = 100, ar = 0.95, ma = -0.6, method = "product.square")
Simulates a GARCH process which is an example of a weak white noise.
simGARCH(n, c, A, B = NULL, ninit = 100)
simGARCH(n, c, A, B = NULL, ninit = 100)
n |
Number of observations. |
c |
Positive number. |
A |
Vector of ARCH coefficients >=0. |
B |
Vector of GARCH coefficients >=0. If |
ninit |
Length of 'burn-in' period. |
Vector of size n
containing a nonlinear sequence such as
where
Francq C. and Zakoïan J.M., 2010, GARCH models: structure, statistical inference and financial applications
simGARCH(100, c = 1, A = 0.25) simGARCH(100, c = 1, A = 0.1, B = 0.88)
simGARCH(100, c = 1, A = 0.25) simGARCH(100, c = 1, A = 0.1, B = 0.88)
Estimates the coefficients of a VAR(p) model. Used in matXi
.
VARest(x, p)
VARest(x, p)
x |
Matrix of dimension (n,p+q). |
p |
Integer for the lag order. |
A list containing:
ac
Coefficients data matrix.
p
Integer of the lag order.
k
Dimension of the VAR.
res
Matrix of residuals.
Simulates an uncorrelated but dependant noise process.
wnPT(n, sigma = 1, k = 1, ninit = 100)
wnPT(n, sigma = 1, k = 1, ninit = 100)
n |
Number of observations. |
sigma |
Standard deviation. |
k |
Integer corresponding to the number of past observation will be used. |
ninit |
Length of 'burn-in' period. |
Vector of size n
containing a nonlinear sequence such as
, where
is a sequence of iid
random variables mean-zero random variable with variance
.
Romano, J. and Thombs, L. 1996, Inference for autocorrelation under weak assumptions, Journal of the American Statistical Association, vol. 91, no. 434, pp. 590-600
wnPT(100) wnPT(100, sigma = 1, k = 1) wnPT(100, k = 0) #strong noise
wnPT(100) wnPT(100, sigma = 1, k = 1) wnPT(100, k = 0) #strong noise
Simulates an uncorrelated but dependant noise process.
wnPT_SQ(n, sigma = 1, k = 1, ninit = 100)
wnPT_SQ(n, sigma = 1, k = 1, ninit = 100)
n |
Number of observations. |
sigma |
Standard deviation. |
k |
Integer corresponding to the number of past observation will be used. |
ninit |
Length of 'burn-in' period. |
Vector of size n
containing a nonlinear sequence such as
, where
is a sequence of iid
random variables mean-zero random variable with variance
.
Romano, J. and Thombs, L. 1996, Inference for autocorrelation under weak assumptions, Journal of the American Statistical Association, vol. 91, no. 434, pp. 590-600
wnPT_SQ(100) wnPT_SQ(100, sigma = 1, k = 1)
wnPT_SQ(100) wnPT_SQ(100, sigma = 1, k = 1)
Simulates an uncorrelated but dependant noise process.
wnRT(n, sigma = 1, k = 1, ninit = 100)
wnRT(n, sigma = 1, k = 1, ninit = 100)
n |
Number of observations. |
sigma |
Standard deviation. |
k |
Integer |
ninit |
Length of 'burn-in' period. |
Vector of size n
containing a nonlinear sequence such as
, where
is a sequence of iid
random variables mean-zero random variable with variance
.
Romano, J. and Thombs, L. 1996, Inference for autocorrelation under weak assumptions, Journal of the American Statistical Association, vol. 91, no. 434, pp. 590-600
wnRT(100) wnRT(100, sigma = 1)
wnRT(100) wnRT(100, sigma = 1)