Package 'optimStrat'

Title: Choosing the Sample Strategy
Description: Intended to assist in the choice of the sampling strategy to implement in a survey.
Authors: Edgar Bueno <[email protected]>
Maintainer: Edgar Bueno <[email protected]>
License: GPL-2
Version: 2.4
Built: 2024-11-16 06:52:19 UTC
Source: CRAN

Help Index


optimStrat

Description

OptimStrat is a package intended to assist in the choice of the sample strategy to implement in a survey. It allows for calculating the variance and the expected variance of several sampling strategies.

Details

The package includes a function to calculate the design variance of several sampling strategies. It also includes a function to calculate the expected variance under a superpopuation model and a web-based application where the user can compare five sampling strategies in order to determine which one to implement in a survey.

Author(s)

Edgar Bueno

References

Bueno, E. (2018). A Comparison of Stratified Simple Random Sampling and Probability Proporional-to-size Sampling. Research Report, Department of Statistics, Stockholm University 2018:6. http://gauss.stat.su.se/rr/RR2018_6.pdf.


Design variance

Description

Compute the design variance of six sampling strategies.

Usage

desvar(y, x, n, H, d2, d4)

Arguments

y

a numeric vector giving the values of the study variable.

x

a positive numeric vector giving the values of the auxiliary variable.

n

a positive integer indicating the desired sample size.

H

a positive integer giving the desired number of strata/poststrata.

d2

a number giving the assumed shape of the trend term in the superpopulation model.

d4

a number giving the assumed shape of the spread term in the superpopulation model.

Details

The design variance of a sample of size n is computed for six sampling strategies (stsi–HT, π\pips–HT, stsi–pos, π\pips–pos, stsi–reg and π\pips–pos). The strategies are defined assuming that there is an underlying superpopulation model of the form

Yk=δ0+δ1xkδ2+ϵkY_{k}=\delta_{0}+\delta_{1}x_{k}^{\delta_{2}}+\epsilon_{k}

with Eϵk=0E\epsilon_{k}=0, Vϵk=δ32xk2δ4V\epsilon_{k}=\delta_{3}^{2}x_{k}^{2\delta_{4}} and Cov(ϵk,ϵl)=0Cov(\epsilon_{k},\epsilon_{l})=0.

The number of strata/poststrata is given by H.

Value

A vector of length six with the variance of the six sampling strategies.

References

Bueno, E. (2018). A Comparison of Stratified Simple Random Sampling and Probability Proporional-to-size Sampling. Research Report, Department of Statistics, Stockholm University 2018:6. http://gauss.stat.su.se/rr/RR2018_6.pdf.

See Also

expvar for the expected variance of five sampling strategies.

Examples

f<- function(x,b0,b1,b2,...) {b0+b1*x^b2}
g<- function(x,b3,...) {x^b3}
x<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )
y<- simulatey(x,f,g,dist="gamma",b0=10,b1=1,b2=1.25,b3=0.5,rho=0.90)

desvar(y,x,n=500,H=6,d2=1.25,d4=0.50)
desvar(y,x,n=500,H=6,d2=1.00,d4=1.00)

Expected variance of the general regression estimator

Description

Compute the expected design variance of the general regression estimator of the total of a study variable under different sampling designs.

Usage

expgreg(x, b11, b12, b21, b22, d12, Rfy, n, design = NULL, 
        stratum = NULL, x_des = NULL, inc.p = NULL, ...)

Arguments

x

design matrix with the variables to be used into the GREG estimator.

b11

a numeric vector of length equal to the number of variables in x giving the coefficients of the trend term in the true superpopulation model (see ‘Details’).

b12

a numeric vector of length equal to the number of variables in x giving the exponents of the trend term in the true superpopulation model (see ‘Details’).

b21

a numeric vector of length equal to the number of variables in x giving the coefficients of the spread term in the true superpopulation model (see ‘Details’).

