Spatial modelling etc

Size: px
Start display at page:

Download "Spatial modelling etc"

Transcription

1 Spatial modelling etc David L Miller & Mark V Bravington International Whaling Commission Scientific Committee 2017

2 Why are we here/why did we do this? Stratified Horvitz-Thompson is workhorse of many abundance estimates How is H-T going to fail? When do we need to use spatial models? What are Bad surveys? Report

3 Overview Today: 1. what's wrong with H-T? 2. Spatial models overview 3. What can go wrong with spatial models? 4. Testing designs in R 5. Model checking for spatial models Tomorrow: 1. What we missed, what is hard 2. Try out tester on your data 3. Other methods/software, future work 4. Guidelines

4 Practicalities Try not to talk for more than an hour without a break We both have funny accents, yell if you don't understand! There is maths don't worry

5 This is not a distance sampling course! This material usually takes 4 days+ to teach This will not prepare you to analyse spatial data BUT you can do this in St Andrews this summer! creem2.st-andrews.ac.uk

6 Why are we interested in spatially-explicit estimation?

7 Inferential aims

8 Part I

9 Horvitz-Thompson estimation: the good, the bad and the ugly

10 Horvitz-Thompson-like estimators Rescale the (flat) density and extrapolate N = study area n covered area i=1 s i p i s i p i are group/cluster sizes is the detection probability (from distance sampling)

11 Variance of H-T Multiple sources of randomness in H-T equation: p i - detectability n s - dealt with as, encounter rate - group size n/l

12 Hidden in this formula is a simple assumption Probability of sampling every point in the study area is equal Is this true? Sometimes. If (and only if) the design is randomised

13 Many faces of randomisation

14 What does this randomisation give us? Coverage probability H-T estimator assumes even coverage (or you can estimate) Otherwise not really valid

15 Estimating coverage We can estimate coverage of a non-uniform design! In Distance! Example from BC, Canada in this paper:

16 Estimating coverage

17 A complex survey plan Thomas, Williams and Sandilands (2007) Different areas require different strategies Zig-zags, parallel lines, census Analysis in Distance

18 Sideline: alternative terminology A design is an algorithm for laying down samplers in the survey area A realization (from that algorithm) is called a survey plan Len Thomas 2004)

19 H-T estimation again Can't estimate w/ H-T w/o coverage Fixed designs violate assumptions Some animals have P(included) = 0 Deteriorate pooling robustness property What can we do?

20 More on variance Encounter rate variance n j / l j n/l Within-transect variation can be bad e.g., N-S transect, N-S density gradient

21 Stratification If we suspect density change can stratify! Pre or post hoc (spatial and non-spatial)

22 I am going to stop talking very soon

23 Summary H-T is a spatial model (sort of) Violated an assumption if no randomness Hard to assess how bad this is Fewster et al (2009) and Fewster (2011) give variance approaches

24 Part II

25 Spatial models

26 Spatial models of distance sampling data Collect spatially referenced data Why not make spatially-explicit models? Go beyond stratified estimates Relate environmental covariates to counts

27 This is the rosy picture talk

28 We'll talk about the grim reality later

29 Example data in this talk

30 Sperm whales off the US east coast Hang out near canyons, eat squid Surveys in 2004, US east coast Combination of data from 2 NOAA cruises Thanks to Debi Palka, Lance Garrison for data. Jason Roberts for data prep.

31 Example data

32 Model formulation Pure spatial, pure environmental, mixed? May have some prior knowledge Biology/ecology What are drivers of distribution? Inferential aim Abundance Ecology

33 Density surface models Hedley and Buckland (2004) Miller et al. (2013)

34 Ignoring group size (more on that tomorrow)

35 Physeter catodon by Noah Schlottman

36 How do we model that?

37 SPOILER ALERT: your model is probably just a very fancy GLM

38 Generalised additive models (in 1 slide) Taking the previous example ( n j ) = A j p j exp β 0 + s ( ) [ k z kj ] k n j area of segment some count distribution probability of detection in segment (inverse) link function model terms

39 What about those s thingys?

40 Covariates space, time, environmental (remotely sensed?) data

41

42 Modelling smooths 1-dimension: not much difference 2D more tricky edge effects tricky boundaries more tomorrow Now going to do some maths (ignore at will)

43 How do we build them? Functions made of other, simpler functions Basis functions, b k Estimate β k s(x) = (x) K k=1 β kb k

44 Straight lines vs. interpolation Want a line that is close to all the data Don't want interpolation we know there is error Balance between interpolation and generality

45 How wiggly is a function?

46 Making wigglyness matter Fit needs to be penalised Something like: 2 2 s(x) x 2 R ( ) dx β T Sβ (Can always re-write this in the form ) Estimate the β k terms but penalise objective closeness to data + penalty (REML/ML)

47 Smoothing parameter

48 Sideline: GAMs are Bayesian models Generally: penalties are improper prior precision matrices (nullspace gives improper priors) Using shrinkage smoothers: proper priors empirical Bayes interpretation

49 Beyond univariate smooths? Can build (anisotropic) tensor product terms Take 2 or more univariate terms Thin plate regression splines allow multivariate terms (isotropic)

50 Spatial smoothing Can just smooth in space Valid abundance estimation technique Useful for EDA for env. cov. models (hard day 2!) Not good for extrapolations Basis choice can matter!

51 Why GAMs are cool... Fancy smooths (cyclic, boundaries, ) Fancy responses (exp family and beyond!) Random effects (by equivalence) Markov random fields Correlation structures See Wood (2006/2017) for a handy intro

52 Let's fit a model library(dsm) # environmental covariates dsm_env_tw <- dsm(count~s(depth) + s(npp) + s(sst), ddf.obj=df_hr, segment.data=segs, observation.data=obs, family=tw()) # space dsm_xy_tw <- dsm(count~s(x, y), ddf.obj=df_hr, segment.data=segs, observation.data=obs, family=tw()) dsm is based on mgcv by Simon Wood

53 Simple! Done?

54 NO

55 More on model checking later...

56 Predictions/abundance estimates Grid of covariates must be available Predict within survey area Extrapolate outside (with caution) Working on a grid of cells Plot is s(x,y) + s(depth) Add up to get abundance

57 Estimating variance Uncertainty from: detection function parameters spatial model Need to propagate uncertainty! Methods in dsm Bravington, Hedley & Miller (in prep)

58 Plotting uncertainty Maps of coefficient of variation CV for given stratum (better) Visualisation is hard

