Path to this page:
./
biology/samtools,
Tools for manipulating sequence alignment maps
Branch: CURRENT,
Version: 1.10nb2,
Package name: samtools-1.10nb2,
Maintainer: baconSamtools implements various utilities for post-processing alignments in the
SAM, BAM, and CRAM formats, including indexing, variant calling (in conjunction
with bcftools), and a simple alignment viewer.
Required to run:[
lang/perl5] [
biology/htslib] [
lang/python37]
Required to build:[
pkgtools/cwrappers]
Master sites:
SHA1: 98b24393629d63f2203f59c108b840b1e046f209
RMD160: e8d91dfc0970a0faa85d45962f76f831af331007
Filesize: 4353.281 KB
Version history: (Expand)
- (2020-12-05) Updated to version: samtools-1.10nb2
- (2020-08-31) Updated to version: samtools-1.10nb1
- (2020-07-27) Updated to version: samtools-1.10
- (2019-08-11) Updated to version: samtools-1.9nb2
- (2019-04-25) Updated to version: samtools-1.9nb1
- (2018-11-06) Updated to version: samtools-1.9
CVS history: (Expand)
2020-12-04 21:45:51 by Nia Alarie | Files touched by this commit (456) |
Log message:
Revbump packages with a runtime Python dep but no version prefix.
For the Python 3.8 default switch.
|
2020-08-31 20:13:29 by Thomas Klausner | Files touched by this commit (3631) |  |
Log message:
*: bump PKGREVISION for perl-5.32.
|
2020-07-27 01:30:30 by Jason Bacon | Files touched by this commit (4) |
Log message:
biology/samtools: Upgrade to 1.10
Numerous performance and feature improvements and several bug fixes since 1.9
|
2020-01-26 18:32:28 by Roland Illig | Files touched by this commit (981) |
Log message:
all: migrate homepages from http to https
pkglint -r --network --only "migrate"
As a side-effect of migrating the homepages, pkglint also fixed a few
indentations in unrelated lines. These and the new homepages have been
checked manually.
|
2019-08-11 15:25:21 by Thomas Klausner | Files touched by this commit (3557) |  |
Log message:
Bump PKGREVISIONs for perl 5.30.0
|
2019-04-25 09:33:32 by Maya Rashish | Files touched by this commit (620) |
Log message:
PKGREVISION bump for anything using python without a PYPKGPREFIX.
This is a semi-manual PKGREVISION bump.
|
2019-03-27 21:47:36 by Jason Bacon | Files touched by this commit (1) |
Log message:
biology/samtools: Add zlib dependency for Linux
Fixes build on CentOS 7 minimal.
|
2018-11-06 11:49:41 by Adam Ciarcinski | Files touched by this commit (2) |  |
Log message:
samtools: updated to 1.9
Release 1.9:
* Samtools mpileup VCF and BCF output is now deprecated. It is still
functional, but will warn. Please use bcftools mpileup instead.
* Samtools mpileup now handles the '-d' max_depth option differently. There
is no longer an enforced minimum, and '-d 0' is interpreted as limitless
(no maximum - warning this may be slow). The default per-file depth is
now 8000, which matches the value mpileup used to use when processing
a single sample. To get the previous default behaviour use the higher
of 8000 divided by the number of samples across all input files, or 250.
* Samtools stats new features:
- The '--remove-overlaps' option discounts overlapping portions of
templates when computing coverage and mapped base counting.
- When a target file is in use, the number of bases inside the
target is printed and the percentage of target bases with coverage
above a given threshold specified by the '--cov-threshold' option.
- Split base composition and length statistics by first and last reads.
* Samtools faidx new features:
- Now takes long options.
- Now warns about zero-length and truncated sequences due to the
requested range being beyond the end of the sequence.
- Gets a new option (--continue) that allows it to carry on
when a requested sequence was not in the index.
- It is now possible to supply the list of regions to output in a text
file using the new '--region-file' option.
- New '-i' option to make faidx return the reverse complement of
the regions requested.
- faidx now works on FASTQ (returning FASTA) and added a new
fqidx command to index and return FASTQ.
* Samtools collate now has a fast option '-f' that only operates on
primary pairs, dropping secondary and supplementary. It tries to write
pairs to the final output file as soon as both reads have been found.
* Samtools bedcov gets a new '-j' option to make it ignore deletions (D) and
reference skips (N) when computing coverage.
* Small speed up to samtools coordinate sort, by converting it to use
radix sort.
* Samtools idxstats now works on SAM and CRAM files, however this
isn't fast due to some information lacking from indices.
* Compression levels may now be specified with the level=N
output-fmt-option. E.g. with -O bam,level=3.
* Various documentation improvements.
* Bug-fixes:
- Improved error reporting in several places.
- Various test improvements.
- Fixed failures in the multi-region iterator (view -M) when regions
provided via BED files include overlaps
- Samtools stats now counts '=' and 'X' CIGAR operators when
counting mapped bases.
- Samtools stats has fixes for insert size filtering (-m, -i).
- Samtools stats -F now longer negates an earlier -d option.
- Fix samtools stats crash when using a target region.
- Samtools sort now keeps to a single thread when the -@ option is absent.
Previously it would spawn a writer thread, which could cause the CPU
usage to go slightly over 100%.
- Fixed samtools phase '-A' option which was incorrectly defined to take
a parameter.
- Fixed compilation problems when using C_INCLUDE_PATH.
- Fixed --version when built from a Git repository.
- Use noenhanced mode for title in plot-bamstats. Prevents unwanted
interpretation of characters like underscore in gnuplot version 5.
- blast2sam.pl now reports perfect match hits (no indels or mismatches).
- Fixed bug in fasta and fastq subcommands where stdout would not be flushed
correctly if the -0 option was used.
- Fixed invalid memory access in mpileup and depth on alignment records
where the sequence is absent.
|