Probe-Level Analysis of Affymetrix GeneChip Microarray Data

Size: px
Start display at page:

Download "Probe-Level Analysis of Affymetrix GeneChip Microarray Data"

Transcription

1 Probe-Level Analysis of Affymetrix GeneChip Microarray Data Ben Bolstad Michigan State University February 15, 2005

2 Outline for Today's Talk A brief introduction to microarrays and the Affymetrix GeneChip Technology Pre-processing Background Correction Normalization Probe Level Modeling and its applications

3 The Human Genome The cell is the fundamental working unit of every living organism. Humans: trillions of cells (metazoa); other organisms like yeast: one cell (protozoa). Cells are of many different types (e.g. blood, skin, nerve cells), but all can be traced back to a single cell, the fertilized egg.

4 Genes The human genome is distributed along 23 pairs of chromosomes. 22 autosomal pairs; the sex chromosome pair, XX for females and XY for males. In each pair, one chromosome is paternally inherited, the other maternally inherited. Chromosomes are made of compressed and entwined DNA. A (protein-coding) gene is a segment of chromosomal DNA that directs the synthesis of a protein.

5 Chromosomes and DNA

6 DNA A deoxyribonucleic acid or DNA molecule is a double-stranded polymer composed of four basic molecular units called nucleotides. Each nucleotide comprises a phosphate group, a deoxyribose sugar, and one of four nitrogen bases: adenine (A), guanine (G), cytosine (C), and thymine (T). The two chains are held together by hydrogen bonds between nitrogen bases. Base-pairing occurs according to the following rule: G pairs with C, and A pairs with T.

7

8 Exons and introns Genes comprise only about 2% of the human genome; the rest consists of noncoding regions, whose functions may include providing chromosomal structural integrity and regulating when, where, and in what quantity proteins are made (regulatory regions). The terms exon and intron refer to coding (translated into a protein) and noncoding DNA, respectively.

9 Differential expression Each cell contains a complete copy of the organism's genome. Cells are of many different types and states E.g. blood, nerve, and skin cells, dividing cells, cancerous cells, etc. What makes the cells different? Differential gene expression, i.e., when, where, and in what quantity each gene is expressed. On average, 40% of our genes are expressed at any given time.

10 Functional genomics The various genome projects have yielded the complete DNA sequences of many organisms. E.g. human, mouse, yeast, fruitfly, etc. Human: 3 billion base-pairs, thousand genes. Challenge: go from sequence to function, i.e., define the role of each gene and understand how the genome functions as a whole.

11 Central dogma The expression of the genetic information stored in the DNA molecule occurs in two stages: (i) transcription, during which DNA is transcribed into mrna; (ii) translation, during which mrna is translated to produce a protein. DNA mrna protein Other important aspects of regulation: methylation, alternative splicing, etc. The correspondence between DNA's four-letter alphabet and a protein's twenty-letter alphabet is specified by the genetic code, which relates nucleotide triplets to amino acids.

12 Idea: measure the amount of mrna to see which genes are being expressed in (used by) the cell. Measuring protein might be better, but is currently harder.

13 RNA A ribonucleic acid or RNA molecule is a nucleic acid similar to DNA, but single-stranded; ribose sugar rather than deoxyribose sugar; uracil (U) replaces thymine (T) as one of the bases. RNA plays an important role in protein synthesis and other chemical activities of the cell. Several classes of RNA molecules, including messenger RNA (mrna), transfer RNA (trna), ribosomal RNA (rrna), and other small RNAs.

14 Affymetrix GeneChip Commericial mass produced high density oligonucleotide array technology developed by Affymetrix Some overview images courtesy of Affymetrix.

15 Probes and Probesets Typically 11 probe(pairs) in a probeset Latest GeneChips have as many as: 54,000 probesets 1.3 Million probes Counts for HG-U133A plus 2.0 arrays

16 Two Probe Types Reference Sequence TAGGTCTGTATGACAGACACAAAGAAGATG CAGACATAGTGTCTGTGTTTCTTCT CAGACATAGTGTGTGTGTTTCTTCT PM: the Perfect Match MM: the Mismatch

17 Constructing the Chip

18 Sample Preparation

19 Hybridization to the Chip

20 The Chip is Scanned

21 Chip dat file checkered board close up pixel selection

22 Chip cel file checkered board Courtesy: F. Colin

23 Levels of Analysis Probe level Unprocessed data (or minimal processing) Dataset is larger Often ignored or viewed as a black box. High level Processed data Dataset is smaller Most analysis seems to start here

24 High-Level Analysis Clustering/Classification Pathway Analysis Cell Cycle Gene function Anything where a more biological interpretation is desired These are important topics, but such matters will not be discussed further in today's talk.

25 Probe-Level Analysis What is Probe-level analysis? Analysis and manipulation of probe intensity data Expression calculation: Background, Normalization, Summarization Fitting models to probe intensity data Quality control diagnostics Why do we do it? Hopefully it will allow us to produce better, more biologically meaningful gene expression values We want accurate (low bias) and precise (low variance) gene expression estimates Is there additional information at the probe-level that we might otherwise throw away?

26 RMA Background Approach Convolution Model = + Observed O 2 a o, b Signal S ( ) a o a φ E( ) b φ b SO= o = a+ b a o a Φ 1 b +Φ b = μ σ α = σ Noise N ( 2 ) Exp α N μ, σ