b22

a numeric vector of length equal to the number of variables in x giving the exponents of the spread term in the true superpopulation model (see ‘Details’).

d12

a numeric vector of length equal to the number of variables in x giving the exponents of the trend term in the assumed superpopulation model (see ‘Details’).

Rfy

a number giving the square root of the coefficient of determination between the auxiliary variables and the study varible.

n

either a positive number indicating the (expected) sample size (when design is one of 'srs', 'poi', 'pips' or NULL) or a numeric vector indicating the sample size of the strata to which each element belongs (when design is 'stsi') (see ‘Examples’).

design

a character string giving the sampling design. It must be one of 'srs' (simple random sampling without replacement), 'poi' (Poisson sampling), 'stsi' (stratified simple random sampling), 'pips' (Pareto π\pips sampling) or NULL (see ‘Details’).

stratum

a vector indicating the stratum to which every unit belongs. Only used if design is 'stsi'.

x_des

a positive numeric vector giving the values of the auxiliary variable that is used for defining the inclusion probabilities. Only used if design is 'poi' or 'pips'.

inc.p

a matrix giving the first and second order inclusion probabilities. Only used if design is NULL.

...

other arguments passed to lm (see ‘Details’).

Details

The expected variance of the general regression estimator under different sampling designs is computed.

It is assumed that the underlying superpopulation model is of the form

Yk=f(xkδ1)+ϵkY_{k} = f(x_{k}|\delta_{1}) + \epsilon_{k}

with Eϵk=0E\epsilon_{k}=0, Vϵk=σ02g2(xkδ2)V\epsilon_{k}= \sigma_{0}^{2}g^{2}(x_{k}|\delta_{2}) and Cov(ϵk,ϵl)=0Cov(\epsilon_{k},\epsilon_{l})=0.

But the true generating model is in fact of the form

Yk=f(xkβ1)+ϵkY_{k} = f(x_{k}|\beta_{1}) + \epsilon_{k}

with Eϵk=0E\epsilon_{k}=0, Vϵk=σ2g2(xkβ2)V\epsilon_{k}= \sigma^{2}g^{2}(x_{k}|\beta_{2}) and Cov(ϵk,ϵl)=0Cov(\epsilon_{k},\epsilon_{l})=0.

Where

f(xkδ1)=j=1Jδ1,jxjkδ1,J+j,f(x_{k}|\delta_{1}) = \sum_{j=1}^{J}\delta_{1,j}x_{jk}^{\delta_{1,J+j}},

g(xkδ2)=j=1Jδ2,jxjkδ2,J+j,g(x_{k}|\delta_{2}) = \sum_{j=1}^{J}\delta_{2,j}x_{jk}^{\delta_{2,J+j}},

f(xkβ1)=j=1Jβ1,jxjkβ1,J+j,f(x_{k}|\beta_{1}) = \sum_{j=1}^{J}\beta_{1,j}x_{jk}^{\beta_{1,J+j}},

g(xkβ2)=j=1Jβ2,jxjkβ2,J+j.g(x_{k}|\beta_{2}) = \sum_{j=1}^{J}\beta_{2,j}x_{jk}^{\beta_{2,J+j}}.

  • the coefficients β1,j\beta_{1,j} (j=1,,Jj=1,\cdots,J) are given by b11;

  • the exponents β1,j\beta_{1,j} (j=J+1,,2Jj=J+1,\cdots,2J) are given by b12;

  • the coefficients β2,j\beta_{2,j} (j=1,,Jj=1,\cdots,J) are given by b21;

  • the exponents β2,j\beta_{2,j} (j=J+1,,2Jj=J+1,\cdots,2J) are given by b22;

  • the exponents δ1,j\delta_{1,j} (j=J+1,,2Jj=J+1,\cdots,2J) are given by d12.

The expected variance of the GREG estimator is approximated by

