ENGR 213 Bioengineering Fundamentals April 25, A very coarse introduction to bioinformatics

Size: px
Start display at page:

Download "ENGR 213 Bioengineering Fundamentals April 25, A very coarse introduction to bioinformatics"

Transcription

1 A very coarse introduction to bioinformatics In this exercise, you will get a quick primer on how DNA is used to manufacture proteins. You will learn a little bit about how the building blocks of these proteins may change due to point mutations. And, you will investigate how a statistical description of these mutations can be used as evidence supporting hypothesized evolutionary paths. Summary of genetic machinery DNA sequences are composed of four bases: adenine (A), thymine (T), guanine (G), and cytosine (C). The two strands of DNA are composed of nucleotides with complementary bases where A is matched up with T and C is matched up with G. An example of the two strands of a fragment of DNA is shown here: DNA (3' end)...cacctacgttcaggaggtcaggactggtac... (5' end) (5' end)...gtggatgcaagtcctccagtcctgaccatg... (3' end) A DNA sequence is transcribed into mrna starting at the 3' end of the DNA strand. Each nucleotide of the DNA strand attracts its complementary RNA base through a pairing rule. mrna is composed of A, G, and C bases with uracine (U) substituted for thymine. The pairing rule is shown below: DNA -> mrna A U T A G C C G DNA (3' end)...cacctacgttcaggaggtcaggactggtac... (5' end) mrna (5' end)...guggaugcaaguccuccaguccugaccaug... (3' end) mrna is translated into a sequence of amino acids by ribosomes. This process is initiated by a ribosome with the amino acid methionine attached to it. This ribosome latches onto the 5' end of the mrna strand and begins to move downstream until it finds a sequence of three nucleotides, AUG, known as the start codon. This codon triggers the ribosome to start building a polypeptide with methionine as the first amino acid in the chain. The ribosome continues down the mrna strand by binding to the next triplet (without re-using any of the mrna nucleotides and matching each subsequent triplet with a particular amino acid. This continues until the ribosome reaches a stop codon signifying the end of the chain of amino acids which make up the particular protein coded by this genetic sequence. The triplets and their corresponding amino acids are displayed in the matrix on the following page.

2 An alternate way of visualizing this information is the codon wheel:

3 The red letters in the codon wheel are a simple code for each of the twenty amino acids that can be used to express the sequence of amino acids that comprise a single protein. The ribosome finds the beginning of the gene by looking for a start codon and then reads the mrna sequence as a series of triplets until it reaches a stop codon. start codon v mrna (5' end) GUGGAUGCAAGUCCUCCAGUCCUGACCAUG (3' end) mrna triplets AUG CAA GUC CUC CAG UCC UGA (start) (stop) Amino acids M Q V L Q S Notice that the codon table (or wheel) shows that there are two different mrna codes for glutamine (Q) which differ in the third base of the triplet. Either CAG or CAA triplets will cause a glutamine to be added to the polypeptide chain. There is redundancy in the codon for some amino acids but there is no ambiguity. Redundancy is actually a trait which protects the genetic code from some point mutations. A point mutation is characterized by the accidental substitution of a single nucleotide with another nucleotide. A point mutation is responsible for sickle cell disease due to the substiation of of a T for an A in a triplet for GAG. The sequence GAG codes for glutamic acid whereas the sequence GTG codes for valine. The substitition of one amino acid for another can cause the resulting protein to have a different shape and/or functionality. Point mutations that occur in the third base position are sometimes silent when they change the genetic code but do not change the sequence of amino acids in the resulting protein. Point mutations in the first and second positions are much more likely to change the structure of a protein.

4 Properties of amino acids This Venn diagram relates some of the properties of amino acids. Substitutions of amino acids with similar properties are less likely to change the function of the protein than those whose properties are very different.

5 Evolution and bioinformatics Bioinformatics is a study of genetics and molecular biology using tools derived from the fields of computer science and information technology. By studying many samples of genetic material from a single species, it is possible to estimate the probability that mutations to the genetic code will cause one amino acid in a protein to be changed to a different amino acid. This can be quantified by a substitution matrix. In the matrix below each entry is a log-odds score, which means that it is the log of the likelihood of a certain amino acid substitution taking place in a fixed number of generations. A positive number represents a substitution that is relatively common. A negative number is one that is less common. These numbers are known as a PAM score (for Point Accepted Mutation). To compare a sequence of amino acids in two related proteins: sequence 1: sequence 2: PEYDLLV PERDILV To get from sequence 1 to 2, the first two amino acids must be preserved, the third substituted, the fourth conserved, etc. These two sequences would be scored as follows:

6 sequence 1: P E Y D L L V sequence 2: P E R D I L V PAM score: = 26 A third sequence might get a PAM score of 24 when compared to sequence 1. The lower PAM score suggests that the third sequence is less likely to have evolved from sequence 1 over a given amount of time. A simplified look at the study of evolution using bioinformatics 1. Isolate and decode a particular gene in two different species Not always as easy as it sounds. These genes may have different lengths and various insertions, deletions, and mutations. 2. Align the base pairs for the two genes. 3. Determine the sequence of amino acids coded by the genes. 4. Calculate a quantitative measure of the differences between the proteins produced by the two genes. 5. Assess this difference in evolutionary terms. The average protein in the human body is comprised of about 400 amino acids but there might be tens of thousands of base pairs in the DNA sequence which produces this protein. Analyzing two alleles of a single gene would be virtually impossible to do by hand. There are more than 20,000 genes in the human genome. Obviously, most of the raw work of bioinformatics must be done by computers.

7 Genetic Sequence Alignment One of the more difficult and time-consuming tasks involved in the study of genetic information is deciding how to two sequences should be aligned for comparison. Evolution of the genetic code includes not only point mutations, but also dropped information and inserted information in the genetic code. The following notes describe how you can use PAM scores to decide how sequences of amino acids in two different species should be compared. To solve alignment problems, we use the PAM table from the previous section: This table gives you a relative measure of the likelihood of a substitution between amino acids due to point mutations. We will now consider one more type of mutation an insertion or deletion of one or more amino acids. Each instance of a insertion or deletion has an equivalent PAM score of -5. Using this information and given two sequences of possibly different lengths, one must decide what is the most likely alignment of the amino acids. For example, sequence 1: sequence 2: PEYLLV PERDILV To align these two sequences, we must take into account a deletion of a single codon in the DNA code of the sequence 1. Or equivalently, this could be an insertion of a single codon in sequence 2. Several alignments might reasonably be considered:

8 sequence 1: P E Y - L L V sequence 2: P E R D I L V PAM score: = 15 sequence 1: P E - Y L L V sequence 2: P E R D I L V PAM score: = 14 sequence 1: P E Y L - L V sequence 2: P E R D I L V PAM score: = 9 The higher PAM score suggests that the first alignment is the most likely to arise from evolutionary processes. There is a tabular solution technique that can simplify the alignment process. To use this technique, we first write one sequence at the top of the table and the other along the left hand side: P E R D I L V In the upper left hand corner of the table, the 0 is a starting point for calculating the relative probability of producing one of these sequences from the other through point mutations, substitutions, or deletions. The goal is to sum together the relative probabilities of each link in the replication/mutation sequence that gets to the bottom right corner of the table. The most probable path through this table is usually the best alignment of the two sequences. The first amino acid in each sequence is proline (P). The relative probably of an accurate replication of this is given by the PAM score for a P to P replication, +7. This is the most likely event, so we add this PAM score to our current score of 0 (from the cell above the current one along the diagonal). We enter the new sum in the corresponding cell, 0+7 = 7.

9 P 0+7 E R D I L V Moving down in the table indicates that the vertical sequence has an insertion (PAM score = -5).compared to the horizontal sequence. Moving to the right indicates a deletion (PAM score = -5). Moving diagonally down and to the right indicates that the next two amino acids represent either an accurate duplication or a point mutation. In our case, this would be an accurate duplication of E (PAM score = +5). This last option is more probable (higher PAM score) as indicated in the table below. P 7 7-5=2 E 7-5=2 7+5=12 R D I L V We continue this process for each cell in out table choosing the most probable outcome and retaining some of the neighboring PAM values for comparison purposes. P 7 2 E =7 R 12-5=7 12-2=10 D I L V

10 The alignment should generally follow a path to the left and downward. Inspection of the two sequences shows that the last amino acids should match up directly. So, the task is to find the path from left to right that is most probable. We will continue to choose the most likely outcome at each step to see where that takes us. The next step is shown below: P 7 2 E R D 5 6 I L V And, continuing to the end of the sequence, we get the following: P 7 2 E R D I L 3 9 V 4 This path has a net PAM score of +4. However, this is only one of many possible paths through the table. Another one is shown below: P 7 2 E R D 5 6 I 1 L 5 V 9

11 Yet another path through this table is shown below. This alignment is the most probable one that we found previously. P 7 2 E R D 5 0 I 0 7 L 11 V 15 This path problem formulation allows the more mathematically-oriented scientists to use graph theory to solve for the most probable alignment between any two sequences. However, the optimization problem is beyond our present needs. A brute force approach will also work wherein one tries all possible paths through the table and chooses the one with the highest PAM score.

Sections 12.3, 13.1, 13.2

Sections 12.3, 13.1, 13.2 Sections 12.3, 13.1, 13.2 Background: Watson & Crick recognized that base pairing in the double helix allows DNA to be copied, or replicated Each strand in the double helix has all the information to remake

More information

1. The diagram below shows an error in the transcription of a DNA template to messenger RNA (mrna).

1. The diagram below shows an error in the transcription of a DNA template to messenger RNA (mrna). 1. The diagram below shows an error in the transcription of a DNA template to messenger RNA (mrna). Which statement best describes the error shown in the diagram? (A) The mrna strand contains the uracil

More information

3. Use the codon chart to translate the mrna sequence into an amino acid sequence.

3. Use the codon chart to translate the mrna sequence into an amino acid sequence. Honors Biology 317 The Beads of Translation: Using Beads to translate DNA into a Polypeptide Bracelet Objectives: 1. Using plastic beads, construct a representation of "standard" sequence of amino acids

More information

CHapter 14. From DNA to Protein

CHapter 14. From DNA to Protein CHapter 14 From DNA to Protein How? DNA to RNA to Protein to Trait Types of RNA 1. Messenger RNA: carries protein code or transcript 2. Ribosomal RNA: part of ribosomes 3. Transfer RNA: delivers amino

More information

Hello! Outline. Cell Biology: RNA and Protein synthesis. In all living cells, DNA molecules are the storehouses of information. 6.

Hello! Outline. Cell Biology: RNA and Protein synthesis. In all living cells, DNA molecules are the storehouses of information. 6. Cell Biology: RNA and Protein synthesis In all living cells, DNA molecules are the storehouses of information Hello! Outline u 1. Key concepts u 2. Central Dogma u 3. RNA Types u 4. RNA (Ribonucleic Acid)

More information

3. The following sequence is destined to be translated into a protein: However, a mutation occurs that results in the molecule being altered to:

3. The following sequence is destined to be translated into a protein: However, a mutation occurs that results in the molecule being altered to: 1. Please identify the molecule below: 5 -ACTCGATTACGATACGA-3ʼ a) DNA b) mrna c) trna d) rrna e) It cannot be determined 2. If a complimentary strand of RNA were made to the molecule in question 1, what