59 Communicating uncertainty Are animations a good way to do this? Simulate from posterior parameter distribution β N( β, Σ ) Some features (e.g. shelf, N-S gradient) stick out

60 I am going to stop talking very soon

61 Summary Build models in stages (detection function + GAM) Counts are functions of covariates Pure spatial models Environmental covariate models Mix?! Fit/check using dsm Most of the theory is resolved, applications are hard

62 Part III

63 H-T or spatial or give up?

64 Spatial models can help Spatial modelling can give ubiased abundance ests even with uneven coverage limits to extrapolation V. even coverage => HT? Evenness subtle, detectability effect e.g., weather bad in east

65 Weather or distribution? Weather has a big effect on detectability Need to record during survey Disambiguate between distribution/detectability Potential confounding can be BAD

66 Visibility during POWER 2014 Thanks to Hiroto Murase and co for this data!

67 Covariates can make a big difference!

68 Other stuff

69 Spatial modelling won't solve all yr problems Design issues Ludicrous extrapolation Survey plan not robust to weather issues Non-uniform distribution wrt sampler Migration Spatial models alone can't solve these issues

70 Spatial modelling won't solve all yr problems Violations of survey procedure Following animals Responsive movement Guarding the trackline Group size estimation Spatial models alone can't solve these issues

71 Spatial modelling won't solve all yr problems Detection functions Not enough observations Uncertain species ID Group size Spatial models alone can't solve these issues

72 @kitabet

73 Should everything be spatial? Do you have enough observations? If they do look good (even coverage, etc) Is it worth re-analysing from H-T? Point estimates similar? Variance may well be different?

74 I am going to stop talking very soon

75 Summary Spatial models don't solve all problems Complex models can lead to complex issues Recording weather conditions is important You can always give up!

76 Part IV

77 Testing designs

78 What can we do? Take a survey and simulate Is H-T robust? How do different spatial models compare? Only thinking about total abundance & CV

79 Software ltdesigntester github.com/dill/ltdesigntester (based on DSsim by Laura Marshall, CREEM) Setup simulations, test what can be done Most of the work needs to be done in GIS Survey shapefiles, covariates etc Import to R, runs models, shows output

80 Setting up a survey simulation

81 Density Grid in polygon of study area Either specify simple gradient or use other tools to make complex density Density as grid

82 Design Generate using GIS/Distance Export to shapefile

83 Detection function Functional form (halfnormal, hazard-rate) Parameters (scale, shape) Truncation (Covariates via multiple functions, more later)

84 Specification to simulation Generate multiple realizations Analyse each with a many models Different spatial, H-T Compare results

85 Test models Spatial smoothers thin plate spline, bs="tp" (Wood, 2003) thin plate spline with shrinkage, bs="ts" (Marra et al., 2011) Duchon spline, bs="ds", m=c(1, 0.5) (Miller et al., 2014) tensor of thin plate spline (w/ and w/o rotated covariates) Stratified estimates Horvitz-Thompson (w/ and w/o covariates) stratified Horvitz-Thompson (w/ and w/o covariates)

86 Comparing performance

87 Important caveats No model checking Dependent on good detection specs No group size model No g(0) or availability

88 Quick example code library(ltdesigntester) # setup a simulation my_sim <- build_sim(design_path="path/to/shp", dsurf=density_surface_matrix, n_grid_x=dsurf_dim_x, n_grid_y=dsurf_dim_y, n_pop=true_n, df=detection_function_specs, region="path/to/shp") # run it! res <- do_sim(nsim=number_of_sims, scenario=my_sim, pred_dat=prediction_data_frame,...)

89 We made a big deal about weather earlier... We can add covariates too (a wee bit unwieldy at the moment) Build multiple detection functions/sims in list() Covariates vary according to: logit function E-W (can set pars, 2 state) set values in segment data (already observed)

90 I am going to stop talking very soon

91 Summary We can test multiple (simple) scenarios Assumption of simple gradients Models likely won't work for difficult stuff if they don't work for simple things What will work/what won't Simple summary plots Better than the rest good

92 Part V

93 Model checking for DSMs

94 Model checking Count distribution Basis complexity Model (term) selection Sensitivity Observed vs. expected Cross-validation (replicability)

95 (Plus all the usual stuff for detection functions!)

96 Count distributions Response is a count Often, it's mostly zero Aggregations occur at scales smaller than spatial model Want response distribution that deals with that Could mess-up variance if ignored Linked to segmenting Flexible mean-variance relationship

97 Negative binomial Var (count) = (count) + κ(count) 2 Estimate κ Is quadratic relationship a strong assumption? Similar to Poisson: Var (count) = (count)

98 Tweedie distribution Var (count) = ϕ(count) q Common distributions are sub-cases: q = 1 q = 2 q = 3 Gaussian Poisson Gamma inverse- We are interested in 1 < q < 2 (here q = 1.2, 1.3,, 1.9 )

99 Basis complexity Before: s(x) = (x) K k=1 β kb k How big should k be? Big enough Penalty takes care of the rest?gam.check gives useful output (also residual checks etc)

100 gam.check text output gam.check(dsm_env_tw) Method: REML Optimizer: outer newton full convergence after 8 iterations. Gradient range [ e-08, e-08] (score & scale ). Hessian positive definite, eigenvalue range [ , ]. Model rank = 28 / 28 Basis dimension (k) checking results. Low p-value (k-index<1) may indicate that k is too low, especially if edf is close to k'. k' edf k-index p-value s(depth) s(npp) s(sst)

101 Tobler's first law of geography Everything is related to everything else, but near things are more related than distant things Tobler (1970)

102 Implications of Tobler's law

103 What can we do about this? Careful inclusion of terms Test for sensitivity (lots of models) Fit models using robust criteria (REML) Test for concurvity (mgcv::concurvity, dsm::vis.concurvity)

104 Term selection p (approximate) values (Marra & Wood, 2012) path dependence issues shrinkage methods (Marra & Wood, 2011) ecological-level term selection which biomass measure? include spatial smooth or not?

105 Observed vs. expected Diagnostic compare observed vs. expected counts Compare for different covariate/aggregations In next dsm, obs_exp() does this Going back to those rough POWER models > obs_exp(b, "beaufort") Observed Expected > obs_exp(b_nc, "beaufort") Observed Expected

106 Cross-validation How well does the model reproduce what we saw? Leave out one area, re-fit model, predict to new data Wenger & Olden (2012) have good spatial examples

