Download Slides of short summary on Molecular Biology

Survey
yes no Was this document useful for you?
   Thank you for your participation!

* Your assessment is very important for improving the workof artificial intelligence, which forms the content of this project

Document related concepts

Protein–protein interaction wikipedia , lookup

Protein wikipedia , lookup

Nucleosome wikipedia , lookup

Metabolism wikipedia , lookup

Gene regulatory network wikipedia , lookup

Real-time polymerase chain reaction wikipedia , lookup

Molecular cloning wikipedia , lookup

Polyadenylation wikipedia , lookup

Transformation (genetics) wikipedia , lookup

RNA silencing wikipedia , lookup

Promoter (genetics) wikipedia , lookup

DNA supercoil wikipedia , lookup

RNA polymerase II holoenzyme wikipedia , lookup

Eukaryotic transcription wikipedia , lookup

Endogenous retrovirus wikipedia , lookup

RNA wikipedia , lookup

RNA-Seq wikipedia , lookup

Proteolysis wikipedia , lookup

Non-coding DNA wikipedia , lookup

Gene wikipedia , lookup

Biochemistry wikipedia , lookup

Two-hybrid screening wikipedia , lookup

Messenger RNA wikipedia , lookup

Vectors in gene therapy wikipedia , lookup

Point mutation wikipedia , lookup

Genetic code wikipedia , lookup

Transcriptional regulation wikipedia , lookup

Artificial gene synthesis wikipedia , lookup

Silencer (genetics) wikipedia , lookup

Deoxyribozyme wikipedia , lookup

Gene expression wikipedia , lookup

Nucleic acid analogue wikipedia , lookup

Epitranscriptome wikipedia , lookup

Biosynthesis wikipedia , lookup