27 Normalization Non-biological factors can contribute to the variability of data... In order to reliably compare data from multiple probe arrays, differences of non-biological origin must be minimized. 1 Normalization is a process of reducing unwanted variation across chips. It may use information from multiple chips 1 GeneChip 3.1 Expression Analysis Algorithm Tutorial, Affymetrix technical support

28 Non-Biological Variability 5 scanners for 6 dilution groups

29 Quantile Normalization Normalize so that the quantiles of each chip are equal. Simple and fast algorithm. Goal is to give same distribution to each chip. Original Distribution Target Distribution

30 It works!! Unnormalized Scaled Quantile Normalization

31 General Probe Level Model y kij = f( X) + ε kij Where f(x) is function of factor (and possibly covariate) variables (our interest will be in linear functions) y kij is a pre-processed probe intensity (usually log scale) Assume that E = 0 ε kij = 2 Var εkij σ k

32 Parallel Behavior Suggests Multi-chip Model

33 Probe Pattern Suggests Including Probe-Effect

34 Also Want Robustness

35 Summarization Problem: Calculating gene expression values. How do we reduce the probe intensities for each probeset on to a gene expression value? Our Approach: RMA

36 What is RMA? 1. Convolution Background 2. Quantile Normalization 3. Probe Level Linear model on the log2 scale fit robustly. Software Bioconductor affy package RMAExpress Also available in some commercial software eg S+ ArrayAnalzyer, Iobian GeneTraffic

37 The RMA model y = m + α + β + ε kij k ki kj kij where y kij α ki ( ( )) = log 2 N B PMkij is a probe-effect i= 1,,I is chip-effect ( m + β is log2 gene expression on array j) j=1,,j k=1,,k is the number of probesets βkj k kj

38 RMA mostly does well in practice Detecting Differential Expression Not noisy in low intensities RMA MAS 5.0

39 One Drawback RMA MAS 5.0 Some fixes for this are being developed see GCRMA (Irizarry and Wu, JHU)

40 Median Polish Algorithm y11 L y1 J 0 M O M M yi1 L yij 0 0 L 0 0 Imposes Constraints Sweep Columns Iterate medianα = median β = 0 i Sweep Rows median ε = median ε = 0 i ij j ij j ˆ ε L ˆ ε αˆ 11 1J 1 M O M M ˆ ε ˆ ˆ I1 L ε α IJ I ˆ ˆ β L β mˆ 1 J

41 Advantages Fast Very robust Disadvantages Median Polish No algorithmic flexibility to fit alternative models No standard error estimates

42 An Alternative Method for Fitting a PLM Robust regression using M-estimation In this talk, we will use Huber s influence function ψ. The software handles many more. Fitting algorithm is IRLS with weights dependent on current residuals ( r ) Software for fitting such models is part of BioConductor package affyplm ψ r kij kij

43 Variance Covariance Estimates Suppose model is Y = Xβ + ε Huber (1981) gives three forms for estimating variance covariance matrix 2 κ 1/ ( n p) ψ ( r) 1/ n i i ψ ( r) i i 2 2 ( T X X ) 1 1/( n p) ψ ri i κ 1/ n ψ r i ( ) ( ) i 2 W 1 1 1/ ( ) ( ) ( T n p ψ r ) i W X X W κ i We will use this form T ' W = X Ψ X

44 We Will Focus on the Summarization PLM Array effect model Array Effect y = α + β + ε kij ki kj kij Pre-processed Log PM intensity With constraint I i= 1 α ki = Probe Effect 0

45 Detecting Differential Expression Problem: Given an experiment with two treatment groups correctly identify the differential genes without incorrectly choosing non differential genes. Question 1: How do different methods for DDE compare? Question 2: Can we do better using PLM s?

46 How Do We Know Which Genes are Differential? Spike-in datasets. Transcripts at known concentrations differing across arrays. Common background crna. Typically, Latin Square design

47 Affymetrix Spike-in Data 59 chips. All but 1 of the rows are done as triplicates A B C D E F G H I J K L M N O P Q R S T

48 X Testing for Differential Expression On a probeset by probeset basis compute a test statistic Should include something related to observed FC and some variability estimate l A t statistic: something of the form = β Ind( j group l) j Ind( j group l) t = X SE ie Average expression measures across arrays in group

49 Expression Values Based Statistics Fold Change X l X m FC Two Sample T-statistic s + n ( X l X m ) 2 2 l m l s n m T.std Simple Moderation 2 2 sl sm X X + + s nl nm ( l m) med T.mod Limma Ebayes T.ebayes Robust % s s % % % + n n ( X ) l Xm 2 2 l m l m T.robust

50 Probe Level Model Test Statistics Σ Suppose that is component of the variancecovariance matrix related to β Let c be the contrast vector defined such that the j th element of c is T 1 c β t n if array j is in group l PLM.1 = l J 2 1 if array j is in group m c jσ jj n m j= 1 0 otherwise T t PLM.2 = c β T c Σc

51 A First Comparison 8 chips from Affymetrix HG-U95A spike-in dataset 4 arrays for each of two concentration profiles Fit an array effect model to all 8 chips Compare the performance of the different methods by looking at all 3 vs 3 comparisons

52

53 What Happens as the Number of Arrays Increases? Expand comparison to all 24 Arrays with same concentration profiles from Affymetrix HG-U95A spike-in dataset Fit an array effect model to all 24 arrays Look at comparisons between equal number of chips