107 Cross-validation example

108 Cross-validation example

109 I am going to stop talking very soon

110 2 (or more)-stage models Not cool (statistically), but Multi-stage models are handy! Understand and check each part Split your modelling efforts amongst people

111 Conclusions This methodology is general Bears, birds, beer cans, Loch Ness monsters Models are flexible! Linear things, smooth things, random effect things (and more) If you know GLMs, you can get started with DSMs Mature theoretical basis, still lots to do Active user community, active software development

112 Resources distancesampling.org/r/ distancesampling.org/workshops/duke-spatial-2015/

113 Thanks! Slides w/ references available at converged.yt

114 References Fewster, R.M., Buckland, S.T., Burnham, K.P., Borchers, D.L., Jupp, P.E., Laake, J.L., et al. (2009) Estimating the Encounter Rate Variance in Distance Sampling. Biometrics, 65, Fewster, R. M. (2011), Variance Estimation for Systematic Designs in Spatial Surveys. Biometrics, 67: Hedley, S. L., & Buckland, S. T. (2004). Spatial models for line transect sampling. Journal of Agricultural, Biological, and Environmental Statistics, 9(2). Marques, T. A., Thomas, L., Fancy, S. G., & Buckland, S. T. (2007). Improving estimates of bird density using multiple-covariate distance sampling. The Auk, 124(4). Marra, G., & Wood, S. N. (2011). Practical variable selection for generalized additive models. Computational Statistics and Data Analysis, 55(7). Marra, G., & Wood, S. N. (2012). Coverage Properties of Confidence Intervals for Generalized Additive Model Components. Scandinavian Journal of Statistics, 39(1). Wenger, S.J. and Olden, J.D. (2012) Assessing transferability of ecological models: an underappreciated aspect of statistical validation. Methods in Ecology and Evolution, 3,

115 Handy awkward question answers

116 Don't throw away your residuals!

117 gam.check

118 rqgam.check (Dunn and Smyth, 1996)

119 Penalty matrix For each b k calculate the penalty Penalty is a function of λ β T Sβ β S calculated once smoothing parameter ( ) dictates influence λ

120 How wiggly are things? We can set basis complexity or size ( ) Maximum wigglyness Smooths have effective degrees of freedom (EDF) k EDF < k Set k large enough

121 Let's talk about detectability

122 Detectability

123 Distance sampling Fit to the histogram Model: P [animal detected animal at distance y] = g(y; θ) Calculate the average probability of detection: w 1 p = g(y; θ )dy w 0

124 Distance sampling (extensions) Covariates that affect detectability (Marques et al, 2007) g(0) < 1 Perception bias ( ) (Burt et al, 2014) Availability bias (Borchers et al, 2013) Detection function formulations (Miller and Thomas, 2015) Measurement error (Marques, 2004)

125 That's not really how the ocean works...

126 Availability

127 We can only see whales at the surface What proportion of the time are they there? Acoustics Tags (DTAGs etc) Behavioural studies p Fixed correction to? Model via fancy Markov models (Borchers et al, 2013) Picture from University of St Andrews Library Special Collections

Generalized Additive Models

Generalized Additive Models Generalized Additive Models Overview What is a GAM? What is smoothing? How do GAMs work? Fitting GAMs using dsm What is a GAM? "gam" 1. Collective noun used to refer to a group of whales, or rarely also

More information

Model checking overview. Checking & Selecting GAMs. Residual checking. Distribution checking

Model checking overview. Checking & Selecting GAMs. Residual checking. Distribution checking Model checking overview Checking & Selecting GAMs Simon Wood Mathematical Sciences, University of Bath, U.K. Since a GAM is just a penalized GLM, residual plots should be checked exactly as for a GLM.

More information

Non-uniform coverage estimators for distance sampling

Non-uniform coverage estimators for distance sampling Abstract Non-uniform coverage estimators for distance sampling CREEM Technical report 2007-01 Eric Rexstad Centre for Research into Ecological and Environmental Modelling Research Unit for Wildlife Population

More information

Automated Survey Design

Automated Survey Design Automated Survey Design Aim: Use geographic information system (GIS) within Distance to aid survey design and evaluate the properties of different designs See: Chapter 7 of Buckland et al. (2004) Advanced

More information

An Introduction to GAMs based on penalized regression splines. Simon Wood Mathematical Sciences, University of Bath, U.K.

An Introduction to GAMs based on penalized regression splines. Simon Wood Mathematical Sciences, University of Bath, U.K. An Introduction to GAMs based on penalied regression splines Simon Wood Mathematical Sciences, University of Bath, U.K. Generalied Additive Models (GAM) A GAM has a form something like: g{e(y i )} = η

More information

ATLANTIC-WIDE RESEARCH PROGRAMME ON BLUEFIN TUNA (ICCAT GBYP PHASE ) ELABORATION OF DATA FROM THE AERIAL SURVEYS ON SPAWNING AGGREGATIONS

ATLANTIC-WIDE RESEARCH PROGRAMME ON BLUEFIN TUNA (ICCAT GBYP PHASE ) ELABORATION OF DATA FROM THE AERIAL SURVEYS ON SPAWNING AGGREGATIONS ATLANTIC-WIDE RESEARCH PROGRAMME ON BLUEFIN TUNA (ICCAT GBYP PHASE 7-2017) ELABORATION OF DATA FROM THE AERIAL SURVEYS ON SPAWNING AGGREGATIONS Report 18 July 2017 Ana Cañadas & José Antonio Vázquez Alnilam

More information

Physics 509: Bootstrap and Robust Parameter Estimation

Physics 509: Bootstrap and Robust Parameter Estimation Physics 509: Bootstrap and Robust Parameter Estimation Scott Oser Lecture #20 Physics 509 1 Nonparametric parameter estimation Question: what error estimate should you assign to the slope and intercept

More information

Checking, Selecting & Predicting with GAMs. Simon Wood Mathematical Sciences, University of Bath, U.K.

Checking, Selecting & Predicting with GAMs. Simon Wood Mathematical Sciences, University of Bath, U.K. Checking, Selecting & Predicting with GAMs Simon Wood Mathematical Sciences, University of Bath, U.K. Model checking Since a GAM is just a penalized GLM, residual plots should be checked, exactly as for

More information

Univariate Normal Distribution; GLM with the Univariate Normal; Least Squares Estimation

