gonomics

module
v1.0.1 Latest Latest
Warning

This package is not in the latest version of its module.

Go to latest
Published: May 1, 2024 License: BSD-3-Clause

README

Go Report Card codecov

gonomics

A collection of genomics software tools written in Go (golang).

gonomicsFigure

Complete gonomics Documentation

The complete documentation for gonomics can be found here.

Installation

1. Install go.

2. Install gonomics

Option 1: Executables only - go install github.com/vertgenlab/gonomics/...@latest

Option 2: Complete library & executables

## Clone gonomics repository  
git clone https://github.com/vertgenlab/gonomics.git && cd gonomics

## Run gonomics tests
go test ./...

## Install executables
go install  ./...

Executables will be present in the Go binary folder (~/go/bin by default)

  • Running a command with no arguments will print the usage statement for that command: ~/go/bin/commandName

The command line tools' code is located in /gonomics/cmd/

  • More information about using our tools can be found here: Using gonomics commands
  • To see every command in gonomics in command groups with their usage listed run ~/go/bin/gonomics
  • Instructions and examples on making your own tools can be found here: Writing new tools with gonomics

To create a docker container of gonomics
  1. Inside the root directory of the gonomics repository run this command to build a docker container of gonomics:
docker build . -t gonomics
  • This command takes a working directory as an input. A period is used here to indicate the current directory. Any scripts, data, or files you reference will build local paths from that directory.
  • -t (tag) is used to name you container. As you acculate more docker images, you can easily reference them by their assgined tags.
  1. Inside the container, you are essently running the same set up for build from source. I set up my working directory as: WORKDIR: /src/github.com/vertgenlab/gonomics
  • alternatively you could just set it as $HOME/src/github.com/vertgenlab/gonomics, but this makes more sense to me because the general convention is to create your applications at the /app or /gonomics but as a go programing building in src is how I think about it.
  1. Once we set our working directory in the container, we need to add code we wrote with ADD . . which takes a local directory as the first argument and the destination (inside the docker container) as the second. In other words we are recursively copying local files in gonomics into our WORKDIR which we set in step 2.
  • ADD (everything in gonomics dir) to here /src/github.com/vertgenlab/ is what that means.
  1. I think everything should be familiar at this point you run the following commands to install all package dependencies with:
    go mod download
    go mod vendor
    go mod verify
  1. Finally, go install ./... will build all gonomics executables into your $GOBIN which is located at /go/bin by default.

  2. Now you can basically run any gonomics cmd globally in the container:

    docker run gonomics chimpAncestorRecon -h
* or use the containers golang compiler globally on your desktop without having to worry about setting your $GOROOT, $GOPATH, $GOBIN
  • all your gonomics dependencies should be all set up at this point

docker run -v $(pwd):/mnt gonomics go run $script.go

  • this command will mount your local file system into the /mnt directory of your container.

Compatibility with previous golang versions

Gonomics is compatible with golang version 1.18 and above. Please note that due to changes in random number generation since golang v1.20, many cmd tests will fail if run on 1.18 or 1.19, including cmds that use random numbers, such as the simulate commands and MCMC sampling. However, we expect these programs to function as intended in these older versions.


Citing Gonomics:

We ask that the following publication be cited in work using Gonomics executable commands or development libraries:

Au et al, Bioinformatics Volume 39, Issue 8, August 2023, btad516 https://doi.org/10.1093/bioinformatics/btad516


Authors:
  • Eric Au
  • Luke C. Bartelt
  • Olivier Boivin
  • Sophie Campione
  • Christiana Fauci
  • Craig B. Lowe
  • Yanting Luo
  • Riley J. Mangan
  • Chelsea R. Shoben
  • Daniel A. Snellings
  • Seth Weaver

Directories

