What you still might want to know about microarrays. Brixen 2011 Wolfgang Huber EMBL

Size: px
Start display at page:

Download "What you still might want to know about microarrays. Brixen 2011 Wolfgang Huber EMBL"

Transcription

1 What you still might want to know about microarrays Brixen 2011 Wolfgang Huber EMBL

2 Brief history Late 1980s: Lennon, Lehrach: cdnas spotted on nylon membranes 1990s: Affymetrix adapts microchip production technology for in situ oligonucleotide synthesis (commercial, patent-fenced) 1990s: Brown lab in Stanford develops two-colour spotted array technology (open and free) 1998: Yeast cell cycle expression profiling on spotted arrays (Spellmann) and Affymetrix (Cho) 1999: Tumor type discrimination based on mrna profiles (Golub) 2000-ca. 2004: Affymetrix dominates the microarray market Since ~2003: Nimblegen, Illumina, Agilent (and many others) Throughout 2000 s: CGH, CNVs, SNPs, ChIP, tiling arrays Since ~2007: Next-generation sequencing (454, Solexa, ABI Solid,...)

3 Oligonucleotide microarrays

4 Base Pairing Ability to use hybridisation for constructing specific + sensitive probes at will is unique to DNA (cf. proteins, RNA, metabolites)

5 Oligonucleotide microarrays Hybridized Probe Cell GeneChip * Target - single stranded cdna oligonucleotide probe 1.28cm Image of array after hybridisation and staining * * * * 5µm millions of copies of a specific oligonucleotide probe molecule per cell up to 6.5 Mio different probe cells

6 Probe sets

7 Terminology for transcription arrays Each target molecule (transcript) is represented by several oligonucleotides of (intended) length 25 bases Probe: one of these 25-mer oligonucleotides Probe set: a collection of probes (e.g. 11) targeting the same transcript MGED/MIAME: probe is ambiguous! Reporter: the sequence Feature: a physical patch on the array with molecules intended to have the same reporter sequence (one reporter can be represented by multiple features)

8 Image analysis several dozen pixels per feature segmentation summarisation into one number representing the intensity level for this feature CEL file

9 µarray data arrays: probes = gene-specific DNA strands

10 µarray data samples: mrna from tissue biopsies, cell lines arrays: probes = gene-specific DNA strands

11 µarray data samples: mrna from tissue biopsies, cell lines arrays: probes = gene-specific DNA strands

12 µarray data samples: mrna from tissue biopsies, cell lines fluorescent detection of the amount of sample-probe binding arrays: probes = gene-specific DNA strands tissue A tissue B tissue C ErbB VIM ALDH CASP LAMA MCAM

13 Microarray Infrastructure in Bioconductor

14 Platform-specific data import and initial processing Affymetrix 3 IVT (e.g. Human U133 Plus 2.0, Mouse ): affy Affymetrix Exon (e.g. Human Exon 1.0 ST): oligo, exonmap, xps Affymetrix SNP arrays: oligo Nimblegen tiling arrays (e.g. for ChIP-chip): Ringo Affymetrix tiling arrays (e.g. for ChIP-chip): Starr Illumina bead arrays: beadarray, lumi

15 Flexible data import Using generic R I/O functions and constructors Biobase limma Chapter Two Color Arrays in the user-book. limma user guide

16 Normalisation and quality assessment preprocesscore limma vsn arrayqualitymetrics

17 featuredata ( AnnotatedDataframe ) Sequence Target gene ID NChannelSet assaydata can contain N=1, 2,..., matrices of the same size Physical Physical coordinates D coordinates Sequence Target gene ID labeldescription varmetadata Sample-ID red Sample-ID red Sample-ID green Sample-ID blue Array-ID Sample-ID green Array ID Sample-ID blue phenodata ( AnnotatedDataframe ) labeldescription R G B channeldescription _ALL_

18 Annotation / Metadata Keeping data together with the metadata (about reporters, target genes, samples, experimental conditions,...) is one of the major principles of Bioconductor avoid alignment bugs facilitate discovery Often, the same microarray design is used for multiple experiments. Duplicating that metadata every time would be inefficient, and risk versioning mismatches instead of featuredata, just keep a pointer to an annotation package. (In principle, one could also want to do this for samples.)

19 For affy: Annotation infrastructure for Affymetrix hgu133plus2.db all available information about target genes hgu133plus2cdf maps the physical features on the array to probesets hgu133plus2probe nucleotide sequence of the features (e.g. for gcrma)

20 Genotyping crlmm Genotype Calling (CRLMM) and Copy Number Analysis tool for Affymetrix SNP 5.0 and 6.0 and Illumina arrays. snpmatrix... others See also: Genome-wide association study of CNVs in 16,000 cases of eight common diseases and 3,000 shared controls, The Wellcome Trust Case Control Consortium, Nature 464, (Box 1).

21 Gene expression analysis with microarrays

22 Microarray Analysis Tasks Data import reformating and setup/curation of the metadata Normalisation Quality assessment & control Differential expression Using gene-level annotation Gene set enrichment analysis Clustering & Classification Integration of other datasets

23 What is wrong with microarray data? Many data are measured in definite units: time in seconds lengths in meters energy in Joule, etc. Climb Mount Plose (2465 m) from Brixen (559 m) with weight of 76 kg, working against a gravitation field of strength 9.81 m/s 2 : ( ) m kg m/s 2 = kg m 2 s -2 = kj

24 What is wrong with microarray data? Many data are measured in definite units: time in seconds lengths in meters energy in Joule, etc. Climb Mount Plose (2465 m) from Brixen (559 m) with weight of 76 kg, working against a gravitation field of strength 9.81 m/s 2 : ( ) m kg m/s 2 = kg m 2 s -2 = kj

25 A complex measurement process lies between mrna concentrations and intensities o RNA degradation o amplification efficiency o reverse transcription efficiency o hybridization efficiency and specificity o labeling efficiency o quality of actual probe sequences (vs intended) o scratches and spatial gradients on the array o cross-talk across features o crosshybridisation o optical noise o image segmentation o signal quantification o signal "preprocessing"

26 A complex measurement process lies between mrna concentrations and intensities o RNA degradation o amplification efficiency o reverse transcription efficiency o hybridization efficiency and specificity o labeling efficiency o quality of actual probe sequences (vs intended) o scratches and spatial gradients on the array o crosshybridisation o optical noise o image segmentation o signal quantification The problem is less that these steps are o not cross-talk perfect ; it is that they vary across from features array to array, experiment to experiment. o signal "preprocessing"

27 Background signal and non-linearities

28 mild non-linearity spike-in data log 2 Cope et al. Bioinformatics 2003

29 ratio compression nominal 3:1 nominal 1:1 nominal 1:3 Yue et al., (Incyte Genomics) NAR (2001) 29 e41