54

55

56

57 How About With More Real Data? GeneLogic Dilution/Mixture Dataset Learning Set Liver 30x VS CNS 30x 400 top genes truth 75:25 5x VS 25:75 5x Test Set Mixture Data Dilution Series Data

58 Mixture Data Results Method 3 vs 3 4 vs 4 5 vs 5 0% FP 5% FP AUC 0% FP 5% FP AUC 0% FP 5% FP AUC FC Std Robust Mod PLM PLM Ebayes

59 Moderation for the PLM test statistic Method 5 vs 5 0% FP 5% FP AUC PLM Ebayes PLM Moderated Σ = (1 p) Σ+ pλ mod λ is Σ averaged over all probesets

60 Quality Assessment Problem: Judge quality of chip data Question: Can we do this with the output of the Probe Level Modeling procedures?

61 Chip Pseudo-images

62 An Image Gallery Crop Circles Ring of Fire Tricolor

63 NUSE Plots Normalized Unscaled Standard Errors

64 RLE Plots Relative Log Expression

65 Discordant Probes

66 Discordant Arrays

67 Morals for Today s Talk The black box that is low-level processing is important. Your processing can have a significant effect on your final expression values and resulting conclusions. Testing for differential expression at the probe level can improve upon probeset-level testing. There is interesting quality assessment information at the probe-level

68 Ongoing Work in this Area Technology changes: What still works? What doesn t? Other probe-level models (eg Introduce sequence information, MM s) Tweaking the model fitting procedure to down weight poor performing probes across all chips Can we introduce the biology into the process (gene families? GO? etc)

69 Acknowledgements Terry Speed (UC Berkeley) Francois Colin Julia Brettschneider (UC Berkeley) Rafael Irizarry (Johns Hopkins) Bioconductor Core

70 Additional Slides

71 Background/Signal Adjustment A method which does some or all of the following Corrects for background noise, processing effects Adjusts for cross hybridization Adjust estimated expression values to fall on proper scale Probe intensities are used in background adjustment to compute correction (unlike cdna arrays where area surrounding spot might be used)

72 E Correction is given by ( ) SO= o = a+ b a= o, b= 2 μ σ α σ φ a o a φ b b a o a Φ +Φ 1 b b

73 Sort Sort columns of of original matrix Take averages across rows Take averages across rows Set Set average as as value for for All All elements in in the the row row Unsort columns of of matrix to to original order

74 It Reduces Variability Expression Values Fold change Also no serious bias effects. For more see Bolstad et al (2003)

75 Summarization Problem: Calculating gene expression values. How do we reduce the probe intensities for each probeset on to a gene expression value? Our Approach RMA a robust multi-chip linear model fit on the log scale Some Other Approaches Single chip AvDiff (Affymetrix) no longer recommended for use due to many flaws Mas 5.0 (Affymetrix) use a 1 step Tukey-biweight to combine the probe intensities in log scale Multiple Chip MBEI (Li-Wong dchip) a multiplicative model on natural scale

76 How Do We Know Which Genes are Differential? Spike-in datasets. Transcripts at known concentrations differing across arrays. Common background crna. Typically, Latin Square design Affymetrix HG-U95A GeneLogic AML bacterial spike-ins GeneLogic Tonsil bacterial spike-ins

77 Quality Assessment using PLM PLM quantities useful for assessing chip quality Weights Residuals Standard Errors Expression values relative to median chip

78 Chip Pseudo-images Weights Residuals Positive Residuals Negative Residuals

79 NUSE Plots Normalized Unscaled Standard Errors

80 RLE Plots Relative Log Expression

81 Probes and Probesets

82 Two Probe Types Reference Sequence TAGGTCTGTATGACAGACACAAAGAAGATG CAGACATAGTGTCTGTGTTTCTTCT CAGACATAGTGTGTGTGTTTCTTCT PM: the Perfect Match MM: the Mismatch

83 Probe Level Model test statistics t PLM.1 = J j= 1 T c β c 2 j Σ jj PLM.2 T t = c β T c Σc

84

85 A Larger Comparison Look at the entire 59 chips for Affymetrix HG-U95A spike-in dataset Examine two cases. After standard preprocessing Fit models for each pairwise comparison (individual models) Fit a model to all 59 chips (single model) There are 91 pairwise comparisions

86 Results Method Individual Models Single Model 0% FP 5% FP AUC 0% FP 5% FP AUC FC Std Robust Mod PLM PLM Ebayes

87 What is Going On Here? Examine residuals stratified by concentration group Spike-ins Randomly chosen non-differential probesets at low, medium and high average expression

88 Affymetrix Spike-ins

89 Low Non-Differential

90 Middle Non-Differential

91 High Non-Differential

92 Chip Pseudo-images

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

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

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

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

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

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

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

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

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

Algorithms in Bioinformatics

Algorithms in Bioinformatics Algorithms in Bioinformatics Sami Khuri Department of Computer Science San José State University San José, California, USA khuri@cs.sjsu.edu www.cs.sjsu.edu/faculty/khuri Outline Central Dogma of Molecular

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

Bundle 5 Test Review

Bundle 5 Test Review Bundle 5 Test Review DNA vs. RNA DNA Replication Gene Mutations- Protein Synthesis 1. Label the different components and complete the complimentary base pairing. What is this molecule called? _Nucleic

More information