Univariate Normal Distribution; GLM with the Univariate Normal; Least Squares Estimation Univariate Normal Distribution; GLM with the Univariate Normal; Least Squares Estimation PRE 905: Multivariate Analysis Spring 2014 Lecture 4 Today s Class The building blocks: The basics of mathematical

More information

Physics 509: Error Propagation, and the Meaning of Error Bars. Scott Oser Lecture #10

Physics 509: Error Propagation, and the Meaning of Error Bars. Scott Oser Lecture #10 Physics 509: Error Propagation, and the Meaning of Error Bars Scott Oser Lecture #10 1 What is an error bar? Someone hands you a plot like this. What do the error bars indicate? Answer: you can never be

More information

POLI 8501 Introduction to Maximum Likelihood Estimation

POLI 8501 Introduction to Maximum Likelihood Estimation POLI 8501 Introduction to Maximum Likelihood Estimation Maximum Likelihood Intuition Consider a model that looks like this: Y i N(µ, σ 2 ) So: E(Y ) = µ V ar(y ) = σ 2 Suppose you have some data on Y,

More information

Inversion Base Height. Daggot Pressure Gradient Visibility (miles)

Inversion Base Height. Daggot Pressure Gradient Visibility (miles) Stanford University June 2, 1998 Bayesian Backtting: 1 Bayesian Backtting Trevor Hastie Stanford University Rob Tibshirani University of Toronto Email: trevor@stat.stanford.edu Ftp: stat.stanford.edu:

More information

Model-Based Distance Sampling

Model-Based Distance Sampling Model-Based Distance Sampling S. T. Buckland,C.S.Oedekoven, and D. L. Borchers Conventional distance sampling adopts a mixed approach, using model-based methods for the detection process, and design-based

More information

Chapter 1 Statistical Inference

Chapter 1 Statistical Inference Chapter 1 Statistical Inference causal inference To infer causality, you need a randomized experiment (or a huge observational study and lots of outside information). inference to populations Generalizations

More information

The Ecology and Acoustic Behavior of Minke Whales in the Hawaiian and Pacific Islands

The Ecology and Acoustic Behavior of Minke Whales in the Hawaiian and Pacific Islands DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. The Ecology and Acoustic Behavior of Minke Whales in the Hawaiian and Pacific Islands Vincent Janik 1, Len Thomas 2 University

More information

review session gov 2000 gov 2000 () review session 1 / 38

review session gov 2000 gov 2000 () review session 1 / 38 review session gov 2000 gov 2000 () review session 1 / 38 Overview Random Variables and Probability Univariate Statistics Bivariate Statistics Multivariate Statistics Causal Inference gov 2000 () review

More information

mgcv: GAMs in R Simon Wood Mathematical Sciences, University of Bath, U.K.

mgcv: GAMs in R Simon Wood Mathematical Sciences, University of Bath, U.K. mgcv: GAMs in R Simon Wood Mathematical Sciences, University of Bath, U.K. mgcv, gamm4 mgcv is a package supplied with R for generalized additive modelling, including generalized additive mixed models.

More information

Stat 587: Key points and formulae Week 15

Stat 587: Key points and formulae Week 15 Odds ratios to compare two proportions: Difference, p 1 p 2, has issues when applied to many populations Vit. C: P[cold Placebo] = 0.82, P[cold Vit. C] = 0.74, Estimated diff. is 8% What if a year or place

More information

Biostatistics and Design of Experiments Prof. Mukesh Doble Department of Biotechnology Indian Institute of Technology, Madras

Biostatistics and Design of Experiments Prof. Mukesh Doble Department of Biotechnology Indian Institute of Technology, Madras Biostatistics and Design of Experiments Prof. Mukesh Doble Department of Biotechnology Indian Institute of Technology, Madras Lecture - 39 Regression Analysis Hello and welcome to the course on Biostatistics

More information

Practical Statistics for the Analytical Scientist Table of Contents

Practical Statistics for the Analytical Scientist Table of Contents Practical Statistics for the Analytical Scientist Table of Contents Chapter 1 Introduction - Choosing the Correct Statistics 1.1 Introduction 1.2 Choosing the Right Statistical Procedures 1.2.1 Planning

More information

Alex Zerbini. National Marine Mammal Laboratory Alaska Fisheries Science Center, NOAA Fisheries

Alex Zerbini. National Marine Mammal Laboratory Alaska Fisheries Science Center, NOAA Fisheries Alex Zerbini National Marine Mammal Laboratory Alaska Fisheries Science Center, NOAA Fisheries Introduction Abundance Estimation Methods (Line Transect Sampling) Survey Design Data collection Why do we

More information

Multiple covariate distance sampling (MCDS)

Multiple covariate distance sampling (MCDS) Multiple covariate distance sampling (MCDS) Aim: Model the effect of additional covariates on detection probability, in addition to distance, while assuming probability of detection at zero distance is

More information

Statistical Distribution Assumptions of General Linear Models

Statistical Distribution Assumptions of General Linear Models Statistical Distribution Assumptions of General Linear Models Applied Multilevel Models for Cross Sectional Data Lecture 4 ICPSR Summer Workshop University of Colorado Boulder Lecture 4: Statistical Distributions

More information

Generalized Linear. Mixed Models. Methods and Applications. Modern Concepts, Walter W. Stroup. Texts in Statistical Science.

Generalized Linear. Mixed Models. Methods and Applications. Modern Concepts, Walter W. Stroup. Texts in Statistical Science. Texts in Statistical Science Generalized Linear Mixed Models Modern Concepts, Methods and Applications Walter W. Stroup CRC Press Taylor & Francis Croup Boca Raton London New York CRC Press is an imprint

More information

Lecture 9 SLR in Matrix Form

Lecture 9 SLR in Matrix Form Lecture 9 SLR in Matrix Form STAT 51 Spring 011 Background Reading KNNL: Chapter 5 9-1 Topic Overview Matrix Equations for SLR Don t focus so much on the matrix arithmetic as on the form of the equations.

More information

Multilevel Models in Matrix Form. Lecture 7 July 27, 2011 Advanced Multivariate Statistical Methods ICPSR Summer Session #2

Multilevel Models in Matrix Form. Lecture 7 July 27, 2011 Advanced Multivariate Statistical Methods ICPSR Summer Session #2 Multilevel Models in Matrix Form Lecture 7 July 27, 2011 Advanced Multivariate Statistical Methods ICPSR Summer Session #2 Today s Lecture Linear models from a matrix perspective An example of how to do

