Areal data models. Spatial smoothers. Brook s Lemma and Gibbs distribution. CAR models Gaussian case Non-Gaussian case

Size: px
Start display at page:

Download "Areal data models. Spatial smoothers. Brook s Lemma and Gibbs distribution. CAR models Gaussian case Non-Gaussian case"

Transcription

1 Areal data models Spatial smoothers Brook s Lemma and Gibbs distribution CAR models Gaussian case Non-Gaussian case SAR models Gaussian case Non-Gaussian case CAR vs. SAR STAR models

2 Inference for areal data Note: This chapter is very important for hierarchical spatial modeling of any type of data using MCMC methods. For areal units the inferential issues are: Is there a spatial pattern? How strong is it? Spatial pattern suggest that observations close to each other have more similar values than those far from each other. Do we want to smooth the data? How much? If we modify the areal units to new units (from zip codes to county values), what can we say about the new counts we expect for the latter give those for the former? This is the modifiable areal unit problem (MAUP).

3 Exploratory tools Proximity matrix W : proximity matrix. The entries in W connect different values of the process Y 1,...,Y n in some fashion. Generally w ii is set to zero. Examples (symmetric W ): w ij =1ifi and j share common boundary. w ij could be distance between centroids of regions i and j. w ij =1ifj is one of the K nearest neighbors of i. W does not need to be symmetric. The w ij might be standardized by j w ij = w i+. We can define distance intervals, (0,d 1 ], (d 1,d 2 ], and so on. Then, we call:

4 First order neighbors of unit i: all units within distance d 1 of i. Second order neighbors: all units within distance d 2 of i but separated by more more than d 1. Analogous to W we can define W (1) as the proximity matrix for the first-order neighbors. This means w (1) ij =1ifi and j and first-order neighbors. And, so on.

5 Measures of spatial association The standard statistics are the Moran s I and Geary s C. They are analogues for areal data of the empirical correlation function and the variogram. Moran s I: I = n i w ij(y i Ȳ )(Y j Ȳ ) ( i j w ij) i (Y i Ȳ )2 I is not supported on [ 1, 1]. Under the hypothesis of independence, I is asymptotically normal with mean 1/(n 1).

6 Geary s C: C = (n 1) i j w ij(y i Y j ) 2 ( i j w ij) i (Y i Ȳ )2 C is never negative, and has mean 1 for the null model. Low values (between 0 and 1) indicate positive spatial association. Under the null hypothesis we have asymptotic normality. However for testing is preferable to use Monte Carlo. By permuting the values of Y i s.

7 The correlogram is a useful tool to study spatial association with areal data. Working with I we can replace w ij with the previously defined w (1) ij and obtain say I (1). Then, we replace it with w (2) ij and obtain I (2). A plot of I (r) versus r is called a correlogram. If there is spatial pattern, we expect I (r) to decline in r Initially and then vary about 0.

8 Spatial smoothers W provides a spatial smoother. We can replace Y i by Ŷ i = j w ij Y j /w i+. This ensures that the value for an areal unit i looks more like its neighbors. Alternatively, we can consider (to take into account the actual value of Y i ) Ŷ i =(1 α)y i + αŷi, for α (0, 1). This can be viewed as a filter. We will revisit this topic in the hierarchical modeling chapter.

9 Brook s Lemma Given p(y 1,...,y n ), the full conditional distributions, then p(y i y j,j i) for i = 1,...,n, are uniquely determined. Brook s lemma proves the converse, and it enables us to retrieve the unique joint distribution determined by the conditionals. We can not write down an arbitrary set of conditionals and assert that they determine the joint distribution. Example: Y 1 Y 2 N(α 0 + α 1 Y 2,σ 2 1) Y 2 Y 1 N(β 0 + β 1 Y 3 1,σ 2 2) Thus, E[Y 1 ] is linear in E[Y 2 ] E[Y 1 ]=α 0 + α 1 E[Y 2 ], then, E[Y 2 ] is linear in E[Y 1 ]. However it must also be the case that E[Y 2 ]=β 0 + β 1 E[Y 3 1 ],

10 This can not be in general. Therefore, there is no joint distribution. Also, p(y 1,...,y n )mightbeimproperevenif the conditionals are proper. Example: p(y 1,y 2 ) exp( 1/2(y 1 y 2 ) 2 ). p(y 1 y 2 )is N(y 2, 1) and p(y 2 y 1 ) N(y 1, 1). But, p(y 1,y 2 ) is improper.

11 Brook s Lemma p(y 1, y 2...,y n ) p(y 10, y 2...,y n ) p(y 1,...,y n )= p(y 2, y 10,y 3...,y n ) p(y 20, y 10,y 3...,y n ) p(y n, y 10,...,y n 1,0 ) p(y n0, y 10,...,y n 1,0 ) p(y 10,...,y n0 ) here y 0 =(y 10,...,y n0 )isanyfixedpointin the support of p. The joint distribution is determined up to a proportionality constant by the conditionals.

12 Definitions Markov Random Field (MRF): We specify a set of full conditional distributions for the Y i such that p(y i y j,j i) =p(y i y j,j δ i ). The notion of using local specification to determine a joint distribution is refereed to as a MRF. Clique: A clique is a set of cells such that each element is a neighbor of every other element. We use notation i j if i is a neighbor of j and j is a neighbor of i. Potential: A potential of order k, itisa function of k arguments that is exchangeable in these arguments. The arguments of the potential would be the values taken by variables associated with the cells for a clique of size k. Example: for k =2,wehaveY i Y j if i and j are

13 a clique of size 2. This is a potential of order 2. Gibbs distribution: p(y 1,...,y n ) is a Gibbs distribution if it is a function of the Y i only through potentials on cliques. ( p(y 1,...,y n ) exp γ ) φ (k) (y α1,...,y αk ) k α M k φ (k) is a potential of order k, M k is the collection of all subsets of size k, α indexes this set, and γ>0 is a scale parameter. Hammersley-Clifford Theorem: If we have a MRF, i.e. if the conditional defines a unique joint distribution, then this joint distribution is a Gibbs distribution.

