Skip to main content

Variant Ranker: a web-tool to rank genomic data according to functional significance

Abstract

Background

The increasing volume and complexity of high-throughput genomic data make analysis and prioritization of variants difficult for researchers with limited bioinformatics skills. Variant Ranker allows researchers to rank identified variants and determine the most confident variants for experimental validation.

Results

We describe Variant Ranker, a user-friendly simple web-based tool for ranking, filtering and annotation of coding and non-coding variants. Variant Ranker facilitates the identification of causal variants based on novelty, effect and annotation information. The algorithm implements and aggregates multiple prediction algorithm scores, conservation scores, allelic frequencies, clinical information and additional open-source annotations using accessible databases via ANNOVAR. The available information for a variant is transformed into user-specified weights, which are in turn encoded into the ranking algorithm. Through its different modules, users can (i) rank a list of variants (ii) perform genotype filtering for case-control samples (iii) filter large amounts of high-throughput data based on user custom filter requirements and apply different models of inheritance (iv) perform downstream functional enrichment analysis through network visualization. Using networks, users can identify clusters of genes that belong to multiple ontology categories (like pathways, gene ontology, disease categories) and therefore expedite scientific discoveries. We demonstrate the utility of Variant Ranker to identify causal genes using real and synthetic datasets. Our results indicate that Variant Ranker exhibits excellent performance by correctly identifying and ranking the candidate genes

Conclusions

Variant Ranker is a freely available web server on http://paschou-lab.mbg.duth.gr/Software.html. This tool will enable users to prioritise potentially causal variants and is applicable to a wide range of sequencing data.

Background

Identifying causal variants is critical to understanding the pathogenesis of diseases. With the advancement in high-throughput next-generation genomic technology, whole genome sequencing, exome sequencing, RNA-Seq and ChIP-Seq are now becoming standard for identifying susceptibility loci in complex and Mendelian disorders. The challenge lies in sifting through the vast amount of data these techniques generate to identify causal variants. In addition to this, researchers often face the dilemma of not knowing which is the “optimal” algorithm to use for prediction of deleteriousness (e.g.’s PolyPhen [1], SIFT [2], MutationTaster [3]) and conservation (e.g.’s PhyloP [4], SiPhy [5], GERP [6]), as there exists considerable variability in predictions from different tools. Furthermore, annotations of variant functionality tend to vary from one database to the other. There are several very useful tools for annotation of variants like SnpEff [7], SeattleSeq [8] or ANNOVAR [9] however they lack the ability to rank variants. Tools like like eXtasy [10] and SPRING [11] are limited to ranking non-synonymous variants alone. In other cases, tools like VAAST [12] and KGGSeq [13] are useful command line tools to prioritize disease-causing variants but typically the user will need some level of programming knowledge to download and execute the tools.

