SlideShare a Scribd company logo
RNA Structure Analysis
RNA
• Ribonucleic acid
• Single-stranded nucleic acid polymer
• Carbohydrate is ribose
• fold into unique structures guided by
complementary pairing between nucleotide
bases.
• To many people:
– “RNA is the passive intermediary messenger
between DNA genes and the protein
translation machinery”
Non-coding RNAs
Many non-coding RNAs exist
 Adopt sophisticated 3D structures
 Catalyse biochemical reactions
Different classes of non-coding RNAs participate in
different cellular process:
 Gene expression regulation (miRNAs, piRNAs,
IncRNAs)
 RNA maturation (snRNAs, snoRNAs)
 Protein synthesis (rRNAs, tRNAs)
Three major types of RNA
• Messenger RNA (mRNA)
– Serving as a temporary copy of genes that is used as
a template for protein synthesis.
• Transfer RNA (tRNA)
– Functioning as adaptor molecules that decode the
genetic code.
• Ribosomal RNA (rRNA)
– Catalyzing the synthesis of proteins.
RNA secondary structure
• Unlike DNA, RNA is typically produced as
a single stranded molecule
• Then folds intramolecularly to form a
number of short base-paired stems.
• This base-paired structure is called the
secondary structure of the RNA.
Base Pairing
Pseudoknots
Nucleic acid secondary structure
containing at least two stem
loop structures in which half of
one stem is intercalated
between the two halves of
another stem
primary (sequence),
secondary (hairpins, bulges and internal loops),
tertiary (A‐minor motif, 3‐way junction, pseudoknot, etc.)
Elements of a
RNA secondary structure
• Loop: single stranded subsequence bounded by
base pairs
• Hairpin loop: a loop at the end of a stem
• Bulge (loop): single stranded bases occurring
within a stem
• Interior loop: single stranded bases interrupting
both sides of a stem
• Multi-branched loop/junctions: a loop from
which three or more stems radiate
Need
• Understanding the structures of RNA provides insights
into the functions of this class of molecules.
• Detailed structural information about RNA has significant
impact on understanding the mechanisms of a vast array
of cellular processes such as gene expression, viral
infection, and immunity.
• RNA structures can be experimentally determined using
x-ray crystallography or NMR techniques.
• However, these approaches are extremely time
consuming and expensive.
• As a result, computational prediction has become an
attractive alternative.
RNA Sequence Analysis
• The sequence evolution of RNA is
constrained by the structure.
• It is possible to have two different RNA
sequences with the same secondary
structure.
• Drastic changes in sequence can often be
tolerated as long as compensatory
mutations maintain base-pairing
complementarity.
SRP- signal recognition particle RNA
Computational Prediction
• At present, there are essentially two types of method of
RNA structure prediction.
• One is based on the calculation of the minimum free
energy of the all possible combinations of potential
double-stranded regions derived from a single RNA
sequence.
• This can be considered as ab initio approach.
• The second is a comparative approach which infers
structures based on an evolutionary comparison of
multiple related RNA sequences.
• Involves identification of Base Covariation that
maintains 2° and 3° structure of an RNA molecule during
evolution
Base covariation – sequence is changed while base pairing interations
are preserved
1. Ab Initio
• Many secondary structures can be drawn for a given
sequence
• Again, the number of secondary structures increases
exponentially with sequence length
– An RNA of 200 bases has over 1050 possible base-paired
structures
• Goal: Distinguish the biologically correct structure from all the
incorrect structures.
• In searching for the lowest energy form, all possible base-pair
patterns have to be examined.
• There are several methods for finding all the possible base-
paired regions from a given nucleic acid sequence.
• Two methods
– Dot matrix method
– Dynamic programming method
Dot Matrices
• A simple dot matrix can find all possible base-paring
patterns of an RNA sequence when one sequence is
compared with itself.
• Here dots are placed in the matrix to represent matching
complementary bases instead of identical ones.
• The diagonals perpendicular to the main diagonal
represent regions that can self hybridize to form
double-stranded structure with traditional A–U and G–
C base pairs.
• In reality, the pattern detection in a dot matrix is often
obscured by high noise levels.
• One way to reduce the noise in the matrix is to select an
appropriate window size of a minimum number of
contiguous base matches.
• Normally, only a window size of four consecutive base
matches is used.
• If the dot plot reveals more than one feasible structures,
the lowest energy one is chosen.
Dynamic Programming
• The use of a dot plot can be effective in finding a single
secondary structure in a small molecule.
• However, if a large molecule contains multiple secondary
structure segments, choosing a combination that is
energetically most stable among a large number of
possibilities can be difficult.
• In this approach, an RNA sequence is compared with itself.
• A scoring scheme is applied to fill the matrix with match
scores based on Watson–Crick base complementarity.
• A path with the maximal score within a scoring matrix after
taking into account the entire sequence information
represents the most probable secondary structure form.
• The dynamic programming method produces one
structure with a single best score.
• However, this is potentially a drawback of this approach
because in reality an RNA may exist in multiple alternative
forms with near minimum energy but not necessarily the
one with maximum base pairs.
Algorithms for RNA secondary
structure prediction
• We need:
– An algorithm for evaluating the scores of all
possible structures
– A function that assigns the correct structure
the highest score
• Two methods:
– Nussinov folding algorithm
– Zuker folding algorithm
Nussinov folding algorithm
• Goal:
Find the structure with the most base pairs
• Nussinov introduced an efficient dynamic programming algorithm
for this problem
• A recursive algorithm that calculates
– the best structure for small subsequences and
– computes for a given RNA sequence the maximal number of base pairs
of any nested structure
– Nussinov Algorithm solves the problem of RNA non-crossing
secondary structure prediction by base pair maximization
– Simplistic approach ;„Does not give accurate structure predictions.
Predictions; Misses: nearest neighbor interactions, stacking interactions,„
loop length preferences
Zuker folding algorithm
• Most sophisticated secondary structure prediction
method for single RNAs
– An energy minimisation algorithm which assumes
that the correct structure is the one with the
lowest equilibrium free energy
• The equilibrium free energy of an RNA secondary
structure is approximated as the sum of individual
contributions from loops, base pairs and other secondary
structure elements.
• The minimum energy structure can be calculated
recursively by a dynamic programming algorithm
very similar to how the maximum base-paired structure
was calculated like the Nussinov algorithm
Suboptimal RNA folding
• The original Zuker algorithm finds only the
optimal structure.
• The biologically correct structure is often not the
calculated optimal structure.
• suboptimal structures are structures that a
given sequence could fold into aside from the
minimum free energy structure
• Zuker introduced a suboptimal folding algorithm.
• The algorithm samples one base pair sub
optimally.
• The rest of the structure is the optimal structure
given that base pair.
• Difference with the Nussinov folding algorithm:
– Energies of stems are calculated by adding stacking
contributions for the interface between
neighbouring base pairs instead of individual
contributions for each pair.
• Advantage:
– Better fit to experimentally observed equilibrium free
energy values for RNA structures, but it complicates
the dynamic programming algorithm
Zuker folding algorithm
RNA Analysis Tools
• MFOLD: prediction of RNA Secondary Structure by
Energy Minimization (Zuker)
• RNAfold: calculate secondary structures of RNAs
RNAeval: calculate energy of RNA sequences on given
secondary structure
• RNAheat: calculate specific heat of RNAs
• RNAdistance: calculate distances of RNA secondary
structures
• RNApdist: calculate distances of thermodynamic RNA
secondary structures ensembles
• RNAinverse: find RNA sequences with given secondary
structure
RNA Analysis Tools
• RNAsubopt: calculate suboptimal secondary
structures of RNAs
• tRNAscan-SE: detection of transfer RNA genes
• FAStRNA: predicts potential tRNA genes in genomic
DNA sequences.
• FAStRNA-CM relies on a probabilistic model.
• FAStRNA-CLASS relies on a pattern-matching
approach.
• palindrome: Looks for inverted repeats in a nucleotide
sequence (EMBOSS).
• RNAGA: Prediction of common secondary structures of
RNAs by genetic algorithm (Chen, Le, Maizel)
MFOLD
• Predicts energetically most stable structure of an
RNA molecule.
• Also uses covariance information from
phylogenetically related sequences.
• Includes methods for graphic display of predicted
molecule.
• Used for sequence lengths < 1000 nucleotides in length.
• Demands more resources on computer
• Uses N3 complexity – where N is sequence length
• Doubling sequence length increases computation time
up to 8 times
2. COMPARATIVE APPROACH
• The comparative approach uses multiple
evolutionarily related RNA sequences to infer
a consensus structure.
• This approach is based on the assumption that
RNA sequences that deem to be homologous
fold into the same secondary structure.
• By comparing related RNA sequences, an
evolutionarily conserved secondary structure
can be derived.
Covariation
• To distinguish the conserved secondary structure among
multiple related RNA sequences, a concept of
“covariation” is used.
• It is known that RNA functional motifs are structurally
conserved.
• To maintain the secondary structures while the
homologous sequences evolve, a mutation occurring in
one position that is responsible for base pairing should
be compensated for by a mutation in the corresponding
base-pairing position so to maintain base pairing and the
stability of the secondary structure.
• Any lack of covariation can be deleterious to the RNA
structure and functions.
Consensus drawing
• Another aspect of the comparative method is to select a
common structure through consensus drawing.
• Because predicting secondary structures for each
individual sequence may produce errors, by comparing
all predicted structures of a group of aligned RNA
sequences and drawing a consensus, the commonly
adopted structure can be selected; many other possible
structures can be eliminated in the process.
• The comparative-based algorithms can be further
divided into two categories based on the type of input
data.
• One requires predefined alignment and the other does
not.
Algorithms That Use Prealignment
• This type of algorithm requires the user to provide a
pairwise or multiple alignment as input.
• The sequence alignment can be obtained using standard
alignment programs such as T-Coffee, PRRN, or Clustal.
• Based on the alignment input, the prediction programs
compute structurally consistent mutational patterns such
as covariation and derive a consensus structure
common for all the sequences.
• In practice, the consensus structure prediction is often
combined with thermodynamic calculations to improve
accuracy.
• This type of program is relatively successful for
reasonably conserved sequences.
RNAalifold
• RNAalifold (http://rna.tbi.univie.ac.at/cgi-
bin/alifold.cgi) is a program in the Vienna
package.
• It uses a multiple sequence alignment as
input to analyze covariation patterns on the
sequences.
• A scoring matrix is created that combines
minimum free energy and covariation
information.
• Dynamic programming is used to select the
structure that has the minimum energy for the
whole set of aligned RNA sequences.
Algorithms That Do Not Use
Prealignment
• This type of algorithm simultaneously aligns
multiple input sequences and infers a consensus
structure.
• The alignment is produced using dynamic
programming with a scoring scheme that
incorporates sequence similarity as well as
energy terms.
• Because the full dynamic programming for
multiple alignment is computationally too
demanding, currently available programs limit
the input to two sequences.
Foldalign
• Foldalign (http://foldalign.kvl.dk/server/index.html) is a
web-based program for RNA alignment and structure
prediction.
• The user provides a pair of unaligned sequences.
• The program uses a combination of Clustal and dynamic
programming with a scoring scheme that includes
covariation information to construct the alignment.
• A commonly conserved structure for both sequences is
subsequently derived based on the alignment.
• To reduce computational complexity, the program
ignores multibranch loops and is only suitable for
handling short RNA sequences.

More Related Content

What's hot

multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignment
harshita agarwal
 
Proteins databases
Proteins databasesProteins databases
Proteins databases
Hafiz Muhammad Zeeshan Raza
 
Sequence assembly
Sequence assemblySequence assembly
Sequence assembly
Dr. Naveen Gaurav srivastava
 
Pyrosequencing
PyrosequencingPyrosequencing
Pyrosequencing
qadardana kakar
 
PIR- Protein Information Resource
PIR- Protein Information ResourcePIR- Protein Information Resource
Cath
CathCath
Cath
Ramya S
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomicshemantbreeder
 
Protein Databases
Protein DatabasesProtein Databases
Protein protein interaction
Protein protein interactionProtein protein interaction
Protein protein interaction
Aashish Patel
 
Composite and Specialized databases
Composite and Specialized databasesComposite and Specialized databases
Sts
StsSts
Structural genomics
Structural genomicsStructural genomics
Structural genomics
Vaibhav Maurya
 
DNA data bank of japan (DDBJ)
DNA data bank of japan (DDBJ)DNA data bank of japan (DDBJ)
DNA data bank of japan (DDBJ)
ZoufishanY
 
Protein 3 d structure prediction
Protein 3 d structure predictionProtein 3 d structure prediction
Protein 3 d structure prediction
Samvartika Majumdar
 
Express sequence tags
Express sequence tagsExpress sequence tags
Express sequence tags
Dhananjay Desai
 
Sequence alignment
Sequence alignmentSequence alignment
Sequence alignment
Zeeshan Hanjra
 
Protein Database
Protein DatabaseProtein Database
Ab Initio Protein Structure Prediction
Ab Initio Protein Structure PredictionAb Initio Protein Structure Prediction
Ab Initio Protein Structure Prediction
Arindam Ghosh
 
Secondary Structure Prediction of proteins
Secondary Structure Prediction of proteins Secondary Structure Prediction of proteins
Secondary Structure Prediction of proteins
Vijay Hemmadi
 

What's hot (20)

multiple sequence alignment
multiple sequence alignmentmultiple sequence alignment
multiple sequence alignment
 
Proteins databases
Proteins databasesProteins databases
Proteins databases
 
Sequence assembly
Sequence assemblySequence assembly
Sequence assembly
 
Pyrosequencing
PyrosequencingPyrosequencing
Pyrosequencing
 
PIR- Protein Information Resource
PIR- Protein Information ResourcePIR- Protein Information Resource
PIR- Protein Information Resource
 
Cath
CathCath
Cath
 
Comparative genomics
Comparative genomicsComparative genomics
Comparative genomics
 
Protein Databases
Protein DatabasesProtein Databases
Protein Databases
 
Protein protein interaction
Protein protein interactionProtein protein interaction
Protein protein interaction
 
Composite and Specialized databases
Composite and Specialized databasesComposite and Specialized databases
Composite and Specialized databases
 
Sts
StsSts
Sts
 
Structural genomics
Structural genomicsStructural genomics
Structural genomics
 
DNA data bank of japan (DDBJ)
DNA data bank of japan (DDBJ)DNA data bank of japan (DDBJ)
DNA data bank of japan (DDBJ)
 
Protein 3 d structure prediction
Protein 3 d structure predictionProtein 3 d structure prediction
Protein 3 d structure prediction
 
Express sequence tags
Express sequence tagsExpress sequence tags
Express sequence tags
 
Sequence alignment
Sequence alignmentSequence alignment
Sequence alignment
 
Protein Database
Protein DatabaseProtein Database
Protein Database
 
Ab Initio Protein Structure Prediction
Ab Initio Protein Structure PredictionAb Initio Protein Structure Prediction
Ab Initio Protein Structure Prediction
 
Secondary Structure Prediction of proteins
Secondary Structure Prediction of proteins Secondary Structure Prediction of proteins
Secondary Structure Prediction of proteins
 
Est database
Est databaseEst database
Est database
 

Similar to RNA structure analysis

rna synthesis and working
rna synthesis and workingrna synthesis and working
rna synthesis and workingAnkit Bhardwaj
 
AI 바이오 (4일차).pdf
AI 바이오 (4일차).pdfAI 바이오 (4일차).pdf
AI 바이오 (4일차).pdf
H K Yoon
 
Computational Analysis with ICM
Computational Analysis with ICMComputational Analysis with ICM
Computational Analysis with ICMVernon D Dutch Jr
 
Rna secondary structure prediction, a cuckoo search approach
Rna secondary structure prediction, a cuckoo search approachRna secondary structure prediction, a cuckoo search approach
Rna secondary structure prediction, a cuckoo search approach
eSAT Journals
 
MOLECULAR ORGANIZATION OF EKARYOTIC RNA
 MOLECULAR ORGANIZATION OF EKARYOTIC RNA MOLECULAR ORGANIZATION OF EKARYOTIC RNA
MOLECULAR ORGANIZATION OF EKARYOTIC RNA
gohil sanjay bhagvanji
 
Dna based nanobioelectronics
Dna based nanobioelectronicsDna based nanobioelectronics
Dna based nanobioelectronicsudhay roopavath
 
Exploring Randomly Wired Neural Networks for Image Recognition
Exploring Randomly Wired Neural Networks for Image RecognitionExploring Randomly Wired Neural Networks for Image Recognition
Exploring Randomly Wired Neural Networks for Image Recognition
Yongsu Baek
 
Gutell 116.rpass.bibm11.pp618-622.2011
Gutell 116.rpass.bibm11.pp618-622.2011Gutell 116.rpass.bibm11.pp618-622.2011
Gutell 116.rpass.bibm11.pp618-622.2011
Robin Gutell
 
Motiffs
MotiffsMotiffs
Conformational study of polynucleotide
Conformational study of polynucleotideConformational study of polynucleotide
Conformational study of polynucleotide
KAUSHAL SAHU
 
Protein Threading
Protein ThreadingProtein Threading
Protein Threading
SANJANA PANDEY
 
RNASeq Experiment Design
RNASeq Experiment DesignRNASeq Experiment Design
RNASeq Experiment Design
Yaoyu Wang
 
DNA-RNA-Protein in microbes
DNA-RNA-Protein in microbesDNA-RNA-Protein in microbes
DNA-RNA-Protein in microbesCharles Spencer
 
wsn
wsnwsn
20110524zurichngs 2nd pub
20110524zurichngs 2nd pub20110524zurichngs 2nd pub
20110524zurichngs 2nd pubsesejun
 
PCR applications.pptx
PCR applications.pptxPCR applications.pptx
PCR applications.pptx
B. BHASKAR
 
Global and Local Sequence Alignment
Global and Local Sequence AlignmentGlobal and Local Sequence Alignment
Global and Local Sequence Alignment
AjayPatil210
 
DNA Sequencing- Sanger's Method
DNA Sequencing- Sanger's MethodDNA Sequencing- Sanger's Method
DNA Sequencing- Sanger's Method
Harsha Joseph
 
Semester presentation
Semester presentationSemester presentation
Semester presentation
khush bakhat
 

Similar to RNA structure analysis (20)

Nanotech
NanotechNanotech
Nanotech
 
rna synthesis and working
rna synthesis and workingrna synthesis and working
rna synthesis and working
 
AI 바이오 (4일차).pdf
AI 바이오 (4일차).pdfAI 바이오 (4일차).pdf
AI 바이오 (4일차).pdf
 
Computational Analysis with ICM
Computational Analysis with ICMComputational Analysis with ICM
Computational Analysis with ICM
 
Rna secondary structure prediction, a cuckoo search approach
Rna secondary structure prediction, a cuckoo search approachRna secondary structure prediction, a cuckoo search approach
Rna secondary structure prediction, a cuckoo search approach
 
MOLECULAR ORGANIZATION OF EKARYOTIC RNA
 MOLECULAR ORGANIZATION OF EKARYOTIC RNA MOLECULAR ORGANIZATION OF EKARYOTIC RNA
MOLECULAR ORGANIZATION OF EKARYOTIC RNA
 
Dna based nanobioelectronics
Dna based nanobioelectronicsDna based nanobioelectronics
Dna based nanobioelectronics
 
Exploring Randomly Wired Neural Networks for Image Recognition
Exploring Randomly Wired Neural Networks for Image RecognitionExploring Randomly Wired Neural Networks for Image Recognition
Exploring Randomly Wired Neural Networks for Image Recognition
 
Gutell 116.rpass.bibm11.pp618-622.2011
Gutell 116.rpass.bibm11.pp618-622.2011Gutell 116.rpass.bibm11.pp618-622.2011
Gutell 116.rpass.bibm11.pp618-622.2011
 
Motiffs
MotiffsMotiffs
Motiffs
 
Conformational study of polynucleotide
Conformational study of polynucleotideConformational study of polynucleotide
Conformational study of polynucleotide
 
Protein Threading
Protein ThreadingProtein Threading
Protein Threading
 
RNASeq Experiment Design
RNASeq Experiment DesignRNASeq Experiment Design
RNASeq Experiment Design
 
DNA-RNA-Protein in microbes
DNA-RNA-Protein in microbesDNA-RNA-Protein in microbes
DNA-RNA-Protein in microbes
 
wsn
wsnwsn
wsn
 
20110524zurichngs 2nd pub
20110524zurichngs 2nd pub20110524zurichngs 2nd pub
20110524zurichngs 2nd pub
 
PCR applications.pptx
PCR applications.pptxPCR applications.pptx
PCR applications.pptx
 
Global and Local Sequence Alignment
Global and Local Sequence AlignmentGlobal and Local Sequence Alignment
Global and Local Sequence Alignment
 
DNA Sequencing- Sanger's Method
DNA Sequencing- Sanger's MethodDNA Sequencing- Sanger's Method
DNA Sequencing- Sanger's Method
 
Semester presentation
Semester presentationSemester presentation
Semester presentation
 

More from Afra Fathima

Time management
Time managementTime management
Time management
Afra Fathima
 
Radio active labeling
Radio active labelingRadio active labeling
Radio active labeling
Afra Fathima
 
Micriobiology & Microbes
Micriobiology & MicrobesMicriobiology & Microbes
Micriobiology & Microbes
Afra Fathima
 
Identification of proteins by 2D gel
Identification of proteins by 2D gelIdentification of proteins by 2D gel
Identification of proteins by 2D gel
Afra Fathima
 
SDS PAGE
SDS PAGESDS PAGE
SDS PAGE
Afra Fathima
 
HIGH PERFORMANCE LIQUID CHROMATOGRAPHY
HIGH PERFORMANCE LIQUID CHROMATOGRAPHYHIGH PERFORMANCE LIQUID CHROMATOGRAPHY
HIGH PERFORMANCE LIQUID CHROMATOGRAPHY
Afra Fathima
 
Dialysis
DialysisDialysis
Dialysis
Afra Fathima
 
Lowry's method
Lowry's  methodLowry's  method
Lowry's method
Afra Fathima
 
Bradford's method
Bradford's methodBradford's method
Bradford's method
Afra Fathima
 
Ammonium sulphate precipitation
Ammonium sulphate precipitationAmmonium sulphate precipitation
Ammonium sulphate precipitation
Afra Fathima
 
Collection of blood, serum & plasma
Collection of blood, serum & plasmaCollection of blood, serum & plasma
Collection of blood, serum & plasma
Afra Fathima
 
Sub cellular fractionation
Sub cellular fractionationSub cellular fractionation
Sub cellular fractionation
Afra Fathima
 
Cells of the immune system
Cells of the immune systemCells of the immune system
Cells of the immune system
Afra Fathima
 
Cells of the immune system
Cells  of the immune system Cells  of the immune system
Cells of the immune system
Afra Fathima
 
Dinitro salicylic acid (DNSA) method
Dinitro salicylic acid (DNSA) methodDinitro salicylic acid (DNSA) method
Dinitro salicylic acid (DNSA) method
Afra Fathima
 
Cells of the immune system
Cells of the immune system Cells of the immune system
Cells of the immune system
Afra Fathima
 
Cells of the immune system
Cells  of the immune system Cells  of the immune system
Cells of the immune system
Afra Fathima
 
Cells of the immune system
Cells  of the immune system Cells  of the immune system
Cells of the immune system
Afra Fathima
 
Cells of the immune system
Cells  of the immune systemCells  of the immune system
Cells of the immune system
Afra Fathima
 
Sulphadiazine
SulphadiazineSulphadiazine
Sulphadiazine
Afra Fathima
 

More from Afra Fathima (20)

Time management
Time managementTime management
Time management
 
Radio active labeling
Radio active labelingRadio active labeling
Radio active labeling
 
Micriobiology & Microbes
Micriobiology & MicrobesMicriobiology & Microbes
Micriobiology & Microbes
 
Identification of proteins by 2D gel
Identification of proteins by 2D gelIdentification of proteins by 2D gel
Identification of proteins by 2D gel
 
SDS PAGE
SDS PAGESDS PAGE
SDS PAGE
 
HIGH PERFORMANCE LIQUID CHROMATOGRAPHY
HIGH PERFORMANCE LIQUID CHROMATOGRAPHYHIGH PERFORMANCE LIQUID CHROMATOGRAPHY
HIGH PERFORMANCE LIQUID CHROMATOGRAPHY
 
Dialysis
DialysisDialysis
Dialysis
 
Lowry's method
Lowry's  methodLowry's  method
Lowry's method
 
Bradford's method
Bradford's methodBradford's method
Bradford's method
 
Ammonium sulphate precipitation
Ammonium sulphate precipitationAmmonium sulphate precipitation
Ammonium sulphate precipitation
 
Collection of blood, serum & plasma
Collection of blood, serum & plasmaCollection of blood, serum & plasma
Collection of blood, serum & plasma
 
Sub cellular fractionation
Sub cellular fractionationSub cellular fractionation
Sub cellular fractionation
 
Cells of the immune system
Cells of the immune systemCells of the immune system
Cells of the immune system
 
Cells of the immune system
Cells  of the immune system Cells  of the immune system
Cells of the immune system
 
Dinitro salicylic acid (DNSA) method
Dinitro salicylic acid (DNSA) methodDinitro salicylic acid (DNSA) method
Dinitro salicylic acid (DNSA) method
 
Cells of the immune system
Cells of the immune system Cells of the immune system
Cells of the immune system
 
Cells of the immune system
Cells  of the immune system Cells  of the immune system
Cells of the immune system
 
Cells of the immune system
Cells  of the immune system Cells  of the immune system
Cells of the immune system
 
Cells of the immune system
Cells  of the immune systemCells  of the immune system
Cells of the immune system
 
Sulphadiazine
SulphadiazineSulphadiazine
Sulphadiazine
 

Recently uploaded

Cancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate PathwayCancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate Pathway
AADYARAJPANDEY1
 
Nutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technologyNutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technology
Lokesh Patil
 
Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...
Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...
Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...
NathanBaughman3
 
general properties of oerganologametal.ppt
general properties of oerganologametal.pptgeneral properties of oerganologametal.ppt
general properties of oerganologametal.ppt
IqrimaNabilatulhusni
 
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCINGRNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
AADYARAJPANDEY1
 
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdfUnveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Erdal Coalmaker
 
Citrus Greening Disease and its Management
Citrus Greening Disease and its ManagementCitrus Greening Disease and its Management
Citrus Greening Disease and its Management
subedisuryaofficial
 
Structures and textures of metamorphic rocks
Structures and textures of metamorphic rocksStructures and textures of metamorphic rocks
Structures and textures of metamorphic rocks
kumarmathi863
 
GBSN - Microbiology (Lab 4) Culture Media
GBSN - Microbiology (Lab 4) Culture MediaGBSN - Microbiology (Lab 4) Culture Media
GBSN - Microbiology (Lab 4) Culture Media
Areesha Ahmad
 
Lab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerinLab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerin
ossaicprecious19
 
Richard's entangled aventures in wonderland
Richard's entangled aventures in wonderlandRichard's entangled aventures in wonderland
Richard's entangled aventures in wonderland
Richard Gill
 
platelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptxplatelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptx
muralinath2
 
Leaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdfLeaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdf
RenuJangid3
 
NuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final versionNuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final version
pablovgd
 
insect taxonomy importance systematics and classification
insect taxonomy importance systematics and classificationinsect taxonomy importance systematics and classification
insect taxonomy importance systematics and classification
anitaento25
 
4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf
4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf
4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf
ssuserbfdca9
 
Comparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebratesComparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebrates
sachin783648
 
EY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptxEY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptx
AlguinaldoKong
 
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
muralinath2
 
Lateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensiveLateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensive
silvermistyshot
 

Recently uploaded (20)

Cancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate PathwayCancer cell metabolism: special Reference to Lactate Pathway
Cancer cell metabolism: special Reference to Lactate Pathway
 
Nutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technologyNutraceutical market, scope and growth: Herbal drug technology
Nutraceutical market, scope and growth: Herbal drug technology
 
Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...
Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...
Astronomy Update- Curiosity’s exploration of Mars _ Local Briefs _ leadertele...
 
general properties of oerganologametal.ppt
general properties of oerganologametal.pptgeneral properties of oerganologametal.ppt
general properties of oerganologametal.ppt
 
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCINGRNA INTERFERENCE: UNRAVELING GENETIC SILENCING
RNA INTERFERENCE: UNRAVELING GENETIC SILENCING
 
Unveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdfUnveiling the Energy Potential of Marshmallow Deposits.pdf
Unveiling the Energy Potential of Marshmallow Deposits.pdf
 
Citrus Greening Disease and its Management
Citrus Greening Disease and its ManagementCitrus Greening Disease and its Management
Citrus Greening Disease and its Management
 
Structures and textures of metamorphic rocks
Structures and textures of metamorphic rocksStructures and textures of metamorphic rocks
Structures and textures of metamorphic rocks
 
GBSN - Microbiology (Lab 4) Culture Media
GBSN - Microbiology (Lab 4) Culture MediaGBSN - Microbiology (Lab 4) Culture Media
GBSN - Microbiology (Lab 4) Culture Media
 
Lab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerinLab report on liquid viscosity of glycerin
Lab report on liquid viscosity of glycerin
 
Richard's entangled aventures in wonderland
Richard's entangled aventures in wonderlandRichard's entangled aventures in wonderland
Richard's entangled aventures in wonderland
 
platelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptxplatelets_clotting_biogenesis.clot retractionpptx
platelets_clotting_biogenesis.clot retractionpptx
 
Leaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdfLeaf Initiation, Growth and Differentiation.pdf
Leaf Initiation, Growth and Differentiation.pdf
 
NuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final versionNuGOweek 2024 Ghent - programme - final version
NuGOweek 2024 Ghent - programme - final version
 
insect taxonomy importance systematics and classification
insect taxonomy importance systematics and classificationinsect taxonomy importance systematics and classification
insect taxonomy importance systematics and classification
 
4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf
4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf
4. An Overview of Sugarcane White Leaf Disease in Vietnam.pdf
 
Comparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebratesComparative structure of adrenal gland in vertebrates
Comparative structure of adrenal gland in vertebrates
 
EY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptxEY - Supply Chain Services 2018_template.pptx
EY - Supply Chain Services 2018_template.pptx
 
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
Circulatory system_ Laplace law. Ohms law.reynaults law,baro-chemo-receptors-...
 
Lateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensiveLateral Ventricles.pdf very easy good diagrams comprehensive
Lateral Ventricles.pdf very easy good diagrams comprehensive
 

RNA structure analysis

  • 2. RNA • Ribonucleic acid • Single-stranded nucleic acid polymer • Carbohydrate is ribose • fold into unique structures guided by complementary pairing between nucleotide bases. • To many people: – “RNA is the passive intermediary messenger between DNA genes and the protein translation machinery”
  • 3.
  • 4. Non-coding RNAs Many non-coding RNAs exist  Adopt sophisticated 3D structures  Catalyse biochemical reactions Different classes of non-coding RNAs participate in different cellular process:  Gene expression regulation (miRNAs, piRNAs, IncRNAs)  RNA maturation (snRNAs, snoRNAs)  Protein synthesis (rRNAs, tRNAs)
  • 5. Three major types of RNA • Messenger RNA (mRNA) – Serving as a temporary copy of genes that is used as a template for protein synthesis. • Transfer RNA (tRNA) – Functioning as adaptor molecules that decode the genetic code. • Ribosomal RNA (rRNA) – Catalyzing the synthesis of proteins.
  • 6. RNA secondary structure • Unlike DNA, RNA is typically produced as a single stranded molecule • Then folds intramolecularly to form a number of short base-paired stems. • This base-paired structure is called the secondary structure of the RNA.
  • 8. Pseudoknots Nucleic acid secondary structure containing at least two stem loop structures in which half of one stem is intercalated between the two halves of another stem
  • 9. primary (sequence), secondary (hairpins, bulges and internal loops), tertiary (A‐minor motif, 3‐way junction, pseudoknot, etc.)
  • 10. Elements of a RNA secondary structure • Loop: single stranded subsequence bounded by base pairs • Hairpin loop: a loop at the end of a stem • Bulge (loop): single stranded bases occurring within a stem • Interior loop: single stranded bases interrupting both sides of a stem • Multi-branched loop/junctions: a loop from which three or more stems radiate
  • 11.
  • 12. Need • Understanding the structures of RNA provides insights into the functions of this class of molecules. • Detailed structural information about RNA has significant impact on understanding the mechanisms of a vast array of cellular processes such as gene expression, viral infection, and immunity. • RNA structures can be experimentally determined using x-ray crystallography or NMR techniques. • However, these approaches are extremely time consuming and expensive. • As a result, computational prediction has become an attractive alternative.
  • 13. RNA Sequence Analysis • The sequence evolution of RNA is constrained by the structure. • It is possible to have two different RNA sequences with the same secondary structure. • Drastic changes in sequence can often be tolerated as long as compensatory mutations maintain base-pairing complementarity.
  • 14. SRP- signal recognition particle RNA
  • 15.
  • 16. Computational Prediction • At present, there are essentially two types of method of RNA structure prediction. • One is based on the calculation of the minimum free energy of the all possible combinations of potential double-stranded regions derived from a single RNA sequence. • This can be considered as ab initio approach. • The second is a comparative approach which infers structures based on an evolutionary comparison of multiple related RNA sequences. • Involves identification of Base Covariation that maintains 2° and 3° structure of an RNA molecule during evolution Base covariation – sequence is changed while base pairing interations are preserved
  • 17. 1. Ab Initio • Many secondary structures can be drawn for a given sequence • Again, the number of secondary structures increases exponentially with sequence length – An RNA of 200 bases has over 1050 possible base-paired structures • Goal: Distinguish the biologically correct structure from all the incorrect structures. • In searching for the lowest energy form, all possible base-pair patterns have to be examined. • There are several methods for finding all the possible base- paired regions from a given nucleic acid sequence. • Two methods – Dot matrix method – Dynamic programming method
  • 18. Dot Matrices • A simple dot matrix can find all possible base-paring patterns of an RNA sequence when one sequence is compared with itself. • Here dots are placed in the matrix to represent matching complementary bases instead of identical ones. • The diagonals perpendicular to the main diagonal represent regions that can self hybridize to form double-stranded structure with traditional A–U and G– C base pairs. • In reality, the pattern detection in a dot matrix is often obscured by high noise levels. • One way to reduce the noise in the matrix is to select an appropriate window size of a minimum number of contiguous base matches. • Normally, only a window size of four consecutive base matches is used. • If the dot plot reveals more than one feasible structures, the lowest energy one is chosen.
  • 19.
  • 20. Dynamic Programming • The use of a dot plot can be effective in finding a single secondary structure in a small molecule. • However, if a large molecule contains multiple secondary structure segments, choosing a combination that is energetically most stable among a large number of possibilities can be difficult. • In this approach, an RNA sequence is compared with itself. • A scoring scheme is applied to fill the matrix with match scores based on Watson–Crick base complementarity. • A path with the maximal score within a scoring matrix after taking into account the entire sequence information represents the most probable secondary structure form. • The dynamic programming method produces one structure with a single best score. • However, this is potentially a drawback of this approach because in reality an RNA may exist in multiple alternative forms with near minimum energy but not necessarily the one with maximum base pairs.
  • 21. Algorithms for RNA secondary structure prediction • We need: – An algorithm for evaluating the scores of all possible structures – A function that assigns the correct structure the highest score • Two methods: – Nussinov folding algorithm – Zuker folding algorithm
  • 22. Nussinov folding algorithm • Goal: Find the structure with the most base pairs • Nussinov introduced an efficient dynamic programming algorithm for this problem • A recursive algorithm that calculates – the best structure for small subsequences and – computes for a given RNA sequence the maximal number of base pairs of any nested structure – Nussinov Algorithm solves the problem of RNA non-crossing secondary structure prediction by base pair maximization – Simplistic approach ;„Does not give accurate structure predictions. Predictions; Misses: nearest neighbor interactions, stacking interactions,„ loop length preferences
  • 23. Zuker folding algorithm • Most sophisticated secondary structure prediction method for single RNAs – An energy minimisation algorithm which assumes that the correct structure is the one with the lowest equilibrium free energy • The equilibrium free energy of an RNA secondary structure is approximated as the sum of individual contributions from loops, base pairs and other secondary structure elements. • The minimum energy structure can be calculated recursively by a dynamic programming algorithm very similar to how the maximum base-paired structure was calculated like the Nussinov algorithm
  • 24. Suboptimal RNA folding • The original Zuker algorithm finds only the optimal structure. • The biologically correct structure is often not the calculated optimal structure. • suboptimal structures are structures that a given sequence could fold into aside from the minimum free energy structure • Zuker introduced a suboptimal folding algorithm. • The algorithm samples one base pair sub optimally. • The rest of the structure is the optimal structure given that base pair.
  • 25. • Difference with the Nussinov folding algorithm: – Energies of stems are calculated by adding stacking contributions for the interface between neighbouring base pairs instead of individual contributions for each pair. • Advantage: – Better fit to experimentally observed equilibrium free energy values for RNA structures, but it complicates the dynamic programming algorithm Zuker folding algorithm
  • 26. RNA Analysis Tools • MFOLD: prediction of RNA Secondary Structure by Energy Minimization (Zuker) • RNAfold: calculate secondary structures of RNAs RNAeval: calculate energy of RNA sequences on given secondary structure • RNAheat: calculate specific heat of RNAs • RNAdistance: calculate distances of RNA secondary structures • RNApdist: calculate distances of thermodynamic RNA secondary structures ensembles • RNAinverse: find RNA sequences with given secondary structure
  • 27. RNA Analysis Tools • RNAsubopt: calculate suboptimal secondary structures of RNAs • tRNAscan-SE: detection of transfer RNA genes • FAStRNA: predicts potential tRNA genes in genomic DNA sequences. • FAStRNA-CM relies on a probabilistic model. • FAStRNA-CLASS relies on a pattern-matching approach. • palindrome: Looks for inverted repeats in a nucleotide sequence (EMBOSS). • RNAGA: Prediction of common secondary structures of RNAs by genetic algorithm (Chen, Le, Maizel)
  • 28. MFOLD • Predicts energetically most stable structure of an RNA molecule. • Also uses covariance information from phylogenetically related sequences. • Includes methods for graphic display of predicted molecule. • Used for sequence lengths < 1000 nucleotides in length. • Demands more resources on computer • Uses N3 complexity – where N is sequence length • Doubling sequence length increases computation time up to 8 times
  • 29. 2. COMPARATIVE APPROACH • The comparative approach uses multiple evolutionarily related RNA sequences to infer a consensus structure. • This approach is based on the assumption that RNA sequences that deem to be homologous fold into the same secondary structure. • By comparing related RNA sequences, an evolutionarily conserved secondary structure can be derived.
  • 30. Covariation • To distinguish the conserved secondary structure among multiple related RNA sequences, a concept of “covariation” is used. • It is known that RNA functional motifs are structurally conserved. • To maintain the secondary structures while the homologous sequences evolve, a mutation occurring in one position that is responsible for base pairing should be compensated for by a mutation in the corresponding base-pairing position so to maintain base pairing and the stability of the secondary structure. • Any lack of covariation can be deleterious to the RNA structure and functions.
  • 31. Consensus drawing • Another aspect of the comparative method is to select a common structure through consensus drawing. • Because predicting secondary structures for each individual sequence may produce errors, by comparing all predicted structures of a group of aligned RNA sequences and drawing a consensus, the commonly adopted structure can be selected; many other possible structures can be eliminated in the process. • The comparative-based algorithms can be further divided into two categories based on the type of input data. • One requires predefined alignment and the other does not.
  • 32. Algorithms That Use Prealignment • This type of algorithm requires the user to provide a pairwise or multiple alignment as input. • The sequence alignment can be obtained using standard alignment programs such as T-Coffee, PRRN, or Clustal. • Based on the alignment input, the prediction programs compute structurally consistent mutational patterns such as covariation and derive a consensus structure common for all the sequences. • In practice, the consensus structure prediction is often combined with thermodynamic calculations to improve accuracy. • This type of program is relatively successful for reasonably conserved sequences.
  • 33. RNAalifold • RNAalifold (http://rna.tbi.univie.ac.at/cgi- bin/alifold.cgi) is a program in the Vienna package. • It uses a multiple sequence alignment as input to analyze covariation patterns on the sequences. • A scoring matrix is created that combines minimum free energy and covariation information. • Dynamic programming is used to select the structure that has the minimum energy for the whole set of aligned RNA sequences.
  • 34. Algorithms That Do Not Use Prealignment • This type of algorithm simultaneously aligns multiple input sequences and infers a consensus structure. • The alignment is produced using dynamic programming with a scoring scheme that incorporates sequence similarity as well as energy terms. • Because the full dynamic programming for multiple alignment is computationally too demanding, currently available programs limit the input to two sequences.
  • 35. Foldalign • Foldalign (http://foldalign.kvl.dk/server/index.html) is a web-based program for RNA alignment and structure prediction. • The user provides a pair of unaligned sequences. • The program uses a combination of Clustal and dynamic programming with a scoring scheme that includes covariation information to construct the alignment. • A commonly conserved structure for both sequences is subsequently derived based on the alignment. • To reduce computational complexity, the program ignores multibranch loops and is only suitable for handling short RNA sequences.