14 For continuous data on R, a common choice for joint distribution is p(y 1,...,y n ) exp 1 2τ 2 (y i y j ) 2 I(i j) We will study next this type of distributions, which are Gibbs distributions on potential of order 1 and 2, and then i,j p(y i y j,j i) =N( j δ i y j /m i,τ 2 /m i ) where m i is the number of neighbors of i.

15 CAR models Conditionally autoregressive models (CAR). The are widely used in MCMC methods for fitting certain classes of hierarchical spatial models. As we will see later. The Gaussian (autonormal) case Y i y j,j i N( j b ij y j,τ 2 i ) i = 1,...,n. These full conditionals are compatible, through Brooks lemma we obtain p(y 1,...,y n ) exp { 1/2y T D 1 (I B)y } where B = {b ij } and D is diagonal with D ii = τ 2 i. For Y to be normal we need first to prove the symmetry of Σ Y =(I B) 1 D. The simple resulting conditions are

16 b ij τ 2 i = b ji τ 2 j for all i, j. Thus, B is not symmetric in this setting. Suppose we set b ij = w ij /w i+, and τi 2 = τ 2 /w i+. Then, the condition is satisfied, andwehavethaty, p(y 1,...,y n ) exp { 1/2τ 2 y T (D w W )y }, (1) where D w is diagonal with (D w ) ii = w i+.

17 A second problem is that (D w W )1 = 0 then Σ 1 y is singular and Σ y does not exits. thus, this distribution is improper. we can rewrite (1) as follows p(y 1,...,y n ) exp 1/2τ 2 i j w ij (y i y j ) 2, The impropriety of p is clear, since we can add any constant to all the Y i and the distribution is unaffected. The Y i are not centered. A constraint such as Y i =0 i would solve the problem. This is the IAR model, intrinsically autoregressive model. A joint distribution that is improper but has all full conditionals proper. The impropriety can be remedied in an obvious

18 way. Redefine: Σ 1 y = D w ρw and choose ρ to make Σ 1 y nonsingular. This is guaranteed if ρ (1/λ 1, 1/λ n ), where λ 1 < <λ n are the ordered eigenvalues of D 1/2 w WD 1/2 w. The bounds can be simplified, by replacing W by W = Diag(1/w i+ )W. then, Σ 1 y = D w (I α W ) where D w is diagonal. If α < 1, then I α W is nonsingular.

19 Interpretation of the ρ parameter: The additional parameter ρ, when it is zero, the Y i become independent. ρ should not be interpreted as a parameter that explains the spatial dependency. For instance, in a simulation study when ρ =.8, I =.1, when ρ =.9, I=.5. But, an improper choice (ρ = 1) may enable wider scope for posterior spatial patterns, and might be preferable.

20 We may write the CAR model as Y = BY + ɛ, or (I B)Y = ɛ. If p(y) is proper, then Y N(0, (I B) 1 D) then ɛ N(0,D(I B) t ), i.e. the components of ɛ are not independent. Also cov(ɛ, Y )=D.

21 The non-gaussian CAR In many cases (e.g. binary data) the normality assumption might not be appropriate. We can start with any exponential family model: p(y i y j,j i) exp(ψ(θ i y i χ(θ i ))) θ i is a canonical link, e.g. θ i = j i b ijy j χ is some specific function, and ψ is a non-negative dispersion parameter. If you write θ i = x i β + j i b ijy j,forsome covariates x i,thenwehave p(y i y j,j i) exp(x i τ + ψ j i b ij y j )

22 Autologistic model When Y i are binary, the previous model gives us the autologistic model and log P (Y i =1) P (Y i =0) = x i γ + ψ j i w ij y j, where w ij =1,ifi j, and zero otherwise. The joint distribution (by Brook s lemma is) p(y 1,...,y n ) exp(γ( i y i x i )+ψ i j w ij y i y j )

23 SAR models Simultaneous autoregressive models (SAR). Remember that we may write the CAR model as Y = BY + ɛ, or (I B)Y = ɛ. Suppose that instead of letting Y induce the distribution of ɛ. We let ɛ induce a distribution Y. Suppose the ɛ N(0, D), where D is diagonal, ( D) ii = σ 2 i. Now Y i = j b ij Y j + ɛ i, Therefore, if (I B) isfullrank, Y N(0, (I B) 1 D((I B) 1 ) t )

24 Also cov(ɛ, Y )=D(I B) 1. If D = σ 2 I,then Y N(0,σ 2 (I B) 1 ((I B) 1 ) t )

25 Common choices for B: B = ρw, where W is called contiguity matrix, W has entries 1 or 0 according to whether or not i and j are neighbors (with w ii =0.). Here ρ is called a spatial autoregression parameter. We need to impose ρ (1/λ 1, 1/λ n ) where λ are ordered eigenvalues of W.TogetI ρw nonsingular. Alternatively, W can be replaced by W, and replace B = ρ W,then ρ < 1 With point-referenced data B is taken to be ρw where W is the matrix of inter-point distances.

26 A SAR model is usually used in a regression context, i.e. the residuals U = Y Xβ are assumed to follow a SAR model, rather than Y itself. Then, Y = BY +(I B)Xβ + ɛ. SAR models are well suited to maximum likelihood estimation but not at all for MCMC fitting of Bayesian models. Because it is difficult to introduce SAR random effects (in the CAR framework is easy because of the hierarchical conditional representation).

27 CAR versus SAR The CAR and SAR models are equivalent only if (I B) 1 D =(I B) 1 D((I B) 1 ) where the tilde indicates the SAR matrices. Any SAR model can be represented as a CAR model (because D is diagonal). But the converse is NOT TRUE.

28 Also, correlation among pairs can switch in nonintuitive ways, by varying the ρ parameter. Example, working with the adjacency relationships generated by the lower 48 contiguous US states, Wall (2004) finds that when ρ =.49 in proper CAR model, and corr(alabama, F lorida) =.2, and corr(alabama, Georgia) =.16. But when ρ =.975, we instead get corr(alabama, F lorida) =.65, and corr(alabama, Georgia) =.67.