30 Preprocessing Terminology Calibration, normalisation: adjust for systematic drifts associated with dye, array (and sometimes position within array) Background correction: adjust for the non-linearity at the lower end of the dynamic range Transformation: bring data to a scale appropriate for the analysis (e.g. logarithm; variance stabilisation) Log-ratio: adjust for unknown scale (units) of the data Existing approaches differ in the order in which these steps are done, some are exactly stepwise ( greedy ), others aim to gain strength by doing things simultaneously.

31 Statistical issues

32 Which genes are differentially transcribed? same-same log-ratio

33 Which genes are differentially transcribed? same-same tumor-normal log-ratio

34 Sources of variation amount of RNA in the biopsy efficiencies of -RNA extraction -reverse transcription -labeling -fluorescent detection probe purity and length distribution spotting efficiency, spot size cross-/unspecific hybridization stray signal

35 Sources of variation amount of RNA in the biopsy efficiencies of -RNA extraction -reverse transcription -labeling -fluorescent detection probe purity and length distribution spotting efficiency, spot size cross-/unspecific hybridization stray signal Systematic o similar effect on many measurements o corrections can be estimated from data

36 Sources of variation amount of RNA in the biopsy efficiencies of -RNA extraction -reverse transcription -labeling -fluorescent detection probe purity and length distribution spotting efficiency, spot size cross-/unspecific hybridization stray signal Systematic o similar effect on many measurements o corrections can be estimated from data Calibration

37 Sources of variation amount of RNA in the biopsy efficiencies of -RNA extraction -reverse transcription -labeling -fluorescent detection Systematic o similar effect on many measurements o corrections can be estimated from data probe purity and length distribution spotting efficiency, spot size cross-/unspecific hybridization stray signal Stochastic o too random to be explicitely accounted for o remain as noise Calibration

38 Sources of variation amount of RNA in the biopsy efficiencies of -RNA extraction -reverse transcription -labeling -fluorescent detection Systematic o similar effect on many measurements o corrections can be estimated from data probe purity and length distribution spotting efficiency, spot size cross-/unspecific hybridization stray signal Stochastic o too random to be explicitely accounted for o remain as noise Calibration Error model

39 Why do you need normalisation (a.k.a. calibration)?

40 Systematic drift effects From: lymphoma dataset vsn package Alizadeh et al., Nature 2000

41 Quantile normalisation Within each column (array), replace the intensity values by their rank For each rank, compute the average of the intensities with that rank, across columns (arrays) Replace the ranks by those averages features (genes) arrays (samples) Ben Bolstad 2001

42

43 Quantile normalisation

44 Quantile normalisation + Simple, fast, easy to implement

45 Quantile normalisation + Simple, fast, easy to implement + Always works, needs no user interaction / tuning

46 Quantile normalisation + Simple, fast, easy to implement + Always works, needs no user interaction / tuning + Non-parametric: can correct for quite nasty non-linearities (saturation, background) in the data

47 Quantile normalisation + Simple, fast, easy to implement + Always works, needs no user interaction / tuning + Non-parametric: can correct for quite nasty non-linearities (saturation, background) in the data - Always "works", even if data are bad / inappropriate

48 Quantile normalisation + Simple, fast, easy to implement + Always works, needs no user interaction / tuning + Non-parametric: can correct for quite nasty non-linearities (saturation, background) in the data - Always "works", even if data are bad / inappropriate - May be conservative: rank transformation looses information - may yield less power to detect differentially expressed genes

49 Quantile normalisation + Simple, fast, easy to implement + Always works, needs no user interaction / tuning + Non-parametric: can correct for quite nasty non-linearities (saturation, background) in the data - Always "works", even if data are bad / inappropriate - May be conservative: rank transformation looses information - may yield less power to detect differentially expressed genes - Aggressive: if there is an excess of up- (or down) regulated genes, it removes not just technical, but also biological variation

50 Estimating relative expression (fold-changes)

51 ratios and fold changes Fold changes are useful to describe continuous changes in expression x3 x1.5 A B C But what if the gene is off (below detection limit) in one condition? ?? A B C

52 ratios and fold changes The idea of the log-ratio (base 2) 0: no change +1: up by factor of 2 1 = 2 +2: up by factor of 2 2 = 4-1: down by factor of 2-1 = 1/2-2: down by factor of 2-2 = ¼

53 ratios and fold changes The idea of the log-ratio (base 2) 0: no change +1: up by factor of 2 1 = 2 +2: up by factor of 2 2 = 4-1: down by factor of 2-1 = 1/2-2: down by factor of 2-2 = ¼ A unit for measuring changes in expression: assumes that a change from 1000 to 2000 units has a similar biological meaning to one from 5000 to data reduction

54 ratios and fold changes The idea of the log-ratio (base 2) 0: no change +1: up by factor of 2 1 = 2 +2: up by factor of 2 2 = 4-1: down by factor of 2-1 = 1/2-2: down by factor of 2-2 = ¼ A unit for measuring changes in expression: assumes that a change from 1000 to 2000 units has a similar biological meaning to one from 5000 to data reduction What about a change from 0 to 500? - conceptually - noise, measurement precision

55 Two component error model and variance stabilisation

56 The two-component model raw scale log scale B. Durbin, D. Rocke, JCB 2001

57 The two-component model multiplicative noise additive noise raw scale log scale B. Durbin, D. Rocke, JCB 2001

58 The two-component model multiplicative noise additive noise We will see something similar in with short read count data - just replace the additive component with Poisson raw scale log scale B. Durbin, D. Rocke, JCB 2001

59 The additive-multiplicative error model variance var = mean 2 additive component sqrt(variance) multiplicative component mean mean

60 The additive-multiplicative error Trey Ideker et al.: JCB (2000) model David Rocke and Blythe Durbin: JCB (2001), Bioinformatics (2002) Use for robust affine regression normalisation: W. Huber, Anja von Heydebreck et al. Bioinformatics (2002). For background correction in RMA: R. Irizarry et al., Biostatistics (2003).

61 The two component model measured intensity = offset + gain true abundance a i per-sample offset ε ik additive noise b i per-sample gain factor b k sequence-wise probe efficiency η ik multiplicative noise

62 variance stabilizing transformations X u a family of random variables with E(X u ) = u and Var(X u ) = v(u). Define Then, var f(x u ) does not depend on u Derivation: linear approximation, relies on smoothness of v(u).

63 variance stabilizing transformation f(x) x

64 variance stabilizing transformations 1.) constant variance ( additive ) 2.) constant CV ( multiplicative ) 3.) offset 4.) additive and multiplicative

65 the glog transformation P. Munson, 2001 D. Rocke & B. Durbin, ISMB 2002 W. Huber et al., ISMB 2002

66 glog raw scale log glog difference log-ratio generalized log-ratio

67 glog raw scale log glog difference log-ratio generalized log-ratio variance: constant part proportional part

