Package 'PAGFL'

Title: Joint Estimation of Latent Groups and Group-Specific Coefficients in Panel Data Models
Description: Latent group structures are a common challenge in panel data analysis. Disregarding group-level heterogeneity can introduce bias. Conversely, estimating individual coefficients for each cross-sectional unit is inefficient and may lead to high uncertainty. This package addresses the issue of unobservable group structures by implementing the pairwise adaptive group fused Lasso (PAGFL) by Mehrabani (2023) <doi:10.1016/j.jeconom.2022.12.002>. PAGFL identifies latent group structures and group-specific coefficients in a single step. On top of that, we extend the PAGFL to time-varying coefficient functions.
Authors: Paul Haimerl [aut, cre] , Stephan Smeekes [ctb] , Ines Wilms [ctb] , Ali Mehrabani [ctb]
Maintainer: Paul Haimerl <[email protected]>
License: AGPL (>= 3)
Version: 1.1.1
Built: 2024-10-22 06:43:30 UTC
Source: CRAN

Help Index


Grouped Panel Data Model

Description

Estimate a grouped panel data model given an observed group structure. Slope parameters are homogeneous within groups but heterogeneous across groups. This function supports both static and dynamic panel data models, with or without endogenous regressors.

Usage

grouped_plm(
  formula,
  data,
  groups,
  index = NULL,
  n_periods = NULL,
  method = "PLS",
  Z = NULL,
  bias_correc = FALSE,
  rho = 0.07 * log(N * n_periods)/sqrt(N * n_periods),
  verbose = TRUE,
  parallel = TRUE,
  ...
)

## S3 method for class 'gplm'
print(x, ...)

## S3 method for class 'gplm'
formula(x, ...)

## S3 method for class 'gplm'
df.residual(object, ...)

## S3 method for class 'gplm'
summary(object, ...)

## S3 method for class 'gplm'
coef(object, ...)

## S3 method for class 'gplm'
residuals(object, ...)

## S3 method for class 'gplm'
fitted(object, ...)

Arguments

formula

a formula object describing the model to be estimated.

data

a data.frame or matrix holding a panel data set. If no index variables are provided, the panel must be balanced and ordered in the long format Y=(Y1,,YN)\bold{Y}=(Y_1^\prime, \dots, Y_N^\prime)^\prime, Yi=(Yi1,,YiT)Y_i = (Y_{i1}, \dots, Y_{iT})^\prime with Yit=(yit,xit)Y_{it} = (y_{it}, x_{it}^\prime)^\prime. Conversely, if data is not ordered or not balanced, data must include two index variables that declare the cross-sectional unit ii and the time period tt of each observation.

groups

a numerical or character vector of length NN that indicates the group membership of each cross-sectional unit ii.

index

a character vector holding two strings. The first string denotes the name of the index variable identifying the cross-sectional unit ii, and the second string represents the name of the variable declaring the time period tt. In case of a balanced panel data set that is ordered in the long format, index can be left empty if the the number of time periods n_periods is supplied.

n_periods

the number of observed time periods TT. If an index is passed, this argument can be left empty.

method

the estimation method. Options are

"PLS"

for using the penalized least squares (PLS) algorithm. We recommend PLS in case of (weakly) exogenous regressors (Mehrabani, 2023, sec. 2.2).

"PGMM"

for using the penalized Generalized Method of Moments (PGMM). PGMM is required when instrumenting endogenous regressors, in which case a matrix Z\bold{Z} containing the necessary exogenous instruments must be supplied (Mehrabani, 2023, sec. 2.3).

Default is "PLS".

Z

a NT×qNT \times q matrix or data.frame of exogenous instruments, where qpq \geq p, Z=(z1,,zN)\bold{Z}=(z_1, \dots, z_N)^\prime, zi=(zi1,,ziT)z_i = (z_{i1}, \dots, z_{iT})^\prime and zitz_{it} is a q×1q \times 1 vector. Z is only required when method = "PGMM" is selected. When using "PLS", the argument can be left empty or it is disregarded. Default is NULL.

bias_correc

logical. If TRUE, a Split-panel Jackknife bias correction following Dhaene and Jochmans (2015) is applied to the slope parameters. We recommend using the correction when working with dynamic panels. Default is FALSE.

rho

a tuning parameter balancing the fitness and penalty terms in the IC. If left unspecified, the heuristic ρ=0.07log(NT)NT\rho = 0.07 \frac{\log(NT)}{\sqrt{NT}} of Mehrabani (2023, sec. 6) is used. We recommend the default.

verbose

logical. If TRUE, helpful warning messages are shown. Default is TRUE.

parallel

logical. If TRUE, certain operations are parallelized across multiple cores. Default is TRUE.

...

ellipsis

x

of class gplm.

object

of class gplm.

Details

Consider the grouped panel data model

yit=γi+βixit+ϵit,i=1,,N,  t=1,,T,y_{it} = \gamma_i + \beta^\prime_{i} x_{it} + \epsilon_{it}, \quad i = 1, \dots, N, \; t = 1, \dots, T,

where yity_{it} is the scalar dependent variable, γi\gamma_i is an individual fixed effect, xitx_{it} is a p×1p \times 1 vector of explanatory variables, and ϵit\epsilon_{it} is a zero mean error. The coefficient vector βi\beta_i is subject to the observed group pattern

βi=k=1Kαk1{iGk},\beta_i = \sum_{k = 1}^K \alpha_k \bold{1} \{i \in G_k \},

with k=1KGk={1,,N}\cup_{k = 1}^K G_k = \{1, \dots, N\}, GkGj=G_k \cap G_j = \emptyset and αkαj0\| \alpha_k - \alpha_j \| \neq 0 for any kjk \neq j, k=1,,Kk = 1, \dots, K.

Using PLS, the group-specific coefficients for group kk are obtained via OLS

α^k=(iGkt=1Tx~itx~it)1iGkt=1Tx~ity~it,\hat{\alpha}_k = \left( \sum_{i \in G_k} \sum_{t = 1}^T \tilde{x}_{it} \tilde{x}_{it}^\prime \right)^{-1} \sum_{i \in G_k} \sum_{t = 1}^T \tilde{x}_{it} \tilde{y}_{it},

where a~it=aitT1t=1Tait\tilde{a}_{it} = a_{it} - T^{-1} \sum_{t=1}^T a_{it}, a={y,x}a = \{y, x\} to concentrate out the individual fixed effects γi\gamma_i (within-transformation).

In case of PGMM, the slope coefficients are derived as

α^k=([iGkT1t=1TzitΔxit]Wk[iGkT1t=1TzitΔxit])1\hat{\alpha}_k = \left( \left[ \sum_{i \in G_k} T^{-1} \sum_{t = 1}^T z_{it} \Delta x_{it} \right]^\prime W_k \left[ \sum_{i \in G_k} T^{-1} \sum_{t = 1}^T z_{it} \Delta x_{it} \right] \right)^{-1}