CHAPTER 11 DNA NOTES PT. 4: PROTEIN SYNTHESIS TRANSCRIPTION & TRANSLATION

CHAPTER 11 DNA NOTES PT. 4: PROTEIN SYNTHESIS TRANSCRIPTION & TRANSLATION CHAPTER 11 DNA NOTES PT. 4: PROTEIN SYNTHESIS TRANSCRIPTION & TRANSLATION DNA and the Language of Life RECAP Synthesis= Making something Protein Synthesis= Making Proteins Three steps in Protein Synthesis

More information

What happens after DNA Replication??? Transcription, translation, gene expression/protein synthesis!!!!

What happens after DNA Replication??? Transcription, translation, gene expression/protein synthesis!!!! What happens after DNA Replication??? Transcription, translation, gene expression/protein synthesis!!!! Protein Synthesis/Gene Expression Why do we need to make proteins? To build parts for our body as

More information

RNA & PROTEIN SYNTHESIS

RNA & PROTEIN SYNTHESIS RNA & PROTEIN SYNTHESIS DNA & RNA Genes are coded DNA instructions that control the production of proteins within the cell. The first step in decoding these genetic messages is to copy part of the nucleotide

More information

PROTEIN SYNTHESIS Flow of Genetic Information The flow of genetic information can be symbolized as: DNA RNA Protein

PROTEIN SYNTHESIS Flow of Genetic Information The flow of genetic information can be symbolized as: DNA RNA Protein PROTEIN SYNTHESIS Flow of Genetic Information The flow of genetic information can be symbolized as: DNA RNA Protein This is also known as: The central dogma of molecular biology Protein Proteins are made

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

Genetics 101. Prepared by: James J. Messina, Ph.D., CCMHC, NCC, DCMHS Assistant Professor, Troy University, Tampa Bay Site

Genetics 101. Prepared by: James J. Messina, Ph.D., CCMHC, NCC, DCMHS Assistant Professor, Troy University, Tampa Bay Site Genetics 101 Prepared by: James J. Messina, Ph.D., CCMHC, NCC, DCMHS Assistant Professor, Troy University, Tampa Bay Site Before we get started! Genetics 101 Additional Resources http://www.genetichealth.com/

More information

Introduction to Microarray Data Analysis and Gene Networks. Alvis Brazma European Bioinformatics Institute

Introduction to Microarray Data Analysis and Gene Networks. Alvis Brazma European Bioinformatics Institute Introduction to Microarray Data Analysis and Gene Networks Alvis Brazma European Bioinformatics Institute A brief outline of this course What is gene expression, why it s important Microarrays and how

More information

DNA, Replication and RNA

DNA, Replication and RNA DNA, Replication and RNA The structure of DNA DNA, or Deoxyribonucleic Acid, is the blue prints for building all of life. DNA is a long molecule made up of units called NUCLEOTIDES. Each nucleotide is

More information

Protein Synthesis: Transcription and Translation

Protein Synthesis: Transcription and Translation Protein Synthesis: Transcription and Translation Proteins In living things, proteins are in charge of the expression of our traits (hair/eye color, ability to make insulin, predisposition for cancer, etc.)

More information

The common structure of a DNA nucleotide. Hewitt

The common structure of a DNA nucleotide. Hewitt GENETICS Unless otherwise noted* the artwork and photographs in this slide show are original and by Burt Carter. Permission is granted to use them for non-commercial, non-profit educational purposes provided

More information

DNA Structure and Replication, and Virus Structure and Replication Test Review

DNA Structure and Replication, and Virus Structure and Replication Test Review DNA Structure and Replication, and Virus Structure and Replication Test Review What does DNA stand for? Deoxyribonucleic Acid DNA is what type of macromolecule? DNA is a nucleic acid The building blocks

More information

What Are the Chemical Structures and Functions of Nucleic Acids?

What Are the Chemical Structures and Functions of Nucleic Acids? THE NUCLEIC ACIDS What Are the Chemical Structures and Functions of Nucleic Acids? Nucleic acids are polymers specialized for the storage, transmission, and use of genetic information. DNA = deoxyribonucleic

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

Chapter 12. DNA TRANSCRIPTION and TRANSLATION

Chapter 12. DNA TRANSCRIPTION and TRANSLATION Chapter 12 DNA TRANSCRIPTION and TRANSLATION 12-3 RNA and Protein Synthesis WARM UP What are proteins? Where do they come from? From DNA to RNA to Protein DNA in our cells carry the instructions for making

More information

Ch 10.4 Protein Synthesis

Ch 10.4 Protein Synthesis Ch 10.4 Protein Synthesis I) Flow of Genetic Information A) DNA is made into RNA which undergoes transcription and translation to be made into a protein. II) RNA Structure and Function A) RNA contains

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

DNA. translation. base pairing rules for DNA Replication. thymine. cytosine. amino acids. The building blocks of proteins are?

DNA. translation. base pairing rules for DNA Replication. thymine. cytosine. amino acids. The building blocks of proteins are? 2 strands, has the 5-carbon sugar deoxyribose, and has the nitrogen base Thymine. The actual process of assembling the proteins on the ribosome is called? DNA translation Adenine pairs with Thymine, Thymine

More information

DNA - DEOXYRIBONUCLEIC ACID

DNA - DEOXYRIBONUCLEIC ACID DNA - DEOXYRIBONUCLEIC ACID blueprint of life (has the instructions for making an organism) established by James Watson and Francis Crick codes for your genes shape of a double helix made of repeating

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