E(V(t^))=V(t^z)+σ^2k=1N(1πk1)g2(xkβ2)E\left(V\left(\hat{t}\right)\right) = V\left(\hat{t}_{z}\right) + \hat{\sigma}^{2}\sum_{k=1}^{N}\left(\frac{1}{\pi_{k}}-1\right)g^{2}(x_{k}|\beta_{2})

where

V(t^z)=k=1Nl=1Nπklzkπkzlπl(k=1Nzk)2V\left(\hat{t}_{z}\right) = \sum_{k=1}^{N}\sum_{l=1}^{N}\pi_{kl}\frac{z_{k}}{\pi_{k}}\frac{z_{l}}{\pi_{l}} - \left(\sum_{k=1}^{N}z_{k}\right)^{2}

and

σ^2=Sf2g2ˉ(1Rfy21),\hat{\sigma}^{2} = \frac{S^{2}_{f}}{\bar{g^{2}}}\left(\frac{1}{R^{2}_{fy}}-1\right),

zk=(xkβxkδA)β1,z_{k} = \left(x_{k}^{\beta}-x_{k}^{\delta}A\right)\beta_{1}^{**},

Sf2=k=1N(f(xkβ1)fˉ)2/N,S^{2}_{f} = \sum_{k=1}^{N}(f(x_{k}|\beta_{1})-\bar{f})^{2}/N,

g2ˉ=k=1Ng(xkβ2)2/N,\bar{g^{2}} = \sum_{k=1}^{N}g(x_{k}|\beta_{2})^{2}/N,

xkβ=(x1kβ1,J+1,,xJkβ1,2J),x_{k}^{\beta} = \left(x_{1k}^{\beta_{1,J+1}},\cdots,x_{Jk}^{\beta_{1,2J}}\right),

xkδ=(x1kδ1,J+1,,xJkδ1,2J),x_{k}^{\delta} = \left(x_{1k}^{\delta_{1,J+1}},\cdots,x_{Jk}^{\delta_{1,2J}}\right),

β1=(β1,1,,β1,J),\beta_{1}^{**} = (\beta_{1,1},\cdots,\beta_{1,J})',

A=(k=1Nwkxkδxkδ)1k=1Nwkxkδxkβ.A = \left(\sum_{k=1}^{N}w_{k}x_{k}^{\delta'}x_{k}^{\delta}\right)^{-1}\sum_{k=1}^{N}w_{k}x_{k}^{\delta'}x_{k}^{\beta}.

NN is the population size and πk\pi_{k} and πkl\pi_{kl} are, respectively, the first and second order inclusion probabilities. wkw_{k} is a weight associated to each element and it represents the inverse of the conditional variance (up to a scalar) of the underlying superpopulation model (see ‘Examples’).

If design=NULL, the matrix of inclusion probabilities is obtained proportional to the matrix p.inc. If design is other than NULL, the formula for the variance is simplified in such a way that the inclusion probabilities matrix is no longer necessary. In particular:

  • if design='srs', only the sample size n is required;

  • if design='stsi', both the stratum ID stratum and the sample size per stratum n, are required;

  • if design is either 'pips' or 'poi', the inclusion probabilities are obtained proportional to the values of x_des, corrected if necessary.

Value

A numeric value giving the expected variance of the general regression estimator for the desired design under the working and true models.

References

Bueno, E. (2018). A Comparison of Stratified Simple Random Sampling and Probability Proportional-to-size Sampling. Research Report, Department of Statistics, Stockholm University 2018:6. http://gauss.stat.su.se/rr/RR2018_6.pdf.

See Also

expvar for the simultaneous calculation of the expected variance of five sampling strategies under a superpopulation model; vargreg for the variance of the GREG estimator; desvar for the simultaneous calculation of the variance of six sampling strategies; optimApp for an interactive application of expgreg.

Examples

x1<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )
x2<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )
x3<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )
x<- cbind(x1,x2,x3)
expgreg(x,b11=c(1,-1,0),b12=c(1,1,0),b21=c(0,0,1),b22=c(0,0,0.5),
        d12=c(1,1,0),Rfy=0.8,n=150,"pips",x_des=x3)