[iGkT1t=1TzitΔxit]Wk[iGkT1t=1TzitΔyit],\quad \quad \left[ \sum_{i \in G_k} T^{-1} \sum_{t = 1}^T z_{it} \Delta x_{it} \right]^\prime W_k \left[ \sum_{i \in G_k} T^{-1} \sum_{t = 1}^T z_{it} \Delta y_{it} \right],

where WkW_k is a q×qq \times q p.d. symmetric weight matrix and Δ\Delta denotes the first difference operator Δxit=xitxit1\Delta x_{it} = x_{it} - x_{it-1} (first-difference transformation).

Value

An object of class gplm holding

model

a data.frame containing the dependent and explanatory variables as well as cross-sectional and time indices,

coefficients

a K×pK \times p matrix of the group-specific parameter estimates,

groups

a list containing (i) the total number of groups KK and (ii) a vector of group memberships g1,,gN)g_1, \dots, g_N), where gi=kg_i = k if ii is assigned to group kk,

residuals

a vector of residuals of the demeaned model,

fitted

a vector of fitted values of the demeaned model,

args

a list of additional arguments,

IC

a list containing (i) the value of the IC and (ii) the MSE,

call

the function call.

A gplm object has print, summary, fitted, residuals, formula, df.residual, and coef S3 methods.

Author(s)

Paul Haimerl

References

Dhaene, G., & Jochmans, K. (2015). Split-panel jackknife estimation of fixed-effect models. The Review of Economic Studies, 82(3), 991-1030. doi:10.1093/restud/rdv007. Mehrabani, A. (2023). Estimation and identification of latent group structures in panel data. Journal of Econometrics, 235(2), 1464-1482. doi:10.1016/j.jeconom.2022.12.002.

Examples

# Simulate a panel with a group structure
sim <- sim_DGP(N = 20, n_periods = 80, p = 2, n_groups = 3)
y <- sim$y
X <- sim$X
groups <- sim$groups
df <- cbind(y = c(y), X)

# Estimate the grouped panel data model
estim <- grouped_plm(y ~ ., data = df, groups = groups, n_periods = 80, method = "PLS")
summary(estim)

# Lets pass a panel data set with explicit cross-sectional and time indicators
i_index <- rep(1:20, each = 80)
t_index <- rep(1:80, 20)
df <- data.frame(y = c(y), X, i_index = i_index, t_index = t_index)
estim <- grouped_plm(
  y ~ ., data = df, index = c("i_index", "t_index"), groups = groups, method = "PLS"
)
summary(estim)

Grouped Time-varying Panel Data Model

Description

Estimate a grouped time-varying panel data model given an observed group structure. Coefficient functions are homogeneous within groups but heterogeneous across groups. The time-varying coefficients are modeled as polynomial B-splines. The function supports both static and dynamic panel data models.

Usage

grouped_tv_plm(
  formula,
  data,
  groups,
  index = NULL,
  n_periods = NULL,
  d = 3,
  M = floor(length(y)^(1/7) - log(p)),
  const_coef = NULL,
  rho = 0.04 * log(N * n_periods)/sqrt(N * n_periods),
  verbose = TRUE,
  parallel = TRUE,
  ...
)

## S3 method for class 'tv_gplm'
summary(object, ...)

## S3 method for class 'tv_gplm'
formula(x, ...)

## S3 method for class 'tv_gplm'
df.residual(object, ...)

## S3 method for class 'tv_gplm'
print(x, ...)

## S3 method for class 'tv_gplm'
coef(object, ...)

## S3 method for class 'tv_gplm'
residuals(object, ...)

## S3 method for class 'tv_gplm'
fitted(object, ...)

Arguments

formula

a formula object describing the model to be estimated.

data

a data.frame or matrix holding a panel data set. If no index variables are provided, the panel must be balanced and ordered in the long format Y=(Y1,,YN)\bold{Y}=(Y_1^\prime, \dots, Y_N^\prime)^\prime, Yi=(Yi1,,YiT)Y_i = (Y_{i1}, \dots, Y_{iT})^\prime with Yit=(yit,xit)Y_{it} = (y_{it}, x_{it}^\prime)^\prime. Conversely, if data is not ordered or not balanced, data must include two index variables that declare the cross-sectional unit ii and the time period tt of each observation.

groups

a numerical or character vector of length NN that indicates the group membership of each cross-sectional unit ii.

index

a character vector holding two strings. The first string denotes the name of the index variable identifying the cross-sectional unit ii, and the second string represents the name of the variable declaring the time period tt. In case of a balanced panel data set that is ordered in the long format, index can be left empty if the the number of time periods n_periods is supplied.

n_periods

the number of observed time periods TT. If an index character vector is passed, this argument can be left empty. Default is Null.

d

the polynomial degree of the B-splines. Default is 3.

M

the number of interior knots of the B-splines. If left unspecified, the default heuristic M=floor((NT)17log(p))M = \text{floor}((NT)^{\frac{1}{7}} - \log(p)) is used. Note that MM does not include the boundary knots and the entire sequence of knots is of length M+d+1M + d + 1.

const_coef

a character vector containing the variable names of explanatory variables that enter with time-constant coefficients.

rho

the tuning parameter balancing the fitness and penalty terms in the IC. If left unspecified, the heuristic ρ=0.07log(NT)NT\rho = 0.07 \frac{\log(NT)}{\sqrt{NT}} of Mehrabani (2023, sec. 6) is used. We recommend the default.

verbose

logical. If TRUE, helpful warning messages are shown. Default is TRUE.

parallel

logical. If TRUE, certain operations are parallelized across multiple cores. Default is TRUE.

...

ellipsis

object

of class tv_gplm.

x

of class tv_gplm.

Details

Consider the grouped time-varying panel data model

yit=γi+βi(t/T)xit+ϵit,i=1,,N,  t=1,,T,y_{it} = \gamma_i + \beta^\prime_{i} (t/T) x_{it} + \epsilon_{it}, \quad i = 1, \dots, N, \; t = 1, \dots, T,

where yity_{it} is the scalar dependent variable, γi\gamma_i is an individual fixed effect, xitx_{it} is a p×1p \times 1 vector of explanatory variables, and ϵit\epsilon_{it} is a zero mean error. The coefficient vector βi(t/T)\beta_{i} (t/T) is subject to the observed group pattern

βi(tT)=k=1Kαk(tT)1{iGk},\beta_i \left(\frac{t}{T} \right) = \sum_{k = 1}^K \alpha_k \left( \frac{t}{T} \right) \bold{1} \{i \in G_k \},