68 Parameter estimation

69 Parameter estimation

70 Parameter estimation

71 Parameter estimation o maximum likelihood estimator: straightforward but sensitive to deviations from normality

72 Parameter estimation o maximum likelihood estimator: straightforward but sensitive to deviations from normality o model holds for genes that are unchanged; differentially transcribed genes act as outliers.

73 Parameter estimation o maximum likelihood estimator: straightforward but sensitive to deviations from normality o model holds for genes that are unchanged; differentially transcribed genes act as outliers. o robust variant of ML estimator, à la Least Trimmed Sum of Squares regression.

74 Parameter estimation o maximum likelihood estimator: straightforward but sensitive to deviations from normality o model holds for genes that are unchanged; differentially transcribed genes act as outliers. o robust variant of ML estimator, à la Least Trimmed Sum of Squares regression. o works well as long as <50% of genes are differentially transcribed (and may still work otherwise)

75 usual log-ratio 'glog' (generalized log-ratio) c 1, c 2 are experiment specific parameters (~level of background noise)

76 Variance-bias trade-off and shrinkage estimators Shrinkage estimators: a general technology in statistics: pay a small price in bias for a large decrease of variance, so overall the mean-squared-error (MSE) is reduced. Particularly useful if you have few replicates. Generalized log-ratio is a shrinkage estimator for log fold change

77 other background correction methods

78 Background correction 0 pm 750 fm 500 fm 1 pm Irizarry et al. Biostatistics 2003

79 RMA Background correction Irizarry et al. (2002)

80 Background correction: raw intensities x biased background correction s=e[s data] log 2 (s) unbiased background correction s=x-b glog 2 (s data)?

81 Comparison between RMA and VSN background correction vsn package vignette

82 Summaries for Affymetrix genechip probe sets

83 Data and notation PM ikg, MM ikg = Intensities for perfect match and mismatch probe k for gene g on chip i i = 1,, n k = 1,, J one to hundreds of chips usually 11 probe pairs g = 1,, G tens of thousands of probe sets. Tasks: calibrate (normalize) the measurements from different chips (samples) summarize for each probe set the probe level data, i.e., 11 PM and MM pairs, into a single expression measure. compare between chips (samples) for detecting differential expression.

84 Expression measures: MAS 4.0 Affymetrix GeneChip MAS 4.0 software used AvDiff, a trimmed mean: o sort d k = PM k -MM k o exclude highest and lowest value o K := those pairs within 3 standard deviations of the average

85 Expression measures MAS 5.0 Instead of MM, use "repaired" version CT CT = MM if MM<PM = PM / "typical log-ratio" if MM>=PM Signal = Weighted mean of the values log(pm-ct) weights follow Tukey Biweight function (location = data median, scale a fixed multiple of MAD)

86 Expression measures: Li & Wong dchip fits a model for each gene where φ i : expression measure for the gene in sample i θ k : probe effect φ i is estimated by maximum likelihood

87

88 Expression measures RMA: Irizarry et al. (2002) dchip RMA b i is estimated using the robust method median polish (successively remove row and column medians, accumulate terms, until convergence).

89 Quality assessment

90 Quality assessment arrayqualitymetrics example quality report

91 References Bioinformatics and computational biology solutions using R and Bioconductor, R. Gentleman, V. Carey, W. Huber, R. Irizarry, S. Dudoit, Springer (2005). Variance stabilization applied to microarray data calibration and to the quantification of differential expression. W. Huber, A. von Heydebreck, H. Sültmann, A. Poustka, M. Vingron. Bioinformatics 18 suppl. 1 (2002), S96-S104. Exploration, Normalization, and Summaries of High Density Oligonucleotide Array Probe Level Data. R. Irizarry, B. Hobbs, F. Collins,, T. Speed. Biostatistics 4 (2003) Error models for microarray intensities. W. Huber, A. von Heydebreck, and M. Vingron. Encyclopedia of Genomics, Proteomics and Bioinformatics. John Wiley & sons (2005). Normalization and analysis of DNA microarray data by self-consistency and local regression. T.B. Kepler, L. Crosby, K. Morgan. Genome Biology. 3(7):research0037 (2002) Statistical methods for identifying differentially expressed genes in replicated cdna microarray experiments. S. Dudoit, Y.H. Yang, M. J. Callow, T. P. Speed. Technical report # 578, August 2000 (UC Berkeley Dep. Statistics) A Benchmark for Affymetrix GeneChip Expression Measures. L.M. Cope, R.A. Irizarry, H. A. Jaffee, Z. Wu, T.P. Speed. Bioinformatics (2003)....many, many more...

92 Acknowledgements Anja von Heydebreck (Merck, Darmstadt) Robert Gentleman (Genentech, San Francisco) Günther Sawitzki (Uni Heidelberg) Martin Vingron (MPI, Berlin) Rafael Irizarry (JHU, Baltimore) Terry Speed (UC Berkeley) Jörn Tödling (Inst. Curie, Paris) Lars Steinmetz (EMBL Heidelberg) Audrey Kauffmann (Novartis, Basel)

93

94 What about non-linear effects o Microarrays can be operated in a linear regime, where fluorescence intensity increases proportionally to target abundance (see e.g. Affymetrix dilution series) Two reasons for non-linearity: o At the high intensity end: saturation/quenching. This can (and should) be avoided experimentally - loss of data! o At the low intensity end: background offsets, instead of y=k x we have y=k x+x 0, and in the log-log plot this can look curvilinear. But this is an affine-linear effect and can be correct by affine normalization. Local polynomial regression may be OK, but tends to be less efficient.

95 Non-linear or affine linear?

Bioconductor tools for microarray analysis Preprocessing : normalization & error models. Wolfgang Huber EMBL

Bioconductor tools for microarray analysis Preprocessing : normalization & error models. Wolfgang Huber EMBL Bioconductor tools for microarray analysis Preprocessing : normalization & error models Wolfgang Huber EMBL An international open source and open development software project for the analysis of genomic

More information

Normalization. Getting the numbers comparable. DNA Microarray Bioinformatics - #27612

Normalization. Getting the numbers comparable. DNA Microarray Bioinformatics - #27612 Normalization Getting the numbers comparable The DNA Array Analysis Pipeline Question Experimental Design Array design Probe design Sample Preparation Hybridization Buy Chip/Array Image analysis Expression

More information

Introduction to gene expression microarray data analysis

Introduction to gene expression microarray data analysis Introduction to gene expression microarray data analysis Outline Brief introduction: Technology and data. Statistical challenges in data analysis. Preprocessing data normalization and transformation. Useful

More information

Affymetrix GeneChip Arrays. Lecture 3 (continued) Computational and Statistical Aspects of Microarray Analysis June 21, 2005 Bressanone, Italy