More information

Biology Celebration of Learning (100 points possible)

Biology Celebration of Learning (100 points possible) Name Date Block Biology Celebration of Learning (100 points possible) Matching (1 point each) 1. Codon a. process of copying DNA and forming mrna 2. Genes b. section of DNA coding for a specific protein

More information

Biology. Biology. Slide 1 of 39. End Show. Copyright Pearson Prentice Hall

Biology. Biology. Slide 1 of 39. End Show. Copyright Pearson Prentice Hall Biology Biology 1 of 39 12-3 RNA and Protein Synthesis 2 of 39 Essential Question What is transcription and translation and how do they take place? 3 of 39 12 3 RNA and Protein Synthesis Genes are coded

More information

Biology. Biology. Slide 1 of 39. End Show. Copyright Pearson Prentice Hall

Biology. Biology. Slide 1 of 39. End Show. Copyright Pearson Prentice Hall Biology Biology 1 of 39 12-3 RNA and Protein Synthesis 2 of 39 12 3 RNA and Protein Synthesis Genes are coded DNA instructions that control the production of proteins. Genetic messages can be decoded by

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

Protein Synthesis 101

Protein Synthesis 101 Protein Synthesis 101 What is DNA? - Blueprint of Life (has the instructions for making ) - Gene = a segment of DNA which determines a ( ) - - is wrapped around protein to form - Structure was discovered