We have developed a web based bioinformatics tool, Variant Ranker to address current challenges in interpreting genomic data by providing a simple method to combine predictions and annotations of variants from various algorithms and databases respectively. The end result is a ranked list of variants to take forward for functional studies or experimental validation. Using this tool, a ranked list of prioritized variants is generated by computing a single score combining existing and available information present for a variant from several databases. Variant Ranker is applicable to all types of sequencing data using the de factoVCF [14] and ANNOVAR [9]) formats. The advantages of this tool are the ease of use, ability to score all variants (coding and non-coding) and flexibility in filtering offered to the user. Users can query results quickly through the database, thus providing easily accessible and interpretable outputs, including for those with limited bioinformatics skills. For the purpose of downstream functional enrichment analysis to discover vital biological connections from a ranked list of variants/genes, the Network Analyser is integrated; a network visualization tool that investigates tabular results from DAVID (database for annotation, visualization and integrated discovery, https://david.ncifcrf.gov) [15, 16] through a network approach.

Implementation

The user-friendly website is constructed on an Apache web server and exploits a MySQL database using PHP, JQuery and R. Figure 1 depicts the Variant Ranker system architecture and workflow. Figure 2 depicts Variant Ranker’s functionality along with its available modules for variant/gene list analysis. We provide online tutorials with example analysis for using Variant Ranker and its available modules.

Fig. 1
figure 1

Variant Ranker system architecture and workflow

Fig. 2
figure 2

Variant Ranker’s functionality along with its available modules for variant/gene list analysis

Variant annotation

To facilitate the combination of various prediction algorithms and annotations, we use the annotations of variants from software ANNOVAR [9](see Fig. 3 a). Encoding annotations include: (i) Variant position and dbSNP IDs, (ii) Population frequency - rare or novel variants from 1000 Genomes Project [17], Exome Sequencing Project [18] and Exome Aggregation Consortium (ExAC) [19], (iii) Gene annotations from RefSeq [20] and ENSEMBL [21] including variant classifications like intronic/ncRNA/UTRs/exonic (nonsynonymous/stoploss/stopgain etc.), (iv) Functional prediction scores (SIFT [2], PolyPhen2 [1], LRT [22], MetaLR [23], MetaSVM [23], MutationTaster [3], MutationAssessor [24] and FATHMM [25]), (v) Conservation scores (PhyloP [4], GERP++ [6], phastCons [26], SiPhy [5]), (vi) Encoding elements from ENCODE [27], and (vii) Disease annotations (GWAS catalog [28] and clinVar [29]). Scores from CADD [30] are also included in the ranking output.

Fig. 3
figure 3

a Variant Ranker input parameter page showing default weights. These weights can be changed by the user. b Top 20 candidate genes from analysing an exome of an individual having idiopathic hemolytic anemia (IHA) for which PKLR was identified as the most likely causative gene

Variant ranking algorithm

Using available annotations, all the variants are encoded by assigning weights between 0 and 1. For example, a variant is given weights following the ANNOVAR annotation precedence rule: exonic=splicing >ncRNA >UTR5/UTR3 >intron >upstream/downstream >intergenic and will have corresponding weights 1, 5/6, 4/6, 3/6, 2/6, and 1/6 respectively. Scores from conservation and prediction algorithms are converted to corresponding weights using each algorithm-scoring cut off. For example, if a variant has GERP [6] score>2 (highly conserved), it is given a corresponding weight of 1 otherwise 0. Similarly for prediction algorithm Polyphen2, weights follow 1 (damaging), 0.5 (possibly damaging) and 0 (benign) and SIFT [2], LRT [22], MetalLR [23], MetaSVM [23], MutationTaster [3], MutationAssessor [24], and FATHMM [25] follow weights 1 (deleterious) and 0 (tolerated). Binary weights (1 or 0) are applied to variants carrying ENCODE [27] elements, transcription factor binding sites or conserved sites and also if absent from dbSNP or present in the GWAS catalog [28]) or clinVAR [29] database. For population frequency databases, weights are assigned (1 – allele frequency) in order to assign more weight to rare alleles.

A higher score is thus given for a functionally important variant which is novel and predicted to be deleterious by several prediction algorithms (different algorithms tend to have different predictions). The total score for each variant is obtained by taking the sum of encoded weights per variant, and then all variants are sorted by their total score and ranked. Implementing such a score overcomes annotation discrepancies from various databases wherein a variant might be called exonic in one and intronic in the other or prediction scores may range from deleterious to tolerant from program to program. This also has the advantage of having a single score for all variants based on the available information per variant.

Results

To demonstrate the utility of Variant Ranker, we applied the tool to both real exome sequencing and synthetic exome datasets. Our results indicate that Variant Ranker exhibits excellent performance by correctly identifying and ranking the candidate genes. For fully ranked annotation results see http://paschou-lab.mbg.duth.gr/html5up/Examples.html

Analysis of a real exome sequencing dataset on idiopathic hemolytic anemia (MIM: 266200)

We used the exome of an individual with idiopathic hemolytic anemia (IHA) for which PKLR was identified as the most likely causative gene [31, 32]. 28,644 variants were ranked reporting PKLR as the 4th rank. On applying further filtering using the autosomal rare recessive model, the number of variants reduced to 28 with PKLR as the top candidate gene (out of 14 candidate genes) Fig. 3 b.

Analysis of synthetic whole-genome sequencing dataset on Pfeiffer syndrome (MIM: 101600)