with k=1KGk={1,,N}\cup_{k = 1}^K G_k = \{1, \dots, N\}, GkGj=G_k \cap G_j = \emptyset and αkαj0\| \alpha_k - \alpha_j \| \neq 0 for any kjk \neq j, k=1,,Kk = 1, \dots, K.

αk(t/T)\alpha_k (t/T) and, in turn, βi(t/T)\beta_i (t/T) is estimated as polynomial B-splines using the penalized sieve-technique. To this end, let B(v)B(v) denote a M+d+1M + d +1 vector of polynomial spline basis functions, where dd represents the polynomial degree and MM gives the number of interior knots of the B-spline. αk(t/T)\alpha_{k}(t/T) is approximated by forming a linear combination of the basis functions αk(t/T)ξkB(t/T)\alpha_{k}(t/T) \approx \xi_k^\prime B(t/T), where ξk\xi_k is a (M+d+1)×p(M + d + 1) \times p coefficient matrix.

The explanatory variables are projected onto the spline basis system, which results in the (M+d+1)p×1(M + d + 1)p \times 1 vector zit=xitB(v)z_{it} = x_{it} \otimes B(v). Subsequently, the DGP can be reformulated as

yit=γi+zitvec(πi)+uit,y_{it} = \gamma_i + z_{it}^\prime \text{vec}(\pi_{i}) + u_{it},

where πi=ξk\pi_i = \xi_k if iGki \in G_k, uit=ϵit+ηitu_{it} = \epsilon_{it} + \eta_{it}, and ηit\eta_{it} reflects a sieve approximation error. We refer to Su et al. (2019, sec. 2) for more details on the sieve technique.

Finally, α^k(t/T)\hat{\alpha}_{k}(t/T) is obtained as α^k(t/T)=ξ^kB(t/T)\hat{\alpha}_{k}(t/T) = \hat{\xi}_k^\prime B(t/T), where the vector of control points ξk\xi_k is estimated using OLS

ξ^k=(iGkt=1Tz~itz~it)1iGkt=1Tz~ity~it,\hat{\xi}_k = \left( \sum_{i \in G_k} \sum_{t = 1}^T \tilde{z}_{it} \tilde{z}_{it}^\prime \right)^{-1} \sum_{i \in G_k} \sum_{t = 1}^T \tilde{z}_{it} \tilde{y}_{it},

and a~it=aitT1t=1Tait\tilde{a}_{it} = a_{it} - T^{-1} \sum_{t = 1}^T a_{it}, a={y,z}a = \{y, z\} to concentrate out the fixed effect γi\gamma_i (within-transformation).

In case of an unbalanced panel data set, the earliest and latest available observations per group define the start and end-points of the interval on which the group-specific time-varying coefficients are defined.

Value

An object of class tv_gplm holding

model

a data.frame containing the dependent and explanatory variables as well as cross-sectional and time indices,

coefficients

let p(1)p^{(1)} denote the number of time-varying and p(2)p^{(2)} the number of time constant coefficients. A list holding (i) a T×p(1)×KT \times p^{(1)} \times K array of the group-specific functional coefficients and (ii) a K×p(2)K \times p^{(2)} matrix of time-constant estimates.

groups

a list containing (i) the total number of groups KK and (ii) a vector of group memberships (g^1,,g^N)(\hat{g}_1, \dots, \hat{g}_N), where g^i=k\hat{g}_i = k if ii is part of group kk,

residuals

a vector of residuals of the demeaned model,

fitted

a vector of fitted values of the demeaned model,

args

a list of additional arguments,

IC

a list containing (i) the value of the IC and (ii) the MSE,

call

the function call.

An object of class tv_gplm has print, summary, fitted, residuals, formula, df.residual and coef S3 methods.

Author(s)

Paul Haimerl

References

Su, L., Wang, X., & Jin, S. (2019). Sieve estimation of time-varying panel data models with latent structures. Journal of Business & Economic Statistics, 37(2), 334-349. doi:10.1080/07350015.2017.1340299.

Examples

# Simulate a time-varying panel with a trend and a group pattern
set.seed(1)
sim <- sim_tv_DGP(N = 10, n_periods = 50, intercept = TRUE, p = 2)
df <- data.frame(y = c(sim$y))
groups <- sim$groups

# Estimate the time-varying grouped panel data model
estim <- grouped_tv_plm(y ~ ., data = df, n_periods = 50, groups = groups)
summary(estim)

Pairwise Adaptive Group Fused Lasso

Description

Estimate panel data models with a latent group structure using the pairwise adaptive group fused Lasso (PAGFL) by Mehrabani (2023). The PAGFL jointly identifies the group structure and group-specific slope parameters. The function supports both static and dynamic panels, with or without endogenous regressors.

Usage

pagfl(
  formula,
  data,
  index = NULL,
  n_periods = NULL,
  lambda,
  method = "PLS",
  Z = NULL,
  min_group_frac = 0.05,
  bias_correc = FALSE,
  kappa = 2,
  max_iter = 5000,
  tol_convergence = 1e-08,
  tol_group = 0.001,
  rho = 0.07 * log(N * n_periods)/sqrt(N * n_periods),
  varrho = max(sqrt(5 * N * n_periods * p)/log(N * n_periods * p) - 7, 1),
  verbose = TRUE,
  parallel = TRUE,
  ...
)

## S3 method for class 'pagfl'
print(x, ...)

## S3 method for class 'pagfl'
formula(x, ...)

## S3 method for class 'pagfl'
df.residual(object, ...)

## S3 method for class 'pagfl'
summary(object, ...)

## S3 method for class 'pagfl'
coef(object, ...)

## S3 method for class 'pagfl'
residuals(object, ...)

## S3 method for class 'pagfl'
fitted(object, ...)

Arguments

formula

a formula object describing the model to be estimated.

data

a data.frame or matrix holding a panel data set. If no index variables are provided, the panel must be balanced and ordered in the long format Y=(Y1,,YN)\bold{Y}=(Y_1^\prime, \dots, Y_N^\prime)^\prime, Yi=(Yi1,,YiT)Y_i = (Y_{i1}, \dots, Y_{iT})^\prime with Yit=(yit,xit)Y_{it} = (y_{it}, x_{it}^\prime)^\prime. Conversely, if data is not ordered or not balanced, data must include two index variables that declare the cross-sectional unit ii and the time period tt of each observation.

index

a character vector holding two strings. The first string denotes the name of the index variable identifying the cross-sectional unit ii, and the second string represents the name of the variable declaring the time period tt. In case of a balanced panel data set that is ordered in the long format, index can be left empty if the the number of time periods n_periods is supplied.

n_periods

the number of observed time periods TT. If an index character vector is passed, this argument can be left empty.

lambda