expgreg(x,b11=c(1,-1,0),b12=c(1,1,0),b21=c(0,0,1),b22=c(0,0,0.5),
        d12=c(1,1,0),Rfy=0.8,n=150,"pips",x_des=x2)
expgreg(x,b11=c(1,-1,0),b12=c(1,1,0),b21=c(0,0,1),b22=c(0,0,0.5),
        d12=c(1,1,0),Rfy=0.8,n=150,"pips",x_des=x2,weights=1/x1)

st1<- optiallo(n=150,x=x3,H=6)
expgreg(x,b11=c(1,-1,0),b12=c(1,1,0),b21=c(0,0,1),b22=c(0,0,0.5),
        d12=c(1,1,0),Rfy=0.8,n=st1$nh,"stsi",stratum=st1$stratum)
expgreg(x,b11=c(1,-1,0),b12=c(1,1,0),b21=c(0,0,1),b22=c(0,0,0.5),
        d12=c(1,0,1),Rfy=0.8,n=st1$nh,"stsi",stratum=st1$stratum)
expgreg(x,b11=c(1,-1,0),b12=c(1,1,0),b21=c(0,0,1),b22=c(0,0,0.5),
        d12=c(1,0,1),Rfy=0.8,n=st1$nh,"stsi",stratum=st1$stratum,weights=1/x1)

Expected variance

Description

Compute the expected variance of five sampling strategies.

Usage

expvar(b, d, x, n, H, Rxy, stratum1 = NULL, stratum2 = NULL, st = 1:5,
   short = FALSE)

Arguments

b

a numeric vector of length two giving the true shapes of the trend and spread terms.

d

a numeric vector of length two giving the assumed shapes of the trend and spread terms.

x

a positive numeric vector giving the values of the auxiliary variable.

n

a positive integer indicating the desired sample size.

H

a positive integer giving the desired number of strata/poststrata. Ignored if stratum1 and stratum2 are given.

Rxy

a number giving the correlation between the auxiliary variable and the study variable.

stratum1

a list giving stratum and sample sizes per stratum (see ‘Details’).

stratum2

a list giving stratum and sample sizes per stratum (see ‘Details’).

st

a numeric vector indicating the strategies for which the expected variance is to be calculated (see ‘Details’).

short

logical. If FALSE (the default) a vector of length five is returned. If TRUE only the strategies given by st are returned.

Details

The expected variance of a sample of size n is computed for five sampling strategies (π\pips–reg, STSI–reg, STSI–HT, π\pips–pos and STSI–pos).

The strategies are defined assuming that the underlying superpopulation model is of the form

Yk=δ0+δ1xkδ2+ϵkY_{k}=\delta_{0}+\delta_{1}x_{k}^{\delta_{2}}+\epsilon_{k}

with Eϵk=0E\epsilon_{k}=0, Vϵk=δ32xk2δ4V\epsilon_{k}=\delta_{3}^{2}x_{k}^{2\delta_{4}} and Cov(ϵk,ϵl)=0Cov(\epsilon_{k} , \epsilon_{l}) = 0. But the true generating model is of the form

Yk=β0+β1xkβ2+ϵkY_{k}=\beta_{0}+\beta_{1}x_{k}^{\beta_{2}}+\epsilon_{k}

with Eϵk=0E\epsilon_{k}=0, Vϵk=β32xk2β4V\epsilon_{k} = \beta_{3}^{2}x_{k}^{2\beta_{4}} and Cov(ϵk,ϵl)=0Cov(\epsilon_{k},\epsilon_{l})=0.

The parameters β2\beta_2 and β4\beta_4 are given by b. The parameters δ2\delta_2 and δ4\delta_4 are given by d.