More information

Ch 12.DNA and RNA.Biology.Landis

Ch 12.DNA and RNA.Biology.Landis Identity Section 12 1 DNA (pages 287 294) This section tells about the experiments that helped scientists discover the relationship between genes and DNA. It also describes the chemical structure of the

More information

Griffith and Transformation (pages ) 1. What hypothesis did Griffith form from the results of his experiments?

Griffith and Transformation (pages ) 1. What hypothesis did Griffith form from the results of his experiments? Section 12 1 DNA (pages 287 294) This section tells about the experiments that helped scientists discover the relationship between genes and DNA. It also describes the chemical structure of the DNA molecule.

More information

Student Exploration: RNA and Protein Synthesis Due Wednesday 11/27/13

Student Exploration: RNA and Protein Synthesis Due Wednesday 11/27/13 http://www.explorelearning.com Name: Period : Student Exploration: RNA and Protein Synthesis Due Wednesday 11/27/13 Vocabulary: Define these terms in complete sentences on a separate piece of paper: amino

More information

1. An alteration of genetic information is shown below. 5. Part of a molecule found in cells is represented below.

1. An alteration of genetic information is shown below. 5. Part of a molecule found in cells is represented below. 1. An alteration of genetic information is shown below. 5. Part of a molecule found in cells is represented below. A-G-T-A-C-C-G-A-T A-G-T-G-A-T This type of alteration of the genetic information is an

