
Create Your Own Bioinformatics Pipeline: Powerful and Easy-to-use.
Design your own ultra-fast, cloud-based pipeline in seconds. Use defaults or define specific parameters. It's your choice!
Preprocessing ✯ Alignment & Mapping ✯ Variant Calling & Discovery ✯ Annotations ✯ Interpretations ✯ Conversions
Meet EvE, the first universal genetic adaptor that aligns, calls, annotates, converts and interprets almost any genetic data file to EvErything. EvE includes a straightforward user interface and powerful, dynamic multithreaded processing so that using your custom EvE pipeline is effortless and fast.
With EvE Premium, you can create your own ultra-fast custom pipeline within seconds. For example, you can select BWA-MEM2 for alignment and SamTools for variant calling. Or you can select CutAdapt for pre-processing, BowTie2 for alignment, Strelka for variant calling, SnpEff for annotation, and ClinVar for interpretation with the output format being a TXT file in 23andMe format.
Once you select your pipeline, you can use defaults or easily modify almost any parameter. EvE Premium will then run your pipeline using powerful multithreaded cluster cloud-based processing.
You no longer have to worry about whether your computer hardware and servers are powerful enough to process your data. With EvE, you also don't have to worry about bandwidth charges or obscure cloud computing fees. All you need is an internet connection (such as from a laptop or mobile device) and EvE will process your genetic data.
New in EvE Premium v4: ClinVar Interpretation
Turn on the ClinVar option (located under 'Interpretation') to annotate with ClinVar data.
INPUTS
EvE accepts almost all file formats including .bz2 and .gz compression.
EvE Premium can process files as large as 100 GB. To process files larger than 100 GB, please first contact Support.
EvE also accepts inputs generated using reference genome GRCh37 through the latest patch releases of GRCh38.
- FASTA
- FASTQ
- SEQUENCE.TXT
- QSEQ
- SAM
- BAM
- CRAM
- VCF
- gVCF (genome VCF with blocks)
- GVCF (genome VCF without blocks)
- GVF (Genome variant format)
- WT (Wormtable)
- CSV
- TXT
- 23andMe data files (all 23andMe versions)
- AncestryDNA data files (all Ancestry versions)
- FamilyTreeDNA (FTDNA) data files
- MyHeritage data files
- Living DNA data files
- HomeDNA data files
- Genographic Project (National Geographic) data files
- Dante Labs data files
- Helix (Exome+) data files
- Veritas Genetics data files
- GeneDx data files
- Ambry Genetics data files
- Baylor College of Medicine data files
- Invitae data files
- Color Genomics data files
- As well as array, exome and whole genome sequencing data files from almost all laboratories such as Illumina's Clinical Sequencing Lab, BGI, Macrogen and WuXi NEXTcode.
OUTPUTS (Target Formats)
Outputs can be produced using any reference genome of your choice from GRCh37 through GRCh38 (including the latest patch releases).
- FASTA
- FASTQ
- SAM
- BAM
- VCF
- VCF with reference SNP IDs (rs<number>) added
- Annotated VCF (includes reference SNP IDs rs<number>)
- gVCF (genome VCF with blocks)
- GVF (Genome variant format)
- Clinical+ VCF
- WT (Wormtable)
- SVG
- CRAM
- AVRO
- TXT (23andMe format)
- SQLite
- CNV (vcf file containing copy number variations) (coming soon)
- SV (vcf file containing structural variants) (coming soon)
- Mitochondrial Heteroplasmy (coming soon)
- Telomere Length (coming soon)
- Methylation (coming soon)
SamTools
Input Options:
- -6, --illumina1.3+: Assume the quality is in the Illumina 1.3+ encoding.
- -A, --count-orphans: Do not skip anomalous read pairs in variant calling.
- -b, --bam-list FILE: List of input BAM files, one file per line [null]
- -B, --no-BAQ: Disable probabilistic realignment for the computation of base alignment quality (BAQ). BAQ is the Phred-scaled probability of a read base being misaligned. Applying this option greatly helps to reduce false SNPs caused by misalignments.
- -C, --adjust-MQ INT: Coefficient for downgrading mapping quality for reads containing excessive mismatches. Given a read with a phred-scaled probability q of being generated from the mapped position, the new mapping quality is about sqrt((INT-q)/INT)*INT. A zero value disables this functionality; if enabled, the recommended value for BWA is 50. [0]
- -d, --max-depth INT:At a position, read maximally INT reads per input BAM. [250]
- -E, --redo-BAQ: Recalculate BAQ on the fly, ignore existing BQ tags
- -f, --fasta-ref FILE: The faidx-indexed reference file in the FASTA format. The file can be optionally compressed by bgzip. [null]
- -G, --exclude-RG FILE: Exclude reads from readgroups listed in FILE (one @RG-ID per line)
- -l, --positions FILE: BED or position list file containing a list of regions or sites where pileup or BCF should be generated. If BED, positions are 0-based half-open [null]
- -q, -min-MQ INT: Minimum mapping quality for an alignment to be used [0]
- -Q, --min-BQ INT: Minimum base quality for a base to be considered [13]
- -r, --region STR: Only generate pileup in region. Requires the BAM files to be indexed. If used in conjunction with -l then considers the intersection of the two requests. STR [all sites]
- -R, --ignore-RG: Ignore RG tags. Treat all reads in one BAM as one sample.
- --rf, --incl-flags STR|INT: Required flags: skip reads with mask bits unset [null]
- --ff, --excl-flags STR|INT: Filter flags: skip reads with mask bits set [UNMAP,SECONDARY,QCFAIL,DUP]
- -x, --ignore-overlaps: Disable read-pair overlap detection.
Output Options:
- -o, --output FILE: Write pileup or VCF/BCF output to FILE, rather than the default of standard output.
- -g, --BCF: Compute genotype likelihoods and output them in the binary call format (BCF). As of v1.0, this is BCF2 which is incompatible with the BCF1 format produced by previous (0.1.x) versions of samtools.
- -v, --VCF: Compute genotype likelihoods and output them in the variant call format (VCF). Output is bgzip-compressed VCF unless -u option is set.
- -O, --output-BP: Output base positions on reads.
- -s, --output-MQ: Output mapping quality.
Output Options for VCF/BCF format (with -g or -v):
- -D: Output per-sample read depth [DEPRECATED - use -t DP instead]
- -S: Output per-sample Phred-scaled strand bias P-value [DEPRECATED - use -t SP instead]
- -t, --output-tags LIST
Options for SNP/INDEL Genotype Likelihood Computation (for -g or -v):
- -e, --ext-prob INT: Phred-scaled gap extension sequencing error probability. Reducing INT leads to longer indels. [20]
- -F, --gap-frac FLOAT: Minimum fraction of gapped reads [0.002]
- -h, --tandem-qual INT: Coefficient for modeling homopolymer errors. Given an l-long homopolymer run, the sequencing error of an indel of size s is modeled as INT*s/l. [100]
- -I, --skip-indels: Do not perform INDEL calling
- -L, --max-idepth INT
- -m, --min-ireads INT: Minimum number gapped reads for indel candidates INT. [1]
- -o, --open-prob INT: Phred-scaled gap open sequencing error probability. Reducing INT leads to more indel calls. [40]
- -p, --per-sample-mF: Apply -m and -F thresholds per sample to increase sensitivity of calling. By default both options are applied to reads pooled from all samples.
- -P, --platforms STR: Comma-delimited list of platforms (determined by @RG-PL) from which indel candidates are obtained. It is recommended to collect indel candidates from sequencing technologies that have low indel error rate such as ILLUMINA. [all]
GATK
Unified Genotyper:
- -R: Reference File Name
- -I: BAM file name
- --alleles: The set of alleles at which to genotype when --genotyping_mode is GENOTYPE_GIVEN_ALLELES
- --comp: Comparison VCF file
- --dbsnp: -D dbSNP file
- --annotation: -A: One or more specific annotations to apply to variant calls
- --contamination_fraction_to_filter, -contamination: Fraction of contamination in sequencing data (for all samples) to aggressively remove
- --excludeAnnotation, -XA: One or more specific annotations to exclude
- --genotype_likelihoods_model, -glm NA Genotype likelihoods calculation model to employ -- SNP is the default option, while INDEL is also available for calling indels and BOTH is available for calling both together
- --genotyping_mode, -gt_mode: Specifies how to determine the alternate alleles to use for genotyping,
- --group, -G: One or more classes/groups of annotations to apply to variant calls. The single value 'none' removes the default group
- --heterozygosity, -hets: Heterozygosity value used to compute prior likelihoods for any locus.
- --indel_heterozygosity, -indelHeterozygosity: Heterozygosity for indel calling.
- --max_deletion_fraction, -deletions: Maximum fraction of reads with deletions spanning this locus for it to be callable
- --min_base_quality_score, -mbq: Minimum base quality required to consider a base for calling
- --min_indel_count_for_genotyping, -minIndelCnt: Minimum number of consensus indels required to trigger genotyping run
- --min_indel_fraction_per_sample, -minIndelFrac: Minimum fraction of all reads at a locus that must contain an indel (of any allele) for that sample to contribute to the indel count for alleles
- --output_mode, -out_mode: Specifies which type of calls we should output
- --pair_hmm_implementation -pairHMM: The PairHMM implementation to use for -glm INDEL genotype likelihood calculations
- --pcr_error_rate, -pcr_error: The PCR error rate to be used for computing fragment-based likelihoods
- --sample_ploidy
- --standard_min_confidence_threshold_for_calling, -stand_call_conf: The minimum phred-scaled confidence threshold at which variants should be called.
- --standard_min_confidence_threshold_for_emitting, -stand_emit_conf: The minimum phred-scaled confidence threshold at which variants should be emitted (and filtered with LowQual if less than the calling threshold)
- -annotateNDA, -nda: If provided, we will annotate records with the number of alternate alleles that were discovered (but not necessarily genotyped) at a given site
- --computeSLOD, -slod: If provided, we will calculate the SLOD (SB annotation)
- --contamination_fraction_per_sample_file
- --indelGapContinuationPenalty
- -indelGCP: Indel gap continuation penalty, as Phred-scaled probability. I.e., 30 => 10^-30/10
- --indelGapOpenPenalty, -indelGOP: Indel gap open penalty, as Phred-scaled probability. I.e., 30 => 10^-30/10
- --input_prior, -inputPrior: Input prior for calls
- --max_alternate_alleles, -maxAltAlleles: Maximum number of alternate alleles to genotype
SNPEff
- -noShiftHgvs: Do not shift variants towards most 3-prime position (as required by HGVS).
- -canon: Only use canonical transcripts.
- -interval: Use a custom intervals in TXT/BED/BigBed/VCF/GFF file (you may use this option many times)
- -motif: Annotate using motifs (requires Motif database).
- -noMotif: Disable motif annotations.
- -noNextProt: Disable NextProt annotations.
- -onlyReg: Only use regulation tracks.
- -onlyProtein: Only use protein coding transcripts. Default: false
- -onlyTR: Only use the transcripts in this file. Format: One transcript ID per line.
- -reg: Regulation track to use (this option can be used add several times).
- -ss , -spliceSiteSize : Set size for splice sites (donor and acceptor) in bases. Default: 2
- -strict: Only use 'validated' transcripts (i.e. sequence has been checked). Default: false
When you use EvE Premium, your data files and result file(s) will be stored in your Sequencing.com account, which provides free, unlimited storage of genetic data.
This simple yet secure approach means you no longer have to use your own storage or computing power to conduct genetic analysis and you also no longer have to use USB drives or FTP sites to move and share genetic data.
EvE includes an integration of the following:
Samtools
A suite of programs for interacting with high-throughput sequencing data. It consists of three separate repositories:
- Samtools: Reading/writing/editing/indexing/viewing SAM/BAM/CRAM format
- BCFtools: Reading/writing BCF2/VCF/gVCF files and calling/filtering/summarising SNP and short indel sequence variants
- HTSlib: A C library for reading/writing high-throughput sequencing data
GATK (Genome Analysis Toolkit)
GATK analyzes high-throughput sequencing data. The toolkit, which focuses on providing high quality data, offers a wide variety of tools including variant discovery and genotyping.
Isaac Variant Caller
Isaac Variant Caller (IVC) is an analysis package designed to detect SNVs and small indels from the aligned sequencing reads of a single diploid sample.
SnpEFF
SnpEFF predicts the effects of genetic variations and also provides annotations. Annotations can simple such as variant name or more complex such as site of variation such as exon, intron and its effect on gene expression.
Sequencing.com Scripts
Since UGENE offers conversions between different file formats such which is a multistep process at time, we use our own scripts to pipe data and create some file types. Specifically, the Clinical plus VCF files and gVCF to VCF conversions are executed by sequencing.com customs scripts.
Wormtable (WT)
Wormtable is a format for storing large scale tabular data and interacting with it. It generates an index file as well that can be used repeatedly. Wormtable files are considered very Python friendly and can be used in downstream Python based analysis.
GVF
GVF (Genome Variation Format) is gaining popularity as a standard for sequence ontology based datasets. It is a successor of the GFF3 format and includes pragmas for defining sequence alterations at genomic locations as compared to the reference genome.
gVCF
Human clinical applications require sequencing information for both variant and non-variant positions, yet there is currently no common exchange format for such data. Genomic VCF (gVCF) addresses this issue. gVCF is a set of conventions applied to the standard variant call format (VCF) that include genotype, annotation and other information across all sites in the genome in a reasonably compact format.
This app is designed for researchers, bioinformatics experts and genomics professionals. The genetic analysis and statements that appear in this app have not been evaluated by the United States Food and Drug Administration. The Sequencing.com website and all software applications (Apps) that use Sequencing.com's website, as well as Sequencing.com's open Application Programming Interface (API), are not intended to diagnose, treat, cure, or prevent any disease.