stratum1 and stratum2 are lists with two components (each with length length(x)): stratum indicates the stratum to which each element belongs and nh indicates the sample sizes to be selected in each stratum. They can be created via optiallo. stratum1 gives the stratification for STSI–HT and the poststrata for π\pips–pos and STSI–pos; whereas stratum2 gives the stratification for STSI–reg and STSI–pos. If NULL, optiallo is used for defining H strata/poststrata.

st indicates which variances to be calculated. If 1 in st, the expected variance of π\pips–reg is calculated. If 2 in st, the expected variance of STSI–reg is calculated, and so on.

Value

If short=FALSE a vector of length five is returned giving the expected variance of the strategies given in st. NA is returned for those strategies not given in st. If short=TRUE, the NAs are omitted.

References

Bueno, E. (2018). A Comparison of Stratified Simple Random Sampling and Probability Proportional-to-size Sampling. Research Report, Department of Statistics, Stockholm University 2018:6. http://gauss.stat.su.se/rr/RR2018_6.pdf.

See Also

optiallo for how to stratify an auxiliary variable and allocate the sample size; desvar for calculating the variance of the five strategies.

Examples

x<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )
expvar(b=c(1,1),d=c(1,1),x,n=500,H=6,Rxy=0.9)
expvar(b=c(1,1),d=c(1,1),x,n=500,H=6,Rxy=0.9,st=1:3)
expvar(b=c(1,1),d=c(1,1),x,n=500,H=6,Rxy=0.9,st=1:3,short=TRUE)

st1<- optiallo(n=500,x,H=6)
post1<- optiallo(n=500,x^1.5,H=10)
expvar(b=c(1,1),d=c(1,1),x,n=500,H=6,Rxy=0.9,
   stratum1=post1,stratum2=st1)

Optimal allocation in stratified simple random sampling

Description

Allocates a sample of size n using Neyman optimal allocation in Stratified Simple Random Sampling.

Usage

optiallo(n, x, stratum = NULL, ...)

Arguments

n

a positive integer indicating the desired sample size.

x

a positive numeric vector giving the values of the auxiliary variable.

stratum

a vector indicating the stratum to which every unit belongs (see ‘Details’).

...

other arguments passed to stratify (see ‘Details’).

Details

Allocates a sample of size n using Neyman optimal allocation in Stratified Simple Random Sampling.

If stratum==NULL, the stratification is generated via stratify. Then at least the number of strata should be passed to stratify using the argument H.

Value

A list with two elements:

stratum

a vector indicating the stratum to which each element belongs.

nh

a vector indicating the sample size of the strata to which each element belongs.

See Also

stratify for defining the stratification using the cum-sqrt-rule.

Examples

x<- 1 + sort( rgamma(100, shape=4/9, scale=108) )
st1<- stratify(x,H=6)
optiallo(n=30,x,stratum=st1)

optiallo(n=30,x,H=6)

Interactive Web-based Application of optimStrat

Description

Call Shiny to run a web-based application of optimStrat.

Usage

optimApp()

Author(s)

Edgar Bueno, [email protected]


Inclusion probabilities in a PIps design

Description

Compute the inclusion probabilities to be used in a PIps design with sample size equal to n.

Usage

pinc(n, x)

Arguments

n

a positive integer indicating the desired sample size.

x

a positive numeric vector giving the values of the auxiliary variable.

Details

The inclusion probabilities are calculated as n×xk/txn\times x_{k}/t_{x} and corrected, if necessary, to ensure that they are smaller or equal than one.

Value

A numeric vector giving the inclusion probability of each element.

Examples

x<- 1 + sort( rgamma(100, shape=4/9, scale=108) )
pinc(n=30,x)

Simulate the Study Variable

Description

Simulate values for the study variable based on the auxiliary variable x and an assumed superpopulation model.

Usage