the tuning parameter determining the strength of the penalty term. Either a single λ\lambda or a vector of candidate values can be passed. If a vector is supplied, a BIC-type IC automatically selects the best fitting λ\lambda value.

method

the estimation method. Options are

"PLS"

for using the penalized least squares (PLS) algorithm. We recommend PLS in case of (weakly) exogenous regressors (Mehrabani, 2023, sec. 2.2).

"PGMM"

for using the penalized Generalized Method of Moments (PGMM). PGMM is required when instrumenting endogenous regressors, in which case a matrix Z\bold{Z} containing the necessary exogenous instruments must be supplied (Mehrabani, 2023, sec. 2.3).

Default is "PLS".

Z

a NT×qNT \times q matrix or data.frame of exogenous instruments, where qpq \geq p, Z=(z1,,zN)\bold{Z}=(z_1, \dots, z_N)^\prime, zi=(zi1,,ziT)z_i = (z_{i1}, \dots, z_{iT})^\prime and zitz_{it} is a q×1q \times 1 vector. Z is only required when method = "PGMM" is selected. When using "PLS", either pass NULL or Z is disregarded. Default is NULL.

min_group_frac

the minimum group cardinality as a fraction of the total number of individuals NN. In case a group falls short of this threshold, each of its members is allocated to one of the remaining groups according to the MSE. Default is 0.05.

bias_correc

logical. If TRUE, a Split-panel Jackknife bias correction following Dhaene and Jochmans (2015) is applied to the slope parameters. We recommend using the correction when working with dynamic panels. Default is FALSE.

kappa

the a non-negative weight used to obtain the adaptive penalty weights. Default is 2.

max_iter

the maximum number of iterations for the ADMM estimation algorithm. Default is 11041*10^4.

tol_convergence

the tolerance limit for the stopping criterion of the iterative ADMM estimation algorithm. Default is 11081*10^{-8}.

tol_group

the tolerance limit for within-group differences. Two individuals ii, jj are assigned to the same group if the Frobenius norm of their coefficient vector difference is below this threshold. Default is 11031*10^{-3}.

rho

the tuning parameter balancing the fitness and penalty terms in the IC that determines the penalty parameter λ\lambda. If left unspecified, the heuristic ρ=0.07log(NT)NT\rho = 0.07 \frac{\log(NT)}{\sqrt{NT}} of Mehrabani (2023, sec. 6) is used. We recommend the default.

varrho