More information

13.1 RNA Lesson Objectives Contrast RNA and DNA. Explain the process of transcription.

13.1 RNA Lesson Objectives Contrast RNA and DNA. Explain the process of transcription. 13.1 RNA Lesson Objectives Contrast RNA and DNA. Explain the process of transcription. The Role of RNA 1. Complete the table to contrast the structures of DNA and RNA. DNA Sugar Number of Strands Bases

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

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

6. Which nucleotide part(s) make up the rungs of the DNA ladder? Sugar Phosphate Base

6. Which nucleotide part(s) make up the rungs of the DNA ladder? Sugar Phosphate Base DNA Unit Review Worksheet KEY Directions: Correct your worksheet using a non blue or black pen so your corrections can be clearly seen. DNA Basics 1. Label EVERY sugar (S), phosphate (P), and nitrogen

More information

BIOLOGY 111. CHAPTER 6: DNA: The Molecule of Life

BIOLOGY 111. CHAPTER 6: DNA: The Molecule of Life BIOLOGY 111 CHAPTER 6: DNA: The Molecule of Life Chromosomes and Inheritance Learning Outcomes 6.1 Describe the structure of the DNA molecule and how this structure allows for the storage of information,

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

Just one nucleotide! Exploring the effects of random single nucleotide mutations

Just one nucleotide! Exploring the effects of random single nucleotide mutations Dr. Beatriz Gonzalez In-Class Worksheet Name: Learning Objectives: Just one nucleotide! Exploring the effects of random single nucleotide mutations Given a coding DNA sequence, determine the mrna Based

More information

A DNA molecule consists of two strands of mononucleotides. Each of these strands

A DNA molecule consists of two strands of mononucleotides. Each of these strands 1 Read through the following passage on the structure of DNA, then write on the dotted lines the most appropriate word or words to complete the passage. (8) A DNA molecule consists of two strands of mononucleotides.

More information

From DNA to Protein: Genotype to Phenotype

From DNA to Protein: Genotype to Phenotype 12 From DNA to Protein: Genotype to Phenotype 12.1 What Is the Evidence that Genes Code for Proteins? The gene-enzyme relationship is one-gene, one-polypeptide relationship. Example: In hemoglobin, each

More information

Lecture for Wednesday. Dr. Prince BIOL 1408

Lecture for Wednesday. Dr. Prince BIOL 1408 Lecture for Wednesday Dr. Prince BIOL 1408 THE FLOW OF GENETIC INFORMATION FROM DNA TO RNA TO PROTEIN Copyright 2009 Pearson Education, Inc. Genes are expressed as proteins A gene is a segment of DNA that

More information

Chapter 8. Microbial Genetics. Lectures prepared by Christine L. Case. Copyright 2010 Pearson Education, Inc.

Chapter 8. Microbial Genetics. Lectures prepared by Christine L. Case. Copyright 2010 Pearson Education, Inc. Chapter 8 Microbial Genetics Lectures prepared by Christine L. Case Structure and Function of Genetic Material Learning Objectives 8-1 Define genetics, genome, chromosome, gene, genetic code, genotype,

More information

Chapter 14: From DNA to Protein

Chapter 14: From DNA to Protein Chapter 14: From DNA to Protein Steps from DNA to Proteins Same two steps produce all proteins: 1) DNA is transcribed to form RNA Occurs in the nucleus RNA moves into cytoplasm 2) RNA is translated in

More information

Basic concepts of molecular biology

Basic concepts of molecular biology Basic concepts of molecular biology Gabriella Trucco Email: gabriella.trucco@unimi.it Life The main actors in the chemistry of life are molecules called proteins nucleic acids Proteins: many different

More information

Protein Synthesis: Transcription and Translation

Protein Synthesis: Transcription and Translation Review Protein Synthesis: Transcription and Translation Central Dogma of Molecular Biology Protein synthesis requires two steps: transcription and translation. DNA contains codes Three bases in DNA code

More information

Living Environment. Directions: Use Aim # (Unit 4) to complete this study guide.

Living Environment. Directions: Use Aim # (Unit 4) to complete this study guide. Name: Date: Period: Living Environment Living Environment Unit 4 Genetics Study Guide Due Date: Test Date: Unit 5 Important Topics: I. Aim # 20 DNA Structure and Function II. Aim # 21 DNA Replication III.

More information

DNA & Genetics. Chapter Introduction DNA 6/12/2012. How are traits passed from parents to offspring?