simulatey(x, f, g, dist = "normal", rho = NULL, Sigma = NULL, ...)

Arguments

x

a numeric vector giving the values of the auxiliary variable.

f

the name of the function defining the desired trend (see ‘Details’).

g

the name of the function defining the desired spread (see ‘Details’).

dist

the desired distribution of the study variable conditioned on the auxiliary variable. Either 'normal' or 'gamma' (see ‘Details’).

rho

a number giving the absolute value of the desired correlation between x and the vector to be simulated.

Sigma

a nonnegative number giving the scale of the spread term in the superpopulation model. Ignored if rho is given (see ‘Details’).

...

other arguments passed to f and g (see ‘Details’).

Details

The values of the study variable y are simulated using a superpopulation model defined as:

Yk=f(xk)+ϵkY_{k}=f(x_{k})+\epsilon_{k}

with E(ϵk)=0E(\epsilon_{k}) = 0, V(ϵk)=σ2g2(xk)V(\epsilon_{k}) = \sigma^{2}g^{2}(x_{k}) and Cov(ϵk,ϵl)=0Cov(\epsilon_{k},\epsilon_{l}) = 0 if klk\ne l. Also Ykf(xk)Y_{k}|f(x_{k}) is distributed according to dist.

f and g should return a vector of the same length of x. Their first argument should be x and they should not share the name of any other argument. Both f and g should have the ... argument (see ‘Examples’).

Note that Sigma defines the degree of association between x and y: the larger Sigma, the smaller the correlation, rho, and vice versa. For this reason only one of them should be defined. If both are defined, Sigma will be ignored.

Depending on the trend function f, some correlations cannot be reached. In those cases, Sigma will automatically be set to zero, dist will automatically be set to 'normal' and rho will be ignored (see ‘Examples’).

If the trend term takes negative values, dist will be automatically set to 'normal'.

Value

A numeric vector giving the simulated value of y associated to each value in x.

Examples

f<- function(x,b0,b1,b2,...) {b0+b1*x^b2}
g<- function(x,b3,...) {x^b3}

x<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )

#Linear trend and homocedasticity
y1<- simulatey(x,f,g,dist="normal",b0=0,b1=1,b2=1,b3=0,rho=0.90)
y2<- simulatey(x,f,g,dist="gamma",b0=0,b1=1,b2=1,b3=0,rho=0.90)

#Linear trend and heterocedasticity
y3<- simulatey(x,f,g,dist="normal",b0=0,b1=1,b2=1,b3=1,rho=0.90)
y4<- simulatey(x,f,g,dist="gamma",b0=0,b1=1,b2=1,b3=1,rho=0.90)

#Quadratic trend and homocedasticity
y5<- simulatey(x,f,g,dist="gamma",b0=0,b1=1,b2=2,b3=0,rho=0.80)

#Correlation of minus one
y6<- simulatey(x,f,g,dist="normal",b0=0,b1=-1,b2=1,b3=0,rho=1)

#Desired correlation cannot be attained
y7<- simulatey(x,f,g,dist="normal",b0=0,b1=1,b2=3,b3=0,rho=0.99)

#Negative expectation not possible under gamma distribution
y8<- simulatey(x,f,g,dist="gamma",b0=0,b1=-1,b2=1,b3=0,rho=1) 

#Conditional variance of zero not possible under gamma distribution
y9<- simulatey(x,f,g,dist="gamma",b0=0,b1=1,b2=3,b3=0,rho=0.99)

Sample Skewness

Description

Calculate the sample skewness.

Usage

skewness(x, na.rm = FALSE)

Arguments

x

a numeric vector.

na.rm

a logical value indicating whether NA values should be stripped before the computation proceeds.

Details

Compute the sample skewness of x as

1Ni=1N(xixˉ)3[1N1i=1N(xixˉ)2]3/2\frac{\frac{1}{N}\sum_{i=1}^{N}\left(x_{i}-\bar{x}\right)^{3}}{\left[\frac{1}{N-1}\sum_{i=1}^{N}\left(x_{i}-\bar{x}\right)^{2}\right]^{3/2}}