the non-negative Lagrangian ADMM penalty parameter. For PLS, the ϱ\varrho value is trivial. However, for PGMM, small values lead to slow convergence. If left unspecified, the default heuristic ϱ=max(5NTplog(NTp)7,1\varrho = \max(\frac{\sqrt{5NTp}}{\log(NTp)}-7, 1) is used.

verbose

logical. If TRUE, helpful warning messages are shown. Default is TRUE.

parallel

logical. If TRUE, certain operations are parallelized across multiple cores. Default is TRUE.

...

ellipsis

x

of class pagfl.

object

of class pagfl.

Details

Consider the grouped panel data model

yit=γi+βixit+ϵit,i=1,,N,  t=1,,T,y_{it} = \gamma_i + \beta^\prime_{i} x_{it} + \epsilon_{it}, \quad i = 1, \dots, N, \; t = 1, \dots, T,

where yity_{it} is the scalar dependent variable, γi\gamma_i is an individual fixed effect, xitx_{it} is a p×1p \times 1 vector of weakly exogenous explanatory variables, and ϵit\epsilon_{it} is a zero mean error. The coefficient vector βi\beta_i is subject to the latent group pattern

βi=k=1Kαk1{iGk},\beta_i = \sum_{k = 1}^K \alpha_k \bold{1} \{i \in G_k \},

with k=1KGk={1,,N}\cup_{k = 1}^K G_k = \{1, \dots, N\}, GkGj=G_k \cap G_j = \emptyset and αkαj0\| \alpha_k - \alpha_j \| \neq 0 for any kjk \neq j, k=1,,Kk = 1, \dots, K.

The PLS method jointly estimates the latent group structure and group-specific coefficients by minimizing the criterion

QNT(β,λ)=1Ti=1Nt=1T(y~itβix~it)2+λNi=1N1j>iNω˙ijβiβjQ_{NT} (\bold{\beta}, \lambda) = \frac{1}{T} \sum^N_{i=1} \sum^{T}_{t=1}(\tilde{y}_{it} - \beta^\prime_i \tilde{x}_{it})^2 + \frac{\lambda}{N} \sum_{i = 1}^{N - 1} \sum_{j>i}^N \dot{\omega}_{ij} \| \beta_i - \beta_j \|

with respect to β=(β1,,βN)\bold{\beta} = (\beta_1^\prime, \dots, \beta_N^\prime)^\prime. a~it=aitT1t=1Tait\tilde{a}_{it} = a_{it} - T^{-1} \sum_{t = 1}^T a_{it}, a={y,x}a = \{y,x\} to concentrate out the individual fixed effects γi\gamma_i. λ\lambda is the penalty tuning parameter and ω˙ij\dot{\omega}_{ij} reflects adaptive penalty weights (see Mehrabani, 2023, eq. 2.6). \| \cdot \| denotes the Frobenius norm. The adaptive weights w˙ij\dot{w}_{ij} are obtained by a preliminary individual least squares estimation. The criterion function is minimized via an iterative alternating direction method of multipliers (ADMM) algorithm (see Mehrabani, 2023, sec. 5.1).

PGMM employs a set of instruments Z\bold{Z} to control for endogenous regressors. Using PGMM, β\bold{\beta} is estimated by minimizing

QNT(β,λ)=i=1N[1Nt=1Tzit(ΔyitβiΔxit)]Wi[1Tt=1Tzit(ΔyitβiΔxit)]Q_{NT}(\bold{\beta}, \lambda) = \sum^N_{i = 1} \left[ \frac{1}{N} \sum_{t=1}^T z_{it} (\Delta y_{it} - \beta^\prime_i \Delta x_{it}) \right]^\prime W_i \left[\frac{1}{T} \sum_{t=1}^T z_{it}(\Delta y_{it} - \beta^\prime_i \Delta x_{it}) \right]

+λNi=1N1j>iNω¨ijβiβj.\quad + \frac{\lambda}{N} \sum_{i = 1}^{N - 1} \sum_{j > i}^N \ddot{\omega}_{ij} \| \beta_i - \beta_j \|.

ω¨ij\ddot{\omega}_{ij} are obtained by an initial GMM estimation. Δ\Delta gives the first differences operator Δyit=yityit1\Delta y_{it} = y_{it} - y_{i t-1}. WiW_i represents a data-driven q×qq \times q weight matrix. I refer to Mehrabani (2023, eq. 2.10) for more details. Again, the criterion function is minimized using an efficient ADMM algorithm (Mehrabani, 2023, sec. 5.2).

Two individuals are assigned to the same group if β^iβ^jϵtol\| \hat{\beta}_i - \hat{\beta}_j \| \leq \epsilon_{\text{tol}}, where ϵtol\epsilon_{\text{tol}} is determined by tol_group. Subsequently, the number of groups follows as the number of distinct elements in β^\hat{\bold{\beta}}. Given an estimated group structure, it is straightforward to obtain post-Lasso estimates using group-wise least squares or GMM (see grouped_plm).

We recommend identifying a suitable λ\lambda parameter by passing a logarithmically spaced grid of candidate values with a lower limit close to 0 and an upper limit that leads to a fully homogeneous panel. A BIC-type information criterion then selects the best fitting λ\lambda value.

Value

An object of class pagfl holding

model

a data.frame containing the dependent and explanatory variables as well as cross-sectional and time indices,

coefficients

a K^×p\hat{K} \times p matrix of the post-Lasso group-specific parameter estimates,

groups

a list containing (i) the total number of groups K^\hat{K} and (ii) a vector of estimated group memberships (g^1,,g^N)(\hat{g}_1, \dots, \hat{g}_N), where g^i=k\hat{g}_i = k if ii is assigned to group kk,

residuals

a vector of residuals of the demeaned model,

fitted

a vector of fitted values of the demeaned model,

args

a list of additional arguments,

IC

a list containing (i) the value of the IC, (ii) the employed tuning parameter λ\lambda, and (iii) the MSE,

convergence

a list containing (i) a logical variable indicating if convergence was achieved and (ii) the number of executed ADMM algorithm iterations,

call

the function call.

A pagfl object has print, summary, fitted, residuals, formula, df.residual, and coef S3 methods.

Author(s)

Paul Haimerl

References

Dhaene, G., & Jochmans, K. (2015). Split-panel jackknife estimation of fixed-effect models. The Review of Economic Studies, 82(3), 991-1030. doi:10.1093/restud/rdv007. Mehrabani, A. (2023). Estimation and identification of latent group structures in panel data. Journal of Econometrics, 235(2), 1464-1482. doi:10.1016/j.jeconom.2022.12.002.

Examples

# Simulate a panel with a group structure
sim <- sim_DGP(N = 20, n_periods = 80, p = 2, n_groups = 3)
y <- sim$y
X <- sim$X
df <- cbind(y = c(y), X)

# Run the PAGFL procedure
estim <- pagfl(y ~ ., data = df, n_periods = 80, lambda = 0.5, method = "PLS")
summary(estim)

# Lets pass a panel data set with explicit cross-sectional and time indicators
i_index <- rep(1:20, each = 80)
t_index <- rep(1:80, 20)
df <- data.frame(y = c(y), X, i_index = i_index, t_index = t_index)
estim <- pagfl(
  y ~ ., data = df, index = c("i_index", "t_index"), lambda = 0.5, method = "PLS"
)
summary(estim)

Simulate a Panel With a Group Structure in the Slope Coefficients

Description

Construct a static or dynamic, exogenous or endogenous panel data set subject to a group structure in the slope coefficients with optional AR(1)AR(1) or GARCH(1,1)GARCH(1,1) innovations.

Usage

sim_DGP(
  N = 50,
  n_periods = 40,
  p = 2,
  n_groups = 3,
  group_proportions = NULL,
  error_spec = "iid",
  dynamic = FALSE,
  dyn_panel = lifecycle::deprecated(),
  q = NULL,
  alpha_0 = NULL
)

Arguments

N

the number of cross-sectional units. Default is 50.

n_periods

the number of simulated time periods TT. Default is 40.

p

the number of explanatory variables. Default is 2.

n_groups

the number of groups KK. Default is 3.

group_proportions

a numeric vector of length n_groups indicating size of each group as a fraction of NN. If NULL, all groups are of size N/KN / K. Default is NULL.

error_spec

options include

"iid"

for iidiid errors.

"AR"

for an AR(1)AR(1) error process with an autoregressive coefficient of 0.5.

"GARCH"

for a GARCH(1,1)GARCH(1,1) error process with a 0.05 constant, a 0.05 ARCH and a 0.9 GARCH coefficient.

Default is "iid".

dynamic

Logical. If TRUE, the panel includes one stationary autoregressive lag of yity_{it} as an explanatory variable (see sec. Details for more information on the ARAR coefficient). Default is FALSE.

dyn_panel

[Deprecated] deprecated and replaced by dynamic.

q

the number of exogenous instruments when a panel with endogenous regressors is to be simulated. If panel data set with exogenous regressors is supposed to be generated, pass NULL. Default is NULL.

alpha_0

a K×pK \times p matrix of group-specific coefficients. If dynamic = TRUE, the first column represents the stationary ARAR coefficient. If NULL, the coefficients are drawn randomly (see sec. Details). Default is NULL.

Details

The scalar dependent variable yity_{it} is generated according to the following grouped panel data model

yit=γi+βixit+uit,i={1,,N},t={1,,T}.y_{it} = \gamma_i + \beta_i^\prime x_{it} + u_{it}, \quad i = \{1, \dots, N\}, \quad t = \{1, \dots, T\}.

γi\gamma_i represents individual fixed effects and xitx_{it} a p×1p \times 1 vector of regressors. The individual slope coefficient vectors βi\beta_i are subject to a group structure

βi=k=1Kαk1{iGk},\beta_i = \sum_{k = 1}^K \alpha_k \bold{1} \{i \in G_k\},

with k=1KGk={1,,N}\cup_{k = 1}^K G_k = \{1, \dots, N\}, GkGj=G_k \cap G_j = \emptyset and αkαj0\| \alpha_k - \alpha_j \| \neq 0 for any kjk \neq j, k=1,,Kk = 1, \dots, K. The total number of groups KK is determined by n_groups.

If a panel data set with exogenous regressors is generated (set q = NULL), the explanatory variables are simulated according to

xit,j=0.2γi+eit,j,γi,eit,ji.i.d.N(0,1),j={1,,p},x_{it,j} = 0.2 \gamma_i + e_{it,j}, \quad \gamma_i,e_{it,j} \sim i.i.d. N(0, 1), \quad j = \{1, \dots, p\},

where eit,je_{it,j} denotes a series of innovations. γi\gamma_i and eie_i are independent of each other.

In case alpha_0 = NULL, the group-level slope parameters αk\alpha_{k} are drawn from U[2,2]\sim U[-2, 2].

If a dynamic panel is specified (dynamic = TRUE), the ARAR coefficients βiAR\beta^{\text{AR}}_i are drawn from a uniform distribution with support (1,1)(-1, 1) and xit,j=eit,jx_{it,j} = e_{it,j}. Moreover, the individual fixed effects enter the dependent variable via (1βiAR)γi(1 - \beta^{\text{AR}}_i) \gamma_i to account for the autoregressive dependency. We refer to Mehrabani (2023, sec 6) for details.

When specifying an endogenous panel (set q to qpq \geq p), the eit,je_{it,j} correlate with the cross-sectional innovations uitu_{it} by a magnitude of 0.5 to produce endogenous regressors (E(uX)0\text{E}(u|X) \neq 0). However, the endogenous regressors can be accounted for by exploiting the qq instruments in Z\bold{Z}, for which E(uZ)=0\text{E}(u|Z) = 0 holds. The instruments and the first stage coefficients are generated in the same fashion as X\bold{X} and α\bold{\alpha} when q = NULL.

The function nests, among other, the DGPs employed in the simulation study of Mehrabani (2023, sec. 6).

Value

A list holding

alpha

the K×pK \times p matrix of group-specific slope parameters. If dynamic = TRUE, the first column holds the ARAR coefficient.

groups

a vector indicating the group memberships (g1,,gN)(g_1, \dots, g_N), where gi=kg_i = k if ii \in group kk.

y

a NT×1NT \times 1 vector of the dependent variable, with y=(y1,,yN)\bold{y}=(y_1, \dots, y_N)^\prime, yi=(yi1,,yiT)y_i = (y_{i1}, \dots, y_{iT})^\prime and the scalar yity_{it}.

X

a NT×pNT \times p matrix of explanatory variables, with X=(x1,,xN)\bold{X}=(x_1, \dots, x_N)^\prime, xi=(xi1,,xiT)x_i = (x_{i1}, \dots, x_{iT})^\prime and the p×1p \times 1 vector xitx_{it}.

Z

a NT×qNT \times q matrix of instruments , where qpq \geq p, Z=(z1,,zN)\bold{Z}=(z_1, \dots, z_N)^\prime, zi=(zi1,,ziT)z_i = (z_{i1}, \dots, z_{iT})^\prime and zitz_{it} is a q×1q \times 1 vector. In case a panel with exogenous regressors is generated (q = NULL), Z\bold{Z} equals NULL.

data

a NT×(p+1)NT \times (p + 1) data.frame of the outcome and the explanatory variables.

Author(s)

Paul Haimerl

References

Mehrabani, A. (2023). Estimation and identification of latent group structures in panel data. Journal of Econometrics, 235(2), 1464-1482. doi:10.1016/j.jeconom.2022.12.002.

Examples

# Simulate DGP 1 from Mehrabani (2023, sec. 6)
alpha_0_DGP1 <- matrix(c(0.4, 1, 1.6, 1.6, 1, 0.4), ncol = 2)
DGP1 <- sim_DGP(
  N = 50, n_periods = 20, p = 2, n_groups = 3,
  group_proportions = c(.4, .3, .3), alpha_0 = alpha_0_DGP1
)

Simulate a Time-varying Panel With a Group Structure in the Slope Coefficients

Description

Construct a time-varying panel data set subject to a group structure in the slope coefficients with optional AR(1)AR(1) innovations.

Usage

sim_tv_DGP(
  N = 50,
  n_periods = 40,
  intercept = TRUE,
  p = 1,
  n_groups = 3,
  d = 3,
  dynamic = FALSE,
  group_proportions = NULL,
  error_spec = "iid",
  locations = NULL,
  scales = NULL,
  polynomial_coef = NULL,
  sd_error = 1,
  DGP = lifecycle::deprecated()
)

Arguments

N

the number of cross-sectional units. Default is 50.

n_periods

the number of simulated time periods TT. Default is 40.

intercept

logical. If TRUE, a time-varying intercept is generated.

p

the number of simulated explanatory variables

n_groups

the number of groups KK. Default is 3.

d

the polynomial degree used to construct the time-varying coefficients.

dynamic

Logical. If TRUE, the panel includes one stationary autoregressive lag of yity_{it} as a regressor. Default is FALSE.

group_proportions

a numeric vector of length n_groups indicating size of each group as a fraction of NN. If NULL, all groups are of size N/KN / K. Default is NULL.

error_spec

options include

"iid"

for iidiid errors.

"AR"

for an AR(1)AR(1) error process with an autoregressive coefficient of 0.5.

Default is "iid".

locations

a p×Kp \times K matrix of location parameters of a logistic distribution function used to construct the time-varying coefficients. If left empty, the location parameters are drawn randomly. Default is NULL.

scales

a p×Kp \times K matrix of scale parameters of a logistic distribution function used to construct the time-varying coefficients. If left empty, the location parameters are drawn randomly. Default is NULL.

polynomial_coef

a p×d×Kp \times d \times K array of coefficients for a the polynomials used to construct the time-varying coefficients. If left empty, the location parameters are drawn randomly. Default is NULL.

sd_error

standard deviation of the cross-sectional errors. Default is 1.

DGP

[Deprecated] the data generating process. Options are

1

generates a trend only.

2

simulates a trend and an additional exogenous explanatory variable.

1

draws a dynamic panel data model with one ARAR lag.

Details

The scalar dependent variable yity_{it} is generated according to the following time-varying grouped panel data model

yit=γi+βitxit+uit,i=1,,N,  t=1,,T,y_{it} = \gamma_i + \beta^\prime_{it} x_{it} + u_{it}, \quad i = 1, \dots, N, \; t = 1, \dots, T,

where γi\gamma_i is an individual fixed effect and xitx_{it} is a p×1p \times 1 vector of explanatory variables. The coefficient vector βi={βi1,,βiT}\beta_i = \{\beta_{i1}^\prime, \dots, \beta_{iT}^\prime \}^\prime is subject to the group pattern

βi(tT)=k=1Kαk(tT)1{iGk},\beta_i \left( \frac{t}{T} \right) = \sum_{k = 1}^K \alpha_k \left( \frac{t}{T} \right) \bold{1} \{i \in G_k \},

with k=1KGk={1,,N}\cup_{k = 1}^K G_k = \{1, \dots, N\}, GkGj=G_k \cap G_j = \emptyset and supv[0,1](αk(v)αj(v))0\sup_{v \in [0,1]} \left( \| \alpha_k(v) - \alpha_j(v) \| \right) \neq 0 for any kjk \neq j, k=1,,Kk = 1, \dots, K. The total number of groups KK is determined by n_groups.

The predictors are simulated as:

xit,j=0.2γi+eit,j,γi,eit,ji.i.d.N(0,1),j={1,,p},x_{it,j} = 0.2 \gamma_i + e_{it,j}, \quad \gamma_i,e_{it,j} \sim i.i.d. N(0, 1), \quad j = \{1, \dots, p\},

where eit,je_{it,j} denotes a series of innovations. γi\gamma_i and eie_i are independent of each other.

The errors uitu_{it} feature a iidiid standard normal distribution.

In case locations = NULL, the location parameters are drawn from U[0.3,0.9]\sim U[0.3, 0.9]. In case scales = NULL, the scale parameters are drawn from U[0.01,0.09]\sim U[0.01, 0.09]. In case polynomial_coef = NULL, the polynomial coefficients are drawn from U[20,20]\sim U[-20, 20] and normalized so that all coefficients of one polynomial sum up to 1. The final coefficient function follows as αk(t/T)=3F(t/T,location,scale)+j=1daj(t/T)j\alpha_k (t/T) = 3 * F(t/T, location, scale) + \sum_{j=1}^d a_j (t/T)^j, where F(,location,scale)F(\cdot, location, scale) denotes a cumulative logistic distribution function and aja_j reflects a polynomial coefficient.

Value

A list holding

alpha

a T×p×KT \times p \times K array of group-specific time-varying parameters

beta

a T×p×NT \times p \times N array of individual time-varying parameters

groups

a vector indicating the group memberships (g1,,gN)(g_1, \dots, g_N), where gi=kg_i = k if ii \in group kk.

y

a NT×1NT \times 1 vector of the dependent variable, with y=(y1,,yN)\bold{y}=(y_1, \dots, y_N)^\prime, yi=(yi1,,yiT)y_i = (y_{i1}, \dots, y_{iT})^\prime and the scalar yity_{it}.

X

a NT×pNT \times p matrix of explanatory variables, with X=(x1,,xN)\bold{X}=(x_1, \dots, x_N)^\prime, xi=(xi1,,xiT)x_i = (x_{i1}, \dots, x_{iT})^\prime and the p×1p \times 1 vector xitx_{it}.

data

a NT×(p+1)NT \times (p + 1) data.frame of the outcome and the explanatory variables.

Author(s)

Paul Haimerl

Examples

# Simulate a time-varying panel subject to a time trend and a group structure
sim <- sim_tv_DGP(N = 20, n_periods = 50, intercept = TRUE, p = 1)
y <- sim$y

Time-varying Pairwise Adaptive Group Fused Lasso

Description

Estimate a time-varying panel data model with a latent group structure using the pairwise adaptive group fused lasso (time-varying PAGFL). The time-varying PAGFL jointly identifies the latent group structure and group-specific time-varying functional coefficients. The time-varying coefficients are modeled as polynomial B-splines. The function supports both static and dynamic panel data models.

Usage

tv_pagfl(
  formula,
  data,
  index = NULL,
  n_periods = NULL,
  lambda,
  d = 3,
  M = floor(length(y)^(1/7) - log(p)),
  min_group_frac = 0.05,
  const_coef = NULL,
  kappa = 2,
  max_iter = 50000,
  tol_convergence = 1e-10,
  tol_group = 0.001,
  rho = 0.04 * log(N * n_periods)/sqrt(N * n_periods),
  varrho = 1,
  verbose = TRUE,
  parallel = TRUE,
  ...
)

## S3 method for class 'tvpagfl'
summary(object, ...)

## S3 method for class 'tvpagfl'
formula(x, ...)

## S3 method for class 'tvpagfl'
df.residual(object, ...)

## S3 method for class 'tvpagfl'
print(x, ...)

## S3 method for class 'tvpagfl'
coef(object, ...)

## S3 method for class 'tvpagfl'
residuals(object, ...)

## S3 method for class 'tvpagfl'
fitted(object, ...)

Arguments

formula

a formula object describing the model to be estimated.

data

a data.frame or matrix holding a panel data set. If no index variables are provided, the panel must be balanced and ordered in the long format Y=(Y1,,YN)\bold{Y}=(Y_1^\prime, \dots, Y_N^\prime)^\prime, Yi=(Yi1,,YiT)Y_i = (Y_{i1}, \dots, Y_{iT})^\prime with Yit=(yit,xit)Y_{it} = (y_{it}, x_{it}^\prime)^\prime. Conversely, if data is not ordered or not balanced, data must include two index variables that declare the cross-sectional unit ii and the time period tt of each observation.

index

a character vector holding two strings. The first string denotes the name of the index variable identifying the cross-sectional unit ii, and the second string represents the name of the variable declaring the time period tt. In case of a balanced panel data set that is ordered in the long format, index can be left empty if the the number of time periods n_periods is supplied.

n_periods

the number of observed time periods TT. If an index character vector is passed, this argument can be left empty. Default is Null.

lambda

the tuning parameter determining the strength of the penalty term. Either a single λ\lambda or a vector of candidate values can be passed. If a vector is supplied, a BIC-type IC automatically selects the best fitting λ\lambda value.

d

the polynomial degree of the B-splines. Default is 3.

M

the number of interior knots of the B-splines. If left unspecified, the default heuristic M=floor((NT)17log(p))M = \text{floor}((NT)^{\frac{1}{7}} - \log(p)) is used. Note that MM does not include the boundary knots and the entire sequence of knots is of length M+d+1M + d + 1.

min_group_frac

the minimum group cardinality as a fraction of the total number of individuals NN. In case a group falls short of this threshold, each of its members is allocated to one of the remaining groups according to the MSE. Default is 0.05.

const_coef

a character vector containing the variable names of explanatory variables that enter with time-constant coefficients.

kappa

the a non-negative weight used to obtain the adaptive penalty weights. Default is 2.

max_iter

the maximum number of iterations for the ADMM estimation algorithm. Default is 51045*10^4.

tol_convergence

the tolerance limit for the stopping criterion of the iterative ADMM estimation algorithm. Default is 110101*10^{-10}.

tol_group

the tolerance limit for within-group differences. Two individuals are assigned to the same group if the Frobenius norm of their coefficient vector difference is below this threshold. Default is 11031*10^{-3}.

rho

the tuning parameter balancing the fitness and penalty terms in the IC that determines the penalty parameter λ\lambda. If left unspecified, the heuristic ρ=0.07log(NT)NT\rho = 0.07 \frac{\log(NT)}{\sqrt{NT}} of Mehrabani (2023, sec. 6) is used. We recommend the default.

varrho

the non-negative Lagrangian ADMM penalty parameter. For the employed penalized sieve estimation PSE, the ϱ\varrho value is trivial. We recommend the default 1.

verbose

logical. If TRUE, helpful warning messages are shown. Default is TRUE.

parallel

logical. If TRUE, certain operations are parallelized across multiple cores. Default is TRUE.

...

ellipsis

object

of class tvpagfl.

x

of class tvpagfl.

Details

Consider the grouped time-varying panel data model

yit=γi+βi(t/T)xit+ϵit,i=1,,N,  t=1,,T,y_{it} = \gamma_i + \beta^\prime_{i} (t/T) x_{it} + \epsilon_{it}, \quad i = 1, \dots, N, \; t = 1, \dots, T,

where yity_{it} is the scalar dependent variable, γi\gamma_i is an individual fixed effect, xitx_{it} is a p×1p \times 1 vector of explanatory variables, and ϵit\epsilon_{it} is a zero mean error. The coefficient vector βi(t/T)\beta_{i} (t/T) is subject to the latent group pattern

βi(tT)=k=1Kαk(tT)1{iGk},\beta_i \left(\frac{t}{T} \right) = \sum_{k = 1}^K \alpha_k \left( \frac{t}{T} \right) \bold{1} \{i \in G_k \},

with k=1KGk={1,,N}\cup_{k = 1}^K G_k = \{1, \dots, N\}, GkGj=G_k \cap G_j = \emptyset and αkαj0\| \alpha_k - \alpha_j \| \neq 0 for any kjk \neq j, k=1,,Kk = 1, \dots, K.

The time-varying coefficient functions are estimated as polynomial B-splines using the penalized sieve-technique. To this end, let B(v)B(v) denote a M+d+1M + d +1 vector basis functions, where dd denotes the polynomial degree and MM the number of interior knots. Then, βi(t/T)\beta_{i}(t/T) and αk(t/T)\alpha_{k}(t/T) are approximated by forming linear combinations of the basis functions βi(t/T)πiB(t/T)\beta_{i} (t/T) \approx \pi_i^\prime B(t/T) and αi(t/T)ξkB(t/T)\alpha_{i}(t/T) \approx \xi_k^\prime B(t/T), where πi\pi_i and ξi\xi_i are (M+d+1)×p(M + d + 1) \times p coefficient matrices.

The explanatory variables are projected onto the spline basis system, which results in the (M+d+1)p×1(M + d + 1)p \times 1 vector zit=xitB(v)z_{it} = x_{it} \otimes B(v). Subsequently, the DGP can be reformulated as

yit=γi+zitvec(πi)+uit,y_{it} = \gamma_i + z_{it}^\prime \text{vec}(\pi_{i}) + u_{it},

where uit=ϵit+ηitu_{it} = \epsilon_{it} + \eta_{it} and ηit\eta_{it} reflects a sieve approximation error. We refer to Su et al. (2019, sec. 2) for more details on the sieve technique.

Inspired by Su et al. (2019) and Mehrabani (2023), the time-varying PAGFL jointly estimates the functional coefficients and the group structure by minimizing the criterion

QNT(π,λ)=1NTi=1Nt=1T(y~itz~itvec(πi))2+λNi=1N1j>iNω˙ijπiπjQ_{NT} (\bold{\pi}, \lambda) = \frac{1}{NT} \sum^N_{i=1} \sum^{T}_{t=1}(\tilde{y}_{it} - \tilde{z}_{it}^\prime \text{vec}(\pi_{i}))^2 + \frac{\lambda}{N} \sum_{i = 1}^{N - 1} \sum_{j > i}^N \dot{\omega}_{ij} \| \pi_i - \pi_j \|

with respect to π=(vec(πi),,vec(πN))\bold{\pi} = (\text{vec}(\pi_i)^\prime, \dots, \text{vec}(\pi_N)^\prime)^\prime. a~it=aitT1t=1Tait\tilde{a}_{it} = a_{it} - T^{-1} \sum^{T}_{t=1} a_{it}, a={y,z}a = \{y, z\} to concentrate out the individual fixed effects γi\gamma_i. λ\lambda is the penalty tuning parameter and w˙ij\dot{w}_{ij} denotes adaptive penalty weights which are obtained by a preliminary non-penalized estimation. \| \cdot \| represents the Frobenius norm. The solution criterion function is minimized via the iterative alternating direction method of multipliers (ADMM) algorithm proposed by Mehrabani (2023, sec. 5.1).

Two individuals are assigned to the same group if vec(π^iπ^j)ϵtol\| \text{vec} (\hat{\pi}_i - \hat{\pi}_j) \| \leq \epsilon_{\text{tol}}, where ϵtol\epsilon_{\text{tol}} is determined by tol_group. Subsequently, the number of groups follows as the number of distinct elements in π^\hat{\bold{\pi}}. Given an estimated group structure, it is straightforward to obtain post-Lasso estimates ξ^\hat{\bold{\xi}} using group-wise least squares (see grouped_tv_plm).

We recommend identifying a suitable λ\lambda parameter by passing a logarithmically spaced grid of candidate values with a lower limit close to 0 and an upper limit that leads to a fully homogeneous panel. A BIC-type information criterion then selects the best fitting λ\lambda value.

In case of an unbalanced panel data set, the earliest and latest available observations per group define the start and end-points of the interval on which the group-specific time-varying coefficients are defined.

Value

An object of class tvpagfl holding

model

a data.frame containing the dependent and explanatory variables as well as cross-sectional and time indices,

coefficients

let p(1)p^{(1)} denote the number of time-varying coefficients and p(2)p^{(2)} the number of time constant parameters. A list holding (i) a T×p(1)×K^T \times p^{(1)} \times \hat{K} array of the post-Lasso group-specific functional coefficients and (ii) a K×p(2)K \times p^{(2)} matrix of time-constant post-Lasso estimates.

groups

a list containing (i) the total number of groups K^\hat{K} and (ii) a vector of estimated group memberships (g^1,,g^N)(\hat{g}_1, \dots, \hat{g}_N), where g^i=k\hat{g}_i = k if ii is assigned to group kk,

residuals

a vector of residuals of the demeaned model,

fitted

a vector of fitted values of the demeaned model,

args

a list of additional arguments,

IC

a list containing (i) the value of the IC, (ii) the employed tuning parameter λ\lambda, and (iii) the MSE,

convergence

a list containing (i) a logical variable if convergence was achieved and (ii) the number of executed ADMM algorithm iterations,

call

the function call.

An object of class tvpagfl has print, summary, fitted, residuals, formula, df.residual and coef S3 methods.

Author(s)

Paul Haimerl

References

Mehrabani, A. (2023). Estimation and identification of latent group structures in panel data. Journal of Econometrics, 235(2), 1464-1482. doi:10.1016/j.jeconom.2022.12.002.

Su, L., Wang, X., & Jin, S. (2019). Sieve estimation of time-varying panel data models with latent structures. Journal of Business & Economic Statistics, 37(2), 334-349. doi:10.1080/07350015.2017.1340299.

Examples

# Simulate a time-varying panel with a trend and a group pattern
set.seed(1)
sim <- sim_tv_DGP(N = 10, n_periods = 50, intercept = TRUE, p = 1)
df <- data.frame(y = c(sim$y))

# Run the time-varying PAGFL
estim <- tv_pagfl(y ~ ., data = df, n_periods = 50, lambda = 10, parallel = FALSE)
summary(estim)