Affymetrix GeneChip Arrays. Lecture 3 (continued) Computational and Statistical Aspects of Microarray Analysis June 21, 2005 Bressanone, Italy Affymetrix GeneChip Arrays Lecture 3 (continued) Computational and Statistical Aspects of Microarray Analysis June 21, 2005 Bressanone, Italy Affymetrix GeneChip Design 5 3 Reference sequence TGTGATGGTGGGGAATGGGTCAGAAGGCCTCCGATGCGCCGATTGAGAAT

More information

Background and Normalization:

Background and Normalization: Background and Normalization: Investigating the effects of preprocessing on gene expression estimates Ben Bolstad Group in Biostatistics University of California, Berkeley bolstad@stat.berkeley.edu http://www.stat.berkeley.edu/~bolstad

More information

Expression summarization

Expression summarization Expression Quantification: Affy Affymetrix Genechip is an oligonucleotide array consisting of a several perfect match (PM) and their corresponding mismatch (MM) probes that interrogate for a single gene.

More information

Preprocessing Affymetrix GeneChip Data. Affymetrix GeneChip Design. Terminology TGTGATGGTGGGGAATGGGTCAGAAGGCCTCCGATGCGCCGATTGAGAAT

Preprocessing Affymetrix GeneChip Data. Affymetrix GeneChip Design. Terminology TGTGATGGTGGGGAATGGGTCAGAAGGCCTCCGATGCGCCGATTGAGAAT Preprocessing Affymetrix GeneChip Data Credit for some of today s materials: Ben Bolstad, Leslie Cope, Laurent Gautier, Terry Speed and Zhijin Wu Affymetrix GeneChip Design 5 3 Reference sequence TGTGATGGTGGGGAATGGGTCAGAAGGCCTCCGATGCGCCGATTGAGAAT

More information

DNA Microarray Data Oligonucleotide Arrays

DNA Microarray Data Oligonucleotide Arrays DNA Microarray Data Oligonucleotide Arrays Sandrine Dudoit, Robert Gentleman, Rafael Irizarry, and Yee Hwa Yang Bioconductor Short Course 2003 Copyright 2002, all rights reserved Biological question Experimental

More information

Microarray Data Analysis Workshop. Preprocessing and normalization A trailer show of the rest of the microarray world.

Microarray Data Analysis Workshop. Preprocessing and normalization A trailer show of the rest of the microarray world. Microarray Data Analysis Workshop MedVetNet Workshop, DTU 2008 Preprocessing and normalization A trailer show of the rest of the microarray world Carsten Friis Media glna tnra GlnA TnrA C2 glnr C3 C5 C6

More information

From CEL files to lists of interesting genes. Rafael A. Irizarry Department of Biostatistics Johns Hopkins University

From CEL files to lists of interesting genes. Rafael A. Irizarry Department of Biostatistics Johns Hopkins University From CEL files to lists of interesting genes Rafael A. Irizarry Department of Biostatistics Johns Hopkins University Contact Information e-mail Personal webpage Department webpage Bioinformatics Program

More information

Exploration, Normalization, Summaries, and Software for Affymetrix Probe Level Data

Exploration, Normalization, Summaries, and Software for Affymetrix Probe Level Data Exploration, Normalization, Summaries, and Software for Affymetrix Probe Level Data Rafael A. Irizarry Department of Biostatistics, JHU March 12, 2003 Outline Review of technology Why study probe level

More information

Introduction to Bioinformatics! Giri Narasimhan. ECS 254; Phone: x3748

Introduction to Bioinformatics! Giri Narasimhan. ECS 254; Phone: x3748 Introduction to Bioinformatics! Giri Narasimhan ECS 254; Phone: x3748 giri@cs.fiu.edu www.cis.fiu.edu/~giri/teach/bioinfs11.html Reading! The following slides come from a series of talks by Rafael Irizzary

More information

Probe-Level Data Normalisation: RMA and GC-RMA Sam Robson Images courtesy of Neil Ward, European Application Engineer, Agilent Technologies.

Probe-Level Data Normalisation: RMA and GC-RMA Sam Robson Images courtesy of Neil Ward, European Application Engineer, Agilent Technologies. Probe-Level Data Normalisation: RMA and GC-RMA Sam Robson Images courtesy of Neil Ward, European Application Engineer, Agilent Technologies. References Summaries of Affymetrix Genechip Probe Level Data,

More information

Background Correction and Normalization. Lecture 3 Computational and Statistical Aspects of Microarray Analysis June 21, 2005 Bressanone, Italy

Background Correction and Normalization. Lecture 3 Computational and Statistical Aspects of Microarray Analysis June 21, 2005 Bressanone, Italy Background Correction and Normalization Lecture 3 Computational and Statistical Aspects of Microarray Analysis June 21, 2005 Bressanone, Italy Feature Level Data Outline Affymetrix GeneChip arrays Two

More information

Image Analysis. Based on Information from Terry Speed s Group, UC Berkeley. Lecture 3 Pre-Processing of Affymetrix Arrays. Affymetrix Terminology

Image Analysis. Based on Information from Terry Speed s Group, UC Berkeley. Lecture 3 Pre-Processing of Affymetrix Arrays. Affymetrix Terminology Image Analysis Lecture 3 Pre-Processing of Affymetrix Arrays Stat 697K, CS 691K, Microbio 690K 2 Affymetrix Terminology Probe: an oligonucleotide of 25 base-pairs ( 25-mer ). Based on Information from

More information

Microarrays The technology

Microarrays The technology Microarrays The technology Goal Goal: To measure the amount of a specific (known) DNA molecule in parallel. In parallel : do this for thousands or millions of molecules simultaneously. Main components

More information

Rafael A Irizarry, Department of Biostatistics JHU

Rafael A Irizarry, Department of Biostatistics JHU Getting Usable Data from Microarrays it s not as easy as you think Rafael A Irizarry, Department of Biostatistics JHU rafa@jhu.edu http://www.biostat.jhsph.edu/~ririzarr http://www.bioconductor.org Acknowledgements

More information

Microarray Data Analysis. Normalization

Microarray Data Analysis. Normalization Microarray Data Analysis Normalization Outline General issues Normalization for two colour microarrays Normalization and other stuff for one color microarrays 2 Preprocessing: normalization The word normalization

More information

Lecture #1. Introduction to microarray technology

Lecture #1. Introduction to microarray technology Lecture #1 Introduction to microarray technology Outline General purpose Microarray assay concept Basic microarray experimental process cdna/two channel arrays Oligonucleotide arrays Exon arrays Comparing

More information

Analysis of Microarray Data

Analysis of Microarray Data Analysis of Microarray Data Lecture 1: Experimental Design and Data Normalization George Bell, Ph.D. Senior Bioinformatics Scientist Bioinformatics and Research Computing Whitehead Institute Outline Introduction

More information