We supplemented the p.E173A mutation into a normal exome VCF file containing 33,862 variants in the FGFR2 gene associated with Pfeiffer syndrome (MIM:101600). The FGFR2 gene was listed as the top candidate by the rank score. Pfeifer syndrome is an autosomal dominant Mendelian disease and so we applied the autosomal rare dominant model, which further reduced the number of variants to 541 variants, with FGFR2 still remaining as the top candidate gene.

Analysis of synthetic whole-genome sequencing dataset on Miller syndrome (MIM: 263750)

We supplemented two known variants (p.G202A and p.G152R) into the DHODH gene causing Miller syndrome (MIM: 263750) in the normal exome and applied the rare recessive autosomal disease model filter. The large number of input variants was drastically reduced to 59 variants (28 candidate genes), including the causal gene DHODH ranked as the top candidate gene.

Analysis of targeted resequencing Tourette Syndrome candidate genes

We applied our algorithm to the first study applying next generation sequencing technology in search for genetic susceptibility variants in candidate Tourette Syndrome genes using a set of 382 TS individuals. In this study [33], we identified 17 nonsynonymous variants and experimentally validated five deleterious rare variants. Interestingly, the five variants identified were within the top 6 ranks of our Variant Ranker result.

Family-exome Alzheimer analysis

Our algorithm was applied to describe the genetic findings of two siblings with Alzheimer-type dementia [34]. The exomes of the two siblings were filtered against their unaffected aunt and the variants were ranked using our Variant Ranker algorithm. By integrating our ranked results along with other prioritization methods, we were able to get a ranked list of genes which were used for pathway/disease network exploration using our Result Explorer module. Our results indicate a set of genes working together in different pathways contributing to the etiology of the complex phenotype.

Comparison with other web tools

We compare Variant Ranker with four similar web-tools using three of our validation datasets, as shown in Table 1. Compared to the other tools, Variant Ranker correctly identifies the candidate gene for the respective disorders in all three validation datasets. Feature comparison of the different tools is shown in Table 2. Our tool,Variant Ranker, benefits from the simplicity of the ranking formula, which does not necessitate any prior knowledge for the disorder, e.g., knowledge of the inheritance model or required phenotypic/HPO(Human Phenotype Ontology) terms. With default parameters and no model application or special filtering, our tool consistently ranks the candidate genes among the top ten hits that it returns. This is a reasonable cutoff for downstream experimental validation. Web tools like eXtasy [10] that require HPO/phenotypic terms are not competitive with our tool in the case of diagnostic analysis of disorders where no such prior knowledge exists. Unlike Variant Ranker, eXtasy [10] is also limited to ranking of non-synonymous variants alone. We also note that wANNOVAR [32] prioritises variants through efficient filtering strategies, but does not produce a ranked list of variants. PhenIX [35] produces a ranked list of genes by calculating clinical similarity using the semantic similarity of HPO terms that areprovided by the user, thus limiting itself to known disease genes.

Table 1 Candidate rank comparison using similar web-tools with three of our validation data sets
Table 2 Feature comparison with similar web-tools

Discussion

Variant Ranker

Input fields include the user’s e-mail address, sample identifier and weighted input parameters between 0 and 1. A default set of weights is provided although the user can change the weights in the input text field (Fig. 3 a) and also deselect databases/algorithms that need to be excluded from the ranking algorithm using the appropriate checkboxes. Users can input a list of variants to prioritize in the form of the de facto VCF format or a simple text-based ANNOVAR input format (1-based coordinate system is used with the hg19 human reference build). Our algorithm focuses on biallelic variants and the input file size is restricted to 500 MB. Identified INDELs are excluded from our ranking algorithm although are annotated and provided separately for examination by the user. The output page provides a table of top ranked variants listing 1000 variants at a time and sorted by rank score. We provide a graphical representation for the distribution of the number of SNPs in each chromosome. Below this are a summary of variant counts based on their location and a combined table depicting the summary of scores from CADD, our ranking method and mutation counts per gene (excluding SNPs in non-genic regions i.e. intergenic, upstream or downstream). Users can query the tables on the webpage, sort the output using each of the available columns and also download complete results and import it into Excel. We also provide external links to UCSC genome browser, genecards and ensembl, in order to to provide the user with additional annotation information like gene expression in different tissues through UCSC or additional pathway/disease information from genecards. Results can also be easily shared via URL. The server process fairly quickly under light load. For example 28,000-150,000 variants required about 20-30 minutes to process and a larger file of ~1,000,000 variants took approximately 5 hours to process.