29 STAR models SAR models have been extended to handle spatiotemporal data. The measurements Y it are spatially soociated at each fixed t. but, we might want to associate, say Y i2 with Y i1 and Y i3. Define W s that provides a spatial contiguity matrix for the Y s. And let W T define a temporal contiguity matrix for the Y s. We can define in our SAR model B = ρ s W s + ρ t W T. We can also introduce W s W T to incorporate interaction between space and time. This models are referred to as spatiotemporal autoregressive (STAR) models.

Areal Unit Data Regular or Irregular Grids or Lattices Large Point-referenced Datasets

Areal Unit Data Regular or Irregular Grids or Lattices Large Point-referenced Datasets Areal Unit Data Regular or Irregular Grids or Lattices Large Point-referenced Datasets Is there spatial pattern? Chapter 3: Basics of Areal Data Models p. 1/18 Areal Unit Data Regular or Irregular Grids

More information

Technical Vignette 5: Understanding intrinsic Gaussian Markov random field spatial models, including intrinsic conditional autoregressive models

Technical Vignette 5: Understanding intrinsic Gaussian Markov random field spatial models, including intrinsic conditional autoregressive models Technical Vignette 5: Understanding intrinsic Gaussian Markov random field spatial models, including intrinsic conditional autoregressive models Christopher Paciorek, Department of Statistics, University

More information

Summary STK 4150/9150

Summary STK 4150/9150 STK4150 - Intro 1 Summary STK 4150/9150 Odd Kolbjørnsen May 22 2017 Scope You are expected to know and be able to use basic concepts introduced in the book. You knowledge is expected to be larger than

More information

Markov Random Fields

Markov Random Fields Markov Random Fields 1. Markov property The Markov property of a stochastic sequence {X n } n 0 implies that for all n 1, X n is independent of (X k : k / {n 1, n, n + 1}), given (X n 1, X n+1 ). Another

More information

Probabilistic Graphical Models

Probabilistic Graphical Models 2016 Robert Nowak Probabilistic Graphical Models 1 Introduction We have focused mainly on linear models for signals, in particular the subspace model x = Uθ, where U is a n k matrix and θ R k is a vector

More information

Asymptotic standard errors of MLE

Asymptotic standard errors of MLE Asymptotic standard errors of MLE Suppose, in the previous example of Carbon and Nitrogen in soil data, that we get the parameter estimates For maximum likelihood estimation, we can use Hessian matrix

More information

Lattice Data. Tonglin Zhang. Spatial Statistics for Point and Lattice Data (Part III)

Lattice Data. Tonglin Zhang. Spatial Statistics for Point and Lattice Data (Part III) Title: Spatial Statistics for Point Processes and Lattice Data (Part III) Lattice Data Tonglin Zhang Outline Description Research Problems Global Clustering and Local Clusters Permutation Test Spatial

More information

Lecture 18. Models for areal data. Colin Rundel 03/22/2017

Lecture 18. Models for areal data. Colin Rundel 03/22/2017 Lecture 18 Models for areal data Colin Rundel 03/22/2017 1 areal / lattice data 2 Example - NC SIDS SID79 3 EDA - Moran s I If we have observations at n spatial locations s 1,... s n ) I = n i=1 n n j=1

More information

Modeling Real Estate Data using Quantile Regression

Modeling Real Estate Data using Quantile Regression Modeling Real Estate Data using Semiparametric Quantile Regression Department of Statistics University of Innsbruck September 9th, 2011 Overview 1 Application: 2 3 4 Hedonic regression data for house prices

More information

An Introduction to Spatial Statistics. Chunfeng Huang Department of Statistics, Indiana University

An Introduction to Spatial Statistics. Chunfeng Huang Department of Statistics, Indiana University An Introduction to Spatial Statistics Chunfeng Huang Department of Statistics, Indiana University Microwave Sounding Unit (MSU) Anomalies (Monthly): 1979-2006. Iron Ore (Cressie, 1986) Raw percent data

More information

Bayesian Areal Wombling for Geographic Boundary Analysis

Bayesian Areal Wombling for Geographic Boundary Analysis Bayesian Areal Wombling for Geographic Boundary Analysis Haolan Lu, Haijun Ma, and Bradley P. Carlin haolanl@biostat.umn.edu, haijunma@biostat.umn.edu, and brad@biostat.umn.edu Division of Biostatistics

More information

Bayesian spatial hierarchical modeling for temperature extremes

Bayesian spatial hierarchical modeling for temperature extremes Bayesian spatial hierarchical modeling for temperature extremes Indriati Bisono Dr. Andrew Robinson Dr. Aloke Phatak Mathematics and Statistics Department The University of Melbourne Maths, Informatics

More information

Nearest Neighbor Gaussian Processes for Large Spatial Data

Nearest Neighbor Gaussian Processes for Large Spatial Data Nearest Neighbor Gaussian Processes for Large Spatial Data Abhi Datta 1, Sudipto Banerjee 2 and Andrew O. Finley 3 July 31, 2017 1 Department of Biostatistics, Bloomberg School of Public Health, Johns

More information

Bayesian Inference. Chapter 4: Regression and Hierarchical Models

Bayesian Inference. Chapter 4: Regression and Hierarchical Models Bayesian Inference Chapter 4: Regression and Hierarchical Models Conchi Ausín and Mike Wiper Department of Statistics Universidad Carlos III de Madrid Advanced Statistics and Data Mining Summer School

More information

Effective Sample Size in Spatial Modeling

Effective Sample Size in Spatial Modeling Int. Statistical Inst.: Proc. 58th World Statistical Congress, 2011, Dublin (Session CPS029) p.4526 Effective Sample Size in Spatial Modeling Vallejos, Ronny Universidad Técnica Federico Santa María, Department

More information

Approaches for Multiple Disease Mapping: MCAR and SANOVA