Measuring and Understanding Gene Expression

Measuring and Understanding Gene Expression Measuring and Understanding Gene Expression Dr. Lars Eijssen Dept. Of Bioinformatics BiGCaT Sciences programme 2014 Why are genes interesting? TRANSCRIPTION Genome Genomics Transcriptome Transcriptomics

More information

Analysis of Microarray Data

Analysis of Microarray Data Analysis of Microarray Data Lecture 1: Experimental Design and Data Normalization George Bell, Ph.D. Senior Bioinformatics Scientist Bioinformatics and Research Computing Whitehead Institute Outline Introduction

More information

SPH 247 Statistical Analysis of Laboratory Data

SPH 247 Statistical Analysis of Laboratory Data SPH 247 Statistical Analysis of Laboratory Data April 14, 2015 SPH 247 Statistical Analysis of Laboratory Data 1 Basic Design of Expression Arrays For each gene that is a target for the array, we have

More information

AFFYMETRIX c Technology and Preprocessing Methods

AFFYMETRIX c Technology and Preprocessing Methods Analysis of Genomic and Proteomic Data AFFYMETRIX c Technology and Preprocessing Methods bhaibeka@ulb.ac.be Université Libre de Bruxelles Institut Jules Bordet Table of Contents AFFYMETRIX c Technology

More information

Outline. Analysis of Microarray Data. Most important design question. General experimental issues

Outline. Analysis of Microarray Data. Most important design question. General experimental issues Outline Analysis of Microarray Data Lecture 1: Experimental Design and Data Normalization Introduction to microarrays Experimental design Data normalization Other data transformation Exercises George Bell,

More information

CS-E5870 High-Throughput Bioinformatics Microarray data analysis

CS-E5870 High-Throughput Bioinformatics Microarray data analysis CS-E5870 High-Throughput Bioinformatics Microarray data analysis Harri Lähdesmäki Department of Computer Science Aalto University September 20, 2016 Acknowledgement for J Salojärvi and E Czeizler for the

More information

A Distribution Free Summarization Method for Affymetrix GeneChip Arrays

A Distribution Free Summarization Method for Affymetrix GeneChip Arrays A Distribution Free Summarization Method for Affymetrix GeneChip Arrays Zhongxue Chen 1,2, Monnie McGee 1,*, Qingzhong Liu 3, and Richard Scheuermann 2 1 Department of Statistical Science, Southern Methodist

More information

Pre-processing DNA Microarray Data

Pre-processing DNA Microarray Data Pre-processing DNA Microarray Data Sandrine Dudoit, Robert Gentleman, Rafael Irizarry, and Yee Hwa Yang Bioconductor Short Course Winter 2002 Copyright 2002, all rights reserved Biological question Experimental

More information

Mixed effects model for assessing RNA degradation in Affymetrix GeneChip experiments

Mixed effects model for assessing RNA degradation in Affymetrix GeneChip experiments Mixed effects model for assessing RNA degradation in Affymetrix GeneChip experiments Kellie J. Archer, Ph.D. Suresh E. Joel Viswanathan Ramakrishnan,, Ph.D. Department of Biostatistics Virginia Commonwealth

More information

Introduction to Microarray Analysis

Introduction to Microarray Analysis Introduction to Microarray Analysis Methods Course: Gene Expression Data Analysis -Day One Rainer Spang Microarrays Highly parallel measurement devices for gene expression levels 1. How does the microarray

More information

2007/04/21.

2007/04/21. 2007/04/21 hmwu@stat.sinica.edu.tw http://idv.sinica.edu.tw/hmwu 1 GeneChip Expression Array Design Assay and Analysis Flow Chart Quality Assessment Low Level Analysis (from probe level data to expression

More information

Measuring gene expression (Microarrays) Ulf Leser

Measuring gene expression (Microarrays) Ulf Leser Measuring gene expression (Microarrays) Ulf Leser This Lecture Gene expression Microarrays Idea Technologies Problems Quality control Normalization Analysis next week! 2 http://learn.genetics.utah.edu/content/molecules/transcribe/

More information

Microarray probe expression measures, data normalization and statistical validation

Microarray probe expression measures, data normalization and statistical validation Comparative and Functional Genomics Comp Funct Genom 2003; 4: 442 446. Published online in Wiley InterScience (www.interscience.wiley.com). DOI: 10.1002/cfg.312 Conference Review Microarray probe expression

More information

Pre-processing DNA Microarray Data

Pre-processing DNA Microarray Data Pre-processing DNA Microarray Data Short course: Practical Analysis of DNA Microarray Data Instructors: Vince Carey & Sandrine Dudoit KolleKolle, Denmark October 26-28, 2003 1 Slides from Short Courses

More information

The essentials of microarray data analysis

The essentials of microarray data analysis The essentials of microarray data analysis (from a complete novice) Thanks to Rafael Irizarry for the slides! Outline Experimental design Take logs! Pre-processing: affy chips and 2-color arrays Clustering

More information

Integrative Genomics 1a. Introduction

Integrative Genomics 1a. Introduction 2016 Course Outline Integrative Genomics 1a. Introduction ggibson.gt@gmail.com http://www.cig.gatech.edu 1a. Experimental Design and Hypothesis Testing (GG) 1b. Normalization (GG) 2a. RNASeq (MI) 2b. Clustering

More information

affy: Built-in Processing Methods

affy: Built-in Processing Methods affy: Built-in Processing Methods Ben Bolstad October 30, 2017 Contents 1 Introduction 2 2 Background methods 2 2.1 none...................................... 2 2.2 rma/rma2...................................

More information

Preprocessing Methods for Two-Color Microarray Data

Preprocessing Methods for Two-Color Microarray Data Preprocessing Methods for Two-Color Microarray Data 1/15/2011 Copyright 2011 Dan Nettleton Preprocessing Steps Background correction Transformation Normalization Summarization 1 2 What is background correction?

More information

Microarray Informatics

Microarray Informatics Microarray Informatics Donald Dunbar MSc Seminar 31 st January 2007 Aims To give a biologist s view of microarray experiments To explain the technologies involved To describe typical microarray experiments

More information

Probe-Level Analysis of Affymetrix GeneChip Microarray Data

Probe-Level Analysis of Affymetrix GeneChip Microarray Data Probe-Level Analysis of Affymetrix GeneChip Microarray Data Ben Bolstad http://www.stat.berkeley.edu/~bolstad Michigan State University February 15, 2005 Outline for Today's Talk A brief introduction to

More information

The Affymetrix platform for gene expression analysis Affymetrix recommended QA procedures The RMA model for probe intensity data Application of the

The Affymetrix platform for gene expression analysis Affymetrix recommended QA procedures The RMA model for probe intensity data Application of the 1 The Affymetrix platform for gene expression analysis Affymetrix recommended QA procedures The RMA model for probe intensity data Application of the fitted RMA model to quality assessment 2 3 Probes are

