Seqanswers Leaderboard Ad

Collapse

Announcement

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

  • sh: samtools: command not found (Tophat)

    Dear all,

    I have been using tophat for my RNA-seq data. The command line I'm using is the standard: ./tophat -p 8 -G /path_to_genes.gtf/ -o <output_folder> /path_to_genome_index/ XXX.fastq

    Tophat runs happily, finds bowtie and samtools, checks for bowtie index, Fasta reference, generates SAM header... all goes well and I have 4 outputs: accepted_hits.bam deletions.bam insertions.bam and junctions.bam... However, when the sam version of accepted_hits.bam is going to be written, samtools fails and I get a message saying sh:samtools: command not found...
    Having gone through with the bam files till the very end (cufflinks then cuffdiff and R), I seem to get the analysis running but I don't understand why samtools fails during the mapping.... Tophat clearly recognises it at first.. and ./samtools <options> work nicely for other applications.
    Just to add I have used samtools-0.1.17.tar.bz2 (I'm on a iMac) untar ed it and cp ed it into my working path (I haven't got permission for /usr/bin), I have also cp ed libbam.a into my working directory...
    Can anyone help me
    Cheers
    lj907

  • #2
    If you try the command

    which samtools

    what do you get as output?

    Comment


    • #3
      I have tried which samtools...the command line renews... no answer... is it not installed properly? but how come tophat initially recognizes it? Thanks very much
      Last edited by lj907; 07-31-2012, 05:23 AM.

      Comment


      • #4
        I don't know how tophat originally found samtools -- indeed, my guess is that it didn't and what you saw relied on linked in libraries.

        Getting no output suggests that samtools is not in your PATH environment variable. Your notes above suggest you may not have compiled it. Check that there is a samtools executable in the directory you specified & that the directory appears in the output for

        echo $PATH

        Comment


        • #5
          Thanks Krobison... I had originally used make to compile... I'm going to try to export the executables to $HOME/bin... and check with which samtools and echo $PATH.. hopefully this will work
          cheers

          Comment

          Latest Articles

          Collapse

          • seqadmin
            Strategies for Sequencing Challenging Samples
            by seqadmin


            Despite advancements in sequencing platforms and related sample preparation technologies, certain sample types continue to present significant challenges that can compromise sequencing results. Pedro Echave, Senior Manager of the Global Business Segment at Revvity, explained that the success of a sequencing experiment ultimately depends on the amount and integrity of the nucleic acid template (RNA or DNA) obtained from a sample. “The better the quality of the nucleic acid isolated...
            03-22-2024, 06:39 AM
          • seqadmin
            Techniques and Challenges in Conservation Genomics
            by seqadmin



            The field of conservation genomics centers on applying genomics technologies in support of conservation efforts and the preservation of biodiversity. This article features interviews with two researchers who showcase their innovative work and highlight the current state and future of conservation genomics.

            Avian Conservation
            Matthew DeSaix, a recent doctoral graduate from Kristen Ruegg’s lab at The University of Colorado, shared that most of his research...
            03-08-2024, 10:41 AM

          ad_right_rmr

          Collapse

          News

          Collapse

          Topics Statistics Last Post
          Started by seqadmin, 03-27-2024, 06:37 PM
          0 responses
          13 views
          0 likes
          Last Post seqadmin  
          Started by seqadmin, 03-27-2024, 06:07 PM
          0 responses
          11 views
          0 likes
          Last Post seqadmin  
          Started by seqadmin, 03-22-2024, 10:03 AM
          0 responses
          53 views
          0 likes
          Last Post seqadmin  
          Started by seqadmin, 03-21-2024, 07:32 AM
          0 responses
          69 views
          0 likes
          Last Post seqadmin  
          Working...
          X