Approaches for Multiple Disease Mapping: MCAR and SANOVA Approaches for Multiple Disease Mapping: MCAR and SANOVA Dipankar Bandyopadhyay Division of Biostatistics, University of Minnesota SPH April 22, 2015 1 Adapted from Sudipto Banerjee s notes SANOVA vs MCAR

More information

Lecture 7 Autoregressive Processes in Space

Lecture 7 Autoregressive Processes in Space Lecture 7 Autoregressive Processes in Space Dennis Sun Stanford University Stats 253 July 8, 2015 1 Last Time 2 Autoregressive Processes in Space 3 Estimating Parameters 4 Testing for Spatial Autocorrelation

More information

Now consider the case where E(Y) = µ = Xβ and V (Y) = σ 2 G, where G is diagonal, but unknown.

Now consider the case where E(Y) = µ = Xβ and V (Y) = σ 2 G, where G is diagonal, but unknown. Weighting We have seen that if E(Y) = Xβ and V (Y) = σ 2 G, where G is known, the model can be rewritten as a linear model. This is known as generalized least squares or, if G is diagonal, with trace(g)

More information

Multivariate spatial modeling

Multivariate spatial modeling Multivariate spatial modeling Point-referenced spatial data often come as multivariate measurements at each location Chapter 7: Multivariate Spatial Modeling p. 1/21 Multivariate spatial modeling Point-referenced

More information

Bayesian Inference. Chapter 4: Regression and Hierarchical Models

Bayesian Inference. Chapter 4: Regression and Hierarchical Models Bayesian Inference Chapter 4: Regression and Hierarchical Models Conchi Ausín and Mike Wiper Department of Statistics Universidad Carlos III de Madrid Master in Business Administration and Quantitative

More information

Models for spatial data (cont d) Types of spatial data. Types of spatial data (cont d) Hierarchical models for spatial data

Models for spatial data (cont d) Types of spatial data. Types of spatial data (cont d) Hierarchical models for spatial data Hierarchical models for spatial data Based on the book by Banerjee, Carlin and Gelfand Hierarchical Modeling and Analysis for Spatial Data, 2004. We focus on Chapters 1, 2 and 5. Geo-referenced data arise

More information

Bayesian SAE using Complex Survey Data Lecture 4A: Hierarchical Spatial Bayes Modeling

Bayesian SAE using Complex Survey Data Lecture 4A: Hierarchical Spatial Bayes Modeling Bayesian SAE using Complex Survey Data Lecture 4A: Hierarchical Spatial Bayes Modeling Jon Wakefield Departments of Statistics and Biostatistics University of Washington 1 / 37 Lecture Content Motivation

More information

Web Appendices: Hierarchical and Joint Site-Edge Methods for Medicare Hospice Service Region Boundary Analysis

Web Appendices: Hierarchical and Joint Site-Edge Methods for Medicare Hospice Service Region Boundary Analysis Web Appendices: Hierarchical and Joint Site-Edge Methods for Medicare Hospice Service Region Boundary Analysis Haijun Ma, Bradley P. Carlin and Sudipto Banerjee December 8, 2008 Web Appendix A: Selecting

More information

Kazuhiko Kakamu Department of Economics Finance, Institute for Advanced Studies. Abstract

Kazuhiko Kakamu Department of Economics Finance, Institute for Advanced Studies. Abstract Bayesian Estimation of A Distance Functional Weight Matrix Model Kazuhiko Kakamu Department of Economics Finance, Institute for Advanced Studies Abstract This paper considers the distance functional weight

More information

Conjugate Analysis for the Linear Model

Conjugate Analysis for the Linear Model Conjugate Analysis for the Linear Model If we have good prior knowledge that can help us specify priors for β and σ 2, we can use conjugate priors. Following the procedure in Christensen, Johnson, Branscum,

More information

Spatial inference. Spatial inference. Accounting for spatial correlation. Multivariate normal distributions

Spatial inference. Spatial inference. Accounting for spatial correlation. Multivariate normal distributions Spatial inference I will start with a simple model, using species diversity data Strong spatial dependence, Î = 0.79 what is the mean diversity? How precise is our estimate? Sampling discussion: The 64

More information

Hierarchical Nearest-Neighbor Gaussian Process Models for Large Geo-statistical Datasets

Hierarchical Nearest-Neighbor Gaussian Process Models for Large Geo-statistical Datasets Hierarchical Nearest-Neighbor Gaussian Process Models for Large Geo-statistical Datasets Abhirup Datta 1 Sudipto Banerjee 1 Andrew O. Finley 2 Alan E. Gelfand 3 1 University of Minnesota, Minneapolis,

More information

Hierarchical Modeling for Spatio-temporal Data

Hierarchical Modeling for Spatio-temporal Data Hierarchical Modeling for Spatio-temporal Data Sudipto Banerjee 1 and Andrew O. Finley 2 1 Biostatistics, School of Public Health, University of Minnesota, Minneapolis, Minnesota, U.S.A. 2 Department of

More information

Lecture 2: From Linear Regression to Kalman Filter and Beyond

Lecture 2: From Linear Regression to Kalman Filter and Beyond Lecture 2: From Linear Regression to Kalman Filter and Beyond January 18, 2017 Contents 1 Batch and Recursive Estimation 2 Towards Bayesian Filtering 3 Kalman Filter and Bayesian Filtering and Smoothing

More information

Lecture 2: From Linear Regression to Kalman Filter and Beyond

Lecture 2: From Linear Regression to Kalman Filter and Beyond Lecture 2: From Linear Regression to Kalman Filter and Beyond Department of Biomedical Engineering and Computational Science Aalto University January 26, 2012 Contents 1 Batch and Recursive Estimation

More information

Using Estimating Equations for Spatially Correlated A

Using Estimating Equations for Spatially Correlated A Using Estimating Equations for Spatially Correlated Areal Data December 8, 2009 Introduction GEEs Spatial Estimating Equations Implementation Simulation Conclusion Typical Problem Assess the relationship