More information

Microarray Informatics

Microarray Informatics Microarray Informatics Donald Dunbar MSc Seminar 4 th February 2009 Aims To give a biologistʼs view of microarray experiments To explain the technologies involved To describe typical microarray experiments

More information

Exploration and Analysis of DNA Microarray Data

Exploration and Analysis of DNA Microarray Data Exploration and Analysis of DNA Microarray Data Dhammika Amaratunga Senior Research Fellow in Nonclinical Biostatistics Johnson & Johnson Pharmaceutical Research & Development Javier Cabrera Associate

More information

Introduction to Bioinformatics and Gene Expression Technology

Introduction to Bioinformatics and Gene Expression Technology Vocabulary Introduction to Bioinformatics and Gene Expression Technology Utah State University Spring 2014 STAT 5570: Statistical Bioinformatics Notes 1.1 Gene: Genetics: Genome: Genomics: hereditary DNA

More information

Array Quality Metrics. Audrey Kauffmann

Array Quality Metrics. Audrey Kauffmann Array Quality Metrics Audrey Kauffmann Introduction Microarrays are widely/routinely used Technology and protocol improvements trustworthy Variance and noise Technical causes: Platform Lab, experimentalist

More information

Analyzing DNA Microarray Data Using Bioconductor

Analyzing DNA Microarray Data Using Bioconductor Analyzing DNA Microarray Data Using Bioconductor Sandrine Dudoit and Rafael Irizarry Short Course on Mathematical Approaches to the Analysis of Complex Phenotypes The Jackson Laboratory, Bar Harbor, Maine

More information

Standard Data Analysis Report Agilent Gene Expression Service

Standard Data Analysis Report Agilent Gene Expression Service Standard Data Analysis Report Agilent Gene Expression Service Experiment: S534662 Date: 2011-01-01 Prepared for: Dr. Researcher Genomic Sciences Lab Prepared by S534662 Standard Data Analysis Report 2011-01-01

More information

Humboldt Universität zu Berlin. Grundlagen der Bioinformatik SS Microarrays. Lecture

Humboldt Universität zu Berlin. Grundlagen der Bioinformatik SS Microarrays. Lecture Humboldt Universität zu Berlin Microarrays Grundlagen der Bioinformatik SS 2017 Lecture 6 09.06.2017 Agenda 1.mRNA: Genomic background 2.Overview: Microarray 3.Data-analysis: Quality control & normalization

More information

Generating quality metrics reports for microarray data sets. Audrey Kauffmann

Generating quality metrics reports for microarray data sets. Audrey Kauffmann Generating quality metrics reports for microarray data sets Audrey Kauffmann Introduction Microarrays are widely/routinely used Technology and protocol improvements trustworthy Variance and noise Technical

More information

Introduction to Genome Wide Association Studies 2014 Sydney Brenner Institute for Molecular Bioscience/Wits Bioinformatics Shaun Aron

Introduction to Genome Wide Association Studies 2014 Sydney Brenner Institute for Molecular Bioscience/Wits Bioinformatics Shaun Aron Introduction to Genome Wide Association Studies 2014 Sydney Brenner Institute for Molecular Bioscience/Wits Bioinformatics Shaun Aron Genotype calling Genotyping methods for Affymetrix arrays Genotyping

More information

Bioinformatics III Structural Bioinformatics and Genome Analysis. PART II: Genome Analysis. Chapter 7. DNA Microarrays

Bioinformatics III Structural Bioinformatics and Genome Analysis. PART II: Genome Analysis. Chapter 7. DNA Microarrays Bioinformatics III Structural Bioinformatics and Genome Analysis PART II: Genome Analysis Chapter 7. DNA Microarrays 7.1 Motivation 7.2 DNA Microarray History and current states 7.3 DNA Microarray Techniques

More information

6. GENE EXPRESSION ANALYSIS MICROARRAYS

6. GENE EXPRESSION ANALYSIS MICROARRAYS 6. GENE EXPRESSION ANALYSIS MICROARRAYS BIOINFORMATICS COURSE MTAT.03.239 16.10.2013 GENE EXPRESSION ANALYSIS MICROARRAYS Slides adapted from Konstantin Tretyakov s 2011/2012 and Priit Adlers 2010/2011

More information

DNA Microarray Technology

DNA Microarray Technology 2 DNA Microarray Technology 2.1 Overview DNA microarrays are assays for quantifying the types and amounts of mrna transcripts present in a collection of cells. The number of mrna molecules derived from

More information

Gene Expression Technology

Gene Expression Technology Gene Expression Technology Bing Zhang Department of Biomedical Informatics Vanderbilt University bing.zhang@vanderbilt.edu Gene expression Gene expression is the process by which information from a gene

More information

PLM Extensions. B. M. Bolstad. October 30, 2013

PLM Extensions. B. M. Bolstad. October 30, 2013 PLM Extensions B. M. Bolstad October 30, 2013 1 Algorithms 1.1 Probe Level Model - robust (PLM-r) The goal is to dynamically select rows and columns for down-weighting. As with the standard PLM approach,

More information

Computational Biology I

Computational Biology I Computational Biology I Microarray data acquisition Gene clustering Practical Microarray Data Acquisition H. Yang From Sample to Target cdna Sample Centrifugation (Buffer) Cell pellets lyse cells (TRIzol)

More information

ADVANCED STATISTICAL METHODS FOR GENE EXPRESSION DATA

ADVANCED STATISTICAL METHODS FOR GENE EXPRESSION DATA ADVANCED STATISTICAL METHODS FOR GENE EXPRESSION DATA Veera Baladandayuthapani & Kim-Anh Do University of Texas M.D. Anderson Cancer Center Houston, Texas, USA veera@mdanderson.org Course Website: http://odin.mdacc.tmc.edu/

More information

David M. Rocke Division of Biostatistics and Department of Biomedical Engineering University of California, Davis

David M. Rocke Division of Biostatistics and Department of Biomedical Engineering University of California, Davis David M. Rocke Division of Biostatistics and Department of Biomedical Engineering University of California, Davis Outline RNA-Seq for differential expression analysis Statistical methods for RNA-Seq: Structure

More information

Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods

Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods EPP 245/298 Statistical Analysis of Laboratory Data October 11, 2005 1 The

More information

Gene Signal Estimates from Exon Arrays

Gene Signal Estimates from Exon Arrays Gene Signal Estimates from Exon Arrays I. Introduction: With exon arrays like the GeneChip Human Exon 1.0 ST Array, researchers can examine the transcriptional profile of an entire gene (Figure 1). Being

More information

Class Information. Introduction to Genome Biology and Microarray Technology. Biostatistics Rafael A. Irizarry. Lecture 1