Prioritization of variants by filtering (Result Explorer)

The user can explore the entire ranked volume of data and apply various filtering procedures using the Result Explorer module. Options to apply different models of inheritance and also build custom pipelines to filter data using basic SQL queries are available through the advanced query option. The users can search for functional variants and filter by MAF (minor allele frequency) and number of rare mutations per gene. Sample pipelines are provided in the tutorial to filter for (i) variants present in databases like clinVar or GWAS Catalog (ii) functionally important novel variants like exonic (nonsynonymous, stop-loss and stop-gain variants) and splicing sites, (iii) filtering for rare/common variants (MAF filtering) using 1000 genomes, ESP600, and ExAC databases.

Disease model filtering

For our model filtering criteria, the autosomal dominant filter keeps genes that carry at least one functionally important variant i.e., nonsynonymous, splicing or stopgain/stoploss variant. The autosomal recessive filter keeps genes that carry two or more functionally important variants. The X-recessive filter requires a functionally important variant to be present on the chromosome X positioned gene.

Case control genotype filtering

For users who want to analyse variants in Case versus Control groups, the CaseControl filtering module can be used to filter for case-control genotype differences in order to get a list of variants which can be further ranked using Variant Ranker. This module makes use of SnpSift tool [7] to calculate the number of homozygous, heterozygous and total alleles in both Cases and Controls to enable case-control filtering. In this module, processing time for ~1,000,000 variants took only 4 minutes.

Visualizing functionally enriched terms (Network Analyser)

The network web based tool uses RDAVIDWebService package [36] in R to query ontologies. The network is generated using the Cytoscape simple interaction file (SIF) format and is clustered based on Cytoscape’s default web visual style. Gene information is ascribed to hits from the NCBI database. Users can submit top candidate gene symbols (HGNC symbols) and identify overlapping genes from different functionally enriched annotation categories like pathways/ontologies/diseases. Different levels of annotation categories can be explored by filtering using count of genes per category and DAVID p-value. The SNPtoGene module can be used to map a list of chromosome locations to HGNC gene names.

Conclusions

We present Variant Ranker; a new web server for performing annotation, filtering and ranking of identified genomic variants based on various available databases of genetic variants and facilitating a system for a-priori weight input by the user to identify the most important variants under study. It is a simple and user-friendly web-tool with the ability to rank both coding and non-coding variants by encoding and integrating information from multiple sources. Our tool is intended to help researchers without much computational skills to perform their genomic data analysis.

In contrast to existing methods for prioritization, the present algorithm facilitates the integration of currently available algorithms for prediction and conservation, population frequency, regulatory elements and disease information for each variant based on the user selection. Users can apply case control genotype filtering using the CaseControl filtering module. Various filtering strategies for ranked results can be easily applied through the Result Explorer module which also facilitates the application of different models of inheritance. Overall, our results indicate that Variant Ranker exhibits excellent performance by correctly identifying and ranking the candidate genes for various disorders, as shown with real and synthetic data. Furthermore, using the Network Analyser module, users can conduct downstream functional enrichment analysis on top candidate genes and disentangle complex biological associations via network visualization. Our Variant Ranker can be applied to various types of sequencing studies, like whole genome or exome studies for both Mendelian and complex disorders. GWAS case-control association and summary statistics data can also be altered to use our tool. We have also applied our algorithm to targeted resequencing data [33] as well as family exome data [34] thus establishing the scope of integrating our methodology with several genomic studies using different experimental designs.

Availability and requirements

Variant Ranker is available at http://paschou-lab.mbg.duth.gr/Software.html. It requires no special or additional data sources, other than the input data from the user. The datasets generated and analysed during the current study are available at http://paschou-lab.mbg.duth.gr/html5up/Examples.html

Operating system(s): Platform independent

Programming language(s): R, PHP, JavaScript, CSS and HTML

Other requirements: Web-browser capable to execute JavaScript/HTML5. Best graphic results on Google Chrome/Mozilla Firefox.