More information

Introduction to Bayesian Statistics and Markov Chain Monte Carlo Estimation. EPSY 905: Multivariate Analysis Spring 2016 Lecture #10: April 6, 2016

Introduction to Bayesian Statistics and Markov Chain Monte Carlo Estimation. EPSY 905: Multivariate Analysis Spring 2016 Lecture #10: April 6, 2016 Introduction to Bayesian Statistics and Markov Chain Monte Carlo Estimation EPSY 905: Multivariate Analysis Spring 2016 Lecture #10: April 6, 2016 EPSY 905: Intro to Bayesian and MCMC Today s Class An

More information

Statistics for Data Analysis. Niklaus Berger. PSI Practical Course Physics Institute, University of Heidelberg

Statistics for Data Analysis. Niklaus Berger. PSI Practical Course Physics Institute, University of Heidelberg Statistics for Data Analysis PSI Practical Course 2014 Niklaus Berger Physics Institute, University of Heidelberg Overview You are going to perform a data analysis: Compare measured distributions to theoretical

More information

A short introduction to INLA and R-INLA

A short introduction to INLA and R-INLA A short introduction to INLA and R-INLA Integrated Nested Laplace Approximation Thomas Opitz, BioSP, INRA Avignon Workshop: Theory and practice of INLA and SPDE November 7, 2018 2/21 Plan for this talk

More information

Gradient types. Gradient Analysis. Gradient Gradient. Community Community. Gradients and landscape. Species responses

Gradient types. Gradient Analysis. Gradient Gradient. Community Community. Gradients and landscape. Species responses Vegetation Analysis Gradient Analysis Slide 18 Vegetation Analysis Gradient Analysis Slide 19 Gradient Analysis Relation of species and environmental variables or gradients. Gradient Gradient Individualistic

More information

Nonparametric Bayesian Methods - Lecture I

Nonparametric Bayesian Methods - Lecture I Nonparametric Bayesian Methods - Lecture I Harry van Zanten Korteweg-de Vries Institute for Mathematics CRiSM Masterclass, April 4-6, 2016 Overview of the lectures I Intro to nonparametric Bayesian statistics

More information

MITOCW ocw-18_02-f07-lec17_220k

MITOCW ocw-18_02-f07-lec17_220k MITOCW ocw-18_02-f07-lec17_220k The following content is provided under a Creative Commons license. Your support will help MIT OpenCourseWare continue to offer high quality educational resources for free.

More information

ENGRG Introduction to GIS

ENGRG Introduction to GIS ENGRG 59910 Introduction to GIS Michael Piasecki October 13, 2017 Lecture 06: Spatial Analysis Outline Today Concepts What is spatial interpolation Why is necessary Sample of interpolation (size and pattern)

More information

CMSC858P Supervised Learning Methods

CMSC858P Supervised Learning Methods CMSC858P Supervised Learning Methods Hector Corrada Bravo March, 2010 Introduction Today we discuss the classification setting in detail. Our setting is that we observe for each subject i a set of p predictors

More information

CREEM. Centre for Research into Ecological and Environmental Modelling. University of St Andrews INTERNATIONAL WORKSHOPS

CREEM. Centre for Research into Ecological and Environmental Modelling. University of St Andrews INTERNATIONAL WORKSHOPS CREEM Centre for Research into Ecological and Environmental Modelling University of St Andrews INTERNATIONAL WORKSHOPS Advanced Techniques and Recent Developments in Distance Sampling St Andrews 25 th

More information

LINE TRANSECT SAMPLING FROM A CURVING PATH

LINE TRANSECT SAMPLING FROM A CURVING PATH LINE TRANSECT SAMPLING FROM A CURVING PATH LEX HIBY Conservation Research Ltd., 110 Hinton Way, Great Shelford, Cambridge, England email: hiby@ntlworld.com and M. B. KRISHNA Wildlife Conservation Society

More information

Experimental Design and Data Analysis for Biologists

Experimental Design and Data Analysis for Biologists Experimental Design and Data Analysis for Biologists Gerry P. Quinn Monash University Michael J. Keough University of Melbourne CAMBRIDGE UNIVERSITY PRESS Contents Preface page xv I I Introduction 1 1.1

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

Cheap DECAF: Density Estimation for Cetaceans from Acoustic Fixed Sensors Using Separate, Non-Linked Devices

Cheap DECAF: Density Estimation for Cetaceans from Acoustic Fixed Sensors Using Separate, Non-Linked Devices DISTRIBUTION STATEMENT A. Approved for public release; distribution is unlimited. Cheap DECAF: Density Estimation for Cetaceans from Acoustic Fixed Sensors Using Separate, Non-Linked Devices David K. Mellinger

More information

Designing line transect surveys for complex survey regions

Designing line transect surveys for complex survey regions J. CETACEAN RES. MANAGE. 9(1):1 13, 2007 1 Designing line transect surveys for complex survey regions LEN THOMAS *, ROB WILLIAMS +# AND DOUG SANDILANDS ++ Contact e-mail: len@mcs.st-and.ac.uk ABSTRACT

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

Concepts and Applications of Kriging. Eric Krause

Concepts and Applications of Kriging. Eric Krause Concepts and Applications of Kriging Eric Krause Sessions of note Tuesday ArcGIS Geostatistical Analyst - An Introduction 8:30-9:45 Room 14 A Concepts and Applications of Kriging 10:15-11:30 Room 15 A

More information

Design and Analysis of Line Transect Surveys for Primates

Design and Analysis of Line Transect Surveys for Primates 1 Design and Analysis of Line Transect Surveys for Primates 2 3 Stephen T. Buckland Andrew J. Plumptre Len Thomas Eric A. Rexstad 4 5 6 7 8 9 10 11 S. T. Buckland (steve@mcs.st-and.ac.uk) S. T. Buckland

More information

Proteomics and Variable Selection

Proteomics and Variable Selection Proteomics and Variable Selection p. 1/55 Proteomics and Variable Selection Alex Lewin With thanks to Paul Kirk for some graphs Department of Epidemiology and Biostatistics, School of Public Health, Imperial

More information

Chapter 3: Maximum-Likelihood & Bayesian Parameter Estimation (part 1)

Chapter 3: Maximum-Likelihood & Bayesian Parameter Estimation (part 1) HW 1 due today Parameter Estimation Biometrics CSE 190 Lecture 7 Today s lecture was on the blackboard. These slides are an alternative presentation of the material. CSE190, Winter10 CSE190, Winter10 Chapter

