samjs | Filters a BAM using a javascript expression ( java nashorn engine ). | sam bam nashorn javascript filter | | |
casectrljfx | display jfx chart of case/control maf from a VCF and a pedigree | vcf pedigree case control visualization jfx chart maf | | |
pubmedcodinglang | Programming language use distribution from recent programs / articles | pubmed xml code programming | | |
vcffixindels | Fix samtools indels (for @SolenaLS) | vcf indel | | |
vcftail | print the last variants of a vcf | vcf | | |
vcfhead | print the first variants of a vcf | vcf | | |
vcfmulti2oneallele | 'one variant with N ALT alleles' to 'N variants with one ALT' | vcf | | |
vcfin | Only prints variants that are contained/not contained into another VCF | vcf compare | | |
vcfpredictions | Basic Variant Effect prediction using ucsc-known gene | vcf annotation prediction | | |
vcffilterso | Filter a VCF file annotated with SNPEff or VEP with terms from Sequence-Ontology. Reasoning : Children of user's SO-terms will be also used.< | vcf filter sequenceontology prediction so | | |
vcffilterjs | Filtering VCF with javascript expressions | vcf filter javascript json nashorn | [ID:0000003]i_use_it_regularly | |
vcfpolyx | Number of repeated REF bases around POS. | vcf repeat | | |
vcfbed | Transfer information from a BED to a VCF | bed vcf annotation | | |
vcftrio | Find mendelian incompatibilitie in a VCF | vcf mendelian pedigree | | |
groupbygene | Group VCF data by gene/transcript. By default it uses data from VEP , SnpEff | vcf gene | | |
addlinearindextobed | Use a Sequence dictionary to create a linear index for a BED file. Can be used as a X-Axis for a chart. | bed reference | | |
almostsortedvcf | Sort an 'almost' sorted VCF. Most variants should be sorted but a few consecutive lines might have been switched by a caller. | | | |
backlocate | Mapping a mutation on a protein back to the genome. | vcf annotation prediction protein | | |
bam2fastq | Same as picard/SamToFastq but allow missing reads + shuffle reads using hash(name) so you can use them with bwa. | fastq | [ID:0000005]unmaintained | use picard. |
bam2raster | BAM to raster graphics | bam alignment graphics visualization png | | |
bam2svg | BAM to raster graphics | bam alignment graphics visualization svg | | |
bam2xml | converts a BAM to XML | sam bam xml | | |
bam2wig | Bam to fixedStep Wiggle converter , or BED GRAPH. Parses the cigar String to get the depth. Memory intensive: must alloc sizeof(int)*size(chrom) | bam wig wiggle bed | | |
bamcmpcoverage | Creates the figure of a comparative view of the depths sample vs sample. Memory consideration: the tool alloc an array of bits which size is: (MIN(maxdepth-mindepth,pixel_width_for_one_sample) * count_samples)^2 | sam bam visualization coverage | | |
bamrenamechr | Convert the names of the chromosomes in a BAM file | sam bam chromosome contig | | |
bamstats04 | Coverage statistics for a BED file. | sam bam coverage depth statistics bed | | |
bamstats05 | Coverage statistics for a BED file, group by gene | bam coverage statistics bed | | |
batchigvpictures | | | | |
bedliftover | Lift-over a VCF file | bed liftover | | |
bedrenamechr | Convert the names of the chromosomes in a Bed file | bed chromosome contig convert | | |
biostar103303 | Calculate Percent Spliced In (PSI). | | [ID:0000015]i_wrote_it_for_biostars | |
biostar130456 | Individual VCF files from main VCF file | | | |
biostar59647 | SAM/BAM to XML | sam bam xml | | |
biostar76892 | fix strand of two paired reads close but on the same strand. | sam bam | | |
biostar77288 | Low resolution sequence alignment visualization | bam sam visualization svg alignment | | |
biostar77828 | Divide the human genome among X cores, taking into account gaps | workflow reference parallel | [ID:0000015]i_wrote_it_for_biostars | |
biostar78285 | Extract BAMs coverage as a VCF file. | sam bam depth coverage | | |
biostar78400 | add the read group info to the sam file on a per lane basis | sam bam xml read-group | | |
biostar81455 | Defining precisely the genomic context based on a position . | bed gene knownGene ucsc | [ID:0000015]i_wrote_it_for_biostars | |
biostar84452 | remove clipped bases from a BAM file | sam bam clip | [ID:0000015]i_wrote_it_for_biostars | |
biostar84786 | Matrix transposition | matrix util | | |
biostar86363 | Set genotype of specific sample/genotype comb to unknown in multisample vcf file. See http://www.biostars.org/p/86363/ | sample genotype vcf | [ID:0000015]i_wrote_it_for_biostars | |
biostar86480 | Genomic restriction finder | rebase genome enzyme restricion genome | [ID:0000015]i_wrote_it_for_biostars | |
biostar90204 | Bam version of linux split. | sam bam split util | | |
msa2vcf | Getting a VCF file from a CLUSTAW or a FASTA alignment. | | | use https://github.com/sanger-pathogens/snp_sites. |
biostar95652 | Drawing a schematic genomic context tree. | genbank svg tree evolution | | |
biostar139647 | Convert alignment in Fasta/Clustal format to SAM/BAM file | | | |
biostar145820 | subsample/shuffle BAM to fixed number of alignments. | sam bam shuffle | | |
blastmapannots | Maps uniprot/genbank annotations on a blast result. | blast annotation genbank uniprot | | |
buildwpontology | Build a simple RDFS/XML ontology from the Wikipedia Categories | wikipedia ontology rdf gui | | |
bwamemdigest | | | | |
bwamemnop | Merge the other BWA-MEM alignements with its SA:Z:* attributes to an alignment containing a cigar string with 'N' ( Skipped region from the reference.) | bwa sam bam | | |
cmpbams | Compare two or more BAM files | sam bam compare | | |
cmpbamsandbuild | Compare two BAM files mapped on two different builds. Requires a liftover chain file | | | |
coveragenormalizer | normalize BAM coverage | | | |
downsamplevcf | DownSample a VCF. Will keep 'n' random variant in a vcf. | vcf | | |
evs2bed | Download data from EVS http://evs.gs.washington.edu/EVS as a BED chrom/start/end/XML For later use, see VCFTabixml. | | | |
evs2vcf | Download data from EVS http://evs.gs.washington.edu/EVS as a BED chrom/start/end/XML For later use, see VCFTabixml. | | | |
evsdumpxml | Download data from EVS http://evs.gs.washington.edu/EVS as XML file. | | | |
fastq2fasta | fastq -> fasta | fastq fasta | | use awk, samtools.... |
kg2bed | converts UCSC knownGenes file to BED. | ucsc bed knownGenes | | |
fastqentropy | Compute the Entropy of a Fastq file (distribution of the length(gzipped(sequence)) | fastq | [ID:0000005]unmaintained | |
fastqgrep | Grep reads names in fastq | fastq | | use picard. |
fastqjs | Filters a FASTQ file using javascript( java nashorn engine). | fastq | [ID:0000005]unmaintained | |
fastqphred64to33 | Convert Illumina Fastq 64 encoding to Fastq 33 | fastq | [ID:0000005]unmaintained | |
fastqrevcomp | produces a reverse-complement fastq (for mate pair alignment see http://seqanswers.com/forums/showthread.php?t=5085 ) | fastq | | |
fastqshuffle | Shuffle Fastq files | fastq | [ID:0000005]unmaintained | |
fastqsplitinterleaved | Split interleaved Fastq files. | fastq | [ID:0000005]unmaintained | |
findallcoverageatposition | Find depth at specific position in a list of BAM files. My colleague Estelle asked: in all the BAM we sequenced, can you give me the depth at a given position ? | bam coverage search depth | | |
findavariation | Finds a specific mutation in a list of VCF files | vcf variation search | | |
findcorruptedfiles | Reads filename from stdin and prints corrupted NGS files (VCF/BAM/FASTQ/BED/TBI/BAI) | vcf bam fastq bed | | |
findmyvirus | Find my Virus. Created for Adrien Inserm. Proportion of reads mapped on HOST/VIRUS. | | | |
findnewsplicesites | use the 'N' operator in the cigar string to find unknown splice sites | rnaseq splice | [ID:0000008]it_was_a_one_shot | |
fixvcf | Fix a VCF if INFO or FILTER are missing | | | |
fixvcfformat | Fix PL format in VCF. Problem is described in http://gatkforums.broadinstitute.org/discussion/3453 | | | |
fixvcfmissinggenotypes | After a VCF-merge, read a VCF, look back at some BAMS to tells if the missing genotypes were homozygotes-ref or not-called. If the number of reads is greater than min.depth, then a missing genotype is said hom-ref. | sam bam vcf | | |
gcpercentanddepth | Extracts GC% and depth for multiple bam using a sliding window | gc% depth coverage | | |
genomicjaspar | Find jaspar patterns in FASTA sequences. Reports a BED file. | jaspar genomic pattern | | |
howmanybamdict | finds if there's are some differences in the sequence dictionaries. | sam bam dict | | |
illuminadir | Create a structured (**JSON** or **XML**) representation of a directory containing some Illumina FASTQs. | json xml illumina fastq workflow | | |
ilmnfastqstats | Reads filenames from stdin: Count FASTQs in Illumina Result. | | | |
impactofduplicates | Impact of Duplicates per BAM. | bam | | |
liftover2svg | Convert LiftOver chain files to animated SVG | svg liftover ucsc xml | | |
mapuniprot | map uniprot features on reference genome | uniprot bed fasta reference xjc xml | | |
mergesplittedblast | merge blast Hits from splitted BLAST database | blast | | |
ncbitaxonomy2xml | Dump NCBI taxonomy tree as a hierarchical XML document | taxonomy ncbi xml | | |
samjmx | Monitor/interrupt/break a BAM/SAM stream with java JMX http://www.oracle.com/technetwork/articles/java/javamanagement-140525.html | sam bam jmx monitoring | | |
ngsfilessummary | Scan folders and generate a summary of the files (SAMPLE/BAM SAMPLE/VCF etc..). Useful to get a summary of your samples. | sam bam vcf util | | |
noemptyvcf | If VCF is empty or doesn't exists, create a dummy one | | | Was developped at the time where VEP didn't send an output if there was no variant, just a header in the source vcf.. |
nozerovariationvcf | cat a whole VCF, or, if there is no variant, creates a fake one | | | |
pademptyfastq | Pad empty fastq sequence/qual with N/# | fastq | | use awk. |
pubmeddump | Dump XML results from pubmed/Eutils | ncbi pubmed xml | | |
pubmedorcidgraph | Creates a graph from Pubmed and Authors' Orcid identifiers | pubmed ncbi orcid | | |
pubmedfilterjs | Filters Pubmed XML with a javascript (java rhino) expression. Context contain 'article' a PubmedBookArticle or a PubmedArticle and 'index', the index in the XML file. | pubmed javascript xml ncbi | | |
referencetovcf | Creates a VCF containing all the possible substitutions from a Reference Genome. | vcf reference fasta | | |
sam2json | Convert a SAM input to JSON | sam bam json | | |
sam2psl | Convert SAM/BAM to PSL http://genome.ucsc.edu/FAQ/FAQformat.html#format2 or BED12 | | | |
sam2tsv | Prints the SAM alignments as a TAB delimited file. | sam bam table tsv | | |
sam4weblogo | Sequence logo for different alleles or generated from SAM/BAM | sam bam visualization logo | [ID:0000015]i_wrote_it_for_biostars | |
Samclipindelfraction | Extract clipping/indel fraction from BAM | sam bam clip | | This tool can be replace with Bioalcidaejdk. |
samfixcigar | Fix Cigar String in SAM replacing 'M' by 'X' or '=' | sam bam cigar | | |
samgrep | grep read-names in a bam file | sam bam | | |
samshortinvert | Scan short inversions in SAM | | [ID:0000023]it_is_broken | |
samstats01 | Statistics about the reads in a BAM. | | | |
sortvcfoninfo | Sort a VCF a field in the INFO column | vcf sort annotation | | |
sortvcfonref2 | Sort a VCF using the internal dictionary or an external reference order (Deprecated: use picard SortVcf). | vcf sort | | use picard sortvcf. |
splitbytile | Split Bam By tile | sam bam | | |
vcf2hilbert | Plot a Hilbert Curve from a VCF file. | vcf image visualization | | |
vcf2postscript | Print VCF context as Postscript | vcf postscript | | |
vcf2rdf | convert VCF to RDF (N3 notation) | vcf rdf | | |
vcf2sql | Generate the SQL code to insert a VCF into mysql | vcf sql | | |
vcf2xml | Convert VCF to XML | vcf xml | | |
vcfannobam | Annotate a VCF with the Coverage statistics of a BAM file+ BED file of capture. | bam sam depth vcf | | useless: use DP/DP4 in the Genotypes, or use GATK variant annotator. |
vcfbiomart | BiomartQueries with VCF | vcf ensembl biomart annotation | | |
vcfcadd | Annotate VCF with Combined Annotation Dependent Depletion (CADD) (Kircher & al. A general framework for estimating the relative pathogenicity of human genetic variants. Nat Genet. 2014 Feb 2. doi: 10.1038/ng.2892.PubMed PMID: 24487276. | | | |
vcfcmppred | Compare predictions (SNPEff, VEP) for several VCFs | | | |
vcfcomm | Equivalent of linux comm for VCF | | | |
vcfcompare | Compares two VCF files | vcf compare | | |
vcfcomparegt | compare two or more genotype-callers for the same individuals. Produce a VCF with FORMAT fields indicating if a genotype is new or modified. | vcf compare | | |
vcfconcat | Concatenante sorted VCF with same sample, does NOT merge genotypes | vcf | | |
vcfcutsamples | Select/Exclude some samples from a VCF | vcf sample | | use bcftools or gatk SelectVariants. |
vcfjaspar | Finds JASPAR profiles in VCF | vcf matrix jaspar | | |
vcfliftover | Lift-over a VCF file | vcf liftover | | |
vcfmerge | Merge VCF Files | vcf sort | | use GATK combineVariants.. |
vcfmulti2one | >Convert VCF with multiple samples to a VCF with one SAMPLE, duplicating variant and adding the sample name in the INFO column | vcf sample | | |
vcfregulomedb | Annotate a VCF with the Regulome data (http://regulome.stanford.edu/ | | | |
vcfrenamechr | Convert the names of the chromosomes in a VCF file | vcf contig chromosome convert | | use `bcftools annotate` with `--rename-chrs file`. |
vcfrenamesamples | Rename the Samples in a VCF | vcf sample | | |
vcfresetvcf | Reset Genotypes in VCF (./.) if they've been found in another VCF indexed with tabix | vcf genotype | | |
vcfsetdict | Set the `##contig` lines in a VCF header on the fly | vcf dict fai | | |
vcfshuffle | Shuffle a VCF | vcf | | |
vcfSimulator | Generate a VCF | vcf | | |
vcfstats | Produce VCF statitics | vcf stats burden gnuplot | | |
vcfcombinetwosnvs | Detect Mutations than are the consequences of two distinct variants. This kind of variant might be ignored/skipped from classical variant consequence predictor. Idea from @SolenaLS and then @AntoineRimbert | vcf annotation prediction protein | | |
vcfstripannot | Removes one or more field from the INFO/FORMAT column of a VCF. | vcf | | Use bcftools annotate -x . |
vcftabixml | annotate a value from a vcf+xml file | vcf xml | | |
vcfvcf | Get the INFO from a VCF and use it for another VCF | | | obsolete. use GATK. |
worldmapgenome | Genome/Map of the world. Input is a BED file: chrom/start/end/country. | gis | [ID:0000017]just_a_proof_of_concept | |
uniprotfilterjs | Filters Uniprot DUMP+ XML with a javascript (java rhino) expression. Context contain 'entry' an uniprot entry and 'index', the index in the XML file. | unitprot javascript xjc xml | | |
skipxmlelements | Filter XML elements with a javascript (java rhino) expression. Context contain 'element' the current element. It implementsthe interface Tag described in SkipXmlElements.class | xml javascript | | |
vcfensemblvep | Annotate a VCF with ensembl REST API | vcf annotation rest ensembl xml xslt xsl | | |
vcfgroupbypop | Group VCF data by population, creates a VCF where each 'SAMPLE' is a population | | | |
bamtile | Answer to @sjackman : Is there a bedtools command to determine a minimal tiling path? A minimal set of features that cover a maximum of the target. | bam sam | | |
xcontaminations | For @AdrienLeger2 : cross contamination between samples by looking at the homozygous genotypes. | sam bam vcf contamination | | |
biostar3654 | show blast alignment with annotations | blast xml annotation | [ID:0000015]i_wrote_it_for_biostars | |
vcfburden | Solena: vcf to (chrom/pos/ref/alt/individus(G:0/1/2/-9) | | | deprecated. |
vcfreplacetag | Replace the key for INFO/FORMAT/FILTER | vcf | | |
vcfpeekvcf | Get the INFO from a VCF and use it for another VCF | vcf annotation | | |
vcfgetvariantbyIndex | Access a Plain or BGZF-compressed VCF file by index | vcf | | |
vcfmulti2oneinfo | 'one INFO with N values' to 'N variants with one INFO' | vcf | | |
bedindextabix | Index and sort a Bed on the fly with Tabix. | bed tabix | | |
vcf2bam | vcf to bam | ref vcf bam | | |
vcffilterxpath | Filter a VCF with a XPATH expression on a INFO tag containing a base64 encodede xml document | vcf xml xpath | [ID:0000017]just_a_proof_of_concept | |
biostar140111 | How to obtain human genotype data from dpSNP ftp? | | [ID:0000015]i_wrote_it_for_biostars | |
extendrefwithreads | Extending ends of sequences with the help of reads | read fastq reference sam bam | [ID:0000015]i_wrote_it_for_biostars | |
pcrslicereads | Mark PCR reads to their PCR amplicon | pcr sam bam cigar | | |
vcfjmx | Monitor/interrupt/break a VCF stream with java JMX http://www.oracle.com/technetwork/articles/java/javamanagement-140525.html | java jmx vcf | | |
gtf2xml | Convert GTF/GFF to XML | xml gtf gff | | |
sortsamrefname | Sort a BAM of contig and then on name | sam sort | | |
biostar154220 | Cap BAM to a given coverage | | [ID:0000015]i_wrote_it_for_biostars | |
biostar160470 | Getting untranslated nucleotide sequences on tblastn standalone | | [ID:0000015]i_wrote_it_for_biostars | |
biostar165777 | Split a XML file | | [ID:0000015]i_wrote_it_for_biostars | |
vcfcomparecallers | Compare two VCFs and print common/exclusive information for each sample/genotype | vcf compare genotype | | |
bamclip2insertion | Convert SOFT clip to Insertion of other read confirm it | sam bam clip | | |
localrealignreads | Local Realignment of Reads | | | |
biostar170742 | convert sam format to axt Format | sam axt | [ID:0000015]i_wrote_it_for_biostars | |
biostar172515 | Convert BAI to XML | bai bam xml | [ID:0000015]i_wrote_it_for_biostars | |
biostar173114 | make a bam file smaller by removing unwanted information see also https://www.biostars.org/p/173114/ | sam bam | [ID:0000015]i_wrote_it_for_biostars | |
biostar175929 | Construct a combination set of fasta sequences from a vcf see also https://www.biostars.org/p/175929/ | | [ID:0000015]i_wrote_it_for_biostars | |
vcfcalledwithanothermethod | Compare one vcf with other , add a flag to tell if a variant was called with another method. Vcf must be sorted on the same Dict. | vcf compare concordance | | |
biostar178713 | split bed file into several bed files where each region is separated of any other by N bases https://www.biostars.org/p/178713/ | | [ID:0000015]i_wrote_it_for_biostars | |
vcfremovegenotypejs | Reset Genotype in VCF using a javascript expression | | | |
bamstats02 | Statistics about the flags and reads in a BAM | | | |
bamstats02view | Statistics about the flags and reads in a BAM. Visualize date from BamStats02 | | | |
biostar105754 | bigwig : peak distance from specific genomic region | wig bigwig | | |
bam2sql | Convert a SAM/BAM to sqlite statements | bam sam sql sqlite | | |
vcf2zip | Reads a stream of concatenated VCFs and insert them into a Zip file | | | |
pubmedgender | Add gender-related attributes in the Author tag of pubmed xml. | pubmed gender ncbi xml | | |
pubmedmap | Use Pubmed Author's Affiliation to map the authors . | pubmed xml gis map | | |
splitvcf | split a vcf using a named list of intervals... | vcf | | |
forkvcf | Fork a VCF. | | | |
bim2vcf | convert a .bim to a .vcf | | | |
concatsam | concat sam files | sam bam | | |
samreadlengthdistribution | Sam read length distribution | sam bam histogram | | |
biostar214299 | Extract allele specific reads from bamfiles | sam bam variant snp | [ID:0000015]i_wrote_it_for_biostars | |
cmpbams4 | Compare two BAM files. Print a tab-delimited report | sam bam compare | | |
biostar234081 | convert extended CIGAR to regular CIGAR | sam bam cigar | [ID:0000015]i_wrote_it_for_biostars | |
vcfgnomad | Peek annotations from gnomad | vcf annotation gnomad | | |
vcf2svg | write a vcf to svg , with gene context | vcf svg xlm visualization | | |
mergeblastxml | merge XML blast results (same Iteration/Iteration_query-def in multiple xml files | blast xml | | |
vcfannotwithbeacon | Annotate a VCF with ga4gh beacon | ga4gh beacon vcf annotation | [ID:0000017]just_a_proof_of_concept | |
commbams | Equivalent of unix 'comm' for bams sorted on queryname | sam bam comm compare | | |
samscansplitreads | scan split reads | sam sv splitreads | | |
samretrieveseqandqual | I have a query-sorted BAM file without read/qual sequences and a FASTQ file with the read/qual sequences. Is there a tool to add seq to BAM? for @sjackman https://twitter.com/sjackman/status/575368165531611136 | | | |
biostar234230 | Sliding Window : discriminate partial and fully contained fragments (from a bam file) | | [ID:0000015]i_wrote_it_for_biostars | |
biostar251649 | Annotating the flanking bases of SNPs in a VCF file | vcf annotation sequence reference | [ID:0000015]i_wrote_it_for_biostars | |
vcfbedsetfilter | Set FILTER for VCF if it doesn't intersects with BED. | vcf bed filter | | use GATK FilterVariants. |
bamliftover | Lift-over a BAM file. | bam liftover | | |
blast2sam | Convert a **BLASTN-XML** input to SAM | sam blast | | |
reduceblast | Reduce the size of XML blast, by removing iterations that have no Hit | blast xml | | |
blastn2snp | print indel/mismatch in a blastn stream | blast snp | | |
splitbam3 | Split a BAM by chromosome group | | | |
vcfindextabix | Index and sort a VCF on the fly with Tabix | vcf tabix | | |
blastfilterjs | Filters a BlastOutput with a javascript expression. The script injects each <Hit> as the variable 'blasthit'. The user script should return 'true' to keep the hit. | blast js javascript filter | | |
SamSlop | extends sam by 'x' bases | | | |
vcfgenesplitter | Split VCF+VEP by gene. | | | |
sammaskalignedbases | Mask bases aligned on Reference. | | | |
queue2make | Convert Broad/Queue genomestrip Log stream to Makefile. | | | |
pcrclipreads | Soft clip bam files based on PCR target regions | sam bam pcr bed | | |
vcfeigen | Annotator for the data of https://xioniti01.u.hpc.mssm.edu/v1.1/ : Eigen makes use of a variety of functional annotations in both coding and noncoding regions (such as made available by the ENCODE and Roadmap Epigenomics projects), and combines them into one single measure of functional importance. | vcf annotation variant | | |
vcfmovefilterstoinfo | Move any FILTER to the INFO column. reset FILTER to PASS | vcf burden format info | | |
vcfburdenmaf | Burden : MAF for Cases / Controls | vcf burden maf case control | | |
vcfburdenfisherh | Fisher Case /Controls per Variant | vcf burden fisher | | |
vcfinjectpedigree | Injects a pedigree (.ped) file in the VCF header | vcf pedigree burden | | |
samcolortag | Add the UCSC 'YC' color tag in a BAM. See http://software.broadinstitute.org/software/igv/book/export/html/6 and http://genome.ucsc.edu/goldenPath/help/hgBamTrackHelp.html | sam bam metadata javascript igv visualization | | |
vcffilternotinpedigree | Adds a FILTER NotInPedigree if the only not(homref) genotypes are not in a pedigree | burden vcf pedigree | | |
vcfburdenexac | Burden filter 3 - Exac | vcf burden exac | | |
vcf2table | convert a vcf to a table, to ease display in the terminal | vcf table visualization | | |
vcfburdenfiltergenes | Filter VEP Output from a list of genes. | gene vcf vep | | |
vcfrefbase | Restriction sites overlaping variations in a vcf | vcf rebase restriction enzyme | | |
projectserver | Jetty Based http server serving VCF, BAM files | | | |
allelefreqcalc | Allele Frequency Calculator | vcf af | | Use bioalcidae. |
bamindexreadnames | Build a dictionary of read names to be searched with BamQueryReadNames | | | |
bamtreepack | Create a TreeMap from one or more SAM/BAM file. Ouput is a SVG file. | bam treepack | | |
fastqrecordtreepack | Create a TreeMap from one or more Fastq file. Ouput is a SVG file | | | |
samfindclippedregions | | | | |
vcftreepack | Create a TreeMap from one or more VCF. Ouput is a SVG file. | | | |
vcfburdensplitter | Split VCF Using a Burden Splitter (by gene, transcript, etc..) | | | |
vcfburdenfisherv | Fisher Case / Controls per Variant (Vertical) | vcf burden fisher | | |
vcfburdenrscriptv | Fisher Case / Controls per Variant (Vertical) | vcf burden fisher | | |
vcfderby01 | Insert similar VCFs into an Apache Derby Database | vcf sql derby burden | | |
vcfdoest | generate Transcript information for DOEST test | vcf burden doest | | |
bioalcidae | javascript version of awk for bioinformatics | sam bam vcf javascript js nashorn | | |
picardmetrics2xml | transforms a picard metrics file to XML. See http://plindenbaum.blogspot.fr/2013/02/making-use-of-picard-metrics-files.html | picard xml metrics | | |
casectrlcanvas | draw a chart of case/control maf from a stream of X/Y values | vcf case control visualization jfx chart maf | | |
lowresbam2raster | Low Resolution BAM to raster graphics | bam alignment graphics visualization png knowngene | | |
| Gatk code generator | | | |
knime2txt | converts a Knime Workflow to a html representation. | knime workflow convert | | |
lumpyvcf2circos | Lumpy to Circos | lumpy circos sv vcf | | |
genscan | Paint a Genome Scan picture from a Tab delimited file (CHROM/POS/VALUE1/VALUE2/....). | chromosome reference chart visualization | | |
vcfucsc | annotate an VCF with mysql UCSC data | ucsc mysql vcf | | |
xsltstream | XSLT transformation for large XML files. xslt is only applied on a given subset of nodes. | xml xslt xsl stylesheet | | |
vcfloopovergenes | Generates a BED file of the Genes in an annotated VCF, loop over those genes and generate a VCF for each gene, then execute an optional command. | vcf gene burden | | |
vcffilterjdk | Filtering VCF with in-memory-compiled java expressions | vcf filter java jdk | | |
optimizer | Genetic-Programming-like parameters optimizer | genetic-programming | | |
bioalcidaejdk | java-based version of awk for bioinformatics | sam bam vcf javascript jdk | | |
copynumber01 | experimental CNV detection. Doesn't work for now. | cnv bam sam | | |
samjdk | Filters a BAM using a java expression compiled in memory. | sam bam java jdk filter | | |
vcfmakedict | Create a SAM Sequence Dictionary from a set of VCF files. | vcf dict fai | | |
vcfbigwig | Annotate a VCF with values from a bigwig file | vcf wig wiggle bigwig | | |
vcfnocall2homref | Convert the UNCALLED gentoypes in a VCF to HOM_REF. This tool can be used after using GATK CombineVariants. | vcf | | |
gff2kg | Convert GFF3/GTF format to UCSC knownGene format. | gff ,gtf knownGene ucsc convert | | |
minicaller | Simple and Stupid Variant Caller designed for @AdrienLeger2 | bam sam calling vcf | [ID:0000005]unmaintained | |
vcfoptimizeped4skat | Optimize ped file for SKAT | vcf pedigree skat burden | | |
vcfskatslidingwindow | SkatFactory Over genome using a sliding window. | vcf pedigree skat burden | | |
vcfskat | Calculate SKAT score for a VCF. | vcf pedigree skat burden | | |
vcfserver | Web Server displaying VCF file. A web interface for vcf2table | vcf table visualization server web | | |
tviewserver | Web Server displaying SAM/BAM file. A web interface for jvarkit:tview | sam bam table visualization server web | | |
pubmedgraph | Creates a Gephi-gexf graph of references-cites for a given PMID | pubmed xml graph | | |
vcftrap | annotate vcf with trap database http://trap-score.org/ | vcf trap annotation | | |
trapindexer | Convert text data to binary format for the trap DATABASE database http://trap-score.org/. Those data can be used by the tool `vcftrap`. | trap | | |
samtranslocations | Explore balanced translocations between two chromosomes using discordant paired-end reads. | sam bam xslt xml | | |
prettysam | Pretty SAM alignments | sam bam | | |
vcfremoveunusedalt | Remove unused ALT allele if there is no genotype with this alt, or there is no sample but AC=0 | vcf genotype | | |
variantsinwindow | Annotate Number of Variants overlaping a sliding window. | vcf annotation | | |
samaddpi | add predicted median insert size 'PI' to SAM Read groups (RG). | sam bam | | |
goutils | Gene Ontology Utils. Retrieves terms from Gene Ontology | geneontology go gexf | | |
gb2gff | Experimental genbank to GFF | xml ncbi genbank convert gff gb | | |
indexcovjfx | display indexcov data in a jfx client | cnv jfx duplication deletion sv | | |
indexcov2vcf | convert indexcov data to vcf | cnv jfx duplication deletion sv | | |
tview | equivalent of samtools tview | sam bam visualization terminal | | |
samcustomsortjdk | Sort a BAM file using a java expression compiled in memory. | sam bam java jdk sort | | |
simpleplot | simple figure plotter using java JFX. You'd better use gnuplot or R. | char figure jfx | | |
cytoband2svg | Creates a svg karyotype . | karyotype svg ideogram | | |