Class Information. Introduction to Genome Biology and Microarray Technology. Biostatistics Rafael A. Irizarry. Lecture 1 This work is licensed under a Creative Commons ttribution-noncommercial-sharelike License. Your use of this material constitutes acceptance of that license and the conditions of use of materials on this

More information

Towards an Optimized Illumina Microarray Data Analysis Pipeline

Towards an Optimized Illumina Microarray Data Analysis Pipeline Towards an Optimized Illumina Microarray Data Analysis Pipeline Pan Du, Simon Lin Robert H. Lurie Comprehensive Cancer Center, Northwestern University Oct 01, 2007 Outline Introduction of Illumina Beadarray

More information

Bioinformatics: Microarray Technology. Assc.Prof. Chuchart Areejitranusorn AMS. KKU.

Bioinformatics: Microarray Technology. Assc.Prof. Chuchart Areejitranusorn AMS. KKU. Introduction to Bioinformatics: Microarray Technology Assc.Prof. Chuchart Areejitranusorn AMS. KKU. ความจร งเก ยวก บ ความจรงเกยวกบ Cell and DNA Cell Nucleus Chromosome Protein Gene (mrna), single strand

More information

Measuring gene expression

Measuring gene expression Measuring gene expression Grundlagen der Bioinformatik SS2018 https://www.youtube.com/watch?v=v8gh404a3gg Agenda Organization Gene expression Background Technologies FISH Nanostring Microarrays RNA-seq

More information

Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods

Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods BST 226 Statistical Methods for Bioinformatics January 8, 2014 1 The -Omics

More information

Identification of biological themes in microarray data from a mouse heart development time series using GeneSifter

Identification of biological themes in microarray data from a mouse heart development time series using GeneSifter Identification of biological themes in microarray data from a mouse heart development time series using GeneSifter VizX Labs, LLC Seattle, WA 98119 Abstract Oligonucleotide microarrays were used to study

More information

Comparison of Affymetrix GeneChip Expression Measures

Comparison of Affymetrix GeneChip Expression Measures Johns Hopkins University, Dept. of Biostatistics Working Papers 9-1-2005 Comparison of Affymetrix GeneChip Expression Measures Rafael A. Irizarry Johns Hopkins Bloomberg School of Public Health, Department

More information

CAP BIOINFORMATICS Su-Shing Chen CISE. 10/5/2005 Su-Shing Chen, CISE 1

CAP BIOINFORMATICS Su-Shing Chen CISE. 10/5/2005 Su-Shing Chen, CISE 1 CAP 5510-9 BIOINFORMATICS Su-Shing Chen CISE 10/5/2005 Su-Shing Chen, CISE 1 Basic BioTech Processes Hybridization PCR Southern blotting (spot or stain) 10/5/2005 Su-Shing Chen, CISE 2 10/5/2005 Su-Shing

More information

FEATURE-LEVEL EXPLORATION OF THE CHOE ET AL. AFFYMETRIX GENECHIP CONTROL DATASET

FEATURE-LEVEL EXPLORATION OF THE CHOE ET AL. AFFYMETRIX GENECHIP CONTROL DATASET Johns Hopkins University, Dept. of Biostatistics Working Papers 3-17-2006 FEATURE-LEVEL EXPLORATION OF THE CHOE ET AL. AFFYETRIX GENECHIP CONTROL DATASET Rafael A. Irizarry Johns Hopkins Bloomberg School

More information

Introduction to Bioinformatics and Gene Expression Technologies

Introduction to Bioinformatics and Gene Expression Technologies Introduction to Bioinformatics and Gene Expression Technologies Utah State University Fall 2017 Statistical Bioinformatics (Biomedical Big Data) Notes 1 1 Vocabulary Gene: hereditary DNA sequence at a

More information

Introduction to Bioinformatics and Gene Expression Technologies

Introduction to Bioinformatics and Gene Expression Technologies Vocabulary Introduction to Bioinformatics and Gene Expression Technologies Utah State University Fall 2017 Statistical Bioinformatics (Biomedical Big Data) Notes 1 Gene: Genetics: Genome: Genomics: hereditary

More information

Gene expression analysis: Introduction to microarrays

Gene expression analysis: Introduction to microarrays Gene expression analysis: Introduction to microarrays Adam Ameur The Linnaeus Centre for Bioinformatics, Uppsala University February 15, 2006 Overview Introduction Part I: How a microarray experiment is

More information

Probe-Level Data Analysis of Affymetrix GeneChip Expression Data using Open-source Software Ben Bolstad

Probe-Level Data Analysis of Affymetrix GeneChip Expression Data using Open-source Software Ben Bolstad Probe-Level Data Analysis of Affymetrix GeneChip Expression Data using Open-source Software Ben Bolstad bmb@bmbolstad.com http://bmbolstad.com August 7, 2006 1 Outline Introduction to probe-level data

More information

Microarray Technique. Some background. M. Nath

Microarray Technique. Some background. M. Nath Microarray Technique Some background M. Nath Outline Introduction Spotting Array Technique GeneChip Technique Data analysis Applications Conclusion Now Blind Guess? Functional Pathway Microarray Technique

More information

1. Introduction Gene regulation Genomics and genome analyses

1. Introduction Gene regulation Genomics and genome analyses 1. Introduction Gene regulation Genomics and genome analyses 2. Gene regulation tools and methods Regulatory sequences and motif discovery TF binding sites Databases 3. Technologies Microarrays Deep sequencing

More information

Lecture 2: March 8, 2007

Lecture 2: March 8, 2007 Analysis of DNA Chips and Gene Networks Spring Semester, 2007 Lecture 2: March 8, 2007 Lecturer: Rani Elkon Scribe: Yuri Solodkin and Andrey Stolyarenko 1 2.1 Low Level Analysis of Microarrays 2.1.1 Introduction

More information

Parameter Estimation for the Exponential-Normal Convolution Model

Parameter Estimation for the Exponential-Normal Convolution Model Parameter Estimation for the Exponential-Normal Convolution Model Monnie McGee & Zhongxue Chen cgee@smu.edu, zhongxue@smu.edu. Department of Statistical Science Southern Methodist University ENAR Spring

More information

Pre processing and quality control of microarray data

Pre processing and quality control of microarray data Pre processing and quality control of microarray data Christine Stansberg, 20.04.10 Workflow microarray experiment 1 Problem driven experimental design Wet lab experiments RNA labelling 2 Data pre processing

More information

A note on oligonucleotide expression values not being normally distributed

A note on oligonucleotide expression values not being normally distributed Biostatistics (2009), 10, 3, pp. 446 450 doi:10.1093/biostatistics/kxp003 Advance Access publication on March 10, 2009 A note on oligonucleotide expression values not being normally distributed JOHANNA

More information

Clones. Glass Slide PCR. Purification. Array Printing. Post-process. Hybridize. Scan. Array Fabrication. Sample Preparation/Hybridization.