DNA & Genetics. Chapter Introduction DNA 6/12/2012. How are traits passed from parents to offspring? Section 5.3 DNA & Genetics Chapter Introduction How are traits passed from parents to offspring? Chromatin- DNA in the nucleus loose strands Chromosome- When DNA gets organized before cell division Gene-

More information

DNA RNA Protein Trait Protein Synthesis (Gene Expression) Notes Proteins (Review) Proteins make up all living materials

DNA RNA Protein Trait Protein Synthesis (Gene Expression) Notes Proteins (Review) Proteins make up all living materials DNA RNA Protein Trait Protein Synthesis (Gene Expression) Notes Proteins (Review) Proteins make up all living materials Proteins are composed of amino acids there are 20 different amino acids Different

More information

Molecular Basis of Inheritance

Molecular Basis of Inheritance Molecular Basis of Inheritance Question 1: Group the following as nitrogenous bases and nucleosides: Adenine, Cytidine, Thymine, Guanosine, Uracil and Cytosine. Answer Nitrogenous bases present in the

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

RNA, & PROTEIN SYNTHESIS. 7 th Grade, Week 4, Day 1 Monday, July 15, 2013

RNA, & PROTEIN SYNTHESIS. 7 th Grade, Week 4, Day 1 Monday, July 15, 2013 RNA, & PROTEIN SYNTHESIS 7 th Grade, Week 4, Day 1 Monday, July 15, 2013 The Central Dogma RNA vs. DNA Ribonucleic Acid RNA is required for translation of genetic information stored in DNA into protein

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

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

From Gene to Protein

From Gene to Protein 8.2 Structure of DNA From Gene to Protein deoxyribonucleic acid - (DNA) - the ultimate source of all information in a cell This information is used by the cell to produce the protein molecules which are

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

Assessment Schedule 2013 Biology: Demonstrate understanding of gene expression (91159)

Assessment Schedule 2013 Biology: Demonstrate understanding of gene expression (91159) NCEA Level 2 Biology (91159) 2013 page 1 of 6 Assessment Schedule 2013 Biology: Demonstrate understanding of gene expression (91159) Assessment Criteria with Merit with Excellence Demonstrate understanding

More information

BIOLOGY. Monday 14 Mar 2016

BIOLOGY. Monday 14 Mar 2016 BIOLOGY Monday 14 Mar 2016 Entry Task List the terms that were mentioned last week in the video. Translation, Transcription, Messenger RNA (mrna), codon, Ribosomal RNA (rrna), Polypeptide, etc. Agenda

More information

Write: Unit 5 Review at the top.

Write: Unit 5 Review at the top. Warm-up Take out a sheet of paper: Write: Unit 5 Review at the top. As each question goes on the board, write that question down and answer it. When answers come up, either write correct next to what you

More information

Genes and How They Work. Chapter 15

Genes and How They Work. Chapter 15 Genes and How They Work Chapter 15 The Nature of Genes They proposed the one gene one enzyme hypothesis. Today we know this as the one gene one polypeptide hypothesis. 2 The Nature of Genes The central

More information

From DNA to Protein: Genotype to Phenotype

From DNA to Protein: Genotype to Phenotype 12 From DNA to Protein: Genotype to Phenotype 12.1 What Is the Evidence that Genes Code for Proteins? The gene-enzyme relationship is one-gene, one-polypeptide relationship. Example: In hemoglobin, each

More information

Class XII Chapter 6 Molecular Basis of Inheritance Biology

Class XII Chapter 6 Molecular Basis of Inheritance Biology Question 1: Group the following as nitrogenous bases and nucleosides: Adenine, Cytidine, Thymine, Guanosine, Uracil and Cytosine. Nitrogenous bases present in the list are adenine, thymine, uracil, and

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

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

Genes are coded DNA instructions that control the production of proteins within a cell. The first step in decoding genetic messages is to copy a part

Genes are coded DNA instructions that control the production of proteins within a cell. The first step in decoding genetic messages is to copy a part Genes are coded DNA instructions that control the production of proteins within a cell. The first step in decoding genetic messages is to copy a part of the nucleotide sequence of the DNA into RNA. RNA

More information

From Gene to Protein Transcription and Translation i

From Gene to Protein Transcription and Translation i From Gene to Protein Transcription and Translation i How do the genes in our DNA influence our characteristics? A gene is a segment of DNA that provides the instructions for making a protein. Proteins

More information

Basic concepts of molecular biology

Basic concepts of molecular biology Basic concepts of molecular biology Gabriella Trucco Email: gabriella.trucco@unimi.it What is life made of? 1665: Robert Hooke discovered that organisms are composed of individual compartments called cells

More information

Chapter 11. Gene Expression and Regulation. Lectures by Gregory Ahearn. University of North Florida. Copyright 2009 Pearson Education, Inc..

