Comparative genomics is the analysis and comparison of genomes from
different species. The purpose is to gain a better understanding of
how species have evolved and to determine the function of genes and
non-coding regions of the genome.
Researchers have learned a great deal about the function of human
genes by examining their counterparts in simpler model organisms such
as the mouse. Genome researchers look at many different features when
comparing genomes: sequence similarity, gene location, the length and
number of coding regions (called exons) within genes, the amount of
non-coding DNA in each genome, and highly conserved regions maintained
in organisms as simple as bacteria and as complex as humans.
On the other hand, finding similarities is not as much important as
finding differences. The comparative approach also points out those
features which are unique for a given phylogenetic group or
particularly a species. Species specific functions can be involved in,
for instance, pathogenicity, resistance to antibiotics, and so on, but
also will result on more complex phenotypic characters such as the
human ability to speak.
Ab initio gene finding programs integrated different measures
obtained from the raw genomic sequences, such as G+C content,
periodicity of coding regions, exon bounds signal detection,
etc. The obvious next step was to include homology from the growing
annotation databases like SWISSPROT and EMBL/GenBank.
Modern gene prediction programs can integrate the data obtained from
the comparison of two genomes to improve the exonic structure of already
predicted genes. Furthermore, novel genes not represented in the
annotation databases can be found as well.
Before we start this practical on comparative gene-finding tools lets review some important concepts. Any of the following links will help us to illustrate some of them: Ensembl Synteny View of Chromosome 7, NCBI Homology Map of Chromosome 22.
|
In this section we will run several ab initio gene prediction
programs on a particular genomic DNA sequence and we will compare the
results against predicted genes from a gene finding program that uses
genomic homology. For each of these programs we will obtain a prediction of
a candidate gene and we will analyze the differences between
predictions and the annotation of the real gene both in human and
mouse.
The programs we are going to use are geneid, genscan
and fgenesh, which have been used in the previous practical
exercise. blast will be used to compare human and mouse
sequences. Then, sgp2 (syntenic gene prediction tool) will
predict genes taking into account the homology found between these two
species. Finally, we will take a look at comparative tools that are based
on the sequence alignment rather than on the gene prediction paradigm.
We are going to work with this
Human sequence, which is stored in FASTA format. We also provide
the homologous region in the mouse genome in this
Mouse sequence.
In the first approach, we will use all the ab initio tools
from the Gene Prediction section and compare the result of the three
programs. You could open a simple word processor and paste the results
of each gene-finding program in order to compare the coordinates of the
predicted exons.
Step 1.-
Analyzing the Human sequence.
In order to use geneid follow these steps:
In order to use genscan follow these steps:
In order to use fgenesh follow these steps:
Some questions:
Here you can find a plot with the predictions of the ab initio
gene finding tools in the human genome.
Step 2.-
Now, make the prediction in the Mouse sequence, with all the ab initio
programs.
Some questions:
Here you can find a plot with the predictions of the ab initio
gene finding tools in the mouse genome.
Do you find any common pattern between human and mouse prediction ?
In this section we will compare the human and the homologous mouse
sequence using blastn and tblastx on the NCBI's
server. Blastn compares a nucleotide query sequence against a
nucleotide sequence database and tblastx compares the
six-frame translations of a nucleotide query sequence against the
six-frame translations of a nucleotide sequence database.
Some questions:
Met Tyr Iso Ser Pro Asp ATG TAT ATC TCT CCC GAC ||| | | || || | | ATG TTT CTC AGC CCT GCC Met Phe Leu Ser Pro Ala Amino Acid Level Score +6 +3 +2 +4 +9 -2 Blosum45 : +22 +++ +-+ -++ --- ++- +-+ Match/Mismatch : +4 Nucleotide Level Score
In order to use blastn follow these steps:
In order to use tblastx follow these steps:
Are all the predicted exons supported by conserved regions ?
Here you can find a plot with the alignment results of the blastn and the tblastx alignments.
There are several programs to align and visualize pairs of large genomic
sequences, for instance: gff2aplot, Vista and
Pipmaker.
In this section we will use sgp2 to make the predictions
using the conservation pattern between human and mouse.
In order to use SGP2 follow these steps:
Some questions:
Here you can find the human predictions, the
mouse predictions and the human and mouse predictions with the
tblastx similarity regions.
There are other program that uses genomic comparison to improve gene
prediction: twinscan and slam.
Go to the UCSC genome browser
, and look for the annotation of this region in the human
genome. Open another web browser window and look for the annotation of
the mouse sequence in the mouse genome annotation.
The predictions we have obtained, are they consistent with the annotation of
the UCSC genome browser ?
Here you can find a plot sumarazing annotations from human and mouse.
![]() | ![]() |
Human annotations | Mouse annotations |
---|
Comparative analysis of DNA sequences from multiple species at varying evolutionary distances is a powerful approach for identifying coding and functional non-coding sequences, as well as sequences that are unique for a given organism. Here we will survey few of such tools.
Two well established programs, Vista and Pipmaker, will provide the best results. They are not easy to use as they require several input files, each having different formats, to obtain highly customized outputs, as it is illuastrated in the figure below (from Frazer et al, Genome Research, 13(1):1-12, 2002; by the way, a must read review).
More intuitive and user-friendly tools with similar capabilities have appeared recently, the most remarkable ones being the ECR-Browser, zPicture and eShadow (all three from the Comparative Genomics Center at Lawrence Livermore National Laboratory). The following figure illustrates the differences between pip- and smooth-plots.
Finally, we will see two web browsers that have been developed from the comparative genomics standpoint. You can follow the link to the K-Browser and the MultiContigView from Ensembl browser.