Clones. Glass Slide PCR. Purification. Array Printing. Post-process. Hybridize. Scan. Array Fabrication. Sample Preparation/Hybridization. Terminologies Reporter: the nucleotide sequence present in a particular location on the array (a.k.a. probe) Feature: the location of a reporter on the array Composite sequence: a set of reporters used

More information

Introduction to Genome Biology

Introduction to Genome Biology Introduction to Genome Biology Sandrine Dudoit, Wolfgang Huber, Robert Gentleman Bioconductor Short Course 2006 Copyright 2006, all rights reserved Outline Cells, chromosomes, and cell division DNA structure

More information

Bioinformatics for Biologists

Bioinformatics for Biologists Bioinformatics for Biologists Microarray Data Analysis. Lecture 1. Fran Lewitter, Ph.D. Director Bioinformatics and Research Computing Whitehead Institute Outline Introduction Working with microarray data

More information

Exercise on Microarray data analysis

Exercise on Microarray data analysis Exercise on Microarray data analysis Aim The aim of this exercise is to introduce basic data analysis of transcriptome data using the statistical software R. The exercise is divided in two parts. First,

More information

From hybridization theory to microarray data analysis: performance evaluation

From hybridization theory to microarray data analysis: performance evaluation RESEARCH ARTICLE Open Access From hybridization theory to microarray data analysis: performance evaluation Fabrice Berger * and Enrico Carlon * Abstract Background: Several preprocessing methods are available

More information

Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods

Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods Some Principles for the Design and Analysis of Experiments using Gene Expression Arrays and Other High-Throughput Assay Methods SPH 247 Statistical Analysis of Laboratory Data April 21, 2015 1 The -Omics

More information

Microarray analysis challenges.

Microarray analysis challenges. Microarray analysis challenges. While not quite as bad as my hobby of ice climbing you, need the right equipment! T. F. Smith Bioinformatics Boston Univ. Experimental Design Issues Reference and Controls

More information

Improvements to the RMA Algorithm for Gene Expression Microarray Background Correction

Improvements to the RMA Algorithm for Gene Expression Microarray Background Correction Improvements to the RMA Algorithm for Gene Expression Microarray Background Correction Monnie McGee & Zhongxue Chen Department of Statistical Science Southern Methodist University MSU Seminar November

More information

What does PLIER really do?

What does PLIER really do? What does PLIER really do? Terry M. Therneau Karla V. Ballman Technical Report #75 November 2005 Copyright 2005 Mayo Foundation 1 Abstract Motivation: Our goal was to understand why the PLIER algorithm

More information

Microarrays & Gene Expression Analysis

Microarrays & Gene Expression Analysis Microarrays & Gene Expression Analysis Contents DNA microarray technique Why measure gene expression Clustering algorithms Relation to Cancer SAGE SBH Sequencing By Hybridization DNA Microarrays 1. Developed

More information

Supplementary Methods

Supplementary Methods Supplementary Methods Microarray Data Analysis Gene expression data were obtained by hybridising a total of 24 samples from 6 experimental groups (n=4 per group) to Illumina HumanHT-12 Expression BeadChips.

More information

Microarrays: since we use probes we obviously must know the sequences we are looking at!

Microarrays: since we use probes we obviously must know the sequences we are looking at! These background are needed: 1. - Basic Molecular Biology & Genetics DNA replication Transcription Post-transcriptional RNA processing Translation Post-translational protein modification Gene expression

More information

Biology 644: Bioinformatics

Biology 644: Bioinformatics Measure of the linear correlation (dependence) between two variables X and Y Takes a value between +1 and 1 inclusive 1 = total positive correlation 0 = no correlation 1 = total negative correlation. When

More information

Identifying Candidate Informative Genes for Biomarker Prediction of Liver Cancer

Identifying Candidate Informative Genes for Biomarker Prediction of Liver Cancer Identifying Candidate Informative Genes for Biomarker Prediction of Liver Cancer Nagwan M. Abdel Samee 1, Nahed H. Solouma 2, Mahmoud Elhefnawy 3, Abdalla S. Ahmed 4, Yasser M. Kadah 5 1 Computer Engineering

More information

Gene expression profiling experiments:

Gene expression profiling experiments: Gene expression profiling experiments: Problems, pitfalls, and solutions. Heli Borg The Alternatives in Microarray Experiments bacteria - eucaryots non poly(a) + - poly(a) + oligonucleotide Affymetrix

More information

Basics of RNA-Seq. (With a Focus on Application to Single Cell RNA-Seq) Michael Kelly, PhD Team Lead, NCI Single Cell Analysis Facility

Basics of RNA-Seq. (With a Focus on Application to Single Cell RNA-Seq) Michael Kelly, PhD Team Lead, NCI Single Cell Analysis Facility 2018 ABRF Meeting Satellite Workshop 4 Bridging the Gap: Isolation to Translation (Single Cell RNA-Seq) Sunday, April 22 Basics of RNA-Seq (With a Focus on Application to Single Cell RNA-Seq) Michael Kelly,

More information

Technical Review. Real time PCR

Technical Review. Real time PCR Technical Review Real time PCR Normal PCR: Analyze with agarose gel Normal PCR vs Real time PCR Real-time PCR, also known as quantitative PCR (qpcr) or kinetic PCR Key feature: Used to amplify and simultaneously

More information

RNA-Seq Analysis. Simon Andrews, Laura v

RNA-Seq Analysis. Simon Andrews, Laura v RNA-Seq Analysis Simon Andrews, Laura Biggins simon.andrews@babraham.ac.uk @simon_andrews v2018-10 RNA-Seq Libraries rrna depleted mrna Fragment u u u u NNNN Random prime + RT 2 nd strand synthesis (+

More information

Computing with large data sets

Computing with large data sets Computing with large data sets Richard Bonneau, spring 2009 Lecture 16 (week 10): bioconductor: an example R multi-developer project Acknowledgments and other sources: Ben Bolstad, Biostats lectures, Berkely

More information

Methods of Biomaterials Testing Lesson 3-5. Biochemical Methods - Molecular Biology -

Methods of Biomaterials Testing Lesson 3-5. Biochemical Methods - Molecular Biology - Methods of Biomaterials Testing Lesson 3-5 Biochemical Methods - Molecular Biology - Chromosomes in the Cell Nucleus DNA in the Chromosome Deoxyribonucleic Acid (DNA) DNA has double-helix structure The

More information

Microarray. Key components Array Probes Detection system. Normalisation. Data-analysis - ratio generation

Microarray. Key components Array Probes Detection system. Normalisation. Data-analysis - ratio generation Microarray Key components Array Probes Detection system Normalisation Data-analysis - ratio generation MICROARRAY Measures Gene Expression Global - Genome wide scale Why Measure Gene Expression? What information

More information