Transcript
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Cells
Molecular Biology Primer
•
•
Fundamental working units of every living system.
Every organism is composed of one of two
radically different types of cells:
prokaryotic cells or
eukaryotic cells.
• Prokaryotes and Eukaryotes are descended from the same primitive cell.
• All extant prokaryotic and eukaryotic cells are the result of a total of 3.5
billion years of evolution.
Angela Brooks, Raymond Brown, Calvin Chen, Mike Daly,
Hoa Dinh, Erinn Hama, Robert Hinman, Julio Ng, Michael
Sneddon, Hoa Troung, Jerry Wang, Che Fung Yung
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
•
•
Chemical composition-by weight
• 70% water
• 7% small molecules
• salts
• Lipids
• amino acids
• nucleotides
• 23% macromolecules
• Proteins
• Polysaccharides
• lipids
biochemical (metabolic) pathways
translation of mRNA into proteins
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Life begins with Cell
Cells
•
An Introduction to Bioinformatics Algorithms
• A cell is a smallest structural unit of an
organism that is capable of independent
functioning
• All cells have some common features
www.bioalgorithms.info
All Cells have common Cycles
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
2 types of cells: Prokaryotes
v.s.Eukaryotes
• Born, eat, replicate, and die
1
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Prokaryotes and Eukaryotes
•According to the most recent evidence, there are three main branches to the tree of life.
•Prokaryotes include Archaea (“ancient ones”) and bacteria.
•Eukaryotes are kingdom Eukarya and includes plants, animals, fungi and certain algae.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Prokaryotes v.s. Eukaryotes
Prokaryotes
Eukaryotes
Single cell
Single or multi cell
No nucleus
Nucleus
No organelles
Organelles
One piece of circular DNA Chromosomes
No mRNA post
Exons/Introns splicing
transcriptional modification
An Introduction to Bioinformatics Algorithms
Prokaryotes
Eukaryotes
¾ Eubacterial (blue green algae)
and archaebacteria
¾ only one type of membrane-plasma membrane forms
¾ plants, animals, Protista, and fungi
ƒ Ecoli cell
ƒ 3x106 protein molecules
ƒ 1000-2000 polypeptide species.
Prokaryotes and Eukaryotes,
continued
www.bioalgorithms.info
Chromosomal differences
Prokaryotes
¾ The smallest cells known are
bacteria
www.bioalgorithms.info
Prokaryotic and Eukaryotic Cells
Structural differences
ƒ the boundary of the cell proper
An Introduction to Bioinformatics Algorithms
¾ The genome of E.coli contains
amount of t 4X106 base pairs
¾ > 90% of DNA encode protein
¾ complex systems of internal
membranes forms
ƒ organelle and compartments
¾ The volume of the cell is several
hundred times larger
An Introduction to Bioinformatics Algorithms
ƒ Hela cell
ƒ 5x109 protein molecules
ƒ 5000-10,000 polypeptide species
www.bioalgorithms.info
Signaling Pathways: Control Gene
Activity
• Instead of having brains, cells make decision
through complex networks of chemical
reactions, called pathways
• Synthesize new materials
• Break other materials down for spare parts
• Signal to eat or die
¾ Lacks a membrane-bound nucleus.
ƒ Circular DNA and supercoiled
domain
¾ Histones are unknown
Eukaryotes
¾ The genome of yeast cells contains
1.35x107 base pairs
¾ A small fraction of the total DNA
encodes protein.
ƒ Many repeats of non-coding
sequences
¾ All chromosomes are contained in
a membrane bound nucleus
ƒ DNA is divided between two or
more chromosomes
¾ A set of five histones
An Introduction to Bioinformatics Algorithms
ƒ
DNA packaging and gene
expression regulation
www.bioalgorithms.info
Cells Information and Machinery
• Cells store all information to replicate itself
• Human genome is around 3 billions base pair long
• Almost every cell in human body contains same
set of genes
• But not all genes are used or expressed by those
cells
• Machinery:
• Collect and manufacture components
• Carry out replication
• Kick-start its new offspring
(A cell is like a car factory)
2
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Overview of organizations of life
•
•
•
•
Nucleus = library
Chromosomes = bookshelves
Genes = books
Almost every cell in an organism contains the
same libraries and the same sets of books.
• Books represent all the information (DNA)
that every cell in the body needs so it can
grow and carry out its vaious functions.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
www.bioalgorithms.info
•
Genome: an organism’s genetic material
•
Gene: a discrete units of hereditary information located on the
•
Genotype: The genetic makeup of an organism
•
Phenotype: the physical expressed traits of an organism
•
chromosomes and consisting of DNA.
Nucleic acid: Biological molecules(RNA and DNA) that allow organisms to
reproduce;
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
All Life depends on 3 critical molecules
More Terminology
• The genome is an organism’s complete set of DNA.
• a bacteria contains about 600,000 DNA base pairs
• human and mouse genomes have some 3 billion.
• human genome has 24 distinct chromosomes.
• Each chromosome contains many genes.
• Gene
• basic physical and functional units of heredity.
• specific sequences of DNA bases that encode
instructions on how to make proteins.
• Proteins
• Make up the cellular structure
• large, complex molecules made up of smaller subunits
called amino acids.
An Introduction to Bioinformatics Algorithms
An Introduction to Bioinformatics Algorithms
Some Terminology
www.bioalgorithms.info
DNA: The Code of Life
• DNAs
• Hold information on how cell works
• RNAs
• Act to transfer short pieces of information to different parts
of cell
• Provide templates to synthesize into protein
• Proteins
• Form enzymes that send signals to other cells and regulate
gene activity
• Form body’s major components (e.g. hair, skin, etc.)
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
DNA, continued
• DNA has a double helix
structure which
composed of
• sugar molecule
• phosphate group
• and a base (A,C,G,T)
•
•
The structure and the four genomic letters code for all living
organisms
Adenine, Guanine, Thymine, and Cytosine which pair A-T and C-G
on complimentary strands.
• DNA always reads from
5’ end to 3’ end for
transcription replication
5’ ATTTAGGCC 3’
3’ TAAATCCGG 5’
3
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
DNA, RNA, and the Flow of
Information
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
DNA the Genetics Makeup
• Genes are inherited and are
expressed
Replication
• genotype (genetic makeup)
• phenotype (physical
expression)
Transcription
Translation
• On the left, is the eye’s
phenotypes of green and
black eye genes.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Cell Information: Instruction book of
Life
• DNA, RNA, and
Proteins are examples
of strings written in
either the four-letter
nucleotide of DNA and
RNA (A C G T/U)
• or the twenty-letter
amino acid of proteins.
Each amino acid is
coded by 3 nucleotides
called codon. (Leu, Arg,
Met, etc.)
An Introduction to Bioinformatics Algorithms
The Purines
An Introduction to Bioinformatics Algorithms
DNA, continued
• DNA has a double helix structure. However,
it is not symmetric. It has a “forward” and
“backward” direction. The ends are labeled
5’ and 3’ after the Carbon atoms in the sugar
component.
5’ AATCGCAAT 3’
3’ TTAGCGTTA 5’
DNA always reads 5’ to 3’ for transcription
replication
www.bioalgorithms.info
The Pyrimidines
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Double helix of DNA
•
The double helix of DNA has these features:
• Concentration of adenine (A) is equal to thymine (T)
• Concentration of cytidine (C) is equal to guanine (G).
• Watson-Crick base-pairing A will only base-pair with T, and C with G
• base-pairs of G and C contain three H-bonds,
• Base-pairs of A and T contain two H-bonds.
• G-C base-pairs are more stable than A-T base-pairs
• Two polynucleotide strands wound around each other.
• The backbone of each consists of alternating deoxyribose and
phosphate groups
4
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Double helix of DNA
An Introduction to Bioinformatics Algorithms
•
•
•
•
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Double helix of DNA
www.bioalgorithms.info
The DNA strands are assembled in the 5' to 3' direction
• by convention, we "read" them the same way.
The phosphate group bonded to the 5' carbon atom of one deoxyribose is
covalently bonded to the 3' carbon of the next.
The purine or pyrimidine attached to each deoxyribose projects in toward the
axis of the helix.
Each base forms hydrogen bonds with the one directly opposite it, forming
base pairs (also called nucleotide pairs).
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
DNA - replication
Superstructure Implications
• DNA can replicate by
splitting, and rebuilding
each strand.
• Note that the rebuilding
of each strand uses
slightly different
mechanisms due to the
5’ 3’ asymmetry, but
each daughter strand is
an exact replica of the
original strand.
• DNA in a living cell is in a highly compacted and
structured state
• Transcription factors and RNA polymerase need
ACCESS to do their work
• Transcription is dependent on the structural
state – SEQUENCE alone does not tell the
whole story
http://users.rcn.com/jkimball.ma.ultranet/BiologyPages/D/DNAReplication.html
An Introduction to Bioinformatics Algorithms
• Central Dogma
(DNAÆRNAÆprotein)
The paradigm that DNA
directs its transcription
to RNA, which is then
translated into a protein.
• Transcription
(DNAÆRNA) The
process which transfers
genetic information from
the DNA to the RNA.
• Translation
(RNAÆprotein) The
process of transforming
RNA to protein as
specified by the genetic
code.
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
RNA
• RNA is similar to DNA chemically. It is usually only
a single strand. T(hyamine) is replaced by U(racil)
• Some forms of RNA can form secondary structures
by “pairing up” with itself. This can have change its
properties
dramatically.
DNA and RNA
can pair with
each other.
tRNA linear and 3D view:
http://www.cgl.ucsf.edu/home/glasfeld/tutorial/trna/trna.gif
5
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
www.bioalgorithms.info
Terminology for Transcription
RNA, continued
• Several types exist, classified by function
• mRNA – this is what is usually being referred
to when a Bioinformatician says “RNA”. This
is used to carry a gene’s message out of the
nucleus.
• tRNA – transfers genetic information from
mRNA to an amino acid sequence
• rRNA – ribosomal RNA. Part of the ribosome
which is involved in translation.
An Introduction to Bioinformatics Algorithms
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
•
hnRNA (heterogeneous nuclear RNA): Eukaryotic mRNA primary
transcipts whose introns have not yet been excised (pre-mRNA).
Phosphodiester Bond: Esterification linkage between a phosphate
group and two alcohol groups.
Promoter: A special sequence of nucleotides indicating the starting
point for RNA synthesis.
RNA (ribonucleotide): Nucleotides A,U,G, and C with ribose
RNA Polymerase II: Multisubunit enzyme that catalyzes the
synthesis of an RNA molecule on a DNA template from nucleoside
triphosphate precursors.
Terminator: Signal in DNA that halts transcription.
•
•
•
•
•
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Transcription
DNA Æ RNA: Transcription
• The process of making
RNA from DNA
• Catalyzed by
“transcriptase” enzyme
• Needs a promoter
region to begin
transcription.
• ~50 base pairs/second
in bacteria, but multiple
transcriptions can occur
simultaneously
• DNA gets transcribed by a
protein known as RNApolymerase
• This process builds a chain of
bases that will become mRNA
• RNA and DNA are similar,
except that RNA is single
stranded and thus less stable
than DNA
• Also, in RNA, the base uracil (U) is
used instead of thymine (T), the
DNA counterpart
http://ghs.gresham.k12.or.us/science/ps/sci/ibbio/chem/nucleic/chpt15/transcription.gif
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Transcription, continued
• Transcription is highly regulated. Most DNA is in a
dense form where it cannot be transcribed.
• To begin transcription requires a promoter, a small
specific sequence of DNA to which polymerase can
bind (~40 base pairs “upstream” of gene)
• Finding these promoter regions is a partially solved
problem that is related to motif finding.
• There can also be repressors and inhibitors acting in
various ways to stop transcription. This makes
regulation of gene transcription complex to
understand.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Definition of a Gene
•
Regulatory regions: up to 50 kb upstream of +1 site
•
Exons:
protein coding and untranslated regions (UTR)
1 to 178 exons per gene (mean 8.8)
8 bp to 17 kb per exon (mean 145 bp)
•
Introns:
splice acceptor and donor sites, junk DNA
average 1 kb – 50 kb per intron
•
Gene size:
Largest – 2.4 Mb (Dystrophin). Mean – 27 kb.
6
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
Central Dogma Revisited
DNA
Transcription
Nucleus
protein
Terminology for Splicing
• Exon: A portion of the gene that appears in
both the primary and the mature mRNA
transcripts.
• Intron: A portion of the gene that is
transcribed but excised prior to translation.
• Lariat structure: The structure that an intron
in mRNA takes during excision/splicing.
Splicing
hnRNA
mRNA
Spliceosome
Translation
Ribosome in Cytoplasm
• Base Pairing Rule: A and T or U is held together by
2 hydrogen bonds and G and C is held together by 3
hydrogen bonds.
• Note: Some mRNA stays as RNA (ie tRNA,rRNA).
An Introduction to Bioinformatics Algorithms
• Spliceosome: A organelle that carries out the
splicing reactions whereby the pre
- mRNA is
converted to a mature mRNA.
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
• In Eukaryotic cells, RNA is processed
between transcription and translation.
• This complicates the relationship between a
DNA gene and the protein it codes for.
• Sometimes alternate RNA processing can
lead to an alternate protein as a result. This
is true in the immune system.
• Unprocessed RNA is
composed of Introns and
Extrons. Introns are
removed before the rest is
expressed and converted
to protein.
• Sometimes alternate
splicings can create
different valid proteins.
• A typical Eukaryotic gene
has 4-20 introns. Locating
them by analytical means
is not easy.
www.bioalgorithms.info
Terminology for Ribosome
• Codon: The sequence of 3 nucleotides in DNA/RNA that
encodes for a specific amino acid.
• mRNA (messenger RNA): A ribonucleic acid whose
sequence is complementary to that of a protein-coding
gene in DNA.
• Ribosome: The organelle that synthesizes polypeptides
under the direction of mRNA
• rRNA (ribosomal RNA):The RNA molecules that constitute
the bulk of the ribosome and provides structural scaffolding
for the ribosome and catalyzes peptide bond formation.
• tRNA (transfer RNA): The small L-shaped RNAs that
deliver specific amino acids to ribosomes according to the
sequence of a bound mRNA.
www.bioalgorithms.info
Splicing (Eukaryotes)
Splicing and other RNA processing
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
•
•
•
•
•
www.bioalgorithms.info
mRNA
Æ Ribosome
mRNA leaves the nucleus via nuclear
pores.
Ribosome has 3 binding sites for tRNAs:
• A-site: position that aminoacyl-tRNA
molecule binds to vacant site
• P-site: site where the new peptide bond
is formed.
• E-site: the exit site
Two subunits join together on a mRNA
molecule near the 5’ end.
The ribosome will read the codons until
AUG is reached and then the initiator tRNA
binds to the P-site of the ribosome.
Stop codons have tRNA that recognize a
signal to stop translation. Release factors
bind to the ribosome which cause the
peptidyl transferase to catalyze the addition
of water to free the molecule and releases
the polypeptide.
7
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Terminology for tRNA and proteins
• Anticodon: The sequence of 3 nucleotides in
tRNA that recognizes an mRNA codon
through complementary base pairing.
• C-terminal: The end of the protein with the
free COOH.
• N-terminal: The end of the protein with the
free NH3.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Purpose of tRNA
• The proper tRNA is chosen by having the
corresponding anticodon for the mRNA’s codon.
• The tRNA then transfers its aminoacyl group to the
growing peptide chain.
• For example, the tRNA with the anticodon UAC
corresponds with the codon AUG and attaches
methionine amino acid onto the peptide chain.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Uncovering the code
RNA Æ Protein: Translation
• Scientists conjectured that proteins came from DNA;
but how did DNA code for proteins?
• If one nucleotide codes for one amino acid, then
there’d be 41 amino acids
• However, there are 20 amino acids, so at least 3
bases codes for one amino acid, since 42 = 16 and
43 = 64
• Ribosomes and transfer-RNAs (tRNA) run along the
length of the newly synthesized mRNA, decoding
one codon at a time to build a growing chain of
amino acids (“peptide”)
• This triplet of bases is called a “codon”
• 64 different codons and only 20 amino acids means that
the coding is degenerate: more than one codon sequence
code for the same amino acid
An Introduction to Bioinformatics Algorithms
Translation
• The process of going
from RNA to
polypeptide.
• Three base pairs of
RNA (called a codon)
correspond to one
amino acid based on a
fixed table.
• Always starts with
Methionine and ends
with a stop codon
www.bioalgorithms.info
• The tRNAs have anti-codons, which complimentarily match
the codons of mRNA to know what protein gets added next
• But first, in eukaryotes, a phenomenon called
splicing occurs
• Introns are non-protein coding regions of the mRNA; exons
are the coding regions
• Introns are removed from the mRNA during splicing so that
a functional, valid protein can form
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Translation, continued
• Catalyzed by Ribosome
• Using two different
sites, the Ribosome
continually binds tRNA,
joins the amino acids
together and moves to
the next location along
the mRNA
• ~10 codons/second,
but multiple translations
can occur
simultaneously
http://wong.scripps.edu/PIX/ribosome.jpg
8
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
Protein Synthesis: Summary
Proteins
• There are twenty amino
acids, each coded by threebase-sequences in DNA,
called “codons”
• Complex organic molecules made up of amino acid
subunits
• 20* different kinds of amino acids. Each has a 1
and 3 letter abbreviation.
• http://www.indstate.edu/thcme/mwking/aminoacids.html for complete list of chemical structures
and abbreviations.
• Proteins are often enzymes that catalyze reactions.
• Also called “poly-peptides”
• This code is degenerate
• The central dogma
describes how proteins
derive from DNA
• DNA Æ mRNA Æ (splicing?)
Æ protein
• The protein adopts a 3D
structure specific to it’s
amino acid arrangement and
function
*Some other amino acids exist but not in humans.
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
Polypeptide v. Protein
Protein Folding
• A protein is a polypeptide, however to
understand the function of a protein given
only the polypeptide sequence is a very
difficult problem.
• Protein folding an open problem. The 3D
structure depends on many variables.
• Current approaches often work by looking at
the structure of homologous (similar)
proteins.
• Improper folding of a protein is believed to be
the cause of mad cow disease.
•
•
•
•
•
•
www.bioalgorithms.info
Proteins tend to fold into the lowest
free energy conformation.
Proteins begin to fold while the
peptide is still being translated.
Proteins bury most of its hydrophobic
residues in an interior core to form an
α helix.
Most proteins take the form of
secondary structures α helices and β
sheets.
Molecular chaperones, hsp60 and hsp
70, work with other proteins to help
fold newly synthesized proteins.
Much of the protein modifications and
folding occurs in the endoplasmic
reticulum and mitochondria.
http://www.sanger.ac.uk/Users/sgj/thesis/node2.html for more information on folding
An Introduction to Bioinformatics Algorithms
www.bioalgorithms.info
An Introduction to Bioinformatics Algorithms
Protein Folding
Protein Folding (cont’d)
• Proteins are not linear structures, though they are
built that way
• The amino acids have very different chemical
properties; they interact with each other after the
protein is built
• The structure that a
protein adopts is vital to
it’s chemistry
• Its structure determines
which of its amino acids
are exposed carry out
the protein’s function
• Its structure also
determines what
substrates it can react
with
• This causes the protein to start fold and adopting it’s
functional structure
• Proteins may fold in reaction to some ions, and several
separate chains of peptides may join together through their
hydrophobic and hydrophilic amino acids to form a polymer
www.bioalgorithms.info
9