Any restrictions to use by non-academics: Contact authors

Tutorial and Example data: Available online

Abbreviations

ChIP-seq:

chromatin immunoprecipitation followed by sequencing

HGNC:

HUGO Gene Nomenclature Committee

RNA-seq:

RNA isolation followed by sequencing

VCF:

variant calling format

References

  1. Adzhubei IA, Schmidt S, Peshkin L, Ramensky VE, Gerasimova A, Bork P. A method and server for predicting damaging missense mutations. Nat Methods. 2010;7. Available from: https://www.nature.com/nmeth/journal/v7/n4/full/nmeth0410-248.html.

  2. Kumar P, Henikoff S, Ng PC. Predicting the effects of coding non-synonymous variants on protein function using the SIFT algorithm. Nat Protoc. 2009; 4(7):1073–81.

    Article  CAS  PubMed  Google Scholar 

  3. Schwarz JM, Rodelsperger C, Schuelke M, Seelow D. MutationTaster evaluates disease-causing potential of sequence alterations. 2010. Available from: http://www.nature.com/nmeth/journal/v7/n8/full/nmeth0810-575.html.

  4. Siepel A, Pollard K, Haussler D. New Methods for Detecting Lineage-Specific Selection In: Apostolico A, Guerra C, Istrail S, Pevzner P, Waterman M, editors. Research in Computational Molecular Biology SE - 17. vol. 3909 of Lecture Notes in Computer Science. Springer Berlin Heidelberg: 2006. p. 190–205. Available from: http://dx.doi.org/10.1007/11732990_17.

  5. Garber M, Guttman M, Clamp M, Zody MC, Friedman N, Xie X. Identifying novel constrained elements by exploiting biased substitution patterns. Bioinformatics. 2009; 25(12):i54–i62. Available from: http://bioinformatics.oxfordjournals.org/content/25/12/i54.abstract. (https://academic.oup.com/bioinformatics/article/25/12/i54/187307/Identifying-novel-constrained-elements-by).

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  6. Davydov EV, Goode DL, Sirota M, Cooper GM, Sidow A, Batzoglou S. Identifying a High Fraction of the Human Genome to be under Selective Constraint Using GERP++. PLoS Comput Biol. 2010; 6(12):e1001025. Available from: http://journals.plos.org/ploscompbiol/article?id=10.1371/journal.pcbi.1001025.

    Article  PubMed  PubMed Central  Google Scholar 

  7. Cingolani P, Platts A, Wang LL, Coon M, Nguyen T, Wang L, et al. A program for annotating and predicting the effects of single nucleotide polymorphisms, SnpEff: SNPs in the genome of Drosophila melanogaster strain w1118; iso-2; iso-3. Fly. 2012; 6(2):80–92.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. Ng SB, Buckingham KJ, Lee C, Bigham AW, Tabor HK, Dent KM, et al.Exome sequencing identifies the cause of a mendelian disorder. Nat Genet. 2010; 42(1):30–5. Available from: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2847889&tool=pmcentrez&rendertype=abstract.

    Article  CAS  PubMed  Google Scholar 

  9. Wang K, Li M, Hakonarson H. ANNOVAR: functional annotation of genetic variants from high-throughput sequencing data. Nucleic Acids Res. 2010; 38(16):e164. Available from: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=2938201&tool=pmcentrez&rendertype=abstract.

    Article  PubMed  PubMed Central  Google Scholar 

  10. Sifrim A, Popovic D, Tranchevent LC, Ardeshirdavani A, Sakai R, Konings P, et al.eXtasy: variant prioritization by genomic data fusion. Nat Meth. 2013; 10(11):1083–1084. Available from: https://www.nature.com/nmeth/journal/v10/n11/full/nmeth.2656.html.

    Article  CAS  Google Scholar 

  11. Wu J, Li Y, Jiang R. Integrating Multiple Genomic Data to Predict Disease-Causing Nonsynonymous Single Nucleotide Variants in Exome Sequencing Studies. PLoS Genet. 2014; 10(3):e1004237. Available from: http://journals.plos.org/plosgenetics/article?id=10.1371/journal.pgen.1004237.

    Article  PubMed  PubMed Central  Google Scholar 

  12. Yandell M, Huff C, Hu H, Singleton M, Moore B, Xing J, et al. A probabilistic disease-gene finder for personal genomes A probabilistic disease-gene finder for personal genomes. Genome research. 2011; 21(9):1529–42. Available from: https://www.ncbi.nlm.nih.gov/pubmed/21700766.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  13. Li MX, Gui HS, Kwan JSH, Bao SY, Sham PC. A comprehensive framework for prioritizing variants in exome sequencing studies of Mendelian diseases. Nucleic Acids Res. 2012; 40(7):e53–e53.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  14. Danecek P, Auton A, Abecasis G, Albers CA, Banks E, Depristo MA, et al. The Variant Call Format and VCFtools. 2011.: p. 3–5. Available from: https://www.ncbi.nlm.nih.gov/pubmed/21653522.

  15. Huang DW, Lempicki RA, Sherman BT. Systematic and integrative analysis of large gene lists using DAVID bioinformatics resources. Nat Protoc. 2009; 4(1):44–57. Available from: http://www.ncbi.nlm.nih.gov/pubmed/19131956.

    Article  CAS  Google Scholar 

  16. Huang DW, Sherman BT, Lempicki RA. Bioinformatics enrichment tools: Paths toward the comprehensive functional analysis of large gene lists. Nucleic Acids Res. 2009; 37(1):1–13.

    Article  Google Scholar 

  17. Abecasis GR, Auton A, Brooks LD, DePristo MA, Durbin RM, Handsaker RE, et al.An integrated map of genetic variation from 1,092 human genomes. Nature. 2012; 491(7422):56–65.

    Article  PubMed  Google Scholar 

  18. NHLBI-ESP. Available from: https://esp.gs.washington.edu/drupal/.

  19. Consortium EA, Lek M, Karczewski K, Minikel E, Samocha K, Banks E, et al. Analysis of protein-coding genetic variation in 60,706 humans. bioRxiv. 2015:030338. Available from: http://biorxiv.org/lookup/doi/10.1101/030338.

  20. Pruitt KD, Tatusova T, Maglott DR. NCBI reference sequences (RefSeq): A curated non-redundant sequence database of genomes, transcripts and proteins. Nucleic Acids Res. 2007; 35(SUPPL. 1):D61–5.

    Article  CAS  PubMed  Google Scholar 

  21. Curwen V, Eyras E, Andrews TD, Clarke L, Mongin E, Searle SMJ, et al.The Ensembl automatic gene annotation system. Genome Res. 2004; 14(5):942–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  22. Chun S, Fay JC. Identification of deleterious mutations within three human genomes. Genome Res. 2009; 19(9):1553–61.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  23. Dong C, Wei P, Jian X, Gibbs R, Boerwinkle E, Wang K, et al. Comparison and integration of deleteriousness prediction methods for nonsynonymous SNVs in whole exome sequencing studies. Hum Mol Genet. 2015; 24(8):2125–37. Available from: http://hmg.oxfordjournals.org/content/24/8/2125.abstract.

    Article  CAS  PubMed  Google Scholar 

  24. Reva B, Antipin Y, Sander C. Predicting the functional impact of protein mutations: Application to cancer genomics. Nucleic Acids Res. 2011; 39(17):e118.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  25. Shihab HA, Gough J, Cooper DN, Stenson PD, Barker GLA, Edwards KJ, et al. Predicting the Functional, Molecular, and Phenotypic Consequences of Amino Acid Substitutions using Hidden Markov Models. Hum Mutat. 2013; 34(1):57–65.

    Article  CAS  PubMed  Google Scholar 

  26. Siepel A, Bejerano G, Pedersen JS, Hinrichs AS, Hou M, Rosenbloom K, et al. Evolutionarily conserved elements in vertebrate, insect, worm, and yeast genomes. Genome Res. 2005; 15(8):1034–50. Available from: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=1182216&tool=pmcentrez&rendertype=abstract.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  27. Raney BJ, Cline MS, Rosenbloom KR, Dreszer TR, Learned K, Barber GP, et al. ENCODE whole-genome data in the UCSC genome browser (2011 update). Nucleic Acids Res. 2011; 39(Database issue):D871–5. Available from: http://dx.doi.org/10.1093/nar/gkq1017.

    Article  CAS  PubMed  Google Scholar 

  28. Welter D, MacArthur J, Morales J, Burdett T, Hall P, Junkins H, et al. The NHGRI GWAS Catalog, a curated resource of SNP-trait associations. Nucleic Acids Res. 2014; 42(D1):D1001–6.

    Article  CAS  PubMed  Google Scholar 

  29. Landrum MJ, Lee JM, Benson M, Brown G, Chao C, Chitipiralla S, et al. ClinVar: public archive of interpretations of clinically relevant variants. Nucleic Acids Res. 2015; 44(D1):D862–8. Available from: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=4702865&tool=pmcentrez&rendertype=abstract.

    Article  PubMed  PubMed Central  Google Scholar 

  30. Kircher M, Witten DM, Jain P, O’Roak BJ, Cooper GM, Shendure J. A general framework for estimating the relative pathogenicity of human genetic variants. Nat Genet. 2014; 46(3):310–315. Available from: http://www.ncbi.nlm.nih.gov/pubmed/24487276.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  31. Lyon GJ, Jiang T, Van Wijk R, Wang W, Bodily PM, Xing J, et al. Exome sequencing and unrelated findings in the context of complex disease research: ethical and clinical implications. Discov Med. 2011; 12(62):41–55. Available from: http://www.pubmedcentral.nih.gov/articlerender.fcgi?artid=3544941&tool=pmcentrez&rendertype=abstract.

    PubMed  PubMed Central  Google Scholar 

  32. Chang X, Wang K. wANNOVAR: annotating genetic variants for personal genomes via the web. 2012. Available from: https://www.ncbi.nlm.nih.gov/pubmed/?term=22717648.

  33. Alexander J, Potamianou H, Xing J, Deng L, Karagiannidis I, Tsetsos F, et al. Targeted re-sequencing approach of candidate genes implicates rare potentially functional variants in Tourette Syndrome etiology. 2016. Available from: http://journal.frontiersin.org/article/10.3389/fnins.2016.00428.

  34. Alexander J, Kalev O, Mehrabian S, Traykov L, Raycheva M, Kanakis D, et al. Familial early-onset dementia with complex neuropathologic phenotype and genomic background. Neurobiol Aging. 2016; 42:199–204. Available from: http://dx.doi.org/10.1016/j.neurobiolaging.2016.03.012.

    Article  CAS  PubMed  Google Scholar 

  35. Zemojtel T, Kohler S, Mackenroth L, Jager M, Hecht J, Krawitz P, et al.Effective diagnosis of genetic disease by computational phenotype analysis of the disease-associated genome. Sci Transl Med. 2014; 6(252):252ra123–252ra123. Available from: http://stm.sciencemag.org/cgi/doi/10.1126/scitranslmed.3009262.

    Article  PubMed  PubMed Central  Google Scholar 

  36. Fresno C, Fernandez EA. RDAVIDWebService: a versatile R interface to DAVID. Bioinformatics (Oxford, England). 2013; 29(21):2810–1.

    Article  CAS  Google Scholar 

Download references

Acknowledgements

The authors thank everyone involved with open source software and database development. Many thanks to the developers of ANNOVAR for its maintenance as open-source and available databases. We specially thank Dr. Kai Wang and his team for their support and prompt clarifications throughout the development of our tools.

Funding

This project was financed by FP7- People-2012-ITN, project: TS-EUROTRAIN, grant number 316978 and FP7 project EMTICS, grant number 278367.

Author information

Authors and Affiliations

Authors

Contributions

PP and PD proposed and provided guidance for the project. JA developed the software, website, analysed the data and wrote the manuscript. DM and MG contributed to the guidance of the project, interpretation of results and subsequent revisions of the manuscript. All authors read, contributed and approved the final manuscript.

Corresponding author

Correspondence to John Alexander.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Alexander, J., Mantzaris, D., Georgitsi, M. et al. Variant Ranker: a web-tool to rank genomic data according to functional significance. BMC Bioinformatics 18, 341 (2017). https://doi.org/10.1186/s12859-017-1752-3

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-017-1752-3

Keywords