Nucleic Acids: DNA and RNA

Nucleic Acids: DNA and RNA Nucleic Acids: DNA and RNA Living organisms are complex systems. Hundreds of thousands of proteins exist inside each one of us to help carry out our daily functions. These proteins are produced locally,

More information

DNA and RNA. Chapter 12

DNA and RNA. Chapter 12 DNA and RNA Chapter 12 History of DNA Late 1800 s scientists discovered that DNA is in the nucleus of the cell 1902 Walter Sutton proposed that hereditary material resided in the chromosomes in the nucleus

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

DNA RNA PROTEIN. Professor Andrea Garrison Biology 11 Illustrations 2010 Pearson Education, Inc. unless otherwise noted

DNA RNA PROTEIN. Professor Andrea Garrison Biology 11 Illustrations 2010 Pearson Education, Inc. unless otherwise noted DNA RNA PROTEIN Professor Andrea Garrison Biology 11 Illustrations 2010 Pearson Education, Inc. unless otherwise noted DNA Molecule of heredity Contains all the genetic info our cells inherit Determines

More information

translation The building blocks of proteins are? amino acids nitrogen containing bases like A, G, T, C, and U Complementary base pairing links

translation The building blocks of proteins are? amino acids nitrogen containing bases like A, G, T, C, and U Complementary base pairing links The actual process of assembling the proteins on the ribosome is called? translation The building blocks of proteins are? Complementary base pairing links Define and name the Purines amino acids nitrogen

More information

Independent Study Guide The Blueprint of Life, from DNA to Protein (Chapter 7)

Independent Study Guide The Blueprint of Life, from DNA to Protein (Chapter 7) Independent Study Guide The Blueprint of Life, from DNA to Protein (Chapter 7) I. General Principles (Chapter 7 introduction) a. Morse code distinct series of dots and dashes encode the 26 letters of the

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

Review of Old Information: What is the monomer and polymer of: Macromolecule Monomer Polymer Carbohydrate Lipid Protein

Review of Old Information: What is the monomer and polymer of: Macromolecule Monomer Polymer Carbohydrate Lipid Protein Section 1.8 Question of the Day: Name: Review of Old Information: What is the monomer and polymer of: Macromolecule Monomer Polymer Carbohydrate Lipid Protein New Information: One of the most important

More information

Nucleic acids and protein synthesis

Nucleic acids and protein synthesis THE FUNCTIONS OF DNA Nucleic acids and protein synthesis The full name of DNA is deoxyribonucleic acid. Every nucleotide has the same sugar molecule and phosphate group, but each nucleotide contains one

More information

GENETICS 1 Classification, Heredity, DNA & RNA. Classification, Objectives At the end of this sub section you should be able to: Heredity, DNA and RNA

GENETICS 1 Classification, Heredity, DNA & RNA. Classification, Objectives At the end of this sub section you should be able to: Heredity, DNA and RNA Classification, Heredity, DNA and Objectives At the end of this sub section you should be able to: RNA Heredity and Variation Gene Expression DNA structure DNA Profiling Protein Synthesis 1. Discuss the

More information

DNA vs. RNA B-4.1. Compare DNA and RNA in terms of structure, nucleotides and base pairs.

DNA vs. RNA B-4.1. Compare DNA and RNA in terms of structure, nucleotides and base pairs. DNA vs. RNA B-4.1 Compare DNA and RNA in terms of structure, nucleotides and base pairs. Key Concepts l Nucleic Acids: l deoxyribonucleic acid (DNA) l ribonucleic acid (RNA) l Nucleotides: l nitrogen base,

More information

DNA - The Double Helix

DNA - The Double Helix DNA - The Double Helix Recall that the nucleus is a small spherical, dense body in a cell. It is often called the "control center" because it controls all the activities of the cell including cell reproduction,

More information

Do you remember. What is a gene? What is RNA? How does it differ from DNA? What is protein?

Do you remember. What is a gene? What is RNA? How does it differ from DNA? What is protein? Lesson 1 - RNA Do you remember What is a gene? What is RNA? How does it differ from DNA? What is protein? Gene Segment of DNA that codes for building a protein DNA code is copied into RNA form, and RNA

More information

DNA. Name: Class: Date: Multiple Choice Identify the choice that best completes the statement or answers the question.

DNA. Name: Class: Date: Multiple Choice Identify the choice that best completes the statement or answers the question. Class: Date: DNA Multiple Choice Identify the choice that best completes the statement or answers the question. 1. Which one of the following nucleotide pair bonds would be found in a DNA molecule? a.

More information

DNA and RNA 2/14/2017. What is a Nucleic Acid? Parts of Nucleic Acid. DNA Structure. RNA Structure. DNA vs RNA. Nitrogen bases.

DNA and RNA 2/14/2017. What is a Nucleic Acid? Parts of Nucleic Acid. DNA Structure. RNA Structure. DNA vs RNA. Nitrogen bases. DNA and RNA Nucleic Acids What is a Nucleic Acid? Nucleic Acids are organic molecules that carry information needed to make proteins Remember: proteins carry out ALL cellular activity There are two types

More information

DNA Function: Information Transmission

DNA Function: Information Transmission DNA Function: Information Transmission DNA is called the code of life. What does it code for? *the information ( code ) to make proteins! Why are proteins so important? Nearly every function of a living