Chapter 11. Gene Expression and Regulation. Lectures by Gregory Ahearn. University of North Florida. Copyright 2009 Pearson Education, Inc.. Chapter 11 Gene Expression and Regulation Lectures by Gregory Ahearn University of North Florida Copyright 2009 Pearson Education, Inc.. 11.1 How Is The Information In DNA Used In A Cell? Most genes contain

More information

Protein Synthesis Honors Biology

Protein Synthesis Honors Biology Protein Synthesis What do we know? Metabolism is controlled by enzymes enzymes are proteins DNA contains the genetic information to build proteins. DNA is only in the nucleus. Ribosomes are not. How then

More information

COMP 555 Bioalgorithms. Fall Lecture 1: Course Introduction

COMP 555 Bioalgorithms. Fall Lecture 1: Course Introduction COMP 555 Bioalgorithms Fall 2014 Jan Prins Lecture 1: Course Introduction Read Chapter 1 and Chapter 3, Secns 3.1-3.7 1 Intended Audience COMP 555: Bioalgorithms Suitable for both undergraduate and graduate

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

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

Chapter 4 DNA Structure & Gene Expression

Chapter 4 DNA Structure & Gene Expression Biology 12 Name: Cell Biology Per: Date: Chapter 4 DNA Structure & Gene Expression Complete using BC Biology 12, pages 108-153 4.1 DNA Structure pages 112-114 1. DNA stands for and is the genetic material

More information

Chapter 13: RNA and Protein Synthesis. Dr. Bertolotti

Chapter 13: RNA and Protein Synthesis. Dr. Bertolotti Chapter 13: RNA and Protein Synthesis Dr. Bertolotti Essential Question How does information flow from DNA to RNA to direct the synthesis of proteins? How does RNA differ from DNA? RNA and protein synthesis

More information

DNA life s code. Importance of DNA. DNA Structure. DNA Structure - nucleotide. DNA Structure nitrogen bases. Linking Nucleotides

DNA life s code. Importance of DNA. DNA Structure. DNA Structure - nucleotide. DNA Structure nitrogen bases. Linking Nucleotides Importance of life s code molecule that makes up genes and determines the traits of all living things Controls by: producing proteins Proteins are important because All structures are made of protein Skin

More information

Name Date Class. The Central Dogma of Biology

Name Date Class. The Central Dogma of Biology Concept Mapping The Central Dogma of Biology Complete the events chain showing the events that occur as DNA codes for RNA, which guides the synthesis of proteins, the central dogma of biology. These terms

More information

To truly understand genetics, biologists first had to discover the chemical nature of genes

To truly understand genetics, biologists first had to discover the chemical nature of genes To truly understand genetics, biologists first had to discover the chemical nature of genes Identifying the structure that carries genetic information makes it possible to understand how genes control

More information

Helps DNA put genetic code into action RNA Structure

Helps DNA put genetic code into action RNA Structure 13.1 RNA Helps DNA put genetic code into action RNA Structure Single Stranded Nucleotides building blocks to RNA Ribose (5C sugar) Phosphate Group Nitrogenous base: Adenine, Uracil Guanine, Cytosine Disposable

More information

The Nature of Genes. The Nature of Genes. Genes and How They Work. Chapter 15/16

The Nature of Genes. The Nature of Genes. Genes and How They Work. Chapter 15/16 Genes and How They Work Chapter 15/16 The Nature of Genes Beadle and Tatum proposed the one gene one enzyme hypothesis. Today we know this as the one gene one polypeptide hypothesis. 2 The Nature of Genes

More information

2. From the first paragraph in this section, find three ways in which RNA differs from DNA.

2. From the first paragraph in this section, find three ways in which RNA differs from DNA. Name Chapter 17: From Gene to Protein Begin reading at page 328 Basic Principles of Transcription and Translation. Work on this chapter a single concept at a time, and expect to spend at least 6 hours

More information

BIO 101 : The genetic code and the central dogma

BIO 101 : The genetic code and the central dogma BIO 101 : The genetic code and the central dogma NAME Objectives The purpose of this exploration is to... 1. design experiments to decipher the genetic code; 2. visualize the process of protein synthesis;

More information

From Gene to Protein Transcription and Translation i

From Gene to Protein Transcription and Translation i How do genes influence our characteristics? From Gene to Protein Transcription and Translation i A gene is a segment of DNA that provides the instructions for making a protein. Proteins have many different

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

The Structure of RNA. The Central Dogma

The Structure of RNA. The Central Dogma 12-3 12-3 RNA and Protein Synthesis The Structure of RNA The Central Dogma Phenotype A gene is a SEQUENCE of DNA that codes for a protein (or functional RNA). Phenotype is the individual s observable trait