More information

CSC 412 (Lecture 4): Undirected Graphical Models

CSC 412 (Lecture 4): Undirected Graphical Models CSC 412 (Lecture 4): Undirected Graphical Models Raquel Urtasun University of Toronto Feb 2, 2016 R Urtasun (UofT) CSC 412 Feb 2, 2016 1 / 37 Today Undirected Graphical Models: Semantics of the graph:

More information

AMS-207: Bayesian Statistics

AMS-207: Bayesian Statistics Linear Regression How does a quantity y, vary as a function of another quantity, or vector of quantities x? We are interested in p(y θ, x) under a model in which n observations (x i, y i ) are exchangeable.

More information

Temporal vs. Spatial Data

Temporal vs. Spatial Data Temporal vs. Spatial Data Temporal 1 dimensional Units: day, week, month Lag: t, t-1, t-2 Durbin-Watson Spatial 2-3 dimensional Units: county, mile, region Lag: near neighbor, networks (?) Moran s I Differencing

More information

Chris Bishop s PRML Ch. 8: Graphical Models

Chris Bishop s PRML Ch. 8: Graphical Models Chris Bishop s PRML Ch. 8: Graphical Models January 24, 2008 Introduction Visualize the structure of a probabilistic model Design and motivate new models Insights into the model s properties, in particular

More information

An Introduction to Exponential-Family Random Graph Models

An Introduction to Exponential-Family Random Graph Models An Introduction to Exponential-Family Random Graph Models Luo Lu Feb.8, 2011 1 / 11 Types of complications in social network Single relationship data A single relationship observed on a set of nodes at

More information

1 Undirected Graphical Models. 2 Markov Random Fields (MRFs)

1 Undirected Graphical Models. 2 Markov Random Fields (MRFs) Machine Learning (ML, F16) Lecture#07 (Thursday Nov. 3rd) Lecturer: Byron Boots Undirected Graphical Models 1 Undirected Graphical Models In the previous lecture, we discussed directed graphical models.

More information

Lecture 5: Spatial probit models. James P. LeSage University of Toledo Department of Economics Toledo, OH

Lecture 5: Spatial probit models. James P. LeSage University of Toledo Department of Economics Toledo, OH Lecture 5: Spatial probit models James P. LeSage University of Toledo Department of Economics Toledo, OH 43606 jlesage@spatial-econometrics.com March 2004 1 A Bayesian spatial probit model with individual

More information

(5) Multi-parameter models - Gibbs sampling. ST440/540: Applied Bayesian Analysis

(5) Multi-parameter models - Gibbs sampling. ST440/540: Applied Bayesian Analysis Summarizing a posterior Given the data and prior the posterior is determined Summarizing the posterior gives parameter estimates, intervals, and hypothesis tests Most of these computations are integrals

More information

Web Appendix for Hierarchical Adaptive Regression Kernels for Regression with Functional Predictors by D. B. Woodard, C. Crainiceanu, and D.

Web Appendix for Hierarchical Adaptive Regression Kernels for Regression with Functional Predictors by D. B. Woodard, C. Crainiceanu, and D. Web Appendix for Hierarchical Adaptive Regression Kernels for Regression with Functional Predictors by D. B. Woodard, C. Crainiceanu, and D. Ruppert A. EMPIRICAL ESTIMATE OF THE KERNEL MIXTURE Here we

More information

A graph contains a set of nodes (vertices) connected by links (edges or arcs)

A graph contains a set of nodes (vertices) connected by links (edges or arcs) BOLTZMANN MACHINES Generative Models Graphical Models A graph contains a set of nodes (vertices) connected by links (edges or arcs) In a probabilistic graphical model, each node represents a random variable,

More information

Modelling geoadditive survival data

Modelling geoadditive survival data Modelling geoadditive survival data Thomas Kneib & Ludwig Fahrmeir Department of Statistics, Ludwig-Maximilians-University Munich 1. Leukemia survival data 2. Structured hazard regression 3. Mixed model

More information

Can we do statistical inference in a non-asymptotic way? 1

Can we do statistical inference in a non-asymptotic way? 1 Can we do statistical inference in a non-asymptotic way? 1 Guang Cheng 2 Statistics@Purdue www.science.purdue.edu/bigdata/ ONR Review Meeting@Duke Oct 11, 2017 1 Acknowledge NSF, ONR and Simons Foundation.

More information

Spatial Smoothing in Stan: Conditional Auto-Regressive Models

Spatial Smoothing in Stan: Conditional Auto-Regressive Models Spatial Smoothing in Stan: Conditional Auto-Regressive Models Charles DiMaggio, PhD, NYU School of Medicine Stephen J. Mooney, PhD, University of Washington Mitzi Morris, Columbia University Dan Simpson,

More information

The linear model is the most fundamental of all serious statistical models encompassing:

The linear model is the most fundamental of all serious statistical models encompassing: Linear Regression Models: A Bayesian perspective Ingredients of a linear model include an n 1 response vector y = (y 1,..., y n ) T and an n p design matrix (e.g. including regressors) X = [x 1,..., x

More information

Linear Methods for Prediction

Linear Methods for Prediction Chapter 5 Linear Methods for Prediction 5.1 Introduction We now revisit the classification problem and focus on linear methods. Since our prediction Ĝ(x) will always take values in the discrete set G we

More information

Chapter 4 - Fundamentals of spatial processes Lecture notes

Chapter 4 - Fundamentals of spatial processes Lecture notes Chapter 4 - Fundamentals of spatial processes Lecture notes Geir Storvik January 21, 2013 STK4150 - Intro 2 Spatial processes Typically correlation between nearby sites Mostly positive correlation Negative

More information

Bayesian Linear Models

Bayesian Linear Models Bayesian Linear Models Sudipto Banerjee 1 and Andrew O. Finley 2 1 Biostatistics, School of Public Health, University of Minnesota, Minneapolis, Minnesota, U.S.A. 2 Department of Forestry & Department

More information

Hierarchical Modeling for Univariate Spatial Data

Hierarchical Modeling for Univariate Spatial Data Hierarchical Modeling for Univariate Spatial Data Geography 890, Hierarchical Bayesian Models for Environmental Spatial Data Analysis February 15, 2011 1 Spatial Domain 2 Geography 890 Spatial Domain This

More information

Probabilistic Graphical Models

Probabilistic Graphical Models Probabilistic Graphical Models David Sontag New York University Lecture 4, February 16, 2012 David Sontag (NYU) Graphical Models Lecture 4, February 16, 2012 1 / 27 Undirected graphical models Reminder

More information

Introduction to Machine Learning CMU-10701

Introduction to Machine Learning CMU-10701 Introduction to Machine Learning CMU-10701 Markov Chain Monte Carlo Methods Barnabás Póczos & Aarti Singh Contents Markov Chain Monte Carlo Methods Goal & Motivation Sampling Rejection Importance Markov

More information

Outline. Remedial Measures) Extra Sums of Squares Standardized Version of the Multiple Regression Model

