Seqanswers Leaderboard Ad

Collapse

Announcement

Collapse
No announcement yet.
X
 
  • Filter
  • Time
  • Show
Clear All
new posts

  • frc1230
    replied
    I like stampy-BWA, but it does take a lot of cpu time

    Leave a comment:


  • ramirob
    replied
    I must admit I just gave up on Casava alignments, just use BWA and I am exploring other aligners.

    Leave a comment:


  • frc1230
    replied
    I am currently trying to deal with exactly this problem: CASAVA alignments that choke mpileup. We use mpileup output directly for analysis with our own SNP finders, and it works very well with output from a BWA-based aligner (stampy). But with CASAVA output, as stated in another response, mpileup thinks everything is a SNP, all reads with phred scores of 0. This is not the case, fortunately, as the same read data run through stampy produces an alignment file that behaves well with mpileup.

    Leave a comment:


  • swbarnes2
    replied
    Double check that the chromosome names in your .bam file match the chromosome names in your fasta. And I'd remake the fa.fai with samtools faidx, see if that completes without an error.

    Leave a comment:


  • ramirob
    replied
    sdriscoll,

    It seems that mpileup looking like:

    chr1.fa 3309 N 1 ^NT C
    chr1.fa 3310 N 1 G C
    chr1.fa 3311 N 1 C F
    chr1.fa 3312 N 1 C F

    is a bad sign, it looks to me that it is not mapping to the ref. genome properly. I did as you suggested and everything was a SNP.

    Leave a comment:


  • AllanLindh
    replied
    How to combine .vcf files into whole genome

    This discussion is very useful, but when I run mpileup plus bcftools to produce .vcf files for individual Chrm, I have found no way to combine them into whole genome .vcf file for further processing. vcf-concat seems like it might do it, but it never runs due to diverse errors. Most recent is:
    ****************************
    The use of -1 for unknown number of values is deprecated, please use '.' instead.
    FORMAT=<ID=PL,Number=-1,Type=Integer,Description="List of Phred-scaled genotype likelihoods, number of values is (#ALT+1)*(#ALT+2)/2">
    ****************************
    I am running most recent version of samtools (0.1.18) -- has anyone else noticed a mismatch in the FORMAT specs between samtools and vcftools??

    Any suggestions at all would be very welcom, this is driving me nuts.

    Thanks
    Allan Lindh

    Leave a comment:


  • sdriscoll
    replied
    indeed...i align data using BWA when i'm looking for SNPs.

    Leave a comment:


  • bioinfosm
    replied
    or you can try splitting the bam file by chromosome and then calling SNP on them separately.. you could also try starting from the fastq or qseq files, run alignment using something like bwa and then call variants

    Leave a comment:


  • sdriscoll
    replied
    try this. mpileup doesn't do too much. bcftools is the program that actually does the SNP calling.

    Code:
    samtools mpileup -uf ../genomes/Homo_sapiens/UCSC/hg18/Sequence/WholeGenomeFasta/genome.fa sorted.bam | bcftools view -bvcg - > sorted.bcf
    bcftools view sorted.bcf > sorted.vcf
    head sorted.vcf

    Leave a comment:


  • ramirob
    started a topic Samtools on Chromosomes Versus Genome

    Samtools on Chromosomes Versus Genome

    Hi everyone,

    Does anybody have experience running samtools on CASAVA alignments?

    I am trying to call SNPs using samtools on a CASAVA/illumina alignment.

    CASAVA outputs an alignment of the type name_export.txt.gz

    and it automatically converts to BAM format when using their SNP caller.

    Now I want to call SNPs using Samtools.

    The alignment was done using each chromosome individually:

    genomes/Homo_sapiens/UCSC/hg18/Sequence/Chromosomes/Chr...

    However, the BAM alignment provided by CASAVA is for the whole genome, so then should I use the whole reference genome?:

    samtools mpileup -f ../genomes/Homo_sapiens/UCSC/hg18/Sequence/WholeGenomeFasta/genome.fa sorted.bam > sorted.mpileupOutput

    the problem is that, in that case the mpileup output doesn't seem to recognize it as I get:

    bash-3.2$ head -n 100 sorted.mpileupOutput
    chr1.fa 3309 N 1 ^NT C
    chr1.fa 3310 N 1 G C
    chr1.fa 3311 N 1 C F
    chr1.fa 3312 N 1 C F
    chr1.fa 3313 N 1 C F


    Any ideas??

    Thanks in advance,

    Ramiro

Latest Articles

Collapse

  • seqadmin
    Non-Coding RNA Research and Technologies
    by seqadmin




    Non-coding RNAs (ncRNAs) do not code for proteins but play important roles in numerous cellular processes including gene silencing, developmental pathways, and more. There are numerous types including microRNA (miRNA), long ncRNA (lncRNA), circular RNA (circRNA), and more. In this article, we discuss innovative ncRNA research and explore recent technological advancements that improve the study of ncRNAs.

    Nobel Prize for MicroRNA Discovery
    This week,...
    10-07-2024, 08:07 AM
  • seqadmin
    Recent Developments in Metagenomics
    by seqadmin





    Metagenomics has improved the way researchers study microorganisms across diverse environments. Historically, studying microorganisms relied on culturing them in the lab, a method that limits the investigation of many species since most are unculturable1. Metagenomics overcomes these issues by allowing the study of microorganisms regardless of their ability to be cultured or the environments they inhabit. Over time, the field has evolved, especially with the advent...
    09-23-2024, 06:35 AM

ad_right_rmr

Collapse

News

Collapse

Topics Statistics Last Post
Started by seqadmin, 10-02-2024, 04:51 AM
0 responses
103 views
0 likes
Last Post seqadmin  
Started by seqadmin, 10-01-2024, 07:10 AM
0 responses
111 views
0 likes
Last Post seqadmin  
Started by seqadmin, 09-30-2024, 08:33 AM
1 response
114 views
0 likes
Last Post EmiTom
by EmiTom
 
Started by seqadmin, 09-26-2024, 12:57 PM
0 responses
20 views
0 likes
Last Post seqadmin  
Working...
X