Forecasting Time Series of Inhomogeneous Poisson Processes With Application To Call Center Workforce Management
Forecasting Time Series of Inhomogeneous Poisson Processes With Application To Call Center Workforce Management
statistical efficiency of the method. Note that forecasting the latent arrival
rates of the Poisson processes is of primary interest from the management
point of view (see Section 4.1). Although the point forecasts for counts
and rates are the same, their distributional forecasts are different. Fur-
thermore, neither Weinberg, Brown and Stroud (2007) nor Shen and Huang
(2008) has considered the managerial consequences of different forecasts of
the rates of the Poisson processes.
The purpose of this paper is to develop a forecasting method that utilizes
the widely used Poisson assumption in queueing models. More precisely,
we consider a time series of inhomogeneous Poisson processes and use the
historical data to forecast the future rate functions of the Poisson processes.
In the call center application, for example, each Poisson process models the
customer call arrivals during one day in a sequence of days. Since the rate
function of each Poisson process is approximately constant during short time
intervals (such as quarter hours in our data example in Section 4), the data
for a given day can be aggregated into a vector of Poisson random variables
with varying rates, counting the call arrivals during these intervals. The
collection of such rates for a given day is referred as the rate profile and the
corresponding counts form the count profile. The unobservable rate profiles
form a vector time series, and our goal is to forecast future rate profiles
using the observed historical count profiles.
The dimensionality of the vector time series of count profiles is usually
high. Thus, we propose to first reduce dimension by building a factor model
on the hidden rate profiles. The proposed dimension reduction technique
can be viewed as an extension of singular value decomposition to Poisson
data, or Poisson SVD. According to the factor model, every rate profile can
be expressed as a linear combination of a few factors. Factor loadings and
scores can be computed by fitting generalized linear models (GLM) [Dobson
(2001)]. An alternating maximum likelihood algorithm is employed that fits
marginal Poisson regression models by alternately fixing the factor loadings
and scores. The algorithm is closely related to the alternating least squares
algorithm for computing singular value decomposition [Gabriel and Zamir
(1979)].
After the factor analysis, forecasting future rate profiles reduces to fore-
casting time series of factor scores. Univariate time series models can be
built for each factor score series to produce time series forecasts of the rate
profile. To achieve within-process dynamic rate updating, we propose to ef-
fectively combine the information contained in both the historical processes
and the current process, through maximizing a penalized likelihood crite-
rion. The criterion appropriately balances two measures, the goodness-of-fit
of the factor model to the early segment of the current process and the devi-
ation of the factor scores from their forecasts provided by the interday time
series forecasting.
4 H. SHEN AND J. Z. HUANG
Our forecasting approach enjoys the benefit of both the model-driven ap-
proach of Weinberg, Brown and Stroud (2007) and the data-driven approach
of Shen and Huang (2008). It directly models and forecasts the rate profiles
of inhomogeneous Poisson processes. [Some earlier analysis is briefly doc-
umented in Shen, Huang and Lee (2007).] Making no rigid model assump-
tions on the rate profiles, our approach is robust, as shown in two simulation
studies. In this paper we also illustrate how rate forecasting and dynamic
updating benefits the staffing decision in a real call center application, which
has not been considered before in the literature.
The data we analyze and use for building forecasting models have an inter-
esting two-way structure: there are both day-to-day variation/dependence
and within-day variation/dependence. This specific structure differentiates
our work with the related literature on longitudinal data analysis and dy-
namic factor models, where only one-way structure is present. Longitudinal
data analysis [Diggle et al. (2002)] concerns repeated measurements from
many subjects. While there are typically within subject correlation, the mea-
surements from different subjects are usually independent. Dynamic factor
models are commonly used in econometrics for analyzing economic time
series [Stock and Watson (2005)]. Since economic variables do not have a
natural ordering as the one present in our within-day call volume profiles,
intraday dynamic updating is not of concern in the dynamic factor models
literature. Moreover, we are unaware of any work on dynamic factor models
for Poisson count data.
The rest of the paper is structured as follows. Section 2 describes the factor
model as well as the alternating maximum likelihood estimation algorithm
for model estimation. Our forecasting approach is described in detail in
Section 3. The proposed method is applied in Section 4 to the call center
arrival data analyzed by Shen and Huang (2008). Some background on call
center staffing is briefly discussed in Section 4.1. Section 4.2 fits the factor
model to the real data. Two simulation studies are presented in Section 4.3.2
to illustrate the robustness of our method and its performance on forecasting
hidden rate profiles. The effect of rate forecasting on staffing level is discussed
in Section 4.3.3. In Section 4.4 several intraday rate updating methods are
used to update the related staffing levels. We conclude in Section 5 with
some discussion.
counts from n such processes with each process being aggregated into m time
intervals. Furthermore, we assume that yij is a Poisson random variable with
rate λij . For notational purpose, we let Λ = (λij ) denote the n × m hidden
Poisson rate matrix. The ith row of Λ, denoted as λT(i) = (λi1 , . . . , λim ), is the
rate profile of the ith process. Correspondingly, the ith row of Y, denoted
T = (y , . . . , y ), is the count profile of the ith process. Note that the
as y(i) i1 im
rows of Λ and Y are time ordered.
The rate profiles {λ(i) }ni=1 then form a vector-valued time series taking
values in Rm . It is of interest to forecast future rate profiles λ(n+h) (h > 0).
However, the difficulty is that the rate profiles are unobservable. The idea is
to build a time series forecasting model on the corresponding count profiles
{y(i) }ni=1 , which can then be used to forecast λ(n+h) .
In practice, the dimensionality of the vector time series {y(i) } is usually
so large that it is infeasible to directly apply the classical vector autoregres-
sive and moving average (VARMA) models [Reinsel (1997)]. For example,
the call center application in Section 4 has m = 68, and the application of
Weinberg, Brown and Stroud (2007) has m = 169. This calls for the neces-
sity of dimension reduction. In addition, each y(i) is a vector of Poisson
random variables with a positive rate vector λ(i) . The Poisson nature of the
data needs to be accounted for appropriately.
For dimension reduction of Poisson variables, we consider the following
K-factor model,
y(i) ∼ Poisson(λ(i) ), i = 1, . . . , n,
(2.1)
g(λ(i) ) = βi1 f1 + · · · + βiK fK ≡ Fβ(i) ,
where β (i) = (βi1 , . . . , βiK )T is the K-vector of underlying factor scores for
the ith rate profile, Fm×K = (f1 , . . . , fK ) contains the K factor loading vec-
tors in Rm , and the transformation g is a link function suitable for Poisson
variables such as the logarithmic or square root function. Here and through-
out the paper, application of the link function g to a vector or matrix is un-
derstood as a componentwise operation. See McCullagh and Nelder (1989)
and Dobson (2001) for more discussion on generalized linear models (GLM)
and, in particular, specification of link functions.
Denote the factor matrix as Bn×K = (β T(1) , . . . , β T(n) )T . Then the factor
model for the transformed rate profiles can be written in the following matrix
form:
Y ∼ Poisson(Λ),
(2.2)
g(Λ) = BFT .
The factor model summarizes the transformed rate profiles using K com-
mon factors, denoted as β 1 , . . . , β K , which are the columns of B. Note that
each β k is a time series of factor scores. How to build time series models on
these series for forecasting will be discussed in Section 3. In practice, one
6 H. SHEN AND J. Z. HUANG
3. Repeat Step 2 with Bold and Fold replaced by the first K columns of
Unew Snew and Vnew respectively until convergence.
The algorithm is presented in such a way that the factor loadings are
orthonormal in that FT F = I. Alternatively, we can modify the algorithm
to make the score vectors satisfy BT B = I. To achieve that, we can set B to
be the first K columns of the left singular vector matrix U, and F to be the
corresponding columns of SV. This alternative formulation turns out to be
more useful for the penalized dynamic updating approach to be discussed
in Section 3.2.
Our Poisson factor model extends singular value decomposition (SVD) to
Poisson count data. The above alternating maximum likelihood algorithm is
an extension of the alternating least squares algorithm for computing SVD
[Gabriel and Zamir (1979)].
In addition, consider the saturated model where the rate matrix Λ is esti-
mated as the count matrix Y, and denote the corresponding log-likelihood
as l(Y; Λ = Y). The deviance of the model (2.1) is then defined as
b
2{l(Y; Λ = Y) − l(Y; Λ = Λ)}.
8 H. SHEN AND J. Z. HUANG
3. Forecasting.
3.1. Forecasting future rate profile. Given the historical count data y(i) ,
i = 1, . . . , n, and assuming the latent Poisson rates satisfy (2.1), consider
forecasting the future rate profile λ(n+h) (h > 0). According to (2.1),
λ(n+h) = g−1 (βn+h,1 f1 + · · · + βn+h,K fK ).
Since the factor loading vectors f1 , . . . , fK can be obtained from historical
data using the alternating maximum likelihood (AML) algorithm, forecast-
ing the m-dimensional rate profile λ(n+h) reduces to forecasting the K-
dimensional vector of factor scores β (n+h) = {βn+h,1 , . . . , βn+h,K }T . Suppose
we can obtain such a forecast β̂ TS
(n+h) , then a forecast of λ(n+h) follows as
λ̂TS −1 TS TS
(n+h) = g (β̂n+h,1 f1 + · · · + β̂n+h,K fK ),
TS
where β̂n+h,k is a time series forecast of βn+h,k , 1 ≤ k ≤ K. Because the
count profile y(n+h) has a Poisson distribution with rate λ(n+h) , the point
forecast of y(n+h) is the same as λ̂TS(n+h) .
In addition to the factors, the AML algorithm also produces the matrix
B of factor scores, whose row vectors β (1) , . . . , β (n) form a K-dimension
time series. This vector time series is subject to time series modeling to
generate desired forecast β̂ TS
(n+h) . Note that the dimension K of this vector
time series is much smaller than the dimension m of the original observa-
tion y(i) . However, we propose to model the score time series for each factor
separately using univariate time series models such as exponential smooth-
ing, ARIMA models [Box, Jenkins and Reinsel (1997)] or state space models
[Harvey (1990)]. An appropriate model can be decided on by analyzing his-
torical data. The rational for this separate univariate time series modeling
lies in the alternating estimation algorithm (Section 2.2). We observe that
the score series β k is orthogonal to score series β ′k for k 6= k′ . This lack of
contemporaneous correlation suggests that the cross-correlations at nonzero
lags are likely to be small. Hence, it suffices to forecast each β k separately.
To generate interval and distributional forecasts, we modify the bootstrap
approach described in Shen and Huang (2008). For a fixed k, we use the
FORECASTING INHOMOGENEOUS POISSON PROCESSES 9
fitted time series model for the series β k recursively, and bootstrap the
model errors from the fitted model to generate a sample of B forecasts
TS,b
{β̂n+h,k }, 1 ≤ b ≤ B. Then B forecasts of λ(n+h) can be obtained as
TS,b −1 TS,b TS,b
b
λ (n+h) = g (β̂n+h,1 f1 + · · · + β̂n+h,K fK ), b = 1, . . . , B,
which provides a distributional forecast for λ(n+h) . To obtain a distributional
forecast of the count profile, for any b, we randomly sample one count profile
forecast y TS,b
b (n+h) from Poisson distributions with rate λb TS,b . The sample of B
(n+h)
forecasts of y(n+h) then leads to its distributional forecast. Interval forecasts
can be obtained easily using quantiles of the distributional forecasts.
(3.1) λ̂l,TS −1 TS l TS l
n+1 = g (β̂n+1,1 f1 + · · · + β̂n+1,K fK ),
where fkl is the latter segment of fk after the initial m0 time intervals. How-
ever, this forecast does not utilize any new information contained in yn+1 e .
The new information can be incorporated using a Poisson regression as
we describe now. Suppose the factor model (2.1) holds for the rate profile
10 H. SHEN AND J. Z. HUANG
which minimizes the negative log-likelihood function. Note that the regressor
Fe in the Poisson regression is obtained using historical data.
However, the above Poisson regression approach ignores the time series
dependence among the rate profiles, present in the factor score series. To im-
prove the ML forecast, we propose to combine it with the time series forecast
of β (n+1) using a penalized Poisson regression. Specifically, we minimize the
following penalized likelihood criterion with respect to β (n+1) ,
m0
X 2
{λn+1,j − yn+1,j log(λn+1,j )} + ωkβ (n+1) − β̂ TS
(n+1) k
j=1
(3.4)
subject to g(λe(n+1) ) = Fe β (n+1) ,
where β̂ TS
(n+1) is a time series forecast based on the historical count pro-
files, and ω > 0 is a penalty parameter. To simplify our procedure, only one
penalty parameter is used. Thus, it is desirable for the K time series {β k } to
be roughly on the same scale. This can be achieved by requiring them to be
orthonormal in the alternating maximum likelihood algorithm (Section 2.2).
The penalized criterion (3.4) involves two terms: the first term measures
e
the goodness-of-fit of the model to y(n+1) in terms of likelihood, while the
second term penalizes a large departure from the time series forecast. Its
solution is a compromise between the two terms based on the size of ω, the
penalty parameter. In practice, ω can be selected based on the forecasting
performance on a rolling hold-out sample [Shen and Huang (2008)].
Below in Section 3.3, we describe an iterative re-weighted least squares
(IRLS) algorithm for minimizing (3.4) based on a quadratic approximation
FORECASTING INHOMOGENEOUS POISSON PROCESSES 11
of the objective function. The minimizer then gives us the penalized maxi-
mum likelihood (PML) forecast of β (n+1) . The PML forecast of λl(n+1) (and
l
y(n+1) ) is then given by
j = m0 + 1, . . . , m; b = 1, . . . , B.
The interval and density forecasts of λn+1,j are obtained using the empirical
distribution of λ̂PML,b
n+1,j , b = 1, . . . , B. To obtain a distributional update of
PML,b
the count profile, for b = 1, . . . , B, we randomly sample one forecast ŷn+1,j
of yn+1,j from the Poisson distribution with rate λ̂PML,b
n+1,j . The sample of B
forecasts of yn+1,j then leads to its interval and density forecasts.
m0
X
+ {λ0n+1,j − yn+1,j log(λ0n+1,j )}
j=1
K
X
TS
+ω (βn+1,k − β̂n+1,k )2 ,
k=1
where λn+1,j = g−1 (fjeT β (n+1) ) and λ0n+1,j = g−1 (fjeT β 0(n+1) ). Dropping the
sub/super-scripts, the summand in the first term of (3.7) is
(3.8) (λ − λ0 ) − y{log(λ) − log(λ0 )},
where λ = g−1 (f T β) and λ0 = g−1 (f T β 0 ). It follows from a second-order
Taylor expansion that
(λ − λ0 ) − y{log(λ) − log(λ0 )} = w(y, f T β 0 ){f T β − y ∗ (y, f T β 0 )}2 + c(β 0 ),
where c(β 0 ) is a constant given the initial estimate β 0 , while the specific
expressions of the functions w(·, ·) and y ∗ (·, ·) depend on the link function
g.
The exact expressions of w(·, ·) and y ∗ (·, ·) for several commonly used link
functions are listed below. For the identity link,
y (f T β 0 )2 − yf T β 0
w(y, f T β 0 ) = , y ∗ (y, f T β 0 ) = f T β 0 − ;
2(f β 0 )2
T y
for the logarithmic link,
T β0
w(y, f T β 0 ) = 12 f T β 0 , y ∗ (y, f T β 0 ) = f T β 0 − (1 − ye−f );
and for the square-root link,
y (f T β 0 )3 − yf T β 0
w(y, f T β 0 ) = 1 + , y ∗ (y, f T β 0 ) = f T β 0 − .
(f β 0 )2
T (f T β 0 )2 + y
Note that, for all three links, the induced response variable y ∗ is a shifted
version of f T β 0 .
Plugging back the sub/super-scripts, barring any additive constant inde-
pendent of β (n+1) , the quadratic approximation of the minimizing criterion
C(β (n+1) ) is equivalent to
m0
X
w(yn+1,j , fjeT β 0(n+1) ){fjeT β (n+1) − y ∗ (yn+1,j , fjeT β 0(n+1) )}2
j=1
K
X
TS
+ω (βn+1,k − β̂n+1,k )2 .
k=1
FORECASTING INHOMOGENEOUS POISSON PROCESSES 13
The call center data record the incoming call volumes to a northeastern
US bank call center during every quarter hour within the normal business
hour (7:00AM–midnight). The data cover 210 weekdays between January
6th and October 24th, 2003. Among them, ten abnormal days are excluded
from the analysis, including six holidays where the call volumes are very
low and four days where the data are missing [Shen and Huang (2008)].
Empirical research has recently suggested that it is appropriate to model
the arrival process of customer calls to a call center as an inhomogeneous
Poisson process [Brown et al. (2005)].
This section is organized as follows. We first provide some background on
call center agent staffing in Section 4.1 to facilitate our later calculation of
staffing levels. We fit the factor model (2.1) in Section 4.2 and develop time
series models for the factor score series. In Section 4.3 simulation studies
are first performed to investigate the rate forecasting performance of our
methods. The effect of interday rate forecasting on staffing level is then
illustrated using the real data. Various intraday updating methods are then
compared in Section 4.4 in terms of the related staffing level forecasts.
Fig. 1. The deviance reduction plot, suggesting five significant factors whose loadings are
plotted.
16 H. SHEN AND J. Z. HUANG
Fig. 2. Time series plot of the first score series and its lag-one scatter plot, suggesting
an AR(1) time series model with a day-of-the-week dependent slope.
where di−1 denotes the day-of-the-week of day i − 1, and the varying in-
tercept a1 depends on di−1 . A more complicated model was also considered
where the slope is allowed to depend on day-of-the-week. However, an F -test
for the nested models returns a p-value of 0.7724, which suggests that the
larger model does not provide any significant improvement.
Further exploratory data analysis suggested similar varying intercept AR(1)
models for the other score series. Hence, we opt to use such models to fore-
cast the future scores, which are denoted as
Under this model, the square-root of the rate has a two-way multiplicative
structure: the day-to-day variation (αi ) is auto-regressive of order one with
mean depending on day-of-the-week (di ); the time-of-day variation (γdi j )
also depends on day-of-the-week. This model can be viewed as
a non-Bayesian version of the Bayesian model proposed by
Weinberg, Brown and Stroud (2007), except that they also require the in-
traday variation γdi j to be smooth.
An additive model. The additive (ADD) model assumes that the Poisson
rates satisfy
q
λij = µ + αi + βj + γdi j , di = 1, 2, 3, 4, 5,
(4.5) αi − adi = b(αi−1 − adi−1 ) + ηi , ηi ∼ N (0, φ2 ),
X X X X X
α i = βj = γd j = γ d j = γdi j = 0.
i i
i j i j ij
Fig. 3. Comparison of empirical CDF of Mean RMSE for rate forecasting. The true
model is highlighted in the legend using an asterisk. TS4 performs comparably to the true
model, while the wrong model performs worse.
(CDF) of the Mean RMSE calculated on the 100 data sets simulated using
the multiplicative and additive models respectively. The true model is indi-
cated in the legend using an asterisk. When the data are generated using the
multiplicative model, the additive model is a misspecified model and vice
versa. In both cases, our TS methods do not use the model assumptions on
the form of the underlying Poisson rate. The improvement of TS5 over TS4
is minimal; hence, the CDF for TS5 is omitted in both panels.
Several observations can be made from the plots. For the TS methods,
when increasing the number of factors K, the performance measure gets
stochastically smaller; TS4 is competitively close to the true model; when
K increases beyond five, the forecasting improvement remains minimal. This
suggests that four underlying factors are sufficient to approximate the true
models. In addition, the wrong parametric model results in stochastically
inferior forecasts than TS4. The uniformly good performance of our method
shows its robustness against model assumptions, which is important in prac-
tice where the information of the true underlying model is hardly ever avail-
able. The results for Mean MRE (%) are similar and are not shown.
4.3.3. The effect of rate forecasting on staffing level. Below we apply the
seven forecasting methods considered previously in Section 4.3.2 to the call
center data, and illustrate how the rate forecasting affects staffing level. This
important fundamental question has not been investigated previously in the
literature. To calculate the staffing level, we apply the square-root safety
staffing rule discussed in Section 4.1.
We assume an average service time of 5 minutes per call, which corre-
sponds to an agent service rate of 12 calls per hour, or 3 calls per 15-minute
interval. This figure is chosen subjectively for illustration purposes based
on the empirical analysis in Brown et al. (2005). Suppose the arrival rate is
20 H. SHEN AND J. Z. HUANG
Table 1
Summary statistics (mean, median, lower quartile Q1, upper quartile Q3) of RMSE and
MRE of the forecasted staffing level in a rolling forecast exercise. The forecasting set
contains 50 days. MUL, TS4 and TS5 perform comparable
forecasted to be λj for the jth interval. Then the offered load is Rj = λj /3.
To figure out the additional safety staffing, we assume that the call center
expects a 22% delay probability in steady state, which then determines the
safety staffing factor θ to be 1 according to (4.2). Hence, it follows that the
required staffing level for interval j is
q
λj /3 + λj /3.
4.4. Dynamic intraday updating of rate and staffing level. The call cen-
ter data are used to illustrate the benefit of dynamic updating. We focus
on the 10:00AM updating and the 12:00PM updating, which means that
intraday dynamic updating is performed at 10:00AM and 12:00PM, respec-
tively. The benchmark is the TS4 method which performs no updating. We
shall use the square-root link and K = 4 based on the forecasting results in
Section 4.3.3. Correspondingly, we term our penalized maximum likelihood
intraday updating approach as PML4.
For comparison purpose, we also consider two alternative intraday up-
dating approaches that combine the MUL/ADD forecasts with historical
proportions (HP). Suppose the MUL point forecast for the rate profile of
day n + 1 is λ̂MUL
(n+1) , which also gives the point forecast for the count profile
y(n+1) . For an updating point m0 :
• calculate the ratio R between the total number of calls arrived and the
cumulative forecasted rate up to the time period m0 ,
Pm0
j=1 yn+1,j
R = Pm0 MUL
;
j=1 λ̂n+1,j
Table 2
Summary statistics (mean, median, lower quartile Q1 and upper quartile Q3) of RMSE
of the updated staffing level for the 10:00AM and 12:00PM updatings. PML4 outperforms
the other methods
performance measure (e.g., RMSE) for every day in the hold-out sample and
take the average. The ω that minimizes this average performance measure
will be used for all days in the forecasting set. In this study, we consider ω
from {0, 10, . . . , 109 }, and ω = 103 is chosen for both updatings.
Table 2 presents summary statistics of the RMSE of the forecasted staffing
levels from TS4, HPA, HPM and PML4. The averages are calculated over
the 50 days in the forecasting set. For a fair comparison, only data after
12:00PM are used when calculating the RMSE. The superior performance
of PML4 over the other methods is quite clear, which improves over TS4
by 14.5% on average. We also observe that, for every intraday updating
method, updating later always improves the forecasting accuracy. In addi-
tion, intraday updating reduces the prediction interval width as illustrated
in the right panel of Figure 4.
Figure 4 provides a graphical illustration of the forecasted staffing lev-
els for September 2nd, 2003. The left panel shows the required number of
agents for every 15-minute interval between 10:00AM and 17:00PM, when
Fig. 4. Comparison between the required number of agents per 15-minute interval for
September 2nd based on the forecasted rates from various methods. The PML4 10:00AM
updating gives the most accurate staffing.
FORECASTING INHOMOGENEOUS POISSON PROCESSES 23
the majority of the calls get connected to the center. We observe that the
10:00AM updating results in a dramatic upward shift in the related staffing
level, which is very close to the oracle staffing level. On the other hand, the
TS4 forecast leads to uniformly under-staffing throughout the day. What
happens is that September 2nd corresponds to the day after Labor Day.
Consequently, the call center experienced an unusably high call volume that
day, which was not accounted for by the TS4 method. The HP updating
methods can somehow adjust for the upward shift; however, their perfor-
mance is worse than the PML4 method.
In the right panel of Figure 4, we superimpose the 95% prediction inter-
vals for the staffing level resulting from the corresponding intervals for the
forecasted arrival rates. Only PML4 and TS4 are compared. The number of
bootstrapped forecasts is chosen to be B = 1000. We observe that the in-
tervals from the intraday updating (PML4) almost always cover the “true”
staffing level, while the intervals without the updating miss for more than
half of the time periods. In addition, intraday updating results in uniformly
narrower prediction intervals, which suggests that the prediction is more
precise. The average interval width for TS4 and PML4 is 84.86 and 49.65,
respectively; hence, a 41.5% average reduction results from the intraday up-
dating. The managerial benefit is that the call center manager can work
with a much narrower range of staffing level in the presence of arrival rate
uncertainty.
REFERENCES
Aksin, Z., Armony, M. and Mehrotra, V. (2007). The modern call-center: A multi-
disciplinary perspective on operations management research. Production and Operations
Management 16 665–688.
Box, G. E. P., Jenkins, G. M. and Reinsel, G. C. (1994). Time Series Analysis: Fore-
casting and Control, 3rd ed. Prentice Hall, Englewood Cliffs, New Jersey. MR1312604
Brown, L. D., Cai, T., Zhang, R., Zhao, L. and Zhou, H. (2007). The root-unroot
algorithm for density estimation as implemented via wavelet block thresholding. Tech-
nical report.
Brown, L. D., Gans, N., Mandelbaum, A., Sakov, A., Shen, H., Zeltyn, S. and
Zhao, L. (2005). Statistical analysis of a telephone call center: A queueing-science
perspective. J. Amer. Statist. Assoc. 100 36–50. MR2166068
Cox, D. R. (1955). Some statistical methods connected with series of events. J. Roy.
Statist. Soc. Ser. B 17 129–164. MR0092301
Diggle, P., Heagerty, P., Liang, K. Y. and Zeger, S. (2002). Analysis of Longitudinal
Data, 2nd ed. Oxford Univ. Press, New York. MR2049007
Dobson, A. J. (2001). An Introduction to Generalized Linear Models, 2nd ed. Chapman
and Hall/CRC, London. MR1070981
Gabriel, K. R. and Zamir, S. (1979). Lower rank approximation of matrices by least
squares with any choice of weights. Technometrics 21 489–498.
Gans, N., Koole, G. M. and Mandelbaum, A. (2003). Telephone call centers: Tutorial,
review, and research prospects. Manufacturing & Service Operations Management 5
79–141.
Garnett, O., Mandelbaum, A. and Reiman, M. (2002). Designing a call center with
impatient customers. Manufacturing & Service Operations Management 4 208–227.
Halfin, S. and Whitt, W. (1981). Heavy-traffic limits for queues with many exponential
servers. Operations Research 29 567–588. MR0629195
Harvey, A. C. (1990). Forecasting, Structural Time Series Models and the Kalman Filter.
Cambridge Univ. Press, New York. MR1085719
Mandelbaum, A. (2006). Call centers. Research bibliography with abstracts. Technical
report, Technion, Israel.
McCullagh, P. and Nelder, J. A. (1989). Generalized Linear Models, 2nd ed. Chapman
and Hall, London. MR0727836
Reinsel, G. C. (1997). Elements of Multivariate Time Series Analysis, 2nd ed. Springer,
New York. MR1451875
Shen, H. and Huang, J. Z. (2008). Interday forecasting and intraday updating of call
center arrivals. Manufacturing & Service Operations Management. To appear.
FORECASTING INHOMOGENEOUS POISSON PROCESSES 25
Shen, H., Huang, J. Z. and Lee, C. (2007). Forecasting and dynamic updating of un-
certain arrival rates to a call center. Proceedings of the IEEE/INFORMS International
Conference on Service Operations and Logistics, and Informatics 50–55.
Stock, J. H. and Watson, M. W. (2005). Implications of dynamic factor models for
VAR analysis. NBER Working Paper No. 11467.
Weinberg, J., Brown, L. D. and Stroud, J. R. (2007). Bayesian forecasting of an
inhomogeneous Poisson process with applications to call center data. J. Amer. Statist.
Assoc. 102 1185–1199.