Value

A vector of length one giving the sample skewness of x.

Examples

x<- rnorm(1000)
skewness(x)

Stratification of an Auxiliary Variable

Description

Stratify the auxiliary variable x into H strata using the cum-sqrt-rule.

Usage

stratify(x, H, forced = FALSE, J = NULL)

Arguments

x

a positive numeric vector giving the values of the auxiliary variable.

H

a positive integer smaller or equal than length(x) giving the desired number of strata.

forced

a logical value indicating if the number of strata must be exactly equal to H (see ‘Details’).

J

a positive integer indicating the number of bins used for the cum-sqrt-rule.

Details

The cum-sqrt-rule is used in order to define H strata from the auxiliary vector x.

Depending on some characteristics of x, e.g. high skewness, few observations or too many ties, the resulting stratification may have a number of strata other than H. Using forced = TRUE tries its best to obtain exactly H strata.

Note that if length(x) < H then forced will be set to FALSE.

Value

A numeric vector giving the stratum to which each observation in x belongs.

References

Sarndal, C.E., Swensson, B. and Wretman, J. (1992). Model Assisted Survey Sampling. Springer.

See Also

optiallo for allocating the sample into the strata using Neyman optimal allocation.

Examples

x<- 1 + sort( rgamma(100, shape=4/9, scale=108) )
stratify(x, H=3)

Design variance of the general regression estimator.

Description

Compute the (approximated) design variance of the general regression estimator of the total of a study variable under different sampling designs.

Usage

vargreg(formula, design = NULL, n, stratum = NULL, 
        x_des = NULL, inc.p = NULL, ...)

Arguments

formula

an object of class formula: a symbolic description of the model to be fitted. The details of model specification are given under ‘Details’.

design

a character string giving the sampling design. It must be one of 'srs' (simple random sampling without replacement), 'poi' (Poisson sampling), 'stsi' (stratified simple random sampling), 'pips' (Pareto π\pips sampling) or NULL (see ‘Details’).

n

either a positive number indicating the (expected) sample size (when design is one of 'srs', 'poi', 'pips' or NULL) or a numeric vector indicating the sample size of the strata to which each element belongs (when design is 'stsi') (see ‘Examples’).

stratum

a vector indicating the stratum to which every unit belongs. Only used if design is 'stsi'.

x_des

a positive numeric vector giving the values of the auxiliary variable that is used for defining the inclusion probabilities. Only used if design is 'poi' or 'pips'.

inc.p

a matrix giving the first and second order inclusion probabilities. Only used if design is NULL.

...

other arguments passed to lm (see ‘Details’).

Details

The formula should be of the form y~x, where y is the study variable and x are the auxiliary variables used by the general regression (GREG) estimator, t^\hat{t},. See formula for more details and ‘Examples’ for typical expressions for some well-known estimators (e.g. the Horvitz-Thompson, ratio, regression and poststratification estimators).

The variance of the GREG estimator is approximated by

AV(t^)=k=1Nl=1NπklEkπkElπl(k=1NEk)2AV\left(\hat{t}\right) = \sum_{k=1}^{N}\sum_{l=1}^{N}\pi_{kl}\frac{E_{k}}{\pi_{k}}\frac{E_{l}}{\pi_{l}} - \left(\sum_{k=1}^{N}E_{k}\right)^{2}

where