More information

Biology Day 67. Tuesday, February 24 Wednesday, February 25, 2015

Biology Day 67. Tuesday, February 24 Wednesday, February 25, 2015 Biology Day 67 Tuesday, February 24 Wednesday, February 25, 2015 Do#Now:' Brainstorm+8.5 + 1. Write today s FLT! 2. Identify 3 specific differences between DNA and RNA.! 3. is the process of making RNA

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

Biology 30 DNA Review: Importance of Meiosis nucleus chromosomes Genes DNA

Biology 30 DNA Review: Importance of Meiosis nucleus chromosomes Genes DNA Biology 30 DNA Review: Importance of Meiosis Every cell has a nucleus and every nucleus has chromosomes. The number of chromosomes depends on the species. o Examples: Chicken 78 Chimpanzee 48 Potato 48

More information

DNA & PROTEIN SYNTHESIS REVIEW

DNA & PROTEIN SYNTHESIS REVIEW Name: Block: DNA & PROTEIN SYNTHESIS REVIEW 1. Give the purpose of each of the following steps in the process of protein synthesis. a) Ribosome moving along a mrna: (1 mark) b) Adenine bonding to thymine:

More information

Gene Expression Transcription/Translation Protein Synthesis

Gene Expression Transcription/Translation Protein Synthesis Gene Expression Transcription/Translation Protein Synthesis 1. Describe how genetic information is transcribed into sequences of bases in RNA molecules and is finally translated into sequences of amino

More information

Gene Expression DNA to Protein - 1

Gene Expression DNA to Protein - 1 Gene Expression DNA to Protein - 1 As we have just discussed, the structure of DNA provides a mechanism for selfreplication. The structure of DNA also reveals the mechanism for storing the genetic information

More information

Unit VII DNA to RNA to protein The Central Dogma

Unit VII DNA to RNA to protein The Central Dogma Unit VII DNA to RNA to protein The Central Dogma DNA Deoxyribonucleic acid, the material that contains information that determines inherited characteristics. A DNA molecule is shaped like a spiral staircase

More information

Introduction to Cellular Biology and Bioinformatics. Farzaneh Salari

Introduction to Cellular Biology and Bioinformatics. Farzaneh Salari Introduction to Cellular Biology and Bioinformatics Farzaneh Salari Outline Bioinformatics Cellular Biology A Bioinformatics Problem What is bioinformatics? Computer Science Statistics Bioinformatics Mathematics...

More information

Transcription & Translation Practice Examination

Transcription & Translation Practice Examination Name: Date: Students must provide an explanation for all problems. Students must have parent signature prior to submission. 1. A DNA molecule with the base sequence A-G-C-T-C-A was used as a template for

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 & 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

DNA and Biotechnology Form of DNA Form of DNA Form of DNA Form of DNA Replication of DNA Replication of DNA

DNA and Biotechnology Form of DNA Form of DNA Form of DNA Form of DNA Replication of DNA Replication of DNA 21 DNA and Biotechnology DNA and Biotechnology OUTLINE: Replication of DNA Gene Expression Mutations Regulating Gene Activity Genetic Engineering Genomics DNA (deoxyribonucleic acid) Double-stranded molecule

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

E. Incorrect! The four different DNA nucleotides follow a strict base pairing arrangement:

E. Incorrect! The four different DNA nucleotides follow a strict base pairing arrangement: AP Biology - Problem Drill 10: Molecular and Human Genetics Question No. 1 of 10 Instructions: (1) Read the problem and answer choices carefully, (2) Work the problems on paper as 1. Which of the following

More information

1. DNA, RNA structure. 2. DNA replication. 3. Transcription, translation

1. DNA, RNA structure. 2. DNA replication. 3. Transcription, translation 1. DNA, RNA structure 2. DNA replication 3. Transcription, translation DNA and RNA are polymers of nucleotides DNA is a nucleic acid, made of long chains of nucleotides Nucleotide Phosphate group Nitrogenous

More information

The Flow of Genetic Information

The Flow of Genetic Information Chapter 17 The Flow of Genetic Information The DNA inherited by an organism leads to specific traits by dictating the synthesis of proteins and of RNA molecules involved in protein synthesis. Proteins

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

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

Why are proteins important?

Why are proteins important? PROTEIN SYNTHESIS Why are proteins important? proteins help build cell structures some proteins are enzymes that promote biological reactions Proteins are found in muscles, blood, bones, etc.. RNA RNA

More information

2. Examine the objects inside the box labeled #2. What is this called? nucleotide