Outline. Remedial Measures) Extra Sums of Squares Standardized Version of the Multiple Regression Model Outline 1 Multiple Linear Regression (Estimation, Inference, Diagnostics and Remedial Measures) 2 Special Topics for Multiple Regression Extra Sums of Squares Standardized Version of the Multiple Regression

More information

Frailty Modeling for Spatially Correlated Survival Data, with Application to Infant Mortality in Minnesota By: Sudipto Banerjee, Mela. P.

Frailty Modeling for Spatially Correlated Survival Data, with Application to Infant Mortality in Minnesota By: Sudipto Banerjee, Mela. P. Frailty Modeling for Spatially Correlated Survival Data, with Application to Infant Mortality in Minnesota By: Sudipto Banerjee, Melanie M. Wall, Bradley P. Carlin November 24, 2014 Outlines of the talk

More information

Probabilistic Graphical Models Lecture Notes Fall 2009

Probabilistic Graphical Models Lecture Notes Fall 2009 Probabilistic Graphical Models Lecture Notes Fall 2009 October 28, 2009 Byoung-Tak Zhang School of omputer Science and Engineering & ognitive Science, Brain Science, and Bioinformatics Seoul National University

More information

3 : Representation of Undirected GM

3 : Representation of Undirected GM 10-708: Probabilistic Graphical Models 10-708, Spring 2016 3 : Representation of Undirected GM Lecturer: Eric P. Xing Scribes: Longqi Cai, Man-Chia Chang 1 MRF vs BN There are two types of graphical models:

More information

Default Priors and Effcient Posterior Computation in Bayesian

Default Priors and Effcient Posterior Computation in Bayesian Default Priors and Effcient Posterior Computation in Bayesian Factor Analysis January 16, 2010 Presented by Eric Wang, Duke University Background and Motivation A Brief Review of Parameter Expansion Literature

More information

Bayesian Linear Regression

Bayesian Linear Regression Bayesian Linear Regression Sudipto Banerjee 1 Biostatistics, School of Public Health, University of Minnesota, Minneapolis, Minnesota, U.S.A. September 15, 2010 1 Linear regression models: a Bayesian perspective

More information

Statistics 203: Introduction to Regression and Analysis of Variance Course review

Statistics 203: Introduction to Regression and Analysis of Variance Course review Statistics 203: Introduction to Regression and Analysis of Variance Course review Jonathan Taylor - p. 1/?? Today Review / overview of what we learned. - p. 2/?? General themes in regression models Specifying

More information

Markov Chain Monte Carlo (MCMC)