More information

Generalized Additive Models (GAMs)

Generalized Additive Models (GAMs) Generalized Additive Models (GAMs) Israel Borokini Advanced Analysis Methods in Natural Resources and Environmental Science (NRES 746) October 3, 2016 Outline Quick refresher on linear regression Generalized

More information

Types of spatial data. The Nature of Geographic Data. Types of spatial data. Spatial Autocorrelation. Continuous spatial data: geostatistics

Types of spatial data. The Nature of Geographic Data. Types of spatial data. Spatial Autocorrelation. Continuous spatial data: geostatistics The Nature of Geographic Data Types of spatial data Continuous spatial data: geostatistics Samples may be taken at intervals, but the spatial process is continuous e.g. soil quality Discrete data Irregular:

More information

Regularizing inverse problems. Damping and smoothing and choosing...

Regularizing inverse problems. Damping and smoothing and choosing... Regularizing inverse problems Damping and smoothing and choosing... 141 Regularization The idea behind SVD is to limit the degree of freedom in the model and fit the data to an acceptable level. Retain

More information

Statistics and Data Analysis

Statistics and Data Analysis Statistics and Data Analysis The Crash Course Physics 226, Fall 2013 "There are three kinds of lies: lies, damned lies, and statistics. Mark Twain, allegedly after Benjamin Disraeli Statistics and Data

More information

Supplementary File 3: Tutorial for ASReml-R. Tutorial 1 (ASReml-R) - Estimating the heritability of birth weight

Supplementary File 3: Tutorial for ASReml-R. Tutorial 1 (ASReml-R) - Estimating the heritability of birth weight Supplementary File 3: Tutorial for ASReml-R Tutorial 1 (ASReml-R) - Estimating the heritability of birth weight This tutorial will demonstrate how to run a univariate animal model using the software ASReml

More information

Generalized Linear Models for Non-Normal Data

Generalized Linear Models for Non-Normal Data Generalized Linear Models for Non-Normal Data Today s Class: 3 parts of a generalized model Models for binary outcomes Complications for generalized multivariate or multilevel models SPLH 861: Lecture

More information

Basis Penalty Smoothers. Simon Wood Mathematical Sciences, University of Bath, U.K.

Basis Penalty Smoothers. Simon Wood Mathematical Sciences, University of Bath, U.K. Basis Penalty Smoothers Simon Wood Mathematical Sciences, University of Bath, U.K. Estimating functions It is sometimes useful to estimate smooth functions from data, without being too precise about the

More information

Kneib, Fahrmeir: Supplement to "Structured additive regression for categorical space-time data: A mixed model approach"

Kneib, Fahrmeir: Supplement to Structured additive regression for categorical space-time data: A mixed model approach Kneib, Fahrmeir: Supplement to "Structured additive regression for categorical space-time data: A mixed model approach" Sonderforschungsbereich 386, Paper 43 (25) Online unter: http://epub.ub.uni-muenchen.de/

More information

MITOCW ocw f99-lec05_300k

MITOCW ocw f99-lec05_300k MITOCW ocw-18.06-f99-lec05_300k This is lecture five in linear algebra. And, it will complete this chapter of the book. So the last section of this chapter is two point seven that talks about permutations,

More information

On dealing with spatially correlated residuals in remote sensing and GIS

On dealing with spatially correlated residuals in remote sensing and GIS On dealing with spatially correlated residuals in remote sensing and GIS Nicholas A. S. Hamm 1, Peter M. Atkinson and Edward J. Milton 3 School of Geography University of Southampton Southampton SO17 3AT

More information

LECTURE NOTES FYS 4550/FYS EXPERIMENTAL HIGH ENERGY PHYSICS AUTUMN 2013 PART I A. STRANDLIE GJØVIK UNIVERSITY COLLEGE AND UNIVERSITY OF OSLO

LECTURE NOTES FYS 4550/FYS EXPERIMENTAL HIGH ENERGY PHYSICS AUTUMN 2013 PART I A. STRANDLIE GJØVIK UNIVERSITY COLLEGE AND UNIVERSITY OF OSLO LECTURE NOTES FYS 4550/FYS9550 - EXPERIMENTAL HIGH ENERGY PHYSICS AUTUMN 2013 PART I PROBABILITY AND STATISTICS A. STRANDLIE GJØVIK UNIVERSITY COLLEGE AND UNIVERSITY OF OSLO Before embarking on the concept

More information

Preface Introduction to Statistics and Data Analysis Overview: Statistical Inference, Samples, Populations, and Experimental Design The Role of

Preface Introduction to Statistics and Data Analysis Overview: Statistical Inference, Samples, Populations, and Experimental Design The Role of Preface Introduction to Statistics and Data Analysis Overview: Statistical Inference, Samples, Populations, and Experimental Design The Role of Probability Sampling Procedures Collection of Data Measures

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

Spatial analysis of a designed experiment. Uniformity trials. Blocking

Spatial analysis of a designed experiment. Uniformity trials. Blocking Spatial analysis of a designed experiment RA Fisher s 3 principles of experimental design randomization unbiased estimate of treatment effect replication unbiased estimate of error variance blocking =

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

The effect of line-transect placement in a coastal distance sampling survey

The effect of line-transect placement in a coastal distance sampling survey J. CETACEAN RES. MANAGE. 8(1):79 85, 2006 79 The effect of line-transect placement in a coastal distance sampling survey SAM DU FRESNE *, DAVID FLETCHER + AND STEVE DAWSON * Contact e-mail: sdufresne@clear.net.nz

More information

Four aspects of a sampling strategy necessary to make accurate and precise inferences about populations are:

Four aspects of a sampling strategy necessary to make accurate and precise inferences about populations are: Why Sample? Often researchers are interested in answering questions about a particular population. They might be interested in the density, species richness, or specific life history parameters such as

More information

MITOCW MIT18_01SCF10Rec_24_300k

MITOCW MIT18_01SCF10Rec_24_300k MITOCW MIT18_01SCF10Rec_24_300k JOEL LEWIS: Hi. Welcome back to recitation. In lecture, you've been doing related rates problems. I've got another example for you, here. So this one's a really tricky one.

More information

An Introduction to Multilevel Models. PSYC 943 (930): Fundamentals of Multivariate Modeling Lecture 25: December 7, 2012