2. Examine the objects inside the box labeled #2. What is this called? nucleotide Name Date: Period: Biology: DNA Review Packet Read each question and fill in the proper answer. 1. Label EVERY sugar (S), phosphate (P), and nitrogen base (A, T, C, G) in the diagram below. #2 2. Examine

More information

MATH 5610, Computational Biology

MATH 5610, Computational Biology MATH 5610, Computational Biology Lecture 2 Intro to Molecular Biology (cont) Stephen Billups University of Colorado at Denver MATH 5610, Computational Biology p.1/24 Announcements Error on syllabus Class

More information

Jay McTighe and Grant Wiggins,

Jay McTighe and Grant Wiggins, Course: Integrated Science 3/4 Unit #3: (DNA & RNA) Instructions for Life Stage 1: Identify Desired Results Enduring Understandings: Students will understand that Nearly all human traits, even many diseases,

More information

DNA. Essential Question: How does the structure of the DNA molecule allow it to carry information?

DNA. Essential Question: How does the structure of the DNA molecule allow it to carry information? DNA Essential Question: How does the structure of the DNA molecule allow it to carry information? Fun Website to Explore! http://learn.genetics.utah.edu/content/molecules/ DNA History Griffith Experimented

More information

BIOLOGY - CLUTCH CH.17 - GENE EXPRESSION.

BIOLOGY - CLUTCH CH.17 - GENE EXPRESSION. !! www.clutchprep.com CONCEPT: GENES Beadle and Tatum develop the one gene one enzyme hypothesis through their work with Neurospora (bread mold). This idea was later revised as the one gene one polypeptide

More information

(Very) Basic Molecular Biology

(Very) Basic Molecular Biology (Very) Basic Molecular Biology (Very) Basic Molecular Biology Each human cell has 46 chromosomes --double-helix DNA molecule (Very) Basic Molecular Biology Each human cell has 46 chromosomes --double-helix

More information

From Gene to Protein Transcription and Translation

From Gene to Protein Transcription and Translation Name: Hour: From Gene to Protein Transcription and Translation Introduction: In this activity you will learn how the genes in our DNA influence our characteristics. For example, how can a gene cause albinism

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

4/3/2013. DNA Synthesis Replication of Bacterial DNA Replication of Bacterial DNA

4/3/2013. DNA Synthesis Replication of Bacterial DNA Replication of Bacterial DNA 4/3/03 3 4 5 6 7 8 9 0 Chapter 8 Microbial Genetics Terminology Genetics: The study of what genes are, how they carry information, how information is expressed, and how genes are replicated Gene: A segment

More information

AGENDA for 02/07/14 AGENDA: HOMEWORK: Due end of period. Due Thurs, OBJECTIVES:

AGENDA for 02/07/14 AGENDA: HOMEWORK: Due end of period. Due Thurs, OBJECTIVES: AGENDA for 02/07/14 AGENDA: 1. Finish 3.2.1: Protein Synthesis (participation) 2. 3.2.2: The Genetic Code OBJECTIVES: 1. Decode the DNA message 2. Investigate the effect that various mutations have on

More information

Lesson 8. DNA: The Molecule of Heredity. Gene Expression and Regulation. Introduction to Life Processes - SCI 102 1

Lesson 8. DNA: The Molecule of Heredity. Gene Expression and Regulation. Introduction to Life Processes - SCI 102 1 Lesson 8 DNA: The Molecule of Heredity Gene Expression and Regulation Introduction to Life Processes - SCI 102 1 Genes and DNA Hereditary information is found in discrete units called genes Genes are segments

More information

Bioinformatics. ONE Introduction to Biology. Sami Khuri Department of Computer Science San José State University Biology/CS 123A Fall 2012

Bioinformatics. ONE Introduction to Biology. Sami Khuri Department of Computer Science San José State University Biology/CS 123A Fall 2012 Bioinformatics ONE Introduction to Biology Sami Khuri Department of Computer Science San José State University Biology/CS 123A Fall 2012 Biology Review DNA RNA Proteins Central Dogma Transcription Translation

More information

4/22/2014. Interest Grabber. Section Outline. Today s Goal. Percentage of Bases in Four Organisms. Figure 12 2 Griffith s Experiment

4/22/2014. Interest Grabber. Section Outline. Today s Goal. Percentage of Bases in Four Organisms. Figure 12 2 Griffith s Experiment Order! Order! Genes are made of, a large, complex molecule. is composed of individual units called nucleotides. Three of these units form a code. The order, or sequence, of a code and the type of code

More information

produces an RNA copy of the coding region of a gene

produces an RNA copy of the coding region of a gene 1. Transcription Gene Expression The expression of a gene into a protein occurs by: 1) Transcription of a gene into RNA produces an RNA copy of the coding region of a gene the RNA transcript may be the

More information