More information

Chapter 10: Gene Expression and Regulation

Chapter 10: Gene Expression and Regulation Chapter 10: Gene Expression and Regulation Fact 1: DNA contains information but is unable to carry out actions Fact 2: Proteins are the workhorses but contain no information THUS Information in DNA must

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

DNA - The Double Helix

DNA - The Double Helix Name Date Period DNA - The Double Helix Recall that the nucleus is a small spherical, dense body in a cell. It is often called the "control center" because it controls all the activities of the cell including

More information

DNA - The Double Helix

DNA - The Double Helix DNA - The Double Helix Recall that the nucleus is a small spherical, dense body in a cell. It is often called the "control center" because it controls all the activities of the cell including cell reproduction,

More information

NUCLEIC ACID. Subtitle

NUCLEIC ACID. Subtitle NUCLEIC ACID Subtitle NUCLEIC ACID Building blocks of living organisms One of the four important biomolecule 1 st isolated from the nuclei of white blood cells by Friedrich Miescher (1860) Came from the

More information

Higher Human Biology Unit 1: Human Cells Pupils Learning Outcomes

Higher Human Biology Unit 1: Human Cells Pupils Learning Outcomes Higher Human Biology Unit 1: Human Cells Pupils Learning Outcomes 1.1 Division and Differentiation in Human Cells I can state that cellular differentiation is the process by which a cell develops more

More information

Nucleic acids deoxyribonucleic acid (DNA) ribonucleic acid (RNA) nucleotide

Nucleic acids deoxyribonucleic acid (DNA) ribonucleic acid (RNA) nucleotide Nucleic Acids Nucleic acids are molecules that store information for cellular growth and reproduction There are two types of nucleic acids: - deoxyribonucleic acid (DNA) and ribonucleic acid (RNA) These

More information

RNA and Protein Synthesis

RNA and Protein Synthesis RNA and Protein Synthesis CTE: Agriculture and Natural Resources: C5.3 Understand various cell actions, such as osmosis and cell division. C5.4 Compare and contrast plant and animal cells, bacteria, and

More information

Chapter 13 - Concept Mapping

Chapter 13 - Concept Mapping Chapter 13 - Concept Mapping Using the terms and phrases provided below, complete the concept map showing the discovery of DNA structure. amount of base pairs five-carbon sugar purine DNA polymerases Franklin

More information

Replication Review. 1. What is DNA Replication? 2. Where does DNA Replication take place in eukaryotic cells?

Replication Review. 1. What is DNA Replication? 2. Where does DNA Replication take place in eukaryotic cells? Replication Review 1. What is DNA Replication? 2. Where does DNA Replication take place in eukaryotic cells? 3. Where does DNA Replication take place in the cell cycle? 4. 4. What guides DNA Replication?

More information

Protein Synthesis. OpenStax College

Protein Synthesis. OpenStax College OpenStax-CNX module: m46032 1 Protein Synthesis OpenStax College This work is produced by OpenStax-CNX and licensed under the Creative Commons Attribution License 3.0 By the end of this section, you will

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

PROTEIN SYNTHESIS. copyright cmassengale

PROTEIN SYNTHESIS. copyright cmassengale PROTEIN SYNTHESIS 1 DNA and Genes 2 Roles of RNA and DNA DNA is the MASTER PLAN RNA is the BLUEPRINT of the Master Plan 3 RNA Differs from DNA RNA has a sugar ribose DNA has a sugar deoxyribose 4 Other

More information

PROTEIN SYNTHESIS. copyright cmassengale

PROTEIN SYNTHESIS. copyright cmassengale PROTEIN SYNTHESIS 1 DNA and Genes 2 Roles of RNA and DNA DNA is the MASTER PLAN RNA is the BLUEPRINT of the Master Plan 3 RNA Differs from DNA RNA has a sugar ribose DNA has a sugar deoxyribose 4 Other

More information

Review? - What are the four macromolecules?

Review? - What are the four macromolecules? Review? - What are the four macromolecules? Lipids Carbohydrates Protein Nucleic Acids What is the monomer of nucleic acids and what do nucleic acids make up? Nucleotides; DNA and RNA 12-1 DNA DNA Stands

More information

NON MENDELIAN GENETICS. DNA, PROTEIN SYNTHESIS, MUTATIONS DUE DECEMBER 8TH

NON MENDELIAN GENETICS. DNA, PROTEIN SYNTHESIS, MUTATIONS DUE DECEMBER 8TH NON MENDELIAN GENETICS. DNA, PROTEIN SYNTHESIS, MUTATIONS DUE DECEMBER 8TH MONDAY TUESDAY WEDNESDAY THURSDAY FRIDAY 11/14 11/15 11/16 11/17 11/18 Non-Mendelian Genetics DNA Structure and Replication 11/28

More information

Name: Date: Pd: Nucleic acids

Name: Date: Pd: Nucleic acids Name: Date: Pd: DNA - The Double Helix Nucleic acids Recall that the nucleus is a small spherical, dense body in a cell. It is often called the "control center" because it controls all the activities of

More information

DNA - The Double Helix

DNA - The Double Helix DNA - The Double Helix Recall that the nucleus is a small spherical, dense body in a cell. It is often called the "control center" because it controls all the activities of the cell including cell reproduction,

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 Structure & the Genome. Bio160 General Biology