Path Synopsis
Package align provides basic struct(s), gap scoring matrices, and dynamical approaches to aligning sequences
Package align provides basic struct(s), gap scoring matrices, and dynamical approaches to aligning sequences
Package axt provides the struct and functions that operate on alignments in Axt format.
Package axt provides the struct and functions that operate on alignments in Axt format.
bed
Package bed provides functions for reading, writing, and manipulating Browser Extensible Data (BED) format files.
Package bed provides functions for reading, writing, and manipulating Browser Extensible Data (BED) format files.
Package bgzf provides functions for reading and writing files in the BGZF compression format.
Package bgzf provides functions for reading and writing files in the BGZF compression format.
Package browser contains command line visualization tools for genomic information.
Package browser contains command line visualization tools for genomic information.
Package chain declares the Chain struct that describes an alignment block and contains functions that operates on chain structs.
Package chain declares the Chain struct that describes an alignment block and contains functions that operates on chain structs.
Package chromInfo provides function to read and manipulate chromInfo files
Package chromInfo provides function to read and manipulate chromInfo files
Package cigar contains functions to manipulate cigar data in the SAM file format.
Package cigar contains functions to manipulate cigar data in the SAM file format.
cmd
DEPRECATED/mouseRecon
WARNING: This program is now deprecated.
WARNING: This program is now deprecated.
DEPRECATED/primateRecon
WARNING: this program is now deprecated.
WARNING: this program is now deprecated.
alleleSplit
Separates a sam alignment from a heterozygous individual
Separates a sam alignment from a heterozygous individual
assemblyStats
Provides information about the number of scaffolds, including the N50, number of scaffolds, and distribution of lengths of assembled scaffolds.
Provides information about the number of scaffolds, including the N50, number of scaffolds, and distribution of lengths of assembled scaffolds.
axTools
Utilities for axt alignments
Utilities for axt alignments
axtSam
Convert axt alignments to sam format
Convert axt alignments to sam format
bedDistanceFromChrEnds
Returns a bed file with the Score field containing the minimum distance from the end of the chromosome.
Returns a bed file with the Score field containing the minimum distance from the end of the chromosome.
bedFilter
Output a subset of a bed file using score, name, position, and length
Output a subset of a bed file using score, name, position, and length
bedFormat
Options to alter bed formatting
Options to alter bed formatting
bedGraphToWig
Converts bedGraph to wig.
Converts bedGraph to wig.
bedMath
Performs comparative arithmetic operations on float values in bed files
Performs comparative arithmetic operations on float values in bed files
bedMerge
Combines overlapping bed entries, keeping max score.
Combines overlapping bed entries, keeping max score.
bedMinimumDistanceName
Calculates the minimum distance between beds in separate files with matching names
Calculates the minimum distance between beds in separate files with matching names
bedOverlapByWindow
Given a window size (default 5000), return the number of base pairs that are in any bed region within that window
Given a window size (default 5000), return the number of base pairs that are in any bed region within that window
bedToAminoAcid
Converts a bed and fasta sequences into amino acid sequences within the bed regions
Converts a bed and fasta sequences into amino acid sequences within the bed regions
bedToFasta
Extracts sequences from a fasta file from regions specified by an input bed
Extracts sequences from a fasta file from regions specified by an input bed
bedToWig
Converts bed score to wig
Converts bed score to wig
bedValueWig
Returns bed file with entries annotated based on the values corresponding to the region in a wig file
Returns bed file with entries annotated based on the values corresponding to the region in a wig file
bedpeOverlap
Filters bedpe entries based on overlaps from the select file.
Filters bedpe entries based on overlaps from the select file.
branchLengthsMultiFaBed
Using a four-way multiple alignment (including the reference species followed by three successive outgroups), this program calculates branch lengths in units of estimate substitutions for regions in the alignment specified by an input bed file
Using a four-way multiple alignment (including the reference species followed by three successive outgroups), this program calculates branch lengths in units of estimate substitutions for regions in the alignment specified by an input bed file
callVariants
A tool to find variation between multiple alignment files
A tool to find variation between multiple alignment files
catMultiFa
Concatenate multiFa alignment files by sequence.
Concatenate multiFa alignment files by sequence.
cigarToBed
Uses globalAlignment, affineGap (instead of constGap) to align 2 .fasta files, each with only 1 sequence, then convert cigars to ins and del beds
Uses globalAlignment, affineGap (instead of constGap) to align 2 .fasta files, each with only 1 sequence, then convert cigars to ins and del beds
divergenceSpectrum
Determine the mutation spectrum for divergent sites in each region of an input bed file
Determine the mutation spectrum for divergent sites in each region of an input bed file
dotToNewick
Generates a newick tree file from an input dot format tree
Generates a newick tree file from an input dot format tree
drawNewickTree
Reads a newick format text file to a png for tree visualization
Reads a newick format text file to a png for tree visualization
dunnIndex
Computes the Dunn Index based on variable SNPs for each input bed region of a multiple alignment
Computes the Dunn Index based on variable SNPs for each input bed region of a multiple alignment
faBin
Bins fastas into a minimum size group with either a single record or multiple records from a size ordered chrom.sizes file
Bins fastas into a minimum size group with either a single record or multiple records from a size ordered chrom.sizes file
faChunkAlign
Align two or more sequences by "chunks" of bases instead of by single bases.
Align two or more sequences by "chunks" of bases instead of by single bases.
faDrawAlnChunks
Align two or more sequences by "chunks" of bases instead of by single bases.
Align two or more sequences by "chunks" of bases instead of by single bases.
faFilter
Returns a filtered fasta based on option parameters
Returns a filtered fasta based on option parameters
faFindFast
Returns number of mutations that separate two sequences for a given window size
Returns number of mutations that separate two sequences for a given window size
faFormat
Reformat the sequences in a fasta file
Reformat the sequences in a fasta file
faInfo
Returns summary statistics to standard out for an input.fa, including the counts for each base.
Returns summary statistics to standard out for an input.fa, including the counts for each base.
faToPredictSet
Make deep learning prediction TSV files from input fasta format data
Make deep learning prediction TSV files from input fasta format data
faUniq
Pull unique sequences from a fasta file
Pull unique sequences from a fasta file
fastqFilter
Returns a filtered fastq based on option parameters
Returns a filtered fastq based on option parameters
fastqFormat
Options alter fastq file formatting
Options alter fastq file formatting
filterGenotypes
Filter genotyped VCFs containing at least 3 samples with SNP regions where parental genomes are homozygous (and different) and have a clear heterozygous F1 from the parents
Filter genotyped VCFs containing at least 3 samples with SNP regions where parental genomes are homozygous (and different) and have a clear heterozygous F1 from the parents
findAndReplace
Finds values in a file and replaces them, processes the input as a string
Finds values in a file and replaces them, processes the input as a string
formatIdeogram
Generates ideogram txt file from a bed
Generates ideogram txt file from a bed
gafFilter
Filter gaf file.
Filter gaf file.
geneAssignmentStats
geneAssignmentStats compares a bedpe containing a gene symbol in the name field to a test set of output from assignGenomeSpace command which assigns every base in the genome a closest gene either from proximity or from a 3d contact map.
geneAssignmentStats compares a bedpe containing a gene symbol in the name field to a test set of output from assignGenomeSpace command which assigns every base in the genome a closest gene either from proximity or from a 3d contact map.
geneIdToName
Find and replace gene IDs with gene names according to an input table or preset NCBI RefSeq / ENSEMBL ID conversion tables
Find and replace gene IDs with gene names according to an input table or preset NCBI RefSeq / ENSEMBL ID conversion tables
getPromoter
getPromoter will take a list of unique genes of interest and return a bed file of the promoter region proceeding the position of the TSS for each isoform by the amount specified with upstream and following the TSS by the amount specified by downstream.
getPromoter will take a list of unique genes of interest and return a bed file of the promoter region proceeding the position of the TSS for each isoform by the amount specified with upstream and following the TSS by the amount specified by downstream.
girafCompress
GIRAF <-> GIRAF.FE conversion, for more information, see the giraf package
GIRAF <-> GIRAF.FE conversion, for more information, see the giraf package
girafSimulate
Returns a file of giraf alignments for a input genome graph
Returns a file of giraf alignments for a input genome graph
girafSort
External sort of giraf records based on topological ordering of nodes in input graph
External sort of giraf records based on topological ordering of nodes in input graph
globalAlignment
Align two FASTA files, each with only 1 sequence
Align two FASTA files, each with only 1 sequence
globalAlignmentAnchor
Operates on 2 species, takes alignment maf, filters for trusted matches (s lines generated from the same chromosome in both species), and aligns the gap sequences between the trusted matches (affineGap, DefaultScoreMatrix)
Operates on 2 species, takes alignment maf, filters for trusted matches (s lines generated from the same chromosome in both species), and aligns the gap sequences between the trusted matches (affineGap, DefaultScoreMatrix)
goFetchCat
View http url links and print data stream to stdout
View http url links and print data stream to stdout
gonomics
A collection of tools that use the gonomics core library
A collection of tools that use the gonomics core library
great3d
Perform functional enrichment analysis by associating genomic regions with their nearest gene in 3d space using bedPe contact sites.
Perform functional enrichment analysis by associating genomic regions with their nearest gene in 3d space using bedPe contact sites.
gsw
Graph-Smith-Waterman: align single or paired end fastqs
Graph-Smith-Waterman: align single or paired end fastqs
haplotypeGenerator
Generate unique haplotypes for provided regions from genetic variation data
Generate unique haplotypes for provided regions from genetic variation data
intervalContacts
Returns all regions that contact input genomic regions
Returns all regions that contact input genomic regions
intervalOverlap
A tool to find non/overlapping genomic regions
A tool to find non/overlapping genomic regions
intervalSubsetMatrix
Produces a binary matrix for accessibility breadth analysis
Produces a binary matrix for accessibility breadth analysis
lastZWriter
Write out lastZ pairwise inputs using contig alignment where multiple references are being used
Write out lastZ pairwise inputs using contig alignment where multiple references are being used
liftCoordinates
Lifts a compatible file format between assembly coordinates
Lifts a compatible file format between assembly coordinates
mafFilter
Filter a maf file to remove entries below a score threshold
Filter a maf file to remove entries below a score threshold
mafIndels
Takes pairwise alignment maf and finds insertions in species_ins not present in species_del but flanked by continuous alignments
Takes pairwise alignment maf and finds insertions in species_ins not present in species_del but flanked by continuous alignments
mafToBed
Convert a maf alignment into a bed, where the bed score is the alignment score
Convert a maf alignment into a bed, where the bed score is the alignment score
mafToMultiFa
Convert a maf alignment into a multiple fasta alignment
Convert a maf alignment into a multiple fasta alignment
mcmcTraceStats
Returns summary statistics on an MCMC trace file produced by selectionMCMC
Returns summary statistics on an MCMC trace file produced by selectionMCMC
mergeMultiFa
Merge two multiFa files on a shared reference.
Merge two multiFa files on a shared reference.
mergesort
Executes an external merge sort of the input file based on desired sort criteria
Executes an external merge sort of the input file based on desired sort criteria
multFaVisualizeBeds
Provides human-readable multiple alignments for all entries in a bed file
Provides human-readable multiple alignments for all entries in a bed file
multFaVisualizer
Provides human-readable multiple alignment from a given multiFa
Provides human-readable multiple alignment from a given multiFa
multiFaAcceleration
Performs velocity and acceleration on a four way multiple alignment in multiFa format
Performs velocity and acceleration on a four way multiple alignment in multiFa format
multiFaExtract
Pull sub-sequence from multiple Fasta alignment for each entry
Pull sub-sequence from multiple Fasta alignment for each entry
multiFaReduce
Removes all columns in a multi fasta alignment that are not variable
Removes all columns in a multi fasta alignment that are not variable
multiFaScan
Scan multiple Fasta alignment for a user-specified pattern (N for now) and report bed regions in reference sequence coordinates
Scan multiple Fasta alignment for a user-specified pattern (N for now) and report bed regions in reference sequence coordinates
multiFaToChain
Convert a pairwise multiFa format alignment to a chain file.
Convert a pairwise multiFa format alignment to a chain file.
multiFaToVcf
Generates a VCF file from an input pairwise or three-way multiFa alignment with the first entry as the reference
Generates a VCF file from an input pairwise or three-way multiFa alignment with the first entry as the reference
overlapEnrichments
Returns the p-value of enrichment and depletion for overlaps between the elements in two input files
Returns the p-value of enrichment and depletion for overlaps between the elements in two input files
pFaTools
A collection of tools for manipulating pFasta files
A collection of tools for manipulating pFasta files
pileup
Count bases from sequencing data
Count bases from sequencing data
plotFunctions
Returns a tab separated list of function evaluations for plotting functions
Returns a tab separated list of function evaluations for plotting functions
prcompFormat
Generates a binary input matrix for PCA
Generates a binary input matrix for PCA
proximityBlockVcf
Pseudorandomly selects variants from an input VCF file
Pseudorandomly selects variants from an input VCF file
pwmTools
A collection of tools for manipulating position matrices
A collection of tools for manipulating position matrices
quickOrthologs
Find corresponding orthologous transcription start
Find corresponding orthologous transcription start
randSeq
Returns pseudorandomly generated DNA sequences in fasta format
Returns pseudorandomly generated DNA sequences in fasta format
reconstructSeq
Reconstruct ancient sequences using extant genomes and a newick tree with branch lengths
Reconstruct ancient sequences using extant genomes and a newick tree with branch lengths
samAssembler
Reference-based diploid assembly of aligned short reads
Reference-based diploid assembly of aligned short reads
samConsensus
Generates a fasta file from a sam over a reference sequence
Generates a fasta file from a sam over a reference sequence
samToBed
Converts sam to bed
Converts sam to bed
samToWig
Converts sam or bam to wig
Converts sam or bam to wig
sampleVcf
Returns a sample from a VCF file with a specified number of results
Returns a sample from a VCF file with a specified number of results
scCount
Generate count matrix from single-cell sequencing data
Generate count matrix from single-cell sequencing data
selectionMcmc
Returns values sampled from the probability distribution of the mean selection coefficient for a given set of bed regions
Returns values sampled from the probability distribution of the mean selection coefficient for a given set of bed regions
selectionMle
Performs maximum likelihood estimation of selection on variants from an input VCF format file
Performs maximum likelihood estimation of selection on variants from an input VCF format file
simRecon
Simulates evolution from the root of a newick tree to the extant species of the trees and then uses the leaf nodes to reconstruct the ancestral nodes and compares the answers for percent accuracy.
Simulates evolution from the root of a newick tree to the extant species of the trees and then uses the leaf nodes to reconstruct the ancestral nodes and compares the answers for percent accuracy.
simulateBed
Returns a file of random bed regions of an input bed file
Returns a file of random bed regions of an input bed file
simulateDivergentWindowsVcf
Simulates Vcf data, partitioned by divergence-based ascertainment
Simulates Vcf data, partitioned by divergence-based ascertainment
simulateEvol
Simulate sequence evolution on an input fasta from the root of a newick tree to the leaf nodes
Simulate sequence evolution on an input fasta from the root of a newick tree to the leaf nodes
simulatePcr
Predict amplicon products generated from PCR
Predict amplicon products generated from PCR
simulateSam
Simulate alignments to a reference sequence
Simulate alignments to a reference sequence
simulateVcf
Contains functions for simulating VCF data
Contains functions for simulating VCF data
simulateWrightFisher
Simulate a multiallelic, haplotic Wright-Fisher population (discrete, non-overlapping generations)
Simulate a multiallelic, haplotic Wright-Fisher population (discrete, non-overlapping generations)
slurmCheck
Used to check for completion of SLURM job arrays (WIP).
Used to check for completion of SLURM job arrays (WIP).
sortGraph
Topologically sorts nodes in a genome graph (.gg) file
Topologically sorts nodes in a genome graph (.gg) file
statCalc
Command line statistics calculator
Command line statistics calculator
strawToBedpe
Convert HiC contact maps in straw format to bedpe contact peak calls
Convert HiC contact maps in straw format to bedpe contact peak calls
vcfAfs
Returns allele frequency spectrum information in a text file for graphing
Returns allele frequency spectrum information in a text file for graphing
vcfAncestorAnnotation
Adds ancestral allele to the INFO column of entries in a VCF file
Adds ancestral allele to the INFO column of entries in a VCF file
vcfEffectPrediction
Annotate Vcf records with cDNA and protein effect predictions
Annotate Vcf records with cDNA and protein effect predictions
vcfFilter
Filter vcf records
Filter vcf records
vcfFormat
Options alter VCF formatting
Options alter VCF formatting
vcfInfo
Provides summary statistics on an input VCF file
Provides summary statistics on an input VCF file
vcfToFa
Use the variant data in the vcf to edit an input fasta of the reference
Use the variant data in the vcf to edit an input fasta of the reference
vcfWebAnnotate
Annotate a vcf file by querying various databases via CellBase
Annotate a vcf file by querying various databases via CellBase
wigFilter
Returns a filtered wig based on option parameters
Returns a filtered wig based on option parameters
wigMath
Perform mathematical operations on wig format data
Perform mathematical operations on wig format data
wigPeaks
Takes wig file and finds peaks
Takes wig file and finds peaks
wigStats
Provide coverage histogram for WIG format visualization files
Provide coverage histogram for WIG format visualization files
wigToTrainingSet
Converts a wig to a training, validation, and testing set for the GenomeSequenceConvNet
Converts a wig to a training, validation, and testing set for the GenomeSequenceConvNet
Package convert contains functions for converting data between standard file formats.
Package convert contains functions for converting data between standard file formats.
dna
Package dna implements a data structure for storage and manipulation of sequences of DNA.
Package dna implements a data structure for storage and manipulation of sequences of DNA.
Package exception provides globally available functions to simplify exit after unrecoverable errors are encountered.
Package exception provides globally available functions to simplify exit after unrecoverable errors are encountered.
Package expandedTree contains structs and functions that build and utilize information in a binary tree format that can be used for genome simulation and reconstruction
Package expandedTree contains structs and functions that build and utilize information in a binary tree format that can be used for genome simulation and reconstruction
Package fasta provides functions for reading, writing, and manipulating fasta files.
Package fasta provides functions for reading, writing, and manipulating fasta files.
Package fastq provides functions for reading, writing, and manipulating data in the fastq file format.
Package fastq provides functions for reading, writing, and manipulating data in the fastq file format.
Package fileio provides wrappers of the builtin golang Reader/Writer utilities for ease of use and automatic gzip handling.
Package fileio provides wrappers of the builtin golang Reader/Writer utilities for ease of use and automatic gzip handling.
Package gene contains structs and functions to help understand protein-coding genes.
Package gene contains structs and functions to help understand protein-coding genes.
Package genePred is a package for reading, writing, and manipulating genePred structs
Package genePred is a package for reading, writing, and manipulating genePred structs
Package genomeGraph has structs and tools for reading, writing, editing and aligning graph representations of genomes
Package genomeGraph has structs and tools for reading, writing, editing and aligning graph representations of genomes
Package giraf contains utilities and software to operate genome graph alignments in giraf format
Package giraf contains utilities and software to operate genome graph alignments in giraf format
Package graphReconstruct (WIP) has tools to reconstruct ancient genomes using extant descendants, but utilizes graph genomes instead of linear genomes.
Package graphReconstruct (WIP) has tools to reconstruct ancient genomes using extant descendants, but utilizes graph genomes instead of linear genomes.
Package gtf contains functions for reading, writing, and manipulating GTF format files.
Package gtf contains functions for reading, writing, and manipulating GTF format files.
Package hic is written to process output from the aidenlab functions straw function: https://github.com/aidenlab/straw note: this package only reads and does not write this file type
Package hic is written to process output from the aidenlab functions straw function: https://github.com/aidenlab/straw note: this package only reads and does not write this file type
Package interval provides functions for manipulating and analyzing intervals including sorting, calculating overlaps, and liftover functions.
Package interval provides functions for manipulating and analyzing intervals including sorting, calculating overlaps, and liftover functions.
Package lastZWriter takes in alignment information and creates a file that contains all necessary lastz jobs with all required parameters for any species listed, as well as creating all the directories where data will be stored when those jobs are run.
Package lastZWriter takes in alignment information and creates a file that contains all necessary lastz jobs with all required parameters for any species listed, as well as creating all the directories where data will be stored when those jobs are run.
Package maf provides structs and functions for processing alignments in maf format.
Package maf provides structs and functions for processing alignments in maf format.
Package motif provides functions for reading, writing, and manipulating position matrices for transcription factor binding site motif analysis.
Package motif provides functions for reading, writing, and manipulating position matrices for transcription factor binding site motif analysis.
Package numbers provides a variety of functions related to statistics
Package numbers provides a variety of functions related to statistics
fit
Package ontology provides functions for gene ontology enrichment analysis.
Package ontology provides functions for gene ontology enrichment analysis.
gaf
Package gaf provides functions for reading, writing, and manipulating GO Annotation File (GAF) format files.
Package gaf provides functions for reading, writing, and manipulating GO Annotation File (GAF) format files.
obo
Package obo provides functions for reading, writing, and manipulating Open Biomedical Ontologies (obo) format files.
Package obo provides functions for reading, writing, and manipulating Open Biomedical Ontologies (obo) format files.
Package phylo contains functions related to phylogenetic analysis from multiple sequence alignment data.
Package phylo contains functions related to phylogenetic analysis from multiple sequence alignment data.
Package popgen contains functions for analyzing population genetic statistics from variation or alignment data.
Package popgen contains functions for analyzing population genetic statistics from variation or alignment data.
package psl defines the Psl struct containing alignment data as well as functions and methods that operate on the Psl struct
package psl defines the Psl struct containing alignment data as well as functions and methods that operate on the Psl struct
Package reconstruct has tools for reconstructing ancient genomes from the genomes of extant species using newick trees and fasta files.
Package reconstruct has tools for reconstructing ancient genomes from the genomes of extant species using newick trees and fasta files.
Package sam provides functions for reading, writing, and manipulating sam files.
Package sam provides functions for reading, writing, and manipulating sam files.
Package simulate contains functions for simulation of genomic data, including generating random sequences, variants, reads, or regions.
Package simulate contains functions for simulation of genomic data, including generating random sequences, variants, reads, or regions.
Package sketch provides utilities and color palettes for plotting graphs and images
Package sketch provides utilities and color palettes for plotting graphs and images
Package sort holds structs and functions for sorting genomic data types
Package sort holds structs and functions for sorting genomic data types
Package tree provides a struct and functions that allow for creating binary trees modifying them, and doing calculations on them.
Package tree provides a struct and functions that allow for creating binary trees modifying them, and doing calculations on them.
Package vcf contains functions for reading, writing, and manipulating VCF format files.
Package vcf contains functions for reading, writing, and manipulating VCF format files.
wig
Package wig provides functions to read, write, and manipulate wig files.
Package wig provides functions to read, write, and manipulate wig files.

Jump to

Keyboard shortcuts

? : This menu
/ : Search site
f or F : Jump to
y or Y : Canonical URL