An Introduction to Multilevel Models. PSYC 943 (930): Fundamentals of Multivariate Modeling Lecture 25: December 7, 2012 An Introduction to Multilevel Models PSYC 943 (930): Fundamentals of Multivariate Modeling Lecture 25: December 7, 2012 Today s Class Concepts in Longitudinal Modeling Between-Person vs. +Within-Person

More information

Part 6: Multivariate Normal and Linear Models

Part 6: Multivariate Normal and Linear Models Part 6: Multivariate Normal and Linear Models 1 Multiple measurements Up until now all of our statistical models have been univariate models models for a single measurement on each member of a sample of

More information

The Inductive Proof Template

The Inductive Proof Template CS103 Handout 24 Winter 2016 February 5, 2016 Guide to Inductive Proofs Induction gives a new way to prove results about natural numbers and discrete structures like games, puzzles, and graphs. All of

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

Supplemental Resource: Brain and Cognitive Sciences Statistics & Visualization for Data Analysis & Inference January (IAP) 2009

Supplemental Resource: Brain and Cognitive Sciences Statistics & Visualization for Data Analysis & Inference January (IAP) 2009 MIT OpenCourseWare http://ocw.mit.edu Supplemental Resource: Brain and Cognitive Sciences Statistics & Visualization for Data Analysis & Inference January (IAP) 2009 For information about citing these

More information

Local Likelihood Bayesian Cluster Modeling for small area health data. Andrew Lawson Arnold School of Public Health University of South Carolina

Local Likelihood Bayesian Cluster Modeling for small area health data. Andrew Lawson Arnold School of Public Health University of South Carolina Local Likelihood Bayesian Cluster Modeling for small area health data Andrew Lawson Arnold School of Public Health University of South Carolina Local Likelihood Bayesian Cluster Modelling for Small Area

More information

Ecological applications of hidden Markov models and related doubly stochastic processes

Ecological applications of hidden Markov models and related doubly stochastic processes . Ecological applications of hidden Markov models and related doubly stochastic processes Roland Langrock School of Mathematics and Statistics & CREEM Motivating example HMM machinery Some ecological applications

More information

Lecture 4: Testing Stuff

Lecture 4: Testing Stuff Lecture 4: esting Stuff. esting Hypotheses usually has three steps a. First specify a Null Hypothesis, usually denoted, which describes a model of H 0 interest. Usually, we express H 0 as a restricted

More information

Glossary. The ISI glossary of statistical terms provides definitions in a number of different languages:

Glossary. The ISI glossary of statistical terms provides definitions in a number of different languages: Glossary The ISI glossary of statistical terms provides definitions in a number of different languages: http://isi.cbs.nl/glossary/index.htm Adjusted r 2 Adjusted R squared measures the proportion of the

More information

Physics 509: Propagating Systematic Uncertainties. Scott Oser Lecture #12

Physics 509: Propagating Systematic Uncertainties. Scott Oser Lecture #12 Physics 509: Propagating Systematic Uncertainties Scott Oser Lecture #1 1 Additive offset model Suppose we take N measurements from a distribution, and wish to estimate the true mean of the underlying

More information

Concepts and Applications of Kriging. Eric Krause Konstantin Krivoruchko

Concepts and Applications of Kriging. Eric Krause Konstantin Krivoruchko Concepts and Applications of Kriging Eric Krause Konstantin Krivoruchko Outline Introduction to interpolation Exploratory spatial data analysis (ESDA) Using the Geostatistical Wizard Validating interpolation

More information

CS 361: Probability & Statistics

CS 361: Probability & Statistics March 14, 2018 CS 361: Probability & Statistics Inference The prior From Bayes rule, we know that we can express our function of interest as Likelihood Prior Posterior The right hand side contains the

More information

Physics 403. Segev BenZvi. Numerical Methods, Maximum Likelihood, and Least Squares. Department of Physics and Astronomy University of Rochester

Physics 403. Segev BenZvi. Numerical Methods, Maximum Likelihood, and Least Squares. Department of Physics and Astronomy University of Rochester Physics 403 Numerical Methods, Maximum Likelihood, and Least Squares Segev BenZvi Department of Physics and Astronomy University of Rochester Table of Contents 1 Review of Last Class Quadratic Approximation

More information

Spatial bias modeling with application to assessing remotely-sensed aerosol as a proxy for particulate matter

Spatial bias modeling with application to assessing remotely-sensed aerosol as a proxy for particulate matter Spatial bias modeling with application to assessing remotely-sensed aerosol as a proxy for particulate matter Chris Paciorek Department of Biostatistics Harvard School of Public Health application joint

More information

A Practitioner s Guide to Generalized Linear Models

A Practitioner s Guide to Generalized Linear Models A Practitioners Guide to Generalized Linear Models Background The classical linear models and most of the minimum bias procedures are special cases of generalized linear models (GLMs). GLMs are more technically

More information

Multilevel Statistical Models: 3 rd edition, 2003 Contents

Multilevel Statistical Models: 3 rd edition, 2003 Contents Multilevel Statistical Models: 3 rd edition, 2003 Contents Preface Acknowledgements Notation Two and three level models. A general classification notation and diagram Glossary Chapter 1 An introduction

More information

Advanced Statistical Methods. Lecture 6

Advanced Statistical Methods. Lecture 6 Advanced Statistical Methods Lecture 6 Convergence distribution of M.-H. MCMC We denote the PDF estimated by the MCMC as. It has the property Convergence distribution After some time, the distribution

More information

Uncertainty and Bias UIUC, 403 Advanced Physics Laboratory, Fall 2014

Uncertainty and Bias UIUC, 403 Advanced Physics Laboratory, Fall 2014 Uncertainty and Bias UIUC, 403 Advanced Physics Laboratory, Fall 2014 Liang Yang* There are three kinds of lies: lies, damned lies and statistics. Benjamin Disraeli If your experiment needs statistics,

More information

Sometimes the domains X and Z will be the same, so this might be written:

Sometimes the domains X and Z will be the same, so this might be written: II. MULTIVARIATE CALCULUS The first lecture covered functions where a single input goes in, and a single output comes out. Most economic applications aren t so simple. In most cases, a number of variables

More information

Ridge regression. Patrick Breheny. February 8. Penalized regression Ridge regression Bayesian interpretation

Ridge regression. Patrick Breheny. February 8. Penalized regression Ridge regression Bayesian interpretation Patrick Breheny February 8 Patrick Breheny High-Dimensional Data Analysis (BIOS 7600) 1/27 Introduction Basic idea Standardization Large-scale testing is, of course, a big area and we could keep talking