DNA Structure & the Genome. Bio160 General Biology DNA Structure & the Genome Bio160 General Biology Lecture Outline I. DNA A nucleic acid II. Chromosome Structure III. Chromosomes and Genes IV. DNA vs. RNA I. DNA A Nucleic Acid Structure of DNA: Remember:

More information

Transcription Eukaryotic Cells

Transcription Eukaryotic Cells Transcription Eukaryotic Cells Packet #20 1 Introduction Transcription is the process in which genetic information, stored in a strand of DNA (gene), is copied into a strand of RNA. Protein-encoding genes

More information

Gene Expression. Student:

Gene Expression. Student: Gene Expression Student: 1. A ribozyme is A. a section of the DNA that is expressed in the mrna. B. a self-splicing intron that acts like an enzyme. C. a complex made up of many ribosomes replicating the

More information

DNA DNA Profiling 18. Discuss the stages involved in DNA profiling 19. Define the process of DNA profiling 20. Give two uses of DNA profiling

DNA DNA Profiling 18. Discuss the stages involved in DNA profiling 19. Define the process of DNA profiling 20. Give two uses of DNA profiling Name: 2.5 Genetics Objectives At the end of this sub section students should be able to: 2.5.1 Heredity and Variation 1. Discuss the diversity of organisms 2. Define the term species 3. Distinguish between

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

Central Dogma. 1. Human genetic material is represented in the diagram below.

Central Dogma. 1. Human genetic material is represented in the diagram below. Central Dogma 1. Human genetic material is represented in the diagram below. 4. If 15% of a DNA sample is made up of thymine, T, what percentage of the sample is made up of cytosine, C? A) 15% B) 35% C)

More information

How do we know what the structure and function of DNA is? - Double helix, base pairs, sugar, and phosphate - Stores genetic information

How do we know what the structure and function of DNA is? - Double helix, base pairs, sugar, and phosphate - Stores genetic information DNA: CH 13 How do we know what the structure and function of DNA is? - Double helix, base pairs, sugar, and phosphate - Stores genetic information Discovering DNA s Function 1928: Frederick Griffith studied

More information

BIOB111 - Tutorial activity for Session 13

BIOB111 - Tutorial activity for Session 13 BIOB111 - Tutorial activity for Session 13 General topics for week 7 Session 13: Types of nucleic acids, DNA replication Useful links: 1. Visit this website and use its menu to locate information and practice

More information

DNA is the genetic material. DNA structure. Chapter 7: DNA Replication, Transcription & Translation; Mutations & Ames test

DNA is the genetic material. DNA structure. Chapter 7: DNA Replication, Transcription & Translation; Mutations & Ames test DNA is the genetic material Chapter 7: DNA Replication, Transcription & Translation; Mutations & Ames test Dr. Amy Rogers Bio 139 General Microbiology Hereditary information is carried by DNA Griffith/Avery

More information

GENETICS and the DNA code NOTES

GENETICS and the DNA code NOTES GENETICS and the DNA code NOTES BACKGROUND DNA is the hereditary material of most organisms. It is an organic compound made of two strands, twisted around one another to form a double helix. Each strand

More information

How can something so small cause problems so large?

How can something so small cause problems so large? How can something so small cause problems so large? Objectives Identify the structural components of DNA and relate to its function Create and ask questions about a model of DNA DNA is made of genes. Gene

More information

The Double Helix. DNA and RNA, part 2. Part A. Hint 1. The difference between purines and pyrimidines. Hint 2. Distinguish purines from pyrimidines

The Double Helix. DNA and RNA, part 2. Part A. Hint 1. The difference between purines and pyrimidines. Hint 2. Distinguish purines from pyrimidines DNA and RNA, part 2 Due: 3:00pm on Wednesday, September 24, 2014 You will receive no credit for items you complete after the assignment is due. Grading Policy The Double Helix DNA, or deoxyribonucleic

More information

Chapter 8: DNA and RNA

Chapter 8: DNA and RNA Chapter 8: DNA and RNA Lecture Outline Enger, E. D., Ross, F. C., & Bailey, D. B. (2012). Concepts in biology (14th ed.). New York: McGraw- Hill. 1 8-1 DNA and the Importance of Proteins Proteins play

More information

Neurospora mutants. Beadle & Tatum: Neurospora molds. Mutant A: Mutant B: HOW? Neurospora mutants

Neurospora mutants. Beadle & Tatum: Neurospora molds. Mutant A: Mutant B: HOW? Neurospora mutants Chapter 10: Central Dogma Gene Expression and Regulation Mutant A: Neurospora mutants Mutant B: Not made Not made Fact 1: DNA contains information but is unable to carry out actions Fact 2: Proteins are

More information

Click here to read the case study about protein synthesis.

Click here to read the case study about protein synthesis. Click here to read the case study about protein synthesis. Big Question: How do cells use the genetic information stored in DNA to make millions of different proteins the body needs? Key Concept: Genetics

More information

Protein Synthesis. DNA to RNA to Protein

Protein Synthesis. DNA to RNA to Protein Protein Synthesis DNA to RNA to Protein From Genes to Proteins Processing the information contained in DNA into proteins involves a sequence of events known as gene expression and results in protein synthesis.

More information

Name: Class: Date: ID: A

Name: Class: Date: ID: A Class: _ Date: _ CH 12 Review Multiple Choice Identify the choice that best completes the statement or answers the question. 1. How many codons are needed to specify three amino acids? a. 6 c. 3 b. 12