Ek=yky^k and y^k=xkB with B=(k=1Nwkxkxk)k=1NwkxkykE_{k} = y_{k}-\hat{y}_{k} \textrm{ and } \hat{y}_{k} = x_{k}B \textrm{ with } B = \left(\sum_{k=1}^{N}w_{k}x_{k}^{'}x_{k}\right)\sum_{k=1}^{N}w_{k}x_{k}^{'}y_{k}

NN is the population size and πk\pi_{k} and πkl\pi_{kl} are, respectively, the first and second order inclusion probabilities. wkw_{k} is a weight associated to each element and it represents the inverse of the conditional variance (up to a scalar) of the underlying superpopulation model (see ‘Examples’).

If design=NULL, the matrix of inclusion probabilities is obtained proportional to the matrix p.inc. If design is other than NULL, the formula for the variance is simplified in such a way that the inclusion probabilities matrix is no longer necessary. In particular:

  • if design='srs', only the sample size n is required;

  • if design='stsi', both the stratum ID stratum and the sample size per stratum n, are required;

  • if design is either 'pips' or 'poi', the inclusion probabilities are obtained proportional to the values of x_des, corrected if necessary.

Value

A numeric value giving the variance of the general regression estimator under the desired design.

References

Sarndal, C.E., Swensson, B. and Wretman, J. (1992). Model Assisted Survey Sampling. Springer.

Rosen, B. (1997). On Sampling with Probability Proportional to Size. Journal of Statistical Planning and Inference 62, 159-191.

See Also

desvar for the simultaneous calculation of the variance of six sampling strategies; expgreg for the expected variance of the GREG estimator under a superpopulation model; expvar for the simultaneous calculation of the expected variance of five sampling strategies under a superpopulation model; optimApp for an interactive application of expgreg.

Examples

f<- function(x,b0,b1,b2,...) {b0+b1*x^b2}
g<- function(x,b3,...) {x^b3}
x<- 1 + sort( rgamma(5000, shape=4/9, scale=108) )
y<- simulatey(x,f,g,dist="gamma",b0=10,b1=1,b2=1,b3=1,rho=0.95)

st1<- optiallo(n=100,x=x,H=6)
vargreg("y~0",design="srs",n=100)                         #SRS-HT
vargreg("y~0",design="poi",n=100,x_des=x)                 #Poi-HT
vargreg("y~0",design="stsi",n=st1$nh,stratum=st1$stratum) #STSI-HT
vargreg("y~0",design="pips",n=100,x_des=x)                #PIPS-HT

vargreg("y~x-1",design="srs",n=100,weights=1/x)          #SRS-ratio
vargreg("y~x-1",design="poi",n=100,x_des=x,weights=1/x)  #Poi-ratio
vargreg("y~x-1",design="stsi",n=st1$nh,
        stratum=st1$stratum,weights=1/x)                 #STSI-ratio
vargreg("y~x-1",design="pips",n=100,x_des=x,weights=1/x) #PIPS-ratio

vargreg("y~x",design="srs",n=100)                         #SRS-reg
vargreg("y~x",design="poi",n=100,x_des=x)                 #Poi-reg
vargreg("y~x",design="stsi",n=st1$nh,stratum=st1$stratum) #STSI-reg
vargreg("y~x",design="pips",n=100,x_des=x)                #PIPS-reg

x2<- as.factor(st1$stratum)
vargreg("y~x2",design="srs",n=100)                          #SRS-pos
vargreg("y~x2",design="poi",n=100,x_des=x)                  #Poi-pos
vargreg("y~x2",design="stsi",n=st1$nh,stratum=st1$stratum)  #STSI-pos
vargreg("y~x2",design="pips",n=100,x_des=x)                 #PIPS-pos

y2<- c(16,21,18)
x2<- y2
inc.probs<- matrix(c(8,5,4,5,7,3,4,3,6),3,3)
vargreg("y2~0",n=2.1,inc.p=inc.probs)                 #HT
vargreg("y2~x2-1",n=2.1,inc.p=inc.probs,weights=1/x2) #Ratio
vargreg("y2~x2",n=2.1,inc.p=inc.probs)                #Regression
x3<- as.factor(c(1,2,2))
vargreg("y2~x3",n=2.1,inc.p=inc.probs)                #Post.