More information

Statistics 203: Introduction to Regression and Analysis of Variance Penalized models

Statistics 203: Introduction to Regression and Analysis of Variance Penalized models Statistics 203: Introduction to Regression and Analysis of Variance Penalized models Jonathan Taylor - p. 1/15 Today s class Bias-Variance tradeoff. Penalized regression. Cross-validation. - p. 2/15 Bias-variance

More information

F denotes cumulative density. denotes probability density function; (.)

F denotes cumulative density. denotes probability density function; (.) BAYESIAN ANALYSIS: FOREWORDS Notation. System means the real thing and a model is an assumed mathematical form for the system.. he probability model class M contains the set of the all admissible models

More information

6.041SC Probabilistic Systems Analysis and Applied Probability, Fall 2013 Transcript Tutorial:A Random Number of Coin Flips

6.041SC Probabilistic Systems Analysis and Applied Probability, Fall 2013 Transcript Tutorial:A Random Number of Coin Flips 6.041SC Probabilistic Systems Analysis and Applied Probability, Fall 2013 Transcript Tutorial:A Random Number of Coin Flips Hey, everyone. Welcome back. Today, we're going to do another fun problem that

More information

Analytics Software. Beyond deterministic chain ladder reserves. Neil Covington Director of Solutions Management GI

Analytics Software. Beyond deterministic chain ladder reserves. Neil Covington Director of Solutions Management GI Analytics Software Beyond deterministic chain ladder reserves Neil Covington Director of Solutions Management GI Objectives 2 Contents 01 Background 02 Formulaic Stochastic Reserving Methods 03 Bootstrapping

More information

Detection ASTR ASTR509 Jasper Wall Fall term. William Sealey Gosset

Detection ASTR ASTR509 Jasper Wall Fall term. William Sealey Gosset ASTR509-14 Detection William Sealey Gosset 1876-1937 Best known for his Student s t-test, devised for handling small samples for quality control in brewing. To many in the statistical world "Student" was

More information

STA 4273H: Sta-s-cal Machine Learning

STA 4273H: Sta-s-cal Machine Learning STA 4273H: Sta-s-cal Machine Learning Russ Salakhutdinov Department of Computer Science! Department of Statistical Sciences! rsalakhu@cs.toronto.edu! h0p://www.cs.utoronto.ca/~rsalakhu/ Lecture 2 In our

More information

+ + ( + ) = Linear recurrent networks. Simpler, much more amenable to analytic treatment E.g. by choosing

+ + ( + ) = Linear recurrent networks. Simpler, much more amenable to analytic treatment E.g. by choosing Linear recurrent networks Simpler, much more amenable to analytic treatment E.g. by choosing + ( + ) = Firing rates can be negative Approximates dynamics around fixed point Approximation often reasonable

More information

Small Area Modeling of County Estimates for Corn and Soybean Yields in the US

Small Area Modeling of County Estimates for Corn and Soybean Yields in the US Small Area Modeling of County Estimates for Corn and Soybean Yields in the US Matt Williams National Agricultural Statistics Service United States Department of Agriculture Matt.Williams@nass.usda.gov

More information

18.02SC Multivariable Calculus, Fall 2010 Transcript Recitation 34, Integration in Polar Coordinates

18.02SC Multivariable Calculus, Fall 2010 Transcript Recitation 34, Integration in Polar Coordinates 18.02SC Multivariable Calculus, Fall 2010 Transcript Recitation 34, Integration in Polar Coordinates DAVID JORDAN: Hello, and welcome back to recitation. So today I want to practice doing some computings

More information

PMR Learning as Inference

PMR Learning as Inference Outline PMR Learning as Inference Probabilistic Modelling and Reasoning Amos Storkey Modelling 2 The Exponential Family 3 Bayesian Sets School of Informatics, University of Edinburgh Amos Storkey PMR Learning

More information

Observations define abundance scale.

Observations define abundance scale. Observations define abundance scale. Burro Pasture Coyote Pasture Paisano Pasture CREEM WS Variance, Standard Error, Coefficient of Variation, Confidence Intervals CREEM WS 6 CREEM WS 7 CREEM WS 8 CREEM

More information

Bayesian Networks in Educational Assessment

Bayesian Networks in Educational Assessment Bayesian Networks in Educational Assessment Estimating Parameters with MCMC Bayesian Inference: Expanding Our Context Roy Levy Arizona State University Roy.Levy@asu.edu 2017 Roy Levy MCMC 1 MCMC 2 Posterior

More information

MITOCW MITRES18_005S10_DiffEqnsGrowth_300k_512kb-mp4

MITOCW MITRES18_005S10_DiffEqnsGrowth_300k_512kb-mp4 MITOCW MITRES18_005S10_DiffEqnsGrowth_300k_512kb-mp4 GILBERT STRANG: OK, today is about differential equations. That's where calculus really is applied. And these will be equations that describe growth.

More information

Covariance function estimation in Gaussian process regression

Covariance function estimation in Gaussian process regression Covariance function estimation in Gaussian process regression François Bachoc Department of Statistics and Operations Research, University of Vienna WU Research Seminar - May 2015 François Bachoc Gaussian

More information

New Statistical Methods That Improve on MLE and GLM Including for Reserve Modeling GARY G VENTER

New Statistical Methods That Improve on MLE and GLM Including for Reserve Modeling GARY G VENTER New Statistical Methods That Improve on MLE and GLM Including for Reserve Modeling GARY G VENTER MLE Going the Way of the Buggy Whip Used to be gold standard of statistical estimation Minimum variance

More information

Remote Sensing Techniques for Renewable Energy Projects. Dr Stuart Clough APEM Ltd

Remote Sensing Techniques for Renewable Energy Projects. Dr Stuart Clough APEM Ltd Remote Sensing Techniques for Renewable Energy Projects Dr Stuart Clough APEM Ltd What is Remote Sensing? The use of aerial sensors to detect and classify objects on Earth Remote sensing for ecological

More information

Multidimensional Density Smoothing with P-splines

Multidimensional Density Smoothing with P-splines Multidimensional Density Smoothing with P-splines Paul H.C. Eilers, Brian D. Marx 1 Department of Medical Statistics, Leiden University Medical Center, 300 RC, Leiden, The Netherlands (p.eilers@lumc.nl)

More information