More information

Bundle 6 Test Review

Bundle 6 Test Review Bundle 6 Test Review DNA vs. RNA DNA Replication Gene Mutations- Protein Synthesis 1. Label the different components and complete the complimentary base pairing. What is this molecule called? Deoxyribonucleic

More information

Comparing RNA and DNA

Comparing RNA and DNA RNA The Role of RNA Genes contain coded DNA instructions that tell cells how to build proteins. 1 st step in decoding these genetic instructions = copy part of the base sequence from DNA into RNA. 2 nd

More information

THE CELLULAR AND MOLECULAR BASIS OF INHERITANCE

THE CELLULAR AND MOLECULAR BASIS OF INHERITANCE Umm AL Qura University THE CELLULAR AND MOLECULAR BASIS OF INHERITANCE Dr. Neda Bogari www.bogari.net EMERY'S ELEMENTS OF MEDICAL GENETICS Peter Turnpenny and Sian Ellard 13 th edition 2008 COURSE SYLLABUS

More information

Chapter 10 - Molecular Biology of the Gene

Chapter 10 - Molecular Biology of the Gene Bio 100 - Molecular Genetics 1 A. Bacterial Transformation Chapter 10 - Molecular Biology of the Gene Researchers found that they could transfer an inherited characteristic (e.g. the ability to cause pneumonia),

More information

Chapter 6. Genes and DNA. Table of Contents. Section 1 What Does DNA Look Like? Section 2 How DNA Works

Chapter 6. Genes and DNA. Table of Contents. Section 1 What Does DNA Look Like? Section 2 How DNA Works Genes and DNA Table of Contents Section 1 What Does DNA Look Like? Section 1 What Does DNA Look Like? Objectives List three important events that led to understanding the structure of DNA. Describe the

More information

DNA RNA PROTEIN SYNTHESIS -NOTES-

DNA RNA PROTEIN SYNTHESIS -NOTES- DNA RNA PROTEIN SYNTHESIS -NOTES- THE COMPONENTS AND STRUCTURE OF DNA DNA is made up of units called nucleotides. Nucleotides are made up of three basic components:, called deoxyribose in DNA In DNA, there

More information

DNA, RNA, PROTEIN SYNTHESIS, AND MUTATIONS UNIT GUIDE Due December 9 th. Monday Tuesday Wednesday Thursday Friday 16 CBA History of DNA video

DNA, RNA, PROTEIN SYNTHESIS, AND MUTATIONS UNIT GUIDE Due December 9 th. Monday Tuesday Wednesday Thursday Friday 16 CBA History of DNA video DNA, RNA, PROTEIN SYNTHESIS, AND MUTATIONS UNIT GUIDE Due December 9 th Monday Tuesday Wednesday Thursday Friday 16 CBA History of DNA video 17 History of DNA 18 Lecture: DNA Structure Worksheet 19 Lecture:

More information

Protein Synthesis

Protein Synthesis HEBISD Student Expectations: Identify that RNA Is a nucleic acid with a single strand of nucleotides Contains the 5-carbon sugar ribose Contains the nitrogen bases A, G, C and U instead of T. The U is

More information

STATC 141 Spring 2005, April 5 th Lecture notes on Affymetrix arrays. Materials are from

STATC 141 Spring 2005, April 5 th Lecture notes on Affymetrix arrays. Materials are from STATC 141 Spring 2005, April 5 th Lecture notes on Affymetrix arrays Materials are from http://www.ohsu.edu/gmsr/amc/amc_technology.html The GeneChip high-density oligonucleotide arrays are fabricated

More information

Adv Biology: DNA and RNA Study Guide

Adv Biology: DNA and RNA Study Guide Adv Biology: DNA and RNA Study Guide Chapter 12 Vocabulary -Notes What experiments led up to the discovery of DNA being the hereditary material? o The discovery that DNA is the genetic code involved many

More information

RNA Structure and the Versatility of RNA. Mitesh Shrestha

RNA Structure and the Versatility of RNA. Mitesh Shrestha RNA Structure and the Versatility of RNA Mitesh Shrestha Ribonucleic Acid (RNA) Nitrogenous Bases (Adenine, Uracil, Guanine, Cytosine) Ribose Sugar Ribonucleic Acid (RNA) Phosphate Group RNA world Hypothesis

More information

Chapter 13. From DNA to Protein

Chapter 13. From DNA to Protein Chapter 13 From DNA to Protein Proteins All proteins consist of polypeptide chains A linear sequence of amino acids Each chain corresponds to the nucleotide base sequenceof a gene The Path From Genes to

More information

Transcription and Translation

Transcription and Translation Biology Name: Morales Date: Period: Transcription and Translation Directions: Read the following and answer the questions in complete sentences. DNA is the molecule of heredity it determines an organism

More information

LABS 9 AND 10 DNA STRUCTURE AND REPLICATION; RNA AND PROTEIN SYNTHESIS

LABS 9 AND 10 DNA STRUCTURE AND REPLICATION; RNA AND PROTEIN SYNTHESIS LABS 9 AND 10 DNA STRUCTURE AND REPLICATION; RNA AND PROTEIN SYNTHESIS OBJECTIVE 1. OBJECTIVE 2. OBJECTIVE 3. OBJECTIVE 4. Describe the structure of DNA. Explain how DNA replicates. Understand the structure

More information