Markov Chain Monte Carlo (MCMC) Markov Chain Monte Carlo (MCMC Dependent Sampling Suppose we wish to sample from a density π, and we can evaluate π as a function but have no means to directly generate a sample. Rejection sampling can

More information

Bayesian Linear Models

Bayesian Linear Models Bayesian Linear Models Sudipto Banerjee 1 and Andrew O. Finley 2 1 Department of Forestry & Department of Geography, Michigan State University, Lansing Michigan, U.S.A. 2 Biostatistics, School of Public

More information

Using AMOEBA to Create a Spatial Weights Matrix and Identify Spatial Clusters, and a Comparison to Other Clustering Algorithms

Using AMOEBA to Create a Spatial Weights Matrix and Identify Spatial Clusters, and a Comparison to Other Clustering Algorithms Using AMOEBA to Create a Spatial Weights Matrix and Identify Spatial Clusters, and a Comparison to Other Clustering Algorithms Arthur Getis* and Jared Aldstadt** *San Diego State University **SDSU/UCSB

More information

Basics of Geographic Analysis in R

Basics of Geographic Analysis in R Basics of Geographic Analysis in R Spatial Autocorrelation and Spatial Weights Yuri M. Zhukov GOV 2525: Political Geography February 25, 2013 Outline 1. Introduction 2. Spatial Data and Basic Visualization

More information

Simultaneous Multi-frame MAP Super-Resolution Video Enhancement using Spatio-temporal Priors

Simultaneous Multi-frame MAP Super-Resolution Video Enhancement using Spatio-temporal Priors Simultaneous Multi-frame MAP Super-Resolution Video Enhancement using Spatio-temporal Priors Sean Borman and Robert L. Stevenson Department of Electrical Engineering, University of Notre Dame Notre Dame,

More information

Introduction to Graphical Models

Introduction to Graphical Models Introduction to Graphical Models STA 345: Multivariate Analysis Department of Statistical Science Duke University, Durham, NC, USA Robert L. Wolpert 1 Conditional Dependence Two real-valued or vector-valued

More information

Statistics & Data Sciences: First Year Prelim Exam May 2018

Statistics & Data Sciences: First Year Prelim Exam May 2018 Statistics & Data Sciences: First Year Prelim Exam May 2018 Instructions: 1. Do not turn this page until instructed to do so. 2. Start each new question on a new sheet of paper. 3. This is a closed book

More information

Lecture 4 October 18th

Lecture 4 October 18th Directed and undirected graphical models Fall 2017 Lecture 4 October 18th Lecturer: Guillaume Obozinski Scribe: In this lecture, we will assume that all random variables are discrete, to keep notations

More information

Large-scale Collaborative Prediction Using a Nonparametric Random Effects Model

Large-scale Collaborative Prediction Using a Nonparametric Random Effects Model Large-scale Collaborative Prediction Using a Nonparametric Random Effects Model Kai Yu Joint work with John Lafferty and Shenghuo Zhu NEC Laboratories America, Carnegie Mellon University First Prev Page

More information

Linear Regression. In this problem sheet, we consider the problem of linear regression with p predictors and one intercept,

Linear Regression. In this problem sheet, we consider the problem of linear regression with p predictors and one intercept, Linear Regression In this problem sheet, we consider the problem of linear regression with p predictors and one intercept, y = Xβ + ɛ, where y t = (y 1,..., y n ) is the column vector of target values,

More information

Spatio-Temporal Modelling of Credit Default Data

Spatio-Temporal Modelling of Credit Default Data 1/20 Spatio-Temporal Modelling of Credit Default Data Sathyanarayan Anand Advisor: Prof. Robert Stine The Wharton School, University of Pennsylvania April 29, 2011 2/20 Outline 1 Background 2 Conditional

More information

Spatio-Temporal Models for Areal Data

Spatio-Temporal Models for Areal Data Spatio-Temporal Models for Areal Data Juan C. Vivar (jcvivar@dme.ufrj.br) and Marco A. R. Ferreira (marco@im.ufrj.br) Departamento de Métodos Estatísticos - IM Universidade Federal do Rio de Janeiro (UFRJ)

More information

STAT 518 Intro Student Presentation

STAT 518 Intro Student Presentation STAT 518 Intro Student Presentation Wen Wei Loh April 11, 2013 Title of paper Radford M. Neal [1999] Bayesian Statistics, 6: 475-501, 1999 What the paper is about Regression and Classification Flexible

More information

Bayesian Estimation of DSGE Models 1 Chapter 3: A Crash Course in Bayesian Inference

Bayesian Estimation of DSGE Models 1 Chapter 3: A Crash Course in Bayesian Inference 1 The views expressed in this paper are those of the authors and do not necessarily reflect the views of the Federal Reserve Board of Governors or the Federal Reserve System. Bayesian Estimation of DSGE

More information

Bayesian Inference in GLMs. Frequentists typically base inferences on MLEs, asymptotic confidence

Bayesian Inference in GLMs. Frequentists typically base inferences on MLEs, asymptotic confidence Bayesian Inference in GLMs Frequentists typically base inferences on MLEs, asymptotic confidence limits, and log-likelihood ratio tests Bayesians base inferences on the posterior distribution of the unknowns

More information

Spatial Analysis of Incidence Rates: A Bayesian Approach

Spatial Analysis of Incidence Rates: A Bayesian Approach Spatial Analysis of Incidence Rates: A Bayesian Approach Silvio A. da Silva, Luiz L.M. Melo and Ricardo Ehlers July 2004 Abstract Spatial models have been used in many fields of science where the data

More information

Gibbs Sampling in Endogenous Variables Models

Gibbs Sampling in Endogenous Variables Models Gibbs Sampling in Endogenous Variables Models Econ 690 Purdue University Outline 1 Motivation 2 Identification Issues 3 Posterior Simulation #1 4 Posterior Simulation #2 Motivation In this lecture we take

More information

The Particle Filter. PD Dr. Rudolph Triebel Computer Vision Group. Machine Learning for Computer Vision

The Particle Filter. PD Dr. Rudolph Triebel Computer Vision Group. Machine Learning for Computer Vision The Particle Filter Non-parametric implementation of Bayes filter Represents the belief (posterior) random state samples. by a set of This representation is approximate. Can represent distributions that

More information

Bayesian Inference. Chapter 9. Linear models and regression

Bayesian Inference. Chapter 9. Linear models and regression Bayesian Inference Chapter 9. Linear models and regression M. Concepcion Ausin Universidad Carlos III de Madrid Master in Business Administration and Quantitative Methods Master in Mathematical Engineering

More information

Bayesian inference for multivariate skew-normal and skew-t distributions

Bayesian inference for multivariate skew-normal and skew-t distributions Bayesian inference for multivariate skew-normal and skew-t distributions Brunero Liseo Sapienza Università di Roma Banff, May 2013 Outline Joint research with Antonio Parisi (Roma Tor Vergata) 1. Inferential

More information

Minimal basis for connected Markov chain over 3 3 K contingency tables with fixed two-dimensional marginals. Satoshi AOKI and Akimichi TAKEMURA

Minimal basis for connected Markov chain over 3 3 K contingency tables with fixed two-dimensional marginals. Satoshi AOKI and Akimichi TAKEMURA Minimal basis for connected Markov chain over 3 3 K contingency tables with fixed two-dimensional marginals Satoshi AOKI and Akimichi TAKEMURA Graduate School of Information Science and Technology University

More information

Bayesian (conditionally) conjugate inference for discrete data models. Jon Forster (University of Southampton)

Bayesian (conditionally) conjugate inference for discrete data models. Jon Forster (University of Southampton) Bayesian (conditionally) conjugate inference for discrete data models Jon Forster (University of Southampton) with Mark Grigsby (Procter and Gamble?) Emily Webb (Institute of Cancer Research) Table 1:

More information

Penalized Loss functions for Bayesian Model Choice

Penalized Loss functions for Bayesian Model Choice Penalized Loss functions for Bayesian Model Choice Martyn International Agency for Research on Cancer Lyon, France 13 November 2009 The pure approach For a Bayesian purist, all uncertainty is represented

More information

A Bayesian perspective on GMM and IV

A Bayesian perspective on GMM and IV A Bayesian perspective on GMM and IV Christopher A. Sims Princeton University sims@princeton.edu November 26, 2013 What is a Bayesian perspective? A Bayesian perspective on scientific reporting views all

More information

1 Data Arrays and Decompositions

1 Data Arrays and Decompositions 1 Data Arrays and Decompositions 1.1 Variance Matrices and Eigenstructure Consider a p p positive definite and symmetric matrix V - a model parameter or a sample variance matrix. The eigenstructure is

More information

Partial factor modeling: predictor-dependent shrinkage for linear regression

Partial factor modeling: predictor-dependent shrinkage for linear regression modeling: predictor-dependent shrinkage for linear Richard Hahn, Carlos Carvalho and Sayan Mukherjee JASA 2013 Review by Esther Salazar Duke University December, 2013 Factor framework The factor framework

More information

Stat 5101 Lecture Notes

Stat 5101 Lecture Notes Stat 5101 Lecture Notes Charles J. Geyer Copyright 1998, 1999, 2000, 2001 by Charles J. Geyer May 7, 2001 ii Stat 5101 (Geyer) Course Notes Contents 1 Random Variables and Change of Variables 1 1.1 Random

More information

Notes on Markov Networks

Notes on Markov Networks Notes on Markov Networks Lili Mou moull12@sei.pku.edu.cn December, 2014 This note covers basic topics in Markov networks. We mainly talk about the formal definition, Gibbs sampling for inference, and maximum

More information

Bayesian Linear Models

Bayesian Linear Models Bayesian Linear Models Sudipto Banerjee September 03 05, 2017 Department of Biostatistics, Fielding School of Public Health, University of California, Los Angeles Linear Regression Linear regression is,

More information

Gibbs Fields & Markov Random Fields

Gibbs Fields & Markov Random Fields Statistical Techniques in Robotics (16-831, F10) Lecture#7 (Tuesday September 21) Gibbs Fields & Markov Random Fields Lecturer: Drew Bagnell Scribe: Bradford Neuman 1 1 Gibbs Fields Like a Bayes Net, a

More information

Part 8: GLMs and Hierarchical LMs and GLMs

Part 8: GLMs and Hierarchical LMs and GLMs Part 8: GLMs and Hierarchical LMs and GLMs 1 Example: Song sparrow reproductive success Arcese et al., (1992) provide data on a sample from a population of 52 female song sparrows studied over the course

More information

Some Curiosities Arising in Objective Bayesian Analysis

Some Curiosities Arising in Objective Bayesian Analysis . Some Curiosities Arising in Objective Bayesian Analysis Jim Berger Duke University Statistical and Applied Mathematical Institute Yale University May 15, 2009 1 Three vignettes related to John s work

More information

Markov random fields. The Markov property

Markov random fields. The Markov property Markov random fields The Markov property Discrete time: (X k X k!1,x k!2,... = (X k X k!1 A time symmetric version: (X k! X!k = (X k X k!1,x k+1 A more general version: Let A be a set of indices >k, B

More information

Fully Bayesian Spatial Analysis of Homicide Rates.

Fully Bayesian Spatial Analysis of Homicide Rates. Fully Bayesian Spatial Analysis of Homicide Rates. Silvio A. da Silva, Luiz L.M. Melo and Ricardo S. Ehlers Universidade Federal do Paraná, Brazil Abstract Spatial models have been used in many fields

More information

Hypothesis Testing hypothesis testing approach

Hypothesis Testing hypothesis testing approach Hypothesis Testing In this case, we d be trying to form an inference about that neighborhood: Do people there shop more often those people who are members of the larger population To ascertain this, we

More information

Spatial Analysis 2. Spatial Autocorrelation

Spatial Analysis 2. Spatial Autocorrelation Spatial Analysis 2 Spatial Autocorrelation Spatial Autocorrelation a relationship between nearby spatial units of the same variable If, for every pair of subareas i and j in the study region, the drawings

More information

Generalized Linear Models. Kurt Hornik

Generalized Linear Models. Kurt Hornik Generalized Linear Models Kurt Hornik Motivation Assuming normality, the linear model y = Xβ + e has y = β + ε, ε N(0, σ 2 ) such that y N(μ, σ 2 ), E(y ) = μ = β. Various generalizations, including general

More information

Graphical Models and Kernel Methods

Graphical Models and Kernel Methods Graphical Models and Kernel Methods Jerry Zhu Department of Computer Sciences University of Wisconsin Madison, USA MLSS June 17, 2014 1 / 123 Outline Graphical Models Probabilistic Inference Directed vs.

More information

STA 4273H: Statistical Machine Learning

STA 4273H: Statistical Machine Learning STA 4273H: Statistical Machine Learning Russ Salakhutdinov Department of Statistics! rsalakhu@utstat.toronto.edu! http://www.utstat.utoronto.ca/~rsalakhu/ Sidney Smith Hall, Room 6002 Lecture 3 Linear

More information

Spatial Regression. 6. Specification Spatial Heterogeneity. Luc Anselin.

Spatial Regression. 6. Specification Spatial Heterogeneity. Luc Anselin. Spatial Regression 6. Specification Spatial Heterogeneity Luc Anselin http://spatial.uchicago.edu 1 homogeneity and heterogeneity spatial regimes spatially varying coefficients spatial random effects 2

More information

Monte Carlo Dynamically Weighted Importance Sampling for Spatial Models with Intractable Normalizing Constants

Monte Carlo Dynamically Weighted Importance Sampling for Spatial Models with Intractable Normalizing Constants Monte Carlo Dynamically Weighted Importance Sampling for Spatial Models with Intractable Normalizing Constants Faming Liang Texas A& University Sooyoung Cheon Korea University Spatial Model Introduction

More information

Lecture 13 Fundamentals of Bayesian Inference

Lecture 13 Fundamentals of Bayesian Inference Lecture 13 Fundamentals of Bayesian Inference Dennis Sun Stats 253 August 11, 2014 Outline of Lecture 1 Bayesian Models 2 Modeling Correlations Using Bayes 3 The Universal Algorithm 4 BUGS 5 Wrapping Up

More information